REVIEW ARTICLE |
https://doi.org/10.5005/jacm-11020-0005 |
Breaking Barriers in Candida auris Genomics: Analysis Tools for Whole Genome Sequencing Amid Database Scarcity
1–4Department of Molecular Diagnostics, Sir H. N. Reliance Foundation Hospital and Research Centre, Mumbai, Maharashtra, India
Corresponding Author: Shashikala Shivaprakash, Department of Molecular Diagnostics, Sir H. N. Reliance Foundation Hospital and Research Centre, Mumbai, Maharashtra, India, Phone: +91 02261305124, e-mail: Shashikala.Shivaprakash@rfhospital.org
Received: 10 April 2024; Accepted: 28 May 2024; Published on: 26 July 2024
ABSTRACT
Candida auris, a multidrug-resistant yeast, is an opportunistic pathogen that is capable of causing invasive infections, particularly in hospitalized patients with compromised immune systems. Whole genome sequencing (WGS) analysis provides valuable information related to the presence of C. auris clades and antifungal drug resistance mutations, and the data can be used to study transmission patterns in healthcare settings. However, analyzing data can be challenging due to its massive size and complexity. The data generated from WGS require advanced computational infrastructure and expertise in bioinformatics to handle tasks such as data preprocessing, quality control, read alignment, and variant calling. The purpose of this review is to provide a comprehensive overview of the computational tools and software used for WGS data analysis of C. auris. In this review, we have summarized all the tools, software, and databases used so far to the best of our knowledge for analysis of C. auris WGS data by several scientists.
Keywords: Candida auris, Multidrug resistance, Whole genome sequencing
How to cite this article: Gupta N, Chheda P, Shivaprakash S, et al. Breaking Barriers in Candida auris Genomics: Analysis Tools for Whole Genome Sequencing Amid Database Scarcity. J Acad Clin Microbiol 2024;26(1):1 3–22.
Source of support: This study was funded by Sir H. N. Reliance Foundation Hospital and Research Centre.
Conflict of interest: None
INTRODUCTION
Candida auris has been linked to hospital-associated outbreaks of deadly invasive infections with a high mortality rate due to multidrug resistance.1-4 In healthcare environment, there is a potential risk of spread of C. auris since it is frequently present in common shared surfaces used by patients, and this serves as a potential source of outbreak.5,6 Strains isolated from medical reusable equipment were genetically related to patient isolates and this was proven by whole genome sequencing (WGS).7 C. auris has been reported in several countries across Asia, Europe, Africa, and the Americas.8-11 Notable outbreaks have occurred in the United States of America, Canada, Mexico, the United Kingdom, Spain, India, Pakistan, Russia, Saudi Arabia, Oman, Kuwait, Kenya, South Africa, and Colombia.12-31 In some of these countries, C. auris has become endemic, meaning that it is now established as a persistent problem in healthcare facilities. Clinical antifungal resistance can be explained by identifying novel genetic determinants of antifungal susceptibilities in C. auris.32 Among C. auris population covering different hospitals in India, wide genomic variability has been observed by WGS.33 Genomic data of C. auris have been used to study single nucleotide variation (SNV), phylogenetic analysis for detection of C. auris clades, orthologous identification of genes, prediction of antifungal resistance, etc., which requires the use of several computational tools and databases. It is to be noted that there are multiple software tools developed for studying bacterial antimicrobial resistance (AMR) such as CARD, ResFinder, etc.; however, similar tools are unavailable for studying fungi. This review article is based on summation of all the tools, software, and databases used so far to the best of our knowledge for the study of C. auris by several scientists.
Whole genome Sequencing
Whole genome sequencing of C. auris has been generated on several next generation sequencing (NGS) platforms ranging from low to high throughput such as Illumina, PacBio, and Oxford Nanopore technologies.32,34-38 WGS has helped in delivering large volume of data to support assembly of 12.5 Mb of C. auris genome.
Next generation sequencing data analysis typically involves a multistep process that includes primary, secondary, and tertiary analysis as shown in Figure 1. First step is primary analysis, which involves the processing of raw sequence data generated by the NGS platform. Secondary analysis involves further processing of data generated in primary analysis, including quality control check, read alignment, and variant calling. Tertiary analysis involves the interpretation of the results obtained from the secondary analysis, with the goal of generating biological insights and functional knowledge.
Quality Check
The first inevitable step after NGS is to perform QC check (Table 1) and to analyze the quality of obtained NGS data. Standard quality control of reads obtained after short-read sequencing (typically from Illumina to Ion torrent) is performed using FastQC or Trimmomatic. FastQC provides a visual illustration of distribution of GC content, nucleotide bias, and base quality. Graphs and tables generated by FastQC helps quickly to assess data quality. If poor quality reads are obtained then Trimmomatic software, which is available freely in GALAXY, can be used to remove or trim those reads to obtained better quality data.42 GALAXY is an open-source, web-based platform for computational analysis. It allows scientists to analyze, visualize, share, and efficiently manage their data. After removing spurious and contaminated reads, data should be reanalyzed using FastQC to check the final quality of reads.
Utility | Organisms | Tools | Operating system | Link | Availability of software (free or commercial) | References |
---|---|---|---|---|---|---|
Quality check: assess read quality and filter out poor quality reads | C. auris | FastQC | Linux; Mac OS X; Windows | https://usegalaxy.org/root | Free | 34,39 |
C. auris | PRINSEQ | Linux; Mac OS X; Windows | https://bioinformaticshome.com/tools/rna-seq/descriptions/PRINSEQ.html#gsc.tab=0 | Free | 39 | |
C. albicans | QualiMap | Linux; Mac OS X; Windows | http://qualimap.conesalab.org/ | Free | 40 | |
Trimming: trim poor quality reads for better downstream analysis | C. auris | Trimmomatic v0.39 | Linux; Mac OS X | https://github.com/usadellab/Trimmomatic | Free | 32,37 |
C. albicans | Trimmomatic v0.39 | Linux; Mac OS X | https://github.com/usadellab/Trimmomatic | Free | 35,40 | |
C. auris | FASTX-Toolkit v0.0.14 | Linux; Mac OS X; Windows | https://bioinformaticshome.com/tools/rna-seq/descriptions/FASTX-Toolkit.html#gsc.tab=0 | Free | 37 | |
C. albicans | LoRDEC | Linux; Mac OS X | http://www.atgc-montpellier.fr/lordec/ | Free | 41 | |
C. albicans | Porechop v0.2.4 | Linux; Mac OS X | https://github.com/rrwick/Porechop | Free | 40 |
Similarly, PRINSEQ tool can be used to filter, reformat, or trim genomic data obtained from long-read sequencing technologies (like Pacific Biosciences and Oxford Nanopore). PRINSEQ tool is best used for metagenomic data but has also been used for C. auris to assess the quality of NGS data and to filter out low-quality sequences.40,42 Another tool for quality control is QUALIMAP for long reads and can be used as graphical user interface (GUI) or command line interface.41 It analyzes alignment sequence data file for the biases and helps in taking decision for further analyzes. The advantage with QUALIMAP is that it can be used to assess the data quality irrespective of the NGS platform being used. Another option of tools to trim reads are FASTX-Toolkit, long-read error correction (LoRDEC), and Porechop.37 FASTX-Toolkit is a collection of command line tools, which can be used to filter data based on different quality parameters and trims fastq or fasta reads.38 LoRDEC is mostly used for PacBio long reads since error rate is high and it uses graph based approach to fetch corrective sequence from erroneous sequence data. On similar lines, Porechop is used for data generated on Oxford Nanopore platform to find and trim adapter reads from the sequences.41 Porechop also provides demultiplexing support for reads generated by Oxford Nanopore.
Genome Assembly
Using better quality of reads, genome is assembled so as to reconstruct and recreate original chromosomal structure of organism. Tools like SPAdes, Velvet, Flye, PHRAP, NECAT, Canu, SMRT analysis, etc. are used for genome assembly (Table 2).43-45 For de novo sequencing, SPAdes assembler is used, which an open access downloadable tool and is also available in Illumina’s basespace sequence hub platform (https://basespace.illumina.com/).45 Velvet assembler uses algorithm of de Bruijn graph to assemble short reads and resolve the small repeats and produces contigs of reasonable length.46 The mean number of contigs is lower and the mean N50 value is higher in the genomes assembled using SPAdes, which is more desirable in comparison to Velvet assembled genomes. The shortest contig’s sequence length at 50% of the assembly’s overall length is known as N50, which determines the assembly’s quality. Flye assembler is mostly used for long sequencing reads such as those produced by PacBio and Oxford Nanopore Technologies. For assembly of shotgun sequence data, PHRAP assembler is used. PHRAP assembly program follows match “words” criteria and can also change parameters for assembly using command line. For assembling large genome which uses long noisy reads generated by Nanopore, NECAT assembler is used. Canu provides graph-based assembly outputs of higher N50 in GFA format. Canu assembler can be used for both, short as well as long reads generated by PacBio and Oxford Nanopore Technologies. SmrtAnalysis suite v2.3 was used to assemble the single-molecule real-time (SMRT) sequencing reads of C. auris that were generated on PacBio RS II SMRT DNA sequencing system (Pacific Biosciences).47
Utility | Organism | Tools | Operating system | Link | Availability of software (free or commercial) | References |
---|---|---|---|---|---|---|
Genome assembly: process of putting a large number of short DNA sequences back together to recreate the original chromosomes from which the DNA originated | C. auris | SmrtAnalysis suite v2.3 | Linux; Mac OS X | https://www.pacb.com/support/software-downloads/ | Free | 48 |
C. auris | Canu v1.6 | Linux; Mac OS X | https://github.com/marbl/canu | Free | 37,39,48 | |
C. albicans | Canu v1.9 | Linux; Mac OS X | https://github.com/marbl/canu | Free | 41 | |
C. auris | SPAdes assembler | Linux; Mac OS X | http://cab.spbu.ru/software/spades/ | Free | 48 | |
C. glabrata | SPAdes assembler | Linux; Mac OS X | http://cab.spbu.ru/software/spades/ | Free | 38 | |
C. auris | Flye v 2.4.2 | Linux; Mac OS X | https://github.com/fenderglass/Flye | Free | 39 | |
C. albicans | Flye v 2.4.2 | Linux; Mac OS X | https://github.com/fenderglass/Flye | Free | 41 | |
C. auris | VELVET v1.2.0 | Linux | https://bioinformaticshome.com/tools/wga/descriptions/Velvet.html#gsc.tab=0 | Free | 36 | |
C. albicans | NECAT | Linux; Mac OS X | https://github.com/xiaochuanle/NECAT | Free | 40 | |
Genome assembly evaluation: software evaluating the quality of genome assemblies by computing various metrics | C. auris | GAEMR package | Linux | http://software.broadinstitute.org/software/gaemr/ | Commercial | 48 |
Genome assembly polishing: an improved representation of the genome from the read data and an optional VCF file detailing variation seen between the read data and the input genome | C. auris | Pilon v1.23 | Linux | https://github.com/broadinstitute/pilon/releases | Free | 37,48 |
C. auris | Medaka version 0.8.1 | Linux; Mac OS X | https://github.com/nanoporetech/medaka | Free | 39 | |
C. albicans | Medaka version 0.8.2 | Linux; Mac OS X | https://github.com/nanoporetech/medaka | Free | 40 |
Since there are many assemblers available for use, choice of assembler will depend on several factors including characteristics of the sequencing data, such as the size and complexity of the genome and specific research question or application. It is important to select an assembler that is compatible with sequencing data generated for your experiment. When evaluating assemblers, it is important to consider performance metrics such as contiguity, completeness, and accuracy of the assembled genome.
Assembled genome needs to be polished for better representation of genome from the read data. Pilon and Medaka are the tools used for polishing of assembly.49 Pilon is a free online automated tool and by correcting bases, fixing mis-assemblies, and filling gaps, it improves draft genome assemblies. Medaka uses signal-based and sequence-graph based logic to create consensus sequences and generate polished genomic data.
The genome of C. auris is relatively large (around 12.7 Mb) and complex, with multiple copies of some genes and regions of repetitive DNA.50 Candida species exhibit significant genetic diversity, both within and between species.51 This can make it challenging to compare genomes and identify conserved and variable regions. Accurate gene predictions and functional annotations is a concern because C. auris is poorly characterized.52
Sequence Alignment
To identify regions of similarity or nucleotide variations that may be a consequence of evolutionary relationships, alignment of sequences is done. Sequence alignment (Table 3) can be local or global. Three algorithms make up the BWA software package: BWA-backtrack, BWA-SW, and BWA-MEM. BWA-MEM is faster, most accurate, and highly recommended for long sequences.54 BWA focuses on local alignment and hence need indexes for alignment. To perform multiple sequence alignment, ClustalW software is used, which is available online for free, but comes with limitation of file upload size. ClustalW uses progressive algorithm to perform global alignment of sequences. MUSCLE uses iterative algorithm and run combination of both global and local alignment. TOPHAT2 is alignment tool for transcriptome data of RNA seq. Bowtie 2 supports gapped, local, and paired-end alignment modes with most accurate and fast result.55 MUMmer/nucmer tool is basically used for alignment of whole genome of organism and generates results in minimum amount of time.56 MUMmer/nucmer is a tool to check “Maximal Unique Matches” and is best used for sequences with high similarity but have large rearrangements.
Utility | Organisms | Tools | Operating system | Link | Availability of software (free or commercial) | References |
---|---|---|---|---|---|---|
Alignment: mapping with reference genome to identify sequence variations | C. auris | BWA-MEM v0.7.17 | Linux; Mac OS X | https://bio-bwa.sourceforge.net/ | Free | 32,34,37,39,53 |
C. albicans | BWA-MEM v0.7.22 | Linux; Mac OS X | https://bio-bwa.sourceforge.net/ | Free | 35,40 | |
C. auris | Tophat2 | Linux; Mac OS X | http://www.sthda.com/english/wiki/tophat2-download-build-reference-genome-and-align-the-reads-to-the-reference-genome | Free | 39,48 | |
C. auris | MAUVE | Linux; Mac OS X, Windows | https://darlinglab.org/mauve/user-guide/installing.html | Free | 37 | |
C. auris | MUSCLE | Linux; Mac OS X, Windows | https://www.ebi.ac.uk/Tools/msa/muscle/ | Free | 48 | |
C. auris | Bowtie2 | Linux; Mac OS X | https://bowtie-bio.sourceforge.net/bowtie2/manual.shtml | Free | 48 | |
Candida auris | MUMmer v3.22 /NUCmer | Linux; Mac OS X | https://github.com/mummer4/mummer | Free | 37,39 | |
C. auris | ClustalW | Linux; Mac OS X, Windows | https://www.ebi.ac.uk/Tools/msa/clustalw2/ | Free | 48 | |
Alignment manipulation: converts between the formats, does sorting, duplicate reads removal, merging and indexing, and can retrieve reads in any regions | C. auris | Samtools | Linux; Mac OS X | http://www.htslib.org/ | Free | 34,37 |
C. albicans | Samtools | Linux; Mac OS X | http://www.htslib.org/ | Free | 35,40 | |
Alignment viewer: to visualize the genomic track and coverage plot | C. auris | Integrative Genomics Viewer (IGV) v2.3.72 | Linux; Mac OS X, Windows | https://software.broadinstitute.org/software/igv/ | Free | 39 |
C. albicans | Integrative Genomics Viewer (IGV) v2.3.73 | Linux; Mac OS X, Windows | https://software.broadinstitute.org/software/igv/ | Free | 35,40 |
After alignment of sequences, either BAM, SAM, or CRAM file is generated. With the use of samtools, data can be sorted, merged, and converted between the formats. It can also create indexes of the alignment file as well as can mark duplicates.57 Sequence alignment/map (Samtools) can be very useful in calculating coverage of sequences and read depth at each position or region. Similar to samtools, PICARD tool can be used for sorting, format conversion, to locate, and tag duplicate reads in a BAM or SAM file.
New SAM/BAM file obtained after edit can be visualized using Integrative Genomics Viewer (IGV).58 In IGV, user can upload BAM file along with their reference genomes to have clear visualization of mutations at relevant positions of chromosomes. IGV can also be used to view alignment, depth of reads and regions of poor reads. IGV can either be downloaded or can be used on web server independently. Along with BAM file, index file is necessary to be kept under same folder in local machine for error free visualization in IGV. Previously published study, used IGV to visualize rearrangement sites based on alignment of reads of C. auris.40
Gene Prediction
Process of identifying the coding region in genome is called gene prediction (Table 4). The output of gene prediction is the position of start, stop, and open reading frame of gene in chromosome or scaffold. Gene prediction can be done for both prokaryotic as well as eukaryotic organism. AUGUSTUS, based on a Generalized Hidden Markov Model, predicts genes for eukaryotic as well prokaryotic genome on web server.59 AUGUSTUS not only predicts coding parts of the genes but also gives respective protein sequences. Glimmer3 software is used for gene prediction for prokaryotes and is available for free on the GALAXY tool package.
Utility | Organism | Tools | Operating system | Link | Availability of software (free or commercial) | References |
---|---|---|---|---|---|---|
Gene prediction: computational methods for finding the location of protein coding regions | C. auris | AUGUSTUS | Linux; Mac OS X; Windows | https://bioinf.uni-greifswald.de/augustus/ | Free | 37,39,47 |
Gene annotation: plotting of genes onto genome assemblies, and indexing their genomic coordinates | C. auris | BRAKER1 | Linux; Mac OS X, Windows | https://usegalaxy.org/root | Free | 47 |
C. auris | BRAKER2 | Linux; Mac OS X, Windows | https://usegalaxy.org/root | Free | 39 | |
C. auris | GeneMark-ET | Linux; Mac OS X, Windows | https://usegalaxy.org/root | Free | 47 | |
C. auris | MAKER2 | Linux; Mac OS X, Windows | https://usegalaxy.org/root | Free | 36 | |
C. auris | GeneMark-ES | Linux; Mac OS X, Windows | https://usegalaxy.org/root | Free | 39 | |
Orthologs identification: prediction of orthologs for functional annotation of gene or proteins | C. auris | OrthoMCL v1.4 | Linux; Windows | https://orthomcl.org/orthomcl/app/ | Commercial | 40,47 |
C. albicans | BUSCO v5.2.2 | Linux | https://mybiosoftware.com/busco-assessing-genome-assembly-and-annotation-completeness-with-single-copy-orthologs.html | Free | 40,47 | |
tRNAs prediction: to identifies transfer RNA genes in genomic DNA or RNA sequences | C. auris | tRNAscan | Linux; Mac OS X | https://anaconda.org/bioconda/trnascan-se | Free | 40,47,53 |
rRNAs prediction: to identifies ribosomal RNA sub units | C. auris | RNAmmer | Linux; Mac OS X | https://vcru.wisc.edu/simonlab/bioinformatics/programs/install/rnammer.htm | Free | 40,47,53 |
For all those predicted genes, functional annotation is required, which can be done using software like MAKER2, BRAKER1, BRAKER2, and GENEMARK.60,61 For adding annotation to genes, trained dataset is required. Annotation quality can be improved by using genomic GFF file available in databases and mRNA-sequence data. The functional annotation of C. auris and other Candida species was performed using the Clusters of Orthologous Groups of proteins (COGs) database.62
For C. auris, gene level data is not appropriately documented in the NCBI or “Candida Genome Database”.44 For example, “FKS1” is annotated as “CJI97_001351” and “ERG11” as “CJI97_00156.” Similarly, description for annotation, “CJI97_000015,” is given as “hypothetical protein” and role of this gene is unclear. TAC1b, which is one of the important gene responsible for antifungal resistance, cannot be searched in the databases by its name. This major limitation hinders postsequencing data analysis process and needs to be addressed by the scientific community.
Orthologs Identification
Orthologs genes are common genes evolved due to speciation event and can be traced to ancestral genome if same gene exists. Using orthology relationships, the biologists can predict functional data like genome annotation, comparative genomics, etc., computationally. In case of C. auris, closest organism is Candida albicans for which data are available on all platforms or databases. Also, biofilm and antimicrobial mechanism are studied for C. albicans in depth, hence information available on C. albicans can give functional insights for C. auris genome.63 OrthoMCL and BUSCO are two software used for identification of orthologs.64 OrthoMCL approach is similar to INPARANOID algorithm with some exceptions of parameters used during analyses.65 BUSCO is an open source software available in conda package for assessment of orthologs. In the study focusing on clade specific rearrangement of C. auris, orthologs were assigned using bidirectional blast and Markov index 1.5; maximum e-value 1e-5 were parameters used in OrthoMCL.40 Chatterjee et al. used orthologues of C. albicans and reported that C. auris shared significant virulence attributes, including secreted proteases, genes involved in biofilm formation, mannosyl transferases, and oligopeptide transporters.50
Variant Calling
Variant calling uses high-throughput sequencing technology to calculate genomic variations like single nucleotide polymorphisms (SNPs), insertions, deletions, structural variations, and copy number variations (Table 5). GATK (Genome Analysis Toolkit) Haplotype Caller is one of the promising tool used for variant calling.66 Output of the Haplotype caller is variant calling file (VCF) and VCF index files. For variant calling, reference of Candida genome is necessary. Reference genomes can either be downloaded from NCBI or de novo assembled genome can be used. Freebayes is based on Bayesian algorithm, which checks whole haplotype of the read independently of alignment positions.67 VarScan2 employs a heuristic approach to call variance and it relies on threshold set for various parameters to determine variants.68 VarScan2 performs variant calling based on aligned read and by going through each read position by position.
Utility | Organism | Tools | Operating system | Link | Availability of software (free or Commercial) | References |
---|---|---|---|---|---|---|
Contigs join and circulating: to stitch multiple contigs together | C. auris | Circlator v1.5 | Linux; Mac OS X | https://sanger-pathogens.github.io/circlator/ | Free | 47 |
Variant calling: process to identify variants from sequence data | C. auris | GATK v4.1.2.1 | Linux; Mac OS X | https://gatk.broadinstitute.org/hc/en-us | Free | 32,38,40,48 |
C. albicans | GATK v4.1.2.4 | Linux; Mac OS X | https://gatk.broadinstitute.org/hc/en-us | Free | 36 | |
C. auris | Freebayes | Linux; Mac OS X, Windows | https://usegalaxy.org/root | Free | 35 | |
C. glabrata | Freebayes | Linux; Mac OS X, Windows | https://usegalaxy.org/root | Free | 53 | |
VCF annotation: to add biologically relevant data to variants in VCF | C. auris | SnpEff v4.3T and SnpSift | Linux; Mac OS X, Windows | http://pcingola.github.io/SnpEff/ | Free | 35,48 |
C. albicans | SnpEff v4.3T and SnpSift | Linux; Mac OS X, Windows | http://pcingola.github.io/SnpEff/ | Free | 36 | |
Manipulate variant calls in VCF | C. auris | BCFtools | Linux; Mac OS X | http://www.htslib.org/ | Free | 35 |
SNP identification: to predict single nucleotide polymorphisms | C. auris | NASP pipeline | Windows | https://github.com/TGenNorth/NASP | Free | 32 |
C. glabrata | CLC Genomics Workbench | Windows | https://digitalinsights.qiagen.com/products-overview/discovery-insights-portfolio/analysis-and-visualization/qiagen-clc-genomics-workbench/ | Commercial | 53 | |
CNV identification: to predict copy number variation | C. auris | CNVnator v0.3 | Linux; Mac OS X | https://anaconda.org/bioconda/cnvnator | Commercial | 47 |
SnpEff and SnpSift are tools to annotate genomic variants and predict its functional effects.69,70 SnpEff can also provide noncoding and regulatory annotations. SnpSift helps in filtering and manipulation of VCF files like joining, extracting fields, interval indexing, and calculation of concordance of two VCF files etc.71 NASP is a comprehensive, open-source tool, which is easily executable and aids in SNP identification as well as offers differentiation between large numbers of microbial genome datasets.32 Another software for SNP identification is CLC Genomics workbench (Qiagen), which is a commercially available comprehensive analysis package that supports analysis and visualization of NGS data.53 VCFtools is another open source tool that is designed to work on VCF/BCF format to filter, summarize, manipulate, and convert data into other useful file formats.47 It is a very easy tool to filter out variants with less quality score and uncharacterized genes of C. auris.47 Variants are filtered out based on several quality parameters such as QualByDepth (QD) or FisherStrand (FS) or mapping quality (MQ). QD is assessment of the variant’s quality relative to the sequencing depth. FS is Phred score to evaluate the variation being seen on only the forward or only the reverse strand. Root mean square of the MQ of the reads across all samples in a run is known as RMSMappingQuality. To further enhance data accuracy and to remove technical biases, hard filters such as MQRankSum, ReadPosRankSum, and SOR can be applied. Variants can also be filtered out based upon genotype quality and alternate percent allele.
Prediction of tRNAs and rRNAs
tRNA and rRNA are associated with each other and are involved in protein synthesis. tRNAscan is widely used tool to predict tRNA genes in genomic sequences by using covariance model.72 Structural information of tRNA is stored as training dataset, which is then used to search for complete gene details in query sequences. Output of tRNAscan tool is genomic coordinate, predicted function, and secondary structure of tRNA. Hidden Markov Model is used as foundation for RNAmmer software.73 RNAmmer is a free webserver tool that uses ERRD to predict ribosomal genes by mapping aligned data. Very few researchers have actually worked on prediction of tRNAs and rRNAs in Candida and further utility of this information is unclear.53
Phylogenetic Analysis
C. auris has five clades (I–V) based upon the number of SNPs identified after alignment. These clades are highly identical, sharing an average pairwise nucleotide of 98.7%. Clade II and Clade III appear most similar and share 99.3% identity.47 Whole genome based large SNP data file is used to study relatedness among the isolates. Based on SNP density, average divergence for each chromosome and whole genome is calculated. Using aligned file, phylogeny of multiple samples can be generated together to depict evolutionary relationship among each other, hence very useful in comparative genomics. Maximum Parsimony, Neighbour Joining, UPGMA, Maximum Likelihood, and MCMC are some of the algorithm used for generating phylogeny by MEGA software (Table 6).74 Each tree can be represented as cladogram or dendrogram. MEGA is a very popular tool used for computational molecular evolution analysis. It is an interactive software and has integrated feature of alignment, tree construction, and tree visualization. MEGA is a free tool that can be downloaded and installed on any computer system. RAxML is another popular software, which return trees with good likelihood score.75 RAxML uses 1,000 bootstrap replicates with the GTR model of nucleotide substitution and γ-distributed rates to speed up the process and gives very fast result of large data. Based upon Bayesian phylogenetic inference methods, BEAST software uses MCMC algorithm to construct phylogeny.76 IQ-Tree and FastTree are different tools used for tree visualization.77 To better understand the spread and evolution of C. auris over time, it is important to perform phylogenetic analysis on strains from different geographic locations. Phylogeny also helps in study of transmission of C. auris within a particular healthcare facility.
Utility | Organism | Tools | Operating system | Link | Availability of software (free or commercial) | References |
---|---|---|---|---|---|---|
Phylogeny: to depict the lines of evolutionary descent of different species, organisms, or genes | C. auris | RAxML | Windows | https://raxml-ng.vital-it.ch/#/ | Free | 32,37,48 |
C. auris | BEAST | Linux; Mac OS X; Windows | https://beast.community/ | Free | 32 | |
C. auris | MEGA V6.06 software | Linux; Mac OS X; Windows | https://www.megasoftware.net/downloads/dload_win_gui | Free | 47 | |
C. auris | IQ-TREE | Windows | http://iqtree.cibiv.univie.ac.at/ | Free | 34 | |
C. glabrata | IQ-TREE | Windows | http://iqtree.cibiv.univie.ac.at/ | Free | 38 | |
C. albicans | FastTree | Linux; Windows | http://www.microbesonline.org/fasttree/ | Free | 41 | |
C. glabrata | SplitsTree4 | Linux; Mac OS X; Windows | https://uni-tuebingen.de/en/fakultaeten/mathematisch-naturwissenschaftliche-fakultaet/fachbereiche/informatik/lehrstuehle/algorithms-in-bioinformatics/software/splitstree/ | Free | 38 |
Genomic Sequence Databases
There are limited databases, which hold information of C. auris and its genetic clades. One of the databases is CANDIDAGENOME (http://www.candidagenome.org/), which has information on genomic sequences, genes, and protein of C. albicans, Candida dubliniensis, Candida parapsilosis, Candida glabrata, and C. auris.78-80 Candidagenome database has lot of information for C. albicans, but minimal data is available for C. auris.44 Hence, for the researchers who are working on different clades of C. auris, Candidagenome database is of limited use.
NCBI is another database, which is a premium source of knowledge on Candida species. However, in case of C. auris, most of the genomic data are at scaffold level in NCBI (e.g., C. auris strain B11221) and very few at chromosome level (e.g., C. auris strain B11220). Since chromosome/scaffold level information is not consistent or uniform among clades, it hampers downstream analysis.
FungiDB provides a range of analysis tools and resources to facilitate data exploration and analysis.81 These tools include genome browsers, BLAST search functionality, sequence alignment tools, and data visualization tools. It provides gene sequence along with mRNA and protein sequences, which can be utilized for tertiary analysis such as identification of drug resistance mutations after sequencing. FungiDB has benefit over other databases in terms of gene information, which is not be present in NCBI explicitly.
Another database is MARDy, Mycology Antifungal Resistance Database version 1.1, which has limited information (mutations associated with drug resistance) for three genes, namely ERG11, FKS1, and FUR1 for C. auris and C. albicans.82 The information available in the database can be retrieved by applying relevant filters such as name of the organism, gene, or drug.
JGI (Joint Genome Institute) MycoCosm is a web-based platform that provides access to genomic and functional data for fungal organisms.83 The platform allows users to search and browse the available fungal genomes, explore gene annotations, and access various tools for analyzing and visualizing the data. Researchers can investigate specific genes, metabolic pathways, or genetic features of interest, and compare them across different fungal species.84 MycoCosm is linked to another database such as Ensembl fungi, which has sequence level information and focuses specifically on providing genomic data, annotations, and analysis tools for fungal species.85 Both MycoCosm and Ensembl fungi do not have information for C. auris but does have information on other species of Candida.
Antimicrobial Resistance
Most of the researchers have determined Minimal Inhibitory Concentration (MIC50) for antifungal susceptibility testing for drugs like fluconazole, caspofungin, and amphotericin B for C. auris.32,38,47,53 At molecular level, the resistant mutations are identified by Sanger sequencing, allele-specific PCR, or real-time PCR.48,84 Some of the researchers have managed to figure out antifungal resistant mutations by manually aligning the whole genome sequence to the reference genome by ClustalW alignment using MEGA.74 In case of fungi, the utility of the WGS data is limited as far as antifungal resistance is concerned because there are no automated tools to retrieve mutations associated with AMR. Instead, different gene sequences of a particular isolate have to be manually aligned to the reference gene sequences to pick up nucleotide variations.
CONCLUSION
Analysis of genome sequence is a humongous task and several computational software tools are currently being employed sequentially to churn out relevant information. A researcher has to use several local and online tools for C. auris genome analysis related to clade-level identification, phylogenetic analysis to check for relatedness among isolates and antifungal drug mutations. Nevertheless, there is a need to upgrade and curate reference genome databases as well as to create antifungal mutation database and related automated analysis tool. It requires focused, combined efforts of scientists and computational biologists. This will allow easy identification of drug resistant mutations and transmission dynamics of C. auris in the healthcare settings in real time basis and will enable improved surveillance and treatment strategies.
KEY POINTS
-
Genomic analysis of fungal superbug—C. auris aids in identification of clade, antifungal drug mutations, and evolutionary relationships with other Candida species.
-
Several tools are being employed consecutively to extract pertinent information from WGS data.
-
There is a need for creation of antimicrobial mutation database for fungi and curation of existing genomic databases to ease data analysis process.
REFERENCES
1. Forsberg K, Woodworth K, Walters M, et al. Candida auris: The recent emergence of a multidrug-resistant fungal pathogen. Med Mycol 2019;57(1):1–12. DOI: 10.1093/mmy/myy054
2. Kordalewska M, Perlin DS. Identification of drug resistant Candida auris. Front Microbiol 2019;10:1918. DOI: 10.3389/fmicb.2019.01918
3. Mirabet V, Salvador C, Valentín A, et al. Risk assessment of arterial allograft contamination from tissue donors colonized by Candida auris. J Hosp Infect 2021;112:49–53. DOI: 10.1016/j.jhin.2021.03.003
4. Chakrabarti A, Sood P. On the emergence, spread and resistance of Candida auris: host, pathogen and environmental tipping points. J Med Microbiol 2021;70(3):001318. DOI: 10.1099/jmm.0.001318
5. Escandón P, Chow NA, Caceres DH, et al. Molecular epidemiology of Candida auris in Colombia reveals a highly related, countrywide colonization with regional patterns in amphotericin B resistance. Clin Infect Dis 2019;68(1):15–21. DOI: 10.1093/cid/ciy411
6. Piedrahita CT, Cadnum JL, Jencson AL, et al. Environmental surfaces in healthcare facilities are a potential source for transmission of Candida auris and other Candida species. Infect Control Hosp Epidemiol 2017;38(9):1107–1109. DOI: 10.1017/ice.2017.127
7. Eyre DW, Sheppard AE, Madder H, et al. A Candida auris outbreak and its control in an intensive care setting. N Engl J Med 2018;379(14):1322–1331. DOI: 10.1056/NEJMoa1714373
8. Du H, Bing J, Hu T, et al. Candida auris: Epidemiology, biology, antifungal resistance, and virulence. PLoS Pathog 2020;16(10):e1008921. DOI: 10.1371/journal.ppat.1008921
9. Villanueva-Lozano H, Treviño-Rangel RdJ, González GM, et al. Outbreak of Candida auris infection in a COVID-19 hospital in Mexico. Clin Microbiol Infect 2021;27(5):813. DOI: 10.1016/j.cmi.2020.12.030
10. Allaw F, Kara Zahreddine N, Ibrahim A, et al. First Candida auris outbreak during a COVID-19 pandemic in a tertiary-care center in Lebanon. Pathogens 2021;10(2):157. DOI: 10.3390/pathogens10020157
11. Watkins RR, Gowen R, Lionakis MS, et al. Update on the pathogenesis, virulence, and treatment of Candida auris. Pathog Immun 2022;7(2):46–65. DOI: 10.20411/pai.v7i2.535
12. Vallabhaneni S, Kallen A, Tsay S, et al. Investigation of the first seven reported cases of Candida auris, a globally emerging invasive, multidrug-resistant fungus—United States, May 2013–August 2016. MMWR Morb Mortal Wkly Rep 2016;65(44):1234–1237. DOI: 10.1111/ajt.14121
13. Tsay S, Welsh RM, Adams EH, et al. Notes from the field: ongoing transmission of Candida auris in health care facilities—United States, June 2016–May 2017. MMWR Morb Mortal Wkly Rep 2017;66(19):514–515. DOI: 10.15585/mmwr.mm6619a7
14. Adams E, Quinn M, Tsay S, et al. Candida auris in healthcare facilities, New York, USA, 2013–2017. Emerg Infect Dis 2018;24(10):1816–1824. DOI: 10.3201/eid2410.180649
15. Prestel C, Anderson E, Forsberg K, et al. Candida auris outbreak in a COVID-19 specialty care unit—Florida, July–August 2020. MMWR Morb Mortal Wkly Rep 2021;70(2):56–57. DOI: 10.15585/mmwr.mm7002e3
16. Eckbo EJ, Wong T, Bharat A, et al. First reported outbreak of the emerging pathogen Candida auris in Canada. Am J Infect Control 2021;49(6):804–807. DOI: 10.1016/j.ajic.2021.01.013
17. Schelenz S, Hagen F, Rhodes JL, et al. First hospital outbreak of the globally emerging Candida auris in a European hospital. Antimicrob Resist Infect Control 2016;5:35. DOI: 10.1186/s13756-016-0132-5
18. Rhodes J, Abdolrasouli A, Farrer RA, et al. Genomic epidemiology of the UK outbreak of the emerging human fungal pathogen Candida auris. Emerg Microbes Infect 2018;7(1):1–12. DOI: 10.1038/s41426-018-0045-x
19. Ruiz-Gaitán A, Moret AM, Tasias-Pitarch M, et al. An outbreak due to Candida auris with prolonged colonisation and candidaemia in a tertiary care European hospital. Mycoses 2018;61(7):498–505. DOI: 10.1111/myc.12781
20. Mulet Bayona JV, Tormo Palop N, Salvador García C, et al. Characteristics and management of candidaemia episodes in an established Candida auris outbreak. Antibiotics 2020;9(9):558. DOI: 10.3390/antibiotics9090558
21. Mathur P, Hasan F, Singh PK, et al. Five-year profile of candidaemia at an Indian trauma centre: High rates of Candida auris blood stream infections. Mycoses 2018;61(9):674–680. DOI: 10.1111/myc.12790
22. Farooqi JQ, Soomro AS, Baig MA, et al. Outbreak investigation of Candida auris at a tertiary care hospital in Karachi, Pakistan. J InfectPrev 2020;21(5):189–195. DOI: 10.1177/1757177420935639
23. Barantsevich NE, Vetokhina AV, Ayushinova NI, et al. Candida auris bloodstream infections in Russia. Antibiotics 2020;9(9):557. DOI: 10.3390/antibiotics9090557
24. Alshamrani MM, El-Saed A, Mohammed A, et al. Management of Candida auris outbreak in a tertiary-care setting in Saudi Arabia. Infect Control Hosp Epidemiol. 2021;42(2):149–155. DOI: 10.1017/ice.2020.414
25. Al Maani A, Paul H, Al-Rashdi A, et al. Ongoing challenges with healthcare-associated Candida auris outbreaks in Oman. J Fungi (Basel) 2019;5(4):101. DOI: 10.3390/jof5040101
26. Mohsin J, Weerakoon S, Ahmed S, et al. A cluster of Candida auris blood stream infections in a tertiary care hospital in Oman from 2016 to 2019. Antibiotics 2020;9(10):638. DOI: 10.3390/antibiotics9100638
27. Alfouzan W, Ahmad S, Dhar R, et al. Molecular epidemiology of Candida auris outbreak in a major secondary-care hospital in Kuwait. J Fungi (Basel) 2020;6(4):307. DOI: 10.3390/jof6040307
28. Adam RD, Revathi G, Okinda N, et al. Analysis of Candida auris fungemia at a single facility in Kenya. Int J Infect Dis. 2019;85:182–187. DOI: 10.1016/j.ijid.2019.06.001
29. Govender NP, Magobo RE, Mpembe R, et al. Candida auris in South Africa, 2012–2016. Emerg Infect Dis 2018;24(11):2036–2040. DOI: 10.3201/eid2411.180368
30. Armstrong PA, Rivera SM, Escandon P, et al. Hospital-associated multicenter outbreak of emerging fungus Candida auris, colombia, 2016. Emerg Infect Dis. 2019;25(7):1339–1346. DOI: 10.3201/eid2507.180491
31. Yadav A, Singh A, Wang Y, et al. Colonisation and transmission dynamics of Candida auris among chronic respiratory diseases patients hospitalised in a chest hospital, Delhi, India: A comparative analysis of whole genome sequencing and microsatellite typing. J Fungi (Basel) 2021;7(2):81. DOI: 10.3390/jof7020081
32. Chow NA, Muñoz JF, Gade L, et al. Tracing the evolutionary history and global expansion of Candida auris using population genomic analyses. mBio 2020;11(2):e03364-19. DOI: 10.1128/mBio.03364-19
33. Sanglard D. Finding the needle in a haystack: mapping antifungal drug resistance in fungal pathogen by genomic approaches. PLoS Pathog 2019;15(1):e1007478. DOI: 10.1371/journal.ppat.1007478
34. Oladele R, Uwanibe JN, Olawoye IB, et al. Emergence and genomic characterization of multidrug resistant Candida auris in Nigeria, West Africa. J Fungi (Basel) 2022;8(8):787. DOI: 10.3390/jof8080787
35. Todd RT, Wikoff TD, Forche A, et al. Genome plasticity in Candida albicans is driven by long repeat sequences. Elife 2019;8:e45954. DOI: 10.7554/eLife.45954
36. Kumaraswamy M, Coady A, Szubin R, et al. Comprehensive whole genome sequencing with hybrid assembly of multi-drug resistant Candida albicans isolate causing cerebral abscess. Curr Res Microb Sci 2023;4:100180. DOI: 10.1016/j.crmicr.2023.100180
37. Fan S, Zhan P, Bing J, et al. A biological and genomic comparison of a drug-resistant and a drug-susceptible strain of Candida auris isolated from Beijing, China. Virulence 2021;12(1):1388–1399. DOI: 10.1080/21505594.2021.1928410
38. Lockhart SR, Etienne KA, Vallabhaneni S, et al. Simultaneous emergence of multidrug-resistant Candida auris on 3 continents confirmed by whole-genome sequencing and epidemiological analyses. Clin Infect Dis 2017;64(2):134–140. DOI: 10.1093/cid/ciw691
39. Muñoz JF, Welsh RM, Shea T, et al. Clade-specific chromosomal rearrangements and loss of subtelomeric adhesins in Candida auris. Genetics 2021;218(1):iyab029. DOI: 10.1093/genetics/iyab029
40. Rizzo M, Soisangwan N, Vega-Estevez S, et al. Stress combined with loss of the Candida albicans SUMO protease Ulp2 triggers selection of aneuploidy via a two-step process. PLoS Genet 2022;18(12):e1010576. DOI: 10.1371/journal.pgen.1010576
41. Bolger AM, L ohse M, Usadel B. Trimmomatic: a flexible trimmer for Illumina sequence data. Bioinformatics 2014;30(15):2114–2120. DOI: 10.1093/bioinformatics/btu170
42. Koren S, Walenz BP, Berlin K, et al. Canu: scalable and accurate long-read assembly via adaptive k-mer weighting and repeat separation. Genome Res 2017;27(5):722–736. DOI: 10.1101/gr.215087.116
43. Skrzypek MS, Binkley J, Binkley G, et al. The Candida Genome Database (CGD): incorporation of Assembly 22, systematic identifiers and visualization of high throughput sequencing data. Nucleic Acids Res 2017;45(D1):D592–D596. DOI: 10.1093/nar/gkw924
44. Bankevich A, Nurk S, Antipov D, et al. SPAdes: a new genome assembly algorithm and its applications to single-cell sequencing. J Comput Biol 2012;19(5):455–477. DOI: 10.1089/cmb.2012.0021
45. Zerbino DR, Birney E. Velvet: algorithms for de novo short read assembly using de Bruijn graphs. Genome Res 2008;18(5):821–829. DOI: 10.1101/gr.074492.107
46. Muñoz JF, Gade L, Chow NA, et al. Genomic insights into multidrug-resistance, mating and virulence in Candida auris and related emerging species. Nat Commun 2018;9(1):5346. DOI: 10.1038/s41467-018-07779-6
47. Carolus H, Pierson S, Muñoz JF, et al. Genome-wide analysis of experimentally evolved Candida auris reveals multiple novel mechanisms of multidrug resistance. mBio 2021;12(2):e03333-20. DOI: 10.1128/mBio.03333-20
48. Walker BJ, Abeel T, Shea T, et al. Pilon: an integrated tool for comprehensive microbial variant detection and genome assembly improvement. PLoS One 2014;9(11):e112963. DOI: 10.1371/journal.pone.0112963
49. Chatterjee S, Alampalli SV, Nageshan RK, et al. Draft genome of a commonly misdiagnosed multidrug resistant pathogen Candida auris. BMC Genomics 2015;16(1):686. DOI: 10.1186/s12864-015-1863-z
50. Hirakawa MP, Martinez DA, Sakthikumar S, et al. Genetic and phenotypic intra-species variation in Candida albicans. Genome Res 2015;25(3):413–425. DOI: 10.1101/gr.174623.114
51. Reslan L, Araj GF, Finianos M, et al. Molecular characterization of Candida auris isolates at a major tertiary care center in Lebanon. Front Microbiol 2021;12:770635. DOI: 10.3389/fmicb.2021.770635
52. Sharma C, Kumar N, Pandey R, et al. Whole genome sequencing of emerging multidrug resistant Candida auris isolates in India demonstrates low genetic variation. New Microbes New Infect 2016;13:77–82. DOI: 10.1016/j.nmni.2016.07.003
53. Wilton R, Szalay AS. Performance optimization in DNA short-read alignment. Bioinformatics 2022;38(8):2081–2087. DOI: 10.1093/bioinformatics/btac066
54. Langmead B, Salzberg SL. Fast gapped-read alignment with Bowtie 2. Nat Methods 2012;9(4):357–359. DOI: 10.1038/nmeth.1923
55. Kurtz S, Phillippy A, Delcher AL, et al. Versatile and open software for comparing large genomes. Genome Biol 2004;5(2):R12. DOI: 10.1186/gb-2004-5-2-r12
56. Li H. A statistical framework for SNP calling, mutation discovery, association mapping and population genetical parameter estimation from sequencing data. Bioinformatics 2011;27(21):2987–2993. DOI: 10.1093/bioinformatics/btr509
57. Robinson JT, Thorvaldsdóttir H, Winckler W, et al. Integrative genomics viewer. Nat Biotechnol 2011;29(1):24–26. DOI: 10.1038/nbt.1754
58. Stanke M, Diekhans M, Baertsch R, et al. Using native and syntenically mapped cDNA alignments to improve de novo gene finding. Bioinformatics 2008;24(5):637–644. DOI: 10.1093/bioinformatics/btn013
59. Hoff KJ, L ange S, L omsadze A, et al. BRAKER1: unsupervised RNA-Seq-based genome annotation with GeneMark-ET and AUGUSTUS. Bioinformatics 2016;32(5):767–769. DOI: 10.1093/bioinformatics/btv661
60. Lomsadze A, Burns PD, Borodovsky M. Integration of mapped RNA-Seq reads into automatic training of eukaryotic gene finding algorithm. Nucleic Acids Res 2014;42(15):e119. DOI: 10.1093/nar/gku557
61. Tatusov RL, Galperin MY, Natale DA, et al. The COG database: a tool for genome-scale analysis of protein functions and evolution. Nucleic Acids Res 2000;28(1):33–36. DOI: 10.1093/nar/28.1.33
62. Kean R, Delaney C, Sherry L, et al. Transcriptome assembly and profiling of Candida auris reveals novel insights into biofilm-mediated resistance. mSphere 2018;3(4):e00334-18. DOI: 10.1128/mSphere.00334-18
63. Simão FA, Waterhouse RM, Ioannidis P, et al. BUSCO: assessing genome assembly and annotation completeness with single-copy orthologs. Bioinformatics 2015;31(19):3210–3212. DOI: 10.1093/bioinformatics/btv351
64. Li L, Stoeckert CJ, Roos DS. OrthoMCL: identification of ortholog groups for eukaryotic genomes. Genome Res 2003;13(9):2178–2189. DOI: 10.1101/gr.1224503
65. McKenna A, Hanna M, Banks E, et al. The Genome Analysis Toolkit: a MapReduce framework for analyzing next-generation DNA sequencing data. Genome Res 2010;20(9):1297–1303. DIO: 10.1101/gr.107524.110
66. Clevenger J, Chavarro C, Pearl SA, et al. Single nucleotide polymorphism identification in polyploids: a review, example, and recommendations. Mol Plant 2015;8(6):831–846. DOI: 10.1016/j.molp.2015.02.002
67. Koboldt DC, Zhang Q, L arson DE, et al. VarScan 2: somatic mutation and copy number alteration discovery in cancer by exome sequencing. Genome Res 2012;22(3):568–576. DOI: 10.1101/gr.129684.111
68. Cingolani P, Platts A, Wang le L, et al. A program for annotating and predicting the effects of single nucleotide polymorphisms, SnpEff: SNPs in the genome of Drosophila melanogaster strain w1118; iso-2; iso-3. Fly (Austin) 2012;6(2):80–92. DOI: 10.4161/fly.19695
69. Cingolani P, Patel VM, Coon M, et al. Using Drosophila melanogaster as a model for genotoxic chemical mutational studies with a new program, SnpSift. Front Genet 2012;3:35. DOI: 10.3389/fgene.2012.00035
70. Danecek P, Auton A, Abecasis G, et al. The variant call format and VCFtools. Bioinformatics 2011;27(15):2156–2158. DOI: 10.1093/bioinformatics/btr330
71. Lowe TM, Eddy SR. tRNAscan-SE: a program for improved detection of transfer RNA genes in genomic sequence. Nucleic Acids Res 1997;25(5):955–964. DOI: 10.1093/nar/25.5.955
72. Lagesen K, Hallin P, Rødland EA, et al. RNAmmer: consistent and rapid annotation of ribosomal RNA genes. Nucleic Acids Res 2007;35(9):3100–3108. DOI: 10.1093/nar/gkm160
73. Tamura K, Stecher G, Peterson D, et al. MEGA6: Molecular Evolutionary Genetics Analysis version 6.0. Mol Biol Evol 2013;30:2725–2729. DOI: 10.1093/molbev/mst197
74. Stamatakis A. RAxML-VI-HPC: maximum likelihood-based phylogenetic analyses with thousands of taxa and mixed models. Bioinformatics 2006;22(21):2688–2690. DOI: 10.1093/bioinformatics/btl446
75. Drummond AJ, Rambaut, A. BEAST: Bayesian evolutionary analysis by sampling trees. BMC Evol Biol 2007;7:214. DOI: 10.1186/1471-2148-7-214
76. Minh BQ, Schmidt HA, Chernomor O, et al. IQ-TREE 2: new models and efficient methods for phylogenetic inference in the genomic era. Mol BiolEvol 2020;37(5):1530–1534. DOI: 10.1093/molbev/msaa015
77. Skrzypek MS, Binkley J, Sherlock G. Using the Candida Genome Database. Methods Mol Biol 2018;1757:31–47. DOI: 10.1007/978-1-4939-7737-6_3
78. Kumar A, Prakash A, Singh A, et al. Candida haemulonii species complex: an emerging species in India and its genetic diversity assessed with multilocus sequence and amplified fragment-length polymorphism analyses. Emerg Microbes Infect 2016;5(5):e49. DOI: 10.1038/emi.2016.49
79. Khalaf RA, Fattouh N, Medvecky M, et al. Whole genome sequencing of a clinical drug resistant Candida albicans isolate reveals known and novel mutations in genes involved in resistance acquisition mechanisms. J Med Microbiol 2021;70(4):001351. DOI: 10.1099/jmm.0.001351
80. Stajich JE, Harris T, Brunk BP, et al. FungiDB: an integrated functional genomics database for fungi. Nucleic Acids Res 2012;40(Database issue):D675–D681. DOI: 10.1093/nar/gkr918
81. Nash A, Sewell T, Farrer RA, et al. MARDy: Mycology Antifungal Resistance Database. Bioinformatics 2018;34(18):3233–3234. DOI: 10.1093/bioinformatics/bty321
82. Grigoriev IV, Nikitin R, Haridas S, et al. MycoCosm portal: gearing up for 1000 fungal genomes. Nucleic Acids Res 2014;42(Database issue):D699–D704. DOI: 10.1093/nar/gkt1183
83. Jacobs SE, Jacobs JL, Dennis EK, et al. Candida auris pan-drug-resistant to four classes of antifungal agents. Antimicrob Agents Chemother 2022;66(7):e0005322. DOI: 10.1128/aac.00053-22
84. Yates AD, Allen J, Amode RM, et al. Ensembl Genomes 2022: an expanding genome resource for non-vertebrates. Nucleic Acids Res 2022;50(D1):D996–D1003. DOI: 10.1093/nar/gkab1007
________________________
© The Author(s). 2024 Open Access. This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (https://creativecommons.org/licenses/by-nc/4.0/), which permits unrestricted use, distribution, and non-commercial reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. 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.