├── LICENSE.md
├── README.md
├── User tutorial.pdf
├── doc
├── HGT_pipeline.png
└── YOL164W_circle_tree.png
├── example
├── HGT_workflow.py
├── blastp_files
│ └── AAT92670.txt
├── input.fasta
└── output.tsv
├── main
├── HGT_workflow_close.py
├── HGT_workflow_distant.py
└── blastp.py
├── phylogenetics
├── input
│ ├── YOL164W.fasta
│ ├── YOL164W.txt
│ └── YOL164W_homologs.fasta
├── intermediate
│ ├── YOL164W.bionj
│ ├── YOL164W.ckp.gz
│ ├── YOL164W.contree
│ ├── YOL164W.iqtree
│ ├── YOL164W.log
│ ├── YOL164W.mldist
│ ├── YOL164W.model.gz
│ ├── YOL164W.splits.nex
│ ├── YOL164W.treefile
│ ├── YOL164W_aln.fasta
│ ├── YOL164W_aln_trimmed.fasta
│ ├── YOL164W_midpoint-color.txt
│ ├── YOL164W_midpoint-font.txt
│ └── YOL164W_midpoint.tree
├── output
│ ├── YOL164W_circle_tree.pdf
│ ├── YOL164W_midpoint-color.txt
│ ├── YOL164W_midpoint-font.txt
│ ├── YOL164W_midpoint.tree
│ └── YOL164W_rectangular_tree.pdf
└── scripts
│ ├── HGT_homologs_sequence.py
│ ├── create_iTOL_config.pl
│ ├── generate_tree.sh
│ └── midpoint_tree.R
└── requirements.txt
/LICENSE.md:
--------------------------------------------------------------------------------
1 | MIT License
2 |
3 | Copyright (c) 2018 Systems and Synthetic Biology at Chalmers University of Technology
4 |
5 | Permission is hereby granted, free of charge, to any person obtaining a copy
6 | of this software and associated documentation files (the "Software"), to deal
7 | in the Software without restriction, including without limitation the rights
8 | to use, copy, modify, merge, publish, distribute, sublicense, and/or sell
9 | copies of the Software, and to permit persons to whom the Software is
10 | furnished to do so, subject to the following conditions:
11 |
12 | The above copyright notice and this permission notice shall be included in all
13 | copies or substantial portions of the Software.
14 |
15 | THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR
16 | IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY,
17 | FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE
18 | AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER
19 | LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM,
20 | OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE
21 | SOFTWARE.
22 |
--------------------------------------------------------------------------------
/README.md:
--------------------------------------------------------------------------------
1 | # HGTphyloDetect
2 | Horizontal gene transfer (HGT) refers to the exchange of genetic material
3 | between disparate groups of organisms other than from parent to offspring,
4 | which has been confirmed as a very significant factor in adaptive
5 | evolution, disease emergence and metabolic shift that can act across various
6 | species. However, current methods for HGT detection are usually not automatic,
7 | narrow applicable or unavailable to use. In this work, we developed a versatile computational
8 | toolbox named HGTphyloDetect by combining a high-throughput pipeline together with phylogenetic analysis
9 | to facilitate comprehensive investigation of the potential mechanism for HGT events. Tests on two case
10 | studies suggest that this approach could effectively
11 | identify horizontally acquired genes with high accuracy. In-depth phylogenetic analysis further facilitates
12 | the navigation of the potential donors and detailed gene transmission process. The HGTphyloDetect toolbox
13 | is designed for ease of use and could accurately find HGT events with a very low false discovery rate
14 | in a high-throughput manner.
15 |
16 | ## HGT identification pipeline
17 | 
18 |
19 | ## Citation
20 | Please cite this paper:
21 | Yuan, Le, et al. _HGTphyloDetect: facilitating the identification and phylogenetic analysis of horizontal gene transfer._ Briefings in Bioinformatics (2023). https://academic.oup.com/bib/advance-article/doi/10.1093/bib/bbad035/7031155.
22 |
23 | ## Installation
24 | Install the latest version with:
25 | ```bash
26 | $ git clone https://github.com/SysBioChalmers/HGTphyloDetect.git
27 | $ cd HGTphyloDetect
28 | $ pip install -r requirements.txt
29 | ```
30 | Please note: this is sufficient to run the HGT detection functionality of HGTphyloDetect. Additional software dependencies and installation instructions are specified in the [User tutorial](https://github.com/SysBioChalmers/HGTphyloDetect/blob/master/User%20tutorial.pdf).
31 |
32 | ## Example
33 | We provide a user-friendly example for small test, users just need to prepare a FASTA file including protein id and protein sequence, note that protein id should be from the GenBank protein database.
34 | (1) If you are now in the HGTphyloDetect directory, just enter into the folder [example](https://github.com/SysBioChalmers/HGTphyloDetect/tree/master/example) via the command line:
35 | ```linux
36 | cd example
37 | ```
38 |
39 | (2.1) Then users can run the script for the input file (default AI value = 45, out_pct = 0.90):
40 | ```linux
41 | python HGT_workflow.py input.fasta
42 | ```
43 |
44 | (2.2) If users want to change the default values for the parameters used in the pipeline, e.g., AI value = 40, out_pct = 0.80, just reset the constant values and run the following:
45 | ```linux
46 | python HGT_workflow.py input.fasta AI=40 out_pct=0.80
47 | ```
48 |
49 | (3) Finally, our software could generate the output results as a file under the folder [example](https://github.com/SysBioChalmers/HGTphyloDetect/tree/master/example) for this gene/protein. The output file includes some important information, i.e., Alien index, E value and donor information. For example:
50 | |Gene/Protein | Alien index | E value | Donor id | Donor taxonomy |
51 | |:---------------:|:---------------:|:---------------:|:---------------:|:---------------:|
52 | | AAT92670 | 199.18| 3.15e-87| WP_208929673| Bacteria/Firmicutes|
53 |
54 | ## User Manual
55 | Please check the documentation [User tutorial](https://github.com/SysBioChalmers/HGTphyloDetect/blob/master/User%20tutorial.pdf) for the user manual. Here you can download this file for your case studies.
56 |
57 | ## Contact
58 | * [Le Yuan](https://www.chalmers.se/en/Staff/Pages/leyu.aspx) ([@leyuan](https://github.com/le-yuan)), Chalmers University of Technology, Sweden
59 |
--------------------------------------------------------------------------------
/User tutorial.pdf:
--------------------------------------------------------------------------------
https://raw.githubusercontent.com/SysBioChalmers/HGTphyloDetect/d4ff8c5dbdaf3b200e45dd57962dfb11776f43d7/User tutorial.pdf
--------------------------------------------------------------------------------
/doc/HGT_pipeline.png:
--------------------------------------------------------------------------------
https://raw.githubusercontent.com/SysBioChalmers/HGTphyloDetect/d4ff8c5dbdaf3b200e45dd57962dfb11776f43d7/doc/HGT_pipeline.png
--------------------------------------------------------------------------------
/doc/YOL164W_circle_tree.png:
--------------------------------------------------------------------------------
https://raw.githubusercontent.com/SysBioChalmers/HGTphyloDetect/d4ff8c5dbdaf3b200e45dd57962dfb11776f43d7/doc/YOL164W_circle_tree.png
--------------------------------------------------------------------------------
/example/HGT_workflow.py:
--------------------------------------------------------------------------------
1 | #!/usr/bin/env python
2 | # -*- coding: utf-8 -*-
3 |
4 | # Step 1 : BLAST hits were parsed to retrieve associated taxonomic information
5 | # using the NCBI's taxonomy database.
6 |
7 | # Step 2: Calculate Alien Index (AI) values and out_pct based on the above information.
8 |
9 | # Step 3: Output the horizontal gene transfer (HGT) high-throughput identification results.
10 |
11 | import sys
12 | import os
13 | import math
14 | import csv
15 | import warnings
16 | from Bio import BiopythonWarning
17 | from Bio import SeqIO
18 | from Bio import Entrez
19 | from ete3 import NCBITaxa
20 |
21 |
22 | def parse_NCBI(gene):
23 | with open("./blastp_files/%s.txt" % gene, "r") as filename :
24 | data = filename.readlines()
25 | for line in data :
26 | if line.strip("\n").endswith("found") :
27 | index = data.index(line)
28 |
29 | blast_results = data[index+1:-1]
30 |
31 | accession_number = list()
32 | evalue = dict()
33 | for blast in blast_results :
34 | accession = blast.strip("\n").split("\t")[1]
35 | accession_number.append(accession)
36 | evalue[accession] = float(blast.strip('\n').split("\t")[2])
37 | return accession_number, evalue
38 |
39 | def getTaxid(accession):
40 | # Retrieving data in the GenBank using only the GenBank code accession in biopython
41 | # https://www.ncbi.nlm.nih.gov/books/NBK25497/table/chapter2.T._entrez_unique_identifiers_ui/?report=objectonly
42 | # https://www.ncbi.nlm.nih.gov/books/NBK25499/#chapter4.EFetch
43 | # https://biopython.org/DIST/docs/api/Bio.Entrez-module.html
44 | Entrez.email = "abcd@ncbi.org"
45 |
46 | # https://www.biostars.org/p/304175/
47 | # get tax id using only the GenBank code accession in biopython
48 | # handle = Entrez.efetch(db='protein', id="NP_012706.1", rettype='gb')
49 | handle = Entrez.efetch(db='protein', id=accession, rettype='gb')
50 | record = SeqIO.read(handle,'genbank')
51 | # print(record.features[0].qualifiers)
52 | if record.features[0].qualifiers['db_xref'][0].split(":")[0] == 'taxon':
53 | taxid = record.features[0].qualifiers['db_xref'][0].split(":")[1] # the type is a string
54 | organism = record.features[0].qualifiers['organism'][0]
55 | # seq = record.seq
56 | # print(taxid,organism)
57 |
58 | return taxid
59 |
60 | def main(AI=45, out_pct=0.90) :
61 | name = sys.argv[1:][0]
62 | if len(sys.argv) == 2 :
63 | pass
64 | else :
65 | AI = float(sys.argv[2].split("=")[1])
66 | out_pct = float(sys.argv[3].split("=")[1])
67 | genes = list()
68 | HGT = list()
69 | warnings.simplefilter('ignore', BiopythonWarning)
70 |
71 | with open(name, 'r') as handleGene :
72 | for record in SeqIO.parse(handleGene, "fasta") :
73 | gene = str(record.id)
74 | genes.append(gene)
75 |
76 | n=0
77 | for gene in genes :
78 | n += 1
79 | print("This is gene %d------------------" %(n))
80 | print(gene)
81 |
82 | if os.path.exists("./blastp_files/%s.txt" % gene) :
83 | accession_number,evalue = parse_NCBI(gene)
84 | print('Yes, blast file already exists, nice!')
85 | else :
86 | # Need to install blast!
87 | myCmd = "blastp -db nr -remote -query ./%s.fasta -max_target_seqs 250 -task 'blastp-fast' -outfmt '7 qacc sacc evalue bitscore length pident' -out ./blastp_files/%s.txt" %('input', gene)
88 | os.system(myCmd)
89 |
90 | ncbi = NCBITaxa()
91 | outgroup = list()
92 | ingroup = list()
93 | outgroup_species = list()
94 | ingroup_species = list()
95 | outgroup_dict = dict()
96 | ingroup_dict = dict()
97 | e_minus = 1e-200
98 |
99 | try :
100 | gene_taxid = getTaxid(gene)
101 | gene_lineage = ncbi.get_lineage(gene_taxid)
102 | gene_lineage2ranks = ncbi.get_rank(gene_lineage)
103 | gene_ranks2lineage = dict((rank, taxid) for (taxid, rank) in gene_lineage2ranks.items())
104 | gene_taxonomy_alignment = gene_ranks2lineage
105 | gene_kingdom = gene_taxonomy_alignment['kingdom']
106 | gene_subphylum = gene_taxonomy_alignment['subphylum']
107 | # print(gene_kingdom)
108 | # print(type(gene_kingdom)) #
109 | # print(gene_subphylum)
110 | except :
111 | print('Attention: please check the gene accession id!')
112 | break
113 |
114 | for accession in accession_number[:200] :
115 | try :
116 | # print(accession)
117 | taxid = getTaxid(accession)
118 | print('Taxid by BLAST:', taxid)
119 | except :
120 | continue
121 |
122 | try :
123 | lineage = ncbi.get_lineage(taxid)
124 | lineage2ranks = ncbi.get_rank(lineage)
125 | ranks2lineage = dict((rank, taxid) for (taxid, rank) in lineage2ranks.items())
126 |
127 | taxonomy_alignment = ranks2lineage
128 | LINNAEUS_FILTER = ["subphylum","kingdom","superkingdom"]
129 | except :
130 | print('Warning: %s taxid not found!' % str(taxid))
131 | continue
132 |
133 | try :
134 | if taxonomy_alignment['kingdom'] != gene_kingdom :
135 | outgroup.append(accession)
136 | outgroup_species.append(taxonomy_alignment['species'])
137 |
138 | if taxonomy_alignment['kingdom'] == gene_kingdom and taxonomy_alignment['subphylum'] != gene_subphylum :
139 | ingroup.append(accession)
140 | ingroup_species.append(taxonomy_alignment['species'])
141 |
142 | except :
143 | outgroup.append(accession)
144 | try :
145 | outgroup_species.append(taxonomy_alignment['species'])
146 | except :
147 | continue
148 |
149 | for accession_id in outgroup :
150 | outgroup_dict[accession_id] = evalue[accession_id]
151 |
152 | for accession_id in ingroup :
153 | ingroup_dict[accession_id] = evalue[accession_id]
154 |
155 | if outgroup_dict :
156 | min_outgroup_key = min(outgroup_dict,key=outgroup_dict.get)
157 | min_outgroup_evalue = outgroup_dict[min_outgroup_key]
158 | else :
159 | min_outgroup_evalue = 1
160 |
161 | if ingroup_dict :
162 | min_ingroup_key = min(ingroup_dict,key=ingroup_dict.get)
163 | min_ingroup_evalue = ingroup_dict[min_ingroup_key]
164 | else :
165 | min_ingroup_evalue = 1
166 |
167 | alienindex = format(math.log(min_ingroup_evalue+e_minus, math.e)-math.log(min_outgroup_evalue+e_minus, math.e), '.2f')
168 | try :
169 | outg_pct = format(len(set(outgroup_species))/(len(set(outgroup_species))+len(set(ingroup_species))), '.4f')
170 | except :
171 | continue
172 |
173 | print('Alien index: %s' % str(alienindex))
174 |
175 | if float(alienindex) >= AI and float(outg_pct) >= out_pct :
176 | print('This is a HGT event')
177 | print('Accession_id: %s' % min_outgroup_key)
178 | print('Evalue: %s' % evalue[min_outgroup_key])
179 | taxid= getTaxid(min_outgroup_key)
180 | Evalue = evalue[min_outgroup_key]
181 | lineage = ncbi.get_lineage(taxid)
182 | lineage2ranks = ncbi.get_rank(lineage)
183 | ranks2lineage = dict((rank, taxid) for (taxid, rank) in lineage2ranks.items())
184 | # print(lineage)
185 | # print(ranks2lineage)
186 | taxid2name = ncbi.get_taxid_translator([ranks2lineage['phylum'], ranks2lineage['class'], ranks2lineage['superkingdom']])
187 | print(taxid2name[ranks2lineage['phylum']])
188 |
189 | superkingdom = taxid2name[ranks2lineage['superkingdom']]
190 | phylum = taxid2name[ranks2lineage['phylum']]
191 | hgt = 'Yes'
192 | taxonomy = superkingdom + '/' + phylum
193 |
194 | item = [gene, alienindex, Evalue, min_outgroup_key, taxonomy]
195 | HGT.append(item)
196 |
197 | else:
198 | # print('This is not a HGT event')
199 | hgt = 'No'
200 | HGT.append([gene,alienindex,'No', 'No', 'No'])
201 |
202 | outfile = open("./output.tsv", "wt")
203 | tsv_writer = csv.writer(outfile, delimiter="\t")
204 | column = ['Gene/Protein', 'Alien index', 'E value', 'Donor id', 'Donor taxonomy']
205 | tsv_writer.writerow(column)
206 | for HGT_info in HGT :
207 | tsv_writer.writerow(HGT_info)
208 | outfile.close()
209 |
210 |
211 | if __name__== "__main__":
212 | main()
213 |
--------------------------------------------------------------------------------
/example/blastp_files/AAT92670.txt:
--------------------------------------------------------------------------------
1 | # BLASTP 2.10.1+
2 | # Query: AAT92670
3 | # RID: 8MMNC23C016
4 | # Database: nr
5 | # Fields: query acc., subject acc., evalue, bit score, alignment length, % identity
6 | # 250 hits found
7 | AAT92670 5COG_A 1.11e-126 364 179 100.000
8 | AAT92670 NP_010829 4.83e-126 362 179 100.000
9 | AAT92670 AJU85562 1.31e-125 360 179 99.441
10 | AAT92670 AJV04521 2.15e-125 360 179 99.441
11 | AAT92670 CAD6614768 2.15e-125 360 179 99.441
12 | AAT92670 ONH79032 2.29e-125 360 179 99.441
13 | AAT92670 AJU96086 3.02e-125 360 179 99.441
14 | AAT92670 AHY75482 3.88e-125 359 179 99.441
15 | AAT92670 PTN18717 4.29e-125 359 179 99.441
16 | AAT92670 CAD6614350 6.57e-125 359 179 99.441
17 | AAT92670 CAD6614837 7.84e-125 358 179 98.883
18 | AAT92670 AJU59728 1.16e-124 358 179 98.883
19 | AAT92670 CAD6614250 2.96e-124 357 179 98.883
20 | AAT92670 AJU63907 5.60e-123 354 179 97.765
21 | AAT92670 GHM89243 4.22e-122 352 179 97.207
22 | AAT92670 AJV01730 1.00e-121 351 179 97.207
23 | AAT92670 AJU98194 1.33e-121 350 179 97.207
24 | AAT92670 EGA83280 2.88e-111 324 159 99.371
25 | AAT92670 EGA75337 2.44e-99 295 145 97.931
26 | AAT92670 ONH78076 8.85e-90 270 136 95.588
27 | AAT92670 WP_208929673 3.15e-87 263 168 73.214
28 | AAT92670 WP_206843940 8.25e-86 260 168 73.214
29 | AAT92670 WP_086277901 4.52e-85 258 168 72.024
30 | AAT92670 WP_069646943 1.07e-84 257 168 72.024
31 | AAT92670 WP_086330545 7.61e-84 254 168 72.619
32 | AAT92670 WP_086315029 1.39e-83 254 168 72.024
33 | AAT92670 WP_071877120 2.00e-83 254 168 70.833
34 | AAT92670 WP_069653266 3.13e-82 251 168 68.452
35 | AAT92670 WP_010761928 1.01e-81 249 168 69.643
36 | AAT92670 WP_206838637 1.58e-81 249 168 67.857
37 | AAT92670 WP_207113218 2.40e-81 248 168 70.238
38 | AAT92670 WP_069635085 3.97e-81 248 168 70.238
39 | AAT92670 WP_207695964 4.33e-81 248 168 69.643
40 | AAT92670 WP_206849624 5.23e-81 248 168 67.262
41 | AAT92670 WP_010766489 8.47e-81 247 167 69.461
42 | AAT92670 WP_111248972 1.24e-80 247 168 67.857
43 | AAT92670 WP_010770404 2.61e-80 246 168 69.048
44 | AAT92670 WP_025870318 4.42e-80 245 168 69.048
45 | AAT92670 WP_086345820 4.42e-80 245 168 69.048
46 | AAT92670 WP_088270311 1.03e-79 244 168 66.667
47 | AAT92670 WP_209551020 5.93e-75 232 168 64.881
48 | AAT92670 WP_035019983 9.81e-75 232 168 65.476
49 | AAT92670 WP_228159366 4.20e-73 228 168 62.500
50 | AAT92670 WP_074403517 5.97e-73 228 174 60.920
51 | AAT92670 WP_135025830 6.66e-73 227 174 60.920
52 | AAT92670 WP_135018024 6.74e-73 227 174 60.920
53 | AAT92670 WP_034573059 8.48e-73 227 174 60.920
54 | AAT92670 WP_124006429 1.63e-72 226 168 63.095
55 | AAT92670 WP_086319184 2.37e-72 226 168 64.881
56 | AAT92670 WP_004559864 3.11e-72 225 168 63.690
57 | AAT92670 WP_195495722 4.14e-72 225 168 61.905
58 | AAT92670 WP_119907274 4.38e-72 225 174 60.345
59 | AAT92670 WP_096711087 4.62e-72 225 168 61.905
60 | AAT92670 WP_005227560 5.38e-72 225 166 61.446
61 | AAT92670 WP_115231784 6.41e-72 224 166 61.446
62 | AAT92670 WP_104688309 6.92e-72 224 168 64.881
63 | AAT92670 WP_194194192 7.38e-72 224 166 61.446
64 | AAT92670 WP_012492203 7.64e-72 224 168 63.095
65 | AAT92670 WP_003128966 8.16e-72 224 168 61.905
66 | AAT92670 WP_220022871 8.62e-72 224 168 65.476
67 | AAT92670 WP_087913410 9.83e-72 224 168 62.500
68 | AAT92670 HCO71425 1.04e-71 224 166 62.048
69 | AAT92670 WP_194853683 1.06e-71 224 168 63.095
70 | AAT92670 WP_121260015 1.12e-71 224 166 61.446
71 | AAT92670 WP_086294562 1.17e-71 224 166 60.843
72 | AAT92670 WP_128488310 1.32e-71 224 166 60.843
73 | AAT92670 WP_036076428 1.51e-71 224 167 62.275
74 | AAT92670 WP_074934572 1.64e-71 224 166 61.446
75 | AAT92670 WP_167822701 1.64e-71 224 166 60.843
76 | AAT92670 WP_016994205 2.16e-71 223 167 62.275
77 | AAT92670 WP_014918942 2.21e-71 223 168 64.881
78 | AAT92670 WP_054607410 2.33e-71 223 168 64.881
79 | AAT92670 CCK23958 2.34e-71 223 168 62.500
80 | AAT92670 WP_159161509 2.39e-71 223 166 61.446
81 | AAT92670 WP_147587199 2.78e-71 223 168 61.310
82 | AAT92670 WP_016609715 2.81e-71 223 166 60.843
83 | AAT92670 WP_155853236 2.90e-71 223 168 61.310
84 | AAT92670 WP_221680393 3.14e-71 223 167 62.275
85 | AAT92670 ADX70393 3.43e-71 223 168 64.881
86 | AAT92670 WP_023061843 3.95e-71 223 168 64.881
87 | AAT92670 WP_054550367 4.35e-71 223 167 62.275
88 | AAT92670 WP_066037277 4.65e-71 222 167 62.275
89 | AAT92670 WP_123032107 4.70e-71 222 168 63.095
90 | AAT92670 WP_151493937 5.13e-71 222 168 62.500
91 | AAT92670 WP_003577112 5.42e-71 222 168 62.500
92 | AAT92670 WP_081116974 5.42e-71 222 166 60.843
93 | AAT92670 WP_061053753 5.48e-71 222 166 60.843
94 | AAT92670 WP_004225105 6.18e-71 222 167 62.275
95 | AAT92670 WP_016369059 6.32e-71 222 168 62.500
96 | AAT92670 WP_195265238 6.53e-71 222 166 61.446
97 | AAT92670 WP_172998771 6.90e-71 222 168 64.881
98 | AAT92670 WP_142973918 7.21e-71 222 166 61.446
99 | AAT92670 WP_086316885 7.29e-71 222 168 61.310
100 | AAT92670 WP_003586053 7.69e-71 222 168 62.500
101 | AAT92670 WP_167822118 8.97e-71 222 166 60.843
102 | AAT92670 WP_005232023 8.97e-71 222 166 61.446
103 | AAT92670 WP_054612910 9.79e-71 221 167 62.275
104 | AAT92670 WP_142963124 1.00e-70 221 166 61.446
105 | AAT92670 WP_115673276 1.06e-70 221 167 62.275
106 | AAT92670 WP_213355573 1.14e-70 221 166 60.843
107 | AAT92670 WP_077453653 1.18e-70 221 166 61.446
108 | AAT92670 WP_131520065 1.21e-70 221 167 61.677
109 | AAT92670 WP_015508975 1.27e-70 221 166 60.843
110 | AAT92670 WP_205840691 1.29e-70 221 168 64.286
111 | AAT92670 WP_003600237 1.47e-70 221 168 62.500
112 | AAT92670 WP_081119017 1.50e-70 221 166 61.446
113 | AAT92670 WP_060792753 1.50e-70 221 166 60.843
114 | AAT92670 KRO14293 1.50e-70 221 168 64.881
115 | AAT92670 WP_218193225 1.75e-70 221 166 61.446
116 | AAT92670 WP_057730345 1.83e-70 221 168 64.881
117 | AAT92670 WP_194957952 1.85e-70 221 168 61.905
118 | AAT92670 WP_194186201 1.95e-70 221 166 61.446
119 | AAT92670 NTJ98307 2.06e-70 221 168 64.286
120 | AAT92670 WP_076651954 2.11e-70 221 168 61.905
121 | AAT92670 WP_048392561 2.15e-70 221 167 61.677
122 | AAT92670 WP_196498648 2.18e-70 221 168 62.500
123 | AAT92670 WP_016388093 2.20e-70 221 168 61.905
124 | AAT92670 WP_086293992 2.83e-70 220 166 60.843
125 | AAT92670 WP_036117070 2.89e-70 220 167 61.677
126 | AAT92670 WP_142965075 2.93e-70 220 166 60.843
127 | AAT92670 WP_173009066 3.12e-70 220 168 64.286
128 | AAT92670 WP_003568315 3.45e-70 220 168 61.905
129 | AAT92670 WP_167827335 3.76e-70 220 166 61.446
130 | AAT92670 WP_074536584 4.48e-70 220 166 60.843
131 | AAT92670 WP_142973074 4.59e-70 220 166 60.843
132 | AAT92670 WP_165846893 5.64e-70 219 168 61.905
133 | AAT92670 WP_123022120 6.29e-70 219 168 61.905
134 | AAT92670 WP_058205773 7.18e-70 219 168 63.690
135 | AAT92670 WP_011675062 8.10e-70 219 168 61.905
136 | AAT92670 WP_195961081 9.44e-70 219 166 60.843
137 | AAT92670 WP_008377943 1.54e-69 219 166 60.843
138 | AAT92670 WP_017152268 1.63e-69 218 168 59.524
139 | AAT92670 WP_221685466 1.70e-69 218 166 60.241
140 | AAT92670 WP_035450618 1.80e-69 218 167 60.479
141 | AAT92670 WP_168784600 2.03e-69 218 167 64.072
142 | AAT92670 WP_142972095 2.12e-69 218 166 60.843
143 | AAT92670 WP_058218936 2.29e-69 218 167 64.072
144 | AAT92670 WP_196043740 2.64e-69 218 166 60.843
145 | AAT92670 WP_087664892 3.22e-69 218 166 60.843
146 | AAT92670 WP_010748807 3.25e-69 218 166 60.843
147 | AAT92670 WP_086333006 3.25e-69 218 166 60.843
148 | AAT92670 EPD07047 4.42e-69 217 166 62.048
149 | AAT92670 EPC89042 4.87e-69 217 168 61.310
150 | AAT92670 WP_201705749 5.32e-69 217 166 60.241
151 | AAT92670 EKP98078 6.77e-69 217 168 61.310
152 | AAT92670 WP_172982252 7.54e-69 216 163 65.644
153 | AAT92670 WP_114820579 7.89e-69 217 166 61.446
154 | AAT92670 WP_002191562 1.00e-68 216 168 58.333
155 | AAT92670 WP_063226548 1.18e-68 216 168 58.333
156 | AAT92670 WP_068709110 1.42e-68 216 168 60.119
157 | AAT92670 WP_003596614 1.49e-68 216 168 61.310
158 | AAT92670 WP_061674712 1.62e-68 216 168 58.333
159 | AAT92670 WP_229443398 1.85e-68 216 166 62.651
160 | AAT92670 WP_202067617 1.89e-68 216 166 62.651
161 | AAT92670 WP_215589296 2.00e-68 216 168 58.333
162 | AAT92670 WP_241139205 2.09e-68 216 168 57.738
163 | AAT92670 WP_215588168 2.09e-68 216 168 58.333
164 | AAT92670 WP_081143378 2.46e-68 216 168 58.929
165 | AAT92670 WP_079241112 3.13e-68 215 166 60.241
166 | AAT92670 WP_076597054 4.30e-68 215 169 59.172
167 | AAT92670 WP_120230529 4.35e-68 215 166 60.241
168 | AAT92670 WP_071865667 4.69e-68 214 156 64.744
169 | AAT92670 WP_215559710 5.07e-68 215 168 57.738
170 | AAT92670 WP_002203044 5.07e-68 215 168 58.333
171 | AAT92670 WP_002144233 5.35e-68 214 168 57.738
172 | AAT92670 WP_098287108 8.67e-68 214 168 58.333
173 | AAT92670 WP_213278628 8.76e-68 214 166 60.241
174 | AAT92670 WP_002187330 1.03e-67 214 168 57.738
175 | AAT92670 WP_152873926 1.04e-67 214 167 60.479
176 | AAT92670 WP_016093939 1.24e-67 214 168 57.738
177 | AAT92670 WP_013709724 1.33e-67 214 168 59.524
178 | AAT92670 WP_201053994 1.48e-67 213 168 57.143
179 | AAT92670 WP_216483989 1.69e-67 213 168 57.738
180 | AAT92670 WP_078422372 1.80e-67 213 168 57.738
181 | AAT92670 NUF97537 1.91e-67 213 168 58.929
182 | AAT92670 WP_163120899 1.97e-67 213 167 60.479
183 | AAT92670 WP_244012899 2.10e-67 213 167 60.479
184 | AAT92670 WP_227943935 2.67e-67 213 166 59.639
185 | AAT92670 QBA21333 2.76e-67 213 166 60.241
186 | AAT92670 WP_174788971 3.33e-67 213 168 58.929
187 | AAT92670 WP_130131624 3.40e-67 213 167 59.880
188 | AAT92670 WP_239045432 3.44e-67 213 167 60.479
189 | AAT92670 WP_223600316 3.76e-67 213 166 59.036
190 | AAT92670 WP_234624222 3.80e-67 213 167 59.880
191 | AAT92670 WP_130112315 4.01e-67 213 167 59.880
192 | AAT92670 WP_101668531 4.05e-67 213 167 57.485
193 | AAT92670 WP_130116989 4.62e-67 212 167 59.880
194 | AAT92670 WP_174791913 4.73e-67 212 168 58.333
195 | AAT92670 WP_096886786 5.57e-67 212 167 57.485
196 | AAT92670 WP_003340693 5.95e-67 212 167 57.485
197 | AAT92670 WP_087552928 6.28e-67 212 167 59.880
198 | AAT92670 WP_129036932 7.08e-67 212 166 59.036
199 | AAT92670 WP_068974833 7.48e-67 212 167 59.880
200 | AAT92670 WP_071680068 7.90e-67 212 168 57.143
201 | AAT92670 WP_201033505 8.35e-67 212 168 57.143
202 | AAT92670 WP_077319935 8.82e-67 211 168 55.952
203 | AAT92670 WP_202844057 9.11e-67 211 166 59.639
204 | AAT92670 WP_105703154 1.02e-66 211 166 59.036
205 | AAT92670 WP_070129311 1.05e-66 211 168 57.738
206 | AAT92670 WP_096734381 1.07e-66 212 167 59.880
207 | AAT92670 WP_115964082 1.09e-66 211 166 59.036
208 | AAT92670 WP_088030746 1.12e-66 211 168 57.143
209 | AAT92670 WP_130168913 1.17e-66 211 167 59.880
210 | AAT92670 WP_227900732 1.41e-66 211 168 57.143
211 | AAT92670 WP_105713699 1.59e-66 211 167 59.880
212 | AAT92670 WP_057876868 1.64e-66 211 168 56.548
213 | AAT92670 WP_181749346 1.70e-66 211 167 57.485
214 | AAT92670 WP_110009419 2.16e-66 211 166 59.036
215 | AAT92670 WP_124536318 2.19e-66 211 166 59.036
216 | AAT92670 WP_236850724 2.33e-66 211 166 59.036
217 | AAT92670 WP_004822309 2.36e-66 211 167 59.880
218 | AAT92670 WP_184552522 2.47e-66 211 166 61.446
219 | AAT92670 WP_209785239 2.72e-66 210 166 59.036
220 | AAT92670 WP_088308704 3.95e-66 210 168 57.143
221 | AAT92670 WP_089977464 4.12e-66 210 168 58.333
222 | AAT92670 WP_198175763 4.17e-66 210 168 57.738
223 | AAT92670 WP_152289620 4.91e-66 210 166 58.434
224 | AAT92670 WP_034615226 5.07e-66 210 167 59.880
225 | AAT92670 WP_126320462 5.30e-66 210 172 56.395
226 | AAT92670 WP_187948837 6.11e-66 209 168 59.524
227 | AAT92670 WP_045922684 6.18e-66 209 168 58.333
228 | AAT92670 WP_174790729 6.46e-66 209 168 58.333
229 | AAT92670 WP_185287214 7.28e-66 209 166 58.434
230 | AAT92670 WP_165006160 8.13e-66 209 168 60.119
231 | AAT92670 WP_002169656 8.22e-66 209 168 56.548
232 | AAT92670 WP_185507149 8.77e-66 209 172 55.814
233 | AAT92670 WP_220746435 9.68e-66 209 172 58.140
234 | AAT92670 WP_105683644 9.79e-66 209 166 58.434
235 | AAT92670 WP_003755718 1.07e-65 209 172 55.814
236 | AAT92670 WP_167029757 1.29e-65 209 166 59.036
237 | AAT92670 WP_010744365 1.33e-65 209 168 65.476
238 | AAT92670 WP_056512763 1.34e-65 209 167 58.683
239 | AAT92670 WP_003335899 1.44e-65 208 167 56.886
240 | AAT92670 EHB6449604 1.47e-65 208 168 57.738
241 | AAT92670 WP_142014514 1.57e-65 208 166 59.036
242 | AAT92670 WP_149216920 1.62e-65 208 168 58.333
243 | AAT92670 WP_022586250 1.73e-65 208 167 56.886
244 | AAT92670 NST56843 1.73e-65 208 166 58.434
245 | AAT92670 WP_010818106 1.85e-65 208 168 57.738
246 | AAT92670 WP_137904171 1.97e-65 208 166 59.639
247 | AAT92670 WP_042087352 2.43e-65 208 167 59.281
248 | AAT92670 WP_156248593 2.62e-65 208 168 57.143
249 | AAT92670 WP_223607470 2.86e-65 208 166 59.639
250 | AAT92670 WP_016627294 2.86e-65 207 166 58.434
251 | AAT92670 WP_163245235 2.89e-65 207 167 56.886
252 | AAT92670 WP_151957428 3.02e-65 208 167 59.880
253 | AAT92670 HCN47554 3.26e-65 207 166 57.831
254 | AAT92670 WP_086319892 3.37e-65 207 168 65.476
255 | AAT92670 WP_070786995 3.84e-65 207 168 57.143
256 | AAT92670 WP_000816114 3.93e-65 207 168 57.143
257 | # BLAST processed 1 queries
258 |
--------------------------------------------------------------------------------
/example/input.fasta:
--------------------------------------------------------------------------------
1 | >AAT92670
2 | MREYTSKKELKEEIEKKYEKYDAEFETISESQKDEKVETVDRTPSENLSYQLGWVNLLLEWEAKEIAGYNVETPAPGYKWNNLGGLYQSFYKKYGIYSIKEQRAKLREAVNEVYKWISTLSDDELFQAGNRKWATTKAMWPVYKWIHINTVAPFTNFRGKIRKWKRLVPEEQRIKRRKI
--------------------------------------------------------------------------------
/example/output.tsv:
--------------------------------------------------------------------------------
1 | Gene/Protein Alien index E value Donor id Donor taxonomy
2 | AAT92670 199.18 3.15e-87 WP_208929673 Bacteria/Firmicutes
3 |
--------------------------------------------------------------------------------
/main/HGT_workflow_close.py:
--------------------------------------------------------------------------------
1 | #!/usr/bin/env python
2 | # -*- coding: utf-8 -*-
3 |
4 | import sys
5 | import os
6 | import math
7 | import csv
8 | import warnings
9 | from Bio import BiopythonWarning
10 | from Bio import SeqIO
11 | from Bio import Entrez
12 | from ete3 import NCBITaxa
13 |
14 |
15 | def parse_NCBI(gene):
16 | with open("./blastp_files/%s.txt" % gene, "r") as filename :
17 | data = filename.readlines()
18 | for line in data :
19 | if line.strip("\n").endswith("found") :
20 | index = data.index(line)
21 |
22 | blast_results = data[index+1:-1]
23 |
24 | accession_number = list()
25 | accession_bitscore = dict()
26 | for blast in blast_results :
27 | accession = blast.strip("\n").split("\t")[1]
28 | accession_number.append(accession)
29 | accession_bitscore[accession] = float(blast.strip('\n').split("\t")[3])
30 | return accession_number, accession_bitscore
31 |
32 | def getTaxid(accession):
33 | # Retrieving data in the GenBank using only the GenBank code accession in biopython
34 | # https://www.ncbi.nlm.nih.gov/books/NBK25497/table/chapter2.T._entrez_unique_identifiers_ui/?report=objectonly
35 | # https://www.ncbi.nlm.nih.gov/books/NBK25499/#chapter4.EFetch
36 | # https://biopython.org/DIST/docs/api/Bio.Entrez-module.html
37 | Entrez.email = "abcd@ncbi.org"
38 |
39 | # https://www.biostars.org/p/304175/
40 | # get tax id using only the GenBank code accession in biopython
41 | # handle = Entrez.efetch(db='protein', id="NP_012706.1", rettype='gb')
42 | handle = Entrez.efetch(db='protein', id=accession, rettype='gb')
43 | record = SeqIO.read(handle,'genbank')
44 | # print(record.features[0].qualifiers)
45 | if record.features[0].qualifiers['db_xref'][0].split(":")[0] == 'taxon':
46 | taxid = record.features[0].qualifiers['db_xref'][0].split(":")[1] # the type is a string
47 | organism = record.features[0].qualifiers['organism'][0]
48 | # seq = record.seq
49 | # print(taxid,organism)
50 |
51 | return taxid
52 |
53 | def main(bitscore_parameter=100, HGTIndex=0.5, out_pct=0.8) :
54 | name = sys.argv[1:][0]
55 | if len(sys.argv) == 2 :
56 | pass
57 | else :
58 | bitscore_parameter = float(sys.argv[2].split("=")[1])
59 | HGTIndex = float(sys.argv[3].split("=")[1])
60 | out_pct = float(sys.argv[4].split("=")[1])
61 | genes = list()
62 | geneSeq = dict()
63 | HGT = list()
64 | warnings.simplefilter('ignore', BiopythonWarning)
65 |
66 | with open(name, 'r') as handleGene :
67 | for record in SeqIO.parse(handleGene, "fasta") :
68 | gene = str(record.id)
69 | sequence = str(record.seq)
70 | geneSeq[gene] = sequence
71 | genes.append(gene)
72 |
73 | n=0
74 | for gene in genes :
75 | n += 1
76 | print("This is gene %d------------------" %(n))
77 | print(gene)
78 |
79 | if os.path.exists("./blastp_files/%s.txt" % gene) :
80 | accession_number,accession_bitscore = parse_NCBI(gene)
81 | print('Yes, blast file already exists, nice!')
82 | else :
83 | # Need to install blast!
84 | with open('./%s.fasta' % gene, 'w') as outfile :
85 | outfile.write('>'+gene+'\n')
86 | outfile.write(geneSeq[gene]+'\n')
87 | if not os.path.exists("./blastp_files/") :
88 | os.system('mkdir ./blastp_files')
89 | myCmd = "blastp -db nr -remote -query ./%s.fasta -max_target_seqs 250 -task 'blastp-fast' -outfmt '7 qacc sacc evalue bitscore length pident' -out ./blastp_files/%s.txt" %(gene, gene)
90 | os.system(myCmd)
91 | os.remove('./%s.fasta' % gene)
92 | accession_number,accession_bitscore = parse_NCBI(gene)
93 |
94 | ncbi = NCBITaxa()
95 | recipient_accession = list()
96 | outgroup_accession = list()
97 | recipient_accession_bitscore = dict()
98 | outgroup_accession_bitscore = dict()
99 | recipient_species = list()
100 | outgroup_species = list()
101 |
102 | try :
103 | gene_taxid = getTaxid(gene)
104 | gene_lineage = ncbi.get_lineage(gene_taxid)
105 | gene_lineage2ranks = ncbi.get_rank(gene_lineage)
106 | gene_ranks2lineage = dict((rank, taxid) for (taxid, rank) in gene_lineage2ranks.items())
107 | gene_taxonomy_alignment = gene_ranks2lineage
108 | gene_kingdom = gene_taxonomy_alignment['kingdom']
109 | gene_subphylum = gene_taxonomy_alignment['subphylum']
110 | # print(gene_kingdom)
111 | # print(type(gene_kingdom)) #
112 | # print(gene_subphylum)
113 | except :
114 | print('Attention: please check the gene accession id!')
115 | break
116 |
117 | for accession in accession_number[:200] :
118 | try :
119 | taxid = getTaxid(accession)
120 | print('Taxid by BLAST:', taxid)
121 | except :
122 | continue
123 |
124 | try :
125 | lineage = ncbi.get_lineage(taxid)
126 | lineage2ranks = ncbi.get_rank(lineage)
127 | ranks2lineage = dict((rank, taxid) for (taxid, rank) in lineage2ranks.items())
128 | # print(ranks2lineage)
129 |
130 | taxid2name = ncbi.get_taxid_translator(lineage)
131 | taxonomy_alignment = ranks2lineage
132 | except :
133 | print('Warning: %s taxid not found!' % str(taxid))
134 | continue
135 |
136 | try :
137 | if taxonomy_alignment['subphylum'] == gene_subphylum :
138 | recipient_accession.append(accession)
139 | recipient_species.append(taxonomy_alignment['species'])
140 |
141 | if taxonomy_alignment['kingdom'] == gene_kingdom and taxonomy_alignment['subphylum'] != gene_subphylum :
142 | outgroup_accession.append(accession)
143 | outgroup_species.append(taxonomy_alignment['species'])
144 | except :
145 | continue
146 |
147 | for accession_id in recipient_accession :
148 | recipient_accession_bitscore[accession_id] = accession_bitscore[accession_id]
149 |
150 | for accession_id in outgroup_accession :
151 | outgroup_accession_bitscore[accession_id] = accession_bitscore[accession_id]
152 |
153 | if recipient_accession_bitscore :
154 | max_recipient_organism_accession_key = max(recipient_accession_bitscore,key=recipient_accession_bitscore.get)
155 | max_recipient_organism_bitscore = recipient_accession_bitscore[max_recipient_organism_accession_key]
156 |
157 | if outgroup_accession_bitscore :
158 | max_outgroup_accession_key = max(outgroup_accession_bitscore,key=outgroup_accession_bitscore.get)
159 | max_outgroup_bitscore = outgroup_accession_bitscore[max_outgroup_accession_key]
160 | if max_outgroup_accession_key :
161 | max_taxid = getTaxid(max_outgroup_accession_key)
162 | max_lineage = ncbi.get_lineage(max_taxid)
163 | max_lineage2ranks = ncbi.get_rank(max_lineage)
164 | max_ranks2lineage = dict((rank, taxid) for (taxid, rank) in max_lineage2ranks.items())
165 | try :
166 | max_taxid2name = ncbi.get_taxid_translator([max_ranks2lineage['kingdom'], max_ranks2lineage['phylum'], max_ranks2lineage['subphylum'], max_ranks2lineage['species']])
167 | except :
168 | continue
169 |
170 | # print(gene)
171 | # print(max_recipient_organism_bitscore)
172 | # print(max_outgroup_bitscore)
173 | # print(max_taxid2name)
174 |
175 | if recipient_species :
176 | recipient_species_number = len(set(recipient_species))
177 | if outgroup_species :
178 | outgroup_species_number = len(set(outgroup_species))
179 |
180 | HGT_index = format(max_outgroup_bitscore/max_recipient_organism_bitscore, '.4f')
181 | Outg_pct = format(outgroup_species_number/(outgroup_species_number+recipient_species_number), '.4f')
182 |
183 | print('HGT index: %s' % str(HGT_index))
184 | print('Out_pct: %s' % str(Outg_pct))
185 | if max_outgroup_bitscore>=bitscore_parameter and float(HGT_index)>=HGTIndex and float(Outg_pct)>=out_pct :
186 | print('This is a HGT event')
187 | taxonomy = max_taxid2name[max_ranks2lineage['kingdom']] + '/' + max_taxid2name[max_ranks2lineage['subphylum']]
188 | item = [gene, max_outgroup_bitscore, Outg_pct, HGT_index, taxonomy]
189 | HGT.append(item)
190 | else :
191 | print('This is not a HGT event')
192 | item = [gene, max_outgroup_bitscore, Outg_pct, HGT_index, 'No']
193 | HGT.append(item)
194 |
195 | outfile = open("./output_close_HGT.tsv", "wt")
196 | tsv_writer = csv.writer(outfile, delimiter="\t")
197 | column = ['Gene/Protein', 'Bitscore', 'Out_pct', 'HGT index', 'Donor taxonomy']
198 | tsv_writer.writerow(column)
199 | for HGT_info in HGT :
200 | tsv_writer.writerow(HGT_info)
201 | outfile.close()
202 |
203 |
204 | if __name__== "__main__":
205 | main()
206 |
--------------------------------------------------------------------------------
/main/HGT_workflow_distant.py:
--------------------------------------------------------------------------------
1 | #!/usr/bin/env python
2 | # -*- coding: utf-8 -*-
3 |
4 | # Step 1 : BLAST hits were parsed to retrieve associated taxonomic information
5 | # using the NCBI's taxonomy database.
6 |
7 | # Step 2: Calculate Alien Index (AI) values and out_pct based on the above information.
8 |
9 | # Step 3: Output the horizontal gene transfer (HGT) high-throughput identification results.
10 |
11 | import sys
12 | import os
13 | import math
14 | import csv
15 | import warnings
16 | from Bio import BiopythonWarning
17 | from Bio import SeqIO
18 | from Bio import Entrez
19 | from ete3 import NCBITaxa
20 |
21 |
22 | def parse_NCBI(gene):
23 | with open("./blastp_files/%s.txt" % gene, "r") as filename :
24 | data = filename.readlines()
25 | for line in data :
26 | if line.strip("\n").endswith("found") :
27 | index = data.index(line)
28 |
29 | blast_results = data[index+1:-1]
30 |
31 | accession_number = list()
32 | evalue = dict()
33 | for blast in blast_results :
34 | accession = blast.strip("\n").split("\t")[1]
35 | accession_number.append(accession)
36 | evalue[accession] = float(blast.strip('\n').split("\t")[2])
37 | return accession_number, evalue
38 |
39 | def getTaxid(accession):
40 | # Retrieving data in the GenBank using only the GenBank code accession in biopython
41 | # https://www.ncbi.nlm.nih.gov/books/NBK25497/table/chapter2.T._entrez_unique_identifiers_ui/?report=objectonly
42 | # https://www.ncbi.nlm.nih.gov/books/NBK25499/#chapter4.EFetch
43 | # https://biopython.org/DIST/docs/api/Bio.Entrez-module.html
44 | Entrez.email = "abcd@ncbi.org"
45 |
46 | # https://www.biostars.org/p/304175/
47 | # get tax id using only the GenBank code accession in biopython
48 | # handle = Entrez.efetch(db='protein', id="NP_012706.1", rettype='gb')
49 | handle = Entrez.efetch(db='protein', id=accession, rettype='gb')
50 | record = SeqIO.read(handle,'genbank')
51 | # print(record.features[0].qualifiers)
52 | if record.features[0].qualifiers['db_xref'][0].split(":")[0] == 'taxon':
53 | taxid = record.features[0].qualifiers['db_xref'][0].split(":")[1] # the type is a string
54 | organism = record.features[0].qualifiers['organism'][0]
55 | # seq = record.seq
56 | # print(taxid,organism)
57 |
58 | return taxid
59 |
60 | def main(AI=45, out_pct=0.90) :
61 | name = sys.argv[1:][0]
62 | if len(sys.argv) == 2 :
63 | pass
64 | else :
65 | AI = float(sys.argv[2].split("=")[1])
66 | out_pct = float(sys.argv[3].split("=")[1])
67 | genes = list()
68 | geneSeq = dict()
69 | HGT = list()
70 | warnings.simplefilter('ignore', BiopythonWarning)
71 |
72 | with open(name, 'r') as handleGene :
73 | for record in SeqIO.parse(handleGene, "fasta") :
74 | gene = str(record.id)
75 | sequence = str(record.seq)
76 | geneSeq[gene] = sequence
77 | genes.append(gene)
78 |
79 | n=0
80 | for gene in genes :
81 | n += 1
82 | print("This is gene %d------------------" %(n))
83 | print(gene)
84 |
85 | if os.path.exists("./blastp_files/%s.txt" % gene) :
86 | accession_number,evalue = parse_NCBI(gene)
87 | print('Yes, blast file already exists, nice!')
88 | else :
89 | # Need to install blast!
90 | with open('./%s.fasta' % gene, 'w') as outfile :
91 | outfile.write('>'+gene+'\n')
92 | outfile.write(geneSeq[gene]+'\n')
93 | if not os.path.exists("./blastp_files/") :
94 | os.system('mkdir ./blastp_files')
95 | myCmd = "blastp -db nr -remote -query ./%s.fasta -max_target_seqs 250 -task 'blastp-fast' -outfmt '7 qacc sacc evalue bitscore length pident' -out ./blastp_files/%s.txt" %(gene, gene)
96 | os.system(myCmd)
97 | os.remove('./%s.fasta' % gene)
98 | accession_number,evalue = parse_NCBI(gene)
99 |
100 | ncbi = NCBITaxa()
101 | outgroup = list()
102 | ingroup = list()
103 | outgroup_species = list()
104 | ingroup_species = list()
105 | outgroup_dict = dict()
106 | ingroup_dict = dict()
107 | e_minus = 1e-200
108 |
109 | try :
110 | gene_taxid = getTaxid(gene)
111 | gene_lineage = ncbi.get_lineage(gene_taxid)
112 | gene_lineage2ranks = ncbi.get_rank(gene_lineage)
113 | gene_ranks2lineage = dict((rank, taxid) for (taxid, rank) in gene_lineage2ranks.items())
114 | gene_taxonomy_alignment = gene_ranks2lineage
115 | gene_kingdom = gene_taxonomy_alignment['kingdom']
116 | gene_subphylum = gene_taxonomy_alignment['subphylum']
117 | # print(gene_kingdom)
118 | # print(type(gene_kingdom)) #
119 | # print(gene_subphylum)
120 | except :
121 | print('Attention: please check the gene accession id!')
122 | break
123 |
124 | for accession in accession_number[:200] :
125 | try :
126 | # print(accession)
127 | taxid = getTaxid(accession)
128 | print('Taxid by BLAST:', taxid)
129 | except :
130 | continue
131 |
132 | try :
133 | lineage = ncbi.get_lineage(taxid)
134 | lineage2ranks = ncbi.get_rank(lineage)
135 | ranks2lineage = dict((rank, taxid) for (taxid, rank) in lineage2ranks.items())
136 |
137 | taxonomy_alignment = ranks2lineage
138 | LINNAEUS_FILTER = ["subphylum","kingdom","superkingdom"]
139 | except :
140 | print('Warning: %s taxid not found!' % str(taxid))
141 | continue
142 |
143 | try :
144 | if taxonomy_alignment['kingdom'] != gene_kingdom :
145 | outgroup.append(accession)
146 | outgroup_species.append(taxonomy_alignment['species'])
147 |
148 | if taxonomy_alignment['kingdom'] == gene_kingdom and taxonomy_alignment['subphylum'] != gene_subphylum :
149 | ingroup.append(accession)
150 | ingroup_species.append(taxonomy_alignment['species'])
151 |
152 | except :
153 | outgroup.append(accession)
154 | try :
155 | outgroup_species.append(taxonomy_alignment['species'])
156 | except :
157 | continue
158 |
159 | for accession_id in outgroup :
160 | outgroup_dict[accession_id] = evalue[accession_id]
161 |
162 | for accession_id in ingroup :
163 | ingroup_dict[accession_id] = evalue[accession_id]
164 |
165 | if outgroup_dict :
166 | min_outgroup_key = min(outgroup_dict,key=outgroup_dict.get)
167 | min_outgroup_evalue = outgroup_dict[min_outgroup_key]
168 | else :
169 | min_outgroup_evalue = 1
170 |
171 | if ingroup_dict :
172 | min_ingroup_key = min(ingroup_dict,key=ingroup_dict.get)
173 | min_ingroup_evalue = ingroup_dict[min_ingroup_key]
174 | else :
175 | min_ingroup_evalue = 1
176 |
177 | alienindex = format(math.log(min_ingroup_evalue+e_minus, math.e)-math.log(min_outgroup_evalue+e_minus, math.e), '.2f')
178 | try :
179 | outg_pct = format(len(set(outgroup_species))/(len(set(outgroup_species))+len(set(ingroup_species))), '.4f')
180 | except :
181 | continue
182 |
183 | print('Alien index: %s' % str(alienindex))
184 |
185 | if float(alienindex) >= AI and float(outg_pct) >= out_pct :
186 | print('This is a HGT event')
187 | print('Accession_id: %s' % min_outgroup_key)
188 | print('Evalue: %s' % evalue[min_outgroup_key])
189 | taxid= getTaxid(min_outgroup_key)
190 | Evalue = evalue[min_outgroup_key]
191 | lineage = ncbi.get_lineage(taxid)
192 | lineage2ranks = ncbi.get_rank(lineage)
193 | ranks2lineage = dict((rank, taxid) for (taxid, rank) in lineage2ranks.items())
194 | # print(lineage)
195 | # print(ranks2lineage)
196 | taxid2name = ncbi.get_taxid_translator([ranks2lineage['phylum'], ranks2lineage['class'], ranks2lineage['superkingdom']])
197 | print(taxid2name[ranks2lineage['phylum']])
198 |
199 | superkingdom = taxid2name[ranks2lineage['superkingdom']]
200 | phylum = taxid2name[ranks2lineage['phylum']]
201 | hgt = 'Yes'
202 | taxonomy = superkingdom + '/' + phylum
203 |
204 | item = [gene, alienindex, Evalue, min_outgroup_key, taxonomy]
205 | HGT.append(item)
206 |
207 | else:
208 | # print('This is not a HGT event')
209 | hgt = 'No'
210 | HGT.append([gene,alienindex,'No', 'No', 'No'])
211 |
212 | outfile = open("./output_distant_HGT.tsv", "wt")
213 | tsv_writer = csv.writer(outfile, delimiter="\t")
214 | column = ['Gene/Protein', 'Alien index', 'E value', 'Donor id', 'Donor taxonomy']
215 | tsv_writer.writerow(column)
216 | for HGT_info in HGT :
217 | tsv_writer.writerow(HGT_info)
218 | outfile.close()
219 |
220 |
221 | if __name__== "__main__":
222 | main()
223 |
--------------------------------------------------------------------------------
/main/blastp.py:
--------------------------------------------------------------------------------
1 | #!/usr/bin/python
2 | # coding: utf-8
3 |
4 | ### Usage: python blastp.py input.fasta
5 |
6 | import os
7 | import sys
8 | import time
9 | from Bio import SeqIO
10 |
11 |
12 | def main() :
13 | start_time = time.time()
14 | name = sys.argv[1:][0]
15 | genes = list()
16 | geneSeq = dict()
17 | with open(name, 'r') as handleGene :
18 | for record in SeqIO.parse(handleGene, "fasta") :
19 | gene = str(record.id)
20 | sequence = str(record.seq)
21 | geneSeq[gene] = sequence
22 | genes.append(gene)
23 |
24 | for gene in genes :
25 | print('This is gene:', gene)
26 | with open('./%s.fasta' % gene, 'w') as outfile :
27 | outfile.write('>'+gene+'\n')
28 | outfile.write(geneSeq[gene]+'\n')
29 | if not os.path.exists("./blastp_files/") :
30 | os.system('mkdir ./blastp_files')
31 | # Execute shell command line in Python using the os.system function
32 | myCmd = "blastp -db nr -remote -query ./%s.fasta -max_target_seqs 250 -task 'blastp-fast' -outfmt '7 qacc sacc evalue bitscore length pident' -out ./blastp_files/%s.txt" % (gene, gene)
33 | os.system(myCmd)
34 | os.remove('./%s.fasta' % gene)
35 |
36 | elapsed_time = (time.time() - start_time)
37 | print("Finished------------------")
38 | print("Running the Blast process: %.4fs" %(elapsed_time))
39 |
40 |
41 | if __name__ == "__main__" :
42 | main()
--------------------------------------------------------------------------------
/phylogenetics/input/YOL164W.fasta:
--------------------------------------------------------------------------------
1 | >YOL164W
2 | MIGAFKRNRGSSQSFAKECQPSTLKANLEVAKELPFSDRRDFEDATQGYIGSLSDEQIIGPDGGVVWCMKSYGFLEPETPANTVNPSLWRQAQLNAIHGLFKITDNVYQVRGLDISNMTIIEGNTSLIIIDTLFTTETAQESLKLYYRHRPQKPVRTVIYTHSHSDHYGGVKGIVKEADVKSGEVQIIAPVGFMESVVAENILAGNAMHRRSQYQFGMLLSPSVKGHVDCGIGKAASHGTVTLIAPTIIIEEPVEERTIDGVDFVFQLAPGSEAPSEMLIYMPQQRVLNMAEDVTHHMHNLYALRGVEVRDGNQWAKYIDAARVAFGSKTDVLIAQHHWPTTGQMRINELLKKQRDMYKFIHDQTLRLLNQGYTSRDIAETLRMPSSLEQEWSTRGYYGTLSHNVKAVYQKYLGWYDANPANLNPLPPVAYAKKAVEYMGGADAVLARAYKDFQKGEFRWVASVVNQLVFADPNNHQARELCADALEQLGYQAEASTWRNAYLVGAMELRQGVPKRRSTGKRNNIAVLNNEMFFDFLAVRLNATKAEGKIIVSNWCFINSNERFVITLENCALTYIQGWQTDADATITLKRTTFEALLANEITMVDFLRSKEVEIEGNRLRIEELLKLFDDFDQSFPVVEPMGGST
--------------------------------------------------------------------------------
/phylogenetics/input/YOL164W.txt:
--------------------------------------------------------------------------------
1 | YOL164W 646 NP_014478.1 100.0 646 0.0e+00 1306.2
2 | YOL164W 646 AJT92780.1 99.7 646 0.0e+00 1303.5
3 | YOL164W 646 AJU05032.1 99.5 646 0.0e+00 1301.6
4 | YOL164W 646 AJU05530.1 99.5 646 0.0e+00 1301.2
5 | YOL164W 646 AJT72762.1 99.4 646 0.0e+00 1300.0
6 | YOL164W 646 CAC9901847.1 99.4 646 0.0e+00 1299.3
7 | YOL164W 646 AJU07963.1 99.2 646 0.0e+00 1297.7
8 | YOL164W 646 CAC9924707.1 99.1 646 0.0e+00 1297.3
9 | YOL164W 646 CAC9914509.1 93.7 646 0.0e+00 1204.1
10 | YOL164W 646 QLG72306.1 78.0 642 6.6e-302 1046.6
11 | YOL164W 646 WP_007837899.1 68.2 633 3.2e-256 894.8
12 | YOL164W 646 WP_116911865.1 68.0 632 7.9e-255 890.2
13 | YOL164W 646 WP_093241869.1 68.6 628 1.0e-254 889.8
14 | YOL164W 646 WP_108140783.1 67.9 632 1.3e-254 889.4
15 | YOL164W 646 WP_132801781.1 67.9 632 1.3e-254 889.4
16 | YOL164W 646 WP_184638849.1 67.6 632 2.3e-254 888.6
17 | YOL164W 646 WP_184605932.1 67.7 632 6.7e-254 887.1
18 | YOL164W 646 WP_145759386.1 67.6 632 8.7e-254 886.7
19 | YOL164W 646 WP_093435402.1 67.6 638 1.5e-253 885.9
20 | YOL164W 646 WP_176665552.1 66.6 638 1.9e-253 885.6
21 | YOL164W 646 WP_097197469.1 67.6 633 1.9e-253 885.6
22 | YOL164W 646 WP_093195641.1 67.2 632 2.5e-253 885.2
23 | YOL164W 646 WP_119556153.1 68.1 627 2.5e-253 885.2
24 | YOL164W 646 WP_093174861.1 67.6 633 3.3e-253 884.8
25 | YOL164W 646 WP_126020505.1 67.4 631 4.3e-253 884.4
26 | YOL164W 646 WP_093076613.1 67.6 633 4.3e-253 884.4
27 | YOL164W 646 WP_081267376.1 67.1 633 7.4e-253 883.6
28 | YOL164W 646 WP_132755990.1 67.4 632 9.6e-253 883.2
29 | YOL164W 646 TAJ61793.1 67.9 627 9.6e-253 883.2
30 | YOL164W 646 WP_106936183.1 67.3 633 1.3e-252 882.9
31 | YOL164W 646 WP_126183471.1 67.6 627 1.6e-252 882.5
32 | YOL164W 646 WP_093300535.1 66.9 638 1.6e-252 882.5
33 | YOL164W 646 WP_130421160.1 66.8 632 1.6e-252 882.5
34 | YOL164W 646 ODU15846.1 67.3 633 2.1e-252 882.1
35 | YOL164W 646 WP_153281245.1 68.2 628 2.1e-252 882.1
36 | YOL164W 646 WP_013538622.1 67.2 638 2.8e-252 881.7
37 | YOL164W 646 WP_093057006.1 67.5 633 2.8e-252 881.7
38 | YOL164W 646 WP_052810747.1 67.7 632 2.8e-252 881.7
39 | YOL164W 646 WP_124458460.1 66.9 635 2.8e-252 881.7
40 | YOL164W 646 WP_125952496.1 66.8 638 3.7e-252 881.3
41 | YOL164W 646 WP_062470459.1 68.3 628 3.7e-252 881.3
42 | YOL164W 646 WP_139703542.1 68.2 628 3.7e-252 881.3
43 | YOL164W 646 WP_099794476.1 68.2 628 4.8e-252 880.9
44 | YOL164W 646 WP_056574498.1 67.8 628 1.1e-251 879.8
45 | YOL164W 646 WP_101490554.1 68.0 628 1.8e-251 879.0
46 | YOL164W 646 WP_126472589.1 66.6 638 1.8e-251 879.0
47 | YOL164W 646 WP_070061350.1 68.0 628 2.4e-251 878.6
48 | YOL164W 646 WP_095948515.1 67.8 628 2.4e-251 878.6
49 | YOL164W 646 WP_159274326.1 68.0 628 3.1e-251 878.2
50 | YOL164W 646 WP_187113215.1 67.5 628 3.1e-251 878.2
51 | YOL164W 646 WP_095743122.1 67.8 628 1.2e-250 876.3
52 | YOL164W 646 WP_159278964.1 67.5 628 2.6e-250 875.2
53 | YOL164W 646 WP_172705422.1 67.1 627 7.6e-250 873.6
54 | YOL164W 646 KPU98577.1 67.1 627 7.6e-250 873.6
55 | YOL164W 646 WP_176660984.1 66.9 632 9.9e-250 873.2
56 | YOL164W 646 WP_093343818.1 68.1 615 4.9e-249 870.9
57 | YOL164W 646 WP_145738683.1 66.8 639 1.1e-248 869.8
58 | YOL164W 646 XP_002555886.1 65.5 631 1.4e-248 869.4
59 | YOL164W 646 WP_020722993.1 66.2 636 5.5e-248 867.5
60 | YOL164W 646 SCW03834.1 65.2 626 7.9e-247 863.6
61 | YOL164W 646 XP_018221989.1 64.9 638 7.6e-242 847.0
62 | YOL164W 646 MBS76598.1 66.7 615 1.3e-241 846.3
63 | YOL164W 646 QID88192.1 64.7 638 8.4e-241 843.6
64 | YOL164W 646 WP_093131647.1 64.5 625 4.2e-240 841.3
65 | YOL164W 646 KAF1061273.1 63.6 627 1.1e-229 806.6
66 | YOL164W 646 OQW56345.1 60.3 630 1.5e-221 779.6
67 | YOL164W 646 WP_092831606.1 59.1 626 2.2e-217 765.8
68 | YOL164W 646 WP_175367589.1 57.5 628 3.9e-214 755.0
69 | YOL164W 646 WP_184513838.1 57.5 628 5.2e-214 754.6
70 | YOL164W 646 WP_089261759.1 57.8 628 6.7e-214 754.2
71 | YOL164W 646 WP_120288614.1 56.8 628 7.4e-213 750.7
72 | YOL164W 646 WP_092138970.1 57.0 628 3.1e-211 745.3
73 | YOL164W 646 WP_146690165.1 57.4 643 5.3e-211 744.6
74 | YOL164W 646 WP_100386102.1 57.2 643 1.6e-210 743.0
75 | YOL164W 646 WP_057659955.1 54.7 645 2.6e-210 742.3
76 | YOL164W 646 WP_115033941.1 56.7 633 1.0e-209 740.3
77 | YOL164W 646 WP_149531854.1 57.5 626 1.1e-208 736.9
78 | YOL164W 646 OJY11205.1 57.0 628 4.2e-208 734.9
79 | YOL164W 646 WP_077034059.1 56.9 634 1.2e-207 733.4
80 | YOL164W 646 WP_062313220.1 55.9 632 2.7e-207 732.3
81 | YOL164W 646 WP_019195750.1 55.9 632 4.7e-207 731.5
82 | YOL164W 646 NVN87899.1 56.3 631 8.0e-207 730.7
83 | YOL164W 646 WP_024920006.1 55.7 634 1.8e-206 729.6
84 | YOL164W 646 WP_011665574.1 56.6 629 1.8e-206 729.6
85 | YOL164W 646 MBB5054515.1 55.8 634 2.3e-206 729.2
86 | YOL164W 646 WP_184089169.1 55.8 634 2.3e-206 729.2
87 | YOL164W 646 TXJ10197.1 56.5 634 2.3e-206 729.2
88 | YOL164W 646 WP_046827511.1 55.7 634 2.3e-206 729.2
89 | YOL164W 646 HBR43714.1 55.7 634 3.0e-206 728.8
90 | YOL164W 646 ABD08837.1 55.7 650 3.0e-206 728.8
91 | YOL164W 646 WP_041798938.1 55.7 650 3.0e-206 728.8
92 | YOL164W 646 WP_006021976.1 55.7 628 8.8e-206 727.2
93 | YOL164W 646 WP_110782500.1 56.1 633 8.8e-206 727.2
94 | YOL164W 646 RTL81632.1 55.5 634 1.2e-205 726.9
95 | YOL164W 646 HAQ93654.1 55.5 634 1.2e-205 726.9
96 | YOL164W 646 TAH64925.1 55.9 633 2.0e-205 726.1
97 | YOL164W 646 WP_027475679.1 56.7 626 2.0e-205 726.1
98 | YOL164W 646 NGX94573.1 56.0 634 4.4e-205 724.9
99 | YOL164W 646 WP_027276359.1 56.1 633 5.7e-205 724.5
100 | YOL164W 646 WP_164571151.1 56.7 628 7.5e-205 724.2
101 | YOL164W 646 WP_164638651.1 56.8 628 7.5e-205 724.2
102 | YOL164W 646 WP_107345917.1 56.7 628 9.7e-205 723.8
103 | YOL164W 646 WP_163259863.1 55.8 627 1.7e-204 723.0
104 | YOL164W 646 WP_107356882.1 56.5 628 1.7e-204 723.0
105 | YOL164W 646 WP_136963313.1 56.6 631 1.7e-204 723.0
106 | YOL164W 646 RUP23521.1 55.8 626 1.7e-204 723.0
107 | YOL164W 646 WP_011159875.1 56.8 628 2.8e-204 722.2
108 | YOL164W 646 WP_157443435.1 56.2 626 3.7e-204 721.8
109 | YOL164W 646 WP_012497548.1 56.7 628 3.7e-204 721.8
110 | YOL164W 646 WP_002713184.1 55.4 628 1.8e-203 719.5
111 | YOL164W 646 WP_013504207.1 56.2 628 2.4e-203 719.2
112 | YOL164W 646 WP_008968903.1 56.2 624 4.1e-203 718.4
113 | YOL164W 646 KAB2911669.1 55.0 634 7.0e-203 717.6
114 | YOL164W 646 WP_024577766.1 55.3 628 7.0e-203 717.6
115 | YOL164W 646 WP_119019080.1 56.7 628 7.0e-203 717.6
116 | YOL164W 646 WP_022722993.1 55.6 629 2.0e-202 716.1
117 | YOL164W 646 WP_047308756.1 56.1 628 2.0e-202 716.1
118 | YOL164W 646 WP_164630935.1 56.1 628 2.7e-202 715.7
119 | YOL164W 646 WP_187448402.1 55.3 619 3.5e-202 715.3
120 | YOL164W 646 GBU15266.1 53.5 632 3.5e-202 715.3
121 | YOL164W 646 WP_009734135.1 55.1 628 5.9e-202 714.5
122 | YOL164W 646 WP_151072822.1 53.5 648 3.8e-201 711.8
123 | YOL164W 646 WP_108104178.1 53.1 644 2.5e-200 709.1
124 | YOL164W 646 WP_119858943.1 55.4 628 3.2e-200 708.8
125 | YOL164W 646 WP_017937932.1 53.7 628 4.2e-200 708.4
126 | YOL164W 646 WP_142883484.1 55.7 628 4.2e-200 708.4
127 | YOL164W 646 WP_114359664.1 55.0 631 1.6e-199 706.4
128 | YOL164W 646 WP_089945766.1 53.6 632 3.6e-199 705.3
129 | YOL164W 646 WP_074826082.1 52.8 634 4.7e-199 704.9
130 | YOL164W 646 WP_084803943.1 53.2 628 4.7e-199 704.9
131 | YOL164W 646 OGL20369.1 53.6 631 4.7e-199 704.9
132 | YOL164W 646 WP_074117602.1 53.2 628 6.1e-199 704.5
133 | YOL164W 646 WP_046828790.1 53.5 628 1.0e-198 703.7
134 | YOL164W 646 WP_065748757.1 53.3 628 1.0e-198 703.7
135 | YOL164W 646 WP_161852777.1 53.3 628 1.4e-198 703.4
136 | YOL164W 646 WP_057833547.1 52.7 628 3.0e-198 702.2
137 | YOL164W 646 WP_089717141.1 53.5 628 5.2e-198 701.4
138 | YOL164W 646 WP_171577827.1 52.6 633 6.8e-198 701.0
139 | YOL164W 646 WP_079601315.1 52.2 628 6.8e-198 701.0
140 | YOL164W 646 EGP08750.1 53.0 628 6.8e-198 701.0
141 | YOL164W 646 WP_043924226.1 53.0 628 6.8e-198 701.0
142 | YOL164W 646 WP_138835123.1 52.5 634 8.8e-198 700.7
143 | YOL164W 646 WP_155805222.1 52.9 628 8.8e-198 700.7
144 | YOL164W 646 WP_065756637.1 52.5 634 8.8e-198 700.7
145 | YOL164W 646 WP_002714592.1 53.2 628 1.2e-197 700.3
146 | YOL164W 646 WP_092515866.1 51.6 639 1.2e-197 700.3
147 | YOL164W 646 WP_128961978.1 53.0 628 1.2e-197 700.3
148 | YOL164W 646 WP_128953098.1 53.0 628 1.2e-197 700.3
149 | YOL164W 646 SDP08864.1 51.6 639 1.2e-197 700.3
150 | YOL164W 646 WP_071915975.1 53.0 628 2.0e-197 699.5
151 | YOL164W 646 WP_057859318.1 52.2 634 2.0e-197 699.5
152 | YOL164W 646 WP_065730813.1 53.2 628 2.0e-197 699.5
153 | YOL164W 646 WP_079586579.1 52.5 634 4.4e-197 698.4
154 | YOL164W 646 WP_085404469.1 53.3 628 4.4e-197 698.4
155 | YOL164W 646 WP_063680948.1 53.0 628 5.7e-197 698.0
156 | YOL164W 646 WP_155709830.1 54.2 622 9.8e-197 697.2
157 | YOL164W 646 WP_028347371.1 52.7 628 9.8e-197 697.2
158 | YOL164W 646 PYN74367.1 52.3 627 9.8e-197 697.2
159 | YOL164W 646 WP_092295676.1 52.7 628 9.8e-197 697.2
160 | YOL164W 646 WP_108514566.1 52.7 628 1.3e-196 696.8
161 | YOL164W 646 TMJ47098.1 52.4 636 1.3e-196 696.8
162 | YOL164W 646 WP_063984832.1 52.9 628 1.3e-196 696.8
163 | YOL164W 646 WP_027528936.1 52.6 633 1.7e-196 696.4
164 | YOL164W 646 WP_024518537.1 52.5 628 2.2e-196 696.0
165 | YOL164W 646 WP_145664020.1 52.8 633 2.2e-196 696.0
166 | YOL164W 646 WP_028156991.1 52.5 628 2.2e-196 696.0
167 | YOL164W 646 WP_066731373.1 53.4 627 2.8e-196 695.7
168 | YOL164W 646 WP_100380578.1 51.8 628 2.8e-196 695.7
169 | YOL164W 646 PYM96198.1 52.5 631 2.8e-196 695.7
170 | YOL164W 646 WP_071072555.1 53.0 623 3.7e-196 695.3
171 | YOL164W 646 WP_071038742.1 53.0 623 4.8e-196 694.9
172 | YOL164W 646 WP_007594037.1 52.5 628 4.8e-196 694.9
173 | YOL164W 646 WP_143206068.1 52.5 628 4.8e-196 694.9
174 | YOL164W 646 WP_071018820.1 53.0 623 6.3e-196 694.5
175 | YOL164W 646 WP_146687675.1 51.2 637 6.3e-196 694.5
176 | YOL164W 646 WP_045002869.1 52.1 634 6.3e-196 694.5
177 | YOL164W 646 WP_028150107.1 52.9 628 6.3e-196 694.5
178 | YOL164W 646 WP_148749019.1 51.8 635 1.1e-195 693.7
179 | YOL164W 646 WP_011085536.1 52.7 628 1.4e-195 693.3
180 | YOL164W 646 WP_038965832.1 52.7 628 1.4e-195 693.3
181 | YOL164W 646 QHP72204.1 52.5 628 1.4e-195 693.3
182 | YOL164W 646 WP_161535945.1 52.5 628 1.4e-195 693.3
183 | YOL164W 646 WP_123890502.1 53.1 635 1.4e-195 693.3
184 | YOL164W 646 PYN46404.1 52.9 628 1.4e-195 693.3
185 | YOL164W 646 RZL87373.1 53.9 629 1.4e-195 693.3
186 | YOL164W 646 WP_063691485.1 52.4 633 1.8e-195 693.0
187 | YOL164W 646 WP_063993269.1 52.4 628 1.8e-195 693.0
188 | YOL164W 646 WP_060912981.1 52.4 628 1.8e-195 693.0
189 | YOL164W 646 WP_079544782.1 52.5 629 1.8e-195 693.0
190 | YOL164W 646 WP_063705824.1 52.3 633 1.8e-195 693.0
191 | YOL164W 646 BAR59885.1 52.4 628 1.8e-195 693.0
192 | YOL164W 646 KGJ68294.1 52.4 628 2.4e-195 692.6
193 | YOL164W 646 PZW26129.1 52.9 631 2.4e-195 692.6
194 | YOL164W 646 WP_111324427.1 52.9 631 2.4e-195 692.6
195 | YOL164W 646 WP_028174753.1 52.4 628 2.4e-195 692.6
196 | YOL164W 646 WP_076861029.1 53.4 624 3.1e-195 692.2
197 | YOL164W 646 MAB24835.1 53.1 635 4.1e-195 691.8
198 | YOL164W 646 WP_041955910.1 52.0 633 4.1e-195 691.8
199 | YOL164W 646 MBA2399293.1 52.1 628 4.1e-195 691.8
200 | YOL164W 646 WP_166089364.1 53.0 628 5.4e-195 691.4
201 | YOL164W 646 WP_054162298.1 53.8 628 5.4e-195 691.4
202 | YOL164W 646 MBC9878718.1 52.7 628 5.4e-195 691.4
203 | YOL164W 646 WP_008138438.1 52.7 628 5.4e-195 691.4
204 | YOL164W 646 WP_158669522.1 51.8 633 5.4e-195 691.4
205 | YOL164W 646 TMK39387.1 52.0 637 5.4e-195 691.4
206 | YOL164W 646 WP_128967591.1 52.2 628 5.4e-195 691.4
207 | YOL164W 646 WP_057753835.1 52.2 628 7.0e-195 691.0
208 | YOL164W 646 WP_028135100.1 52.4 628 7.0e-195 691.0
209 | YOL164W 646 WP_057900995.1 53.7 613 7.0e-195 691.0
210 | YOL164W 646 WP_035655465.1 52.9 628 7.0e-195 691.0
211 | YOL164W 646 WP_027550185.1 52.3 633 7.0e-195 691.0
212 | YOL164W 646 WP_057843198.1 52.5 628 7.0e-195 691.0
213 | YOL164W 646 RTM13090.1 52.2 628 9.1e-195 690.6
214 | YOL164W 646 WP_057851642.1 53.7 613 9.1e-195 690.6
215 | YOL164W 646 WP_027568791.1 51.9 634 9.1e-195 690.6
216 | YOL164W 646 WP_130580234.1 51.8 628 9.1e-195 690.6
217 | YOL164W 646 WP_148775460.1 52.4 628 9.1e-195 690.6
218 | YOL164W 646 WP_027516639.1 51.7 634 1.2e-194 690.3
219 | YOL164W 646 WP_085395770.1 51.9 636 1.2e-194 690.3
220 | YOL164W 646 WP_182248855.1 52.8 635 1.6e-194 689.9
221 | YOL164W 646 TKW79521.1 52.1 628 1.6e-194 689.9
222 | YOL164W 646 WP_136868902.1 53.6 625 1.6e-194 689.9
223 | YOL164W 646 WP_061878281.1 52.5 628 1.6e-194 689.9
224 | YOL164W 646 WP_135167913.1 52.1 628 1.6e-194 689.9
225 | YOL164W 646 NVN85223.1 53.4 611 1.6e-194 689.9
226 | YOL164W 646 WP_106942729.1 52.2 628 1.6e-194 689.9
227 | YOL164W 646 WP_182869822.1 52.5 628 1.6e-194 689.9
228 | YOL164W 646 WP_126256569.1 52.1 628 2.0e-194 689.5
229 | YOL164W 646 WP_172134110.1 52.3 635 2.0e-194 689.5
230 | YOL164W 646 WP_166350707.1 51.9 634 2.0e-194 689.5
231 | YOL164W 646 WP_035715237.1 52.0 633 2.7e-194 689.1
232 | YOL164W 646 WP_100419024.1 52.7 628 2.7e-194 689.1
233 | YOL164W 646 WP_172180802.1 52.1 635 2.7e-194 689.1
234 | YOL164W 646 CCD98599.1 53.8 613 2.7e-194 689.1
235 | YOL164W 646 WP_085352090.1 51.9 634 2.7e-194 689.1
236 | YOL164W 646 WP_140980779.1 51.8 628 3.5e-194 688.7
237 | YOL164W 646 WP_150987011.1 53.2 635 4.5e-194 688.3
238 | YOL164W 646 WP_091965654.1 52.2 628 4.5e-194 688.3
239 | YOL164W 646 WP_083726556.1 53.2 619 4.5e-194 688.3
240 | YOL164W 646 EZQ18937.1 53.4 625 5.9e-194 688.0
241 | YOL164W 646 WP_024511517.1 51.8 633 5.9e-194 688.0
242 | YOL164W 646 WP_116319445.1 52.8 623 5.9e-194 688.0
243 | YOL164W 646 THD60673.1 51.4 628 5.9e-194 688.0
244 | YOL164W 646 WP_185267007.1 52.2 628 7.7e-194 687.6
245 | YOL164W 646 WP_168167890.1 52.5 628 7.7e-194 687.6
246 | YOL164W 646 OJY09878.1 53.4 631 7.7e-194 687.6
247 | YOL164W 646 WP_183237909.1 52.1 628 7.7e-194 687.6
248 | YOL164W 646 WP_018322728.1 52.2 628 1.0e-193 687.2
249 | YOL164W 646 WP_172111906.1 52.0 635 1.0e-193 687.2
250 | YOL164W 646 WP_033962854.1 53.4 625 1.0e-193 687.2
251 | YOL164W 646 WP_151642895.1 51.8 628 1.0e-193 687.2
252 | YOL164W 646 WP_015687718.1 51.8 628 1.3e-193 686.8
253 | YOL164W 646 WP_183035411.1 52.9 635 1.3e-193 686.8
254 | YOL164W 646 WP_128939625.1 51.5 633 1.3e-193 686.8
255 | YOL164W 646 WP_092029312.1 52.2 628 1.3e-193 686.8
256 | YOL164W 646 WP_035674808.1 52.0 633 1.3e-193 686.8
257 | YOL164W 646 PYN32128.1 52.5 631 1.3e-193 686.8
258 | YOL164W 646 MBB1634382.1 52.9 635 1.3e-193 686.8
259 | YOL164W 646 WP_028179375.1 52.0 633 1.3e-193 686.8
260 | YOL164W 646 WP_148744709.1 51.9 628 1.3e-193 686.8
261 | YOL164W 646 WP_061999991.1 52.6 629 1.7e-193 686.4
262 | YOL164W 646 WP_069276965.1 51.6 634 1.7e-193 686.4
263 | YOL164W 646 WP_027526029.1 51.8 633 1.7e-193 686.4
264 | YOL164W 646 WP_083842450.1 52.6 635 1.7e-193 686.4
265 | YOL164W 646 WP_061021165.1 51.9 628 1.7e-193 686.4
266 | YOL164W 646 WP_025586346.1 54.0 619 2.3e-193 686.0
267 | YOL164W 646 WP_093476299.1 52.4 634 2.3e-193 686.0
268 | YOL164W 646 WP_104462928.1 52.1 628 2.3e-193 686.0
269 | YOL164W 646 WP_183258594.1 52.1 628 2.3e-193 686.0
270 | YOL164W 646 PKM29133.1 51.5 635 2.3e-193 686.0
271 | YOL164W 646 WP_011439962.1 51.0 637 2.3e-193 686.0
272 | YOL164W 646 WP_128955323.1 51.2 635 2.3e-193 686.0
273 | YOL164W 646 WP_018457146.1 51.7 634 2.3e-193 686.0
274 | YOL164W 646 WP_038931390.1 51.7 634 2.9e-193 685.6
275 | YOL164W 646 WP_135162274.1 52.2 628 2.9e-193 685.6
276 | YOL164W 646 WP_092214970.1 51.4 628 2.9e-193 685.6
277 | YOL164W 646 WP_100175831.1 51.8 628 2.9e-193 685.6
278 | YOL164W 646 WP_092594144.1 54.2 627 2.9e-193 685.6
279 | YOL164W 646 WP_039157276.1 51.7 634 2.9e-193 685.6
280 | YOL164W 646 WP_116388232.1 53.9 618 3.8e-193 685.3
281 | YOL164W 646 GAJ33771.1 51.5 641 3.8e-193 685.3
282 | YOL164W 646 WP_092259760.1 52.1 628 3.8e-193 685.3
283 | YOL164W 646 WP_142250055.1 51.8 628 3.8e-193 685.3
284 | YOL164W 646 WP_172648278.1 51.6 634 5.0e-193 684.9
285 | YOL164W 646 WP_028143098.1 51.7 633 5.0e-193 684.9
286 | YOL164W 646 WP_119419155.1 53.3 628 5.0e-193 684.9
287 | YOL164W 646 WP_116377884.1 53.5 622 5.0e-193 684.9
288 | YOL164W 646 WP_027558441.1 51.3 628 5.0e-193 684.9
289 | YOL164W 646 WP_152103320.1 51.7 633 5.0e-193 684.9
290 | YOL164W 646 WP_179739631.1 52.1 628 5.0e-193 684.9
291 | YOL164W 646 WP_116320039.1 53.5 619 5.0e-193 684.9
292 | YOL164W 646 WP_183231495.1 52.1 628 5.0e-193 684.9
293 | YOL164W 646 WP_062795892.1 53.4 622 6.6e-193 684.5
294 | YOL164W 646 WP_130222300.1 51.4 628 6.6e-193 684.5
295 | YOL164W 646 TMK06221.1 51.3 634 6.6e-193 684.5
296 | YOL164W 646 WP_081889718.1 52.5 629 6.6e-193 684.5
297 | YOL164W 646 WP_062170184.1 52.1 629 6.6e-193 684.5
298 | YOL164W 646 WP_014497078.1 51.7 634 8.6e-193 684.1
299 | YOL164W 646 MBA4036164.1 51.3 636 8.6e-193 684.1
300 | YOL164W 646 WP_129271949.1 52.3 633 8.6e-193 684.1
301 |
--------------------------------------------------------------------------------
/phylogenetics/intermediate/YOL164W.bionj:
--------------------------------------------------------------------------------
1 | ((((WP_142250055.1-Bradyrhizobium_sp._UNPF46_Proteobacteria:-0.00005007,WP_100175831.1-Bradyrhizobium_nitroreducens_Proteobacteria:0.00165727):0.01606742,RTM13090.1-Bradyrhizobiaceae_bacterium_Proteobacteria:0.01879184):0.00868380,(((GAJ33771.1-Bradyrhizobium_sp._DOA9_Proteobacteria:0.03861547,(WP_061021165.1-Bradyrhizobium_sp._CCH5-F6_Proteobacteria:0.01458358,(WP_028179375.1-Bradyrhizobium_japonicum_Proteobacteria:0.00166049,WP_035674808.1-Bradyrhizobium_liaoningense_Proteobacteria:-0.00005479):0.01542790):0.00595711):0.00584917,(WP_126256569.1-Bradyrhizobium_sp._LVM_105_Proteobacteria:0.00115269,WP_135167913.1-Bradyrhizobium_frederickii_Proteobacteria:0.00046091):0.01552989):0.00064368,((WP_135162274.1-Bradyrhizobium_frederickii_Proteobacteria:0.02091999,WP_061878281.1-Bradyrhizobium_liaoningense_Proteobacteria:0.01932841):0.00144403,WP_028135100.1-Bradyrhizobium_japonicum_Proteobacteria:0.03194969):0.00329209):0.00382737):0.00022926,(((((((WP_183231495.1-Bradyrhizobium_sp._SBR1B_Proteobacteria:0.00173072,WP_092259760.1-Bradyrhizobium_sp._Rc3b_Proteobacteria:0.00148708):0.00007863,WP_183258594.1-Bradyrhizobium_sp._CIR48_Proteobacteria:-0.00007229):0.00853048,WP_018322728.1-Bradyrhizobium_sp._WSM2793_Proteobacteria:0.00456101):0.00123643,WP_183237909.1-Bradyrhizobium_sp._CIR18_Proteobacteria:0.00275150):0.00926720,WP_152103320.1-Bradyrhizobium_sp._TM102_Proteobacteria:0.01728354):0.00297061,(WP_104462928.1-Bradyrhizobium_sp._AC87j1_Proteobacteria:0.00808883,WP_091965654.1-Bradyrhizobium_shewense_Proteobacteria:0.00662797):0.00589229):0.00483487,(WP_035715237.1-Bradyrhizobium_sp._CCBAU_43298_Proteobacteria:0.00741616,WP_158669522.1-Bradyrhizobium_guangdongense_Proteobacteria:0.00570114):0.03344603):0.00085164,((((((((((((((((((((((((QUERY_Saccharomyces_cerevisiae_YOL164W:0.14155580,QLG72306.1-Zygotorulaspora_mrakii_Saccharomycotina:0.11773159):0.09315414,(SCW03834.1-Lachancea_fermentati_Saccharomycotina:0.13851029,XP_002555886.1-Lachancea_thermotolerans_Saccharomycotina:0.11475700):0.20510036):0.07499051,(WP_092831606.1-Rhodospirillales_bacterium_URHD0017_Proteobacteria:0.26869035,(((((((KAF1061273.1-Variovorax_sp._Proteobacteria:0.00549206,WP_093343818.1-Variovorax_sp._PDC80_Proteobacteria:0.00485994):0.00385868,(MBS76598.1-Variovorax_sp._Proteobacteria:-0.00662376,(KPU98577.1-Variovorax_paradoxus_Proteobacteria:0.00161797,WP_172705422.1-Variovorax_paradoxus_Proteobacteria:-0.00161697):0.00986783):0.00605932):0.00493429,TAJ61793.1-Variovorax_sp._Proteobacteria:0.00379656):0.05581824,((((((((((WP_020722993.1-Variovorax_paradoxus_Proteobacteria:0.00348371,(WP_126183471.1-Variovorax_sp._369_Proteobacteria:0.00387948,WP_145759386.1-Variovorax_sp._1180_Proteobacteria:-0.00071758):0.00356547):0.00038661,WP_184605932.1-Variovorax_sp._BK613_Proteobacteria:0.00124010):0.00185499,WP_132755990.1-Variovorax_sp._BK151_Proteobacteria:0.00459587):0.00036780,WP_132801781.1-Variovorax_sp._BK370_Proteobacteria:-0.00043729):0.00409418,WP_176665552.1-Variovorax_sp._SG517_Proteobacteria:0.01882211):0.00679368,(WP_126020505.1-Variovorax_guangxiensis_Proteobacteria:0.00179225,WP_184638849.1-Variovorax_guangxiensis_Proteobacteria:0.00296015):0.01846875):0.00611772,(WP_126472589.1-Variovorax_gossypii_Proteobacteria:0.00976684,WP_093195641.1-Variovorax_sp._YR750_Proteobacteria:0.00298186):0.01501569):0.00999719,(WP_093057006.1-Variovorax_sp._YR634_Proteobacteria:0.00013250,(WP_093076613.1-Variovorax_sp._OV084_Proteobacteria:0.00211408,(WP_093174861.1-Variovorax_sp._YR266_Proteobacteria:0.00206153,WP_097197469.1-Variovorax_sp._YR752_Proteobacteria:0.00109787):0.00170242):0.00459400):0.02781206):0.01271031,(WP_130421160.1-Variovorax_sp._BK460_Proteobacteria:0.04879893,WP_007837899.1-Variovorax_sp._CF313_Proteobacteria:0.02179327):0.00516054):0.00420860,(ODU15846.1-Variovorax_sp._SCN_67-85_Proteobacteria:0.01748665,WP_081267376.1-Variovorax_paradoxus_Proteobacteria:0.02740685):0.02262956):0.01564948):0.00942311,(WP_145738683.1-Variovorax_beijingensis_Proteobacteria:0.05278750,(((WP_176660984.1-Variovorax_sp._SG533_Proteobacteria:0.02802433,((WP_052810747.1-Variovorax_paradoxus_Proteobacteria:0.01436136,WP_093435402.1-Variovorax_sp._770b2_Proteobacteria:0.01818364):0.01226266,WP_013538622.1-Variovorax_paradoxus_Proteobacteria:0.02272676):0.01476490):0.02516467,WP_119556153.1-Acidovorax_cavernicola_Proteobacteria:0.04392453):0.00536771,((((((WP_159278964.1-Variovorax_boronicumulans_Proteobacteria:0.00423389,(WP_095743122.1-Variovorax_boronicumulans_Proteobacteria:0.00403164,WP_159274326.1-Variovorax_boronicumulans_Proteobacteria:0.00226946):0.00074885):0.00155676,WP_070061350.1-Variovorax_boronicumulans_Proteobacteria:0.00226817):0.00058387,WP_095948515.1-Variovorax_boronicumulans_Proteobacteria:0.00165360):0.00339707,WP_062470459.1-Variovorax_boronicumulans_Proteobacteria:-0.00003740):0.00345504,((((WP_101490554.1-Variovorax_sp._RO1_Proteobacteria:0.00399169,WP_099794476.1-Variovorax_sp._54_Proteobacteria:0.00388781):0.00107804,WP_153281245.1-Variovorax_paradoxus_Proteobacteria:0.00522233):0.00320353,WP_056574498.1-Variovorax_sp._Root473_Proteobacteria:0.02516064):0.00205902,WP_139703542.1-Variovorax_sp._KBS0712_Proteobacteria:0.00285137):0.00136247):0.01619121,((WP_187113215.1-Variovorax_sp._PAMC26660_Proteobacteria:0.02726836,WP_093241869.1-Variovorax_sp._EL159_Proteobacteria:0.01202125):0.02036869,WP_124458460.1-Variovorax_sp._KBW07_Proteobacteria:0.03854855):0.01743166):0.00784122):0.00966920):0.01505098):0.02025851,(QID88192.1-Saccharomyces_pastorianus_Saccharomycotina:0.00661901,XP_018221989.1-Saccharomyces_eubayanus_Saccharomycotina:-0.00034311):0.26979610):0.02052057,WP_093131647.1-Variovorax_sp._OK605_Proteobacteria:0.14058582):0.01573817):0.06433865):0.10542180,(((((PKM29133.1-Gammaproteobacteria_bacterium_HGW-Gammaproteobacteria-11_Proteobacteria:0.14616728,(WP_083726556.1-Pseudomonas_pachastrellae_Proteobacteria:0.08723138,(WP_182248855.1-Pseudomonas_sp._5Ae-yellow_Proteobacteria:0.01610492,MAB24835.1-Pseudomonadales_bacterium_Proteobacteria:0.01611978):0.09016365):0.09935082):0.16241145,((WP_093476299.1-Pseudomonas_yangmingensis_Proteobacteria:0.21986941,(WP_185267007.1-Pseudomonas_xiamenensis_Proteobacteria:0.08760912,(EZQ18937.1-Pseudomonas_bauzanensis_Proteobacteria:-0.00020577,WP_136868902.1-Pseudomonas_bauzanensis_Proteobacteria:0.00647827):0.12435905):0.11054774):0.04643112,(WP_017937932.1-Pseudomonas_thermotolerans_Proteobacteria:0.14657837,WP_108104178.1-Pseudomonas_mangrovi_Proteobacteria:0.10007953):0.08025406):0.05549892):0.07119827,(WP_077034059.1-Pelomonas_sp._KK5_Proteobacteria:0.31644282,WP_057659955.1-Pseudoxanthomonas_dokdonensis_Proteobacteria:0.17870378):0.10150386):0.07679605,WP_151072822.1-Cupriavidus_oxalaticus_Proteobacteria:0.36699289):0.01354036,((((((((((WP_054162298.1-Rhodopseudomonas_sp._AAP120_Proteobacteria:0.09267844,WP_022722993.1-Rhodopseudomonas_sp._B29_Proteobacteria:0.04142976):0.01992554,((WP_142883484.1-Rhodopseudomonas_palustris_Proteobacteria:0.02560758,((WP_164630935.1-Rhodopseudomonas_sp._WA056_Proteobacteria:-0.00040701,WP_047308756.1-Rhodopseudomonas_palustris_Proteobacteria:0.00201061):0.00519235,WP_013504207.1-Rhodopseudomonas_palustris_Proteobacteria:0.00326365):0.01659029):0.02571506,(((((WP_119019080.1-Rhodopseudomonas_palustris_Proteobacteria:0.00290978,(WP_012497548.1-Rhodopseudomonas_palustris_Proteobacteria:0.00709048,WP_011159875.1-Rhodopseudomonas_palustris_Proteobacteria:0.00088052):0.00082481):0.01227796,WP_164571151.1-Rhodopseudomonas_sp._BR0C11_Proteobacteria:0.00312708):0.00155108,WP_107356882.1-Rhodopseudomonas_palustris_Proteobacteria:0.00517447):0.00138215,WP_164638651.1-Rhodopseudomonas_sp._BR0G17_Proteobacteria:0.00311096):0.00222115,WP_107345917.1-Rhodopseudomonas_palustris_Proteobacteria:0.00446341):0.04666227):0.01170064):0.02032285,WP_119858943.1-Rhodopseudomonas_palustris_Proteobacteria:0.07217667):0.03195836,((WP_027276359.1-Rhodopseudomonas_palustris_Proteobacteria:0.00645852,WP_110782500.1-Rhodopseudomonas_faecalis_Proteobacteria:-0.00010052):0.00477149,TAH64925.1-Rhodopseudomonas_palustris_Proteobacteria:0.00329093):0.10522752):0.01969047,WP_011665574.1-Rhodopseudomonas_palustris_Proteobacteria:0.07384391):0.00253838,((WP_041798938.1-Rhodopseudomonas_palustris_Proteobacteria:0.00154631,ABD08837.1-Rhodopseudomonas_palustris_Proteobacteria:-0.00154531):0.09250209,NVN87899.1-Rhodopseudomonas_sp._Proteobacteria:0.06587871):0.02118478):0.08362712,(((((((((WP_009734135.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.00518945,WP_002713184.1-Afipia_clevelandensis_Proteobacteria:-0.00042955):0.03054222,NGX94573.1-Candidatus_Afipia_apatlaquensis_Proteobacteria:0.02471483):0.00831954,TXJ10197.1-Afipia_sp._Proteobacteria:0.02133919):0.00507725,((((HAQ93654.1-Afipia_sp._Proteobacteria:0.00792871,HBR43714.1-Afipia_sp._Proteobacteria:-0.00311751):0.01087958,(RTL81632.1-Bradyrhizobiaceae_bacterium_Proteobacteria:0.00216342,WP_006021976.1-Afipia_broomeae_Proteobacteria:0.00573908):0.00343001):0.01744537,WP_062313220.1-Bradyrhizobium_sp._CCH10-C7_Proteobacteria:0.02295776):0.00463417,(WP_046827511.1-Afipia_massiliensis_Proteobacteria:0.02113946,(WP_184089169.1-Afipia_massiliensis_Proteobacteria:-0.00137594,MBB5054515.1-Afipia_massiliensis_Proteobacteria:0.00293924):0.02133568):0.00862895):0.01334469):0.04763263,((WP_115033941.1-Tardiphaga_sp._CF115_Proteobacteria:0.03305245,WP_092138970.1-Bradyrhizobium_sp._NFR13_Proteobacteria:0.02732945):0.01132831,(((WP_120288614.1-Tardiphaga_sp._YR296_Proteobacteria:0.00924269,WP_175367589.1-Tardiphaga_robiniae_Proteobacteria:0.00187871):0.00079163,WP_184513838.1-Tardiphaga_robiniae_Proteobacteria:0.00536063):0.00265466,WP_089261759.1-Tardiphaga_sp._OK246_Proteobacteria:0.01101393):0.01722624):0.02879424):0.02804241,OJY11205.1-Rhizobiales_bacterium_62-47_Proteobacteria:0.10979432):0.00819138,(WP_100386102.1-Afipia_broomeae_Proteobacteria:0.01793890,WP_146690165.1-Bradyrhizobium_canariense_Proteobacteria:0.01283120):0.08194881):0.00418864,WP_149531854.1-Tardiphaga_sp._P9-11_Proteobacteria:0.06883343):0.04415496,WP_008968903.1-Bradyrhizobium_sp._STM_3843_Proteobacteria:0.15499543):0.00803020):0.00556252,OQW56345.1-Proteobacteria_bacterium_SG_bin9_Proteobacteria:0.17535141):0.10147892,WP_136963313.1-Phreatobacter_stygius_Proteobacteria:0.25688291):0.07283656,(WP_187448402.1-Caulobacter_sp._17J80-11_Proteobacteria:0.04357119,WP_163259863.1-Caulobacter_sp._17J65-9_Proteobacteria:0.03614220):0.34418088):0.00238290):0.00505134):0.02637708,(((((((WP_062170184.1-Burkholderia_sp._PAMC_26561_Proteobacteria:0.00256009,WP_061999991.1-Burkholderia_sp._PAMC_28687_Proteobacteria:0.00710641):0.01775435,WP_081889718.1-Caballeronia_sordidicola_Proteobacteria:0.02882676):0.38300076,(((WP_062795892.1-Cupriavidus_nantongensis_Proteobacteria:0.01785286,(WP_116377884.1-Cupriavidus_taiwanensis_Proteobacteria:0.02954637,(WP_116388232.1-Cupriavidus_taiwanensis_Proteobacteria:0.00056534,WP_025586346.1-Cupriavidus_taiwanensis_Proteobacteria:0.00267266):0.02529799):0.00866736):0.06079458,WP_116320039.1-Cupriavidus_sp._P-10_Proteobacteria:0.06262736):0.10988081,((WP_116319445.1-Cupriavidus_sp._P-10_Proteobacteria:0.11259526,WP_066731373.1-Cupriavidus_sp._D384_Proteobacteria:0.10440584):0.00265852,(WP_071018820.1-Cupriavidus_sp._USMAHM13_Proteobacteria:0.00088198,(WP_071038742.1-Cupriavidus_sp._USMAA2-4_Proteobacteria:0.00246368,WP_071072555.1-Cupriavidus_malaysiensis_Proteobacteria:-0.00085658):0.00158301):0.09675419):0.08397070):0.16476843):0.02574365,(WP_111324427.1-Thermosporothrix_hazakensis_Chloroflexi:0.00000050,PZW26129.1-Thermosporothrix_hazakensis_Chloroflexi:0.00000050):0.36994672):0.01793882,(WP_092594144.1-Ralstonia_sp._25mfcol4.1_Proteobacteria:0.16300276,((MBB1634382.1-Cupriavidus_sp._UME77_Proteobacteria:-0.00043452,WP_183035411.1-Cupriavidus_sp._UME77_Proteobacteria:0.00043552):0.01111753,WP_150987011.1-Cupriavidus_basilensis_Proteobacteria:0.00575259):0.09022152):0.31706181):0.06760320,(WP_155709830.1-Massilia_dura_Proteobacteria:0.46813101,(GBU15266.1-Polaromonas_sp._Proteobacteria:0.28639257,((WP_157443435.1-Curvibacter_lanceolatus_Proteobacteria:0.01156546,WP_027475679.1-Curvibacter_gracilis_Proteobacteria:0.01436814):0.02408708,RUP23521.1-Curvibacter_sp._Proteobacteria:0.02455625):0.25886548):0.11281739):0.01403857):0.03614664,RZL87373.1-Variovorax_sp._Proteobacteria:0.39506382):0.00796626):0.01856647,WP_119419155.1-Rhodospirillaceae_bacterium_SYSU_D60015_Proteobacteria:0.43173879):0.04093275,((((PYN32128.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.08515257,PYN46404.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.07482824):0.04479394,(PYM96198.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.08387581,PYN74367.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.07650790):0.05978490):0.02801136,OGL20369.1-Candidatus_Rokubacteria_bacterium_RIFCSPLOWO2_12_FULL_71_22_Candidatus:0.09816149):0.04466873,((WP_089717141.1-Candidatus_Entotheonella_palauensis_Candidatus:0.04446347,WP_089945766.1-Candidatus_Entotheonella_palauensis_Candidatus:0.05980833):0.20521161,KAB2911669.1-Hyphomicrobiaceae_bacterium_Proteobacteria:0.19751158):0.03992926):0.16910589):0.06984518,OJY09878.1-Rhizobiales_bacterium_62-47_Proteobacteria:0.35447615):0.06543535,WP_076861029.1-Bradyrhizobium_mercantei_Proteobacteria:0.32691982):0.12982634,((WP_002714592.1-Afipia_clevelandensis_Proteobacteria:0.00652170,(WP_043924226.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.00000050,EGP08750.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.00000050):0.00460410):0.03823943,WP_046828790.1-Afipia_massiliensis_Proteobacteria:0.04807718):0.16516376):0.14747840,(WP_011439962.1-Rhodopseudomonas_palustris_Proteobacteria:0.08661445,NVN85223.1-Rhodopseudomonas_sp._Proteobacteria:0.06670845):0.03291151):0.00253049,(((WP_083842450.1-Bradyrhizobium_sp._ORS_375_Proteobacteria:0.02464495,((WP_172111906.1-Bradyrhizobium_sp._83012_Proteobacteria:0.00197106,WP_172134110.1-Bradyrhizobium_sp._81013_Proteobacteria:0.00125614):0.00268341,WP_172180802.1-Bradyrhizobium_sp._83002_Proteobacteria:0.00351639):0.03003691):0.01376120,(CCD98599.1-Bradyrhizobium_sp._STM_3809_Proteobacteria:-0.00607275,WP_035655465.1-Bradyrhizobium_sp._STM_3809_Proteobacteria:0.00607375):0.02722110):0.01311481,WP_168167890.1-Bradyrhizobium_sp._BTAi1_Proteobacteria:0.05128635):0.05958775):0.01510274,((WP_024511517.1-Bradyrhizobium_sp._ARR65_Proteobacteria:0.06500475,WP_024518537.1-Bradyrhizobium_sp._Tv2a-2_Proteobacteria:0.05476105):0.01498666,(TMK39387.1-Alphaproteobacteria_bacterium_Proteobacteria:0.01868376,TMJ47098.1-Alphaproteobacteria_bacterium_Proteobacteria:0.02275004):0.03954960):0.00333381):0.00078240,((((((((MBA4036164.1-Bradyrhizobium_sp._Proteobacteria:0.03149774,((WP_057851642.1-Bradyrhizobium_valentinum_Proteobacteria:0.00181038,WP_057900995.1-Bradyrhizobium_valentinum_Proteobacteria:-0.00021298):0.04521258,WP_108514566.1-Bradyrhizobium_algeriense_Proteobacteria:0.03596880):0.00265296):0.00434846,(((((WP_057843198.1-Bradyrhizobium_retamae_Proteobacteria:0.01890358,WP_028347371.1-Bradyrhizobium_murdochi_Proteobacteria:0.01416112):0.00467064,WP_171577827.1-Bradyrhizobium_australiense_Proteobacteria:0.02614374):0.00211619,WP_065748757.1-Bradyrhizobium_sp._LMTR_3_Proteobacteria:0.02282847):0.00639583,WP_065730813.1-Bradyrhizobium_icense_Proteobacteria:0.01870023):0.01195202,((WP_057859318.1-Bradyrhizobium_lablabi_Proteobacteria:0.01314157,WP_065756637.1-Bradyrhizobium_paxllaeri_Proteobacteria:0.01442672):0.00259991,(WP_057833547.1-Bradyrhizobium_jicamae_Proteobacteria:0.01735010,WP_161852777.1-Bradyrhizobium_sp._CCBAU_051011_Proteobacteria:0.02474299):0.00359786):0.00879361):0.00290204):0.00428627,((MBA2399293.1-Bradyrhizobium_sp._Proteobacteria:0.03356645,(WP_079586579.1-Bradyrhizobium_lablabi_Proteobacteria:0.02501575,((SDP08864.1-Afipia_sp._GAS231_Proteobacteria:-0.00020978,WP_092515866.1-Afipia_sp._GAS231_Proteobacteria:0.00181528):0.02239795,WP_155805222.1-Bradyrhizobium_sp._URHA0002_Proteobacteria:0.02922343):0.00209719):0.00341575):0.00352142,WP_143206068.1-Bradyrhizobium_erythrophlei_Proteobacteria:0.04066968):0.00598082):0.00685500,(WP_100419024.1-Bradyrhizobium_lablabi_Proteobacteria:0.04778238,TKW79521.1-Bradyrhizobium_icense_Proteobacteria:0.04963011):0.00757447):0.00545223,WP_069276965.1-Bradyrhizobium_elkanii_Proteobacteria:0.05517927):0.00874191,(((TMK06221.1-Alphaproteobacteria_bacterium_Proteobacteria:0.05620468,(WP_146687675.1-Bradyrhizobium_canariense_Proteobacteria:0.00603030,WP_100380578.1-Afipia_broomeae_Proteobacteria:0.01176680):0.02931351):0.00243368,THD60673.1-Bradyrhizobium_sp._Proteobacteria:0.06946544):0.01484896,WP_079601315.1-Bradyrhizobium_erythrophlei_Proteobacteria:0.04155093):0.00793977):0.01247225,WP_079544782.1-Bradyrhizobium_lablabi_Proteobacteria:0.07161438):0.00290852,(WP_130222300.1-Bradyrhizobium_sp._Leo121_Proteobacteria:0.03702492,WP_130580234.1-Bradyrhizobium_sp._Leo170_Proteobacteria:0.02967519):0.04178145):0.00496562):0.02011241,WP_140980779.1-Bradyrhizobium_guangdongense_Proteobacteria:0.04111129):0.00967473,WP_027526029.1-Bradyrhizobium_sp._Ec3.3_Proteobacteria:0.04323181):0.00250365,((WP_027550185.1-Bradyrhizobium_sp._Cp5.3_Proteobacteria:0.00828014,WP_063680948.1-Bradyrhizobium_neotropicale_Proteobacteria:0.01661656):0.01279557,WP_063705824.1-Bradyrhizobium_centrolobii_Proteobacteria:0.01910906):0.00796709):0.00589226,(((WP_148775460.1-Bradyrhizobium_rifense_Proteobacteria:0.02030998,WP_027528936.1-Bradyrhizobium_sp._WSM3983_Proteobacteria:0.03807472):0.00175148,WP_148749019.1-Bradyrhizobium_cytisi_Proteobacteria:0.01764013):0.00205474,(((WP_057753835.1-Bradyrhizobium_manausense_Proteobacteria:0.03103758,(WP_128953098.1-Bradyrhizobium_guangzhouense_Proteobacteria:0.00403316,WP_128961978.1-Bradyrhizobium_guangzhouense_Proteobacteria:0.00411044):0.01221371):0.00440096,(WP_128967591.1-Bradyrhizobium_guangdongense_Proteobacteria:0.01959735,WP_092295676.1-Bradyrhizobium_sp._Ghvi_Proteobacteria:0.01025905):0.00195481):0.00373454,MBC9878718.1-Bradyrhizobium_campsiandrae_Proteobacteria:0.02281754):0.00401018):0.00869055):0.00195696,((((WP_129271949.1-Bradyrhizobium_betae_Proteobacteria:0.01811012,WP_092029312.1-Bradyrhizobium_sp._OK095_Proteobacteria:0.01387318):0.00222521,WP_008138438.1-Bradyrhizobium_sp._YR681_Proteobacteria:0.01605785):0.00644931,WP_092214970.1-Bradyrhizobium_arachidis_Proteobacteria:0.02330055):0.00288111,((((WP_039157276.1-Bradyrhizobium_japonicum_Proteobacteria:0.00098646,WP_038931390.1-Bradyrhizobium_japonicum_Proteobacteria:0.00224344):0.00385250,(WP_041955910.1-Bradyrhizobium_japonicum_Proteobacteria:0.00013798,WP_028156991.1-Bradyrhizobium_japonicum_Proteobacteria:0.00795142):0.00277074):0.00499223,(WP_166350707.1-Bradyrhizobium_sp._323S2_Proteobacteria:0.01022791,(WP_166089364.1-Bradyrhizobium_sp._1S5_Proteobacteria:0.01159713,(WP_063984832.1-Bradyrhizobium_sp._Proteobacteria:0.00513759,WP_071915975.1-Bradyrhizobium_japonicum_Proteobacteria:0.00297061):0.00341910):0.00566627):0.00719974):0.01208473,(WP_074117602.1-Bradyrhizobium_sp._AS23.2_Proteobacteria:0.00382866,WP_084803943.1-Bradyrhizobium_sp._NAS80.1_Proteobacteria:0.01250194):0.02517257):0.00211807):0.00060096):0.00157603,(((WP_182869822.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.00316426,(WP_038965832.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.00000050,WP_011085536.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.00000050):0.00006804):0.00660898,(WP_161535945.1-Bradyrhizobium_sp._LCT2_Proteobacteria:0.00000050,QHP72204.1-Bradyrhizobium_sp._LCT2_Proteobacteria:0.00000050):0.00148187):0.00257515,((WP_028174753.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.00000050,KGJ68294.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.00000050):0.00061866,(BAR59885.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.00000050,WP_060912981.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.00000050):0.00261844):0.00304063):0.01732870):0.00191377,(WP_128955323.1-Bradyrhizobium_zhanjiangense_Proteobacteria:0.00469922,WP_128939625.1-Bradyrhizobium_zhanjiangense_Proteobacteria:0.00501368):0.03989673):0.00064901,(((((WP_018457146.1-Bradyrhizobium_sp._WSM4349_Proteobacteria:0.01200675,(WP_085352090.1-Bradyrhizobium_canariense_Proteobacteria:-0.00005755,WP_085395770.1-Bradyrhizobium_canariense_Proteobacteria:0.00166565):0.00924431):0.00213443,WP_063993269.1-Bradyrhizobium_sp._Proteobacteria:0.01344140):0.00075345,((WP_027516639.1-Bradyrhizobium_sp._WSM1417_Proteobacteria:0.00857789,WP_007594037.1-Bradyrhizobium_sp._WSM1253_Proteobacteria:0.01429111):0.00145484,WP_027568791.1-Bradyrhizobium_sp._URHA0013_Proteobacteria:0.01766359):0.00171945):0.00207175,WP_106942729.1-Bradyrhizobium_sp._MOS002_Proteobacteria:0.01584580):0.01165280,WP_148744709.1-Bradyrhizobium_hipponense_Proteobacteria:0.04974324):0.00275481):0.00236725,(WP_063691485.1-Bradyrhizobium_stylosanthis_Proteobacteria:0.00446646,WP_145664020.1-Bradyrhizobium_stylosanthis_Proteobacteria:0.00858654):0.02493835):0.00066599,(WP_015687718.1-Bradyrhizobium_cosmicum_Proteobacteria:0.01738231,WP_151642895.1-Bradyrhizobium_betae_Proteobacteria:0.01474909):0.00627276):0.00190368);
2 |
--------------------------------------------------------------------------------
/phylogenetics/intermediate/YOL164W.ckp.gz:
--------------------------------------------------------------------------------
https://raw.githubusercontent.com/SysBioChalmers/HGTphyloDetect/d4ff8c5dbdaf3b200e45dd57962dfb11776f43d7/phylogenetics/intermediate/YOL164W.ckp.gz
--------------------------------------------------------------------------------
/phylogenetics/intermediate/YOL164W.contree:
--------------------------------------------------------------------------------
1 | (QLG72306.1-Zygotorulaspora_mrakii_Saccharomycotina:0.1419700496,((((((((((WP_007837899.1-Variovorax_sp._CF313_Proteobacteria:0.0151690912,(WP_130421160.1-Variovorax_sp._BK460_Proteobacteria:0.0284531116,WP_093131647.1-Variovorax_sp._OK605_Proteobacteria:0.2077748676)71:0.0362866797)48:0.0180645347,((((((WP_132801781.1-Variovorax_sp._BK370_Proteobacteria:0.0000025529,(WP_184605932.1-Variovorax_sp._BK613_Proteobacteria:0.0017862471,((WP_145759386.1-Variovorax_sp._1180_Proteobacteria:0.0000025529,WP_126183471.1-Variovorax_sp._369_Proteobacteria:0.0035540546)100:0.0035555321,WP_020722993.1-Variovorax_paradoxus_Proteobacteria:0.0035576599)99:0.0000025529)100:0.0017773616)100:0.0017770506,WP_132755990.1-Variovorax_sp._BK151_Proteobacteria:0.0035688847)100:0.0104799343,WP_176665552.1-Variovorax_sp._SG517_Proteobacteria:0.0131157333)99:0.0055621019,(WP_184638849.1-Variovorax_guangxiensis_Proteobacteria:0.0020274175,WP_126020505.1-Variovorax_guangxiensis_Proteobacteria:0.0032959768)100:0.0218044199)100:0.0190495155,(WP_093195641.1-Variovorax_sp._YR750_Proteobacteria:0.0070684416,WP_126472589.1-Variovorax_gossypii_Proteobacteria:0.0071333422)100:0.0057923219)100:0.0123758464,(((WP_097197469.1-Variovorax_sp._YR752_Proteobacteria:0.0035469408,WP_093174861.1-Variovorax_sp._YR266_Proteobacteria:0.0000025529)100:0.0017801316,WP_093076613.1-Variovorax_sp._OV084_Proteobacteria:0.0017715048)99:0.0015509454,WP_093057006.1-Variovorax_sp._YR634_Proteobacteria:0.0037490386)100:0.0310630957)90:0.0151340282)48:0.0158120978,(WP_081267376.1-Variovorax_paradoxus_Proteobacteria:0.0267237068,ODU15846.1-Variovorax_sp._SCN_67-85_Proteobacteria:0.0235074842)100:0.0324435784)68:0.0176119332,(TAJ61793.1-Variovorax_sp._Proteobacteria:0.0044418597,((((WP_172705422.1-Variovorax_paradoxus_Proteobacteria:0.0000025529,KPU98577.1-Variovorax_paradoxus_Proteobacteria:0.0000025529)100:0.0041944357,MBS76598.1-Variovorax_sp._Proteobacteria:0.0000025529)100:0.0084588242,WP_093343818.1-Variovorax_sp._PDC80_Proteobacteria:0.0035807296)83:0.0000025529,KAF1061273.1-Variovorax_sp._Proteobacteria:0.0077982365)88:0.0027306660)100:0.0758075801)73:0.0309906417,(((WP_093435402.1-Variovorax_sp._770b2_Proteobacteria:0.0207105354,WP_052810747.1-Variovorax_paradoxus_Proteobacteria:0.0164627857)100:0.0140191965,WP_013538622.1-Variovorax_paradoxus_Proteobacteria:0.0298219181)73:0.0134383093,WP_176660984.1-Variovorax_sp._SG533_Proteobacteria:0.0471575115)61:0.0073315630)72:0.0251669330,WP_145738683.1-Variovorax_beijingensis_Proteobacteria:0.0592966181)71:0.0104317779,(((WP_093241869.1-Variovorax_sp._EL159_Proteobacteria:0.0104207249,WP_187113215.1-Variovorax_sp._PAMC26660_Proteobacteria:0.0337793653)100:0.0294551563,((WP_119556153.1-Acidovorax_cavernicola_Proteobacteria:0.0586978641,((WP_153281245.1-Variovorax_paradoxus_Proteobacteria:0.0069548006,(WP_099794476.1-Variovorax_sp._54_Proteobacteria:0.0034768674,WP_101490554.1-Variovorax_sp._RO1_Proteobacteria:0.0052115411)98:0.0000021671)88:0.0052043853,(((((WP_062470459.1-Variovorax_boronicumulans_Proteobacteria:0.0052256875,WP_095948515.1-Variovorax_boronicumulans_Proteobacteria:0.0000025529)72:0.0034830599,WP_159278964.1-Variovorax_boronicumulans_Proteobacteria:0.0034706320)88:0.0017541743,WP_159274326.1-Variovorax_boronicumulans_Proteobacteria:0.0034841068)54:0.0017458477,(WP_070061350.1-Variovorax_boronicumulans_Proteobacteria:0.0035041316,WP_095743122.1-Variovorax_boronicumulans_Proteobacteria:0.0017464559)61:0.0000029100)90:0.0034866720,WP_139703542.1-Variovorax_sp._KBS0712_Proteobacteria:0.0000025529)96:0.0035178671)81:0.0072394138)45:0.0052248600,WP_056574498.1-Variovorax_sp._Root473_Proteobacteria:0.0206617885)97:0.0334237883)58:0.0089811825,WP_124458460.1-Variovorax_sp._KBW07_Proteobacteria:0.0419721576)95:0.0221227419)99:0.0530969383,((((OQW56345.1-Proteobacteria_bacterium_SG_bin9_Proteobacteria:0.1632611585,((((((((((WP_175367589.1-Tardiphaga_robiniae_Proteobacteria:0.0017113415,WP_120288614.1-Tardiphaga_sp._YR296_Proteobacteria:0.0104275851)93:0.0028179907,WP_184513838.1-Tardiphaga_robiniae_Proteobacteria:0.0040764180)92:0.0055497464,WP_089261759.1-Tardiphaga_sp._OK246_Proteobacteria:0.0089328327)100:0.0314995603,WP_092138970.1-Bradyrhizobium_sp._NFR13_Proteobacteria:0.0243215626)91:0.0267618787,WP_115033941.1-Tardiphaga_sp._CF115_Proteobacteria:0.0231345813)100:0.0631786151,((((WP_062313220.1-Bradyrhizobium_sp._CCH10-C7_Proteobacteria:0.0230042298,((MBB5054515.1-Afipia_massiliensis_Proteobacteria:0.0017180650,WP_184089169.1-Afipia_massiliensis_Proteobacteria:0.0000025529)100:0.0313870386,WP_046827511.1-Afipia_massiliensis_Proteobacteria:0.0148923403)99:0.0173947160)82:0.0117042327,((HBR43714.1-Afipia_sp._Proteobacteria:0.0017487776,HAQ93654.1-Afipia_sp._Proteobacteria:0.0035127226)100:0.0065277838,(WP_006021976.1-Afipia_broomeae_Proteobacteria:0.0062353646,RTL81632.1-Bradyrhizobiaceae_bacterium_Proteobacteria:0.0026332983)100:0.0052171053)100:0.0180877410)94:0.0212074834,TXJ10197.1-Afipia_sp._Proteobacteria:0.0292725665)50:0.0056850197,(NGX94573.1-Candidatus_Afipia_apatlaquensis_Proteobacteria:0.0171254779,(WP_002713184.1-Afipia_clevelandensis_Proteobacteria:0.0017887565,WP_009734135.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.0034874684)100:0.0436975592)91:0.0086592832)100:0.0436721253)99:0.0415336361,WP_149531854.1-Tardiphaga_sp._P9-11_Proteobacteria:0.0879683624)73:0.0088614741,OJY11205.1-Rhizobiales_bacterium_62-47_Proteobacteria:0.1272580020)94:0.0149509524,((WP_146690165.1-Bradyrhizobium_canariense_Proteobacteria:0.0159309791,WP_100386102.1-Afipia_broomeae_Proteobacteria:0.0183639381)100:0.0673779947,WP_008968903.1-Bradyrhizobium_sp._STM_3843_Proteobacteria:0.2058439051)99:0.0499892556)96:0.0275398810,(NVN87899.1-Rhodopseudomonas_sp._Proteobacteria:0.0651319322,((WP_011665574.1-Rhodopseudomonas_palustris_Proteobacteria:0.0822581641,(((WP_110782500.1-Rhodopseudomonas_faecalis_Proteobacteria:0.0017589439,WP_027276359.1-Rhodopseudomonas_palustris_Proteobacteria:0.0053115279)99:0.0030334387,TAH64925.1-Rhodopseudomonas_palustris_Proteobacteria:0.0040631651)100:0.1040817294,((((((WP_164571151.1-Rhodopseudomonas_sp._BR0C11_Proteobacteria:0.0000025529,WP_107345917.1-Rhodopseudomonas_palustris_Proteobacteria:0.0088363287)95:0.0017593662,WP_164638651.1-Rhodopseudomonas_sp._BR0G17_Proteobacteria:0.0052779844)90:0.0000025547,WP_107356882.1-Rhodopseudomonas_palustris_Proteobacteria:0.0088457360)97:0.0037224967,((WP_011159875.1-Rhodopseudomonas_palustris_Proteobacteria:0.0017511885,WP_012497548.1-Rhodopseudomonas_palustris_Proteobacteria:0.0070630722)84:0.0000025529,WP_119019080.1-Rhodopseudomonas_palustris_Proteobacteria:0.0035267369)100:0.0122025678)100:0.0461987355,(((WP_013504207.1-Rhodopseudomonas_palustris_Proteobacteria:0.0071830044,WP_047308756.1-Rhodopseudomonas_palustris_Proteobacteria:0.0000025547)99:0.0017987886,WP_164630935.1-Rhodopseudomonas_sp._WA056_Proteobacteria:0.0000025547)100:0.0116654318,(WP_119858943.1-Rhodopseudomonas_palustris_Proteobacteria:0.1270381688,WP_142883484.1-Rhodopseudomonas_palustris_Proteobacteria:0.0144391419)85:0.0235813830)87:0.0391133213)88:0.0317239131,(WP_022722993.1-Rhodopseudomonas_sp._B29_Proteobacteria:0.0599367324,WP_054162298.1-Rhodopseudomonas_sp._AAP120_Proteobacteria:0.0930437476)83:0.0154941700)100:0.0587662161)99:0.0362320236)100:0.0337380607,(ABD08837.1-Rhodopseudomonas_palustris_Proteobacteria:0.0000025529,WP_041798938.1-Rhodopseudomonas_palustris_Proteobacteria:0.0000025529)100:0.0681380805)100:0.0514751239)100:0.1128479878)98:0.0438744522)100:0.1432912386,WP_136963313.1-Phreatobacter_stygius_Proteobacteria:0.3107259148)100:0.0914841173,((((WP_057659955.1-Pseudoxanthomonas_dokdonensis_Proteobacteria:0.2499156290,WP_077034059.1-Pelomonas_sp._KK5_Proteobacteria:0.2911182532)100:0.0902755565,(((WP_108104178.1-Pseudomonas_mangrovi_Proteobacteria:0.1437074315,WP_017937932.1-Pseudomonas_thermotolerans_Proteobacteria:0.1463729146)100:0.1328203969,(((WP_136868902.1-Pseudomonas_bauzanensis_Proteobacteria:0.0070177890,EZQ18937.1-Pseudomonas_bauzanensis_Proteobacteria:0.0000025529)100:0.1116778476,WP_185267007.1-Pseudomonas_xiamenensis_Proteobacteria:0.1295799419)100:0.1552300850,WP_093476299.1-Pseudomonas_yangmingensis_Proteobacteria:0.2418671959)100:0.0522739951)100:0.0999993841,(((MAB24835.1-Pseudomonadales_bacterium_Proteobacteria:0.0190371508,WP_182248855.1-Pseudomonas_sp._5Ae-yellow_Proteobacteria:0.0166474000)100:0.1054476389,WP_083726556.1-Pseudomonas_pachastrellae_Proteobacteria:0.1002614641)100:0.1237244051,PKM29133.1-Gammaproteobacteria_bacterium_HGW-Gammaproteobacteria-11_Proteobacteria:0.1694416416)100:0.2028711037)100:0.1236209414)99:0.0853467408,WP_151072822.1-Cupriavidus_oxalaticus_Proteobacteria:0.4483536819)77:0.0381174254,((((((((WP_027475679.1-Curvibacter_gracilis_Proteobacteria:0.0152778017,WP_157443435.1-Curvibacter_lanceolatus_Proteobacteria:0.0139536985)100:0.0290141463,RUP23521.1-Curvibacter_sp._Proteobacteria:0.0268394324)100:0.3267455210,GBU15266.1-Polaromonas_sp._Proteobacteria:0.3000919531)100:0.1425417275,(((KAB2911669.1-Hyphomicrobiaceae_bacterium_Proteobacteria:0.1877171123,(WP_089945766.1-Candidatus_Entotheonella_palauensis_Candidatus:0.0633607112,WP_089717141.1-Candidatus_Entotheonella_palauensis_Candidatus:0.0516584331)100:0.2745369041)87:0.0443862242,((OGL20369.1-Candidatus_Rokubacteria_bacterium_RIFCSPLOWO2_12_FULL_71_22_Candidatus:0.1486473069,(PYN74367.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0963276916,PYM96198.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0928619892)100:0.0777905357)98:0.0164313295,(PYN46404.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0914063712,PYN32128.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0891855269)100:0.0652905740)100:0.0990880426)100:0.2068991184,((((((((((((((WP_084803943.1-Bradyrhizobium_sp._NAS80.1_Proteobacteria:0.0149731780,WP_074117602.1-Bradyrhizobium_sp._AS23.2_Proteobacteria:0.0033319189)100:0.0282990642,((((((((WP_128961978.1-Bradyrhizobium_guangzhouense_Proteobacteria:0.0026332813,WP_128953098.1-Bradyrhizobium_guangzhouense_Proteobacteria:0.0065055636)100:0.0157429012,WP_057753835.1-Bradyrhizobium_manausense_Proteobacteria:0.0340705790)95:0.0076656933,MBC9878718.1-Bradyrhizobium_campsiandrae_Proteobacteria:0.0312690452)52:0.0018929054,(WP_092295676.1-Bradyrhizobium_sp._Ghvi_Proteobacteria:0.0098480931,WP_128967591.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0238440857)91:0.0036195235)100:0.0100130792,(WP_027528936.1-Bradyrhizobium_sp._WSM3983_Proteobacteria:0.0485579993,WP_148775460.1-Bradyrhizobium_rifense_Proteobacteria:0.0183375397)95:0.0058401219)66:0.0037692905,WP_148749019.1-Bradyrhizobium_cytisi_Proteobacteria:0.0178810667)100:0.0154724230,((((WP_145664020.1-Bradyrhizobium_stylosanthis_Proteobacteria:0.0098316338,WP_063691485.1-Bradyrhizobium_stylosanthis_Proteobacteria:0.0048258190)100:0.0314224290,(((((((WP_158669522.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0066232698,WP_035715237.1-Bradyrhizobium_sp._CCBAU_43298_Proteobacteria:0.0082771095)100:0.0374209599,(WP_061878281.1-Bradyrhizobium_liaoningense_Proteobacteria:0.0199667350,((WP_035674808.1-Bradyrhizobium_liaoningense_Proteobacteria:0.0000025529,WP_028179375.1-Bradyrhizobium_japonicum_Proteobacteria:0.0017793110)100:0.0179237006,(WP_061021165.1-Bradyrhizobium_sp._CCH5-F6_Proteobacteria:0.0125673875,GAJ33771.1-Bradyrhizobium_sp._DOA9_Proteobacteria:0.0508525228)72:0.0057323593)100:0.0078473940)97:0.0122398389)97:0.0043057866,(RTM13090.1-Bradyrhizobiaceae_bacterium_Proteobacteria:0.0262181276,(WP_100175831.1-Bradyrhizobium_nitroreducens_Proteobacteria:0.0018055267,WP_142250055.1-Bradyrhizobium_sp._UNPF46_Proteobacteria:0.0000025529)100:0.0127560514)95:0.0130068156)53:0.0017470512,(WP_128939625.1-Bradyrhizobium_zhanjiangense_Proteobacteria:0.0054058695,WP_128955323.1-Bradyrhizobium_zhanjiangense_Proteobacteria:0.0053414731)100:0.0493879319)78:0.0061516798,((WP_091965654.1-Bradyrhizobium_shewense_Proteobacteria:0.0072162887,WP_104462928.1-Bradyrhizobium_sp._AC87j1_Proteobacteria:0.0090608714)99:0.0079885968,((WP_183237909.1-Bradyrhizobium_sp._CIR18_Proteobacteria:0.0019142209,(WP_018322728.1-Bradyrhizobium_sp._WSM2793_Proteobacteria:0.0018841203,((WP_183258594.1-Bradyrhizobium_sp._CIR48_Proteobacteria:0.0000025529,WP_183231495.1-Bradyrhizobium_sp._SBR1B_Proteobacteria:0.0017853318)60:0.0000025529,WP_092259760.1-Bradyrhizobium_sp._Rc3b_Proteobacteria:0.0017874989)100:0.0125649942)82:0.0036188114)100:0.0115125693,WP_152103320.1-Bradyrhizobium_sp._TM102_Proteobacteria:0.0194970679)98:0.0021597866)86:0.0041474627)73:0.0026110105,((WP_028135100.1-Bradyrhizobium_japonicum_Proteobacteria:0.0376223232,WP_135162274.1-Bradyrhizobium_frederickii_Proteobacteria:0.0223445808)48:0.0025807336,(WP_135167913.1-Bradyrhizobium_frederickii_Proteobacteria:0.0000025529,WP_126256569.1-Bradyrhizobium_sp._LVM_105_Proteobacteria:0.0018059536)100:0.0168840311)93:0.0110672126)30:0.0046708305,(WP_151642895.1-Bradyrhizobium_betae_Proteobacteria:0.0144650589,WP_015687718.1-Bradyrhizobium_cosmicum_Proteobacteria:0.0216945596)100:0.0093324888)42:0.0064542401)83:0.0025362292,(((((WP_007594037.1-Bradyrhizobium_sp._WSM1253_Proteobacteria:0.0166127899,WP_027516639.1-Bradyrhizobium_sp._WSM1417_Proteobacteria:0.0086715736)100:0.0053169533,WP_027568791.1-Bradyrhizobium_sp._URHA0013_Proteobacteria:0.0177530279)90:0.0021513434,(WP_063993269.1-Bradyrhizobium_sp._Proteobacteria:0.0163150959,(WP_085395770.1-Bradyrhizobium_canariense_Proteobacteria:0.0017808250,WP_085352090.1-Bradyrhizobium_canariense_Proteobacteria:0.0000025529)100:0.0108870232)74:0.0018350078)75:0.0035909479,WP_018457146.1-Bradyrhizobium_sp._WSM4349_Proteobacteria:0.0110683556)97:0.0054039141,WP_106942729.1-Bradyrhizobium_sp._MOS002_Proteobacteria:0.0179765107)100:0.0163708216)65:0.0060903245,(((((WP_011085536.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529,WP_038965832.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529)61:0.0000025529,WP_182869822.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0036067034)100:0.0073088647,(QHP72204.1-Bradyrhizobium_sp._LCT2_Proteobacteria:0.0000025529,WP_161535945.1-Bradyrhizobium_sp._LCT2_Proteobacteria:0.0000025529)99:0.0018077610)100:0.0018373206,((WP_060912981.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529,BAR59885.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529)100:0.0018134686,(KGJ68294.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529,WP_028174753.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529)100:0.0018160394)100:0.0036075077)100:0.0190570227,WP_148744709.1-Bradyrhizobium_hipponense_Proteobacteria:0.0581154032)38:0.0045486491)37:0.0047642211)24:0.0028434465,(((WP_008138438.1-Bradyrhizobium_sp._YR681_Proteobacteria:0.0194658600,WP_129271949.1-Bradyrhizobium_betae_Proteobacteria:0.0231766674)97:0.0017676556,WP_092029312.1-Bradyrhizobium_sp._OK095_Proteobacteria:0.0149106660)100:0.0081781604,WP_092214970.1-Bradyrhizobium_arachidis_Proteobacteria:0.0295593760)88:0.0090160276)65:0.0097075311)91:0.0071243118,(((((WP_071915975.1-Bradyrhizobium_japonicum_Proteobacteria:0.0035947553,WP_063984832.1-Bradyrhizobium_sp._Proteobacteria:0.0054339671)100:0.0024648194,WP_166089364.1-Bradyrhizobium_sp._1S5_Proteobacteria:0.0140608629)100:0.0091284774,WP_166350707.1-Bradyrhizobium_sp._323S2_Proteobacteria:0.0097077442)100:0.0137342174,(WP_038931390.1-Bradyrhizobium_japonicum_Proteobacteria:0.0017959339,WP_039157276.1-Bradyrhizobium_japonicum_Proteobacteria:0.0017999733)100:0.0007232537)98:0.0030715164,(WP_028156991.1-Bradyrhizobium_japonicum_Proteobacteria:0.0090085279,WP_041955910.1-Bradyrhizobium_japonicum_Proteobacteria:0.0000025529)100:0.0035547066)100:0.0157908339)99:0.0152170772,((WP_063680948.1-Bradyrhizobium_neotropicale_Proteobacteria:0.0196191366,WP_027550185.1-Bradyrhizobium_sp._Cp5.3_Proteobacteria:0.0094981002)100:0.0234601203,WP_063705824.1-Bradyrhizobium_centrolobii_Proteobacteria:0.0156788163)77:0.0066710175)91:0.0106956249,WP_027526029.1-Bradyrhizobium_sp._Ec3.3_Proteobacteria:0.0555912556)100:0.0150031037,WP_140980779.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0384142384)100:0.0337784223,((((((((((WP_065748757.1-Bradyrhizobium_sp._LMTR_3_Proteobacteria:0.0300380735,(WP_028347371.1-Bradyrhizobium_murdochi_Proteobacteria:0.0192761298,WP_057843198.1-Bradyrhizobium_retamae_Proteobacteria:0.0177776765)100:0.0062231428)73:0.0022138705,WP_171577827.1-Bradyrhizobium_australiense_Proteobacteria:0.0263737606)100:0.0051958173,WP_065730813.1-Bradyrhizobium_icense_Proteobacteria:0.0247467235)100:0.0170358768,((WP_161852777.1-Bradyrhizobium_sp._CCBAU_051011_Proteobacteria:0.0288673541,(WP_065756637.1-Bradyrhizobium_paxllaeri_Proteobacteria:0.0216339578,WP_057859318.1-Bradyrhizobium_lablabi_Proteobacteria:0.0091303108)100:0.0073818466)100:0.0046259774,WP_057833547.1-Bradyrhizobium_jicamae_Proteobacteria:0.0178046212)100:0.0097279495)100:0.0134088462,WP_108514566.1-Bradyrhizobium_algeriense_Proteobacteria:0.0328499036)82:0.0069697373,(WP_057900995.1-Bradyrhizobium_valentinum_Proteobacteria:0.0000025529,WP_057851642.1-Bradyrhizobium_valentinum_Proteobacteria:0.0017887517)100:0.0550011833)93:0.0110628234,(((WP_155805222.1-Bradyrhizobium_sp._URHA0002_Proteobacteria:0.0355166756,(WP_092515866.1-Afipia_sp._GAS231_Proteobacteria:0.0018011061,SDP08864.1-Afipia_sp._GAS231_Proteobacteria:0.0000025529)100:0.0215545592)100:0.0055095726,WP_079586579.1-Bradyrhizobium_lablabi_Proteobacteria:0.0318814818)99:0.0103536336,((WP_143206068.1-Bradyrhizobium_erythrophlei_Proteobacteria:0.0360882130,(TKW79521.1-Bradyrhizobium_icense_Proteobacteria:0.0608251368,WP_100419024.1-Bradyrhizobium_lablabi_Proteobacteria:0.0515622272)92:0.0201950595)81:0.0104375494,MBA2399293.1-Bradyrhizobium_sp._Proteobacteria:0.0364287714)71:0.0066815175)74:0.0055604339)65:0.0061505875,MBA4036164.1-Bradyrhizobium_sp._Proteobacteria:0.0404953051)81:0.0226880788,WP_069276965.1-Bradyrhizobium_elkanii_Proteobacteria:0.0721663783)97:0.0164474533,(WP_130580234.1-Bradyrhizobium_sp._Leo170_Proteobacteria:0.0274388959,WP_130222300.1-Bradyrhizobium_sp._Leo121_Proteobacteria:0.0492456079)100:0.0546380571)65:0.0166606360)71:0.0145470127,((WP_079601315.1-Bradyrhizobium_erythrophlei_Proteobacteria:0.0483161927,(((WP_100380578.1-Afipia_broomeae_Proteobacteria:0.0177773789,WP_146687675.1-Bradyrhizobium_canariense_Proteobacteria:0.0021300952)100:0.0360098106,TMK06221.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0636096138)78:0.0181351267,THD60673.1-Bradyrhizobium_sp._Proteobacteria:0.0652442628)80:0.0216684806)74:0.0197231469,WP_079544782.1-Bradyrhizobium_lablabi_Proteobacteria:0.0719475579)75:0.0173759806)77:0.0111861737,(WP_024518537.1-Bradyrhizobium_sp._Tv2a-2_Proteobacteria:0.0667305930,WP_024511517.1-Bradyrhizobium_sp._ARR65_Proteobacteria:0.0783072389)99:0.0359213514)94:0.0125116288,(TMJ47098.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0339859459,TMK39387.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0121275441)100:0.0494432825)99:0.0276357838,((((WP_035655465.1-Bradyrhizobium_sp._STM_3809_Proteobacteria:0.0000025547,CCD98599.1-Bradyrhizobium_sp._STM_3809_Proteobacteria:0.0000025529)100:0.0380438088,(((WP_172134110.1-Bradyrhizobium_sp._81013_Proteobacteria:0.0000025529,WP_172111906.1-Bradyrhizobium_sp._83012_Proteobacteria:0.0035435343)100:0.0021310828,WP_172180802.1-Bradyrhizobium_sp._83002_Proteobacteria:0.0050022168)100:0.0307601501,WP_083842450.1-Bradyrhizobium_sp._ORS_375_Proteobacteria:0.0300988167)100:0.0111099627)99:0.0256598907,WP_168167890.1-Bradyrhizobium_sp._BTAi1_Proteobacteria:0.0562562725)100:0.0959047665,(NVN85223.1-Rhodopseudomonas_sp._Proteobacteria:0.0664914122,WP_011439962.1-Rhodopseudomonas_palustris_Proteobacteria:0.1113703890)100:0.0416444945)84:0.0068706115)100:0.1888211768,(WP_046828790.1-Afipia_massiliensis_Proteobacteria:0.0543174324,((EGP08750.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.0000025529,WP_043924226.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.0000025529)100:0.0056464678,WP_002714592.1-Afipia_clevelandensis_Proteobacteria:0.0066674351)100:0.0435158483)100:0.1755538613)100:0.1762574676,WP_076861029.1-Bradyrhizobium_mercantei_Proteobacteria:0.3527849081)100:0.1057181999,OJY09878.1-Rhizobiales_bacterium_62-47_Proteobacteria:0.3719739574)100:0.1223359533)84:0.0699481206)90:0.0450316305,(WP_155709830.1-Massilia_dura_Proteobacteria:0.5557312322,RZL87373.1-Variovorax_sp._Proteobacteria:0.3943420981)100:0.0738665777)83:0.0239120893,((((((WP_066731373.1-Cupriavidus_sp._D384_Proteobacteria:0.1243335709,((WP_071072555.1-Cupriavidus_malaysiensis_Proteobacteria:0.0000025529,WP_071038742.1-Cupriavidus_sp._USMAA2-4_Proteobacteria:0.0018029583)100:0.0018056173,WP_071018820.1-Cupriavidus_sp._USMAHM13_Proteobacteria:0.0000025529)100:0.1085152877)99:0.0424322974,WP_116319445.1-Cupriavidus_sp._P-10_Proteobacteria:0.1027139128)100:0.0836195533,((((WP_025586346.1-Cupriavidus_taiwanensis_Proteobacteria:0.0000025529,WP_116388232.1-Cupriavidus_taiwanensis_Proteobacteria:0.0036524134)100:0.0316566325,WP_116377884.1-Cupriavidus_taiwanensis_Proteobacteria:0.0302131340)99:0.0150531754,WP_062795892.1-Cupriavidus_nantongensis_Proteobacteria:0.0148595343)100:0.0624241545,WP_116320039.1-Cupriavidus_sp._P-10_Proteobacteria:0.0838952296)100:0.1460725142)100:0.1898169895,((WP_061999991.1-Burkholderia_sp._PAMC_28687_Proteobacteria:0.0087180253,WP_062170184.1-Burkholderia_sp._PAMC_26561_Proteobacteria:0.0025025517)100:0.0260311211,WP_081889718.1-Caballeronia_sordidicola_Proteobacteria:0.0276687298)100:0.4390211764)99:0.0721629128,(PZW26129.1-Thermosporothrix_hazakensis_Chloroflexi:0.0000025529,WP_111324427.1-Thermosporothrix_hazakensis_Chloroflexi:0.0000025529)100:0.4278367233)100:0.0982049050,((WP_150987011.1-Cupriavidus_basilensis_Proteobacteria:0.0061693719,(WP_183035411.1-Cupriavidus_sp._UME77_Proteobacteria:0.0000025529,MBB1634382.1-Cupriavidus_sp._UME77_Proteobacteria:0.0000025529)100:0.0121206681)100:0.1045331063,WP_092594144.1-Ralstonia_sp._25mfcol4.1_Proteobacteria:0.1852033396)100:0.3452799242)98:0.0688139200)86:0.0422214232,WP_119419155.1-Rhodospirillaceae_bacterium_SYSU_D60015_Proteobacteria:0.5052752110)88:0.0478196547,(WP_163259863.1-Caulobacter_sp._17J65-9_Proteobacteria:0.0359474717,WP_187448402.1-Caulobacter_sp._17J80-11_Proteobacteria:0.0559777341)100:0.4117043668)94:0.0539472751)67:0.0268488460)100:0.1412527212,WP_092831606.1-Rhodospirillales_bacterium_URHD0017_Proteobacteria:0.2964506726)100:0.0558856313)100:0.0848907630,(XP_018221989.1-Saccharomyces_eubayanus_Saccharomycotina:0.0010253739,QID88192.1-Saccharomyces_pastorianus_Saccharomycotina:0.0059815163)100:0.2278450821)100:0.1315758551,(XP_002555886.1-Lachancea_thermotolerans_Saccharomycotina:0.1332678749,SCW03834.1-Lachancea_fermentati_Saccharomycotina:0.1491417762)100:0.2398100364)100:0.1391876795,QUERY_Saccharomyces_cerevisiae_YOL164W:0.1506726866);
2 |
--------------------------------------------------------------------------------
/phylogenetics/intermediate/YOL164W.model.gz:
--------------------------------------------------------------------------------
https://raw.githubusercontent.com/SysBioChalmers/HGTphyloDetect/d4ff8c5dbdaf3b200e45dd57962dfb11776f43d7/phylogenetics/intermediate/YOL164W.model.gz
--------------------------------------------------------------------------------
/phylogenetics/intermediate/YOL164W.treefile:
--------------------------------------------------------------------------------
1 | (QLG72306.1-Zygotorulaspora_mrakii_Saccharomycotina:0.1410169193,((((((((((WP_007837899.1-Variovorax_sp._CF313_Proteobacteria:0.0152241582,(WP_130421160.1-Variovorax_sp._BK460_Proteobacteria:0.0284286767,WP_093131647.1-Variovorax_sp._OK605_Proteobacteria:0.2080303908)71:0.0363867290)48:0.0181505344,((((((WP_132801781.1-Variovorax_sp._BK370_Proteobacteria:0.0000025902,(WP_184605932.1-Variovorax_sp._BK613_Proteobacteria:0.0017867393,((WP_145759386.1-Variovorax_sp._1180_Proteobacteria:0.0000025529,WP_126183471.1-Variovorax_sp._369_Proteobacteria:0.0035560491)100:0.0035575277,WP_020722993.1-Variovorax_paradoxus_Proteobacteria:0.0035596580)99:0.0000028573)100:0.0017778488)100:0.0017773413,WP_132755990.1-Variovorax_sp._BK151_Proteobacteria:0.0035706853)100:0.0104871553,WP_176665552.1-Variovorax_sp._SG517_Proteobacteria:0.0131240078)99:0.0055691785,(WP_184638849.1-Variovorax_guangxiensis_Proteobacteria:0.0020296942,WP_126020505.1-Variovorax_guangxiensis_Proteobacteria:0.0032976925)100:0.0218177694)100:0.0190596629,(WP_093195641.1-Variovorax_sp._YR750_Proteobacteria:0.0070754256,WP_126472589.1-Variovorax_gossypii_Proteobacteria:0.0071366605)100:0.0057998940)100:0.0123966964,(((WP_097197469.1-Variovorax_sp._YR752_Proteobacteria:0.0035487301,WP_093174861.1-Variovorax_sp._YR266_Proteobacteria:0.0000027141)100:0.0017804944,WP_093076613.1-Variovorax_sp._OV084_Proteobacteria:0.0017718643)99:0.0015431797,WP_093057006.1-Variovorax_sp._YR634_Proteobacteria:0.0037590032)100:0.0310962981)90:0.0149565902)48:0.0156223618,(WP_081267376.1-Variovorax_paradoxus_Proteobacteria:0.0269652371,ODU15846.1-Variovorax_sp._SCN_67-85_Proteobacteria:0.0233850795)100:0.0325716889)68:0.0188985374,(TAJ61793.1-Variovorax_sp._Proteobacteria:0.0044458578,((((WP_172705422.1-Variovorax_paradoxus_Proteobacteria:0.0000025529,KPU98577.1-Variovorax_paradoxus_Proteobacteria:0.0000025529)100:0.0041970861,MBS76598.1-Variovorax_sp._Proteobacteria:0.0000027864)100:0.0084655208,WP_093343818.1-Variovorax_sp._PDC80_Proteobacteria:0.0035828750)83:0.0000029532,KAF1061273.1-Variovorax_sp._Proteobacteria:0.0078040894)88:0.0027320220)100:0.0749097892)73:0.0319422853,(((WP_093435402.1-Variovorax_sp._770b2_Proteobacteria:0.0206586646,WP_052810747.1-Variovorax_paradoxus_Proteobacteria:0.0165659413)100:0.0134437057,WP_013538622.1-Variovorax_paradoxus_Proteobacteria:0.0302286410)73:0.0150777259,WP_176660984.1-Variovorax_sp._SG533_Proteobacteria:0.0453283197)61:0.0068646733)72:0.0244211033,WP_145738683.1-Variovorax_beijingensis_Proteobacteria:0.0610257482)71:0.0106834520,(((WP_093241869.1-Variovorax_sp._EL159_Proteobacteria:0.0125800125,WP_187113215.1-Variovorax_sp._PAMC26660_Proteobacteria:0.0317758982)100:0.0327409585,WP_124458460.1-Variovorax_sp._KBW07_Proteobacteria:0.0418875545)42:0.0093686014,(WP_119556153.1-Acidovorax_cavernicola_Proteobacteria:0.0490619443,(((WP_153281245.1-Variovorax_paradoxus_Proteobacteria:0.0069603947,(WP_099794476.1-Variovorax_sp._54_Proteobacteria:0.0034785224,WP_101490554.1-Variovorax_sp._RO1_Proteobacteria:0.0052145746)98:0.0000026612)88:0.0046318009,(((((WP_062470459.1-Variovorax_boronicumulans_Proteobacteria:0.0052289264,WP_095948515.1-Variovorax_boronicumulans_Proteobacteria:0.0000027198)72:0.0034849056,WP_159278964.1-Variovorax_boronicumulans_Proteobacteria:0.0034724572)88:0.0017543454,WP_159274326.1-Variovorax_boronicumulans_Proteobacteria:0.0034861997)54:0.0017462506,(WP_070061350.1-Variovorax_boronicumulans_Proteobacteria:0.0035059980,WP_095743122.1-Variovorax_boronicumulans_Proteobacteria:0.0017468574)61:0.0000023233)90:0.0034887664,WP_139703542.1-Variovorax_sp._KBS0712_Proteobacteria:0.0000021316)96:0.0040951815)81:0.0077788031,WP_056574498.1-Variovorax_sp._Root473_Proteobacteria:0.0239051762)36:0.0112620334)97:0.0295236989)95:0.0196208468)99:0.0487542445,((((OQW56345.1-Proteobacteria_bacterium_SG_bin9_Proteobacteria:0.1627514055,((((((((((WP_175367589.1-Tardiphaga_robiniae_Proteobacteria:0.0017119630,WP_120288614.1-Tardiphaga_sp._YR296_Proteobacteria:0.0104363849)93:0.0028198655,WP_184513838.1-Tardiphaga_robiniae_Proteobacteria:0.0040792062)92:0.0055540338,WP_089261759.1-Tardiphaga_sp._OK246_Proteobacteria:0.0089400208)100:0.0315266400,WP_092138970.1-Bradyrhizobium_sp._NFR13_Proteobacteria:0.0243423553)91:0.0267856795,WP_115033941.1-Tardiphaga_sp._CF115_Proteobacteria:0.0231530893)100:0.0632464649,((((WP_062313220.1-Bradyrhizobium_sp._CCH10-C7_Proteobacteria:0.0230233757,((MBB5054515.1-Afipia_massiliensis_Proteobacteria:0.0017197135,WP_184089169.1-Afipia_massiliensis_Proteobacteria:0.0000025529)100:0.0314135181,WP_046827511.1-Afipia_massiliensis_Proteobacteria:0.0149053090)99:0.0174094539)82:0.0117145910,((HBR43714.1-Afipia_sp._Proteobacteria:0.0017509222,HAQ93654.1-Afipia_sp._Proteobacteria:0.0035151475)100:0.0065335192,(WP_006021976.1-Afipia_broomeae_Proteobacteria:0.0062396749,RTL81632.1-Bradyrhizobiaceae_bacterium_Proteobacteria:0.0026357283)100:0.0052222606)100:0.0181037867)94:0.0212267008,TXJ10197.1-Afipia_sp._Proteobacteria:0.0292958900)50:0.0056894676,(NGX94573.1-Candidatus_Afipia_apatlaquensis_Proteobacteria:0.0171396871,(WP_002713184.1-Afipia_clevelandensis_Proteobacteria:0.0017891004,WP_009734135.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.0034891952)100:0.0437309542)91:0.0086653250)100:0.0437018874)99:0.0415066233,WP_149531854.1-Tardiphaga_sp._P9-11_Proteobacteria:0.0881091436)73:0.0088712198,OJY11205.1-Rhizobiales_bacterium_62-47_Proteobacteria:0.1273140682)94:0.0148344939,((WP_146690165.1-Bradyrhizobium_canariense_Proteobacteria:0.0159482323,WP_100386102.1-Afipia_broomeae_Proteobacteria:0.0183759330)100:0.0674281139,WP_008968903.1-Bradyrhizobium_sp._STM_3843_Proteobacteria:0.2060846665)99:0.0501990048)96:0.0275586162,(NVN87899.1-Rhodopseudomonas_sp._Proteobacteria:0.0651288182,((WP_011665574.1-Rhodopseudomonas_palustris_Proteobacteria:0.0823318557,(((WP_110782500.1-Rhodopseudomonas_faecalis_Proteobacteria:0.0017607029,WP_027276359.1-Rhodopseudomonas_palustris_Proteobacteria:0.0053158928)99:0.0030356045,TAH64925.1-Rhodopseudomonas_palustris_Proteobacteria:0.0040660973)100:0.1041741088,((((((WP_164571151.1-Rhodopseudomonas_sp._BR0C11_Proteobacteria:0.0000023187,WP_107345917.1-Rhodopseudomonas_palustris_Proteobacteria:0.0088440300)95:0.0017611222,WP_164638651.1-Rhodopseudomonas_sp._BR0G17_Proteobacteria:0.0052823308)90:0.0000020387,WP_107356882.1-Rhodopseudomonas_palustris_Proteobacteria:0.0088534594)97:0.0037241441,((WP_011159875.1-Rhodopseudomonas_palustris_Proteobacteria:0.0017529273,WP_012497548.1-Rhodopseudomonas_palustris_Proteobacteria:0.0070691097)84:0.0000027550,WP_119019080.1-Rhodopseudomonas_palustris_Proteobacteria:0.0035293205)100:0.0122156440)100:0.0462323059,(((WP_013504207.1-Rhodopseudomonas_palustris_Proteobacteria:0.0071875903,WP_047308756.1-Rhodopseudomonas_palustris_Proteobacteria:0.0000027695)99:0.0018000779,WP_164630935.1-Rhodopseudomonas_sp._WA056_Proteobacteria:0.0000027591)100:0.0116720240,(WP_119858943.1-Rhodopseudomonas_palustris_Proteobacteria:0.1271337401,WP_142883484.1-Rhodopseudomonas_palustris_Proteobacteria:0.0144498440)85:0.0235940513)87:0.0391549717)88:0.0317456345,(WP_022722993.1-Rhodopseudomonas_sp._B29_Proteobacteria:0.0599943554,WP_054162298.1-Rhodopseudomonas_sp._AAP120_Proteobacteria:0.0931292521)83:0.0155072260)100:0.0588381775)99:0.0362728913)100:0.0337734339,(ABD08837.1-Rhodopseudomonas_palustris_Proteobacteria:0.0000029645,WP_041798938.1-Rhodopseudomonas_palustris_Proteobacteria:0.0000028130)100:0.0682149503)100:0.0515612765)100:0.1129293073)98:0.0445752282)100:0.1430315180,WP_136963313.1-Phreatobacter_stygius_Proteobacteria:0.3112306934)100:0.0917386658,((((WP_057659955.1-Pseudoxanthomonas_dokdonensis_Proteobacteria:0.2504443031,WP_077034059.1-Pelomonas_sp._KK5_Proteobacteria:0.2907394190)100:0.0897688060,(((WP_108104178.1-Pseudomonas_mangrovi_Proteobacteria:0.1439069358,WP_017937932.1-Pseudomonas_thermotolerans_Proteobacteria:0.1463690630)100:0.1327273239,(((WP_136868902.1-Pseudomonas_bauzanensis_Proteobacteria:0.0070222852,EZQ18937.1-Pseudomonas_bauzanensis_Proteobacteria:0.0000025529)100:0.1117169072,WP_185267007.1-Pseudomonas_xiamenensis_Proteobacteria:0.1297154818)100:0.1555098580,WP_093476299.1-Pseudomonas_yangmingensis_Proteobacteria:0.2420063289)100:0.0524687662)100:0.1002360458,(((MAB24835.1-Pseudomonadales_bacterium_Proteobacteria:0.0190952035,WP_182248855.1-Pseudomonas_sp._5Ae-yellow_Proteobacteria:0.0166167239)100:0.1055173487,WP_083726556.1-Pseudomonas_pachastrellae_Proteobacteria:0.1003605968)100:0.1239403048,PKM29133.1-Gammaproteobacteria_bacterium_HGW-Gammaproteobacteria-11_Proteobacteria:0.1694559589)100:0.2031845527)100:0.1243949737)99:0.0853947488,WP_151072822.1-Cupriavidus_oxalaticus_Proteobacteria:0.4488612335)77:0.0385260750,((((((((WP_027475679.1-Curvibacter_gracilis_Proteobacteria:0.0152875513,WP_157443435.1-Curvibacter_lanceolatus_Proteobacteria:0.0139609041)100:0.0290103111,RUP23521.1-Curvibacter_sp._Proteobacteria:0.0268788572)100:0.3270352857,GBU15266.1-Polaromonas_sp._Proteobacteria:0.3005515697)100:0.1430077918,(((KAB2911669.1-Hyphomicrobiaceae_bacterium_Proteobacteria:0.1877779584,(WP_089945766.1-Candidatus_Entotheonella_palauensis_Candidatus:0.0634081638,WP_089717141.1-Candidatus_Entotheonella_palauensis_Candidatus:0.0517030520)100:0.2748929147)87:0.0444202423,((OGL20369.1-Candidatus_Rokubacteria_bacterium_RIFCSPLOWO2_12_FULL_71_22_Candidatus:0.1487536663,(PYN74367.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0963975720,PYM96198.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0929122334)100:0.0778495930)98:0.0164241468,(PYN46404.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0914615522,PYN32128.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0892436852)100:0.0653428037)100:0.0991123782)100:0.2069049165,((((((((((((((WP_084803943.1-Bradyrhizobium_sp._NAS80.1_Proteobacteria:0.0149844591,WP_074117602.1-Bradyrhizobium_sp._AS23.2_Proteobacteria:0.0033342140)100:0.0283194369,((((((((WP_128961978.1-Bradyrhizobium_guangzhouense_Proteobacteria:0.0026345468,WP_128953098.1-Bradyrhizobium_guangzhouense_Proteobacteria:0.0065109029)100:0.0157546955,WP_057753835.1-Bradyrhizobium_manausense_Proteobacteria:0.0340958176)95:0.0076722371,MBC9878718.1-Bradyrhizobium_campsiandrae_Proteobacteria:0.0312913750)52:0.0018945738,(WP_092295676.1-Bradyrhizobium_sp._Ghvi_Proteobacteria:0.0098555247,WP_128967591.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0238608958)91:0.0036217164)100:0.0100196952,(WP_027528936.1-Bradyrhizobium_sp._WSM3983_Proteobacteria:0.0485879635,WP_148775460.1-Bradyrhizobium_rifense_Proteobacteria:0.0183509323)95:0.0058442356)66:0.0037800916,WP_148749019.1-Bradyrhizobium_cytisi_Proteobacteria:0.0178881925)100:0.0154749267,((((WP_145664020.1-Bradyrhizobium_stylosanthis_Proteobacteria:0.0098409043,WP_063691485.1-Bradyrhizobium_stylosanthis_Proteobacteria:0.0048258408)100:0.0314832002,(((((((WP_158669522.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0066286662,WP_035715237.1-Bradyrhizobium_sp._CCBAU_43298_Proteobacteria:0.0082831082)100:0.0374301231,(WP_061878281.1-Bradyrhizobium_liaoningense_Proteobacteria:0.0199479778,((WP_035674808.1-Bradyrhizobium_liaoningense_Proteobacteria:0.0000022155,WP_028179375.1-Bradyrhizobium_japonicum_Proteobacteria:0.0017797377)100:0.0179304412,(WP_061021165.1-Bradyrhizobium_sp._CCH5-F6_Proteobacteria:0.0125745769,GAJ33771.1-Bradyrhizobium_sp._DOA9_Proteobacteria:0.0508912984)72:0.0057388355)100:0.0078690472)97:0.0122683098)97:0.0042958524,(RTM13090.1-Bradyrhizobiaceae_bacterium_Proteobacteria:0.0262086825,(WP_100175831.1-Bradyrhizobium_nitroreducens_Proteobacteria:0.0018063311,WP_142250055.1-Bradyrhizobium_sp._UNPF46_Proteobacteria:0.0000028028)100:0.0127794736)95:0.0130149000)53:0.0017468173,(WP_128939625.1-Bradyrhizobium_zhanjiangense_Proteobacteria:0.0054097422,WP_128955323.1-Bradyrhizobium_zhanjiangense_Proteobacteria:0.0053458512)100:0.0493678310)78:0.0057988703,((WP_091965654.1-Bradyrhizobium_shewense_Proteobacteria:0.0072224938,WP_104462928.1-Bradyrhizobium_sp._AC87j1_Proteobacteria:0.0090696580)99:0.0083892132,((WP_183237909.1-Bradyrhizobium_sp._CIR18_Proteobacteria:0.0019159112,(WP_018322728.1-Bradyrhizobium_sp._WSM2793_Proteobacteria:0.0018858093,((WP_183258594.1-Bradyrhizobium_sp._CIR48_Proteobacteria:0.0000025529,WP_183231495.1-Bradyrhizobium_sp._SBR1B_Proteobacteria:0.0017861289)60:0.0000025357,WP_092259760.1-Bradyrhizobium_sp._Rc3b_Proteobacteria:0.0017882982)100:0.0125735681)82:0.0036214222)100:0.0114585433,WP_152103320.1-Bradyrhizobium_sp._TM102_Proteobacteria:0.0195235625)98:0.0018180517)86:0.0041309862)73:0.0020372151,(WP_028135100.1-Bradyrhizobium_japonicum_Proteobacteria:0.0374352864,((WP_135167913.1-Bradyrhizobium_frederickii_Proteobacteria:0.0000025529,WP_126256569.1-Bradyrhizobium_sp._LVM_105_Proteobacteria:0.0018064077)100:0.0162631319,WP_135162274.1-Bradyrhizobium_frederickii_Proteobacteria:0.0227703366)34:0.0030593777)93:0.0101627351)30:0.0050541709,(WP_151642895.1-Bradyrhizobium_betae_Proteobacteria:0.0144774369,WP_015687718.1-Bradyrhizobium_cosmicum_Proteobacteria:0.0217250045)100:0.0085910137)42:0.0071084918)83:0.0025209961,(((((WP_007594037.1-Bradyrhizobium_sp._WSM1253_Proteobacteria:0.0166251524,WP_027516639.1-Bradyrhizobium_sp._WSM1417_Proteobacteria:0.0086777562)100:0.0053207306,WP_027568791.1-Bradyrhizobium_sp._URHA0013_Proteobacteria:0.0177663228)90:0.0021525708,(WP_063993269.1-Bradyrhizobium_sp._Proteobacteria:0.0163270933,(WP_085395770.1-Bradyrhizobium_canariense_Proteobacteria:0.0017816263,WP_085352090.1-Bradyrhizobium_canariense_Proteobacteria:0.0000025529)100:0.0108947434)74:0.0018358254)75:0.0035935900,WP_018457146.1-Bradyrhizobium_sp._WSM4349_Proteobacteria:0.0110766552)97:0.0054074038,WP_106942729.1-Bradyrhizobium_sp._MOS002_Proteobacteria:0.0179900111)100:0.0164018318)65:0.0060738807,(((((WP_011085536.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529,WP_038965832.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000020678)61:0.0000027037,WP_182869822.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0036093652)100:0.0073149382,(QHP72204.1-Bradyrhizobium_sp._LCT2_Proteobacteria:0.0000023416,WP_161535945.1-Bradyrhizobium_sp._LCT2_Proteobacteria:0.0000023124)99:0.0018085972)100:0.0018381733,((WP_060912981.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529,BAR59885.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529)100:0.0018143049,(KGJ68294.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529,WP_028174753.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0000025529)100:0.0018168824)100:0.0036101900)100:0.0190720633,WP_148744709.1-Bradyrhizobium_hipponense_Proteobacteria:0.0581515546)38:0.0045507008)37:0.0047666318)24:0.0028471437,(((WP_008138438.1-Bradyrhizobium_sp._YR681_Proteobacteria:0.0194807595,WP_129271949.1-Bradyrhizobium_betae_Proteobacteria:0.0231931663)97:0.0017684549,WP_092029312.1-Bradyrhizobium_sp._OK095_Proteobacteria:0.0149217060)100:0.0081846157,WP_092214970.1-Bradyrhizobium_arachidis_Proteobacteria:0.0295808162)88:0.0090227487)65:0.0097156734)91:0.0071301977,(((((WP_071915975.1-Bradyrhizobium_japonicum_Proteobacteria:0.0035973092,WP_063984832.1-Bradyrhizobium_sp._Proteobacteria:0.0054384548)100:0.0024664171,WP_166089364.1-Bradyrhizobium_sp._1S5_Proteobacteria:0.0140715444)100:0.0091350433,WP_166350707.1-Bradyrhizobium_sp._323S2_Proteobacteria:0.0097146584)100:0.0137446887,(WP_038931390.1-Bradyrhizobium_japonicum_Proteobacteria:0.0017967916,WP_039157276.1-Bradyrhizobium_japonicum_Proteobacteria:0.0018008347)100:0.0007230983)98:0.0030745842,(WP_028156991.1-Bradyrhizobium_japonicum_Proteobacteria:0.0090137277,WP_041955910.1-Bradyrhizobium_japonicum_Proteobacteria:0.0000024434)100:0.0035572034)100:0.0158009222)99:0.0152288989,((WP_063680948.1-Bradyrhizobium_neotropicale_Proteobacteria:0.0196342599,WP_027550185.1-Bradyrhizobium_sp._Cp5.3_Proteobacteria:0.0095048442)100:0.0234775456,WP_063705824.1-Bradyrhizobium_centrolobii_Proteobacteria:0.0156907727)77:0.0066796844)91:0.0107026319,WP_027526029.1-Bradyrhizobium_sp._Ec3.3_Proteobacteria:0.0556339320)100:0.0150153633,WP_140980779.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0384437846)100:0.0338028844,((((((((((WP_065748757.1-Bradyrhizobium_sp._LMTR_3_Proteobacteria:0.0300597239,(WP_028347371.1-Bradyrhizobium_murdochi_Proteobacteria:0.0192907318,WP_057843198.1-Bradyrhizobium_retamae_Proteobacteria:0.0177910559)100:0.0062281679)73:0.0022151630,WP_171577827.1-Bradyrhizobium_australiense_Proteobacteria:0.0263946208)100:0.0051995689,WP_065730813.1-Bradyrhizobium_icense_Proteobacteria:0.0247657613)100:0.0170491396,((WP_161852777.1-Bradyrhizobium_sp._CCBAU_051011_Proteobacteria:0.0288880490,(WP_065756637.1-Bradyrhizobium_paxllaeri_Proteobacteria:0.0216503159,WP_057859318.1-Bradyrhizobium_lablabi_Proteobacteria:0.0091366884)100:0.0073879009)100:0.0046301725,WP_057833547.1-Bradyrhizobium_jicamae_Proteobacteria:0.0178178765)100:0.0097361233)100:0.0134191777,WP_108514566.1-Bradyrhizobium_algeriense_Proteobacteria:0.0328737630)82:0.0069744356,(WP_057900995.1-Bradyrhizobium_valentinum_Proteobacteria:0.0000025529,WP_057851642.1-Bradyrhizobium_valentinum_Proteobacteria:0.0017897692)100:0.0550459293)93:0.0110724346,(((WP_155805222.1-Bradyrhizobium_sp._URHA0002_Proteobacteria:0.0355431287,(WP_092515866.1-Afipia_sp._GAS231_Proteobacteria:0.0018019864,SDP08864.1-Afipia_sp._GAS231_Proteobacteria:0.0000028835)100:0.0215708847)100:0.0055145948,WP_079586579.1-Bradyrhizobium_lablabi_Proteobacteria:0.0319040136)99:0.0103619859,((WP_143206068.1-Bradyrhizobium_erythrophlei_Proteobacteria:0.0361139511,(TKW79521.1-Bradyrhizobium_icense_Proteobacteria:0.0608690494,WP_100419024.1-Bradyrhizobium_lablabi_Proteobacteria:0.0515946924)92:0.0202090948)81:0.0104463810,MBA2399293.1-Bradyrhizobium_sp._Proteobacteria:0.0364554366)71:0.0066879051)74:0.0055647529)65:0.0061542187,MBA4036164.1-Bradyrhizobium_sp._Proteobacteria:0.0405283343)81:0.0227043355,WP_069276965.1-Bradyrhizobium_elkanii_Proteobacteria:0.0722275078)97:0.0164613475,(WP_130580234.1-Bradyrhizobium_sp._Leo170_Proteobacteria:0.0274574027,WP_130222300.1-Bradyrhizobium_sp._Leo121_Proteobacteria:0.0492842417)100:0.0546819528)65:0.0166751451)71:0.0145592668,((WP_079601315.1-Bradyrhizobium_erythrophlei_Proteobacteria:0.0483522052,(((WP_100380578.1-Afipia_broomeae_Proteobacteria:0.0177911776,WP_146687675.1-Bradyrhizobium_canariense_Proteobacteria:0.0021310859)100:0.0360374357,TMK06221.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0636638288)78:0.0181483378,THD60673.1-Bradyrhizobium_sp._Proteobacteria:0.0652871755)80:0.0216840148)74:0.0197372016,WP_079544782.1-Bradyrhizobium_lablabi_Proteobacteria:0.0720034094)75:0.0173912185)77:0.0111860198,(WP_024518537.1-Bradyrhizobium_sp._Tv2a-2_Proteobacteria:0.0667884073,WP_024511517.1-Bradyrhizobium_sp._ARR65_Proteobacteria:0.0783727102)99:0.0359617054)94:0.0125244480,(TMJ47098.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0340033028,TMK39387.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0121410077)100:0.0494829005)99:0.0276614213,((((WP_035655465.1-Bradyrhizobium_sp._STM_3809_Proteobacteria:0.0000025547,CCD98599.1-Bradyrhizobium_sp._STM_3809_Proteobacteria:0.0000025529)100:0.0380780498,(((WP_172134110.1-Bradyrhizobium_sp._81013_Proteobacteria:0.0000025529,WP_172111906.1-Bradyrhizobium_sp._83012_Proteobacteria:0.0035471731)100:0.0021326774,WP_172180802.1-Bradyrhizobium_sp._83002_Proteobacteria:0.0050059425)100:0.0307800772,WP_083842450.1-Bradyrhizobium_sp._ORS_375_Proteobacteria:0.0301196020)100:0.0111131521)99:0.0256677348,WP_168167890.1-Bradyrhizobium_sp._BTAi1_Proteobacteria:0.0563145085)100:0.0959843621,(NVN85223.1-Rhodopseudomonas_sp._Proteobacteria:0.0665542815,WP_011439962.1-Rhodopseudomonas_palustris_Proteobacteria:0.1114647753)100:0.0416817415)84:0.0068793984)100:0.1892107471,(WP_046828790.1-Afipia_massiliensis_Proteobacteria:0.0543554175,((EGP08750.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.0000025529,WP_043924226.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.0000025529)100:0.0056514111,WP_002714592.1-Afipia_clevelandensis_Proteobacteria:0.0066726172)100:0.0435592295)100:0.1754935655)100:0.1763423894,WP_076861029.1-Bradyrhizobium_mercantei_Proteobacteria:0.3530543936)100:0.1056086523,OJY09878.1-Rhizobiales_bacterium_62-47_Proteobacteria:0.3726719779)100:0.1228057174)84:0.0698636387)90:0.0451901483,(WP_155709830.1-Massilia_dura_Proteobacteria:0.5557661566,RZL87373.1-Variovorax_sp._Proteobacteria:0.3945588924)100:0.0736976779)83:0.0239109759,((((((WP_066731373.1-Cupriavidus_sp._D384_Proteobacteria:0.1244621502,((WP_071072555.1-Cupriavidus_malaysiensis_Proteobacteria:0.0000024404,WP_071038742.1-Cupriavidus_sp._USMAA2-4_Proteobacteria:0.0018049159)100:0.0018075780,WP_071018820.1-Cupriavidus_sp._USMAHM13_Proteobacteria:0.0000026140)100:0.1086010247)99:0.0424841488,WP_116319445.1-Cupriavidus_sp._P-10_Proteobacteria:0.1027967862)100:0.0837115318,((((WP_025586346.1-Cupriavidus_taiwanensis_Proteobacteria:0.0000025529,WP_116388232.1-Cupriavidus_taiwanensis_Proteobacteria:0.0036557088)100:0.0316799251,WP_116377884.1-Cupriavidus_taiwanensis_Proteobacteria:0.0302374199)99:0.0150639375,WP_062795892.1-Cupriavidus_nantongensis_Proteobacteria:0.0148732888)100:0.0624658383,WP_116320039.1-Cupriavidus_sp._P-10_Proteobacteria:0.0839847297)100:0.1462076246)100:0.1899307557,((WP_061999991.1-Burkholderia_sp._PAMC_28687_Proteobacteria:0.0087254950,WP_062170184.1-Burkholderia_sp._PAMC_26561_Proteobacteria:0.0025040922)100:0.0260404307,WP_081889718.1-Caballeronia_sordidicola_Proteobacteria:0.0277042159)100:0.4391644299)99:0.0726843554,(PZW26129.1-Thermosporothrix_hazakensis_Chloroflexi:0.0000025529,WP_111324427.1-Thermosporothrix_hazakensis_Chloroflexi:0.0000025529)100:0.4278181864)100:0.0982174834,((WP_150987011.1-Cupriavidus_basilensis_Proteobacteria:0.0061662550,(WP_183035411.1-Cupriavidus_sp._UME77_Proteobacteria:0.0000025529,MBB1634382.1-Cupriavidus_sp._UME77_Proteobacteria:0.0000024494)100:0.0121357022)100:0.1044846317,WP_092594144.1-Ralstonia_sp._25mfcol4.1_Proteobacteria:0.1855041654)100:0.3460007168)98:0.0688633008)86:0.0421557676,WP_119419155.1-Rhodospirillaceae_bacterium_SYSU_D60015_Proteobacteria:0.5054381725)88:0.0483121127,(WP_163259863.1-Caulobacter_sp._17J65-9_Proteobacteria:0.0359889329,WP_187448402.1-Caulobacter_sp._17J80-11_Proteobacteria:0.0560016928)100:0.4106137649)94:0.0539909156)67:0.0266595912)100:0.1389205692,WP_092831606.1-Rhodospirillales_bacterium_URHD0017_Proteobacteria:0.2999519574)100:0.0566919932)100:0.0828212463,(XP_018221989.1-Saccharomyces_eubayanus_Saccharomycotina:0.0010209931,QID88192.1-Saccharomyces_pastorianus_Saccharomycotina:0.0059908746)100:0.2282597169)100:0.1326617390,(XP_002555886.1-Lachancea_thermotolerans_Saccharomycotina:0.1333561401,SCW03834.1-Lachancea_fermentati_Saccharomycotina:0.1492720700)100:0.2396795606)100:0.1389922433,QUERY_Saccharomyces_cerevisiae_YOL164W:0.1521691852);
2 |
--------------------------------------------------------------------------------
/phylogenetics/intermediate/YOL164W_midpoint.tree:
--------------------------------------------------------------------------------
1 | (((((((((((((((((((((((((((((((WP_061021165.1-Bradyrhizobium_sp._CCH5-F6_Proteobacteria:0.0125745769,GAJ33771.1-Bradyrhizobium_sp._DOA9_Proteobacteria:0.0508912984)72:0.0057388355,(WP_035674808.1-Bradyrhizobium_liaoningense_Proteobacteria:2.2155e-06,WP_028179375.1-Bradyrhizobium_japonicum_Proteobacteria:0.0017797377)100:0.0179304412)100:0.0078690472,WP_061878281.1-Bradyrhizobium_liaoningense_Proteobacteria:0.0199479778)97:0.0122683098,(WP_158669522.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0066286662,WP_035715237.1-Bradyrhizobium_sp._CCBAU_43298_Proteobacteria:0.0082831082)100:0.0374301231)97:0.0042958524,((WP_100175831.1-Bradyrhizobium_nitroreducens_Proteobacteria:0.0018063311,WP_142250055.1-Bradyrhizobium_sp._UNPF46_Proteobacteria:2.8028e-06)100:0.0127794736,RTM13090.1-Bradyrhizobiaceae_bacterium_Proteobacteria:0.0262086825)95:0.0130149)53:0.0017468173,(WP_128939625.1-Bradyrhizobium_zhanjiangense_Proteobacteria:0.0054097422,WP_128955323.1-Bradyrhizobium_zhanjiangense_Proteobacteria:0.0053458512)100:0.049367831)78:0.0057988703,((((((WP_183258594.1-Bradyrhizobium_sp._CIR48_Proteobacteria:2.5529e-06,WP_183231495.1-Bradyrhizobium_sp._SBR1B_Proteobacteria:0.0017861289)60:2.5357e-06,WP_092259760.1-Bradyrhizobium_sp._Rc3b_Proteobacteria:0.0017882982)100:0.0125735681,WP_018322728.1-Bradyrhizobium_sp._WSM2793_Proteobacteria:0.0018858093)82:0.0036214222,WP_183237909.1-Bradyrhizobium_sp._CIR18_Proteobacteria:0.0019159112)100:0.0114585433,WP_152103320.1-Bradyrhizobium_sp._TM102_Proteobacteria:0.0195235625)98:0.0018180517,(WP_091965654.1-Bradyrhizobium_shewense_Proteobacteria:0.0072224938,WP_104462928.1-Bradyrhizobium_sp._AC87j1_Proteobacteria:0.009069658)99:0.0083892132)86:0.0041309862)73:0.0020372151,(((WP_135167913.1-Bradyrhizobium_frederickii_Proteobacteria:2.5529e-06,WP_126256569.1-Bradyrhizobium_sp._LVM_105_Proteobacteria:0.0018064077)100:0.0162631319,WP_135162274.1-Bradyrhizobium_frederickii_Proteobacteria:0.0227703366)34:0.0030593777,WP_028135100.1-Bradyrhizobium_japonicum_Proteobacteria:0.0374352864)93:0.0101627351)30:0.0050541709,(WP_151642895.1-Bradyrhizobium_betae_Proteobacteria:0.0144774369,WP_015687718.1-Bradyrhizobium_cosmicum_Proteobacteria:0.0217250045)100:0.0085910137)42:0.0071084918,(WP_145664020.1-Bradyrhizobium_stylosanthis_Proteobacteria:0.0098409043,WP_063691485.1-Bradyrhizobium_stylosanthis_Proteobacteria:0.0048258408)100:0.0314832002)83:0.0025209961,(((((WP_007594037.1-Bradyrhizobium_sp._WSM1253_Proteobacteria:0.0166251524,WP_027516639.1-Bradyrhizobium_sp._WSM1417_Proteobacteria:0.0086777562)100:0.0053207306,WP_027568791.1-Bradyrhizobium_sp._URHA0013_Proteobacteria:0.0177663228)90:0.0021525708,((WP_085395770.1-Bradyrhizobium_canariense_Proteobacteria:0.0017816263,WP_085352090.1-Bradyrhizobium_canariense_Proteobacteria:2.5529e-06)100:0.0108947434,WP_063993269.1-Bradyrhizobium_sp._Proteobacteria:0.0163270933)74:0.0018358254)75:0.00359359,WP_018457146.1-Bradyrhizobium_sp._WSM4349_Proteobacteria:0.0110766552)97:0.0054074038,WP_106942729.1-Bradyrhizobium_sp._MOS002_Proteobacteria:0.0179900111)100:0.0164018318)65:0.0060738807,(((((WP_011085536.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.5529e-06,WP_038965832.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.0678e-06)61:2.7037e-06,WP_182869822.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0036093652)100:0.0073149382,(QHP72204.1-Bradyrhizobium_sp._LCT2_Proteobacteria:2.3416e-06,WP_161535945.1-Bradyrhizobium_sp._LCT2_Proteobacteria:2.3124e-06)99:0.0018085972)100:0.0018381733,((WP_060912981.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.5529e-06,BAR59885.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.5529e-06)100:0.0018143049,(KGJ68294.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.5529e-06,WP_028174753.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.5529e-06)100:0.0018168824)100:0.00361019)100:0.0190720633,WP_148744709.1-Bradyrhizobium_hipponense_Proteobacteria:0.0581515546)38:0.0045507008)37:0.0047666318,((((((WP_128961978.1-Bradyrhizobium_guangzhouense_Proteobacteria:0.0026345468,WP_128953098.1-Bradyrhizobium_guangzhouense_Proteobacteria:0.0065109029)100:0.0157546955,WP_057753835.1-Bradyrhizobium_manausense_Proteobacteria:0.0340958176)95:0.0076722371,MBC9878718.1-Bradyrhizobium_campsiandrae_Proteobacteria:0.031291375)52:0.0018945738,(WP_092295676.1-Bradyrhizobium_sp._Ghvi_Proteobacteria:0.0098555247,WP_128967591.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0238608958)91:0.0036217164)100:0.0100196952,(WP_027528936.1-Bradyrhizobium_sp._WSM3983_Proteobacteria:0.0485879635,WP_148775460.1-Bradyrhizobium_rifense_Proteobacteria:0.0183509323)95:0.0058442356)66:0.0037800916,WP_148749019.1-Bradyrhizobium_cytisi_Proteobacteria:0.0178881925)100:0.0154749267)24:0.0028471437,(((WP_008138438.1-Bradyrhizobium_sp._YR681_Proteobacteria:0.0194807595,WP_129271949.1-Bradyrhizobium_betae_Proteobacteria:0.0231931663)97:0.0017684549,WP_092029312.1-Bradyrhizobium_sp._OK095_Proteobacteria:0.014921706)100:0.0081846157,WP_092214970.1-Bradyrhizobium_arachidis_Proteobacteria:0.0295808162)88:0.0090227487)65:0.0097156734,(WP_084803943.1-Bradyrhizobium_sp._NAS80.1_Proteobacteria:0.0149844591,WP_074117602.1-Bradyrhizobium_sp._AS23.2_Proteobacteria:0.003334214)100:0.0283194369)91:0.0071301977,(((((WP_071915975.1-Bradyrhizobium_japonicum_Proteobacteria:0.0035973092,WP_063984832.1-Bradyrhizobium_sp._Proteobacteria:0.0054384548)100:0.0024664171,WP_166089364.1-Bradyrhizobium_sp._1S5_Proteobacteria:0.0140715444)100:0.0091350433,WP_166350707.1-Bradyrhizobium_sp._323S2_Proteobacteria:0.0097146584)100:0.0137446887,(WP_038931390.1-Bradyrhizobium_japonicum_Proteobacteria:0.0017967916,WP_039157276.1-Bradyrhizobium_japonicum_Proteobacteria:0.0018008347)100:0.0007230983)98:0.0030745842,(WP_028156991.1-Bradyrhizobium_japonicum_Proteobacteria:0.0090137277,WP_041955910.1-Bradyrhizobium_japonicum_Proteobacteria:2.4434e-06)100:0.0035572034)100:0.0158009222)99:0.0152288989,((WP_063680948.1-Bradyrhizobium_neotropicale_Proteobacteria:0.0196342599,WP_027550185.1-Bradyrhizobium_sp._Cp5.3_Proteobacteria:0.0095048442)100:0.0234775456,WP_063705824.1-Bradyrhizobium_centrolobii_Proteobacteria:0.0156907727)77:0.0066796844)91:0.0107026319,WP_027526029.1-Bradyrhizobium_sp._Ec3.3_Proteobacteria:0.055633932)100:0.0150153633,WP_140980779.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0384437846)100:0.0338028844,(((((((((((WP_028347371.1-Bradyrhizobium_murdochi_Proteobacteria:0.0192907318,WP_057843198.1-Bradyrhizobium_retamae_Proteobacteria:0.0177910559)100:0.0062281679,WP_065748757.1-Bradyrhizobium_sp._LMTR_3_Proteobacteria:0.0300597239)73:0.002215163,WP_171577827.1-Bradyrhizobium_australiense_Proteobacteria:0.0263946208)100:0.0051995689,WP_065730813.1-Bradyrhizobium_icense_Proteobacteria:0.0247657613)100:0.0170491396,(((WP_065756637.1-Bradyrhizobium_paxllaeri_Proteobacteria:0.0216503159,WP_057859318.1-Bradyrhizobium_lablabi_Proteobacteria:0.0091366884)100:0.0073879009,WP_161852777.1-Bradyrhizobium_sp._CCBAU_051011_Proteobacteria:0.028888049)100:0.0046301725,WP_057833547.1-Bradyrhizobium_jicamae_Proteobacteria:0.0178178765)100:0.0097361233)100:0.0134191777,WP_108514566.1-Bradyrhizobium_algeriense_Proteobacteria:0.032873763)82:0.0069744356,(WP_057900995.1-Bradyrhizobium_valentinum_Proteobacteria:2.5529e-06,WP_057851642.1-Bradyrhizobium_valentinum_Proteobacteria:0.0017897692)100:0.0550459293)93:0.0110724346,((((WP_092515866.1-Afipia_sp._GAS231_Proteobacteria:0.0018019864,SDP08864.1-Afipia_sp._GAS231_Proteobacteria:2.8835e-06)100:0.0215708847,WP_155805222.1-Bradyrhizobium_sp._URHA0002_Proteobacteria:0.0355431287)100:0.0055145948,WP_079586579.1-Bradyrhizobium_lablabi_Proteobacteria:0.0319040136)99:0.0103619859,(((TKW79521.1-Bradyrhizobium_icense_Proteobacteria:0.0608690494,WP_100419024.1-Bradyrhizobium_lablabi_Proteobacteria:0.0515946924)92:0.0202090948,WP_143206068.1-Bradyrhizobium_erythrophlei_Proteobacteria:0.0361139511)81:0.010446381,MBA2399293.1-Bradyrhizobium_sp._Proteobacteria:0.0364554366)71:0.0066879051)74:0.0055647529)65:0.0061542187,MBA4036164.1-Bradyrhizobium_sp._Proteobacteria:0.0405283343)81:0.0227043355,WP_069276965.1-Bradyrhizobium_elkanii_Proteobacteria:0.0722275078)97:0.0164613475,(WP_130580234.1-Bradyrhizobium_sp._Leo170_Proteobacteria:0.0274574027,WP_130222300.1-Bradyrhizobium_sp._Leo121_Proteobacteria:0.0492842417)100:0.0546819528)65:0.0166751451)71:0.0145592668,(((((WP_100380578.1-Afipia_broomeae_Proteobacteria:0.0177911776,WP_146687675.1-Bradyrhizobium_canariense_Proteobacteria:0.0021310859)100:0.0360374357,TMK06221.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0636638288)78:0.0181483378,THD60673.1-Bradyrhizobium_sp._Proteobacteria:0.0652871755)80:0.0216840148,WP_079601315.1-Bradyrhizobium_erythrophlei_Proteobacteria:0.0483522052)74:0.0197372016,WP_079544782.1-Bradyrhizobium_lablabi_Proteobacteria:0.0720034094)75:0.0173912185)77:0.0111860198,(WP_024518537.1-Bradyrhizobium_sp._Tv2a-2_Proteobacteria:0.0667884073,WP_024511517.1-Bradyrhizobium_sp._ARR65_Proteobacteria:0.0783727102)99:0.0359617054)94:0.012524448,(TMJ47098.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0340033028,TMK39387.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0121410077)100:0.0494829005)99:0.0276614213,((((((WP_172134110.1-Bradyrhizobium_sp._81013_Proteobacteria:2.5529e-06,WP_172111906.1-Bradyrhizobium_sp._83012_Proteobacteria:0.0035471731)100:0.0021326774,WP_172180802.1-Bradyrhizobium_sp._83002_Proteobacteria:0.0050059425)100:0.0307800772,WP_083842450.1-Bradyrhizobium_sp._ORS_375_Proteobacteria:0.030119602)100:0.0111131521,(WP_035655465.1-Bradyrhizobium_sp._STM_3809_Proteobacteria:2.5547e-06,CCD98599.1-Bradyrhizobium_sp._STM_3809_Proteobacteria:2.5529e-06)100:0.0380780498)99:0.0256677348,WP_168167890.1-Bradyrhizobium_sp._BTAi1_Proteobacteria:0.0563145085)100:0.0959843621,(NVN85223.1-Rhodopseudomonas_sp._Proteobacteria:0.0665542815,WP_011439962.1-Rhodopseudomonas_palustris_Proteobacteria:0.1114647753)100:0.0416817415)84:0.0068793984)100:0.1892107471,(((EGP08750.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:2.5529e-06,WP_043924226.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:2.5529e-06)100:0.0056514111,WP_002714592.1-Afipia_clevelandensis_Proteobacteria:0.0066726172)100:0.0435592295,WP_046828790.1-Afipia_massiliensis_Proteobacteria:0.0543554175)100:0.1754935655)100:0.1763423894,WP_076861029.1-Bradyrhizobium_mercantei_Proteobacteria:0.3530543936)100:0.1056086523,OJY09878.1-Rhizobiales_bacterium_62-47_Proteobacteria:0.3726719779)100:0.1228057174,((((PYN74367.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.096397572,PYM96198.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0929122334)100:0.077849593,OGL20369.1-Candidatus_Rokubacteria_bacterium_RIFCSPLOWO2_12_FULL_71_22_Candidatus:0.1487536663)98:0.0164241468,(PYN46404.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0914615522,PYN32128.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0892436852)100:0.0653428037)100:0.0991123782,((WP_089945766.1-Candidatus_Entotheonella_palauensis_Candidatus:0.0634081638,WP_089717141.1-Candidatus_Entotheonella_palauensis_Candidatus:0.051703052)100:0.2748929147,KAB2911669.1-Hyphomicrobiaceae_bacterium_Proteobacteria:0.1877779584)87:0.0444202423)100:0.2069049165)84:0.0698636387,(((WP_027475679.1-Curvibacter_gracilis_Proteobacteria:0.0152875513,WP_157443435.1-Curvibacter_lanceolatus_Proteobacteria:0.0139609041)100:0.0290103111,RUP23521.1-Curvibacter_sp._Proteobacteria:0.0268788572)100:0.3270352857,GBU15266.1-Polaromonas_sp._Proteobacteria:0.3005515697)100:0.1430077918)90:0.0451901483,(WP_155709830.1-Massilia_dura_Proteobacteria:0.5557661566,RZL87373.1-Variovorax_sp._Proteobacteria:0.3945588924)100:0.0736976779)83:0.0047554408,((((((((((((((((((((((WP_145759386.1-Variovorax_sp._1180_Proteobacteria:2.5529e-06,WP_126183471.1-Variovorax_sp._369_Proteobacteria:0.0035560491)100:0.0035575277,WP_020722993.1-Variovorax_paradoxus_Proteobacteria:0.003559658)99:2.8573e-06,WP_184605932.1-Variovorax_sp._BK613_Proteobacteria:0.0017867393)100:0.0017778488,WP_132801781.1-Variovorax_sp._BK370_Proteobacteria:2.5902e-06)100:0.0017773413,WP_132755990.1-Variovorax_sp._BK151_Proteobacteria:0.0035706853)100:0.0104871553,WP_176665552.1-Variovorax_sp._SG517_Proteobacteria:0.0131240078)99:0.0055691785,(WP_184638849.1-Variovorax_guangxiensis_Proteobacteria:0.0020296942,WP_126020505.1-Variovorax_guangxiensis_Proteobacteria:0.0032976925)100:0.0218177694)100:0.0190596629,(WP_093195641.1-Variovorax_sp._YR750_Proteobacteria:0.0070754256,WP_126472589.1-Variovorax_gossypii_Proteobacteria:0.0071366605)100:0.005799894)100:0.0123966964,(((WP_097197469.1-Variovorax_sp._YR752_Proteobacteria:0.0035487301,WP_093174861.1-Variovorax_sp._YR266_Proteobacteria:2.7141e-06)100:0.0017804944,WP_093076613.1-Variovorax_sp._OV084_Proteobacteria:0.0017718643)99:0.0015431797,WP_093057006.1-Variovorax_sp._YR634_Proteobacteria:0.0037590032)100:0.0310962981)90:0.0149565902,((WP_130421160.1-Variovorax_sp._BK460_Proteobacteria:0.0284286767,WP_093131647.1-Variovorax_sp._OK605_Proteobacteria:0.2080303908)71:0.036386729,WP_007837899.1-Variovorax_sp._CF313_Proteobacteria:0.0152241582)48:0.0181505344)48:0.0156223618,(WP_081267376.1-Variovorax_paradoxus_Proteobacteria:0.0269652371,ODU15846.1-Variovorax_sp._SCN_67-85_Proteobacteria:0.0233850795)100:0.0325716889)68:0.0188985374,(((((WP_172705422.1-Variovorax_paradoxus_Proteobacteria:2.5529e-06,KPU98577.1-Variovorax_paradoxus_Proteobacteria:2.5529e-06)100:0.0041970861,MBS76598.1-Variovorax_sp._Proteobacteria:2.7864e-06)100:0.0084655208,WP_093343818.1-Variovorax_sp._PDC80_Proteobacteria:0.003582875)83:2.9532e-06,KAF1061273.1-Variovorax_sp._Proteobacteria:0.0078040894)88:0.002732022,TAJ61793.1-Variovorax_sp._Proteobacteria:0.0044458578)100:0.0749097892)73:0.0319422853,(((WP_093435402.1-Variovorax_sp._770b2_Proteobacteria:0.0206586646,WP_052810747.1-Variovorax_paradoxus_Proteobacteria:0.0165659413)100:0.0134437057,WP_013538622.1-Variovorax_paradoxus_Proteobacteria:0.030228641)73:0.0150777259,WP_176660984.1-Variovorax_sp._SG533_Proteobacteria:0.0453283197)61:0.0068646733)72:0.0244211033,WP_145738683.1-Variovorax_beijingensis_Proteobacteria:0.0610257482)71:0.010683452,(((((((((WP_062470459.1-Variovorax_boronicumulans_Proteobacteria:0.0052289264,WP_095948515.1-Variovorax_boronicumulans_Proteobacteria:2.7198e-06)72:0.0034849056,WP_159278964.1-Variovorax_boronicumulans_Proteobacteria:0.0034724572)88:0.0017543454,WP_159274326.1-Variovorax_boronicumulans_Proteobacteria:0.0034861997)54:0.0017462506,(WP_070061350.1-Variovorax_boronicumulans_Proteobacteria:0.003505998,WP_095743122.1-Variovorax_boronicumulans_Proteobacteria:0.0017468574)61:2.3233e-06)90:0.0034887664,WP_139703542.1-Variovorax_sp._KBS0712_Proteobacteria:2.1316e-06)96:0.0040951815,((WP_099794476.1-Variovorax_sp._54_Proteobacteria:0.0034785224,WP_101490554.1-Variovorax_sp._RO1_Proteobacteria:0.0052145746)98:2.6612e-06,WP_153281245.1-Variovorax_paradoxus_Proteobacteria:0.0069603947)88:0.0046318009)81:0.0077788031,WP_056574498.1-Variovorax_sp._Root473_Proteobacteria:0.0239051762)36:0.0112620334,WP_119556153.1-Acidovorax_cavernicola_Proteobacteria:0.0490619443)97:0.0295236989,((WP_093241869.1-Variovorax_sp._EL159_Proteobacteria:0.0125800125,WP_187113215.1-Variovorax_sp._PAMC26660_Proteobacteria:0.0317758982)100:0.0327409585,WP_124458460.1-Variovorax_sp._KBW07_Proteobacteria:0.0418875545)42:0.0093686014)95:0.0196208468)99:0.0487542445,(((QLG72306.1-Zygotorulaspora_mrakii_Saccharomycotina:0.1410169193,QUERY_Saccharomyces_cerevisiae_YOL164W:0.1521691852)100:0.1389922433,(XP_002555886.1-Lachancea_thermotolerans_Saccharomycotina:0.1333561401,SCW03834.1-Lachancea_fermentati_Saccharomycotina:0.14927207)100:0.2396795606)100:0.132661739,(XP_018221989.1-Saccharomyces_eubayanus_Saccharomycotina:0.0010209931,QID88192.1-Saccharomyces_pastorianus_Saccharomycotina:0.0059908746)100:0.2282597169)100:0.0828212463)100:0.0566919932,WP_092831606.1-Rhodospirillales_bacterium_URHD0017_Proteobacteria:0.2999519574)100:0.1389205692,(((((((((((((MBB5054515.1-Afipia_massiliensis_Proteobacteria:0.0017197135,WP_184089169.1-Afipia_massiliensis_Proteobacteria:2.5529e-06)100:0.0314135181,WP_046827511.1-Afipia_massiliensis_Proteobacteria:0.014905309)99:0.0174094539,WP_062313220.1-Bradyrhizobium_sp._CCH10-C7_Proteobacteria:0.0230233757)82:0.011714591,((HBR43714.1-Afipia_sp._Proteobacteria:0.0017509222,HAQ93654.1-Afipia_sp._Proteobacteria:0.0035151475)100:0.0065335192,(WP_006021976.1-Afipia_broomeae_Proteobacteria:0.0062396749,RTL81632.1-Bradyrhizobiaceae_bacterium_Proteobacteria:0.0026357283)100:0.0052222606)100:0.0181037867)94:0.0212267008,TXJ10197.1-Afipia_sp._Proteobacteria:0.02929589)50:0.0056894676,((WP_002713184.1-Afipia_clevelandensis_Proteobacteria:0.0017891004,WP_009734135.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.0034891952)100:0.0437309542,NGX94573.1-Candidatus_Afipia_apatlaquensis_Proteobacteria:0.0171396871)91:0.008665325)100:0.0437018874,(((((WP_175367589.1-Tardiphaga_robiniae_Proteobacteria:0.001711963,WP_120288614.1-Tardiphaga_sp._YR296_Proteobacteria:0.0104363849)93:0.0028198655,WP_184513838.1-Tardiphaga_robiniae_Proteobacteria:0.0040792062)92:0.0055540338,WP_089261759.1-Tardiphaga_sp._OK246_Proteobacteria:0.0089400208)100:0.03152664,WP_092138970.1-Bradyrhizobium_sp._NFR13_Proteobacteria:0.0243423553)91:0.0267856795,WP_115033941.1-Tardiphaga_sp._CF115_Proteobacteria:0.0231530893)100:0.0632464649)99:0.0415066233,WP_149531854.1-Tardiphaga_sp._P9-11_Proteobacteria:0.0881091436)73:0.0088712198,OJY11205.1-Rhizobiales_bacterium_62-47_Proteobacteria:0.1273140682)94:0.0148344939,((WP_146690165.1-Bradyrhizobium_canariense_Proteobacteria:0.0159482323,WP_100386102.1-Afipia_broomeae_Proteobacteria:0.018375933)100:0.0674281139,WP_008968903.1-Bradyrhizobium_sp._STM_3843_Proteobacteria:0.2060846665)99:0.0501990048)96:0.0275586162,((((((((((WP_164571151.1-Rhodopseudomonas_sp._BR0C11_Proteobacteria:2.3187e-06,WP_107345917.1-Rhodopseudomonas_palustris_Proteobacteria:0.00884403)95:0.0017611222,WP_164638651.1-Rhodopseudomonas_sp._BR0G17_Proteobacteria:0.0052823308)90:2.0387e-06,WP_107356882.1-Rhodopseudomonas_palustris_Proteobacteria:0.0088534594)97:0.0037241441,((WP_011159875.1-Rhodopseudomonas_palustris_Proteobacteria:0.0017529273,WP_012497548.1-Rhodopseudomonas_palustris_Proteobacteria:0.0070691097)84:2.755e-06,WP_119019080.1-Rhodopseudomonas_palustris_Proteobacteria:0.0035293205)100:0.012215644)100:0.0462323059,(((WP_013504207.1-Rhodopseudomonas_palustris_Proteobacteria:0.0071875903,WP_047308756.1-Rhodopseudomonas_palustris_Proteobacteria:2.7695e-06)99:0.0018000779,WP_164630935.1-Rhodopseudomonas_sp._WA056_Proteobacteria:2.7591e-06)100:0.011672024,(WP_119858943.1-Rhodopseudomonas_palustris_Proteobacteria:0.1271337401,WP_142883484.1-Rhodopseudomonas_palustris_Proteobacteria:0.014449844)85:0.0235940513)87:0.0391549717)88:0.0317456345,(WP_022722993.1-Rhodopseudomonas_sp._B29_Proteobacteria:0.0599943554,WP_054162298.1-Rhodopseudomonas_sp._AAP120_Proteobacteria:0.0931292521)83:0.015507226)100:0.0588381775,((WP_110782500.1-Rhodopseudomonas_faecalis_Proteobacteria:0.0017607029,WP_027276359.1-Rhodopseudomonas_palustris_Proteobacteria:0.0053158928)99:0.0030356045,TAH64925.1-Rhodopseudomonas_palustris_Proteobacteria:0.0040660973)100:0.1041741088)99:0.0362728913,WP_011665574.1-Rhodopseudomonas_palustris_Proteobacteria:0.0823318557)100:0.0337734339,(ABD08837.1-Rhodopseudomonas_palustris_Proteobacteria:2.9645e-06,WP_041798938.1-Rhodopseudomonas_palustris_Proteobacteria:2.813e-06)100:0.0682149503)100:0.0515612765,NVN87899.1-Rhodopseudomonas_sp._Proteobacteria:0.0651288182)100:0.1129293073)98:0.0445752282,OQW56345.1-Proteobacteria_bacterium_SG_bin9_Proteobacteria:0.1627514055)100:0.143031518,WP_136963313.1-Phreatobacter_stygius_Proteobacteria:0.3112306934)100:0.0917386658)67:0.0266595912,(((((((WP_136868902.1-Pseudomonas_bauzanensis_Proteobacteria:0.0070222852,EZQ18937.1-Pseudomonas_bauzanensis_Proteobacteria:2.5529e-06)100:0.1117169072,WP_185267007.1-Pseudomonas_xiamenensis_Proteobacteria:0.1297154818)100:0.155509858,WP_093476299.1-Pseudomonas_yangmingensis_Proteobacteria:0.2420063289)100:0.0524687662,(WP_108104178.1-Pseudomonas_mangrovi_Proteobacteria:0.1439069358,WP_017937932.1-Pseudomonas_thermotolerans_Proteobacteria:0.146369063)100:0.1327273239)100:0.1002360458,(((MAB24835.1-Pseudomonadales_bacterium_Proteobacteria:0.0190952035,WP_182248855.1-Pseudomonas_sp._5Ae-yellow_Proteobacteria:0.0166167239)100:0.1055173487,WP_083726556.1-Pseudomonas_pachastrellae_Proteobacteria:0.1003605968)100:0.1239403048,PKM29133.1-Gammaproteobacteria_bacterium_HGW-Gammaproteobacteria-11_Proteobacteria:0.1694559589)100:0.2031845527)100:0.1243949737,(WP_057659955.1-Pseudoxanthomonas_dokdonensis_Proteobacteria:0.2504443031,WP_077034059.1-Pelomonas_sp._KK5_Proteobacteria:0.290739419)100:0.089768806)99:0.0853947488,WP_151072822.1-Cupriavidus_oxalaticus_Proteobacteria:0.4488612335)77:0.038526075)94:0.0539909156,(WP_163259863.1-Caulobacter_sp._17J65-9_Proteobacteria:0.0359889329,WP_187448402.1-Caulobacter_sp._17J80-11_Proteobacteria:0.0560016928)100:0.4106137649)88:0.0483121127,WP_119419155.1-Rhodospirillaceae_bacterium_SYSU_D60015_Proteobacteria:0.5054381725)86:0.0421557676,((((((((WP_071072555.1-Cupriavidus_malaysiensis_Proteobacteria:2.4404e-06,WP_071038742.1-Cupriavidus_sp._USMAA2-4_Proteobacteria:0.0018049159)100:0.001807578,WP_071018820.1-Cupriavidus_sp._USMAHM13_Proteobacteria:2.614e-06)100:0.1086010247,WP_066731373.1-Cupriavidus_sp._D384_Proteobacteria:0.1244621502)99:0.0424841488,WP_116319445.1-Cupriavidus_sp._P-10_Proteobacteria:0.1027967862)100:0.0837115318,((((WP_025586346.1-Cupriavidus_taiwanensis_Proteobacteria:2.5529e-06,WP_116388232.1-Cupriavidus_taiwanensis_Proteobacteria:0.0036557088)100:0.0316799251,WP_116377884.1-Cupriavidus_taiwanensis_Proteobacteria:0.0302374199)99:0.0150639375,WP_062795892.1-Cupriavidus_nantongensis_Proteobacteria:0.0148732888)100:0.0624658383,WP_116320039.1-Cupriavidus_sp._P-10_Proteobacteria:0.0839847297)100:0.1462076246)100:0.1899307557,((WP_061999991.1-Burkholderia_sp._PAMC_28687_Proteobacteria:0.008725495,WP_062170184.1-Burkholderia_sp._PAMC_26561_Proteobacteria:0.0025040922)100:0.0260404307,WP_081889718.1-Caballeronia_sordidicola_Proteobacteria:0.0277042159)100:0.4391644299)99:0.0726843554,(PZW26129.1-Thermosporothrix_hazakensis_Chloroflexi:2.5529e-06,WP_111324427.1-Thermosporothrix_hazakensis_Chloroflexi:2.5529e-06)100:0.4278181864)100:0.0982174834,(((WP_183035411.1-Cupriavidus_sp._UME77_Proteobacteria:2.5529e-06,MBB1634382.1-Cupriavidus_sp._UME77_Proteobacteria:2.4494e-06)100:0.0121357022,WP_150987011.1-Cupriavidus_basilensis_Proteobacteria:0.006166255)100:0.1044846317,WP_092594144.1-Ralstonia_sp._25mfcol4.1_Proteobacteria:0.1855041654)100:0.3460007168)98:0.0688633008)83:0.0191555351);
2 |
--------------------------------------------------------------------------------
/phylogenetics/output/YOL164W_circle_tree.pdf:
--------------------------------------------------------------------------------
https://raw.githubusercontent.com/SysBioChalmers/HGTphyloDetect/d4ff8c5dbdaf3b200e45dd57962dfb11776f43d7/phylogenetics/output/YOL164W_circle_tree.pdf
--------------------------------------------------------------------------------
/phylogenetics/output/YOL164W_midpoint-color.txt:
--------------------------------------------------------------------------------
1 | DATASET_COLORSTRIP
2 | #In colored strip datasets, each ID is associated to a color box/strip and can have an optional label. Color can be specified in hexadecimal, RGB or RGBA notation. When using RGB or RGBA notation, you cannot use COMMA as the dataset separator
3 |
4 | #lines starting with a hash are comments and ignored during parsing
5 |
6 | #=================================================================#
7 | # MANDATORY SETTINGS #
8 | #=================================================================#
9 | #select the separator which is used to delimit the data below (TAB,SPACE or COMMA).This separator must be used throughout this file (except in the SEPARATOR line, which uses space).
10 |
11 | #SEPARATOR TAB
12 | #SEPARATOR COMMA
13 | SEPARATOR SPACE
14 |
15 | #label is used in the legend table (can be changed later)
16 | DATASET_LABEL Taxonomy
17 |
18 | #dataset color (can be changed later)
19 | COLOR #000000
20 |
21 | #=================================================================#
22 | # OPTIONAL SETTINGS #
23 | #=================================================================#
24 |
25 | #If COLOR_BRANCHES is set to 1, branches of the tree will be colored according to the colors of the strips above the leaves.
26 | #When all children of a node have the same color, it will be colored the same, ie. the color will propagate inwards towards the root.
27 | COLOR_BRANCHES 1
28 |
29 | #each dataset can have a legend, which is defined below
30 | #for each row in the legend, there should be one shape, color and label
31 | #shape should be a number between 1 and 5:
32 | #1: square
33 | #2: circle
34 | #3: star
35 | #4: right pointing triangle
36 | #5: left pointing triangle
37 |
38 | LEGEND_TITLE Taxonomy
39 | LEGEND_SHAPES 1 1 1 1
40 | LEGEND_COLORS #e31a1c #28b1aa #2D33E7 #969696
41 | LEGEND_LABELS Saccharomycotina Fungi Bacteria Other
42 | # LEGEND_SHAPES 1 1 1 1 1 1 1 1 1 1 1 1
43 | # LEGEND_COLORS #e31a1c #fb9a99 #ff7f00 #28b1aa #b15928 #6a3d9a #cab2d6 #1f78b4 #a6cee3 #33a02c #ffff99 #969696
44 | # LEGEND_LABELS Leotiomycetes Sordariomycetes Eurotiomycetes Dothideomycetes other_Pezizomycotina other_Ascomycota other_Fungi other_Opisthokonta other_Eukaryota Bacteria Archaea Viruses
45 |
46 | #=================================================================#
47 | # all other optional settings can be set or changed later #
48 | # in the web interface (under 'Datasets' tab) #
49 | #=================================================================#
50 |
51 | #width of the colored strip
52 | STRIP_WIDTH 35
53 |
54 | #left margin, used to increase/decrease the spacing to the next dataset. Can be negative, causing datasets to overlap.
55 | #MARGIN 5
56 |
57 | #border width; if set above 0, a border of specified width (in pixels) will be drawn around the color strip
58 | #BORDER_WIDTH 2
59 |
60 | #border color; used when BORDER_WIDTH is above 0
61 | #BORDER_COLOR #969696
62 |
63 | #always show internal values; if set, values associated to internal nodes will be displayed even if these nodes are not collapsed. It could cause overlapping in the dataset display.
64 | #SHOW_INTERNAL 1
65 |
66 | #Internal tree nodes can be specified using IDs directly, or using the 'last common ancestor' method described in iTOL help pages
67 |
68 | #=================================================================#
69 | # Actual data follows after the DATA keyword #
70 | #=================================================================#
71 | DATA
72 |
73 | #Examples:
74 | #assign a red colored strip to leaf 9606, with label 'Human' (label is displayed in the mouseover popups)
75 | #9606 #ff0000 Human
76 |
77 | #assign a green, semi-transparent (alpha 0.5) strip to an internal node, without any label. If 'Show internal values' is set to 'No', this will only be displayed if the node is collapsed.
78 | #9606|5664 rgba(0,255,0,0.5)
79 | WP_061021165.1-Bradyrhizobium_sp._CCH5-F6_Proteobacteria #2D33E7 Bacteria
80 | GAJ33771.1-Bradyrhizobium_sp._DOA9_Proteobacteria #2D33E7 Bacteria
81 | WP_035674808.1-Bradyrhizobium_liaoningense_Proteobacteria #2D33E7 Bacteria
82 | WP_028179375.1-Bradyrhizobium_japonicum_Proteobacteria #2D33E7 Bacteria
83 | WP_061878281.1-Bradyrhizobium_liaoningense_Proteobacteria #2D33E7 Bacteria
84 | WP_158669522.1-Bradyrhizobium_guangdongense_Proteobacteria #2D33E7 Bacteria
85 | WP_035715237.1-Bradyrhizobium_sp._CCBAU_43298_Proteobacteria #2D33E7 Bacteria
86 | WP_100175831.1-Bradyrhizobium_nitroreducens_Proteobacteria #2D33E7 Bacteria
87 | WP_142250055.1-Bradyrhizobium_sp._UNPF46_Proteobacteria #2D33E7 Bacteria
88 | RTM13090.1-Bradyrhizobiaceae_bacterium_Proteobacteria #2D33E7 Bacteria
89 | WP_128939625.1-Bradyrhizobium_zhanjiangense_Proteobacteria #2D33E7 Bacteria
90 | WP_128955323.1-Bradyrhizobium_zhanjiangense_Proteobacteria #2D33E7 Bacteria
91 | WP_183258594.1-Bradyrhizobium_sp._CIR48_Proteobacteria #2D33E7 Bacteria
92 | WP_183231495.1-Bradyrhizobium_sp._SBR1B_Proteobacteria #2D33E7 Bacteria
93 | WP_092259760.1-Bradyrhizobium_sp._Rc3b_Proteobacteria #2D33E7 Bacteria
94 | WP_018322728.1-Bradyrhizobium_sp._WSM2793_Proteobacteria #2D33E7 Bacteria
95 | WP_183237909.1-Bradyrhizobium_sp._CIR18_Proteobacteria #2D33E7 Bacteria
96 | WP_152103320.1-Bradyrhizobium_sp._TM102_Proteobacteria #2D33E7 Bacteria
97 | WP_091965654.1-Bradyrhizobium_shewense_Proteobacteria #2D33E7 Bacteria
98 | WP_104462928.1-Bradyrhizobium_sp._AC87j1_Proteobacteria #2D33E7 Bacteria
99 | WP_135167913.1-Bradyrhizobium_frederickii_Proteobacteria #2D33E7 Bacteria
100 | WP_126256569.1-Bradyrhizobium_sp._LVM_105_Proteobacteria #2D33E7 Bacteria
101 | WP_135162274.1-Bradyrhizobium_frederickii_Proteobacteria #2D33E7 Bacteria
102 | WP_028135100.1-Bradyrhizobium_japonicum_Proteobacteria #2D33E7 Bacteria
103 | WP_151642895.1-Bradyrhizobium_betae_Proteobacteria #2D33E7 Bacteria
104 | WP_015687718.1-Bradyrhizobium_cosmicum_Proteobacteria #2D33E7 Bacteria
105 | WP_145664020.1-Bradyrhizobium_stylosanthis_Proteobacteria #2D33E7 Bacteria
106 | WP_063691485.1-Bradyrhizobium_stylosanthis_Proteobacteria #2D33E7 Bacteria
107 | WP_007594037.1-Bradyrhizobium_sp._WSM1253_Proteobacteria #2D33E7 Bacteria
108 | WP_027516639.1-Bradyrhizobium_sp._WSM1417_Proteobacteria #2D33E7 Bacteria
109 | WP_027568791.1-Bradyrhizobium_sp._URHA0013_Proteobacteria #2D33E7 Bacteria
110 | WP_085395770.1-Bradyrhizobium_canariense_Proteobacteria #2D33E7 Bacteria
111 | WP_085352090.1-Bradyrhizobium_canariense_Proteobacteria #2D33E7 Bacteria
112 | WP_063993269.1-Bradyrhizobium_sp._Proteobacteria #2D33E7 Bacteria
113 | WP_018457146.1-Bradyrhizobium_sp._WSM4349_Proteobacteria #2D33E7 Bacteria
114 | WP_106942729.1-Bradyrhizobium_sp._MOS002_Proteobacteria #2D33E7 Bacteria
115 | WP_011085536.1-Bradyrhizobium_diazoefficiens_Proteobacteria #2D33E7 Bacteria
116 | WP_038965832.1-Bradyrhizobium_diazoefficiens_Proteobacteria #2D33E7 Bacteria
117 | WP_182869822.1-Bradyrhizobium_diazoefficiens_Proteobacteria #2D33E7 Bacteria
118 | QHP72204.1-Bradyrhizobium_sp._LCT2_Proteobacteria #2D33E7 Bacteria
119 | WP_161535945.1-Bradyrhizobium_sp._LCT2_Proteobacteria #2D33E7 Bacteria
120 | WP_060912981.1-Bradyrhizobium_diazoefficiens_Proteobacteria #2D33E7 Bacteria
121 | BAR59885.1-Bradyrhizobium_diazoefficiens_Proteobacteria #2D33E7 Bacteria
122 | KGJ68294.1-Bradyrhizobium_diazoefficiens_Proteobacteria #2D33E7 Bacteria
123 | WP_028174753.1-Bradyrhizobium_diazoefficiens_Proteobacteria #2D33E7 Bacteria
124 | WP_148744709.1-Bradyrhizobium_hipponense_Proteobacteria #2D33E7 Bacteria
125 | WP_128961978.1-Bradyrhizobium_guangzhouense_Proteobacteria #2D33E7 Bacteria
126 | WP_128953098.1-Bradyrhizobium_guangzhouense_Proteobacteria #2D33E7 Bacteria
127 | WP_057753835.1-Bradyrhizobium_manausense_Proteobacteria #2D33E7 Bacteria
128 | MBC9878718.1-Bradyrhizobium_campsiandrae_Proteobacteria #2D33E7 Bacteria
129 | WP_092295676.1-Bradyrhizobium_sp._Ghvi_Proteobacteria #2D33E7 Bacteria
130 | WP_128967591.1-Bradyrhizobium_guangdongense_Proteobacteria #2D33E7 Bacteria
131 | WP_027528936.1-Bradyrhizobium_sp._WSM3983_Proteobacteria #2D33E7 Bacteria
132 | WP_148775460.1-Bradyrhizobium_rifense_Proteobacteria #2D33E7 Bacteria
133 | WP_148749019.1-Bradyrhizobium_cytisi_Proteobacteria #2D33E7 Bacteria
134 | WP_008138438.1-Bradyrhizobium_sp._YR681_Proteobacteria #2D33E7 Bacteria
135 | WP_129271949.1-Bradyrhizobium_betae_Proteobacteria #2D33E7 Bacteria
136 | WP_092029312.1-Bradyrhizobium_sp._OK095_Proteobacteria #2D33E7 Bacteria
137 | WP_092214970.1-Bradyrhizobium_arachidis_Proteobacteria #2D33E7 Bacteria
138 | WP_084803943.1-Bradyrhizobium_sp._NAS80.1_Proteobacteria #2D33E7 Bacteria
139 | WP_074117602.1-Bradyrhizobium_sp._AS23.2_Proteobacteria #2D33E7 Bacteria
140 | WP_071915975.1-Bradyrhizobium_japonicum_Proteobacteria #2D33E7 Bacteria
141 | WP_063984832.1-Bradyrhizobium_sp._Proteobacteria #2D33E7 Bacteria
142 | WP_166089364.1-Bradyrhizobium_sp._1S5_Proteobacteria #2D33E7 Bacteria
143 | WP_166350707.1-Bradyrhizobium_sp._323S2_Proteobacteria #2D33E7 Bacteria
144 | WP_038931390.1-Bradyrhizobium_japonicum_Proteobacteria #2D33E7 Bacteria
145 | WP_039157276.1-Bradyrhizobium_japonicum_Proteobacteria #2D33E7 Bacteria
146 | WP_028156991.1-Bradyrhizobium_japonicum_Proteobacteria #2D33E7 Bacteria
147 | WP_041955910.1-Bradyrhizobium_japonicum_Proteobacteria #2D33E7 Bacteria
148 | WP_063680948.1-Bradyrhizobium_neotropicale_Proteobacteria #2D33E7 Bacteria
149 | WP_027550185.1-Bradyrhizobium_sp._Cp5.3_Proteobacteria #2D33E7 Bacteria
150 | WP_063705824.1-Bradyrhizobium_centrolobii_Proteobacteria #2D33E7 Bacteria
151 | WP_027526029.1-Bradyrhizobium_sp._Ec3.3_Proteobacteria #2D33E7 Bacteria
152 | WP_140980779.1-Bradyrhizobium_guangdongense_Proteobacteria #2D33E7 Bacteria
153 | WP_028347371.1-Bradyrhizobium_murdochi_Proteobacteria #2D33E7 Bacteria
154 | WP_057843198.1-Bradyrhizobium_retamae_Proteobacteria #2D33E7 Bacteria
155 | WP_065748757.1-Bradyrhizobium_sp._LMTR_3_Proteobacteria #2D33E7 Bacteria
156 | WP_171577827.1-Bradyrhizobium_australiense_Proteobacteria #2D33E7 Bacteria
157 | WP_065730813.1-Bradyrhizobium_icense_Proteobacteria #2D33E7 Bacteria
158 | WP_065756637.1-Bradyrhizobium_paxllaeri_Proteobacteria #2D33E7 Bacteria
159 | WP_057859318.1-Bradyrhizobium_lablabi_Proteobacteria #2D33E7 Bacteria
160 | WP_161852777.1-Bradyrhizobium_sp._CCBAU_051011_Proteobacteria #2D33E7 Bacteria
161 | WP_057833547.1-Bradyrhizobium_jicamae_Proteobacteria #2D33E7 Bacteria
162 | WP_108514566.1-Bradyrhizobium_algeriense_Proteobacteria #2D33E7 Bacteria
163 | WP_057900995.1-Bradyrhizobium_valentinum_Proteobacteria #2D33E7 Bacteria
164 | WP_057851642.1-Bradyrhizobium_valentinum_Proteobacteria #2D33E7 Bacteria
165 | WP_092515866.1-Afipia_sp._GAS231_Proteobacteria #2D33E7 Bacteria
166 | SDP08864.1-Afipia_sp._GAS231_Proteobacteria #2D33E7 Bacteria
167 | WP_155805222.1-Bradyrhizobium_sp._URHA0002_Proteobacteria #2D33E7 Bacteria
168 | WP_079586579.1-Bradyrhizobium_lablabi_Proteobacteria #2D33E7 Bacteria
169 | TKW79521.1-Bradyrhizobium_icense_Proteobacteria #2D33E7 Bacteria
170 | WP_100419024.1-Bradyrhizobium_lablabi_Proteobacteria #2D33E7 Bacteria
171 | WP_143206068.1-Bradyrhizobium_erythrophlei_Proteobacteria #2D33E7 Bacteria
172 | MBA2399293.1-Bradyrhizobium_sp._Proteobacteria #2D33E7 Bacteria
173 | MBA4036164.1-Bradyrhizobium_sp._Proteobacteria #2D33E7 Bacteria
174 | WP_069276965.1-Bradyrhizobium_elkanii_Proteobacteria #2D33E7 Bacteria
175 | WP_130580234.1-Bradyrhizobium_sp._Leo170_Proteobacteria #2D33E7 Bacteria
176 | WP_130222300.1-Bradyrhizobium_sp._Leo121_Proteobacteria #2D33E7 Bacteria
177 | WP_100380578.1-Afipia_broomeae_Proteobacteria #2D33E7 Bacteria
178 | WP_146687675.1-Bradyrhizobium_canariense_Proteobacteria #2D33E7 Bacteria
179 | TMK06221.1-Alphaproteobacteria_bacterium_Proteobacteria #2D33E7 Bacteria
180 | THD60673.1-Bradyrhizobium_sp._Proteobacteria #2D33E7 Bacteria
181 | WP_079601315.1-Bradyrhizobium_erythrophlei_Proteobacteria #2D33E7 Bacteria
182 | WP_079544782.1-Bradyrhizobium_lablabi_Proteobacteria #2D33E7 Bacteria
183 | WP_024518537.1-Bradyrhizobium_sp._Tv2a-2_Proteobacteria #2D33E7 Bacteria
184 | WP_024511517.1-Bradyrhizobium_sp._ARR65_Proteobacteria #2D33E7 Bacteria
185 | TMJ47098.1-Alphaproteobacteria_bacterium_Proteobacteria #2D33E7 Bacteria
186 | TMK39387.1-Alphaproteobacteria_bacterium_Proteobacteria #2D33E7 Bacteria
187 | WP_172134110.1-Bradyrhizobium_sp._81013_Proteobacteria #2D33E7 Bacteria
188 | WP_172111906.1-Bradyrhizobium_sp._83012_Proteobacteria #2D33E7 Bacteria
189 | WP_172180802.1-Bradyrhizobium_sp._83002_Proteobacteria #2D33E7 Bacteria
190 | WP_083842450.1-Bradyrhizobium_sp._ORS_375_Proteobacteria #2D33E7 Bacteria
191 | WP_035655465.1-Bradyrhizobium_sp._STM_3809_Proteobacteria #2D33E7 Bacteria
192 | CCD98599.1-Bradyrhizobium_sp._STM_3809_Proteobacteria #2D33E7 Bacteria
193 | WP_168167890.1-Bradyrhizobium_sp._BTAi1_Proteobacteria #2D33E7 Bacteria
194 | NVN85223.1-Rhodopseudomonas_sp._Proteobacteria #2D33E7 Bacteria
195 | WP_011439962.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
196 | EGP08750.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria #2D33E7 Bacteria
197 | WP_043924226.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria #2D33E7 Bacteria
198 | WP_002714592.1-Afipia_clevelandensis_Proteobacteria #2D33E7 Bacteria
199 | WP_046828790.1-Afipia_massiliensis_Proteobacteria #2D33E7 Bacteria
200 | WP_076861029.1-Bradyrhizobium_mercantei_Proteobacteria #2D33E7 Bacteria
201 | OJY09878.1-Rhizobiales_bacterium_62-47_Proteobacteria #2D33E7 Bacteria
202 | PYN74367.1-Candidatus_Rokubacteria_bacterium_Candidatus #969696 Other
203 | PYM96198.1-Candidatus_Rokubacteria_bacterium_Candidatus #969696 Other
204 | OGL20369.1-Candidatus_Rokubacteria_bacterium_RIFCSPLOWO2_12_FULL_71_22_Candidatus #969696 Other
205 | PYN46404.1-Candidatus_Rokubacteria_bacterium_Candidatus #969696 Other
206 | PYN32128.1-Candidatus_Rokubacteria_bacterium_Candidatus #969696 Other
207 | WP_089945766.1-Candidatus_Entotheonella_palauensis_Candidatus #969696 Other
208 | WP_089717141.1-Candidatus_Entotheonella_palauensis_Candidatus #969696 Other
209 | KAB2911669.1-Hyphomicrobiaceae_bacterium_Proteobacteria #2D33E7 Bacteria
210 | WP_027475679.1-Curvibacter_gracilis_Proteobacteria #2D33E7 Bacteria
211 | WP_157443435.1-Curvibacter_lanceolatus_Proteobacteria #2D33E7 Bacteria
212 | RUP23521.1-Curvibacter_sp._Proteobacteria #2D33E7 Bacteria
213 | GBU15266.1-Polaromonas_sp._Proteobacteria #2D33E7 Bacteria
214 | WP_155709830.1-Massilia_dura_Proteobacteria #2D33E7 Bacteria
215 | RZL87373.1-Variovorax_sp._Proteobacteria #2D33E7 Bacteria
216 | WP_145759386.1-Variovorax_sp._1180_Proteobacteria #2D33E7 Bacteria
217 | WP_126183471.1-Variovorax_sp._369_Proteobacteria #2D33E7 Bacteria
218 | WP_020722993.1-Variovorax_paradoxus_Proteobacteria #2D33E7 Bacteria
219 | WP_184605932.1-Variovorax_sp._BK613_Proteobacteria #2D33E7 Bacteria
220 | WP_132801781.1-Variovorax_sp._BK370_Proteobacteria #2D33E7 Bacteria
221 | WP_132755990.1-Variovorax_sp._BK151_Proteobacteria #2D33E7 Bacteria
222 | WP_176665552.1-Variovorax_sp._SG517_Proteobacteria #2D33E7 Bacteria
223 | WP_184638849.1-Variovorax_guangxiensis_Proteobacteria #2D33E7 Bacteria
224 | WP_126020505.1-Variovorax_guangxiensis_Proteobacteria #2D33E7 Bacteria
225 | WP_093195641.1-Variovorax_sp._YR750_Proteobacteria #2D33E7 Bacteria
226 | WP_126472589.1-Variovorax_gossypii_Proteobacteria #2D33E7 Bacteria
227 | WP_097197469.1-Variovorax_sp._YR752_Proteobacteria #2D33E7 Bacteria
228 | WP_093174861.1-Variovorax_sp._YR266_Proteobacteria #2D33E7 Bacteria
229 | WP_093076613.1-Variovorax_sp._OV084_Proteobacteria #2D33E7 Bacteria
230 | WP_093057006.1-Variovorax_sp._YR634_Proteobacteria #2D33E7 Bacteria
231 | WP_130421160.1-Variovorax_sp._BK460_Proteobacteria #2D33E7 Bacteria
232 | WP_093131647.1-Variovorax_sp._OK605_Proteobacteria #2D33E7 Bacteria
233 | WP_007837899.1-Variovorax_sp._CF313_Proteobacteria #2D33E7 Bacteria
234 | WP_081267376.1-Variovorax_paradoxus_Proteobacteria #2D33E7 Bacteria
235 | ODU15846.1-Variovorax_sp._SCN_67-85_Proteobacteria #2D33E7 Bacteria
236 | WP_172705422.1-Variovorax_paradoxus_Proteobacteria #2D33E7 Bacteria
237 | KPU98577.1-Variovorax_paradoxus_Proteobacteria #2D33E7 Bacteria
238 | MBS76598.1-Variovorax_sp._Proteobacteria #2D33E7 Bacteria
239 | WP_093343818.1-Variovorax_sp._PDC80_Proteobacteria #2D33E7 Bacteria
240 | KAF1061273.1-Variovorax_sp._Proteobacteria #2D33E7 Bacteria
241 | TAJ61793.1-Variovorax_sp._Proteobacteria #2D33E7 Bacteria
242 | WP_093435402.1-Variovorax_sp._770b2_Proteobacteria #2D33E7 Bacteria
243 | WP_052810747.1-Variovorax_paradoxus_Proteobacteria #2D33E7 Bacteria
244 | WP_013538622.1-Variovorax_paradoxus_Proteobacteria #2D33E7 Bacteria
245 | WP_176660984.1-Variovorax_sp._SG533_Proteobacteria #2D33E7 Bacteria
246 | WP_145738683.1-Variovorax_beijingensis_Proteobacteria #2D33E7 Bacteria
247 | WP_062470459.1-Variovorax_boronicumulans_Proteobacteria #2D33E7 Bacteria
248 | WP_095948515.1-Variovorax_boronicumulans_Proteobacteria #2D33E7 Bacteria
249 | WP_159278964.1-Variovorax_boronicumulans_Proteobacteria #2D33E7 Bacteria
250 | WP_159274326.1-Variovorax_boronicumulans_Proteobacteria #2D33E7 Bacteria
251 | WP_070061350.1-Variovorax_boronicumulans_Proteobacteria #2D33E7 Bacteria
252 | WP_095743122.1-Variovorax_boronicumulans_Proteobacteria #2D33E7 Bacteria
253 | WP_139703542.1-Variovorax_sp._KBS0712_Proteobacteria #2D33E7 Bacteria
254 | WP_099794476.1-Variovorax_sp._54_Proteobacteria #2D33E7 Bacteria
255 | WP_101490554.1-Variovorax_sp._RO1_Proteobacteria #2D33E7 Bacteria
256 | WP_153281245.1-Variovorax_paradoxus_Proteobacteria #2D33E7 Bacteria
257 | WP_056574498.1-Variovorax_sp._Root473_Proteobacteria #2D33E7 Bacteria
258 | WP_119556153.1-Acidovorax_cavernicola_Proteobacteria #2D33E7 Bacteria
259 | WP_093241869.1-Variovorax_sp._EL159_Proteobacteria #2D33E7 Bacteria
260 | WP_187113215.1-Variovorax_sp._PAMC26660_Proteobacteria #2D33E7 Bacteria
261 | WP_124458460.1-Variovorax_sp._KBW07_Proteobacteria #2D33E7 Bacteria
262 | QLG72306.1-Zygotorulaspora_mrakii_Saccharomycotina #e31a1c Saccharomycotina
263 | QUERY_Saccharomyces_cerevisiae_YOL164W #e31a1c Saccharomycotina
264 | XP_002555886.1-Lachancea_thermotolerans_Saccharomycotina #e31a1c Saccharomycotina
265 | SCW03834.1-Lachancea_fermentati_Saccharomycotina #e31a1c Saccharomycotina
266 | XP_018221989.1-Saccharomyces_eubayanus_Saccharomycotina #e31a1c Saccharomycotina
267 | QID88192.1-Saccharomyces_pastorianus_Saccharomycotina #e31a1c Saccharomycotina
268 | WP_092831606.1-Rhodospirillales_bacterium_URHD0017_Proteobacteria #2D33E7 Bacteria
269 | MBB5054515.1-Afipia_massiliensis_Proteobacteria #2D33E7 Bacteria
270 | WP_184089169.1-Afipia_massiliensis_Proteobacteria #2D33E7 Bacteria
271 | WP_046827511.1-Afipia_massiliensis_Proteobacteria #2D33E7 Bacteria
272 | WP_062313220.1-Bradyrhizobium_sp._CCH10-C7_Proteobacteria #2D33E7 Bacteria
273 | HBR43714.1-Afipia_sp._Proteobacteria #2D33E7 Bacteria
274 | HAQ93654.1-Afipia_sp._Proteobacteria #2D33E7 Bacteria
275 | WP_006021976.1-Afipia_broomeae_Proteobacteria #2D33E7 Bacteria
276 | RTL81632.1-Bradyrhizobiaceae_bacterium_Proteobacteria #2D33E7 Bacteria
277 | TXJ10197.1-Afipia_sp._Proteobacteria #2D33E7 Bacteria
278 | WP_002713184.1-Afipia_clevelandensis_Proteobacteria #2D33E7 Bacteria
279 | WP_009734135.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria #2D33E7 Bacteria
280 | NGX94573.1-Candidatus_Afipia_apatlaquensis_Proteobacteria #2D33E7 Bacteria
281 | WP_175367589.1-Tardiphaga_robiniae_Proteobacteria #2D33E7 Bacteria
282 | WP_120288614.1-Tardiphaga_sp._YR296_Proteobacteria #2D33E7 Bacteria
283 | WP_184513838.1-Tardiphaga_robiniae_Proteobacteria #2D33E7 Bacteria
284 | WP_089261759.1-Tardiphaga_sp._OK246_Proteobacteria #2D33E7 Bacteria
285 | WP_092138970.1-Bradyrhizobium_sp._NFR13_Proteobacteria #2D33E7 Bacteria
286 | WP_115033941.1-Tardiphaga_sp._CF115_Proteobacteria #2D33E7 Bacteria
287 | WP_149531854.1-Tardiphaga_sp._P9-11_Proteobacteria #2D33E7 Bacteria
288 | OJY11205.1-Rhizobiales_bacterium_62-47_Proteobacteria #2D33E7 Bacteria
289 | WP_146690165.1-Bradyrhizobium_canariense_Proteobacteria #2D33E7 Bacteria
290 | WP_100386102.1-Afipia_broomeae_Proteobacteria #2D33E7 Bacteria
291 | WP_008968903.1-Bradyrhizobium_sp._STM_3843_Proteobacteria #2D33E7 Bacteria
292 | WP_164571151.1-Rhodopseudomonas_sp._BR0C11_Proteobacteria #2D33E7 Bacteria
293 | WP_107345917.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
294 | WP_164638651.1-Rhodopseudomonas_sp._BR0G17_Proteobacteria #2D33E7 Bacteria
295 | WP_107356882.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
296 | WP_011159875.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
297 | WP_012497548.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
298 | WP_119019080.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
299 | WP_013504207.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
300 | WP_047308756.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
301 | WP_164630935.1-Rhodopseudomonas_sp._WA056_Proteobacteria #2D33E7 Bacteria
302 | WP_119858943.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
303 | WP_142883484.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
304 | WP_022722993.1-Rhodopseudomonas_sp._B29_Proteobacteria #2D33E7 Bacteria
305 | WP_054162298.1-Rhodopseudomonas_sp._AAP120_Proteobacteria #2D33E7 Bacteria
306 | WP_110782500.1-Rhodopseudomonas_faecalis_Proteobacteria #2D33E7 Bacteria
307 | WP_027276359.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
308 | TAH64925.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
309 | WP_011665574.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
310 | ABD08837.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
311 | WP_041798938.1-Rhodopseudomonas_palustris_Proteobacteria #2D33E7 Bacteria
312 | NVN87899.1-Rhodopseudomonas_sp._Proteobacteria #2D33E7 Bacteria
313 | OQW56345.1-Proteobacteria_bacterium_SG_bin9_Proteobacteria #2D33E7 Bacteria
314 | WP_136963313.1-Phreatobacter_stygius_Proteobacteria #2D33E7 Bacteria
315 | WP_136868902.1-Pseudomonas_bauzanensis_Proteobacteria #2D33E7 Bacteria
316 | EZQ18937.1-Pseudomonas_bauzanensis_Proteobacteria #2D33E7 Bacteria
317 | WP_185267007.1-Pseudomonas_xiamenensis_Proteobacteria #2D33E7 Bacteria
318 | WP_093476299.1-Pseudomonas_yangmingensis_Proteobacteria #2D33E7 Bacteria
319 | WP_108104178.1-Pseudomonas_mangrovi_Proteobacteria #2D33E7 Bacteria
320 | WP_017937932.1-Pseudomonas_thermotolerans_Proteobacteria #2D33E7 Bacteria
321 | MAB24835.1-Pseudomonadales_bacterium_Proteobacteria #2D33E7 Bacteria
322 | WP_182248855.1-Pseudomonas_sp._5Ae-yellow_Proteobacteria #2D33E7 Bacteria
323 | WP_083726556.1-Pseudomonas_pachastrellae_Proteobacteria #2D33E7 Bacteria
324 | PKM29133.1-Gammaproteobacteria_bacterium_HGW-Gammaproteobacteria-11_Proteobacteria #2D33E7 Bacteria
325 | WP_057659955.1-Pseudoxanthomonas_dokdonensis_Proteobacteria #2D33E7 Bacteria
326 | WP_077034059.1-Pelomonas_sp._KK5_Proteobacteria #2D33E7 Bacteria
327 | WP_151072822.1-Cupriavidus_oxalaticus_Proteobacteria #2D33E7 Bacteria
328 | WP_163259863.1-Caulobacter_sp._17J65-9_Proteobacteria #2D33E7 Bacteria
329 | WP_187448402.1-Caulobacter_sp._17J80-11_Proteobacteria #2D33E7 Bacteria
330 | WP_119419155.1-Rhodospirillaceae_bacterium_SYSU_D60015_Proteobacteria #2D33E7 Bacteria
331 | WP_071072555.1-Cupriavidus_malaysiensis_Proteobacteria #2D33E7 Bacteria
332 | WP_071038742.1-Cupriavidus_sp._USMAA2-4_Proteobacteria #2D33E7 Bacteria
333 | WP_071018820.1-Cupriavidus_sp._USMAHM13_Proteobacteria #2D33E7 Bacteria
334 | WP_066731373.1-Cupriavidus_sp._D384_Proteobacteria #2D33E7 Bacteria
335 | WP_116319445.1-Cupriavidus_sp._P-10_Proteobacteria #2D33E7 Bacteria
336 | WP_025586346.1-Cupriavidus_taiwanensis_Proteobacteria #2D33E7 Bacteria
337 | WP_116388232.1-Cupriavidus_taiwanensis_Proteobacteria #2D33E7 Bacteria
338 | WP_116377884.1-Cupriavidus_taiwanensis_Proteobacteria #2D33E7 Bacteria
339 | WP_062795892.1-Cupriavidus_nantongensis_Proteobacteria #2D33E7 Bacteria
340 | WP_116320039.1-Cupriavidus_sp._P-10_Proteobacteria #2D33E7 Bacteria
341 | WP_061999991.1-Burkholderia_sp._PAMC_28687_Proteobacteria #2D33E7 Bacteria
342 | WP_062170184.1-Burkholderia_sp._PAMC_26561_Proteobacteria #2D33E7 Bacteria
343 | WP_081889718.1-Caballeronia_sordidicola_Proteobacteria #2D33E7 Bacteria
344 | PZW26129.1-Thermosporothrix_hazakensis_Chloroflexi #2D33E7 Bacteria
345 | WP_111324427.1-Thermosporothrix_hazakensis_Chloroflexi #2D33E7 Bacteria
346 | WP_183035411.1-Cupriavidus_sp._UME77_Proteobacteria #2D33E7 Bacteria
347 | MBB1634382.1-Cupriavidus_sp._UME77_Proteobacteria #2D33E7 Bacteria
348 | WP_150987011.1-Cupriavidus_basilensis_Proteobacteria #2D33E7 Bacteria
349 | WP_092594144.1-Ralstonia_sp._25mfcol4.1_Proteobacteria #2D33E7 Bacteria
350 |
--------------------------------------------------------------------------------
/phylogenetics/output/YOL164W_midpoint.tree:
--------------------------------------------------------------------------------
1 | (((((((((((((((((((((((((((((((WP_061021165.1-Bradyrhizobium_sp._CCH5-F6_Proteobacteria:0.0125745769,GAJ33771.1-Bradyrhizobium_sp._DOA9_Proteobacteria:0.0508912984)72:0.0057388355,(WP_035674808.1-Bradyrhizobium_liaoningense_Proteobacteria:2.2155e-06,WP_028179375.1-Bradyrhizobium_japonicum_Proteobacteria:0.0017797377)100:0.0179304412)100:0.0078690472,WP_061878281.1-Bradyrhizobium_liaoningense_Proteobacteria:0.0199479778)97:0.0122683098,(WP_158669522.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0066286662,WP_035715237.1-Bradyrhizobium_sp._CCBAU_43298_Proteobacteria:0.0082831082)100:0.0374301231)97:0.0042958524,((WP_100175831.1-Bradyrhizobium_nitroreducens_Proteobacteria:0.0018063311,WP_142250055.1-Bradyrhizobium_sp._UNPF46_Proteobacteria:2.8028e-06)100:0.0127794736,RTM13090.1-Bradyrhizobiaceae_bacterium_Proteobacteria:0.0262086825)95:0.0130149)53:0.0017468173,(WP_128939625.1-Bradyrhizobium_zhanjiangense_Proteobacteria:0.0054097422,WP_128955323.1-Bradyrhizobium_zhanjiangense_Proteobacteria:0.0053458512)100:0.049367831)78:0.0057988703,((((((WP_183258594.1-Bradyrhizobium_sp._CIR48_Proteobacteria:2.5529e-06,WP_183231495.1-Bradyrhizobium_sp._SBR1B_Proteobacteria:0.0017861289)60:2.5357e-06,WP_092259760.1-Bradyrhizobium_sp._Rc3b_Proteobacteria:0.0017882982)100:0.0125735681,WP_018322728.1-Bradyrhizobium_sp._WSM2793_Proteobacteria:0.0018858093)82:0.0036214222,WP_183237909.1-Bradyrhizobium_sp._CIR18_Proteobacteria:0.0019159112)100:0.0114585433,WP_152103320.1-Bradyrhizobium_sp._TM102_Proteobacteria:0.0195235625)98:0.0018180517,(WP_091965654.1-Bradyrhizobium_shewense_Proteobacteria:0.0072224938,WP_104462928.1-Bradyrhizobium_sp._AC87j1_Proteobacteria:0.009069658)99:0.0083892132)86:0.0041309862)73:0.0020372151,(((WP_135167913.1-Bradyrhizobium_frederickii_Proteobacteria:2.5529e-06,WP_126256569.1-Bradyrhizobium_sp._LVM_105_Proteobacteria:0.0018064077)100:0.0162631319,WP_135162274.1-Bradyrhizobium_frederickii_Proteobacteria:0.0227703366)34:0.0030593777,WP_028135100.1-Bradyrhizobium_japonicum_Proteobacteria:0.0374352864)93:0.0101627351)30:0.0050541709,(WP_151642895.1-Bradyrhizobium_betae_Proteobacteria:0.0144774369,WP_015687718.1-Bradyrhizobium_cosmicum_Proteobacteria:0.0217250045)100:0.0085910137)42:0.0071084918,(WP_145664020.1-Bradyrhizobium_stylosanthis_Proteobacteria:0.0098409043,WP_063691485.1-Bradyrhizobium_stylosanthis_Proteobacteria:0.0048258408)100:0.0314832002)83:0.0025209961,(((((WP_007594037.1-Bradyrhizobium_sp._WSM1253_Proteobacteria:0.0166251524,WP_027516639.1-Bradyrhizobium_sp._WSM1417_Proteobacteria:0.0086777562)100:0.0053207306,WP_027568791.1-Bradyrhizobium_sp._URHA0013_Proteobacteria:0.0177663228)90:0.0021525708,((WP_085395770.1-Bradyrhizobium_canariense_Proteobacteria:0.0017816263,WP_085352090.1-Bradyrhizobium_canariense_Proteobacteria:2.5529e-06)100:0.0108947434,WP_063993269.1-Bradyrhizobium_sp._Proteobacteria:0.0163270933)74:0.0018358254)75:0.00359359,WP_018457146.1-Bradyrhizobium_sp._WSM4349_Proteobacteria:0.0110766552)97:0.0054074038,WP_106942729.1-Bradyrhizobium_sp._MOS002_Proteobacteria:0.0179900111)100:0.0164018318)65:0.0060738807,(((((WP_011085536.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.5529e-06,WP_038965832.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.0678e-06)61:2.7037e-06,WP_182869822.1-Bradyrhizobium_diazoefficiens_Proteobacteria:0.0036093652)100:0.0073149382,(QHP72204.1-Bradyrhizobium_sp._LCT2_Proteobacteria:2.3416e-06,WP_161535945.1-Bradyrhizobium_sp._LCT2_Proteobacteria:2.3124e-06)99:0.0018085972)100:0.0018381733,((WP_060912981.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.5529e-06,BAR59885.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.5529e-06)100:0.0018143049,(KGJ68294.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.5529e-06,WP_028174753.1-Bradyrhizobium_diazoefficiens_Proteobacteria:2.5529e-06)100:0.0018168824)100:0.00361019)100:0.0190720633,WP_148744709.1-Bradyrhizobium_hipponense_Proteobacteria:0.0581515546)38:0.0045507008)37:0.0047666318,((((((WP_128961978.1-Bradyrhizobium_guangzhouense_Proteobacteria:0.0026345468,WP_128953098.1-Bradyrhizobium_guangzhouense_Proteobacteria:0.0065109029)100:0.0157546955,WP_057753835.1-Bradyrhizobium_manausense_Proteobacteria:0.0340958176)95:0.0076722371,MBC9878718.1-Bradyrhizobium_campsiandrae_Proteobacteria:0.031291375)52:0.0018945738,(WP_092295676.1-Bradyrhizobium_sp._Ghvi_Proteobacteria:0.0098555247,WP_128967591.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0238608958)91:0.0036217164)100:0.0100196952,(WP_027528936.1-Bradyrhizobium_sp._WSM3983_Proteobacteria:0.0485879635,WP_148775460.1-Bradyrhizobium_rifense_Proteobacteria:0.0183509323)95:0.0058442356)66:0.0037800916,WP_148749019.1-Bradyrhizobium_cytisi_Proteobacteria:0.0178881925)100:0.0154749267)24:0.0028471437,(((WP_008138438.1-Bradyrhizobium_sp._YR681_Proteobacteria:0.0194807595,WP_129271949.1-Bradyrhizobium_betae_Proteobacteria:0.0231931663)97:0.0017684549,WP_092029312.1-Bradyrhizobium_sp._OK095_Proteobacteria:0.014921706)100:0.0081846157,WP_092214970.1-Bradyrhizobium_arachidis_Proteobacteria:0.0295808162)88:0.0090227487)65:0.0097156734,(WP_084803943.1-Bradyrhizobium_sp._NAS80.1_Proteobacteria:0.0149844591,WP_074117602.1-Bradyrhizobium_sp._AS23.2_Proteobacteria:0.003334214)100:0.0283194369)91:0.0071301977,(((((WP_071915975.1-Bradyrhizobium_japonicum_Proteobacteria:0.0035973092,WP_063984832.1-Bradyrhizobium_sp._Proteobacteria:0.0054384548)100:0.0024664171,WP_166089364.1-Bradyrhizobium_sp._1S5_Proteobacteria:0.0140715444)100:0.0091350433,WP_166350707.1-Bradyrhizobium_sp._323S2_Proteobacteria:0.0097146584)100:0.0137446887,(WP_038931390.1-Bradyrhizobium_japonicum_Proteobacteria:0.0017967916,WP_039157276.1-Bradyrhizobium_japonicum_Proteobacteria:0.0018008347)100:0.0007230983)98:0.0030745842,(WP_028156991.1-Bradyrhizobium_japonicum_Proteobacteria:0.0090137277,WP_041955910.1-Bradyrhizobium_japonicum_Proteobacteria:2.4434e-06)100:0.0035572034)100:0.0158009222)99:0.0152288989,((WP_063680948.1-Bradyrhizobium_neotropicale_Proteobacteria:0.0196342599,WP_027550185.1-Bradyrhizobium_sp._Cp5.3_Proteobacteria:0.0095048442)100:0.0234775456,WP_063705824.1-Bradyrhizobium_centrolobii_Proteobacteria:0.0156907727)77:0.0066796844)91:0.0107026319,WP_027526029.1-Bradyrhizobium_sp._Ec3.3_Proteobacteria:0.055633932)100:0.0150153633,WP_140980779.1-Bradyrhizobium_guangdongense_Proteobacteria:0.0384437846)100:0.0338028844,(((((((((((WP_028347371.1-Bradyrhizobium_murdochi_Proteobacteria:0.0192907318,WP_057843198.1-Bradyrhizobium_retamae_Proteobacteria:0.0177910559)100:0.0062281679,WP_065748757.1-Bradyrhizobium_sp._LMTR_3_Proteobacteria:0.0300597239)73:0.002215163,WP_171577827.1-Bradyrhizobium_australiense_Proteobacteria:0.0263946208)100:0.0051995689,WP_065730813.1-Bradyrhizobium_icense_Proteobacteria:0.0247657613)100:0.0170491396,(((WP_065756637.1-Bradyrhizobium_paxllaeri_Proteobacteria:0.0216503159,WP_057859318.1-Bradyrhizobium_lablabi_Proteobacteria:0.0091366884)100:0.0073879009,WP_161852777.1-Bradyrhizobium_sp._CCBAU_051011_Proteobacteria:0.028888049)100:0.0046301725,WP_057833547.1-Bradyrhizobium_jicamae_Proteobacteria:0.0178178765)100:0.0097361233)100:0.0134191777,WP_108514566.1-Bradyrhizobium_algeriense_Proteobacteria:0.032873763)82:0.0069744356,(WP_057900995.1-Bradyrhizobium_valentinum_Proteobacteria:2.5529e-06,WP_057851642.1-Bradyrhizobium_valentinum_Proteobacteria:0.0017897692)100:0.0550459293)93:0.0110724346,((((WP_092515866.1-Afipia_sp._GAS231_Proteobacteria:0.0018019864,SDP08864.1-Afipia_sp._GAS231_Proteobacteria:2.8835e-06)100:0.0215708847,WP_155805222.1-Bradyrhizobium_sp._URHA0002_Proteobacteria:0.0355431287)100:0.0055145948,WP_079586579.1-Bradyrhizobium_lablabi_Proteobacteria:0.0319040136)99:0.0103619859,(((TKW79521.1-Bradyrhizobium_icense_Proteobacteria:0.0608690494,WP_100419024.1-Bradyrhizobium_lablabi_Proteobacteria:0.0515946924)92:0.0202090948,WP_143206068.1-Bradyrhizobium_erythrophlei_Proteobacteria:0.0361139511)81:0.010446381,MBA2399293.1-Bradyrhizobium_sp._Proteobacteria:0.0364554366)71:0.0066879051)74:0.0055647529)65:0.0061542187,MBA4036164.1-Bradyrhizobium_sp._Proteobacteria:0.0405283343)81:0.0227043355,WP_069276965.1-Bradyrhizobium_elkanii_Proteobacteria:0.0722275078)97:0.0164613475,(WP_130580234.1-Bradyrhizobium_sp._Leo170_Proteobacteria:0.0274574027,WP_130222300.1-Bradyrhizobium_sp._Leo121_Proteobacteria:0.0492842417)100:0.0546819528)65:0.0166751451)71:0.0145592668,(((((WP_100380578.1-Afipia_broomeae_Proteobacteria:0.0177911776,WP_146687675.1-Bradyrhizobium_canariense_Proteobacteria:0.0021310859)100:0.0360374357,TMK06221.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0636638288)78:0.0181483378,THD60673.1-Bradyrhizobium_sp._Proteobacteria:0.0652871755)80:0.0216840148,WP_079601315.1-Bradyrhizobium_erythrophlei_Proteobacteria:0.0483522052)74:0.0197372016,WP_079544782.1-Bradyrhizobium_lablabi_Proteobacteria:0.0720034094)75:0.0173912185)77:0.0111860198,(WP_024518537.1-Bradyrhizobium_sp._Tv2a-2_Proteobacteria:0.0667884073,WP_024511517.1-Bradyrhizobium_sp._ARR65_Proteobacteria:0.0783727102)99:0.0359617054)94:0.012524448,(TMJ47098.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0340033028,TMK39387.1-Alphaproteobacteria_bacterium_Proteobacteria:0.0121410077)100:0.0494829005)99:0.0276614213,((((((WP_172134110.1-Bradyrhizobium_sp._81013_Proteobacteria:2.5529e-06,WP_172111906.1-Bradyrhizobium_sp._83012_Proteobacteria:0.0035471731)100:0.0021326774,WP_172180802.1-Bradyrhizobium_sp._83002_Proteobacteria:0.0050059425)100:0.0307800772,WP_083842450.1-Bradyrhizobium_sp._ORS_375_Proteobacteria:0.030119602)100:0.0111131521,(WP_035655465.1-Bradyrhizobium_sp._STM_3809_Proteobacteria:2.5547e-06,CCD98599.1-Bradyrhizobium_sp._STM_3809_Proteobacteria:2.5529e-06)100:0.0380780498)99:0.0256677348,WP_168167890.1-Bradyrhizobium_sp._BTAi1_Proteobacteria:0.0563145085)100:0.0959843621,(NVN85223.1-Rhodopseudomonas_sp._Proteobacteria:0.0665542815,WP_011439962.1-Rhodopseudomonas_palustris_Proteobacteria:0.1114647753)100:0.0416817415)84:0.0068793984)100:0.1892107471,(((EGP08750.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:2.5529e-06,WP_043924226.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:2.5529e-06)100:0.0056514111,WP_002714592.1-Afipia_clevelandensis_Proteobacteria:0.0066726172)100:0.0435592295,WP_046828790.1-Afipia_massiliensis_Proteobacteria:0.0543554175)100:0.1754935655)100:0.1763423894,WP_076861029.1-Bradyrhizobium_mercantei_Proteobacteria:0.3530543936)100:0.1056086523,OJY09878.1-Rhizobiales_bacterium_62-47_Proteobacteria:0.3726719779)100:0.1228057174,((((PYN74367.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.096397572,PYM96198.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0929122334)100:0.077849593,OGL20369.1-Candidatus_Rokubacteria_bacterium_RIFCSPLOWO2_12_FULL_71_22_Candidatus:0.1487536663)98:0.0164241468,(PYN46404.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0914615522,PYN32128.1-Candidatus_Rokubacteria_bacterium_Candidatus:0.0892436852)100:0.0653428037)100:0.0991123782,((WP_089945766.1-Candidatus_Entotheonella_palauensis_Candidatus:0.0634081638,WP_089717141.1-Candidatus_Entotheonella_palauensis_Candidatus:0.051703052)100:0.2748929147,KAB2911669.1-Hyphomicrobiaceae_bacterium_Proteobacteria:0.1877779584)87:0.0444202423)100:0.2069049165)84:0.0698636387,(((WP_027475679.1-Curvibacter_gracilis_Proteobacteria:0.0152875513,WP_157443435.1-Curvibacter_lanceolatus_Proteobacteria:0.0139609041)100:0.0290103111,RUP23521.1-Curvibacter_sp._Proteobacteria:0.0268788572)100:0.3270352857,GBU15266.1-Polaromonas_sp._Proteobacteria:0.3005515697)100:0.1430077918)90:0.0451901483,(WP_155709830.1-Massilia_dura_Proteobacteria:0.5557661566,RZL87373.1-Variovorax_sp._Proteobacteria:0.3945588924)100:0.0736976779)83:0.0047554408,((((((((((((((((((((((WP_145759386.1-Variovorax_sp._1180_Proteobacteria:2.5529e-06,WP_126183471.1-Variovorax_sp._369_Proteobacteria:0.0035560491)100:0.0035575277,WP_020722993.1-Variovorax_paradoxus_Proteobacteria:0.003559658)99:2.8573e-06,WP_184605932.1-Variovorax_sp._BK613_Proteobacteria:0.0017867393)100:0.0017778488,WP_132801781.1-Variovorax_sp._BK370_Proteobacteria:2.5902e-06)100:0.0017773413,WP_132755990.1-Variovorax_sp._BK151_Proteobacteria:0.0035706853)100:0.0104871553,WP_176665552.1-Variovorax_sp._SG517_Proteobacteria:0.0131240078)99:0.0055691785,(WP_184638849.1-Variovorax_guangxiensis_Proteobacteria:0.0020296942,WP_126020505.1-Variovorax_guangxiensis_Proteobacteria:0.0032976925)100:0.0218177694)100:0.0190596629,(WP_093195641.1-Variovorax_sp._YR750_Proteobacteria:0.0070754256,WP_126472589.1-Variovorax_gossypii_Proteobacteria:0.0071366605)100:0.005799894)100:0.0123966964,(((WP_097197469.1-Variovorax_sp._YR752_Proteobacteria:0.0035487301,WP_093174861.1-Variovorax_sp._YR266_Proteobacteria:2.7141e-06)100:0.0017804944,WP_093076613.1-Variovorax_sp._OV084_Proteobacteria:0.0017718643)99:0.0015431797,WP_093057006.1-Variovorax_sp._YR634_Proteobacteria:0.0037590032)100:0.0310962981)90:0.0149565902,((WP_130421160.1-Variovorax_sp._BK460_Proteobacteria:0.0284286767,WP_093131647.1-Variovorax_sp._OK605_Proteobacteria:0.2080303908)71:0.036386729,WP_007837899.1-Variovorax_sp._CF313_Proteobacteria:0.0152241582)48:0.0181505344)48:0.0156223618,(WP_081267376.1-Variovorax_paradoxus_Proteobacteria:0.0269652371,ODU15846.1-Variovorax_sp._SCN_67-85_Proteobacteria:0.0233850795)100:0.0325716889)68:0.0188985374,(((((WP_172705422.1-Variovorax_paradoxus_Proteobacteria:2.5529e-06,KPU98577.1-Variovorax_paradoxus_Proteobacteria:2.5529e-06)100:0.0041970861,MBS76598.1-Variovorax_sp._Proteobacteria:2.7864e-06)100:0.0084655208,WP_093343818.1-Variovorax_sp._PDC80_Proteobacteria:0.003582875)83:2.9532e-06,KAF1061273.1-Variovorax_sp._Proteobacteria:0.0078040894)88:0.002732022,TAJ61793.1-Variovorax_sp._Proteobacteria:0.0044458578)100:0.0749097892)73:0.0319422853,(((WP_093435402.1-Variovorax_sp._770b2_Proteobacteria:0.0206586646,WP_052810747.1-Variovorax_paradoxus_Proteobacteria:0.0165659413)100:0.0134437057,WP_013538622.1-Variovorax_paradoxus_Proteobacteria:0.030228641)73:0.0150777259,WP_176660984.1-Variovorax_sp._SG533_Proteobacteria:0.0453283197)61:0.0068646733)72:0.0244211033,WP_145738683.1-Variovorax_beijingensis_Proteobacteria:0.0610257482)71:0.010683452,(((((((((WP_062470459.1-Variovorax_boronicumulans_Proteobacteria:0.0052289264,WP_095948515.1-Variovorax_boronicumulans_Proteobacteria:2.7198e-06)72:0.0034849056,WP_159278964.1-Variovorax_boronicumulans_Proteobacteria:0.0034724572)88:0.0017543454,WP_159274326.1-Variovorax_boronicumulans_Proteobacteria:0.0034861997)54:0.0017462506,(WP_070061350.1-Variovorax_boronicumulans_Proteobacteria:0.003505998,WP_095743122.1-Variovorax_boronicumulans_Proteobacteria:0.0017468574)61:2.3233e-06)90:0.0034887664,WP_139703542.1-Variovorax_sp._KBS0712_Proteobacteria:2.1316e-06)96:0.0040951815,((WP_099794476.1-Variovorax_sp._54_Proteobacteria:0.0034785224,WP_101490554.1-Variovorax_sp._RO1_Proteobacteria:0.0052145746)98:2.6612e-06,WP_153281245.1-Variovorax_paradoxus_Proteobacteria:0.0069603947)88:0.0046318009)81:0.0077788031,WP_056574498.1-Variovorax_sp._Root473_Proteobacteria:0.0239051762)36:0.0112620334,WP_119556153.1-Acidovorax_cavernicola_Proteobacteria:0.0490619443)97:0.0295236989,((WP_093241869.1-Variovorax_sp._EL159_Proteobacteria:0.0125800125,WP_187113215.1-Variovorax_sp._PAMC26660_Proteobacteria:0.0317758982)100:0.0327409585,WP_124458460.1-Variovorax_sp._KBW07_Proteobacteria:0.0418875545)42:0.0093686014)95:0.0196208468)99:0.0487542445,(((QLG72306.1-Zygotorulaspora_mrakii_Saccharomycotina:0.1410169193,QUERY_Saccharomyces_cerevisiae_YOL164W:0.1521691852)100:0.1389922433,(XP_002555886.1-Lachancea_thermotolerans_Saccharomycotina:0.1333561401,SCW03834.1-Lachancea_fermentati_Saccharomycotina:0.14927207)100:0.2396795606)100:0.132661739,(XP_018221989.1-Saccharomyces_eubayanus_Saccharomycotina:0.0010209931,QID88192.1-Saccharomyces_pastorianus_Saccharomycotina:0.0059908746)100:0.2282597169)100:0.0828212463)100:0.0566919932,WP_092831606.1-Rhodospirillales_bacterium_URHD0017_Proteobacteria:0.2999519574)100:0.1389205692,(((((((((((((MBB5054515.1-Afipia_massiliensis_Proteobacteria:0.0017197135,WP_184089169.1-Afipia_massiliensis_Proteobacteria:2.5529e-06)100:0.0314135181,WP_046827511.1-Afipia_massiliensis_Proteobacteria:0.014905309)99:0.0174094539,WP_062313220.1-Bradyrhizobium_sp._CCH10-C7_Proteobacteria:0.0230233757)82:0.011714591,((HBR43714.1-Afipia_sp._Proteobacteria:0.0017509222,HAQ93654.1-Afipia_sp._Proteobacteria:0.0035151475)100:0.0065335192,(WP_006021976.1-Afipia_broomeae_Proteobacteria:0.0062396749,RTL81632.1-Bradyrhizobiaceae_bacterium_Proteobacteria:0.0026357283)100:0.0052222606)100:0.0181037867)94:0.0212267008,TXJ10197.1-Afipia_sp._Proteobacteria:0.02929589)50:0.0056894676,((WP_002713184.1-Afipia_clevelandensis_Proteobacteria:0.0017891004,WP_009734135.1-Bradyrhizobiaceae_bacterium_SG-6C_Proteobacteria:0.0034891952)100:0.0437309542,NGX94573.1-Candidatus_Afipia_apatlaquensis_Proteobacteria:0.0171396871)91:0.008665325)100:0.0437018874,(((((WP_175367589.1-Tardiphaga_robiniae_Proteobacteria:0.001711963,WP_120288614.1-Tardiphaga_sp._YR296_Proteobacteria:0.0104363849)93:0.0028198655,WP_184513838.1-Tardiphaga_robiniae_Proteobacteria:0.0040792062)92:0.0055540338,WP_089261759.1-Tardiphaga_sp._OK246_Proteobacteria:0.0089400208)100:0.03152664,WP_092138970.1-Bradyrhizobium_sp._NFR13_Proteobacteria:0.0243423553)91:0.0267856795,WP_115033941.1-Tardiphaga_sp._CF115_Proteobacteria:0.0231530893)100:0.0632464649)99:0.0415066233,WP_149531854.1-Tardiphaga_sp._P9-11_Proteobacteria:0.0881091436)73:0.0088712198,OJY11205.1-Rhizobiales_bacterium_62-47_Proteobacteria:0.1273140682)94:0.0148344939,((WP_146690165.1-Bradyrhizobium_canariense_Proteobacteria:0.0159482323,WP_100386102.1-Afipia_broomeae_Proteobacteria:0.018375933)100:0.0674281139,WP_008968903.1-Bradyrhizobium_sp._STM_3843_Proteobacteria:0.2060846665)99:0.0501990048)96:0.0275586162,((((((((((WP_164571151.1-Rhodopseudomonas_sp._BR0C11_Proteobacteria:2.3187e-06,WP_107345917.1-Rhodopseudomonas_palustris_Proteobacteria:0.00884403)95:0.0017611222,WP_164638651.1-Rhodopseudomonas_sp._BR0G17_Proteobacteria:0.0052823308)90:2.0387e-06,WP_107356882.1-Rhodopseudomonas_palustris_Proteobacteria:0.0088534594)97:0.0037241441,((WP_011159875.1-Rhodopseudomonas_palustris_Proteobacteria:0.0017529273,WP_012497548.1-Rhodopseudomonas_palustris_Proteobacteria:0.0070691097)84:2.755e-06,WP_119019080.1-Rhodopseudomonas_palustris_Proteobacteria:0.0035293205)100:0.012215644)100:0.0462323059,(((WP_013504207.1-Rhodopseudomonas_palustris_Proteobacteria:0.0071875903,WP_047308756.1-Rhodopseudomonas_palustris_Proteobacteria:2.7695e-06)99:0.0018000779,WP_164630935.1-Rhodopseudomonas_sp._WA056_Proteobacteria:2.7591e-06)100:0.011672024,(WP_119858943.1-Rhodopseudomonas_palustris_Proteobacteria:0.1271337401,WP_142883484.1-Rhodopseudomonas_palustris_Proteobacteria:0.014449844)85:0.0235940513)87:0.0391549717)88:0.0317456345,(WP_022722993.1-Rhodopseudomonas_sp._B29_Proteobacteria:0.0599943554,WP_054162298.1-Rhodopseudomonas_sp._AAP120_Proteobacteria:0.0931292521)83:0.015507226)100:0.0588381775,((WP_110782500.1-Rhodopseudomonas_faecalis_Proteobacteria:0.0017607029,WP_027276359.1-Rhodopseudomonas_palustris_Proteobacteria:0.0053158928)99:0.0030356045,TAH64925.1-Rhodopseudomonas_palustris_Proteobacteria:0.0040660973)100:0.1041741088)99:0.0362728913,WP_011665574.1-Rhodopseudomonas_palustris_Proteobacteria:0.0823318557)100:0.0337734339,(ABD08837.1-Rhodopseudomonas_palustris_Proteobacteria:2.9645e-06,WP_041798938.1-Rhodopseudomonas_palustris_Proteobacteria:2.813e-06)100:0.0682149503)100:0.0515612765,NVN87899.1-Rhodopseudomonas_sp._Proteobacteria:0.0651288182)100:0.1129293073)98:0.0445752282,OQW56345.1-Proteobacteria_bacterium_SG_bin9_Proteobacteria:0.1627514055)100:0.143031518,WP_136963313.1-Phreatobacter_stygius_Proteobacteria:0.3112306934)100:0.0917386658)67:0.0266595912,(((((((WP_136868902.1-Pseudomonas_bauzanensis_Proteobacteria:0.0070222852,EZQ18937.1-Pseudomonas_bauzanensis_Proteobacteria:2.5529e-06)100:0.1117169072,WP_185267007.1-Pseudomonas_xiamenensis_Proteobacteria:0.1297154818)100:0.155509858,WP_093476299.1-Pseudomonas_yangmingensis_Proteobacteria:0.2420063289)100:0.0524687662,(WP_108104178.1-Pseudomonas_mangrovi_Proteobacteria:0.1439069358,WP_017937932.1-Pseudomonas_thermotolerans_Proteobacteria:0.146369063)100:0.1327273239)100:0.1002360458,(((MAB24835.1-Pseudomonadales_bacterium_Proteobacteria:0.0190952035,WP_182248855.1-Pseudomonas_sp._5Ae-yellow_Proteobacteria:0.0166167239)100:0.1055173487,WP_083726556.1-Pseudomonas_pachastrellae_Proteobacteria:0.1003605968)100:0.1239403048,PKM29133.1-Gammaproteobacteria_bacterium_HGW-Gammaproteobacteria-11_Proteobacteria:0.1694559589)100:0.2031845527)100:0.1243949737,(WP_057659955.1-Pseudoxanthomonas_dokdonensis_Proteobacteria:0.2504443031,WP_077034059.1-Pelomonas_sp._KK5_Proteobacteria:0.290739419)100:0.089768806)99:0.0853947488,WP_151072822.1-Cupriavidus_oxalaticus_Proteobacteria:0.4488612335)77:0.038526075)94:0.0539909156,(WP_163259863.1-Caulobacter_sp._17J65-9_Proteobacteria:0.0359889329,WP_187448402.1-Caulobacter_sp._17J80-11_Proteobacteria:0.0560016928)100:0.4106137649)88:0.0483121127,WP_119419155.1-Rhodospirillaceae_bacterium_SYSU_D60015_Proteobacteria:0.5054381725)86:0.0421557676,((((((((WP_071072555.1-Cupriavidus_malaysiensis_Proteobacteria:2.4404e-06,WP_071038742.1-Cupriavidus_sp._USMAA2-4_Proteobacteria:0.0018049159)100:0.001807578,WP_071018820.1-Cupriavidus_sp._USMAHM13_Proteobacteria:2.614e-06)100:0.1086010247,WP_066731373.1-Cupriavidus_sp._D384_Proteobacteria:0.1244621502)99:0.0424841488,WP_116319445.1-Cupriavidus_sp._P-10_Proteobacteria:0.1027967862)100:0.0837115318,((((WP_025586346.1-Cupriavidus_taiwanensis_Proteobacteria:2.5529e-06,WP_116388232.1-Cupriavidus_taiwanensis_Proteobacteria:0.0036557088)100:0.0316799251,WP_116377884.1-Cupriavidus_taiwanensis_Proteobacteria:0.0302374199)99:0.0150639375,WP_062795892.1-Cupriavidus_nantongensis_Proteobacteria:0.0148732888)100:0.0624658383,WP_116320039.1-Cupriavidus_sp._P-10_Proteobacteria:0.0839847297)100:0.1462076246)100:0.1899307557,((WP_061999991.1-Burkholderia_sp._PAMC_28687_Proteobacteria:0.008725495,WP_062170184.1-Burkholderia_sp._PAMC_26561_Proteobacteria:0.0025040922)100:0.0260404307,WP_081889718.1-Caballeronia_sordidicola_Proteobacteria:0.0277042159)100:0.4391644299)99:0.0726843554,(PZW26129.1-Thermosporothrix_hazakensis_Chloroflexi:2.5529e-06,WP_111324427.1-Thermosporothrix_hazakensis_Chloroflexi:2.5529e-06)100:0.4278181864)100:0.0982174834,(((WP_183035411.1-Cupriavidus_sp._UME77_Proteobacteria:2.5529e-06,MBB1634382.1-Cupriavidus_sp._UME77_Proteobacteria:2.4494e-06)100:0.0121357022,WP_150987011.1-Cupriavidus_basilensis_Proteobacteria:0.006166255)100:0.1044846317,WP_092594144.1-Ralstonia_sp._25mfcol4.1_Proteobacteria:0.1855041654)100:0.3460007168)98:0.0688633008)83:0.0191555351);
2 |
--------------------------------------------------------------------------------
/phylogenetics/output/YOL164W_rectangular_tree.pdf:
--------------------------------------------------------------------------------
https://raw.githubusercontent.com/SysBioChalmers/HGTphyloDetect/d4ff8c5dbdaf3b200e45dd57962dfb11776f43d7/phylogenetics/output/YOL164W_rectangular_tree.pdf
--------------------------------------------------------------------------------
/phylogenetics/scripts/HGT_homologs_sequence.py:
--------------------------------------------------------------------------------
1 | #!/usr/bin/env python
2 | # -*- coding: utf-8 -*-
3 |
4 | # This file is to get the homolog accession identifiers and sequences for the following multiple sequence alignment
5 |
6 |
7 | import re
8 | import sys
9 | import os
10 | from Bio import SeqIO
11 | from Bio import Entrez
12 | from ete3 import NCBITaxa
13 |
14 |
15 | def parse_NCBI(filename):
16 | with open(filename, "r") as infile :
17 | lines = infile.readlines()
18 |
19 | accession_number = list()
20 | accession_similarity = dict()
21 | for line in lines :
22 | accession = line.strip("\n").split("\t")[2]
23 | similarity = line.strip("\n").split("\t")[3]
24 | accession_number.append(accession)
25 | accession_similarity[accession] = float(similarity)
26 |
27 | return accession_number, accession_similarity
28 |
29 | def get_refSeq(gene) :
30 | # get the related protein sequence accoding to protein identifier
31 | with open("./input/%s.fasta" % gene, "r") as handleGene :
32 | proteinSeq = dict()
33 | for record in SeqIO.parse(handleGene, "fasta") :
34 | # ['__add__', '__bool__', '__class__', '__contains__', '__delattr__', '__dict__', '__dir__', '__doc__', '__eq__', '__format__', '__ge__',
35 | # '__getattribute__', '__getitem__', '__gt__', '__hash__', '__init__', '__init_subclass__', '__iter__', '__le__', '__le___', '__len__', '__lt__',
36 | # '__module__', '__ne__', '__new__', '__nonzero__', '__radd__', '__reduce__', '__reduce_ex__', '__repr__', '__setattr__', '__sizeof__', '__str__',
37 | # '__subclasshook__', '__weakref__', '_per_letter_annotations', '_seq', '_set_per_letter_annotations', '_set_seq', 'annotations', 'dbxrefs', 'description',
38 | # 'features', 'format', 'id', 'letter_annotations', 'lower', 'name', 'reverse_complement', 'seq', 'translate', 'upper']
39 | proteinSeq[record.id] = str(record.seq)
40 |
41 | return proteinSeq[gene]
42 |
43 | def getTaxid(accession):
44 | # Retrieving data in the GenBank using only the GenBank code accession in biopython
45 | # https://www.ncbi.nlm.nih.gov/books/NBK25497/table/chapter2.T._entrez_unique_identifiers_ui/?report=objectonly
46 | # https://www.ncbi.nlm.nih.gov/books/NBK25499/#chapter4.EFetch
47 | # https://biopython.org/DIST/docs/api/Bio.Entrez-module.html
48 | Entrez.email = "abcd@ncbi.org"
49 |
50 | # https://www.biostars.org/p/304175/
51 | # get tax id using only the GenBank code accession in biopython
52 | # handle = Entrez.efetch(db='protein', id="NP_012706.1", rettype='gb')
53 | handle = Entrez.efetch(db='protein', id=accession, rettype='gb')
54 | record = SeqIO.read(handle,'genbank')
55 | # print(record.features[0].qualifiers)
56 | if record.features[0].qualifiers['db_xref'][0].split(":")[0] == 'taxon':
57 | taxid = record.features[0].qualifiers['db_xref'][0].split(":")[1] # the type is a string
58 | organism = record.features[0].qualifiers['organism'][0]
59 | # seq = record.seq
60 | # print(taxid,organism)
61 |
62 | return taxid
63 |
64 | def getSeq(accession):
65 | # Retrieving data in the GenBank using only the GenBank code accession in biopython
66 | # https://www.ncbi.nlm.nih.gov/books/NBK25497/table/chapter2.T._entrez_unique_identifiers_ui/?report=objectonly
67 | # https://www.ncbi.nlm.nih.gov/books/NBK25499/#chapter4.EFetch
68 | # https://biopython.org/DIST/docs/api/Bio.Entrez-module.html
69 | Entrez.email = "abcd@ncbi.org"
70 |
71 | # https://www.biostars.org/p/304175/
72 | # get tax id using only the GenBank code accession in biopython
73 | # handle = Entrez.efetch(db='protein', id="NP_012706.1", rettype='gb')
74 | handle = Entrez.efetch(db='protein', id=accession, rettype='gb')
75 | record = SeqIO.read(handle,'genbank')
76 | seq = record.seq
77 | # print(seq)
78 |
79 | return seq
80 |
81 | def main() :
82 | name = sys.argv[1:][0]
83 | gene = name[6:-6]
84 |
85 | print('This is gene', gene + ' ---------------')
86 | if os.path.exists("./input/%s.txt" % gene) :
87 | accession_number, accession_similarity = parse_NCBI("./input/%s.txt" % gene)
88 | # print(len(accession_number))
89 | else :
90 | print('Warning: please run BLASTP first!')
91 |
92 | ncbi = NCBITaxa()
93 | id_seq = dict()
94 | for accession in accession_number :
95 | # print(accession)
96 | # print(accession_similarity[accession])
97 | try :
98 | seq = str(getSeq(accession))
99 | except :
100 | continue
101 |
102 | taxid = getTaxid(accession)
103 | lineage = ncbi.get_lineage(taxid)
104 | lineage2ranks = ncbi.get_rank(lineage)
105 | ranks2lineage = dict((rank, taxid) for (taxid, rank) in lineage2ranks.items())
106 | # print(ranks2lineage)
107 |
108 | try :
109 | taxid2name = ncbi.get_taxid_translator([ranks2lineage['phylum'], ranks2lineage['species']])
110 | if taxid2name[ranks2lineage["phylum"]] != "Ascomycota":
111 | accession = accession + "-" + taxid2name[ranks2lineage["species"]].replace(" ", "_") + "@" + taxid2name[ranks2lineage["phylum"]]
112 |
113 | print(accession)
114 | id_seq[accession] = seq
115 | continue
116 | except :
117 | pass
118 |
119 | try :
120 | taxid2name = ncbi.get_taxid_translator([ranks2lineage['phylum'], ranks2lineage['subphylum'], ranks2lineage['species']])
121 | # print(taxid2name[ranks2lineage["subphylum"]])
122 |
123 | if accession_similarity[accession] < 80 : # Sequences with more than 80% similarity were eliminated.
124 | if taxid2name[ranks2lineage["subphylum"]] == "Saccharomycotina" :
125 | accession = accession + "-" + taxid2name[ranks2lineage["species"]].replace(" ", "_") + "@Saccharomycotina"
126 | if taxid2name[ranks2lineage["subphylum"]] != "Saccharomycotina" and taxid2name[ranks2lineage["phylum"]] == "Ascomycota":
127 | accession = accession + "-" + taxid2name[ranks2lineage["species"]].replace(" ", "_") + "@other_Ascomycota"
128 | if taxid2name[ranks2lineage["phylum"]] != "Ascomycota":
129 | accession = accession + "-" + taxid2name[ranks2lineage["species"]].replace(" ", "_") + "@" + taxid2name[ranks2lineage["phylum"]]
130 | print(accession)
131 | id_seq[accession] = seq
132 | else :
133 | continue
134 | except :
135 | continue
136 |
137 | gene_seq = get_refSeq(gene)
138 | gene_query = "QUERY_" + 'Saccharomyces_cerevisiae_' + gene
139 | print(gene_query)
140 | print(gene_seq)
141 | id_seq[gene_query] = gene_seq
142 | # print(len(id_seq))
143 |
144 | with open("./input/%s_homologs.fasta" % gene, "w") as outfile :
145 | for accession,seq in id_seq.items() :
146 | outfile.write(">"+accession+"\n")
147 | outfile.write(seq+"\n")
148 |
149 |
150 | if __name__== "__main__":
151 | main()
152 |
--------------------------------------------------------------------------------
/phylogenetics/scripts/create_iTOL_config.pl:
--------------------------------------------------------------------------------
1 | #!/usr/bin/perl -w
2 | # This script is obtained from one high impact paper shown as below:
3 | # Shen, Xing-Xing, et al. "Tempo and mode of genome evolution in the budding yeast subphylum." Cell 175.6 (2018): 1533-1545
4 |
5 | use strict;
6 | use warnings;
7 | use Bio::TreeIO;
8 |
9 | my $infile = $ARGV[0]; #newick tree must end in .tree
10 |
11 | $infile =~ /^(.*)\.tree$/;
12 | my $query = $1;
13 | my %color_hash;
14 | popcolhash();
15 |
16 | my $outfile1 = "${query}-color.txt";
17 | my $outfile2 = "${query}-font.txt";
18 |
19 | open (OFIL1, '>', $outfile1) or die "Couldn't write to file $outfile1: $!\n";
20 | open (OFIL2, '>', $outfile2) or die "Couldn't write to file $outfile2: $!\n";
21 | popcolorfile();
22 | popfontfile();
23 |
24 | my $in = new Bio::TreeIO(-file => "$infile", -format => 'newick');
25 | while( my $tree = $in->next_tree ) {
26 | for my $node ( $tree->get_nodes ) {
27 | if ( $node->is_Leaf ) {
28 | my $name = $node->id();
29 |
30 | my $lineage = '';
31 | if ( $name =~ /.+_(other_[A-Za-z0-9]+)$/ or $name =~ /.+_([A-Za-z0-9]+)$/){
32 | $lineage = $1;
33 | }
34 |
35 | if ($name =~ /^QUERY/i){
36 | print OFIL2 "${name},label,#e31a1c,bold,1\n";
37 | print OFIL1 "${name} \#e31a1c Saccharomycotina\n";
38 | }else{
39 | print OFIL2 "${name},label,#000000,normal,1\n";
40 | }
41 |
42 | if (exists $color_hash{$lineage}) {
43 | my $color = $color_hash{$lineage};
44 | print OFIL1 "${name} ${color}\n";
45 | }else{unless ($name =~ /^QUERY/i) {print OFIL1 "${name} \#969696 Other\n";}}
46 |
47 | }
48 | }
49 | }
50 |
51 | close OFIL1;
52 | close OFIL2;
53 |
54 | sub popcolorfile
55 | {
56 | print OFIL1 "DATASET_COLORSTRIP
57 | #In colored strip datasets, each ID is associated to a color box/strip and can have an optional label. Color can be specified in hexadecimal, RGB or RGBA notation. When using RGB or RGBA notation, you cannot use COMMA as the dataset separator
58 |
59 | #lines starting with a hash are comments and ignored during parsing
60 |
61 | #=================================================================#
62 | # MANDATORY SETTINGS #
63 | #=================================================================#
64 | #select the separator which is used to delimit the data below (TAB,SPACE or COMMA).This separator must be used throughout this file (except in the SEPARATOR line, which uses space).
65 |
66 | #SEPARATOR TAB
67 | #SEPARATOR COMMA
68 | SEPARATOR SPACE
69 |
70 | #label is used in the legend table (can be changed later)
71 | DATASET_LABEL Taxonomy
72 |
73 | #dataset color (can be changed later)
74 | COLOR #000000
75 |
76 | #=================================================================#
77 | # OPTIONAL SETTINGS #
78 | #=================================================================#
79 |
80 | #If COLOR_BRANCHES is set to 1, branches of the tree will be colored according to the colors of the strips above the leaves.
81 | #When all children of a node have the same color, it will be colored the same, ie. the color will propagate inwards towards the root.
82 | COLOR_BRANCHES 1
83 |
84 | #each dataset can have a legend, which is defined below
85 | #for each row in the legend, there should be one shape, color and label
86 | #shape should be a number between 1 and 5:
87 | #1: square
88 | #2: circle
89 | #3: star
90 | #4: right pointing triangle
91 | #5: left pointing triangle
92 |
93 | LEGEND_TITLE Taxonomy
94 | LEGEND_SHAPES 1 1 1 1
95 | LEGEND_COLORS #e31a1c #28b1aa #2D33E7 #969696
96 | LEGEND_LABELS Saccharomycotina Fungi Bacteria Other
97 | # LEGEND_SHAPES 1 1 1 1 1 1 1 1 1 1 1 1
98 | # LEGEND_COLORS #e31a1c #fb9a99 #ff7f00 #28b1aa #b15928 #6a3d9a #cab2d6 #1f78b4 #a6cee3 #33a02c #ffff99 #969696
99 | # LEGEND_LABELS Leotiomycetes Sordariomycetes Eurotiomycetes Dothideomycetes other_Pezizomycotina other_Ascomycota other_Fungi other_Opisthokonta other_Eukaryota Bacteria Archaea Viruses
100 |
101 | #=================================================================#
102 | # all other optional settings can be set or changed later #
103 | # in the web interface (under 'Datasets' tab) #
104 | #=================================================================#
105 |
106 | #width of the colored strip
107 | STRIP_WIDTH 35
108 |
109 | #left margin, used to increase/decrease the spacing to the next dataset. Can be negative, causing datasets to overlap.
110 | #MARGIN 5
111 |
112 | #border width; if set above 0, a border of specified width (in pixels) will be drawn around the color strip
113 | #BORDER_WIDTH 2
114 |
115 | #border color; used when BORDER_WIDTH is above 0
116 | #BORDER_COLOR #969696
117 |
118 | #always show internal values; if set, values associated to internal nodes will be displayed even if these nodes are not collapsed. It could cause overlapping in the dataset display.
119 | #SHOW_INTERNAL 1
120 |
121 | #Internal tree nodes can be specified using IDs directly, or using the 'last common ancestor' method described in iTOL help pages
122 |
123 | #=================================================================#
124 | # Actual data follows after the DATA keyword #
125 | #=================================================================#
126 | DATA
127 |
128 | #Examples:
129 | #assign a red colored strip to leaf 9606, with label 'Human' (label is displayed in the mouseover popups)
130 | #9606 #ff0000 Human
131 |
132 | #assign a green, semi-transparent (alpha 0.5) strip to an internal node, without any label. If 'Show internal values' is set to 'No', this will only be displayed if the node is collapsed.
133 | #9606|5664 rgba(0,255,0,0.5)
134 | ";
135 |
136 | }
137 |
138 | sub popfontfile
139 | {
140 | print OFIL2 "TREE_COLORS
141 | #use this template to define branch colors and styles, colored ranges and label colors/font styles
142 | #lines starting with a hash are comments and ignored during parsing
143 |
144 | #=================================================================#
145 | # MANDATORY SETTINGS #
146 | #=================================================================#
147 | #select the separator which is used to delimit the data below (TAB,SPACE or COMMA).This separator must be used throughout this file (except in the SEPARATOR line, which uses space).
148 |
149 | #SEPARATOR TAB
150 | #SEPARATOR SPACE
151 | SEPARATOR COMMA
152 |
153 | #First 3 fields define the node, type and color
154 | #Possible types are:
155 | #'range': defines a colored range (colored background for labels/clade)
156 | #'clade': defines color/style for all branches in a clade
157 | #'branch': defines color/style for a single branch
158 | #'label': defines font color/style for the leaf label
159 |
160 | #The following additional fields are required:
161 | #for 'range', field 4 defines the colored range label (used in the legend)
162 |
163 | #The following additional fields are optional:
164 | #for 'label', field 4 defines the font style ('normal',''bold', 'italic' or 'bold-italic') and field 5 defines the numeric scale factor for the font size (eg. with value 2, font size for that label will be 2x the standard size)
165 | #for 'clade' and 'branch', field 4 defines the branch style ('normal' or 'dashed') and field 5 defines the branch width scale factor (eg. with value 0.5, branch width for that clade will be 0.5 the standard width)
166 |
167 | #Internal tree nodes can be specified using IDs directly, or using the 'last common ancestor' method described in iTOL help pages
168 | #=================================================================#
169 | # Actual data follows after the DATA keyword #
170 | #=================================================================#
171 | DATA
172 | #NODE_ID,TYPE,COLOR,LABEL_OR_STYLE,SIZE_FACTOR
173 |
174 | #Examples
175 | #internal node with solid branches colored blue and twice the standard width
176 | #9031|9606,clade,#0000ff,normal,2
177 | #internal node with dashed branches colored red and one half the standard width
178 | #601|340,clade,#ff0000,dashed,0.5
179 | #a single internal branch colored green, dashed and 5 times the normal width
180 | #915|777,branch,#00ff00,dashed,5
181 |
182 | #colored range covering all leaves of an internal node, colored red and with label 'Eukaryota'
183 | #184922|9606,range,#ff0000,Eukaryota
184 | #examples of colored ranges from iTOL's Tree of Life
185 | #2190|2287,range,#aaffaa,Archaea
186 | #623|1502,range,#aaaaff,Bacteria
187 |
188 | #leaf label for node 9606 will be displayed in green, bold and twice the regular font size
189 | #9606,label,#00ff00,bold,2
190 |
191 | #leaf label for node 9031 will be displayed in yellow, bold italic and half the regular font size
192 | #9031,label,#ffff00,bold-italic,0.5
193 |
194 | #leaf label for node 8015 will be displayed in blue
195 | #8015,label,#0000ff
196 | ";
197 | }
198 |
199 | sub popcolhash
200 | {
201 |
202 | #good general color scheme
203 | %color_hash = (
204 | "Actinobacteria","#2D33E7 Bacteria",
205 | "Firmicutes","#2D33E7 Bacteria",
206 | "Proteobacteria","#2D33E7 Bacteria",
207 | "other_Bacteria","#2D33E7 Bacteria",
208 | "Aquificae","#2D33E7 Bacteria",
209 | "Armatimonadetes","#2D33E7 Bacteria",
210 | "BacteroidetesChlorobi","#2D33E7 Bacteria",
211 | "Caldiserica","#2D33E7 Bacteria",
212 | "ChlamydiaeVerrucomicrobia","#2D33E7 Bacteria",
213 | "Chloroflexi","#2D33E7 Bacteria",
214 | "Chrysiogenetes","#2D33E7 Bacteria",
215 | "Cyanobacteria","#2D33E7 Bacteria",
216 | "Deferribacteres","#2D33E7 Bacteria",
217 | "DeinococcusThermus","#2D33E7 Bacteria",
218 | "Dictyoglomi","#2D33E7 Bacteria",
219 | "Elusimicrobia","#2D33E7 Bacteria",
220 | "FibrobacteresAcidobacteria","#2D33E7 Bacteria",
221 | "Fusobacteria","#2D33E7 Bacteria",
222 | "Gemmatimonadetes","#2D33E7 Bacteria",
223 | "Nitrospinae","#2D33E7 Bacteria",
224 | "Nitrospirae","#2D33E7 Bacteria",
225 | "Planctomycetes","#2D33E7 Bacteria",
226 | "Spirochaetes","#2D33E7 Bacteria",
227 | "Synergistetes","#2D33E7 Bacteria",
228 | "Tenericutes","#2D33E7 Bacteria",
229 | "Thermodesulfobacteria","#2D33E7 Bacteria",
230 | "Thermotogae","#2D33E7 Bacteria",
231 | "other_Fungi","#28b1aa Fungi",
232 | "Microsporidia","#28b1aa Fungi",
233 | "other_Pezizomycotina","#28b1aa Fungi",
234 | "Dothideomycetes","#28b1aa Fungi",
235 | "Eurotiomycetes","#28b1aa Fungi",
236 | "Sordariomycetes","#28b1aa Fungi",
237 | "Leotiomycetes","#28b1aa Fungi",
238 | "Taphrinomycotina","#28b1aa Fungi",
239 | "Basidiomycota","#28b1aa Fungi",
240 | "Mucoromycota", "#28b1aa Fungi",
241 | "other_Dikarya","#28b1aa Fungi",
242 | "other_Ascomycota","#28b1aa Fungi",
243 | "Saccharomycotina","#e31a1c Saccharomycotina",
244 | );
245 |
246 | }
--------------------------------------------------------------------------------
/phylogenetics/scripts/generate_tree.sh:
--------------------------------------------------------------------------------
1 | #!/bin/bash
2 |
3 | var=$1
4 | gene=${var%.fas*}
5 | echo 'This is gene '$gene' '
6 | echo 'Begin to run!!!'
7 |
8 | cd ../
9 |
10 | python scripts/HGT_homologs_sequence.py input/${gene}.fasta
11 |
12 | mafft --thread 6 --auto ./input/${gene}_homologs.fasta > ./intermediate/${gene}_aln.fasta
13 |
14 | trimal -in ./intermediate/${gene}_aln.fasta -out ./intermediate/${gene}_aln_trimmed.fasta -automated1
15 |
16 | iqtree -nt 6 -st AA -s ./intermediate/${gene}_aln_trimmed.fasta -m TEST -mrate G4 -keep-ident -bb 1000 -pre ./intermediate/${gene}
17 |
18 | Rscript scripts/midpoint_tree.R ${gene}
19 |
20 | perl scripts/create_iTOL_config.pl ./intermediate/${gene}_midpoint.tree
21 |
22 | echo 'Yep, finish!!!'
23 |
24 |
--------------------------------------------------------------------------------
/phylogenetics/scripts/midpoint_tree.R:
--------------------------------------------------------------------------------
1 | # Usage: run command line Rscript midpoint_tree.R gene
2 | # For example: Rscript scripts/midpoint_tree.R YOL164W
3 |
4 | # Midpoint root a phylogeny with R:
5 | library(ape)
6 | library(phangorn)
7 |
8 | args = commandArgs(T)
9 | print(args[1])
10 |
11 | treefile <- paste("./intermediate/",args[1],".treefile",sep="")
12 | mytree <- read.tree(treefile)
13 | midponit_mytree <- ladderize (midpoint(mytree))
14 | write.tree (midponit_mytree, paste("./intermediate/",args[1],"_midpoint.tree",sep=""))
15 |
--------------------------------------------------------------------------------
/requirements.txt:
--------------------------------------------------------------------------------
1 | ete3==3.1.2
2 | biopython==1.78
--------------------------------------------------------------------------------