Skip to main content

GWAMAR: Genome-wide assessment of mutations associated with drug resistance in bacteria

Abstract

Background

Development of drug resistance in bacteria causes antibiotic therapies to be less effective and more costly. Moreover, our understanding of the process remains incomplete. One promising approach to improve our understanding of how resistance is being acquired is to use whole-genome comparative approaches for detection of drug resistance-associated mutations.

Results

We present GWAMAR, a tool we have developed for detecting of drug resistance-associated mutations in bacteria through comparative analysis of whole-genome sequences. The pipeline of GWAMAR comprises several steps. First, for a set of closely related bacterial genomes, it employs eCAMBer to identify homologous gene families. Second, based on multiple alignments of the gene families, it identifies mutations among the strains of interest. Third, it calculates several statistics to identify which mutations are the most associated with drug resistance.

Conclusions

Based on our analysis of two large datasets retrieved from publicly available data for M. tuberculosis, we identified a set of novel putative drug resistance-associated mutations. As a part of this work, we present also an application of our tool to detect putative compensatory mutations.

Background

The development of drug resistance in bacteria makes antibiotics less effective and increases the costs of therapies. This problem has drawn the attention of major health organizations such as WHO (World Health Organization), ECDC (European Centre for Disease Prevention and Control) and CDC (Centers for Disease Control and Prevention) which monitor and report the epidemics of drug resistance in the world [1, 2].

Over a few decades of research on drug resistance, several drug-resistance mechanisms have been discovered such as alteration of a drug's binding site, reduced accumulation of a drug, and specialized enzymes to degrade drug molecules [3]. These mechanisms may be acquired either through chromosomal mutations or horizontal gene transfer.

There are many mutations reported in various studies as associated with drug resistance mechanisms. However, the information is spread throughout the literature and not easy to access. One attempt to collect the information on genetic features associated with drug resistance into a database is the Antibiotic Drug Resistance Database (ARDB) [4]. However, this database focuses on genes associated with drug resistance rather than particular point mutations within them. Another species-specific database of drug resistance-associated mutations in M. tuberculosis is the Tuberculosis Drug Resistance Mutation Database (TBDReaMDB) [5]. This database provides detailed information on a set of 1230 associations between drugs and point mutations. Furthermore, it distinguishes a subset of high-confidence mutations which were often reported in literature.

The process of acquisition of drug resistance is often associated with some additional cost, called fitness, which reduces the general viability of the bacteria [6, 7]. However, this effect may be reversed completely or partially by secondary mutations, called compensatory mutations [7, 8]. Consequently, the evolutionary process of acquiring multiple drug resistance happens in a sequence of steps rather than simultaneously [9–11]. Thus, in order to better understand the process, it is important to identify not only the primary mutations responsible directly for drug resistance, but also those secondary mutations allowing for gradual accumulation of drug resistance.

Since the number of bacterial genomes being sequenced and publicly available sequencing data grows rapidly [12], it opens new possibilities for using large-scale computational approaches for identifying drug resistance-associated mutations.

In our previous work, we presented an approach to use whole-genome comparative approach for identification of drug resistance-associated mutations [13]. We proposed a new computational scoring scheme, called weighted support, which uses phylogenetic information for identifying the drug resistance-associated mutations. In order to test our approach, we used publicly available sequencing data for 100 strains of Staphylococcus aureus and collected phenotype data from over 70 articles. Our experiment suggested that weighted support outperforms other standard measures such as mutual information and odds ratio.

In the current work, we present GWAMAR, a tool for identifying of drug resistance-associated mutations based on comparative analysis of whole-genome sequences of closely related bacterial strains. This tool is designed as a pipeline. It first employs eCAMBer, our previously published tool [14], to identify point mutations among the set of considered genomes. These mutations constitute the genotype data. Then, GWAMAR tries to find the associations between the input phenotype and genotype data by computing several statistical scores. As a part of this work, we also designed a new statistical score, viz tree-generalized hypergeometric score (TGH).

The rational for incorporating phylogenetic information into TGH and weighted support is based on our observation that subtrees of the phylogenetic tree very often correspond to geographic locations. Since drug resistance mutations are subject to evolutionary pressure caused by the drug treatment they should be independent of geographic location and therefore be more widely distributed over the tree, as opposed to mutations driven by other environmental factors which tend to rather concentrate in small subtrees.

In order to test our approach, we run GWAMAR on two large datasets for M. tuberculosis. The first dataset is prepared for the set of 173 strains with genome sequences and annotations publicly available in the PATRIC database [15]. And for this set of strains, we collected drug resistance information from over 20 publications. The genotype and phenotype data for the second dataset comes from the M. tuberculosis Drug Resistance Directed Sequencing Database.

Methods

We present details of GWAMAR in this section, including the problem setting, the preprocessing of input data and the computation of the association scores between the drug resistance phenotypes and point mutations.

Problem setting

We consider a set S of closely related bacterial genomes. Typically, this is a set of strains within the same species of bacteria.

Then, we represent the available drug resistance information as a set of drug-resistance profiles R , where each drug resistance profile r ∈ R is represented as a vector:

r : S → { S , I , R , ? } .

Here, S, I, R denote that a given strain is known to be drug susceptible, intermediate-resistant, or resistant, respectively. Using question mark ‵ ? ′ we indicate that the drug resistance status of a strain is unknown. We call a drug resistance profile complete if it does not contain question marks.

Analogously, we represent the genotype data as a set of mutations M , where each mutation m ∈ M is represented as a triple (g, p, v), where g,p,v denote the gene family identifier, the position of the mutation in its corresponding multiple alignment, and the mutation profile, respectively. The mutation profile is represented as a vector:

v : S → ∑ ∪ { ? } .

Here Σ denotes the set of amino acides (for protein-coding genes) or nucleotides (for promoters and rRNA coding genes). We also assume that Σ contains the gap '-' symbol. Using question mark ‵ ? ′ we indicate that the corresponding amino acid or nucleotide is unknown. Analogously, we call a mutation profile complete if it does not contain question marks.

It should be noted that potentially multiple mutations at different positions in the genome may have identical mutation profiles. Moreover, it may happen that multiple mutations may correspond to the same set of mutated strains. In that situation the mutations would essentially carry the same information about the profiles. Thus, we also introduce an auxiliary concept called binary mutation profile. Let r∈S denote the reference strain and s∈S denote any strain. Then, for a given mutation profile v its corresponding binary mutation profile is defined as follows:

b ( s ) = ? i f v(s) = ? 0 if v(s) = v(r) 1 otherwise

Analogous to mutation profiles, we call a binary mutation profile complete if it does not contain question marks.

Finally, we define the aim of the tool as: To produce an ordered list of associations between the phenotype and genotype data (represented as drug resistance and mutation profiles) such that the top-scored associations are the most likely to be real.

The pipeline of GWAMAR

Figure 1 illustrates the overall design of the tool. Data preprocessing for GWAMAR consists of several steps which may be performed by our previously developed tool, eCAMBer [14]. These preprocessing steps comprise:

Figure 1
figure 1

Schema of the GWAMAR pipeline. For a set of considered bacterial strains, the input data for GWAMAR consists of (i) a set of mutations; (ii) a set of drug resistance profiles; and (iii) phylogenetic tree for the set of bacterial strains. Typically the set of mutation profiles is generated using eCAMBer, which is able to download the genome sequences and annotations for the set of bacterial strains, identify point mutations based on multiple alignments, and reconstruct the phylogenetic tree of the considered bacterial strains. The first step of GWAMAR is to compute binary mutation profiles for all point mutations. This step significantly reduces the number of genetic profiles considered. Finally, GWAMAR implements several statistical scores to associate drug resistance profiles with mutation profiles. These include: mutual information, odds ratio, hypergeometric test, weighted support and tree-generalized hypergeometric score (TGH). As a result, we obtain ordered lists of drug resistance associations, where the top scored associations are the most likely to be real.

  • download genome sequences of multiple bacterial strains,

  • unification of gene annotations,

  • identification of homologous gene families,

  • multiple alignments of the gene families (employing MUSCLE),

  • reconstruction of the phylogenetic tree (employing PHYLIP),

  • identification of point mutations based on the multiple alignments.

The input drug-resistance profiles, typically, are collected from the articles or databases which provide drug-resistance information for the strains of interest. The set of identified point mutations, the set of drug-resistance profiles and and the phylogenetic tree constitute the input for GWAMAR.

In the next step, GWAMAR computes binary mutation profiles for each mutation profile. This step significantly reduces the number of genetic profiles to be scored. Finally, GWAMAR computes several statistical scores to associate drug-resistance profiles to the mutation profiles, including mutual information, odds ratio, hypergeometric test, weighted support (which is our previously published approach [13]), and the tree-generalized hypergeometric score (our new approach here).

Tree-generalized hypergeometric score

As a part of this work we also introduce a new association score, called tree-generalized hypergeometric score (TGH ). This score is a modification of the CCTSWEEP score introduced in the paper [16]. In this section, we consider a subset of strains S for which a given drug-resistance profile r and a binary mutation profile b are complete, i.e. do not contain question marks. Moreover, we assume that r does not contain any intermediate-resistant strains. In all our computational experiments we transform the intermediate-resistant strains into resistant strains.

In order to present the formal definition of TGH, we first define an auxiliary concept called coloring. For a given tree T , we call a subset c of its nodes a coloring, if it satisfies the following two conditions:

  • each path from a leaf to the root contains at most one node from c,

  • each internal node in c has a sibling node which does not belong to c.

Here we also introduce a function L which, for each node ω, returns the set of descendants of the node, including the node itself. We say these nodes are visible from ω. Additionally, the function L applied to a coloring c returns the union of all nodes visible from nodes in c.

Let C T denote the set of all colorings of T . Then, for each complete drug-resistance profile r there exists exactly one coloring ĉ such that the set of leaves visible from ĉ equals the set of drug-resistant nodes in r. We say this coloring is induced by the drug-resistance profile. Analogously, for each complete binary mutation profile b there is exactly one induced coloring c ¯ .

Intuitively, the coloring induced by a given complete drug-resistance profile will contain the set of nodes in which drug-resistance was acquired (assuming a model in which drug-resistance cannot be reversed). Analogously, the coloring induced by a given binary mutation profile will contain the set of nodes in which the mutation was acquired.

Figure 2 (A) presents an example of colorings induced by a given drug-resistance profile (large red nodes) and a given binary mutation profile (small orange nodes) for a flat tree. In that situation the colorings may be interpreted as independent drawing of balls as in the standard hypergeometric distribution model. Knowing this property of TGH we proposed its name as it generalizes the standard hypergeometric test in the case of a flat tree. Figure 2 (B) presents another example of colorings induced by the same pair of profiles, but for a tree which is not flat. In this model the dependencies between different strains are captured by the topology of the tree.

Figure 2
figure 2

Example colorings for the TGH score. (A) an example of coloring ĉ induced by a given drug-resistance profile (large red nodes) and coloring c ¯ induced by a given binary mutation profile (small orange nodes) for a flat tree. In this example |ĉ|=5,| c ¯ |=3 and |L ( ĉ ) ∩ c ¯ |=3. (B) another example of colorings ĉ and c ¯ induced by the same pair of profiles but for a different tree. In this example |ĉ|=3,| c ¯ |=2 and |L ( ĉ ) ∩ c ¯ |=2|

Let us now assume we want to compute the TGH score for a pair of complete drug-resistance profile r and complete binary mutation profile b. Let us additionally assume that the size of coloring c ¯ induced by b equals n. Morover, let the number of nodes in coloring c ¯ visible from the coloring ĉ equals k. This value can be interpreted as the number of times the considered mutation was acquired not earlier than the resistance was acquired.

Now, let V T (n) denote the number of colorings of size n:

V T ( n ) = # { c ∈ C T : | c | = n }

V T (n) may be interpreted as the total number of binary mutation profiles for which the induced coloring is of the same size as for c ¯ .

Then, let B T, ĉ (k, n) denote the number of colorings of size n, such that exactly k nodes of that coloring are visible from nodes of coloring ĉ.

B T , ĉ ( k , n ) = # { c ∈ C T : | L ( ĉ ) ∩ c | = k and | c | = n }

Here, the value B T, ĉ (k, n) may be interpreted as the number of binary mutation profiles such that their induced coloring has n elements, out of which k is visible from the nodes in ĉ.

Finally, for the complete drug-resistance profile r and complete binary mutation profile b, which induce colorings ĉ and c ¯ , respectively, we define the TGH score as follows:

H T ( r , b ) = - log ∑ i = k n B T , ĉ ( i , n ) V T ( n )

Here, we take the negative logarithm to have consistent property for all considered scoring methods, such that the higher the score the more likely drug-resistance profile r is associated with binary mutation profile b.

Time complexity

Let D denote the number of drug-resistance profiles considered. Additionally, let N denote the number of considered strains and M denote the number of binary mutation profiles. Finally, let K denote the maximal number of children of an internal node in the tree. Then, the time complexity of the algorithms we implemented to compute the hypergeometic score, the mutual information, odds ratio, and weighted support is O(D N M ). In order to compute TGH, we implement a dynamic programing algorithm which computes the values B ω,ĉ (k, n) for each internal node ω, k and n. This strategy gives an algorithm with complexity O(D·N K−1·N2 +D·N·M ). For the brevity of the presentation we skip details of the algorithm.

Results and discussion

We now present and discuss results we obtained applying GWAMAR on the two datasets we prepared for M. tuberculosis.

In all the following analyzes we use the set of mutations classified as high-confidence mutations in Tuberculosis Drug Resistance Mutation Database (TBDReaMDB) as our gold standard [5]. In total the database contains 88 of high-confidence associations spanning 27 genes and six drugs or drug families: Fluoroquinolones, Ethambutol, Isoniazid, Pyrazinamide, Rifampicin and Streptomycin.

Mtu173 case study

The first case study is based on the set of 173 fully sequenced strains of M. tuberculosis with publicly available data.

The preprocessing steps of preparing the genotype data were performed using eCAMBer, our previously published tool to support comparative analysis of multiple bacterial strains [13].

In particular, first, we used eCAMBer to download the genome sequences and annotations from the PATRIC database [15]. Next, we applied eCAMBer to unify the genome annotations of protein-coding genes and to identify the clusters of genes with high sequence similarity. Then, for the subset of 4379 such identified gene clusters with genes present in at least 90% of the strains, we computed multiple alignments using MUSCLE [17]. The multiple alignments were computed for amino-acid sequences of protein-coding genes, as well as nucleotide sequences of their promoter regions, and rRNA genes. Finally, based on the computed multiple alignments, we identified 118913 non-synonymous point mutations. The set of identified point mutations constituted the input genotype data for GWAMAR.

The input phenotype data was collected from over 20 publications issued together with the fully sequenced genomes. Additional file 1 shows the drug-resistance status of the strains retrieved from literature together with references. Based on the drug-resistance information collected for Ciprofloxacin and Ofloxacin, we introduced a new drug-resistance profile for Fluoroquinolones. A strain is categorized as susceptible to Fluoroquinolones if it was susceptible to at least one of the drugs, but not resistant to any of them. Similarly, a strain was categorized as resistant to Fluoroquinolones if it was resistant to at least one of the drugs, but not susceptible to any of them. If none of the cases was satisfied for a strain, then the drug-resistance status of the strain was categorized as unknown. We restrict further analysis to the set of six drugs or drug families: Fluoroquinolones, Ethambutol, Isoniazid, Pyrazinamide, Rifampicin and Streptomycin.

The input phylogenetic tree was reconstructed using the maximum-likelihood approach implemented in the PHYLIP package. As an input for the tool we used the set of all the identified mutations concatenated into one multiple alignment file. Additional file 2 presents the reconstructed phylogenetic tree.

Table 1 presents the list of top 20 associations ordered according to TGH score. In the set of 20 top-scoring associations, 15 are present in the TBDReaMDB database and 13 of them are categorized as high-confidence mutations. A closer look at the mutations which are not present in TBDReaMDB revealed that some of them can be supported by literature. In particular, mutation E504G/D in embB has recently been reported as associated with resistance to Ethambutol [18]. Similarly, the mutation T539I has already been associated with resistance to Fluoroquinolones [19].

Table 1 20 top-scoring associations between drug-resistance profiles and point mutations in the case study on 173 fully sequenced M.tuberculosis strains.

Literature search did not provide us any additional support for the remaining three mutations (A505T in embB, D869G in embB and G1108C in rrs), which haven't been reported in TBDReaMDB. These mutations may potentially be false positives or real drug-resistance-associated mutations.

Mtu_broad case study

The second case study, mtu_broad, is based on the data available in the Broad Institute database http://www.broadinstitute.org/annotation/genome/mtb_drug_resistance.1/. This database contains provides sequencing data and drug-resistance information for 1398 strains of M. tuberculosis. However, it should be noted that only genes of interest were sequenced. Table 2 presents the list of 28 sequenced genes for each strain. Additionally 12 promoter sequences were sequenced. In total, this database contains 1069 mutations (non-synonymous amino-acid changes or nucleotide changes in promoters).

Table 2 List of sequenced genes and promoters available in the mtu_broad dataset.

Similar to the previous case study, based on the drug-resistance information available in the database for Ciprofloxacin, Ofloxacin, Levofloxacin and Moxifloxacin, we introduced a new drug-resistance profile for Fluoroquinolones. A strain was categorized as susceptible to Fluoroquinolones if it was susceptible to at least one of the drugs, but not resistant to any of them. Similarly, a strain was categorized as resistant to Fluoroquinolones if it was resistant to at least one of the drugs, but not susceptible to any of them. If none of the cases was satisfied for a strain, then the drug-resistance status of the strain was categorized as unknown. We restrict further analysis to the set of six drugs or drug families: Fluoroquinolones, Ethambutol, Isoniazid, Pyrazinamide, Rifampicin and Streptomycin.

Similarly, as in the previous case study, the phylogenetic tree was reconstructed using the maximum-likelihood approach implemented in the PHYLIP package. As an input for the tool we used the set of all available mutations concatenated into one multiple alignment file.

Table 3 presents the list of the top 20 associations ordered according to TGH score. In the set of 20 top-scoring associations, 19 are present in TBDReaMDB and 15 of them are categorized as high-confidence mutations.

Table 3 20 top-scoring associations between drug-resistance profiles and point mutations in the case study for 1398 partially sequenced M.tuberculosis strains.

A closer look at the mutation D89G/N, which is not present in TBDReaMDB, reveals that the mutation has recently been associated with resistance to Fluoroquinolones [20].

The set of associations provides some additional support for the four mutations which were present in TBDReaMDB, but not categorized as high-confidence.

Assessment of accuracy

Here we use the two datasets described above to assess the accuracy of the various association scores, viz: mutual information, odds ratio, hypergeometric score, weighted support and TGH. The CCTSWEEP software might contain some bugs and did not produce correct output. Its authors had not responded to our queries in time. So we omitted it from our experiments.

As our gold standard we use the set of 88 drug-resistance associations classified as high-confidence in the Tuberculosis Drug Resistance Mutation Database (TBDReaMDB) [5].

In both case studies, as the set of positives, we assume the subset of high-confidence mutations present in TBDReaMDB, which are also present in the genotype data. This is the set of mutations which may be potentially detected using the available datasets. There are 39 and 75 of such associations for the mtu173 and mtu_broad datasets, respectively. The set of negatives is constructed by random sampling from the whole set of identified putative associations except for the associations which are classified as positives. The number of sampled negatives equals the total number of mutations present in genes which has at least one high-confidence mutation. We use this approach in order to significantly reduce the probability of classifying as negatives associations which are real but not present in the database.

Figure 3 presents precision and recall curves for different association scores. Consistently, results on both datasets suggest that tree-aware scores outperform tree-ignorant scores.

Figure 3
figure 3

Comparison of accuracy. Precision-recall curves for comparison of different association scores implemented in GWAMAR. Left panel presents results for the mtu173 dataset; right for the mtu_broad dataset. Numbers present in the square brackets display the Area Under the Curve (AUC) for the scores. In both case studies tree-aware statistics (weighted support and TGH) achieve better performance the the tree-ignorant statistics.

Rifampicin resistance and compensatory mutations

It is commonly known that Rifampicin resistance in M. tuberculosis gets acquired by point mutations within the RRDR region which corresponds to the Rifampicin binding spot [21]. However, these mutations are often associated with deleterious effect on bacteria fitness [22]. This effect may be potentially reversed by compensatory mutations. Recently, three new papers have been released, focusing on identifying putative compensatory mutations within rpoA, rpoB and rpoC genes [23–25].

Figure 4 presents the distribution of the putative compensatory mutations identified in these recent studies, put together with mutations identified based on our two case studies.

Figure 4
figure 4

Compensatory mutations. Distribution of putative compensatory mutations with the rpoA, rpoB and rpoC genes. Position of each mutation is indicated by a vertical line.

Interestingly, several mutations identified by our approach have also been reported in at least one of the papers [23–25].

  • rpoA: G31S/A

  • rpoB: P45S/L, L731P, E761D, R827C, H835P/R

  • rpoC: G332R/S, V431M, G433C/S, V483G/A, W484G, I491T/V, L527V, N698K, A734V

Additional file 3 contains the detailed table with the complete list of putative compensatory mutations.

Conclusion

In this work we presented GWAMAR, a tool we have developed for identifying of drug-resistance associated mutations based on comparative analysis of whole-genome sequences in bacterial strains.

The tool is designed as an automatic pipeline which employs eCAMBer, our previously published tool [14], for preprocessing of data. This preprocessing includes: (i) download of genome sequences and gene annotations, (ii) unification of gene annotations among the set of considered strains, (iii) identification of gene families, (iv) computation of multiple alignments and identification of point mutations which constitute the input genotype data.

GWAMAR implements various statistical methods--such as mutual information, odds ratio, hypergeometric test and weighted support [13]-- to associate the drug-resistance phenotypes with point mutations. As a part of this work, we also present tree-generalized hypergeometric score (TGH) -- a new statistical score.

In order to test our approach, we prepared two datasets for M. tuberuclosis. Results of both case studies suggest that tree-aware methods (weighted support and TGH) perform better than methods which do not incorporate phylogenetic information. This result supports also our corollary from our previous paper about weighted support [13]. Employing GWAMAR on the two datasets, we identified novel mutations putatively associated with drug-resistance.

Finally, despite some promising results, the presented tool has some limitations. First, it does not take into account or predict epistatic interactions between mutations. Second, it only takes into account genomic changes ignoring levels of gene expression. Thirdly, it provides putative in-silico associations which should be subjected to further investigation in wet lab experiments.

Availability

The GWAMAR software, input data and results of the case study experiments are available at the website: http://bioputer.mimuw.edu.pl/gwamar.

References

  1. WHO | Antimicrobial resistance: global report on surveillance 2014. 2014, Accessed 2014-07-12, [http://www.who.int/drugresistance/documents/surveillancereport/en/]

    Google Scholar 

  2. Threat Report 2013 | Antimicrobial Resistance | CDC (2013). Accessed 2014-07-12, [http://www.cdc.gov/drugresistance/threat-report-2013/]

  3. Wright GD: Molecular mechanisms of antibiotic resistance. Chemical Communications (Cambridge, England). 2011, 47 (14): 4055-4061. 10.1039/c0cc05111j.

    Article  CAS  Google Scholar 

  4. Liu B, Pop M: ARDB-antibiotic resistance genes database. Nucleic Acids Research. 2009, 37 (Database): 443-447. 10.1093/nar/gkn656.

    Article  Google Scholar 

  5. Sandgren A, Strong M, Muthukrishnan P, Weiner BK, Church GM, Murray MB: Tuberculosis drug resistance mutation database. PLoS Med. 2009, 6 (2): 1000002-Accessed 2014-07-12

    Article  Google Scholar 

  6. Andersson DI, Hughes D: Antibiotic resistance and its cost: is it possible to reverse resistance?. Nature Reviews Microbiology. 2010, 8 (4): 260-271.

    PubMed  CAS  Google Scholar 

  7. Koch A, Mizrahi V, Warner DF: The impact of drug resistance on mycobacterium tuberculosis physiology: what can we learn from rifampicin?. Emerging Microbes & Infections. 2014, 3 (3): 17-10.1038/emi.2014.17. Accessed 2014-07-14

    Article  Google Scholar 

  8. Wiesch PSz, Engelstädter J, Bonhoeffer S: Compensation of fitness costs and reversibility of antibiotic resistance mutations. Antimicrobial Agents and Chemotherapy. 2010, 54 (5): 2085-2095. 10.1128/AAC.01460-09. Accessed 2014-07-14

    Article  Google Scholar 

  9. Palmer AC, Kishony R: Understanding, predicting and manipulating the genotypic evolution of antibiotic resistance. Nature Reviews Genetics. 2013, 14 (4): 243-248. 10.1038/nrg3351. Accessed 2014-07-14

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  10. Toprak E, Veres A, Michel JB, Chait R, Hartl DL, Kishony R: Evolutionary paths to antibiotic resistance under dynamically sustained drug selection. Nature Genetics. 2012, 44 (1): 101-105. Accessed 2014-07-14

    Article  CAS  Google Scholar 

  11. Angst DC, Hall AR: The cost of antibiotic resistance depends on evolutionary history in escherichia coli. BMC Evolutionary Biology. 2013, 13 (1): 163-10.1186/1471-2148-13-163. Accessed 2014-07-14

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  12. Loman NJ, Constantinidou C, Chan JZM, Halachev M, Sergeant M, Penn CW, Robinson ER, Pallen MJ: High-throughput bacterial genome sequencing: an embarrassment of choice, a world of opportunity. Nature Reviews Microbiology. 2012, 10 (9): 599-606. 10.1038/nrmicro2850.

    Article  PubMed  CAS  Google Scholar 

  13. Wozniak M, Tiuryn J, Wong L: An approach to identifying drug resistance associated mutations in bacterial strains. BMC Genomics. 2012, 13 (Suppl 7): 23-10.1186/1471-2164-13-S7-S23. Accessed 2014-06-26

    Article  Google Scholar 

  14. Wozniak M, Wong L, Tiuryn J: eCAMBer: efficient support for large-scale comparative analysis of multiple bacterial strains. BMC Bioinformatics. 2014, 15 (1): 65-10.1186/1471-2105-15-65. Accessed 2014-07-14

    Article  PubMed  PubMed Central  Google Scholar 

  15. Wattam AR, Abraham D, Dalay O, Disz TL, Driscoll T, Gabbard JL, Gillespie JJ, Gough R, Hix D, Kenyon R, Machi D, Mao C, Nordberg EK, Olson R, Overbeek R, Pusch GD, Shukla M, Schulman J, Stevens RL, Sullivan DE, Vonstein V, Warren A, Will R, Wilson MJC, Yoo HS, Zhang C, Zhang Y, Sobral BW: PATRIC, the bacterial bioinformatics database and analysis resource. Nucleic Acids Research. 2014, 42 (D1): 581-591. 10.1093/nar/gkt1099. Accessed 2014-07-12

    Article  Google Scholar 

  16. Habib F, Johnson AD, Bundschuh R, Janies D: Large scale genotype-phenotype correlation analysis based on phylogenetic trees. Bioinformatics (Oxford, England). 2007, 23 (7): 785-788. 10.1093/bioinformatics/btm003.

    Article  CAS  Google Scholar 

  17. Edgar RC: MUSCLE: multiple sequence alignment with high accuracy and high throughput. Nucleic Acids Research. 2004, 32 (5): 1792-1797. 10.1093/nar/gkh340. Accessed 2014-07-14

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  18. Bakuł AZ, Napiό, Rkowska A, Bielecki J, Augustynowicz-Kopeć Ewa, Zwolska Z, Jagielski T: Mutations in the embB gene and their association with ethambutol resistance in multidrug-resistant Mycobacterium tuberculosis clinical isolates from poland. BioMed Research International. 2013, 2013: 167954-Accessed 2014-07-14

    Google Scholar 

  19. Malik S, Willby M, Sikes D, Tsodikov OV, Posey JE: New insights into fluoroquinolone resistance in mycobacterium tuberculosis: Functional genetic analysis of gyrA and gyrB mutations. PLoS ONE. 2012, 7 (6): 39754-10.1371/journal.pone.0039754. Accessed 2014-07-14

    Article  Google Scholar 

  20. Li J, Gao X, Luo T, Wu J, Sun G, Liu Q, Jiang Y, Zhang Y, Mei J, Gao Q: Association of gyrA/b mutations and resistance levels to fluoroquinolones in clinical isolates of mycobacterium tuberculosis. Emerging Microbes & Infections. 2014, 3 (3): 19-10.1038/emi.2014.21. Accessed 2014-07-14

    Article  Google Scholar 

  21. Patra SK, Jain A, Sherwal BL, Khanna A: Rapid detection of mutation in RRDR of rpo b gene for rifampicin resistance in MDR-pulmonary tuberculosis by DNA sequencing. Indian journal of clinical biochemistry: IJCB. 2010, 25 (3): 315-318. 10.1007/s12291-010-0065-3.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  22. Brandis G, Hughes D: Genetic characterization of compensatory evolution in strains carrying rpoB ser531leu, the rifampicin resistance mutation most frequently found in clinical isolates. Journal of Antimicrobial Chemotherapy. 2013, 68 (11): 2493-2497. 10.1093/jac/dkt224. Accessed 2014-07-15

    Article  PubMed  CAS  Google Scholar 

  23. Comas I, Borrell S, Roetzer A, Rose G, Malla B, Kato-Maeda M, Galagan J, Niemann S, Gagneux S: Whole-genome sequencing of rifampicin-resistant mycobacterium tuberculosis strains identifies compensatory mutations in RNA polymerase genes. Nature Genetics. 2012, 44 (1): 106-110. Accessed 2014-07-14

    Article  CAS  Google Scholar 

  24. de Vos M, Muller B, Borrell S, Black PA, van Helden PD, Warren RM, Gagneux S, Victor TC: Putative compensatory mutations in the rpoC gene of rifampin-resistant mycobacterium tuberculosis are associated with ongoing transmission. Antimicrobial Agents and Chemotherapy. 2013, 57 (2): 827-832. 10.1128/AAC.01541-12. Accessed 2014-07-14

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  25. Casali N, Nikolayevskyy V, Balabanova Y, Harris SR, Ignatyeva O, Kontsevaya I, Corander J, Bryant J, Parkhill J, Nejentsev S, Horstmann RD, Brown T, Drobniewski F: Evolution and transmission of drug-resistant tuberculosis in a russian population. Nature Genetics. 2014, 46 (3): 279-286. 10.1038/ng.2878. Accessed 2014-07-14

    Article  PubMed  CAS  PubMed Central  Google Scholar 

Download references

Acknowledgements

This work is supported in part by Polish Ministry of Science and Higher Education grant no. 2012/05/ST6/03247 and Singapore Ministry of Education Tier-2 grant no. MOE2009-T2-2-004.

Declarations

Funding for the publication of this paper was provided by Wong's KITHCT chair professorship.

This article has been published as part of BMC Genomics Volume 15 Supplement 10, 2014: Proceedings of the 25th International Conference on Genome Informatics (GIW/ISCB-Asia): Genomics. The full contents of the supplement are available online at http://www.biomedcentral.com/bmcgenomics/supplements/15/S10.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Michal Wozniak.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

All authors contributed to design of the method, analysis of results and writing of the manuscript. MW wrote software and performed experiments. All authors read and approved the final manuscript.

Electronic supplementary material

12864_2014_6762_MOESM1_ESM.pdf

Additional file 1: Drug-resistance information for 173 strains of M. tuberculosis. Drug-resistance information collected from literature for 173 strains of M. tuberculosis. (PDF 120 KB)

12864_2014_6762_MOESM2_ESM.pdf

Additional file 2: Phylogenetic tree for 173 strains of M. tuberculosis. Phylogenetic tree reconstructed using the maximum-likelihood method implemented in the PHYLIP for 173 strains of M. tuberculosis. (PDF 70 KB)

12864_2014_6762_MOESM3_ESM.pdf

Additional file 3: Putative compensatory mutations. Complete list of putative compensatory mutations identified in three different studies and our two datasets. (PDF 37 KB)

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an Open Access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/4.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Wozniak, M., Tiuryn, J. & Wong, L. GWAMAR: Genome-wide assessment of mutations associated with drug resistance in bacteria. BMC Genomics 15 (Suppl 10), S10 (2014). https://doi.org/10.1186/1471-2164-15-S10-S10

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1471-2164-15-S10-S10

Keywords