ArticlePDF Available

Abstract and Figures

We present the latest version of the Molecular Evolutionary Genetics Analysis (MEGA) software, which contains many sophisticated methods and tools for phylogenomics and phylomedicine. In this major upgrade, MEGA has been optimized for use on 64-bit computing systems for analyzing bigger datasets. Researchers can now explore and analyze tens of thousands of sequences in MEGA. The new version also provides an advanced wizard for building timetrees and includes a new functionality to automatically predict gene duplication events in gene family trees. The 64-bit MEGA is made available in two interfaces: graphical and command line. The graphical user interface (GUI) is a native Microsoft Windows application that can also be used on Mac OSX. The command line MEGA is available as native applications for Windows, Linux, and Mac OSX. They are intended for use in high-throughput and scripted analysis. Both versions are available from www.megasoftware.net free of charge.
Content may be subject to copyright.
MEGA7: Molecular Evolutionary Genetics Analysis Version 7.0
forBiggerDatasets
Sudhir Kumar
1,2,3
, Glen Stecher
1
, and Koichiro Tamura*
,4,5
1
Institute for Genomics and Evolutionary Medicine, Temple University
2
Department of Biology, Temple University
3
Center for Excellence in Genome Medicine and Research, King Abdulaziz University, Jeddah, Saudi Arabia
4
Research Center for Genomics and Bioinformatics, Tokyo Metropolitan University, Hachioji, Tokyo, Japan
5
Department of Biological Sciences, Tokyo Metropolitan University, Hachioji, Tokyo, Japan
*Corresponding author: E-mail: ktamura@tmu.ac.jp
Associate editor: Joel Dudley
Abstract
We present the latest version of the Molecular Evolutionary Genetics Analysis (MEGA) software, which contains many
sophisticated methods and tools for phylogenomics and phylomedicine. In this major upgrade, MEGA has been optimized
for use on 64-bit computing systems for analyzing larger datasets. Researchers can now explore and analyze tens of
thousands of sequences in MEGA. The new version also provides an advanced wizard for building timetrees and includes a
new functionality to automatically predict gene duplication events in gene family trees. The 64-bit MEGA is made available
in two interfaces: graphical and command line. The graphical user interface (GUI) is a native Microsoft Windows
application that can also be used on Mac OS X. The command line MEGA is available as native applications for
Windows, Linux, and Mac OS X. They are intended for use in high-throughput and scripted analysis. Both versions
are available from www.megasoftware.net free of charge.
Key words: gene families, timetree, software, evolution.
Molecular Evolutionary Genetics Analysis (MEGA) software is now
being applied to increasingly bigger datasets (Kumar et al. 1994;
Tamura et al. 2013). This necessitated technological advance-
ment of the computation core and the user interface of MEGA.
Researchers also need to conduct high-throughput and scripted
analyses on their operating system of choice, which requires
that MEGA be available in native cross-platform implementation.
We have advanced the MEGA software suite to address these
needs of researchers performing comparative analyses of DNA
and protein sequences of increasing larger datasets.
Addressing the Need to Analyze Bigger Datasets
Contemporary personal computers and workstations pack
much greater computing power and system memory than
ever before. It is now common to have many gigabytes of mem-
ory with a 64-bit architecture and an operating system to match.
To harness this power in evolutionary analyses, we have ad-
vanced the MEGA source code to fully utilize 64-bit computing
resources and memory in data handling, file processing, and
evolutionary analytics. MEGA’s internal data structures have
been upgraded, and the refactored source code has been tested
extensively using automated test harnesses.
We benchmarked 64-bit MEGA7 performance using 16S ribo-
somal RNA sequence alignments obtained from the SILVA
rRNA database project (Quast et al. 2013;Yilmaz et al. 2014)
with thousands of sites and increasingly greater number of se-
quences (as many as 10,000). Figure 1 shows that their
computational analysis requires large amounts of memory
and computing power. For the Neighbor-Joining (NJ) method
(Saitou and Nei 1987), memory usage increased at a polynomial
rate as the number of sequences was increased. The peak mem-
ory usage was 1.7 GB for the full dataset of 10,000 rRNA se-
quences (fig. 1B). For the Maximum Likelihood (ML) analyses,
memory usage increased linearly and the peak memory usage
was at 18.6 GB (fig. 1D).Thetimetocompletethecomputation
(fig. 1Aand C)showedapolynomialtrendforNJandalinear
trend for ML. ML required an order of magnitude greater time
and memory. We also benchmarked MEGA7 for datasets with
increasing number of sites. Computational time and peak mem-
ory showed a linear trend. In addition, we compared the mem-
ory and time needs for 32- and 64-bit versions (MEGA6and
MEGA7, respectively), and found no significant difference for NJ
and ML analyses. This is primarily because both MEGA6and
MEGA7 use 8-byte floating point data types. However, the 32-
bit MEGA6 could only carry out ML analysis for fewer than 3,000
sequences of the same length. Therefore, MEGA7isasignificant
upgrade that does not incur any discernible computational or
resource penalty.
Upgrading the Tree Explorer
The ability to construct a phylogenetic tree of >10,000 se-
quences required a major upgrade of the Tree Explorer as well,
because it needed to display very large trees. This was accom-
plished by replacing the native Windows scroll box with a
Brief communication
ßThe Author(s) 2016. Published by Oxford University Press on behalf of the Society for Molecular Biology and Evolution.
All rights reserved. For permissions, please e-mail: journals.permissions@oup.com
Mol. Biol. Evol. doi:10.1093/molbev/msw054 Advance Access publication March 22, 2016 1
MBE Advance Access published April 13, 2016
at :: on April 19, 2016http://mbe.oxfordjournals.org/Downloaded from
custom virtual scroll box, which increased the number of taxa
that can be displayed in the Tree Explorer window from
4,000 in MEGA6 to greater than 100,000 sequences in
MEGA7. This is made possible by our new adaptive approach
to render the tree to ensure the best display quality and
exploration performance. To display a tree, we first evaluate
if the tree can be rendered as a device-dependent bitmap
(DDB), which depends on the power of the available graphics
processing unit. If successful, the tree image is stored in video
memory, which enhances performance. For example, in a
computer equipped with GeForce GT 640 graphics card,
Tree Explorer successfully rendered trees with more than
100,000 sequences and responded quickly to the user scroll-
ing and display changes. When a DDB is not possible to
generate, then Tree Explorer renders the tree as a device in-
dependent bitmap. Because of the extensive system memory
requirements, we automatically choose a pixel format that
maximizes the number of sequences displayed. Basically, the
pixel format dictates the number of colors used: 24 (2
24
colors), 18, 8, 4, or 1 bit (monochrome) per pixel. Memory
needs scale proportional to the number of bits used per pixel.
Cross-Platform MEGA-CC for High-Throughput and
Scripted Analyses
We have now refactored MEGA’s computation core (CC,
Kumar et al. 2012)sothatitcanbecompilednativelyfor
Linux, Windows, and Mac OS X systems in order to avoid the
need for emulation or virtualization. This required porting the
computation core source code to a cross-platform program-
ming language and replacing all the Microsoft Windows sys-
tem API calls. For instance, the App Linker system, which
integrates the MUSCLE (Edgar 2004) sequence alignment ap-
plication with MEGA, relied heavily on the Windows API for
inter-process communication and was refactored extensively.
In order to configure analyses in MEGA7-CC, we have chosen
to continue requiring an analysis options file (called .mao file)
that specifies all the input parameters to the command-line
driven MEGA-CC application; see figure 1 in Kumar et al. (2012).
To generate this control file, we provide native prototyper
applications (MEGA-PROTO) for Windows, Linux, and Mac OS
X. MEGA-PROTO obviates the need to learn a large number of
commands, and, thus, avoids a steep learning curve and po-
tential mistakes for inter-dependent options. It also enables us
to deliver exactly the same experience and options for those
who will use both GUI and CC versions of MEGA7.
Marking Gene Duplication Events in Gene Family Trees
We have added a new functionality in MEGA to mark tree
nodes where gene duplications are predicted to occur. This
system works with or without a species tree. If a species tree is
provided, then we mark gene duplications following Zmasek
and Eddy (2001) algorithm. This algorithm posits the smallest
number of gene duplications in the tree such that the min-
imum number of unobserved genes, due to losses or partial
sampling are invoked. When no species tree is provided, then
all internal nodes in the tree that contain one or more
FIG.1. Timeand memory requirements for phylogenetic analyses using the NJ method (A,B) and the ML analysis (C,D). For NJ analysis, we used the
Tamura–Nei (1993) model, uniform rates of evolution among sites, and pairwise deletion option to deal with the missing data. Time usage
increases polynomially with the number of sequences (third degree polynomial, R
2
¼1), as does the peak memory used (R
2
¼1) (A,B). The same
model and parameters were used for ML tree inference, where the time taken and the memory needs increased linearly with the number of
sequences. For ML analysis, the SPR (Subtree–Pruning–Regrafting) heuristic was used for tree searching and all 5,287 sites in the sequence
alignment were included. All the analyses were performed on a Dell Optiplex 9010 computer with an Intel Core-i7-3770 3.4 GHz processor, 20 GB
of RAM, NVidia GeForce GT 640 graphics card, and a 64-bit Windows 7 Enterprise operating system.
Kumar et al. .doi:10.1093/molbev/msw054 MBE
2
at :: on April 19, 2016http://mbe.oxfordjournals.org/Downloaded from
common species in the two descendant clades are marked as
gene duplication events. This algorithm provides a minimum
number of duplication events, because many duplication
nodes will remain undetected when the gene sampling is
incomplete. Nevertheless, it is useful for cases where species
trees are not well established.
Realizing that the root of the gene family tree is not always
obvious, MEGA runs the above analysis by automatically root-
ing the tree on each branch and selecting a root such that the
number of gene duplications inferred is minimized. This is
done only when the user does not specify a root explicitly. A
Gene Duplication Wizard (fig. 2)walkstheuserthroughallthe
necessary steps for this analysis. Results are displayed in the
Tree Explorer (fig. 3) which marks gene duplications with blue
solid diamonds. When a species tree is provided, speciation
events are marked with open red diamonds. Results can also
be exported to Newick formatted text files where gene du-
plications and speciation events are labeled using comments
in square brackets. In the future, we plan to extend this sys-
tem with the capability to automatically retrieve species tree
from external databases, including the NCBI Taxonomy
(http://www.ncbi.nlm.nih.gov/guide/taxonomy/) and the
timetree of life (Hedges et al. 2015).
Timetree System Updates
We have now upgraded the Timetree Wizard (similar to
the wizard shown in fig. 2), which guides researchers
through a multi-step process of building a molecular phy-
logeny scaled to time using a sequence alignment and a
phylogenetic tree topology. This wizard accepts Newick
formatted tree files, assists users in defining the out-
group(s) on which the tree will be rooted, and allows users
to set divergence time calibration constraints. Setting
time constraints in order to calibrate the final timetree
is optional in the RelTime method (Tamura et al. 2012), so
MEGA7 does not require that calibration constraints be
available and it does not assume a molecular clock. If no
calibrations are used, MEGA7 will produce relative diver-
gence times for nodes, which are useful for determining
the ordering and spacing of divergence events in species
and gene family trees. However, users can obtain absolute
divergence time estimates for each node by providing
FIG.2. The Gene Duplication Wizard (A) to guide users through the process of searching gene duplication events in a gene family tree. In the first
step, the user loads a gene tree from a Newick formatted text file. Second, species associated with sequences are specified using a graphical
interface. In the third step, the user has the option to load a trusted species tree, in which case it will be possible to identify all duplication events in
the gene tree, from a Newick file. Fourth, the user has the option to specify the root of the gene tree in a graphical interface. If the user provides a
trusted species tree, then they must designate the root of that tree. Finally, the user launches the analysis and the results are displayed in the Tree
Explorer window (see fig. 3).
Molecular Evolutionary Genetics Analysis .doi:10.1093/molbev/msw054 MBE
3
at :: on April 19, 2016http://mbe.oxfordjournals.org/Downloaded from
calibrations with minimum and/or maximum constraints
(Tamura et al. 2013). It is important to note that MEGA7
does not use calibrations that are present in the clade
containing the outgroup(s), because that would require
an assumption of equal rates of evolution between
the ingroup and outgroup sequences, which cannot be
tested. For this reason, timetrees displayed in the Tree
Explorer have the outgroup cluster compressed and
grayed out by default to promote correct scientific anal-
ysis and interpretation.
Data Coverage Display by Node
In the Tree Explorer, users will be able to display another set
of numbers at internal tree nodes that correspond to the
proportion of positions in the alignment where there is at
least one sequence with an unambiguous nucleotide or
amino acid in both the descendent lineages; see figure 5
in Filipski et al. (2014). This metric is referred to as mini-
mum data coverage and is useful in exposing nodes in the
tree that lack sufficient data to make reliable phylogenetic
inferences. For example, when the minimum data coverage
is zero for a node, then the time elapsed on the branch
connecting this node with its descendant node will always
be of zero, because zero substitutions will be mapped to
that branch (Filipski et al. 2014). This means that diver-
gence times for such nodes would be underestimated.
Such branches will also have very low statistical confidence
when inferring the phylogenetic tree. So, it is always good
to examine this metric for all nodes in the tree.
Conclusions
We have made many major upgrades to MEGA’s infrastructure
and added a number of new functionalities that will enable
researchers to conduct additional analyses with greater ease.
These upgrades make the seventh version of MEGA more ver-
satile than previous versions. For Microsoft Windows, the
64-bit MEGA is made available with Graphical User Interface
and as a command line program intended for use in high-
throughput and scripted analysis. Both versions are available
from www.megasoftware.net free of charge. The command
line version of MEGA7 is now available in native cross-platform
applications for Linux and Mac OS X also. The GUI version of
MEGA7 is also available for Mac OS X, where we provide an
installation that automatically configures the use of Wine for
compatibility with Mac OS X. Since Wine only supports 32-bit
software, we provide 32-bit MEGA7GUIforMacOSX.
However, Mac and Linux users can run the 64-bit Windows
version of MEGA7 GUI using virtual machine environments,
including VMWare, Parallels, or Crossover. Alternatively,
64-bit MEGA-CC along with MEGA-PROTO can be used as they
run natively on Windows, Mac OS X, and Linux.
Acknowledgments
We thank Charlotte Konikoff and Mike Suleski for extensively
testing MEGA7. Many other laboratory members and beta
testers provided invaluable feedback and bug reports. We
thank Julie Marin for help in assembling the rRNA data ana-
lyzed. This study was supported in part by research grants
from National Institutes of Health (HG002096-12 to S.K.) and
Japan Society for the Promotion of Science (JSPS) grants-in-
aid for scientific research (24370033) to K.T.
References
Edgar RC. 2004. Muscle: a multiple sequence alignment method with
reduced time and space complexity. BMC Bioinformatics 5:113.
Filipski A, Murillo O, Freydenzon A, Tamura K, Kumar S. 2014. Prospects
for building large timetrees using molecular data with incomplete
gene coverage among species. MolBiolEvol31:2542–2550.
Hedges SB, Marin J, Suleski M, Paymer M, Kumar S. 2015. Tree of life
reveals clock-like speciation and diversification. MolBiolEvol
32:835–845.
Kumar S, Stecher G, Peterson D, Tamura K. 2012. MEGA-CC:comput-
ing core of molecular evolutionary genetics analysis program
for automated and iterative data analysis. Bioinformatics
28:2685–2686.
KumarS,TamuraK,NeiM.1994.M
EGA: molecular evolutionary genet-
ics analysis software for microcomputers. Comput Appl Biosci
10:189–191.
Quast C, Pruesse E, Yilmaz P, Gerken J, Schweer T, Yarza P, Peplies J,
Glo¨ckner FO. 2013. The SILVA ribosomal RNA gene database proj-
ect: improved data processing and web-based tools. Nucleic Acids
Res 41:D590–D596.
Saitou N, Nei M. 1987. The neighbor-joining method—a new
method for reconstructing phylogenetic trees. MolBiolEvol
4:406–425.
Tamura K, Battistuzzi FU, Billing-Ross P, Murillo O, Filipski A, Kumar S.
2012. Estimating divergence times in large molecular phylogenies.
Proc Natl Acad Sci USA 109:19333–19338.
Tamura K, Nei M. 1993. Estimation of the number of nucleotide substi-
tutions in the control region of mitochondrial-DNA in humans and
chimpanzees. Mol Biol Evol 10:512–526.
FIG.3.Tree Explorer window with gene duplications marked with
closed blue diamonds and speciation events, if a trusted species
tree is provided, are identified by open red diamonds (see fig. 2 legend
for more information).
Kumar et al. .doi:10.1093/molbev/msw054 MBE
4
at :: on April 19, 2016http://mbe.oxfordjournals.org/Downloaded from
Tamura K, Stecher G, Peterson D, Filipski A, Kumar S. 2013. MEGA6:
molecular evolutionary genetics analysis version 6.0. MolBiolEvol
30:2725–2729.
Yilmaz P, Parfrey LW, Yarza P, Gerken J, Pruesse E, Quast C, Schweer T,
Peplies J, Ludwig W, Glockner FO. 2014. The SILVA and “All-species
Living Tree Project (LTP)” taxonomic frameworks. Nucleic Acids Res
42:D643–D648.
Zmasek CM, Eddy SR. 2001. A simple algorithm to infer gene dupli-
cation and speciation events on a gene tree. Bioinformatics
17:821–828.
Molecular Evolutionary Genetics Analysis .doi:10.1093/molbev/msw054 MBE
5
at :: on April 19, 2016http://mbe.oxfordjournals.org/Downloaded from
... For the three-dimensional representation of PCoA, the Python Data programme [31] was used, applying the Matplotlib strategy. The programme MEGA version 7 [32] was used for the phylogenetic trees and circular dendrograms (neighbour-joining method [33]). ...
Article
Full-text available
A prospection was carried out on Fuerteventura Island in order to explore the existing biodiversity of Vitis vinifera ssp. vinifera in almost desert conditions (<120 mm per year). For this purpose, 40 individuals were collected and genotyped with 20 SSRs. Nine known varieties and one unknown variety, named Majorera on the island, were identified. In addition, four new mutations were found in the varieties Listan negro and Listan prieto, respectively. Thirteen unknown individuals and five erratic accessions were identified. Seven new names are proposed for inclusion in the world databank (one main name (Majorera), one new synonym for Listan negro (Hoja moral), four new mutation names (Listan prieto de Antigua, Listan prieto de Vega, Hoja moral de El Rosario and Hoja moral de Betancuria) and a new synonymy for Muscat Hamburg (Moscatel), which is very widespread on the island). Finally, the possibility is raised that the new Majorera variety is not a pure vinifera but the product of an interspecific cross, as has happened with the variety found on the island of La Palma, Bienmesabe tinto. Once again, the Canary Archipelago shows itself to be a possible centre for the creation of biodiversity for the cultivated vine.
... accessed on 16 December 2021), and highly similar sequences were retrieved from GenBank for pairwise sequence analysis using the sequence demarcation tool [16]. Multiple sequence alignments were performed using MUSCLE, and phylogenetic tree was constructed in MEGAX using the neighborjoining algorithm, selecting the best-fit Kimura-2 parameter with 1000 bootstrap values [17]. Potential recombination events were verified using the RDP4 program with default settings and a cut-off value of p ≤ 0.05 [18]. ...
Article
Full-text available
Alternanthera yellow vein virus (AlYVV), a monopartite begomovirus, has been identified infecting a diverse range of crops and native plants in Pakistan, India, and China. However, distinctive yellow vein symptoms, characteristic of begomovirus infection, were observed on the Ageratum conyzoides weed in Oman, prompting a thorough genomic characterization in this study. The results unveiled a complete genome sequence of 2745 base pairs and an associated betasatellite spanning 1345 base pairs. In addition, Sequence Demarcation Tool analyses indicated the highest nucleotide identity of 92.8% with a previously reported AlYVV-[IN_abalpur_A_17:LC316182] strain, whereas the betasatellite exhibited a 99.8% nucleotide identity with isolates of tomato leaf curl betasatellite. Thus, our findings propose a novel AlYVV Oman virus (AlYVV-OM) variant, emphasizing the need for additional epidemiological surveillance to understand its prevalence and significance in Oman and the broader region. To effectively manage the spread of AlYVV-OM and minimize its potential harm to (agro)ecosystems, future research should focus on elucidating the genetic diversity of AlYVV-OM and its interactions with other begomoviruses.
... The Maximum Composite Likelihood method (Tamura et al. 2004) was used to calculate evolutionary distances, and all ambiguous positions were removed for each sequence pair using pairwise deletion option, resulting in a final dataset of 603 positions. MEGA11 (Kumar et al. 2016) was used for all evolutionary analyses. The overall mean distance (OMD), which represents the average evolutionary distance between all taxa, was calculated to understand the structure of the phylogenetic tree. ...
Article
Full-text available
The Thripidae family is a diverse group of insects with global distribution and significant economic importance as pests of agricultural crops. Accurate identification and classification of Thripidae species are critical for their effective management and control. To aid in this effort, DNA barcoding using the ITS gene region has proven to be an efficient and reliable tool for identifying and differentiating Thripidae species. The high variability rate of the ITS region makes it particularly effective for identifying and classifying closely related species, providing valuable insight for understanding and preserving the taxonomic diversity of the Thripidae family. The present study aims to explore the effectiveness of the ITS gene region for DNA barcoding of Kakothrips priesneri Pelikan species. For the first time, the ITS data obtained from this study showed the placement of Kakothrips priesneri in both common methods, using DNA barcoding (BLAST and MEGA), produced positive results for the ITS analysis, indicating that the region may be suitable for the Kakothrips species.
Article
Full-text available
Eight fungal strains (P1 to P8) were isolated from rapeseed stems (Brassica napus) infected with the blackleg pathogen Leptosphaeria biglobosa (Lb). They formed pycnidia with similar morphology to those of Lb, and thus were considered as Lb relatives (LbRs). The species-level identification of these strains was performed. Their virulence on rapeseed and efficacy in the suppression of Lb infection were determined, and the biocontrol potential and biocontrol mechanisms of strain P2 were investigated. The results showed that the LbRs belong to two teleomorphic genera in the family Didymellaceae, Didymella for P1 to P7 and Boeremia for P8. Pathogenicity tests on rapeseed cotyledons and stems indicated the LbRs were weakly virulent compared to L. biglobosa. Co-inoculation assays on rapeseed cotyledons demonstrated that P1 to P7 (especially P1 to P4) had a suppressive effect on Lb infection, whereas P8 had a marginal effect on infection by L. biglobosa. Moreover, D. macrostoma P2 displayed a more aggressive behavior than L. biglobosa in the endophytic colonization of healthy rapeseed cotyledons. Cultures of P2 in potato dextrose broth (PDB) and pycnidiospore mucilages exuded from P2 pycnidia showed antifungal activity to L. biglobosa. Further leaf assays revealed that antifungal metabolites (AM) of strain P2 from PDB cultures effectively suppressed infection by L. biglobosa, Botrytis cinerea (gray mold), and Sclerotinia sclerotiorum (white mold). An antifungal metabolite, namely penicillither, was purified and identified from PDB cultures and detected in pycnidiospore mucilages of strain P2. This study suggests that the LbRs are a repertoire for screening biocontrol agents (BCAs) against rapeseed diseases, and D. macrostoma P2 is a multi-functional BCA, a penicillither producer, and an endophyte.
Article
Full-text available
Commercial harvesting of American ginseng (Panax quinquefolius) results in root debris in the soil, but the rate of decay is unknown. In this study, post-harvest root debris decayed mostly over the fall and winter, with almost no ginseng debris remaining in the soil by late spring of the following year. However, a small number of intact pencil-shaped roots were able to survive after harvest and sprout the following spring without any evidence of root decay. Root rot lesions were observed, which included many associated with the root rot pathogen Ilyonectria mors-panacis, with disappearing root rot symptoms observed in the following spring. Ginsenosides in soil were highest just prior to harvest, declining until an increase the following spring. Soil bacterial and fungal populations changed over time after harvest with several peaks in bacterial populations mostly in the fall, but this was less clear for fungal populations, which were dominated by only a few taxa. Harvesting ginseng can leave considerable debris in the soil, impacting its chemistry and microbiota. Ginseng replant disease, where the second crop shows high levels of root rot due to I. mors-panacis infection compared to low levels in the first crop, could be related to the decay of post-harvest crop debris, but additional research is needed to demonstrate this.
Article
Full-text available
The stimulator of interferon genes (STING) is a central and multifaceted mediator in innate immunity, and plays vital roles in defending against pathogen infection. In this study, we identified and functionally characterized the STING homolog from the Chinese giant salamander Andrias davidianus (AdSTING) for the first time. The open reading frame of AdSTING encodes a 362 amino acid protein with a predicted molecular mass of 41.6 kDa, which shares 31.1–46.7% of its sequence identity with STING homologs in other vertebrates. Structural analysis revealed that AdSTING possesses four predicted transmembrane domains (TMs) at the N-terminal, and a C-terminal domain (CTD) featuring a dimerization domain (DD), a c-di-GMP-binding domain (CBD), and a short C-terminal tail (CTT). Tissue distribution analysis showed that AdSTING mRNA was ubiquitously expressed in all examined tissues, with abundant expression in muscles, intestine, and thymus. During Andrias davidianus ranavirus (ADRV) infection, significant up-regulation of AdSTING expression was observed in the thymus, spleen, and kidney. Upon different stimuli in vitro, the expression of AdSTING was significantly induced by ADRV infection or polyinosin-polycytidylic acid (poly I:C) stimulation, but no obvious changes were observed during lipopolysaccharide (LPS) stimulation. Subcellular localization analysis revealed that AdSTING mainly localized in the cytoplasm in the Chinese giant salamander thymus cell line (GSTC) and co-localized with the endoplasmic reticulum (ER). Luciferase reporter assays confirmed the ability of AdSTING to activate the interferon-stimulated response element (ISRE) and interferon (IFN) promoter. Furthermore, overexpression of AdSTING effectively decreased ADRV infection, as evidenced by the reduction of virus titers and viral gene expression. Collectively, our findings underscore the pivotal role of AdSTING in the antiviral innate immunity of the Chinese giant salamander, offering insights into the functional evolution of STING in amphibians.
Article
Two novel Pseudomonas strains, SA3-5 T and SA3-6, were isolated from a tidal flat (getbol) in the Republic of Korea. Strains SA3-5 T and SA3-6 were subjected to polyphasic characterization to determine their taxonomic affiliations. Cells were Gram-stain-negative, aerobic, rod-shaped and motile by using peritrichous flagella. Based on their 16S rRNA gene sequences, strains SA3-5 T and SA3-6 exhibited a high degree of similarity (100 %) and were classified within the genus Pseudomonas . Furthermore, the closest related species to SA3-5 T and SA3-6 were Pseudomonas taeanensis MS-3 T (98.3 %). The ranges of average nucleotide identity and digital DNA–DNA hybridization values between SA3-5 T and closely related species were 75.9–89.1% and 21.3–38.7%, respectively, both of which being below the thresholds for delineating novel strains. Strain SA3-5 T and SA3-6 contained C 16 : 1 ω 6 с and/or C 16 : 1 ω 7 с (summed feature 3), C 16 : 0 and C 18 : 1 ω 6 с and/or C 18 : 1 ω 7 с (summed feature 8) as the major fatty acids. The predominant respiratory quinone was Q-9. The DNA G+C content of strain SA3-5 T was 62.5 mol%. Based on their combined phenotypic, chemotaxonomic and phylogenetic characterisitics, strains SA3-5 T and SA3-6 represent a novel species of the genus Pseudomonas for which the name Pseudomonas aestuarii sp. nov. is proposed. The type strain is SA3-5 T (=KCTC 92395 T =JCM 35697 T ).
Article
Full-text available
Genomic data are rapidly resolving the tree of living species calibrated to time, the timetree of life, which will provide a framework for research in diverse fields of science. Previous analyses of taxonomically restricted timetrees have found a decline in the rate of diversification in many groups of organisms, often attributed to ecological interactions among species. Here we have synthesized a global timetree of life from 2,274 studies representing 50,632 species and examined the pattern and rate of diversification as well as the timing of speciation. We found that species diversity has been mostly expanding overall and in many smaller groups of species, and that the rate of diversification in eukaryotes has been mostly constant. We also identified, and avoided, potential biases that may have influenced previous analyses of diversification including low levels of taxon sampling, small clade size, and the inclusion of stem branches in clade analyses. We found consistency in time-to-speciation among plants and animals-approximately two million years-as measured by intervals of crown and stem species times. Together, this clock-like change at different levels suggests that speciation and diversification are processes dominated by random events and that adaptive change is largely a separate process. © The Author(s) 2015. Published by Oxford University Press on behalf of the Society for Molecular Biology and Evolution.
Article
Full-text available
Scientists are assembling sequence data sets from increasing numbers of species and genes to build comprehensive timetrees. However, data are often unavailable for some species and gene combinations, and the proportion of missing data is often large for data sets containing many genes and species. Surprisingly, there has not been a systematic analysis of the effect of the degree of sparseness of the species-gene matrix on the accuracy of divergence time estimates. Here, we present results from computer simulations and empirical data analyses to quantify the impact of missing gene data on divergence time estimation in large phylogenies. We found that estimates of divergence times were robust even when sequences from a majority of genes for most of the species were absent. From the analysis of such extremely sparse data sets, we found that the most egregious errors occurred for nodes in the tree that had no common genes for any pair of species in the immediate descendant clades of the node in question. These problematic nodes can be easily detected prior to computational analyses based only on the input sequence alignment and the tree topology. We conclude that it is best to use larger alignments, since adding both genes and species to the alignment augments the number of genes available for estimating divergence events deep in the tree, and improves their time estimates.
Article
Full-text available
SILVA (from Latin silva, forest, http://www.arb-silva.de) is a comprehensive resource for up-to-date quality-controlled databases of aligned ribosomal RNA (rRNA) gene sequences from the Bacteria, Archaea and Eukaryota domains and supplementary online services. SILVA provides a manually curated taxonomy for all three domains of life, based on representative phylogenetic trees for the small- and large-subunit rRNA genes. This article describes the improvements the SILVA taxonomy has undergone in the last 3 years. Specifically we are focusing on the curation process, the various resources used for curation and the comparison of the SILVA taxonomy with Greengenes and RDP-II taxonomies. Our comparisons not only revealed a reasonable overlap between the taxa names, but also points to significant differences in both names and numbers of taxa between the three resources.
Article
Full-text available
We announce the release of an advanced version of the Molecular Evolutionary Genetics Analysis (MEGA) software, which currently contains facilities for building sequence alignments, inferring phylogenetic histories, and conducting molecular evolutionary analysis. In version 6.0, MEGA now enables the inference of timetrees, as it implements our RelTime method for estimating divergence times for all branching points in a phylogeny. A new Timetree Wizard in MEGA6 facilitates this timetree inference by providing a graphical user interface (GUI) to specify the phylogeny and calibration constraints step-by-step. This version also contains enhanced algorithms to search for the optimal trees under evolutionary criteria and implements a more advanced memory management that can double the size of sequence data sets to which MEGA can be applied. Both GUI and command-line versions of MEGA6 can be downloaded from www.megasoftware.net free of charge.
Article
Full-text available
SILVA (from Latin silva, forest, http://www.arb-silva.de) is a comprehensive web resource for up to date, quality-controlled databases of aligned ribosomal RNA (rRNA) gene sequences from the Bacteria, Archaea and Eukaryota domains and supplementary online services. The referred database release 111 (July 2012) contains 3 194 778 small subunit and 288 717 large subunit rRNA gene sequences. Since the initial description of the project, substantial new features have been introduced, including advanced quality control procedures, an improved rRNA gene aligner, online tools for probe and primer evaluation and optimized browsing, searching and downloading on the website. Furthermore, the extensively curated SILVA taxonomy and the new non-redundant SILVA datasets provide an ideal reference for high-throughput classification of data from next-generation sequencing approaches.
Article
Full-text available
Molecular dating of species divergences has become an important means to add a temporal dimension to the Tree of Life. Increasingly larger datasets encompassing greater taxonomic diversity are becoming available to generate molecular timetrees by using sophisticated methods that model rate variation among lineages. However, the practical application of these methods is challenging because of the exorbitant calculation times required by current methods for contemporary data sizes, the difficulty in correctly modeling the rate heterogeneity in highly diverse taxonomic groups, and the lack of reliable clock calibrations and their uncertainty distributions for most groups of species. Here, we present a method that estimates relative times of divergences for all branching points (nodes) in very large phylogenetic trees without assuming a specific model for lineage rate variation or specifying any clock calibrations. The method (RelTime) performed better than existing methods when applied to very large computer simulated datasets where evolutionary rates were varied extensively among lineages by following autocorrelated and uncorrelated models. On average, RelTime completed calculations 1,000 times faster than the fastest Bayesian method, with even greater speed difference for larger number of sequences. This speed and accuracy will enable molecular dating analysis of very large datasets. Relative time estimates will be useful for determining the relative ordering and spacing of speciation events, identifying lineages with significantly slower or faster evolutionary rates, diagnosing the effect of selected calibrations on absolute divergence times, and estimating absolute times of divergence when highly reliable calibration points are available.
Article
Full-text available
There is a growing need in the research community to apply the molecular evolutionary genetics analysis (MEGA) software tool for batch processing a large number of datasets and to integrate it into analysis workflows. Therefore, we now make available the computing core of the MEGA software as a stand-alone executable (MEGA-CC), along with an analysis prototyper (MEGA-Proto). MEGA-CC provides users with access to all the computational analyses available through MEGA's graphical user interface version. This includes methods for multiple sequence alignment, substitution model selection, evolutionary distance estimation, phylogeny inference, substitution rate and pattern estimation, tests of natural selection and ancestral sequence inference. Additionally, we have upgraded the source code for phylogenetic analysis using the maximum likelihood methods for parallel execution on multiple processors and cores. Here, we describe MEGA-CC and outline the steps for using MEGA-CC in tandem with MEGA-Proto for iterative and automated data analysis. http://www.megasoftware.net/ s.kumar@asu.edu.
Article
Full-text available
A computer program package called MEGA has been developed for estimating evolutionary distances, reconstructing phylogenetic trees and computing basic statistical quantities from molecular data. It is written in C++ and is intended to be used on IBM and IBM-compatible personal computers. In this program, various methods for estimating evolutionary distances from nucleotide and amino acid sequence data, three different methods of phylogenetic inference (UPGMA, neighbor-joining and maximum parsimony) and two statistical tests of topological differences are included. For the maximum parsimony method, new algorithms of branch-and-bound and heuristic searches are implemented. In addition, MEGA computes statistical quantities such as nucleotide and amino acid frequencies, transition/transversion biases, codon frequencies (codon usage tables), and the number of variable sites in specified segments in nucleotide and amino acid sequences. Advanced on-screen sequence data and phylogenetic-tree editors facilitate publication-quality outputs with a wide range of printers. Integrated and interactive designs, on-line context-sensitive helps, and a text-file editor make MEGA easy to use.
Article
A new method called the neighbor-joining method is proposed for reconstructing phylogenetic trees from evolutionary distance data. The principle of this method is to find pairs of operational taxonomic units (OTUs [= neighbors]) that minimize the total branch length at each stage of clustering of OTUs starting with a starlike tree. The branch lengths as well as the topology of a parsimonious tree can quickly be obtained by using this method. Using computer simulation, we studied the efficiency of this method in obtaining the correct unrooted tree in comparison with that of five other tree-making methods: the unweighted pair group method of analysis, Farris's method, Sattath and Tversky's method, Li's method, and Tateno et al.'s modified Farris method. The new, neighbor-joining method and Sattath and Tversky's method are shown to be generally better than the other methods.