Abstract
The microbiome is a complex community of microorganisms, encompassing prokaryotic (bacterial and archaeal), eukaryotic, and viral entities. This microbial ensemble plays a pivotal role in influencing the health and productivity of diverse ecosystems while shaping the web of life. However, many software suites developed to study microbiomes analyze only the prokaryotic community and provide limited to no support for viruses and microeukaryotes. Previously, we introduced the Viral Eukaryotic Bacterial Archaeal (VEBA) open-source software suite to address this critical gap in microbiome research by extending genome-resolved analysis beyond prokaryotes to encompass the understudied realms of eukaryotes and viruses. Here we present VEBA 2.0 with key updates including a comprehensive clustered microeukaryotic protein database, rapid genome/protein-level clustering, bioprospecting, non-coding/organelle gene modeling, genome-resolved taxonomic/pathway profiling, long-read support, and containerization. We demonstrate VEBA’s versatile application through the analysis of diverse case studies including marine water, Siberian permafrost, and white-tailed deer lung tissues with the latter showcasing how to identify integrated viruses. VEBA represents a crucial advancement in microbiome research, offering a powerful and accessible software suite that bridges the gap between genomics and biotechnological solutions.
Graphical Abstract
Introduction
The microbiome is a complex community of microorganisms, encompassing prokaryotic, eukaryotic and viral entities. This ensemble plays a pivotal role in influencing the health and productivity of diverse ecosystems while shaping the web of life. The influence of microbial activity from their interconnected metabolic processes and competition for resources propagate across trophic levels; an ecological trend that is universal from human microbiomes to extreme environmental systems.
Recently, there have been several large-scale microbiome studies where researchers have recovered tens-to-hundreds of thousands of biome-specific metagenome-assembled genomes (MAG) from biomes such as the human gut (UHGG; NMAG = 204 938 (1)), ocean (OceanDNA; NMAG = 52 325 (2)) and soil (NMAG = 40 039 (3)). The aggregate knowledge derived from these large-scale studies as well as many small-to-medium scale studies have provided immeasurable insight into the taxonomic and metabolic complexity of microorganisms. However, aside from prophages, many microbiome studies focus primarily on the prokaryome (i.e. bacteria and archaea) and do not assess the eukaryome and virome from a genome-resolved perspective. The motivating factor for developing the Viral Eukaryotic Bacterial Archaeal (VEBA) open-source software suite (4) was to extend modular end-to-end (meta-)genomics/transcriptomics methodologies beyond the prokaryome to support the eukaryome and virome. The eukaryome in this context is defined as the fraction of microbes composed of nucleated organisms such as protists and unicellular fungi (adapted from (5)) while the virome consists of all the viruses within an ecosystem, including those integrated into host genomes (6).
Parasitic protists cause many human diseases such as malaria, toxoplasmosis, and giardia (7) which drives the focus of research on the eukaryome towards investigating problems related to pathogens and parasites. This emphasis on biomedical applications is essential for progressing the wellness of humankind but inadvertently cultivates a blind-spot in our knowledge around eukaryotic commensals, mutualists, and extremophiles. Despite constituting most of the eukaryotic phylogenetic diversity (8,9), protists are frequently overlooked in investigations of extreme environments and, therefore, key opportunities have been missed to advance our understanding of the functional diversity inherent in eukaryotic life and their impact on ecosystems (10).
Viruses are submicroscopic infectious agents that replicate only inside the living cells of organisms (11). From unicellular microorganisms to complex multicellular societies of sapiens, it is hypothesized that every form of cellular life on Earth is susceptible to viral infection (12). Widespread in nearly every ecosystem, viruses are the most numerically abundant biological entity and can drive the evolution of host organisms (13). Despite their ubiquity, viruses are frequently disregarded in studies, thereby underscoring the need for a more comprehensive understanding of their pervasive presence. There are several reasons for the lack of viral representation in microbiome studies including study design that relies on rRNA amplification, exclusion of viruses on the tree of life, unconventional taxonomic nomenclature in virology, and high complexity in viral replication/metabolism. From a public health perspective, characterizing the breadth of viral biology can provide key insight into emerging pathogens where novel viruses arise via natural processes such as recombination in diverse hosts (14). From a deeper perspective, the study of viruses from diverse ecosystems can provide insight into not only the evolution of living organisms but the origins of life itself (15).
The objective for VEBA 1.0 was to unify robust in silico prokaryotic, (micro)eukaryotic, and viral computational workflows while providing seamless open-source usage for researchers globally (4). As shown in this work, the objectives for VEBA 2.0 included optimizing the current workflows, adding complementary workflows, containerization and expanding community-resources. In this effort, VEBA emphasizes the core principles of FAIR scientific stewardship with its commitment to open-source packages/databases, detailed walkthroughs, interoperability with other tools, and structured outputs for reusability (16).
Here we present a major update to VEBA with key highlights including a comprehensive clustered microeukaryotic protein database, rapid genome/protein-level clustering, non-coding/organelle gene modeling, genome-resolved taxonomic/pathway profiling, long-read support, and containerization. In addition, VEBA 2.0 provides resources for the translation of genome mining results into biotechnological solutions with the addition of mobile genetic element identification, AMR gene detection, virulence factor detection, and biosynthetic potential analysis. We showcase the updates by employing VEBA to analyze 3 different case studies including marine water, Siberian permafrost, and white-tailed deer lung tissue metagenomes. VEBA is freely available as an open-source software suite and is accessible at https://github.com/jolespin/veba providing comprehensive access to its source code, datasets, and instructional walkthroughs.
Materials and methods
VEBA modules
As with the initial release, VEBA 2.0 maintains its modularity but now with 20 independent modules each developed for essential workflows that can be used for (meta-)genomics and/or (meta-)transcriptomics (Figure 1).
preprocess – Fastq quality trimming, adapter removal, decontamination and read statistics calculations (Illumina)
The preprocess module is largely unchanged from the VEBA 1.0 release. It remains as a wrapper around fastq_preprocessor (https://github.com/jolespin/fastq_preprocessor) which is a modernized reimplementation of KneadData (17) that relies on the following backend tools: (i) fastp for ultra-fast automated adapter removal and quality trimming (18); (ii) Bowtie2 for aligning trimmed reads to a contamination database (19); (iii) BBTools’ BBDuk.sh (https://sourceforge.net/projects/bbmap) for profiling reads against a k-mer database (e.g. ribosomal k-mers) and (iv) SeqKit for read accounting purposes (e.g. % contamination or % trimmed) (20). Decontamination and k-mer profiling methods are optional as are the output files for said features. The preprocess environment continues to use Kingfisher (https://github.com/wwood/kingfisher-download) as a backend resource for users to download sequencing files and their annotations from public data sources including ENA, NCBI SRA, Amazon AWS and Google Cloud. For a detailed description, please refer to the initial VEBA publication (4).
preprocess-long – Fastq quality trimming, adapter removal, decontamination and read statistics calculations (Oxford Nanopore & PacBio)
The preprocess-long module uses the approach from the original preprocess module and applies it to long-read technologies such as Oxford Nanopore and PacBio. More specifically, the following methodology is implemented: (i) reads are quality trimmed using NanoPack2 Chopper (21) instead of fastp; (ii) trimmed reads are aligned to a contamination database using minimap2 (22) instead of Bowtie2; (iii) BBTools’ BBDuk.sh for k-mer profiling (as in preprocess) and (iv) SeqKit for read accounting purposes. As with the preprocess module, decontamination and k-mer quantification is optional.
assembly – Assemble reads, align reads to assembly, and count mapped reads (Illumina)
The assembly module has several changes compared to the VEBA 1.0 release. One key change is the addition of MEGAHIT (23) as an alternative to SPAdes-based assemblers (24) with metaSPAdes (25) remaining as the default and rnaSPAdes (26) as an alternative for transcriptomic workflows. With the update, sample names are prepended to the scaffolds or transcripts to bypass the possibility of duplicate identifiers that may occur in large datasets. Additional SPAdes-based algorithms such as Metaviral SPAdes are also supported but have not been thoroughly tested with VEBA (27). The remaining steps are similar to the initial VEBA 1.0 assembly module which includes (i) Bowtie2 for indexing scaffolds or transcripts and aligning reads; (ii) Samtools for producing sorted BAM files (28); (iii) featureCounts for counting reads that have aligned to scaffolds or transcripts (29) and (iv) SeqKit for useful assembly quality control statistics such as N50, number of contigs, and total assembly size. As with the initial release, this module automates many critical yet overlooked workflows dealing with assemblies that are typically performed post hoc such as contig-level sequence alignment, contig-level counts tables, assembly indexing, and assembly statistics.
assembly-long – Assemble reads, align reads to assembly, and count mapped reads (Oxford Nanopore & PacBio)
The assembly-long module uses a similar approach to the assembly module but using packages designed for long reads instead. For instance, instead of SPAdes-based assemblers the module uses Flye (30) and MetaFlye (31) where the sample name is prepended to the contigs. After (meta-)genomic assembly is finished and assembly statistics are computed with SeqKit, long reads are aligned back to the assembly using minimap2 and BAM files are sorted with Samtools. Sorted BAM files are counted using featureCounts in long reads mode.
coverage – Align reads to a (multi-sample) reference and counts mapped reads (Illumina)
The coverage module is largely unchanged from initial release and is used to produce mapping index objects and sorted BAM files. Details have been described previously (4).
coverage-long – Align reads to a (multi-sample) reference and counts mapped reads (Oxford Nanopore & PacBio)
The coverage-long module follows the adaptation strategy of preprocess-long and assembly-long in which Bowtie2 is replaced with minimap2. The approach for coverage-long is the same as coverage but with tools designed for long reads.
binning-prokaryotic – Iterative consensus binning for recovering prokaryotic genomes, modeling coding/non-coding genes, and quality assessment
The fundamentals of the prokaryotic binning module have not changed relative to the initial VEBA 1.0 release. Namely, CoverM (https://github.com/wwood/CoverM) is used for fast coverage calculations, multiple binning algorithms (MaxBin2 (marker set = 107); MaxBin2 (marker set = 40) (32); MetaBat2 (33) and CONCOCT (34), a genome size filter (150 000 bp is the default), consensus binning with DAS Tool (35), and a consensus domain wrapper for Tiara (36) for removing eukaryotes at the MAG level. The module still maintains its iterative functionality where unbinned contigs are fed back into the start of the algorithm as these unbinned contigs can be viewed as a new lower complexity space to cluster contigs into bins. The main updates include the use of CheckM2 (37) to massively speed up genome quality assessments with direct support for CPR (CPR support was available in prior versions but required a workaround as detailed later). Coding sequences are now modeled using Pyrodigal (38) instead of Prodigal (39). For non-coding genes, Barrnap (https://github.com/tseemann/barrnap) is used for ribosomal RNA (rRNA) and tRNAscan-SE 2.0 is used for transfer RNA (tRNA) (40). MAG naming scheme for prokaryotes follows [SampleID]__[Algorithm]__P.[Iteration]__[Name] (e.g. SRR13615824__METABAT2__P.1__bin.3).
binning-eukaryotic – Binning for recovering eukaryotic genomes with nuclear/organelle (exon-aware) coding/non-coding gene modeling and lineage-specific quality assessment
The fundamentals of the eukaryotic binning module have not changed relative to the initial VEBA 1.0 release. Namely, the following protocol: (i) coverage calculated with CoverM; (ii) non-prokaryotic-specific binning algorithms MetaBat2 or CONCOCT for binning out genomes followed by a genome size filter (2 000 000 bp is the default); (iii) Tiara to predict eukaryotic MAGs and remove non-eukaryotic MAGs; (iv) coding/non-coding gene modeling for nuclear and organelle genomes; (v) BUSCO for lineage-specific quality assessment and the removal of poor quality genomes (41); (vi) featureCounts for gene-level counts and (vii) genome statistics calculated with SeqKit. Tiara is now also used for partitioning nuclear, mitochondrion, and plastid genomes where the respective rRNA and tRNA gene modeling parameters are used for Barrnap and tRNAscan-SE 2.0, respectively. MetaEuk is still used for exon-aware gene modeling in nuclear genomes but the database has been updated to include comprehensive clustered options as described in detail below. Coding gene modeling for organelles are called with Pyrodigal using organelle-specific genetic code translation tables (e.g. default uses trans_table = 4 for mitochondrion and trans_table = 11 for plastid genomes). The coding and non-coding gene modeling for nuclear and organelle genomes is wrapped in a standalone script called eukaryotic_gene_modeling.py which allows users to model genes that are acquired outside of VEBA. MAG naming scheme for eukaryotes follows [SampleID]__[Algorithm]__E.[Iteration]__[Name] (e.g. ERR2002407__METABAT2__E.1__bin.2) where iteration currently always is 1 but is used as a placeholder for future methodologies where iterative eukaryotic binning is supported.
binning-viral – Detection of viral genomes and quality assessment
The viral binning module has been entirely reimplemented. Viral binning is performed using either geNomad (default) (42) or VirFinder (43) to identify candidate viral genomes on a per contig basis. Genes are modeled using a modified version of Prodigal designed specifically for viruses called Prodigal-GV (42). The candidate viral genomes are then input into CheckV (44) where quality assessment removes poor quality or low confidence viral predictions. The default filtering scheme (recommended by CheckV developers (44,45)), is summarized by the following: (i) number of viral genes ≥5 × number of host genes; (ii) completeness ≥50%; (iii) CheckV quality is either medium-quality, high-quality, or complete and (iv) MIUViG quality is either medium-quality, high-quality, or complete. If geNomad is selected, then candidate plasmid sequences (along with any conjugation or AMR genes) are identified. Iterative binning is not applicable for viral detection as algorithms are executed on a per-contig basis and all viral genomes will be identified on first pass. MAG naming scheme for viruses follows [SampleID]__[Algorithm]__[Name] (e.g. SRR9668957__GENOMAD__Virus.1).
classify-prokaryotic – Taxonomic classification of prokaryotic genomes
The prokaryotic classification module is a useful wrapper around the updated GTDB-Tk 2.0 (46) and the r214.1 GTDB release (47). If genome clusters are provided, then it performs consensus lineage classification. A mash prescreen is used to screen organisms based on ANI using the following database we provide as an unofficial mirror of the mash sketched r214.1 GTDB (https://zenodo.org/records/8048187). Interactive Krona graphs are generated in HTML and tabular format for prokaryotic taxonomy.
classify-eukaryotic – Taxonomic classification of eukaryotic genomes
As in the prior release, the eukaryotic classification module utilizes genes from BUSCO’s eukaryota_odb10 marker set (and the curated score cutoffs), the target field of MetaEuk gene identifiers, and the taxonomic lineage associated with each source genome. The eukaryotic classification module can reuse previous intermediate files if genomes were binned using VEBA but also provides a workflow for classifying eukaryotic taxonomy from genome assemblies which runs MetaEuk in the background with MicroEuk100.eukaryota_odb10. The classification protocol has been previously described (4) and the only modification is that it can now handle taxa with incomplete lineages such is the case for many protists and fungi. If genome clusters are provided, then it performs consensus lineage classification. Interactive Krona graphs are generated in HTML and tabular format for eukaryotic taxonomy.
classify-viral – Taxonomic classification of viral genomes
The viral classification module utilizes geNomad's taxonomy if provided or runs the geNomad taxonomy module if genome assemblies are provided from a different source. If genome clusters are provided, then it performs consensus lineage classification.
cluster – Species-level clustering of genomes and pangenome-specific protein clustering
The cluster module has been completely reimplemented using state-of-the-art tools designed specifically for genome- and protein-level clustering. The cluster module first uses either skani (default) or FastANI (48) to compute pairwise ANI and these are used to construct a NetworkX graph objects for each organism type where nodes are genomes and weighted edges are ANI values (49). These NetworkX graphs are converted into subgraphs of connected components whose edges are filtered by a particular threshold (default ≥95% ANI) for species-level clustering. Proteins are partitioned by these species-level clusters (SLC) and protein clustering is performed on each pangenome to yield SLC-specific protein clusters (SSPC). VEBA 2.0 now supports MMseqs2 (default) (50) and Diamond DeepClust (51) in both sensitive clustering and linclust modes. These are provided with a convenient wrapper called clustering_wrapper.py that can be used for clustering in protein-space (MMseqs2 and Diamond DeepClust) and nucleotide-space (MMseqs2 only). This wrapper clusters sequences, relabels representatives, and provides representative sequences in either fasta or tabular format. Clustering is performed for prokaryotic, eukaryotic, and viral organisms separately. By default, clustering is global (i.e. containing all samples) with an optional support for local clustering on a sample-specific basis. Genomic and functional feature compression ratios are calculated for prokaryotic, eukaryotic and viral organisms separately as described previously (4). The nomenclature preferred by VEBA is the PSLC-, ESLC- and VSLC- for the prefix of each genome cluster (e.g. PSLC-1) with SSPC-appended for protein clusters (e.g. PSLC-1_SSPC-10) which indicates protein cluster 10 from pangenome 0 but this can be customized.
annotate – Functional annotation of protein sequences
Annotation is performed using best-hit annotations and profile HMMs. Diamond (52,53) is used to align proteins to the following databases: (i) UniRef50 (default) or UniRef90 (54); (ii) MIBiG (55); (iii) VFDB (56) and (iv) CAZy (57). HMMER (58) is used to profile sequences for protein domains using the following databases: (i) the Pfam database (59); (ii) NCBIfam-AMR (60); (iii) AntiFam (61) and (iv) KOfam (62). If clustering is performed prior, then the identifier mapping table can be provided as input to produce additional output which includes: (i) consensus annotations for each protein-level cluster; (ii) KEGG module completion ratios for genomes and SLCs using a custom MicrobeAnnotator build (63) from KEGG orthologs identified via KofamScan.
biosynthetic – Identify biosynthetic gene clusters and cluster in both protein and nucleotide space
The biosynthetic module is a new addition to VEBA 2.0 and is described in detail later under ‘New features and updates section below’. In brief, the biosynthetic module does the following: (i) identifies candidate biosynthetic gene clusters (BGC) and secondary metabolite pathways using antiSMASH (64); (ii) converts the GenBank formatted outputs into tabular and fasta formats; (iii) compiles Krona graphs of BGC protocluster types nested within genomes; (iv) aligns BGC proteins to MIBiG and VFDB using Diamond; (v) calculates novelty scores by identifying the ratio of proteins that have no homology to MIBiG; (vi) clusters BGCs in protein-space via MMseqs2 and builds prevalence tables relative to genomes and (vii) clusters full-length BGCs in nucleotide-space via MMseqs2 and builds prevalence tables relative to samples of origin. This module includes a convenient script called biosynthetic_genbanks_to_table.py that parses antiSMASH GenBank files to compile biosynthetic information relative to the protocluster-type, BGC, and BGC proteins.
profile-taxonomy – Taxonomic profiling of de novo genomes
The profile-taxonomy module is another new addition to VEBA 2.0 and is described in detail later under ‘New features and updates section below’. In brief, the profile-taxonomy module does the following: (i) builds a Sylph sketch database (65) for non-viral and viral genomes using the compile_custom_sylph_sketch_database_from_genomes.py script prior to running the module; (ii) converts paired reads to a query sketch database using Sylph; (iii) profiles the genome sketch databases using the query sketch database generated from the reads; (iv) reformats the Sylph output tables and (v) aggregates abundances with respect to SLC if clusters are provided.
profile-pathway – Pathway profiling of de novo genomes
The profile-pathway module is yet another new addition to VEBA 2.0 and is described in detail later under ‘New features and updates section below’. In brief, the profile-pathway module does the following: 0) builds a custom HUMAnN database based on protein annotations, identifier mapping tables, and taxonomy assignments using the compile_custom_humann_database_from_annotations.py script prior to running the module; (i) either accepts pre-joined reads, joins paired-end reads using bbmerge.sh from BBSuite, or a BAM file of paired-end reads and joins them; (ii) builds a Diamond database of proteins from the custom HUMAnN annotation table; (iii) uses HUMAnN for pathway profiling of the joined reads using the custom HUMAnN database (17) and (iv) reformats the output files.
phylogeny – Constructs phylogenetic trees based on concatenated alignments of marker genes
The phylogeny module has only minor changes relative to the initial VEBA 1.0 release. Briefly, the following methodology is performed: (i) identifying marker proteins using HMMSearch from the HMMER suite; (ii) creating protein alignments for each marker identified via MUSCLE5 (66); (iii) trimming the alignments using ClipKIT (67); (iv) concatenating the alignments; (v) approximately-maximum-likelihood phylogenetic inference using either FastTree2 (default) (68) or VeryFastTree (69) and (vi) optional maximum likelihood phylogenetic inference using IQ-TREE2 (70). More details such as using scoring parameters or determining the minimum number of genomes or minimum markers to include have been described previously (4).
index – Builds local or global index for alignment to genomes
The index module is largely unchanged from initial release and is used to produce mapping index objects. Currently, Bowtie2 (19) is the only alignment software packages supported. Details have been described previously (4).
mapping – Aligns reads to local or global index of genomes
The mapping module is largely unchanged from initial release and is used to generate counts tables at the genome, SLC, gene and SSPC levels. Currently, Bowtie2 (19) is the only alignment software packages supported but wrappers for STAR are provided for exon-aware read mapping (71). Details have been described previously (4).
Compositional network analysis and community detection
To build compositionally-valid association networks (i.e. co-occurrence) we implemented the following strategy: (i) profiling the taxonomic abundances at the genome and SLC-level using VEBA profile-taxonomy module; (ii) computing compositionally-valid ensemble association networks (NDraws = 100) (72) using partial correlation with basis shrinkage (73–75) with the SLC abundances; (iii) subsetting only the positive associations; (iv) computing consensus Leiden communities (NSeeds= 100) (76) and (v) calculating the weighted degree for each SLC and ranking by connectivity.
Visualization
Genomic neighborhoods were visualized using DNA Features Viewer v3.1.3 (77). Phylogenetic trees were constructed from multiple sequence alignments computed by MUSCLE v5.1 (78) and visualized using Toytree v2.0.5 (79). Multiple sequence alignments were visualized using pyMSAviz v0.4.2 (https://moshi4.github.io/pyMSAviz/). CRISPR-Cas systems were identified in genomes recovered from VEBA using CRISPRCasTyper v1.8.0 (80) which generates plots using drawsvg v2.3.0 (https://github.com/cduck/drawsvg). Association networks and genome cluster networks were visualized using NetworkX v3.2.1 (49). Clustered heatmaps and bar charts were visualized using Seaborn v0.13.2 (81) and Matplotlib v3.8.3 (82).
Results and discussion
Walkthroughs and workflow tutorials
In VEBA’s mission toward FAIR principles and widespread accessibility, we have compiled several walkthroughs on our GitHub. We provide multiple end-to-end workflows including a complete metagenomics analysis which covers assembling metagenomic reads, binning, clustering, classification, and annotation. In a similar vein, we provide a walkthrough for recovering viruses from metatranscriptomics datasets which covers assembling metatranscriptomic reads, viral binning, clustering, and classification. We also show how to use the unbinned contigs in a pseudo-coassembly, a concept described in the initial VEBA publication (4), with guidelines on when this should be performed. We provide a walkthrough for setting up a bona fide co-assembly for metagenomics or metatranscriptomics which may be useful in scenarios where all or most samples are of low sequencing depth relative to the microbial diversity that is present. This walkthrough goes through concatenating reads, creating a reads table, co-assembly of concatenated reads, aligning sample-specific reads to the co-assembly for multiple sorted BAM files, and mapping reads for scaffold/transcript-level counts. For abundance estimation walkthroughs, we cover traditional approaches for aligning reads using the mapping and index modules as well as profiling approaches for both genome-resolved taxonomic abundance and pathway profiling using genomes identified through VEBA or elsewhere. Lastly, we provide walkthroughs on converting counts tables to anndata format for integration with scverse (83) and BIOM format (84) for integration with QIIME2 (85). We also include additional miscellaneous walkthroughs such as downloading/preprocess fastq files from NCBI, phylogenetic inference, bioprospecting for BGCs, screening for CRISPR-Cas systems, and adapting commands for use with Docker containers.
New features and updates
Expanded functionality, streamlined user-interface and Docker containerization
The updated VEBA 2.0 includes 20 modules and 95 accessory scripts to streamline workflows (Figure 1, Table 1) with 51 peer-reviewed software dependencies and 21 databases (Supplementary Table S1). Since the initial release, VEBA has included hundreds of GitHub commits to add new features suggested by the user-base and to address issues when flagged by the community. As each module requires a unique set of dependencies, groups of similar modules (e.g. profile-taxonomy and profile-pathway) use shared Conda environments where dependencies are installed (e.g. VEBA-profile_env). While VEBA 1.0 required users to activate specific Conda environments for each workflow this is now automated with a convenient wrapper program. For example, the previous functionality required the following syntax: ‘source activate VEBA-preprocess_env && preprocess.py ${PARAMS}’ while the current functionality is streamlined to ‘veba –module preprocess –params ‘${PARAMS}’’ where the Conda environment is abstracted and determined automatically in the backend.
Table 1.
Module | Description | Docker Registry |
---|---|---|
preprocess | Fastq quality trimming, adapter removal, decontamination, and read statistics calculations (short reads) | https://hub.docker.com/r/jolespin/veba_preprocess |
preproces-long | Fastq quality trimming, adapter removal, decontamination, and read statistics calculations (long reads) | https://hub.docker.com/r/jolespin/veba_preprocess |
assembly | Assemble reads, align reads to assembly, and count mapped reads (short reads) | https://hub.docker.com/r/jolespin/veba_assembly |
assembly-long | Assemble reads, align reads to assembly, and count mapped reads (long reads) | https://hub.docker.com/r/jolespin/veba_assembly |
coverage | Align reads to (concatenated) reference and counts mapped reads (short reads) | https://hub.docker.com/r/jolespin/veba_assembly |
coverage-long | Align reads to (concatenated) reference and counts mapped reads (long reads) | https://hub.docker.com/r/jolespin/veba_assembly |
binning-prokaryotic | Iterative consensus binning for recovering prokaryotic genomes with lineage-specific quality assessment | https://hub.docker.com/r/jolespin/veba_binning-prokaryotic |
binning-eukaryotic | Binning for recovering eukaryotic genomes with exon-aware gene modeling and lineage-specific quality assessment | https://hub.docker.com/r/jolespin/veba_binning-eukaryotic |
binning-viral | Detection of viral genomes and quality assessment | https://hub.docker.com/r/jolespin/veba_binning-viral |
classify-prokaryotic | Taxonomic classification of prokaryotic genomes | https://hub.docker.com/r/jolespin/veba_classify-prokaryotic |
classify-eukaryotic | Taxonomic classification of eukaryotic genomes | https://hub.docker.com/r/jolespin/veba_classify-eukaryotic |
classify-viral | Taxonomic classification of viral genomes | https://hub.docker.com/r/jolespin/veba_classify-viral |
cluster | Species-level clustering of genomes and lineage-specific orthogroup detection | https://hub.docker.com/r/jolespin/veba_cluster |
annotate | Annotates translated gene calls several databases | https://hub.docker.com/r/jolespin/veba_annotate |
phylogeny | Constructs phylogenetic trees given a marker set | https://hub.docker.com/r/jolespin/veba_phylogeny |
index | Builds local or global index for alignment to genomes | https://hub.docker.com/r/jolespin/veba_mapping |
mapping | Aligns reads to local or global index of genomes | https://hub.docker.com/r/jolespin/veba_mapping |
biosynthetic | Identify biosynthetic gene clusters in prokaryotes and fungi | https://hub.docker.com/r/jolespin/veba_biosynthetic |
profile-pathway | Pathway profiling of de novo genomes | https://hub.docker.com/r/jolespin/veba_profile |
profile-taxonomy | Taxonomic profiling of de novo genomes | https://hub.docker.com/r/jolespin/veba_profile |
Many of VEBA’s software dependencies are incompatible in the same compute environment. While VEBA’s installation process remains streamlined with partitioning compute environments for modules with similar dependencies in specific Conda environments, VEBA 2.0 now supports containerization via Docker. Each Conda environment has been prepackaged into Docker containers for seamless usage on local machines and high-performance compute servers where containers are supported (e.g. AWS). Each Docker container comes equipped with input, output, and database mount points that allow for generalized syntax. As the switch from Conda-based workflows to containerized solutions can have a steep learning curve, VEBA’s documentation also provides walkthroughs that guide the user through pulling and running containers on their local machine or on AWS.
MicroEuk100/90/50: Clustered database of ∼80M microeukaryotic protein sequences
VEBA’s Microeukaryotic Protein Database has been completely redesigned using the logic of UniRef and their clustered database (54). The initial microeukaryotic protein database from the previous publication, hereby referred to as MicroEuk_v2, contained 48 006 918 proteins from 44 647 source organisms while the updated database, MicroEuk_v3, contains 79 920 430 proteins from 52 495 source organisms (https://zenodo.org/records/10139451). As in the prior major release, MicroEuk_v3 concentrates on microeukaryotic organisms while excluding higher eukaryotes, as the former are the most common eukaryotes captured by shotgun metagenomics and metatranscriptomics. Source organisms in this context are defined as organisms from which the proteins were derived.
MicroEuk_v3 is built using the following logic: (i) remove stop codons if they exist; (ii) filter proteins that are <11 AA; (iii) convert protein sequence to a unique md5 hash to use as the identifier and (v) add protein if it does not already exist in the database. The removal of stop codons serves 2 functions; first, it creates slightly smaller file sizes and second, more importantly, it ensures that two identical proteins that differ only in the presence of a stop codon will have the same md5 hash for true dereplication. The removal of proteins <11 AA long is to avoid greedy clustering as implemented by UniRef (54). The databases are added with the following priority: (i) JGI MycoCosm (86), (ii) JGI PhycoCosm (87), (iii) EnsemblProtists (88), (iv) MMETSP (89), (v) TARA SAGv1 (90), (vi) EukProt (91), (vii) EukZoo (92), (viii) TARA SMAGv1 (93) and (ix) NCBI non-redundant (protists and fungi) (94) as detailed in Table 2. The majority of MicroEuk proteins (86.8%) are either genome or transcriptome resolved (source organisms) from databases 1–8 while the remaining protein sequence space is padded with NCBI’s non-redundant database (hereby referred to as nr) to provide additional context for eukaryotic gene modeling and classification as these have reliable taxonomic identifiers.
Table 2.
Dataset | MicroEuk100 | MicroEuk90 | MicroEuk50 | MicroEuk100. eukaryota_odb10 |
MicroEuk_v2 | |
---|---|---|---|---|---|---|
System Information | Number of sequences | 79 920 431 | 51 767 730 | 29 898 853 | 713072 | 46 345 612 |
File size (Gzipped) | 19 GB | 13 GB | 6.5 GB | 209 MB | 11 GB | |
Compression of MicroEuk100 | 0% | 35.20% | 62.60% | 99.12% | - | |
Source Organisms | MycoCosm | 2503 | 2503 | 2503 | 2500 | - |
PhycoCosm | 174 | 174 | 174 | 173 | - | |
EnsemblProtists | 233 | 227 | 227 | 212 | - | |
MMETSP | 578 | 578 | 578 | 570 | 677 | |
TARA_SAGv1 | 8 | 8 | 8 | 8 | - | |
EukProt | 366 | 355 | 348 | 310 | 267 | |
EukZoo | 27 | 25 | 22 | 18 | 95 | |
TARA_SMAGv1 | 389 | 389 | 389 | 388 | - | |
NR_Protists-Fungi | 48 217 | 11 279 | 4364 | 1523 | 43 655 | |
Total including NR | 52 495 | 15 538 | 8613 | 5702 | 44 647 | |
Total excluding NR | 4278 | 4259 | 4249 | 4179 | 1039 | |
MicroEuk100 representation including NR | 100 | 29.59900943 | 16.40727688 | 10.86198686 | - | |
MicroEuk100 representation excluding NR | 100 | 99.55586723 | 99.32211314 | 97.6858345 | - |
As UniRef100 contains non-redundant proteins, MicroEuk100 contains the comprehensive non-redundant database of microeukaryotic proteins while MicroEuk90 and MicroEuk50 are clustered at 90% identity and 50% identity (80% query coverage) in a stepwise manner. Excluding the proteins padded from nr, the clustered databases include most of the genome/transcriptome-resolved source organisms from MicroEuk100 with MicroEuk90, MicroEuk50 and MicroEuk100.eukaryota_odb10 at 99.56%, 99.32% and 97.69%, respectively (Table 2). The MicroEuk100.eukaryota_odb10 is a subset of MicroEuk100 that contains only hits from BUSCO’s eukaryota_odb10 marker database which is used for eukaryotic classification.
Fast and memory-efficient genome- and protein-level clustering
VEBA 2.0 has substantially improved the efficiency and scalability of both genome- and protein-level clustering by incorporating the most cutting-edge open-source tools available. Until 2023, FastANI had been the main tool used for pairwise genome ANI calculations. However, to calculate pairwise associations the genome must be loaded into an index twice followed by N2 pairwise ANI calculations. While this is not a problem for small to mid-sized datasets, this implementation can cause significant performance issues for larger datasets. Recently, there has been a major innovation for ANI calculations with skani(∼25× faster than FastANI) which has a module designed specifically for pairwise ANI calculations that loads the genomes into an index only once and then performs (N2– N)/2 calculations. In addition to increased performance, skani also calculates alignment factors and confidence intervals for ANI between genomes. Further skani has higher performance on fragmented genomes (typical of metagenome-assembled genomes) and small genomes (e.g. viruses) with tunable parameters. VEBA 2.0 provides presets for clustering various genomes based on guidelines detailed in the skani documentation and sets skani as the default ANI calculation algorithm while providing support for FastANI to retain previous functionality. As in previous versions, NetworkX’s connected_components algorithm is used to identify species-level genome clusters (SLC). In addition, the NetworkX graph objects are serialized for seamless downstream usage such as generating constellation plots of genome clusters.
While the performance gains of genome clustering have been improved, the most substantial improvements have been implemented in protein space. VEBA 1.0 used OrthoFinder for clustering in protein space. While OrthoFinder is useful for detailed protein orthology, it was not designed for large-scale protein clustering as it creates several output files per protein cluster including alignments and phylogenetic trees allocating a significant amount of time dedicated to system I/O for hundreds of thousands of intermediate files. VEBA 2.0 now includes options for using either MMseqs2 or Diamond's DeepClust algorithm. With either MMseqs2 or DeepClust used in the backend, VEBA can calculate protein clusters in linear time with the linclust algorithm and output representative sequences for each protein cluster making downstream tasks such as annotation less resource intensive. While proteins are only clustered within a SLC to yield SLC-specific protein clusters (SSPC), VEBA provides wrappers around MMseqs2 and DeepClust for other clustering tasks such as the large-scale protein clustering used to produce MicroEuk100/90/50 databases.
In addition to the essentials of protein clustering, VEBA 2.0 also produces protein-cluster prevalence tables which are then used to identify core proteins within SLCs (i.e. pangenomes) and singleton proteins that are only in a single genome within a SLC. These core proteins are output into separate fasta formatted files for each SLC in both protein and nucleotide space which can be used for downstream analysis such as marker gene detection or ratios of non-synonymous to synonymous mutation (dN/dS) calculations used in evolutionary analyses. Further, VEBA also includes an independent script called marker_gene_clustering.py for determining marker genes from these protein-cluster prevalence tables which identifies marker genes that are core within a pangenome and not detected in any other pangenomes. The marker gene detection capabilities of VEBA 2.0 are designed to be used for building custom profiling databases such as Metaphlan4 (95) or MIDAS2 (96).
Automatic calculation of feature compression ratios
In VEBA 1.0, the concept of a feature compression ratio (FCR) was introduced as a measure of a community's complexity from an unsupervised perspective. While the theory of FCR was established, there was no automated calculation of this ratio within VEBA 1.0 and the calculation needed to be performed post hoc. To address this issue, VEBA 2.0 automates FCR calculations in both genome- and protein-space. To fully leverage the power of FCR when analyzing the complexity of a dataset, VEBA 2.0 has adapted clustering to be performed both at the global and local level where global and local refer to inter- and intra-sample clustering, respectively, with local clustering turned off by default. This functionality allows FCR calculations to be calculated for an entire dataset but also for each sample within a dataset. The FCR calculations are expected to provide useful insight on the complexity of a dataset or sample by providing a metric for the redundancy in genome and protein space (i.e. taxonomy and functionality).
Large/complex metagenomes and long-read technology support
Since version 1.0, VEBA has used SPAdes-based programs such as SPAdes, metaSPAdes and rnaSPAdes for genomic, metagenomic, and transcriptomic assembly. While the resulting assemblies are high quality, SPAdes-based assemblers can be resource intensive with large and complex genomes such as soil and sediment metagenomes. MEGAHIT is another assembler that has more accommodating memory requirements than SPAdes-based assemblers and is particularly useful for large and complex metagenomes (23,97). While metaSPAdes remains the default assembler in VEBA 2.0, there is now an option to use MEGAHIT with seamless access to the large and complex preset. In addition to adding a new assembler, VEBA 2.0 also addresses the critical, albeit rare, issue of more than one contig having the same name which can occur with very large complex datasets with many samples. To bypass this issue, VEBA prepends the sample name to the contig identifiers by default but this can be customized.
With the increased accuracy and widescale adoption of long-read technologies such as Oxford Nanopore and PacBio in genomics, transcriptomics and their meta- counterparts, the need for VEBA to accommodate long reads was inevitable to properly address the directive of genome-resolved metagenomics. To accommodate long reads, VEBA has restructured fastq_preprocessor (a light-weight extension of VEBA and the basis for the preprocess module) to include short-read and long-read modules wrapped natively by VEBA with the latter including chopper and minimap2 instead of fastp and bowtie2. VEBA now also provides the assembly-long module which includes Flye, MetaFlye and Minimap2 instead of SPAdes, metaSPAdes and bowtie2. Starting with Flye v2.9+, which is included with VEBA 2.0, users are no longer required to specify an assembly size making general usage much more accessible especially for metagenomics. The coverage calculation has been adapted with coverage-long which includes the same coverage method but using Minimap2 instead of Bowtie2. Last of all, the viral, prokaryotic, and eukaryotic binning modules now incorporate long reads as well.
Bioprospecting and natural product discovery support
antiSMASH is a very popular package that is used for secondary metabolite identification and characterization in natural product discovery (64). However, interpreting the results in high-throughput can be challenging as the output formats include JSON and GenBank both of which are verbose and difficult to query for multiple genomes. To provide increased accessibility to high-throughput bioprospecting, the VEBA 2.0 update includes a new module called biosynthetic that runs antiSMASH on each genome, assigns structured identifiers for each biosynthetic gene cluster and each gene within the cluster, constructs multiple outputs that can be queried for multiple genomes, scores the novelty of the BGC, and clusters the BGCs.
The first stage of VEBA biosynthetic is an antiSMASH wrapper and provides the following output: (i) tabular outputs at both the BGC and gene level; (ii) fasta file for each genome containing BGCs in nucleotide space with informative attributes in the description such as the BGC length, GC-content, number of genes, and whether or not the BGC is on the edge of contig and (iii) fasta file for each genome containing the proteins for all the BGCs. The structured identifier scheme for BGCs is [id_genome]|[id_contig]|[id_region] while the scheme for BGC genes is [id_bgc]_[gene_position_on_bgc] | [start_on_contig]:[end_on_contig] ([strand]). For instance, the BGC gene SRR13615824__METABAT2__P.1__bin.3 |SRR13615824__k127_496 383|region001_1|1:184 (+) is the first gene found on the SRR13615824__METABAT2__P.1__bin.3|SRR13615824__ k127_496 383|region001 BGC from genome SRR13615824__ METABAT2__P.1__bin.3 between position 1–184 in the positive direction of contig SRR13615824__k127_496383.
The second stage of the biosynthetic module aligns all the translated BGC genes to MIBiG (55) and VFDB (56). The ratio of BGC genes that have homology to MIBiG is used to compute the novelty score for a BGC. The novelty score was developed for VEBA 2.0 to quantify the percentage of genes within a BGC that have no homology to MIBiG and, thus, can be used for flagging BGCs with potentially novel activity. Future versions of VEBA will support additional novelty metrics (98). The annotations are summarized into a table that can be used for investigating individual protein products within a BGC.
The third and final stage of the biosynthetic module clusters BGCs in both protein and nucleotide space using MMseqs2 each with their own set of parameters for minimum coverage and identity. The proteins are clustered to produce a BGC protein cluster where identifier mapping tables, representative sequences, and prevalence tables are output. The prevalence table is structured with the genomes as the rows, BGC protein clusters as the columns, and the number of BGC proteins in a genome that are within each cluster. For the nucleotide clustering, MMseqs2 is also used for clustering with identifier mapping tables, representative sequences, and prevalence tables being the output as well. However, the prevalence tables for BGC nucleotide clusters contain samples for the rows and BGC nucleotide clusters for the columns. The prevalence tables can easily be assessed post hoc to identify singleton BGCs and core BGCs. Further, the prevalence tables can be converted to a Boolean matrix and pairwise distance for the genomes or samples can be computed using Jaccard distance which can be directly integrated into unsupervised machine learning methodologies such as principal coordinate analysis or agglomerative hierarchical clustering.
Ribosomal RNA, transfer RNA and organelle support
While VEBA 1.0 focused mainly on protein-coding sequence (CDS) genes, the VEBA 2.0 implementation automates the detection of ribosomal RNA (rRNA) and transfer RNA (tRNA) using Barrnap and t-RNAscan-SE 2.0, respectively, which are now added directly to the GFF gene modeling output. In addition to fasta and GFF records for non-coding RNA, secondary structures are also provided for tRNA sequences. For eukaryotic gene modeling, VEBA 2.0 automates the identification of plastid and mitochondrion organelles using Tiara and performs organelle-specific gene modeling for CDS, rRNA and tRNA. Prokaryotic and organelle CDS genes previously modeled with Prodigal are now performed more efficiently with Pyrodigal.
Genome-resolved taxonomic and pathway profiling
Reads-based profiling of shotgun metagenomic and metatranscriptomics have been established as computationally efficient techniques for quantifying taxonomic (e.g. Sylph (65), Kraken 2 (99), Ganon (100)) and pathway-level (e.g. HUMAnN) abundance and expression, respectively. While small-to-medium sized datasets can be assessed with traditional read alignment tools, this becomes unfeasible with larger numbers of genomes and pathways introducing more genomic redundancies and greater sequence complexity. Despite the computational advantages of reads-based profiling, there are several caveats with the most notable being related to the available databases. More specifically, the findings from these approaches are only as informative as the databases used for profiling allow and most are designed for specific environments. Even in scenarios where the appropriate ecological site is analyzed with respect to the database being used, there is the issue of not knowing which genome the feature is directly associated with in the context of the query samples. The ability to directly associate a specific read with a specific microbe is paramount when studying species with similar strains that occupy different ecological niches (e.g. Prochlorococcus ecotypes (101)). While powerful tools exist for building robust custom genome-resolved prokaryotic databases (e.g. Struo2 (102)) they are not specifically designed to handle eukaryotic organisms. VEBA 2.0 includes methodologies to build custom databases from genomes (either derived from VEBA’s binning modules or externally acquired) that can be used for taxonomic abundance or pathway profiling. In addition to profiling methods, VEBA 2.0 also provides tools to easily convert counts tables (either generated from profiling or traditional alignment methods) to biom, anndata, and pandas pickle formats.
For taxonomic abundance profiling, VEBA’s profile-taxonomy module uses Sylph an ultrafast taxonomic profiling method for shotgun metagenomic (and metatranscriptomic) samples by abundance-corrected minhash (65). Sylph takes 10× less CPU time and uses 30x less memory than Kraken2. Another benefit of using Sylph is the ability to customize databases for fragmented genome assemblies and small genomes such as those found within most viruses. VEBA uses custom Sylph presets designed for viral genomes and non-viral genomes such as prokaryotes and eukaryotes for maximum utility. As with the traditional mapping module based on Bowtie2 alignments, VEBA presents an option for aggregating genome-level abundances to SLC-level abundances if clustering results are provided.
For pathway abundance profiling, VEBA 2.0 uses HUMAnN which has been the industry-standard methodology for profiling the abundance of metabolic pathways and other molecular functions. However, as the name suggests, HUMAnN databases are developed with human microbiomes as the focus and not environmental samples but the method itself is generalizable. VEBA compiles custom HUMAnN databases using the genome-resolved proteins, taxonomic classifications, and UniRef50/90 annotations identified with VEBA’s binning, classification, and annotation modules (or acquired elsewhere). VEBA’s profile-pathway module not only produces stratified genome-level metabolic pathway abundances but also stratified metabolic pathway completion ratios. As HUMAnN operates on single-ended reads, VEBA automates read joining via BBSuite's bbmerge.sh program if paired-ended reads or BAM files are used as input. The module also produces a full accounting of reads that align to the custom HUMAnN database via Diamond and fasta files for reads that do not align.
Expanded protein annotation database
VEBA 1.0 heavily relied on NCBI’s nr database. While nr is extremely comprehensive, the database is massive on disk (∼200 GB), contains many redundant annotations, and has an inconsistent taxon-specific naming scheme for the protein records. Instead of using nr as the base annotation, VEBA 2.0 uses either UniRef90 or UniRef50 for well-characterized and under characterized systems, respectively. VEBA 2.0 has retained the Pfam and KOfam annotations via HMMER3 and KofamScan, respectively; although, these may be replaced with PyHMMER in future versions. VEBA 2.0 also includes several additional databases for protein annotation: (i) MIBiG for secondary metabolite synthesis; (ii) VFDB for virulence factors; (iii) CAZy for catalytic/carbohydrate metabolism; (iv) NCBIfam-AMR for antimicrobial resistance and (v) AntiFam for candidate spurious gene calls.
VEBA 2.0 provides support for annotating either an entire protein database or clustered representatives of a protein database which can be useful for large and complex datasets. With a more uniform annotation syntax using UniRef instead of nr, VEBA 2.0 provides more interpretable consensus annotations for SSPCs. These consensus annotations are useful for assessing the full functional space of protein domains that are within a protein cluster of a pangenome. Annotating SSPCs is much faster than annotating each protein without a significant decrease in information content. For example, consider the 41 971 SSPCs identified in the reanalysis of the marine eukaryotic organisms from the original VEBA publication (described below). On average for each SSPC, 99% of the Pfam domains within all proteins of the cluster were detected in the representative of the cluster. Less than 0.5% of the SSPC representatives were missing Pfam domains that were exclusive to one of the proteins within the cluster.
As KEGG orthology is computed by KofamScan, VEBA now provides a customized version of MicrobeAnnotator's ko_mapper.py module called module_completion_ratios.py that automates the calculation of KEGG module completion ratios for a genome (and pangenome if clustering results are provided). This customized script leverages the strengths of MicrobeAnnotator while tailoring the input and output to synergize with VEBA. The module completion ratio scripts can be used externally without the need for running the full annotation module allowing flexibility for broad usage.
Identification and classification of mobile genetic elements
VEBA 2.0 introduces substantial improvements in the identification and classification of mobile genetic elements such viruses and plasmids; namely, geNomad which is the new default backend algorithm. geNomad is a classification and annotation framework that combines information from gene content and a deep neural network to identify sequences of plasmids and viruses while using >200 000 marker protein profiles to provide functional gene annotation and taxonomic assignment (42). However, to retain similar functionality to previous versions VEBA continues to support VirFinder but classification is performed with geNomad regardless of the identification algorithm. The taxonomy for geNomad uses the most recent revision of viral taxonomy nomenclature ratified by International Committee on Taxonomy of Viruses (103) which is currently not yet supported with vContact2 (104). However, the vContact developers are currently working on an updated version which is likely to include the recent change in viral taxonomy nomenclature and may be included as an option in future updates. Lastly, there have also been advances in CheckV which have improved the ability to quality assess viruses.
Native support for candidate phyla radiation quality assessment and memory-efficient genome classification
VEBA 1.0 relied on CheckM for prokaryotic quality assessment as this was industry-standard at the time of release. Although, CheckM could not natively handle Candidate Phyla Radiation (CPR) organisms it contained a post hoc workflow for using custom marker sets to correct the quality for CPR. VEBA 1.0 automated this procedure to abstract away the involved workflow required to correctly assess quality on CPR organisms but it required running GTDB-Tk in the backend, identifying CPR, running CheckM separately, and updating the existing tables which required considerably more compute time and memory allocation per sample processed (∼128GB at the time). With the release of CheckM2, CPR quality assessment is handled natively and bypasses the need to run GTDB-Tk or rerun quality assessment post hoc. This also drops the compute time and memory allocation substantially (∼16GB per sample). Further, with iterative binning, poor quality MAGs are removed and added back to the grouping of unbinned contigs for the next round. As GTDB-Tk runs were computationally expensive, the CPR adjustment was only implemented after the last iteration which made it possible to include poor quality MAGs that could have been rebinned with higher confidence if the proper quality assessments were determined at each iteration; CheckM2 bypasses this edge case.
There have also been major improvements in GTDB-Tk that have lowered the resource requirements substantially while including more comprehensive reference databases. VEBA 1.0 used GTDB-Tk v1.7.0 with GTDB vR202 (∼128GB memory) while the VEBA 2.0 uses GTDB-Tk v2.3.x with GTDB vR214.1 (∼72GB memory) with faster runtime. The newer version of GTDB-Tk also supports ANI screening using a mash database but this is not officially precompiled nor available with the installation or database download. Using an ANI prescreen can reduce computation by more than 50% depending on whether the set of input genomes have a high scoring representative in the database. In addition, the ANI prescreen reduces the number of genomes that need to be classified by pplacer which reduces computation time substantially (up to 60%). VEBA 2.0 provides an unofficial mirror for the mash build of the GTDB vR214.1 database (https://zenodo.org/records/8048187) and uses this by default in the backend without any user intervention allowing for effortless access to the most cutting edge prokaryotic classifications.
Standalone support for generalized multi-split binning
In 2021, a novel deep learning algorithm called VAMB was introduced for using variational auto encoder models for binning genomes from metagenomic assemblies (105). While VAMB is not currently supported by VEBA due to dependency conflicts with existing packages, VAMB introduced an intuitive new approach for binning which they refer to as ‘multi-split binning’. In multi-split binning, sample-specific assemblies are concatenated but information regarding the samples of origin are retained. Since VAMB is not reliant on marker genes (e.g. MaxBin2), these contigs can be binned together allowing for more data available for modeling by the neural networks. Once the multi-sample binning is completed, the bins are partitioned according to their samples. While VAMB is the first to implement this simple yet powerful approach, the methodology isn’t requisite to VAMB and can be generalized. To empower researchers with this approach, we have provided an option in our binning_wrapper.py that provides this functionality for binning algorithms that do not require marker sets such as Metabat2 and CONCOCT. We constructed a style guide for binning algorithms implemented in the binning_wrapper.py, which is used in the backend of the prokaryotic and eukaryotic binning modules. This technology is designed to be adaptable to handle new binning algorithms if they do not require optimizing marker gene sets for each bin.
Automated phylogenomic functional category feature engineering support
Amalgamations are a compositionally-valid dimensionality reduction technique that aggregate low-level features into engineered features using either data-driven approaches (106) or user-specified categories (107). The PhyloGenomic Functional Category (PGFC) is a special case of amalgamations designed specifically for microbiomes where counts from low-level features (e.g. SSPCs) are aggregated with respect to a taxonomic category (SLC) and a functional category (KEGG module) producing outputs similar to HUMAnN (17). These composite features can be used for downstream statistical analysis and can unpacked back to original features (e.g. SSPCs) unlike other dimensionality reduction methods such as PC[o]A, t-SNE, or UMAP. PGFCs are built using the EnsembleNetworkX Python package (72) via the CategoricalEngineeredFeature class. VEBA 2.0 provides a script compile_phylogenomic_functional_categories.py which builds PGFCs and genome-level (or SLC-level) MCRs with respect to each sample. Since VEBA calculates MCRs for each PGFCs on a per sample basis, they can be used for quality assessment. For example, as it is standard practice to filter low-prevalence compositional features (73), low-prevalence PGFCs can be filtered both by their counts and by MCR thresholds (e.g. MCR < 50%). This functionality provides users with additional approaches for deriving meaning for large and complex datasets.
Visualizations of hierarchical data and phylogenies
While a minor addition, VEBA 2.0 automates the visualization of hierarchical data types and phylogenetic trees. For instance, VEBA 2.0 builds interactive HTML pie charts in the form of Krona graphs (108) for prokaryotic and eukaryotic classifications as well as biosynthetic gene clusters within genomes. In addition, phylogenetic trees are rendered automatically using ETE3 (109) and saved as PDF documents for easily assessing vectorized dendrograms with the added ability of text searching interactively in PDF viewers. While not a visualization, VEBA also provides the NetworkX graph objects for genome clustering which can be used to produce constellation plots showing each node as a genome and each connection as the ANI connecting the genomes.
Case studies.
Revisiting marine phytoplankton case studies from biotechnological and public health perspectives
The VEBA 1.0 publication analyzed several datasets as case studies to showcase the capabilities. One of these case studies was the Plastisphere microbiome (BioProject: PRJNA777294, N = 44 metagenomic samples) dataset which included environmental microbial communities from early and mature stage biofilms formed on macroplastics in a marine environment (110). Another case study included the MarineAerosol microbiome (BioProject: PRJEB20421, N = 64 metagenomic samples, 90 gigabases) dataset which investigated ocean–atmosphere aerosolization mesocosms and included environmental microbial communities in ocean water collected before, during, and after an algal bloom using the Wave Flume ocean simulator (111).
Plastics include a wide range of synthetic or semi-synthetic organic compounds that are durable, malleable, and cheap to manufacture. While the combination of these traits led to accelerated human advancement, the widespread production and distribution of plastics has simultaneously caused public health and environmental crises. The durability property that makes plastic an engineering marvel allows plastics to circulate through the ocean over the course of hundreds to thousands of years before degrading (112). Plastic represents ∼80% of ocean debris (113) and between 4.8 and 12.7 million metric tons are predicted to be deposited into the ocean every year (114). The high deposition and slow degradation rates have caused an accumulation of plastic in the world's oceans that is projected to exceed 150 million tons by 2025 (114,115).
From an environmental perspective, plastic pollution threatens marine life across the trophic levels and accumulates in large mid-ocean gyres due to ocean currents. Plastics degrade into micro- and nano-plastic particles containing chemicals that can enter the tissues of marine organisms, including species consumed by humans (116). Further, previous research has shown that microplastics can transmit protozoan pathogens (117), induce reproductive toxicity (118), and have been identified across sensitive regions of the human body including human waste (119) and the placenta (120).
With VEBA 1.0, we were able to recover five eukaryotic genomes from the Plastisphere (early and mature-stage biofilms) and 3 eukaryotic genomes from the MarineAerosol datasets (epipelagic and sea-surface microlayers) which were not detected in the original studies (Table 3). All the eukaryotic genomes were medium-to-high quality (BUSCO completion ≥50% & contamination <10%). While the backend eukaryotic binning algorithms of VEBA have not changed since the initial release, VEBA 2.0 has introduced more comprehensive gene modeling databases, more memory efficient gene modeling parameters as defaults, non-coding RNA detection, and organelle detection. The objective for reanalyzing these eukaryotic genomes was to demonstrate the increase in information gain per genome and how this new information can be used for bioprospecting and public health assessments.
Table 3.
Genome | Source | Taxonomy classification | CDS MicroEuk_v2 | CDS MicroEuk50 | CDS MicroEuk90 | CDS MicroEuk100 |
---|---|---|---|---|---|---|
ERR2002407__METABAT2__E.1__bin.2 | Epipelagic Layer | c__Coscinodiscophyceae; | 15 655 | 16 478 | 16 755 | 17 098 |
o__Thalassiosirales; | ||||||
f__Thalassiosiraceae; | ||||||
g__Stephanocyclus; | ||||||
s__Stephanocyclus meneghinianus | ||||||
ERR2002416__METABAT2__E.1__bin.1 | Epipelagic Layer | c__Coscinodiscophyceae; | 17 176 | 18 258 | 18 518 | 18 932 |
o__Thalassiosirales; | ||||||
f__Thalassiosiraceae; | ||||||
g__Stephanocyclus; | ||||||
s__Stephanocyclus meneghinianus | ||||||
ERR2002419__METABAT2__E.1__bin.2 | Sea-Surface Microlayer | c__Coscinodiscophyceae; | 17 127 | 18 192 | 18 459 | 18 843 |
o__Thalassiosirales; | ||||||
f__Thalassiosiraceae; | ||||||
g__Stephanocyclus; | ||||||
s__Stephanocyclus meneghinianus | ||||||
SRR17458614__METABAT2__E.1__bin.2 | Mature Plastic Biofilm | c__Bacillariophyceae; | 11 475 | 12 196 | 12 249 | 12 384 |
o__Naviculales; | ||||||
f__Phaeodactylaceae; | ||||||
g__Phaeodactylum; | ||||||
s__Phaeodactylum tricornutum | ||||||
SRR17458615__METABAT2__E.1__bin.2 | Early Plastic Biofilm | c__Bacillariophyceae; | 11 434 | 12 169 | 12 229 | 12 362 |
o__Naviculales; | ||||||
f__Phaeodactylaceae; | ||||||
g__Phaeodactylum; | ||||||
s__Phaeodactylum tricornutum | ||||||
SRR17458630__METABAT2__E.1__bin.3 | Mature Plastic Biofilm | c__Pelagophyceae; | 19 827 | 21 130 | 21 344 | 21 647 |
o__Sarcinochrysidales; | ||||||
f__Chrysocystaceae; | ||||||
g__Chrysoreinhardia; | ||||||
s__ | ||||||
SRR17458638__METABAT2__E.1__bin.3 | Mature Plastic Biofilm | c__Bacillariophyceae; | 21 006 | 23 208 | 23 336 | 23 612 |
o__Naviculales; | ||||||
f__Naviculaceae; | ||||||
g__Seminavis; | ||||||
s__Seminavis robusta | ||||||
SRR17458638__METABAT2__E.1__bin.2 | Mature Plastic Biofilm | c__Bacillariophyceae; | 15 008 | 15 548 | 15 691 | 16 025 |
o__Thalassiophysales; | ||||||
f__Catenulaceae; | ||||||
g__Amphora; | ||||||
s__Amphora coffeiformis |
The updated eukaryotic_gene_modeling_wrapper.py script was run using MicroEuk100, MicroEuk90, MicroEuk50 and MicroEuk_v2. In all cases, more genes were modeled using the updated protein databases in VEBA 2.0. The number of genes detected using the MicroEuk50 was similar to MicroEuk90 and MicroEuk100 with only a fraction of the memory requirements, therefore, MicroEuk50 is set as the new default with options for using MicroEuk90 or MicroEuk100 if users prefer to maximize the gene candidates (Table 3). The updated databases were able to recover on average 6.4%, 7.5% and 9.2% more genes for MicroEuk50, MicroEuk90 and MicroEuk100, respectively.
In addition to coding sequences, the gene modeling script identified between 12–42 tRNA and between 0–7 rRNA for the eukaryotic genomes (Table 3, Supplementary Table S2). The only genome with organelles recovered was a Stephanocyclus meneghinianus (ERR2002419__METABAT2__E.1__bin.2) which included both a partial mitochondrion and a plastid genome. The previous classification for this genome from VEBA 1.0 was Cyclotella meneghiniana but previous research has confirmed that the genus Stephanocyclus includes species that have traditionally been classified under Cyclotella meneghiniana (121).
Since plastics contain polymers of carbon atoms with common organic components such as hydrogen, oxygen, nitrogen and sulphur (122), some organisms have evolved mechanisms to digest these complex forms of carbon (e.g. Ideonella sakaiensis hydrolyzed polyethylene terephthalates (PET) and uses the biproducts as building blocks for growth (123)). To investigate the plastic degrading potential of these eukaryotic genomes, protein homologs to PlasticDB (124) were assessed. Of the 140903 protein coding genes modeled, 156 proteins had plastic degrading properties with the majority representing protease, PEG aldehyde dehydrogenase, hydrolase, and PETase enzymes (Figure 2, Supplementary Table S3). These candidates are not surprising as other photosynthetic microeukaryotes such as the marine diatom Navicula pupula (125) and fresh water algae (Scenedesmus dimorphus and Uronema africanum Borge (126)) have been associated with low-density polyethylene plastic degradation. Naturally occurring enzymes could be used as the starting point for crafting powerful, low-cost and sustainable biotechnological solutions to lessen the impacts of the plastic crisis. Many different solutions are being actively explored such as adding post-translational glycan modifications to increase both activity and thermostability (127) or codon optimization for fast growing model organisms such as Escherichia coli (128). There have even been cases of cross-domain bioengineering such as the introduction of a bacterial PHB biosynthesis pathway into the cytosolic compartment of diatom Phaeodactylum tricornutum (129). Further, microplastics are known vectors for microbial pathogens (116). Pathogenic microbes have been detected on microplastics and plastic-containing sea surface biofilms in the Baltic Sea (130). In addition, ciliates associated with coral disease (131) and algae associated with harmful algal blooms (132) have been found hitchhiking on oceanic microplastics.
To assess the pathogenicity of these organisms, protein homologs to NCBIfam-AMR (60) and VFDB (56) were identified (Figure 2, Supplementary Table S3). While VFDB is designed for bacterial virulence factors, querying with microeukaryotic phytoplankton proteomes is appropriate as horizontal gene transfer from bacteria to protists has been previously characterized (133). Only two genomes contained AMR genes and both of which were ABC-F type ribosomal protection proteins (ribo_prot_ABC_F). Antimicrobial resistant ABC-F family of proteins mediate resistance to many antibiotic classes that bind to the 50S subunit of the ribosome including ketolides (134), lincosamides (135,136), macrolides (137), oxazolidinones (138), phenicols (138), pleuromutilins (139) and streptogramins of groups A (136,140) and B (137). Previous research has demonstrated that the ABC-F family can protect the bacterial ribosome from antibiotic-mediated inhibition (141). ABC-F family proteins have been observed in microeukaryotic phytoplankton including the diatom Fragilariopsis cylindrus and haptophyte Emiliania huxleyi which have 30 and 26 ABC-F proteins, respectively (142).
The most prominent virulence factors included effector delivery systems, nutritional/metabolic factors, and immune modulation. Within VFDB, these categories can be partitioned into subcategories: (i) effector delivery systems consisting of Type I–VII secretion systems; (ii) nutritional/metabolic factors consisting of metal uptake and metabolic adaptation (e.g. nutrient uptake) and (iii) immune modulation consisting of antiphagocytosis, serum resistance, immunoglobulin, antigen variation, apoptosis and inflammatory signaling pathways (56). While not the most prominent virulence factor, biofilm formation and quorum sensing factors were detected, which play a key role in colonizing marine plastics. As biofilms mature into complex structures, they produce secondary metabolites for quorum sensing and antimicrobial activity for competing microbes (110). While categorized broadly as virulence factors in VFDB, anti-inflammatory factors can be used in biomedical research which can drive the translational aspect of ecological research and conservation. Anti-inflammatory properties have been characterized previously in marine phytoplanketon including diatoms (e.g. Porosira glacialis, Attheya longicornis (143), Cylindrotheca closterium, Odontella mobiliensis, Pseudonitzschia pseudodelicatissima (144) and Phaeodactylum tricornutum (145)), dinoflagellates (e.g. Amphidinium carterae (145)), and green algae (e.g. Dunaliella bardawil and Dunaliella tertiolecta (146)).
As an additional confirmation regarding virulence factors against a gold-standard curated metabolic assessment from the same study (110), we analyzed the bacterial Alteromonadaceae pangenome recovered from the Plastisphere in the initial VEBA 1.0 release (4). Bos et al. conducted a comprehensive analysis, as this was the source study, and highlighted the importance of the mannose-sensitive hemagglutinin (MSHA) operon recognizing it as a key factor for intestinal colonization and for early colonization of hydrophobic plastic surfaces. They also determined positive selection for mshA alleles suggesting that mshA provides a competitive advantage for surface colonization and nutrient acquisition. In our revisit of the Alteromonadaceae pangenome, we identified 92 proteins associated with the MSHA pathway including pili biogenesis (mshG, mshO, mshQ), outer membrane secretin (mshL), biotic inner membrane (mshJ, mshI), and pili minor prepilin proteins (mshD, mshB) (Supplementary Table S3). With VEBA 2.0, we were able to rapidly screen for MSHA pathway components.
In this updated case study, we showcase the increase in information gain per genome for phytoplankton analyzed in previous case studies. Not only are more coding genes modeled using the updated MicroEuk_v3 database but we also recover rRNA, tRNA and partial organelles from the same genomes. Further, we demonstrate how the output from the various modules can be analyzed post hoc for identifying candidate plastic degrading enzymes and virulence factors.
Ancient 20 000–1 000 000 year old Siberian permafrost ecology from ecological and biomedical perspectives
The Siberian permafrost microbiome (BioProject: PRJNA596250, N = 7 metagenomic samples) is an Illumina MiSeq dataset investigating permafrost from the Kolyma-Indigirka Lowland permafrost from 6 depth profiles ranging from -3.5m to -20m below the surface (147). The geological site where samples were collected originates from the late Pleistocene Era (148) and the soil pertaining to these samples are estimated to have been continuously frozen for ∼20 000–1 000 000 years (149,150). Permafrost environments contain unique microbial ecosystems that are currently under threat from climate change (151). Even though these soils remain frozen year-round, often for thousands or millions of years, they nevertheless maintain living populations of microorganisms operating at low metabolic rates that can be revived and grown in a laboratory (152). The premise of the Sipes et al. study was to investigate the distribution of microorganisms that persist in this environment and characterize the metabolism associated with long-term energy starvation.
In the original study, 33 MAGs were identified with varying quality including 10 MAGs of medium-to-high quality (completeness ≥ 50% and contamination < 10%) and 8 MAGs of high-quality (completeness ≥ 80% and < 10% contamination); the 8 high-quality MAGs were used for analysis in Sipes et al., 2021. As the purpose of this case study is to showcase updated features, VEBA 2.0 used the recently added MEGAHIT (large and complex metagenome preset) support for metagenomic assembly and was able to increase the number of recovered genomes including 33 MAGs of medium-to-high quality and 11 MAGs of high quality (Table 4, Supplementary Table S2). Of these 33 MAGs recovered by VEBA, 7 MAGs were identified after the first iteration. These 7 MAGs would have been discarded by most binning pipelines even those using consensus methods such as DAS Tool. The 33 MAGs clustered into 17 SLCs with 10 SLCs being singletons with only one representative. Of the bacterial MAGs, there are 6 Actinomycetota, 6 Acidobacteriota, 5 Chloroflexota, 4 Atribacterota, 3 Planctomycetota, 2 Spirochaetota, 1 JANLFM01, 1 Desulfobacterota and 1 Bacteroidota. Of the archaeal MAGs, there are 3 Thermoplasmatota and 1 Thermoproteota (Table 4). These prokaryotic MAGs contained 98135 protein coding genes that clustered into 65 523 SSPCs.
Table 4.
Genome cluster | Genome | Surface depth | Taxonomy |
---|---|---|---|
PSLC-1 | Multisample__CONCOCT__P.1__24 | d__Bacteria;p__Actinomycetota;c__Humimicrobiia;o__Humimicrobiales; | |
f__Humimicrobiaceae;g__Hydromicrobium;s__ | |||
SRR13615823__METABAT2__P.1__bin.4 | -16.6m | d__Bacteria;p__Atribacterota;c__JS1;o__SB-45; | |
f__34–128;g__34–128;s__34–128 sp014894735 | |||
SRR13615824__METABAT2__P.1__bin.14_sub | -14.8m | d__Bacteria;p__Atribacterota;c__JS1;o__SB-45; | |
f__34–128;g__34–128;s__34–128 sp014894735 | |||
SRR13615824__METABAT2__P.1__bin.7_sub | -14.8m | d__Bacteria;p__Actinomycetota;c__Humimicrobiia;o__Humimicrobiales; | |
f__Humimicrobiaceae;g__Hydromicrobium;s__Hydromicrobium sp018894445 | |||
SRR13615825__MAXBIN2-107__P.1__bin.002_sub | -14.1m | d__Bacteria;p__Atribacterota;c__JS1;o__SB-45; | |
f__34–128;g__34–128;s__ | |||
SRR13615825__METABAT2__P.1__bin.5 | -14.1m | d__Bacteria;p__Actinomycetota;c__Humimicrobiia;o__Humimicrobiales; f__Humimicrobiaceae;g__Hydromicrobium;s__ Hydromicrobium sp018894445 | |
SRR13615826__MAXBIN2-40__P.1__bin.002 | -7.2m | d__Bacteria;p__Atribacterota;c__JS1;o__SB-45; | |
f__34–128;g__34–128;s__34–128 sp014894735 | |||
PSLC-2 | SRR13615824__CONCOCT__P.3__28_sub | -14.8m | d__Bacteria;p__Chloroflexota;c__Anaerolineae;o__ Anaerolineales; |
f__EnvOPS12;g__UBA877;s__ | |||
SRR13615825__METABAT2__P.1__bin.6 | -14.1m | d__Bacteria;p__Chloroflexota;c__Anaerolineae;o__Anaerolineales; | |
f__EnvOPS12;g__UBA877;s__ | |||
SRR13615826__CONCOCT__P.5__1_sub | -7.2m | d__Bacteria;p__Chloroflexota;c__Anaerolineae;o__Anaerolineales; | |
f__EnvOPS12;g__UBA877;s__ | |||
PSLC-3 | SRR13615824__CONCOCT__P.1__34 | -14.8m | d__Archaea;p__Thermoplasmatota;c__E2;o__DHVEG-1; |
f__DHVEG-1;g__SM1-50;s__SM1-50 sp014894395 | |||
SRR13615825__CONCOCT__P.1__20 | -14.1m | d__Archaea;p__Thermoplasmatota;c__E2;o__DHVEG-1; | |
f__DHVEG-1;g__SM1-50;s__SM1-50 sp014894395 | |||
SRR13615826__METABAT2__P.1__bin.5 | -7.2m | d__Archaea;p__Thermoplasmatota;c__E2;o__DHVEG-1; | |
f__DHVEG-1;g__SM1-50;s__SM1-50 sp014894395 | |||
PSLC-4 | SRR13615824__METABAT2__P.1__bin.3 | -14.8m | d__Bacteria;p__Acidobacteriota;c__Aminicenantia;o__Aminicenantales; |
f__RBG-16–66-30;g__RBG-16–66-30;s__RBG-16–66-30 sp014894455 | |||
SRR13615825__METABAT2__P.1__bin.4 | -14.1m | d__Bacteria;p__Acidobacteriota;c__Aminicenantia;o__Aminicenantales; | |
f__RBG-16–66-30;g__RBG-16–66-30;s__RBG-16–66-30 sp014894455 | |||
SRR13615826__METABAT2__P.1__bin.3 | -7.2m | d__Bacteria;p__Acidobacteriota;c__Aminicenantia;o__Aminicenantales; | |
f__RBG-16–66-30;g__RBG-16–66-30;s__RBG-16–66-30 sp014894455 | |||
PSLC-5 | Multisample__CONCOCT__P.1__30_sub | d__Bacteria;p__Acidobacteriota;c__Vicinamibacteria;o__Vicinamibacterales; | |
f__Fen-181;g__;s__ | |||
SRR13615824__CONCOCT__P.3__6 | -14.8m | d__Bacteria;p__Acidobacteriota;c__Vicinamibacteria;o__Vicinamibacterales; | |
f__Fen-181;g__;s__ | |||
SRR13615825__CONCOCT__P.1__8_sub | -14.1m | d__Bacteria;p__Acidobacteriota;c__Vicinamibacteria;o__Vicinamibacterales; | |
f__Fen-181;g__;s__ | |||
PSLC-6 | SRR13615824__MAXBIN2-40__P.1__bin.016_sub | -14.8m | d__Bacteria;p__Spirochaetota;c__Spirochaetia;o__SZUA-6; |
f__Fen-1364;g__;s__ | |||
SRR13615825__CONCOCT__P.1__19_sub | -14.1m | d__Bacteria;p__Spirochaetota;c__Spirochaetia;o__SZUA-6; | |
f__Fen-1364;g__;s__ | |||
PSLC-7 | Multisample__METABAT2__P.3__bin.11 | d__Bacteria;p__Actinomycetota;c__Humimicrobiia;o__Humimicrobiales; | |
f__Humimicrobiaceae;g__JAHILC01;s__ | |||
SRR13615823__CONCOCT__P.1__3_sub | -16.6m | d__Bacteria;p__Actinomycetota;c__Humimicrobiia;o__Humimicrobiales; | |
f__Humimicrobiaceae;g__JAHILC01;s__ | |||
PSLC-8 | Multisample__CONCOCT__P.1__62 | d__Bacteria;p__JANLFM01;c__JANLFM01;o__JANLFM01; | |
f__;g__;s__ | |||
PSLC-9 | SRR13615824__MAXBIN2-107__P.3__bin.004_sub | -14.8m | d__Bacteria;p__Planctomycetota;c__Phycisphaerae;o__FEN-1346; |
f__FEN-1346;g__;s__ | |||
PSLC-10 | SRR13615824__CONCOCT__P.2__20_sub | -14.8m | d__Bacteria;p__Desulfobacterota;c__Syntrophia;o__Syntrophales; |
f__Smithellaceae;g__;s__ | |||
PSLC-11 | SRR13615826__CONCOCT__P.1__38 | -7.2m | d__Bacteria;p__Planctomycetota;c__Phycisphaerae;o__FEN-1346; |
f__FEN-1346;g__VGYT01;s__ | |||
PSLC-12 | SRR13615826__CONCOCT__P.1__1_sub | -7.2m | d__Bacteria;p__Chloroflexota;c__Dehalococcoidia;o__DSTF01; |
f__JALHUB01;g__JALHUB01;s__ | |||
PSLC-13 | SRR13615824__METABAT2__P.2__bin.1 | -14.8m | d__Bacteria;p__Chloroflexota;c__Anaerolineae;o__Anaerolineales; |
f__Anaerolineaceae;g__UBA700;s__ | |||
PSLC-14 | SRR13615821__CONCOCT__P.1__6 | -20m | d__Bacteria;p__Actinomycetota;c__Actinomycetia;o__Propionibacteriales; |
f__Propionibacteriaceae;g__Cutibacterium;s__Cutibacterium acnes | |||
PSLC-15 | SRR13615824__CONCOCT__P.1__13 | -14.8m | d__Archaea;p__Thermoproteota;c__Bathyarchaeia;o__B26-1; |
f__UBA233;g__PALSA-986;s__ | |||
PSLC-16 | SRR13615824__METABAT2__P.1__bin.4_sub | -14.8m | d__Bacteria;p__Bacteroidota;c__Bacteroidia;o__Bacteroidales; |
f__VadinHA17;g__LD21;s__ | |||
PSLC-17 | SRR13615824__CONCOCT__P.1__3_sub | -14.8m | d__Bacteria;p__Planctomycetota;c__Phycisphaerae;o__Sedimentisphaerales; |
f__SG8-4;g__Fen-1362;s__ |
VEBA was not able to recover any medium-to-high quality viruses. However, the intermediate step of geNomad in the binning-viral module identified 925 viral candidates that did not meet the strict criteria VEBA uses for defaults (see Methods for settings). In addition to viruses, geNomad was able to identify 382 plasmids,141 of which were binned with the prokaryotic MAGs. Large-scale studies have shown that soil viruses are incredibly abundant, highly diverse, and largely uncharacterized (153) with permafrost soils in particular representing a largely understudied genetic resource (154). While CheckV is highly robust, poorly-characterized biomes such as permafrost may contain viruses that are not represented in the current reference database. Regarding eukaryotic MAGs, we recovered 1 candidate fungal genome that BUSCO determined to be related to Sordariomycetes (completeness 33.3%, contamination 0%) which is not surprising as these fungi have been previously identified in Siberian permafrost (155). Although the candidate Sordariomycetes genome did not meet VEBA’s default eukaryotic quality standards (completeness ≥ 50%, contamination < 10%), this level of BUSCO completion has been acceptable in Tara Oceans protist-centric studies (90,93); therefore, similar studies may be used to set default thresholds in later VEBA releases. These findings suggests that with deeper sequencing one may be able to recover full-length viral and eukaryotic organisms.
To evaluate the biomedical potential of ancient permafrost, we investigated the virulence factors and AMR genes that are now identified automatically with the updated VEBA annotate module. PSLC-5 (d__Bacteria; p__Acidobacteriota; c__Vicinamibacteria; o__Vicinamibacterales; f__Fen-181; g__; s__) and PSCL-11 (d__Bacteria; p__Planctomycetota; c__Phycisphaerae; o__FEN-1346; f__FEN-1346; g__VGYT01; s__) had the highest number of virulence factors per genome. The most prominent virulence factors were related to immune modulation including LPS transporters, daunorubicin resistance, and NAD dependent epimerases (Supplementary Figure S1, Supplementary Table S3). The relevance of immune modulation to biomedical potential was discussed in the previous case study.
Regarding antimicrobial resistance, there were a total of 13 AMR genes from Atribacterota, Chloroflexota, Actinomycetota, and Thermoplasmatota. These genes were mostly involved with mercury metabolism (mercury (II) reductase, mercury resistance co-regulator MerD, mercury resistance system periplasmic binding protein MerP, broad-spectrum mercury transporter MerE), arsenic metabolism (arsenite efflux transporter metallochaperone ArsD, arsinothricin resistance N-acetyltransferase ArsN1 family B), and ABC-F type ribosomal protection (Supplementary Table S3). Mercury metabolism in permafrost is of potential global importance, mercury is a natural component of soils and high emissions scenarios predict globally significant releases of mercury from thawing permafrost to the atmosphere (156). In addition to these predicted atmospheric emissions, methylmercury - a dissolved form of mercury that can be a toxin in the food web - can be remobilized from thawing permafrost (157). Mercury and arsenic may be remobilized from industrially contaminated permafrost sites (158). Arsenic may also be weathered out of arsenic sulfates in thawing permafrost from which it can enter surface waters (159).
To assess biosynthetic potential of the permafrost microbiome, we ran the VEBA’s biosynthetic module and identified 31 BGCs from all SLCs except PSLC-1, PSLC-15, PSLC-6, PSLC-8 and PSLC-9 (Supplementary Figure S2, Supplementary Table S4). The most prominent BGC classes include terpenes, RiPP-like, NRPS/NRPS-like, T3PKS, ranthipeptide and acyl amino acids but there are many more single occurrence BGC classes as well (Supplementary Table S4). As the focus of this case study is to showcase the utility of VEBA and not to exhaustively explore the genomic landscape, we used a data driven approach to identify which organism to focus on both from an ecological perspective and a biotechnological perspective. In particular, we identified the most highly co-occurring organisms in a community and assessed their potential for producing novel natural products. Using a compositionally-valid network approach, we ascertained that PSLC-3 pangenome (d__Archaea;p__Thermoplasmatota;c__E2;o__DHVEG-1;f__DHVEG-1;g__SM1-50;s__SM1-50 sp014894395) was the most highly co-occurring organism in the community despite having average relative abundance (Figure 3B,C). This archaeal pangenome consists of 3 genomes from depths -14.8m, -14.1m, and -7.2m and each have their own version of a RiPP-like BGC with the –14.8m and –7.2m strains having novelty scores >85% based on MIBiG homology. RiPP pathways encode a myriad of chemical and functional diversity due to the various modifications added post-translationally to a core peptide via maturase enzymes (160). Each PSLC-3 genome RiPP BGC contained a copy of AsnC family transcriptional regulator and radical SAM domain protein. Radical SAM proteins catalyze diverse reactions including unusual methylations, isomerization, sulfur insertion, ring formation, anaerobic oxidation and protein radical formation while also functioning in DNA precursor, vitamin, cofactor, antibiotic biosynthesis, and in biodegradation pathways (161).
Recently, RiPP-like natural products have been discovered within the Patescibacteria Eudoremicrobiaceae recovered from the ocean (162). Paoli et al. assessed two novel Eudoremicrobiaceae RiPP pathways empirically to provide evidence for their function. In particular, they showed that the deep ocean Eudoremicrobiaceae RiPP-like natural product displayed low-micromolar protease inhibitory activity against neutrophil elastase within a concentration range comparable to other natural products (163) while the second case was predicted to encode a proteusin with unique biochemistry with the first occurrence of a FkbM O-methyltransferase family member in a RiPP pathway. While empirical assessments are out of scope for this case study, the methodology employed by Paoli et al. provides the basis and rationale for interrogating natural ecosystems, especially unique systems such as permafrost, for biosynthetic potential and biomedical solutions. It is important to note that all the detected BGCs in the permafrost case study reside on the edge of a contig which means that they are likely incomplete clusters and cannot be fully assessed nor synthesized in vitro. However, these findings show strong evidence that there is biomedically relevant and largely unexplored natural product potential in permafrost which may be unlocked with deeper sequencing using these same in silico methods.
For the final post hoc analysis for showcasing the utility of genome mining in unique biomes, we screened for CRISPR-Cas systems using CRISPRCasTyper (80) which includes classifications for 50 subtypes (164,165). CRISPR-Cas systems are an adaptive immunity mechanism evolved by prokaryotic organisms in which fragments of foreign DNA (e.g. phage) get stored in the host prokaryotic genome as spacer sequences which are separated by repeat sequences collectively known as a CRISPR array; upon transcription spacer sequences guide Cas effector nucleases to destroy the source invader (166). Exploring CRISPR-Cas systems from unique conditions such as permafrost can provide insight into the evolution of CRISPR-Cas systems and those that may perform better in harsh conditions such as those of permafrost. CRISPRCasTyper is not currently implemented in VEBA because the current release does not allow for precomputed gene models but this feature is being developed in CRISPRCasTyper and will be added to VEBA once the update is stable. In the interim, we provide a walkthrough on GitHub to encourage users to screen their datasets for candidate CRISPR-Cas systems.
We recovered 1 high-confidence CRISPR-Cas system (subtype I-E) with Cas8, Cse2, Cas7, Cas5 and Cas6 in SRR13615826__CONCOCT__P.1__38 (p__Planctomycetota; c__Phycisphaerae; o__FEN-1346; f__FEN-1346; g__VGYT01; s__VGYT01 sp016872895). In addition, we identified an orphaned high-confidence subtype II-D Cas operon with a Cas9 in SRR13615824__CONCOCT__P.3__28_sub (p__Chloroflexota; c__Anaerolineae; o__Anaerolineales; f__EnvOPS12; g__UBA877; s__UBA877 sp017882065) and 2 orphaned high-confidence CRISPR sites including: (i) I-C subtype CRISPR from SRR13615824__CONCOCT__P.3__28_sub and (ii) an unknown CRISPR from SRR13615826__CONCOCT__P.1__38 (Figure 4). Previous research has shown that the phylum Chloroflexota comprised 18% (Anaerolineae amounting to 6%) of the total Cas1 enzymes identified in thermophiles recovered from hot spring metagenomes (167). As of January 2024, the only Cas9 enzyme from Anaerolineales in NCBI is a partial Cas9 enzyme from a Methanoperedens enrichment culture (CAG0947278.1 from BioSample SAMEA8236570). To date, there are no published Cas8 in Planctomycetota on NCBI or UniProt but there are several Cse2, Cas7, Cas5 and Cas6 enzymes. While CRISPR-associated genes from Planctomycetota populate databases (e.g. Cas9 UniProt: A0A954DXG8 (168)) they are often not mentioned or characterized other than Cas12e (169). While follow up analysis such as assessing the functional diversity of rare CRISPR-Cas systems (170) or interrogating the spacerome (171) to predict viral source organisms from spacer sequences (172) is out of scope for this study, we showcase the utility of mining extremophile microorganisms for biotechnological potential.
Permafrost soils are rapidly thawing, due to climate change (173,174). This may expose previously sequestered organic matter to microbial degradation to greenhouse gases, further exacerbating climate change (175). Another threat from permafrost thaw is losing habitat for organisms that could potentially have unique biomedical or biotechnological potentials (176). Demonstrating these potentials through bioinformatics can help estimate the scope of potential losses when such habitats are destroyed.
Respiratory viruses of white-tailed deer from a veterinary and public health perspective
The white-tailed deer (Odocoileus virginianus) case study is an Oxford Nanopore dataset derived from lung tissue of pneumonia-related deer fatalities (BioProject: PRJNA1025254, N = 34 samples) (177). While-tailed deer are a species broadly distributed across North America with an estimated population size of ∼30 million animals (178) making it the most abundant large mammal species in North America (179). The distributions of deer and human populations overlap substantially, and is increasing due to changes in human land use and deer habitat range expansion. With increasing human–deer interactions, the circulation of respiratory viruses in white-tailed deer can be a cause of concern as we do not know the zoonotic potential of viruses that are endemic in these species. However, there is documented anthroponosis of SARS-CoV-2 from humans to deer and continued viral transmission within deer populations that increases the potential risk of novel virulent strains emerging back into humans (179). Wildlife reservoirs of broad-host-range viruses have the potential to infect humans or livestock and previous research provides evidence for sustained evolution of SARS-CoV-2 in white-tailed deer and of deer-to-human transmission (180).
Towards better defining the virome of animal species that have dynamic interactions with humans, we showcase the long-read adaptation and viral identification capabilities of VEBA 2.0. Here, we analyzed the candidate virome of 17 case samples of deer with pneumonia-related fatalities and 17 control samples. Pneumonia diagnosis and classification was determined by the presence of gross pneumonia lesions and histologic evaluation of lung tissue/lesions as described in Gilbertson et al. (181). Only samples from the Gilbertson et al. study that were classified as bronchopneumonia or mixed-pneumonia were used in this case study, thus, avoiding cases of interstitial pneumonia.
For in silico host depletion we used a concatenated reference including the white-tailed deer reference genome (Ovir.te_1.0:GCF_002102435.1) and the human genome (T2T-CHM13v2.0:GCF_009914755.1) using the latter to account for potential laboratory contamination. It should be noted that the Ovir.te_1.0 genome assembly build was sequenced using short-read Illumina sequencing and such assemblies lack structural variants and repeat regions which is relevant to our interpretations.
Using the strict default settings for high-confidence viral genomes (see Methods for settings), VEBA recovered N = 78 viral genomes from case samples and N = 77 viral genomes from control samples with genome sizes ranging from 6730 to 232 054 bp (Table 5, Supplementary Table S2). Candidate viruses recovered in case samples were novel uncharacterized (NMAG = 38), uncharacterized Ortervirales (NMAG = 35), uncharacterized Retroviridae (NMAG = 3), and Caudoviricetes (NMAG = 2). In control samples, the types of viruses recovered were novel uncharacterized (NMAG = 28), uncharacterized Ortervirales (NMAG = 42), and uncharacterized Retroviridae (NMAG = 7). These genomes clustered into 19 SLCs based on 95% ANI threshold with 16 being singletons and the largest cluster VSLC-1 containing ∼84% (130/155) of the viral genomes sourced from ∼85% (29/34) of the samples. These 155 candidate viral genomes contain 2901 proteins that cluster into 1250 SSPCs (Supplementary Table S3). All viral genome clusters that contained more than 1 genome had representatives in both case and control samples including VSLC-1 (NCase = 65 genomes, NControl = 65 genomes), VSLC-2 (NCase = 3 genomes, NControl = 2 genomes), and VSLC-3 (NCase = 2 genomes, NControl = 2 genomes).
Table 5.
Genome | Source phenotype | Integrated genome size | Host genome homology (%) | Taxonomy classification |
---|---|---|---|---|
SRR26335613__GENOMAD__Virus.1 | case | 66159 | 29.8281 | Viruses;Riboviria;Pararnavirae;Artverviricota; Revtraviricetes;Ortervirales |
SRR26335615__GENOMAD__Virus.1 | case | 20525 | 61.9635 | Viruses;Riboviria;Pararnavirae;Artverviricota; Revtraviricetes;Ortervirales |
SRR26335620__GENOMAD__Virus.6 | control | 20607 | 23.2542 | Unclassified virus |
SRR26335641__GENOMAD__Virus.1 | case | 10668 | 39.2482 | Unclassified virus |
SRR26335643__GENOMAD__Virus.2 | case | 17234 | 37.1533 | Viruses;Riboviria;Pararnavirae;Artverviricota; Revtraviricetes;Ortervirales |
SRR26335644__GENOMAD__Virus.1 | case | 14275 | 39.2925 | Unclassified virus |
SRR26335644__GENOMAD__Virus.2 | case | 15395 | 66.697 | Viruses;Riboviria;Pararnavirae;Artverviricota; Revtraviricetes;Ortervirales |
These candidate viruses were identified using robust cutoffs via geNomad and determined to be high-quality and complete via CheckV. A closer examination of the candidate viral genomes (e.g. length, host alignments and retroviral genes) suggests that these are integrated retroviruses (Table 5). This remains plausible despite the host depletion because individual long reads that align to these genomes span both viral and host genomic content and would not be removed during the decontamination phase which presents the opportunity for identifying these candidate viral integration events. In this case study, we present our rationale for this hypothesis and the evidence to support this largely unexplored area of in silico microbiome research.
To place our candidate integrated viral genomes into the context of existing research, we aligned the viral proteins recovered from this case study against viral proteins to white-tailed deer retroviral proteins from NCBI. We identified 79 hits when aligning the viral proteins to known white-tailed deer retroviral proteins, namely: N = 36 proteins aligned to endogenous retrovirus group K member 10 Gag polyprotein-like protein (XP_020750633.1); N = 36 proteins aligned to endogenous retrovirus group PABLB member 1 Env polyprotein-like protein (XP_020763988.1) and N = 7 proteins aligned to endogenous retrovirus group K member 25 Env polyprotein-like protein (XP_020732150.1) (Supplementary Table S5).
VSLC-1 is classified as an uncharacterized Ortervirales and contains no core proteins that are detected in all genomes; the most prevalent is VSLC-1_SSPC-3 which is detected in ∼35% of the genomes. The functional space for this protein cluster has varied activity with most of the annotations suggesting reverse transcription and RNA-directed DNA polymerase but also includes catenin domains for cell adhesion and an ABC-transporter domain. Most of the genomes containing VSLC-1_SSPC-3 have 1 copy (NMAG = 24) or 2 copies (NMAG = 13) but some genomes contain up to 8 paralogs. Similar annotations exist for VSLC-1_SSPC-4 which is present in ∼28% of the genomes in VSLC-1.
Another protein cluster worthy of note is VSLC-1_SSPC-1 which is in ∼22% of the VSLC-1 genomes and is the cluster with the largest number of proteins (NProteins = 144). The number of copies per genome ranges from 1 to as many as 29 paralogs all in the same orientation as in SRR26335613__GENOMAD__Virus.1 which has a genome size of 66 159 bp (Figure 5, Supplementary Figure S3). The only annotation for VSLC-1_SSPC-1 across the entire viral pangenome is a hypothetical protein (UniRef50_UPI001C9E20F9) from Klebsiella pneumoniae but the following analysis on VSLC-1_SSPC-1 refers to SRR26335613__GENOMAD__Virus.1 unless otherwise noted.
The first 28/29 paralogs in the repeat array are interspaced by either 497–498bp (N = 19), 529bp (N = 6) and 577 bp for the penultimate intergenic region (Figure 5A). The final intergenic region between paralogs genes g28 and g41 is separated by 10 010 bp but this section includes viral coding genes. Within the region between the penultimate and last paralog—g28 and g41, respectively—there are 12 genes with robust annotations including several uncharacterized host proteins (UniRef50_A0A6J0X5M2, UniRef50_A0A6J0XDE6), Gag polyproteins (UniRef50_A0A6J0XL79, UniRef50_A0A3G2KVA0), a human endogenous retrovirus K endopeptidase (UniRef50_A0A6J0B691), a zinc ion binding integrase (UniRef50_A0A173DSU7), and several other uncharacterized proteins.
The repeat array includes the following intergenic repeated components (IGRC): IGRC1(27 bp intergenic region); IGRC2 (470 bp intergenic region); IGRC3 (30 bp intergenic region); and IGRC4 (37 bp intergenic region) (Figure 5A, B). All intergenic regions in the main paralog array between genes g1–g28 begin with IGRC1 and this region has 100% identity to O. virginianus centromeric satellite DNA reverse complement from position 5–31 denoted as U53517.1-RevComp[5:31]. IGRC2 is also in all intergenic regions in the main repeat array region between g1–g28 and aligns to U53517.1-RevComp[518:990] with 98% identity (1 gap) where a G is deleted in the viral copy relative to the host chromosome. IGRC3 is in 7 of the intergenic sequences and aligns with 96% identity to U53517.1-RevComp[494:517]. Lastly, IGRC4 is only in the penultimate intergenic region within g27-g28 and aligns with 95% identity (2 gaps) to U53517.1-RevComp[449:488] where AT dinucleotide was deleted in the viral copy relative to the host chromosome. It should be noted that IGRC2, IGRC3, IGRC4 all occur sequentially on the host chromosome but IGRC1 is homologous to another region on the other end of the host chromosome. These IGRCs are combined with the viral intergenic regions in three combinations denoted as C1 (IGRC1–IGRC2), C2 (IGRC1–IGRC2–IGRC3) and C3 (IGRC1–IGRC2–IGRC3–IGRC4) (Figure 5B). Sequences and alignments for these IGRCs are available in the Supplementary Appendix.
Phylogenetic inference reveals that these repeat paralogs cluster into 4 distinct clusters (RPC, Repeat Paralog Clusters) (Figure 5C,D) with RPC1 (N = 20), RPC2 (N = 1), RPC3 (N = 7) and RPC4 (N = 1) containing the paralog at end of the main repeat array (Figure 5A,B). RPC3 paralogs always are preceded by C2 repeats (Figure 5A). Further characterization of VSLC-1_SSPC-1 repeat array in this uncharacterized Ortervirales viral genome and its effect on white-tailed respiratory disease is outside the scope of this case study. Also, since the data described was generated from genomic DNA and not RNA, the current study may not provide a viral RNA etiology to the respiratory disease found in the cases. However, we encourage researchers to unravel this thread perhaps with defining the viral RNA landscape and deep-learning based structural alignments for exploring functional dark matter.
Although SRR26335613__GENOMAD__Virus.1 contains the highest number of paralogs for VSLC-1_SSPC-1, this trend is also observed in other viruses in VSLC-1. To assess whether IGRCs with homology to host centromeres were detected in other viruses we performed exact sequence searches against all the recovered viral genomes and identified the pattern in 6 other viruses (N = 7 viruses total, Supplementary Figure S4,S5). Of these seven viruses that contain IGRCs, all were members of VSLC-1 and 6/7 were from pneumonia-associated case specimens while only one was from a control specimen (SRR26335620__GENOMAD__Virus.6). These six viral genomes recovered from case samples contain different numbers of repeat paralogs that are dispersed at regular intervals. The IGRC-containing virus recovered from a control specimen contains 17 repeat paralogs of VSLC-1_SSPC-1 and does not contain VSLC-1_SSPC-2. A unique feature that was observed in 5/7 viral genomes, exclusive to viruses recovered from case specimens (though, not observed in SRR26335613__GENOMAD__Virus.1) was the pattern of VSLC-1_SSPC-2 preceding VSLC-1_SSPC-1 (Supplementary Figure S5). There are no annotations for VSLC-1_SSPC-2 from any of the databases used by VEBA 2.0.
With similar integration patterns at the same centromeric site among several specimens, we speculate that these are viruses that have integrated into the host genome. Integrating into or near centromere regions has been observed with HIV (182) and could be advantageous for an actively infecting virus by ensuring its genome gets copied along with the host chromosome. Investigating the function of these repeated paralogs, intergenic repeats homologous to host centromere satellite DNA, and how the virus integrates into the cell may provide key insight into building stable artificial chromosomes which has been demonstrated in diatoms (183), yeast (184), and mammals (185). The discovery of this repeat array and its implications showcase the utility of VEBA and what type of information can be gained only using long-read sequencing technology as these repeat regions are longer than typical Illumina reads. VEBA 2.0 can be used for identifying and annotating integrated viruses in long-read genome assemblies and unlocks numerous potential new studies. For example, within these 34 samples our data suggests the prevalence of integrated viruses across different individual deer and that there is a unique aspect in terms of paralogous repeat structure.
To assess if any functional domains were statistically enriched in viral populations in the case samples relative to control samples or vice versa, we performed Fisher's exact tests. First, we investigated protein clusters within VSLC-1 as this pangenome contains most of the viral genomes. The only unsupervised VSLC-1 protein-cluster that was statistically enriched in control (N = 6 genomes) relative to case (N= 0 genomes) was VSLC-1_SSPC-14 (P ≅ 0.01) which has no homology to any databases used by VEBA 2.0. From a supervised approach, the only Pfam domain that was statistically depleted in control (N = 15) relative to case samples (N = 28) was PF18697.4 (P ≅ 0.02) which is a murine leukemia virus (MLV) integrase C-terminal domain that interacts with the bromo and extra-terminal proteins through the ET domain. This interaction provides a structural basis for global in vivo integration-site preferences and disruption of this interaction through truncation mutations affects the global targeting profile of MLV (186).
As protein clustering is performed within SLCs and not globally, we assessed the entire virome from a supervised perspective using Pfam domains which yielded three enriched protein domains with two being enriched in case relative control samples (Murine leukemia virus integrase C-terminal domain PF18697.4 (NCase = 31, NControl = 16, P ≅ 0.01) and Integrase core domain PF00665.29 (NCase = 37, NControl = 23, P ≅ 0.03)) and one enriched in control relative to case samples (RNase H-like domain found in reverse transcriptase PF17917.4 (NCase = 6, NControl = 15, P ≅ 0.04)). Integrase mediates integration of a DNA copy of the viral genome into the host chromosome which consists of three domains including the central catalytic domain for zinc binding, a non-specific DNA binding domain, and a catalytic domain that acts as an endonuclease (187). Ribonuclease H (RNase H) activities allow reverse transcriptases to convert retroviral ssRNA genome into dsDNA which is integrated into the host genome during infection (188). While it is unclear on how these viral features may contribute to pneumonia-related illness, it is possible that these integrated viruses may be involved in host immune response (189). As previously noted, our current approach of analyzing genomic DNA may not fully reflect the etiology of pneumonia-related events.
There are an estimated 40 000 viral species circulating in mammals, a quarter of which have zoonotic potential (190); in particular, many of the recent epidemics of emerging respiratory viruses are believed to have originated in wildlife (191,192). The reverse can also occur where reverse zoonosis (or anthroponosis) contributes to the diversity of viral species in animals that have high interactions with humans as well as domestic animals (193). The dynamic relationship between humans and animal species and their associated diseases not only put the persistence of wildlife populations at risk (194) but also pose a risk for transmission to domesticated livestock (195) and humans (180) Thus, these events threaten both public health and food security. Advances in molecular sequencing have been instrumental in facilitating pathogen detection and characterization for microbes including viruses that are difficult to identify using culturing-based diagnostic approaches. The added support for long-read sequencing in VEBA 2.0 provided insight into complex genomic features of candidate integrated white-tailed deer viruses including repetitive paralogs and host centromeric satellite incorporation. Further, this case study provides evidence for the discovery and characterization of integrated retroviruses which may play a role in the health of white-tailed deer populations experiencing fatalities attributed to pneumonia (177) and chronic wasting disease (196).
Future perspectives
The ability to integrate genomics into research studies has become increasingly routine due to the continuous decline in sequencing costs per megabase—costs that have far exceeded predictions by Moore's Law (197). The astonishing rate of new of sequencing advancements has led to petabytes of publicly available structured sequence data including 19.6 trillion base pairs from over 2.9 billion nucleotide sequences in NCBI’s GenBank database (198) and even more raw sequencing data including over 90.11 quadrillion base pairs in NCBI’s SRA database (ncbi.nlm.nih.gov/sra/docs/sragrowth/). Comprehensive software suites such as VEBA are a requisite for keeping up with and deriving meaning from this massive amount of sequencing data that is generated and deposited in public repositories each year. Further, as we have demonstrated previously (4) and in this most recent edition, there is potential value to be gained when reanalyzing existing datasets with updated methodologies especially in the context of metagenomics and in silico genome mining for bioprospecting.
To ensure that VEBA can address the deluge of sequencing data, we plan to add performance improvements, new features as new methods are developed, and increased interoperability with other high-quality workflows under active development such as DRAM (199), Bakta (200), MuDoGeR (201), EukHeist (202), EukMetaSanity (203), Woltka (204) and Anvi’o (205). An example of planned performance updates include adapting all HMM-based searches to use PyHMMER which optimizes parallel-processing (206). Another example includes integrating the recently released GTDB-Tk update that replaces FastANI with skani to optimize ANI calculations in the backend. In addition to these performance updates, VEBA will be adding a module for CRISPR-Cas screening and historical viral infections prediction from spacer sequences once CRISPRCasTyper fully supports preexisting gene calls. In addition, we also plan to add support for addressing functional dark matter (207) to demystify the function of hypothetical proteins using remote homology detection and structural alignment methods (208). In the long term on the path towards VEBA 3.0, we plan to reimplement the entire software suite using Nextflow to further maximize our performance gains in terms of parallelization capabilities and resource usage. However, this reimplementation is non-trivial as it requires rewriting all the modules/scripts in Nextflow and the Groovy programming language.
Regarding feature updates, we will add new technologies as they are developed to solve new problems or to update existing solutions. In particular, there is a need for further developments in eukaryotic taxonomy classification as many of the in silico methodologies (e.g. VEBA’s classify-eukaryotic module and EUKulele (209)) rely on protein alignments which are not as flexible as the methods developed for prokaryotic classifications. To address this need, developers with expertise in eukaryotic taxonomy would have to build an in silico eukaryotic taxonomic classification tool that is as robust as GTDB-Tk. Such improvements in eukaryotic classification methods would illuminate the blind-spots in microbial ecology casted by microeukaryotic organisms and would provide a major milestone for large-scale efforts such as Earth BioGenome Project (210,211).
The need for cataloguing Earth's biodiversity is time sensitive due to anthropogenic climate change. The authoritative Intergovernmental Panel on Climate Change (IPCC) recently concluded that human activities have unequivocally warmed the planet while causing substantial biodiversity loss associated with downstream effects such as desertification, decreased precipitation, land/forest degradation, glacial retreat, ocean acidification, and sea level rise (212). The loss of biodiversity is expected to alter ecosystem functionality and the ability to provide society with the requisite resources to prosper (213). Further, with a decrease in biodiversity we also forfeit the potential for discovering natural products with biomedical relevance such as antimicrobial (214–216), chemotherapy (217), and antiviral agents (218). With biodiversity loss growing increasingly dire (219), curbing anthropogenic biodiversity loss is paramount and requires policies to address the multifaceted crisis (220). However, basic research has not been enough to drive substantial change in policies needed to prevent such catastrophes. Translating basic research findings into cogent policy and providing candidate assets for biotechnology industry will not only instill growing interest in basic research but will also provide an economic incentive to preserve natural systems in the prospect of identifying novel natural products from high biodiversity regions.
With the advent of comprehensive software suites such as VEBA, further developments for in silico bioprospecting/screening methods and continued advancements in sequencing technologies, the future of environmental/biodiversity preservation may be driven not just from ethical concerns but also from biotechnological potential for discovering solutions developed by nature. That is, it is essential to preserve ecosystems in an effort to not diminish the catalog of candidate natural products before they can be discovered. Bridging the gap between environmental sustainability and translational potential may be the requisite change needed for policy changes that can dampen the twin crisis of climate change and biodiversity collapse (221).
Supplementary Material
Acknowledgements
We would like to thank our funding sources and our colleagues for support during this research. In addition, we would like to thank Harinder Singh and Yang Chen for testing beta versions of this software.
Contributor Information
Josh L Espinoza, Department of Environment and Sustainability, J. Craig Venter Institute, La Jolla, CA 92037, USA; Department of Genomic Medicine and Infectious Diseases, J. Craig Venter Institute, La Jolla, CA 92037, USA.
Allan Phillips, Department of Environment and Sustainability, J. Craig Venter Institute, La Jolla, CA 92037, USA; Department of Genomic Medicine and Infectious Diseases, J. Craig Venter Institute, La Jolla, CA 92037, USA.
Melanie B Prentice, School of Food and Agriculture, University of Maine, Orono, ME 04469, USA.
Gene S Tan, Department of Genomic Medicine and Infectious Diseases, J. Craig Venter Institute, La Jolla, CA 92037, USA.
Pauline L Kamath, School of Food and Agriculture, University of Maine, Orono, ME 04469, USA; Maine Center for Genetics in the Environment, University of Maine, Orono, ME 04469, USA.
Karen G Lloyd, Microbiology Department, University of Tennessee, Knoxville, TN 37917, USA.
Chris L Dupont, Department of Environment and Sustainability, J. Craig Venter Institute, La Jolla, CA 92037, USA; Department of Genomic Medicine and Infectious Diseases, J. Craig Venter Institute, La Jolla, CA 92037, USA.
Data availability
The source code for VEBA (https://github.com/jolespin/veba), the clustered MicroEuk database (https://zenodo.org/records/10139451), and the analysis for case studies (https://zenodo.org/records/10780433) are publicly available. The original studies for the Plastisphere microbiome (BioProject: PRJNA777294), MarineAerosol microbiome (BioProject: PRJEB20421), Siberian permafrost microbiome (BioProject: PRJNA596250), and white-tailed deer lung microbiome (BioProject: PRJNA1025254) are available on NCBI (https://www.ncbi.nlm.nih.gov/bioproject/).
Supplementary data
Supplementary Data are available at NAR Online.
Funding
National Institute of Health [R21AI160098, 1R01AI170111-01, 1U54GH009824]; National Science Foundation [OCE-1558453]; PolyBio Foundation (to C.L.D.). National Science Foundation Dimensions of Biodiversity [DEB-1442262]; US Department of Energy, Office of Science, Office of Biological and Environmental Research, Genomic Science Program [DE-SC0020369] (to K.G.L.). Additional funding for the sequencing of deer samples was provided to P.L.K. and M.B.P. by the Federal Aid in Wildlife Restoration Act administered by the U.S. Fish and Wildlife Service through the Wisconsin Department of Natural Resources. Funding for open access charge: National Institute of Health [R21AI160098, 1R01AI170111-01, 1U54GH009824]; NSF [OCE-1558453]; PolyBio Foundation (to C.L.D.).
Conflict of interest statement. None declared.
References
- 1. Almeida A., Nayfach S., Boland M., Strozzi F., Beracochea M., Shi Z.J., Pollard K.S., Sakharova E., Parks D.H., Hugenholtz P.et al.. A unified catalog of 204,938 reference genomes from the human gut microbiome. Nat. Biotechnol. 2020; 39:105–114. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 2. Nishimura Y., Yoshizawa S.. The OceanDNA MAG catalog contains over 50,000 prokaryotic genomes originated from various marine environments. Sci.c Data. 2022; 9:305. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3. Ma B., Lu C., Wang Y., Yu J., Zhao K., Xue R., Ren H., Lv X., Pan R., Zhang J.et al.. A genomic catalogue of soil microbiomes boosts mining of biodiversity and genetic resources. Nat. Commun. 2023; 14:7318. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4. Espinoza J.L., Dupont C.L.. VEBA: a modular end-to-end suite for in silico recovery, clustering, and analysis of prokaryotic, microeukaryotic, and viral genomes from metagenomes. BMC Bioinf. 2022; 23:419. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 5. Laforest-Lapointe I., Arrieta M.-C.. Microbial eukaryotes: a missing link in gut microbiome studies. Msystems. 2018; 3:e00201-17. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6. Liang G., Bushman F.D.. The human virome: assembly, composition and host interactions. Nat. Rev. Microbiol. 2021; 19:514–527. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7. Kolářová I., Florent I., Valigurová A.. Parasitic protists: diversity of adaptations to a parasitic lifestyle. Microorganisms. 2022; 10:1560. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 8. Oliverio A.M., Geisen S., Delgado-Baquerizo M., Maestre F.T., Turner B.L., Fierer N.. The global-scale distributions of soil protists and their contributions to belowground systems. Sci. Adv. 2020; 6:eaax8787. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9. Burki F., Sandin M.M., Jamy M.. Diversity and ecology of protists revealed by metabarcoding. Curr. Biol. 2021; 31:R1267–R1280. [DOI] [PubMed] [Google Scholar]
- 10. Rappaport H.B., Oliverio A.M.. Extreme environments offer an unprecedented opportunity to understand microbial eukaryotic ecology, evolution, and genome biology. Nat. Commun. 2023; 14:4959. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11. Ryu W.-S. Discovery and classification. Mol. Virol. Hum. Pathogenic Viruses. 2017; 10.1016/B978-0-12-800838-6.00001-1. [DOI] [Google Scholar]
- 12. Fuhrman J.A. Marine viruses and their biogeochemical and ecological effects. Nature. 1999; 399:541–548. [DOI] [PubMed] [Google Scholar]
- 13. Chen D.S., Wu Y.Q., Zhang W., Jiang S.J., Chen S.Z.. Horizontal gene transfer events reshape the global landscape of arm race between viruses and homo sapiens. Sci. Rep. 2016; 6:26934. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14. Nasir A., Romero-Severson E., Claverie J.M.. Investigating the concept and origin of viruses. Trends Microbiol. 2020; 28:959. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15. Koonin E.V., Senkevich T.G., Dolja V.V.. The ancient Virus World and evolution of cells. Biol. Direct. 2006; 1:29. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16. Wilkinson M.D., Dumontier M., Aalbersberg I..J., Appleton G., Axton M., Baak A., Blomberg N., Boiten J.W., da Silva Santos L.B., Bourne P.E.et al.. The FAIR Guiding Principles for scientific data management and stewardship. Sci. Data. 2016; 3:160018. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 17. Beghini F., McIver L.J., Blanco-Míguez A., Dubois L., Asnicar F., Maharjan S., Mailyan A., Manghi P., Scholz M., Thomas A.M.et al.. Integrating taxonomic, functional, and strain-level profiling of diverse microbial communities with biobakery 3. eLife. 2021; 10:e65088. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 18. Chen S., Zhou Y., Chen Y., Gu J.. fastp: an ultra-fast all-in-one FASTQ preprocessor. Bioinformatics. 2018; 34:i884–i890. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19. Langmead B., Salzberg S.L.. Fast gapped-read alignment with Bowtie 2. Nat. Methods. 2012; 9:357. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 20. Shen W., Le S., Li Y., Hu F.. SeqKit: a cross-platform and ultrafast toolkit for FASTA/Q file manipulation. PLoS One. 2016; 11:e0163962. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 21. De Coster W., Rademakers R.. NanoPack2: population-scale evaluation of long-read sequencing data. Bioinformatics. 2023; 39:btad311. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22. Li H. Minimap2: pairwise alignment for nucleotide sequences. Bioinformatics. 2018; 34:3094–3100. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23. Li D., Liu C.M., Luo R., Sadakane K., Lam T.W.. MEGAHIT: an ultra-fast single-node solution for large and complex metagenomics assembly via succinct de Bruijn graph. Bioinformatics. 2015; 31:1674–1676. [DOI] [PubMed] [Google Scholar]
- 24. Bankevich A., Nurk S., Antipov D., Gurevich A.A., Dvorkin M., Kulikov A.S., Lesin V.M., Nikolenko S.I., Pham S., Prjibelski A.D.et al.. SPAdes: a new genome assembly algorithm and its applications to single-cell sequencing. J. Comput. Biol. 2012; 19:455–477. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 25. Nurk S., Meleshko D., Korobeynikov A., Pevzner P.A.. metaSPAdes: a new versatile metagenomic assembler. Genome Res. 2017; 27:824–834. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 26. Bushmanova E., Antipov D., Lapidus A., Prjibelski A.D.. rnaSPAdes: a de novo transcriptome assembler and its application to RNA-Seq data. Gigascience. 2019; 8:giz100. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 27. Antipov D., Raiko M., Lapidus A., Pevzner P.A.. Metaviral SPAdes: assembly of viruses from metagenomic data. Bioinformatics. 2020; 36:4126–4129. [DOI] [PubMed] [Google Scholar]
- 28. Li H., Handsaker B., Wysoker A., Fennell T., Ruan J., Homer N., Marth G., Abecasis G., Durbin R.. The Sequence Alignment/Map format and SAMtools. Bioinformatics. 2009; 25:2078–2079. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 29. Liao Y., Smyth G.K., Shi W.. featureCounts: an efficient general purpose program for assigning sequence reads to genomic features. Bioinformatics. 2014; 30:923–930. [DOI] [PubMed] [Google Scholar]
- 30. Kolmogorov M., Yuan J., Lin Y., Pevzner P.A.. Assembly of long, error-prone reads using repeat graphs. Nat. Biotechnol. 2019; 37:540–546. [DOI] [PubMed] [Google Scholar]
- 31. Kolmogorov M., Bickhart D.M., Behsaz B., Gurevich A., Rayko M., Shin S.B., Kuhn K., Yuan J., Polevikov E., Smith T.P.L.et al.. metaFlye: scalable long-read metagenome assembly using repeat graphs. Nat. Methods. 2020; 17:1103–1110. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 32. Wu Y.-W., Simmons B.A., Singer S.W.. MaxBin 2.0: an automated binning algorithm to recover genomes from multiple metagenomic datasets. Bioinformatics. 2016; 32:605–607. [DOI] [PubMed] [Google Scholar]
- 33. Kang D.D., Li F., Kirton E., Thomas A., Egan R., An H., Wang Z.. MetaBAT 2: an adaptive binning algorithm for robust and efficient genome reconstruction from metagenome assemblies. PeerJ. 2019; 7:e7359. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 34. Alneberg J., Bjarnason B.S., De Bruijn I., Schirmer M., Quick J., Ijaz U.Z., Lahti L., Loman N.J., Andersson A.F., Quince C.. Binning metagenomic contigs by coverage and composition. Nat. Methods. 2014; 11:1144–1146. [DOI] [PubMed] [Google Scholar]
- 35. Sieber C.M.K., Probst A.J., Sharrar A., Thomas B.C., Hess M., Tringe S.G., Banfield J.F.. Recovery of genomes from metagenomes via a dereplication, aggregation and scoring strategy. Nat. Microbiol. 2018; 3:836–843. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 36. Karlicki M., Antonowicz S., Karnkowska A.. Tiara: deep learning-based classification system for eukaryotic sequences. Bioinformatics. 2022; 38:344–350. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 37. Chklovski A., Parks D.H., Woodcroft B.J., Tyson G.W.. CheckM2: A rapid, scalable and accurate tool for assessing microbial genome quality using machine learning. Nat. Methods. 2023; 20:1203–1212. [DOI] [PubMed] [Google Scholar]
- 38. Larralde M. Pyrodigal: Python bindings and interface to Prodigal, an efficient method for gene prediction in prokaryotes. J. Open Source Softw. 2022; 7:4296. [Google Scholar]
- 39. Hyatt D., Chen G.-L., Locascio P.F., Land M.L., Larimer F.W., Hauser L.J.. Prodigal: prokaryotic gene recognition and translation initiation site identification. BMC Bioinf. 2010; 11:119. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 40. Chan P.P., Lowe T.M.. tRNAscan-SE: Searching for tRNA genes in genomic sequences. Methods Mol. Biol. 2019; 1962:1. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 41. Manni M., Berkeley M.R., Seppey M., Simão F.A., Zdobnov E.M.. BUSCO update: novel and streamlined workflows along with broader and deeper phylogenetic coverage for scoring of eukaryotic, prokaryotic, and viral genomes. Mol. Biol. Evol. 2021; 38:4647–4654. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 42. Camargo A.P., Roux S., Schulz F., Babinski M., Xu Y., Hu B., Chain P.S.G., Nayfach S., Kyrpides N.C.. Identification of mobile genetic elements with geNomad. Nat. Biotechnol. 2023; 10.1038/s41587-023-01953-y. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 43. Ren J., Ahlgren N.A., Lu Y.Y., Fuhrman J.A., Sun F.. VirFinder: a novel k-mer based tool for identifying viral sequences from assembled metagenomic data. Microbiome. 2017; 5:69. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 44. Nayfach S., Camargo A.P., Schulz F., Eloe-Fadrosh E., Roux S., Kyrpides N.C.. CheckV assesses the quality and completeness of metagenome-assembled viral genomes. Nat. Biotechnol. 2020; 39:578–585. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 45. Nayfach S. Recommended cutoffs for analyzing CheckV results. BitBucket. 2021; (6 July 2021, date last accrssed)https://bitbucket.org/berkeleylab/checkv/issues/38/recommended-cutoffs-for-analyzing-checkv. [Google Scholar]
- 46. Chaumeil P.A., Mussig A.J., Hugenholtz P., Parks D.H.. GTDB-Tk v2: memory friendly classification with the genome taxonomy database. Bioinformatics. 2022; 38:5315–5316. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 47. Parks D.H., Chuvochina M., Chaumeil P.A., Rinke C., Mussig A.J., Hugenholtz P.. A complete domain-to-species taxonomy for Bacteria and Archaea. Nat. Biotechnol. 2020; 38:1079–1086. [DOI] [PubMed] [Google Scholar]
- 48. Jain C., Rodriguez-R L.M., Phillippy A.M., Konstantinidis K.T., Aluru S.. High throughput ANI analysis of 90K prokaryotic genomes reveals clear species boundaries. Nat. Commun. 2018; 9:5114. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 49. Hagberg A.A., Schult D.A., Swart P.J.. Exploring network structure, dynamics, and function using NetworkX. 2008;
- 50. Steinegger M., Söding J.. MMseqs2 enables sensitive protein sequence searching for the analysis of massive data sets. Nat, Biotechnol. 2017; 35:1026–1028. [DOI] [PubMed] [Google Scholar]
- 51. Buchfink B., Ashkenazy H., Reuter K., Kennedy J.A., Drost H.-G.. Sensitive clustering of protein sequences at tree-of-life scale using DIAMOND DeepClust. 2023; bioRxiv doi:25 Jaunary 2023, reprint: not peer reviewed 10.1101/2023.01.24.525373. [DOI]
- 52. Buchfink B., Reuter K., Drost H.G.. Sensitive protein alignments at tree-of-life scale using DIAMOND. Nat. Methods. 2021; 18:366–368. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 53. Buchfink B., Xie C., Huson D.H.. Fast and sensitive protein alignment using DIAMOND. Nat. Methods. 2014; 12:59–60. [DOI] [PubMed] [Google Scholar]
- 54. Suzek B.E., Wang Y., Huang H., McGarvey P.B., Wu C.H.. UniRef clusters: a comprehensive and scalable alternative for improving sequence similarity searches. Bioinformatics. 2015; 31:926. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 55. Terlouw B.R., Blin K., Navarro-Muñoz J.C., Avalon N.E., Chevrette M.G., Egbert S., Lee S., Meijer D., Recchia M.J.J., Reitz Z.L.et al.. MIBiG 3.0: A community-driven effort to annotate experimentally validated biosynthetic gene clusters. Nucleic Acids Res. 2023; 51:D603–D610. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 56. Liu B., Zheng D., Zhou S., Chen L., Yang J.. VFDB 2022: a general classification scheme for bacterial virulence factors. Nucleic Acids Res. 2022; 50:D912. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 57. Lombard V., Golaconda Ramulu H., Drula E., Coutinho P.M., Henrissat B.. The carbohydrate-active enzymes database (CAZy) in 2013. Nucleic Acids Res. 2014; 42:D490–D495. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 58. Mistry J., Finn R.D., Eddy S.R., Bateman A., Punta M.. Challenges in homology search: HMMER3 and convergent evolution of coiled-coil regions. Nucleic Acids Res. 2013; 41:e121. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 59. Mistry J., Chuguransky S., Williams L., Qureshi M., Salazar G.A., Sonnhammer E.L.L., Tosatto S.C.E., Paladin L., Raj S., Richardson L.J.et al.. Pfam: The protein families database in 2021. Nucleic Acids Res. 2021; 49:D412–D419. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 60. Feldgarden M., Brover V., Gonzalez-Escalona N., Frye J.G., Haendiges J., Haft D.H., Hoffmann M., Pettengill J.B., Prasad A.B., Tillman G.E.et al.. AMRFinderPlus and the Reference Gene Catalog facilitate examination of the genomic links among antimicrobial resistance, stress response, and virulence. Sci. Rep. 2021; 11:12728. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 61. Eberhardt R.Y., Haft D.H., Punta M., Martin M., O’Donovan C., Bateman A.. AntiFam: a tool to help identify spurious ORFs in protein annotation. Database (Oxford). 2012; 2012:bas003. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 62. Aramaki T., Blanc-Mathieu R., Endo H., Ohkubo K., Kanehisa M., Goto S., Ogata H.. KofamKOALA: KEGG Ortholog assignment based on profile HMM and adaptive score threshold. Bioinformatics. 2020; 36:2251–2252. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 63. Ruiz-Perez C.A., Conrad R.E., Konstantinidis K.T.. MicrobeAnnotator: a user-friendly, comprehensive functional annotation pipeline for microbial genomes. 2021; 22:11. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 64. Blin K., Shaw S., Kloosterman A.M., Charlop-Powers Z., Van Wezel G.P., Medema M.H., Weber T.. antiSMASH 6.0: improving cluster detection and comparison capabilities. Nucleic Acids Res. 2021; 49:W29–W35. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 65. Shaw J., William Yu Y., Shaw J., Yu Y.. Metagenome profiling and containment estimation through abundance-corrected k-mer sketching with sylph. 2023; bioRxiv doi:20 November 2023, preprint: not peer reviewed 10.1101/2023.11.20.567879. [DOI]
- 66. Edgar R.C. Muscle5: High-accuracy alignment ensembles enable unbiased assessments of sequence homology and phylogeny. Nat. Commun. 2022; 13:6968. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 67. Steenwyk J.L., Buida T.J., Li Y., Shen X.X., Rokas A.. ClipKIT: A multiple sequence alignment trimming software for accurate phylogenomic inference. PLoS Biol. 2020; 18:e3001007. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 68. Price M.N., Dehal P.S., Arkin A.P.. FastTree 2–approximately maximum-likelihood trees for large alignments. PLoS One. 2010; 5:e9490. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 69. Piñeiro C., Abuín J.M., Pichel J.C.. Very Fast Tree: speeding up the estimation of phylogenies for large alignments through parallelization and vectorization strategies. Bioinformatics. 2020; 36:4658–4659. [DOI] [PubMed] [Google Scholar]
- 70. Minh B.Q., Schmidt H.A., Chernomor O., Schrempf D., Woodhams M.D., Von Haeseler A., Lanfear R., Teeling E. IQ-TREE 2: new models and efficient methods for phylogenetic inference in the genomic era. Mol. Biol. Evol. 2020; 37:1530–1534. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 71. Dobin A., Davis C.A., Schlesinger F., Drenkow J., Zaleski C., Jha S., Batut P., Chaisson M., Gingeras T.R.. STAR: ultrafast universal RNA-seq aligner. Bioinformatics. 2013; 29:15. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 72. Nabwera H.M., Espinoza J.L., Worwui A., Betts M., Okoi C., Sesay A.K., Bancroft R., Agbla S.C., Jarju S., Bradbury R.S.et al.. Interactions between fecal gut microbiome, enteric pathogens, and energy regulating hormones among acutely malnourished rural Gambian children. EBioMedicine. 2021; 73:103644. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 73. Espinoza J.L., Shah N., Singh S., Nelson K.E., Dupont C.L.. Applications of weighted association networks applied to compositional data in biology. Environ. Microbiol. 2020; 22:3020–3038. [DOI] [PubMed] [Google Scholar]
- 74. Erb I. Partial correlations in compositional data analysis. Appl. Comput. Geosci. 2020; 6:100026. [Google Scholar]
- 75. Jin S., Notredame C., Erb I.. Compositional covariance shrinkage and regularised partial correlations. 2022;
- 76. Traag V.A., Waltman L., van Eck N.J.. From Louvain to Leiden: guaranteeing well-connected communities. Sci. Rep. 2019; 9:5233. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 77. Zulkower V., Rosser S.. DNA Features Viewer: a sequence annotation formatting and plotting library for Python. Bioinformatics. 2020; 36:4350–4352. [DOI] [PubMed] [Google Scholar]
- 78. Edgar R.C. MUSCLE: a multiple sequence alignment method with reduced time and space complexity. BMC Bioinf. 2004; 5:113. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 79. Eaton D.A.R. Toytree: a minimalist tree visualization and manipulation library for Python. Methods Ecol. Evol. 2020; 11:187–191. [Google Scholar]
- 80. Russel J., Pinilla-Redondo R., Mayo-Muñoz D., Shah S.A., Sørensen S.J.. CRISPRCasTyper: Automated Identification, Annotation, and Classification of CRISPR-Cas Loci. CRISPR J. 2020; 3:462–469. [DOI] [PubMed] [Google Scholar]
- 81. Waskom M.L. seaborn: statistical data visualization. J. Open Source Softw. 2021; 6:3021. [Google Scholar]
- 82. Hunter J.D. Matplotlib: a 2D Graphics Environment. Comput. Sci. Eng. 2007; 9:90–95. [Google Scholar]
- 83. Virshup I., Bredikhin D., Heumos L., Palla G., Sturm G., Gayoso A., Kats I., Koutrouli M., Angerer P., Bergen V.et al.. The scverse project provides a computational ecosystem for single-cell omics data analysis. Nat. Biotechnol. 2023; 41:604–606. [DOI] [PubMed] [Google Scholar]
- 84. McDonald D., Clemente J.C., Kuczynski J., Rideout J.R., Stombaugh J., Wendel D., Wilke A., Huse S., Hufnagle J., Meyer F.et al.. The Biological Observation Matrix (BIOM) format or: how I learned to stop worrying and love the ome-ome. Gigascience. 2012; 1:7. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 85. Bolyen E., Rideout J.R., Dillon M.R., Bokulich N.A., Abnet C.C., Al-Ghalith G.A., Alexander H., Alm E.J., Arumugam M., Asnicar F.et al.. Reproducible, interactive, scalable and extensible microbiome data science using QIIME 2. Nat. Biotechnol. 2019; 37:852–857. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 86. Grigoriev I.V., Nikitin R., Haridas S., Kuo A., Ohm R., Otillar R., Riley R., Salamov A., Zhao X., Korzeniewski F.et al.. MycoCosm portal: gearing up for 1000 fungal genomes. Nucleic Acids Res. 2014; 42:D699–D704. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 87. Grigoriev I.V., Hayes R.D., Calhoun S., Kamel B., Wang A., Ahrendt S., Dusheyko S., Nikitin R., Mondo S.J., Salamov A.et al.. PhycoCosm, a comparative algal genomics resource. Nucleic Acids Res. 2021; 49:D1004–D1011. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 88. Martin F.J., Amode M.R., Aneja A., Austine-Orimoloye O., Azov A.G., Barnes I., Becker A., Bennett R., Berry A., Bhai J.et al.. Ensembl 2023. Nucleic Acids Res. 2023; 51:D933–D941. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 89. Keeling P.J., Burki F., Wilcox H.M., Allam B., Allen E.E., Amaral-Zettler L.A., Armbrust E.V., Archibald J.M., Bharti A.K., Bell C.J.et al.. The Marine Microbial Eukaryote Transcriptome Sequencing Project (MMETSP): illuminating the functional diversity of eukaryotic life in the oceans through transcriptome sequencing. PLoS Biol. 2014; 12:e1001889. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 90. Seeleuthner Y., Mondy S., Lombard V., Carradec Q., Pelletier E., Wessner M., Leconte J., Mangot J.F., Poulain J., Labadie K.et al.. Single-cell genomics of multiple uncultured stramenopiles reveals underestimated functional diversity across oceans. Nat. Commun. 2018; 9:310. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 91. Richter D., Berney C., Strassert J., Poh Y.-P., Herman E.K., Muñoz-Gómez S.A., Wideman J.G., Burki F., Vargas C.d.. EukProt: A database of genome-scale predicted proteins across the diversity of eukaryotes. figshare. Dataset. 2022; 10.6084/m9.figshare.12417881.v3. [DOI] [Google Scholar]
- 92. Liu Z., Hu S., Caron D.. EukZoo, an aquatic protistan protein database for meta-omics studies. 2018; 10.5281/ZENODO.1476236. [DOI]
- 93. Delmont T.O., Gaia M., Hinsinger D.D., Frémont P., Vanni C., Fernandez-Guerra A., Eren A.M., Kourlaiev A., d’Agata L., Clayssen Q.et al.. Functional repertoire convergence of distantly related eukaryotic plankton lineages abundant in the sunlit ocean. Cell Genomics. 2022; 2:100123. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 94. Pruitt K.D., Tatusova T., Maglott D.R.. NCBI reference sequences (RefSeq): a curated non-redundant sequence database of genomes, transcripts and proteins. Nucleic Acids Res. 2007; 35:D733–D745. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 95. Blanco-Míguez A., Beghini F., Cumbo F., McIver L.J., Thompson K.N., Zolfo M., Manghi P., Dubois L., Huang K.D., Thomas A.M.et al.. Extending and improving metagenomic taxonomic profiling with uncharacterized species using MetaPhlAn 4. Nat. Biotechnol. 2023; 41:1633–1644. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 96. Zhao C., Dimitrov B., Goldman M., Nayfach S., Pollard K.S.. MIDAS2: metagenomic intra-species diversity analysis system. Bioinformatics. 2023; 39:btac713. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 97. van der Walt A.J., van Goethem M.W., Ramond J.B., Makhalanyane T.P., Reva O., Cowan D.A.. Assembling metagenomes, one community at a time. BMC Genomics. 2017; 18:521. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 98. González-Salazar L.A., Quezada M., Rodríguez-Orduña L., Ramos-Aboites H., Capon R.J., Souza-Saldívar V., Barona-Gomez F., Licona-Cassani C.. Biosynthetic novelty index reveals the metabolic potential of rare actinobacteria isolated from highly oligotrophic sediments. Microb Genom. 2023; 9:mgen000921. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 99. Wood D.E., Lu J., Langmead B.. Improved metagenomic analysis with Kraken 2. Genome Biol. 2019; 20:257. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 100. Piro V.C., Dadi T.H., Seiler E., Reinert K., Renard B.Y.. ganon: precise metagenomics classification against large and up-to-date sets of reference sequences. Bioinformatics. 2020; 36:i12–i20. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 101. Biller S.J., Berube P.M., Lindell D., Chisholm S.W.. Prochlorococcus: the structure and function of collective diversity. Nat. Rev. Microbiol. 2014; 13:13–27. [DOI] [PubMed] [Google Scholar]
- 102. Youngblut N.D., Ley R.E.. Struo2: efficient metagenome profiling database construction for ever-expanding microbial genome datasets. PeerJ. 2021; 9:e12198. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 103. Walker P.J., Siddell S.G., Lefkowitz E.J., Mushegian A.R., Adriaenssens E.M., Alfenas-Zerbini P., Davison A.J., Dempsey D.M., Dutilh B.E., García M.L.et al.. Changes to virus taxonomy and to the International Code of Virus Classification and Nomenclature ratified by the International Committee on Taxonomy of Viruses (2021). Arch. Virol. 2021; 166:2633–2648. [DOI] [PubMed] [Google Scholar]
- 104. Bin Jang H., Bolduc B., Zablocki O., Kuhn J.H., Roux S., Adriaenssens E.M., Brister J.R., Kropinski A.M., Krupovic M., Lavigne R.et al.. Taxonomic assignment of uncultivated prokaryotic virus genomes is enabled by gene-sharing networks. Nat. Biotechnol. 2019; 37:632–639. [DOI] [PubMed] [Google Scholar]
- 105. Nissen J.N., Johansen J., Allesøe R.L., Sønderby C.K., Armenteros J.J.A., Grønbech C.H., Jensen L.J., Nielsen H.B., Petersen T.N., Winther O.et al.. Improved metagenome binning and assembly using deep variational autoencoders. Nat. Biotechnol. 2021; 39:555–560. [DOI] [PubMed] [Google Scholar]
- 106. Quinn T.P., Erb I.. Amalgams : data-driven amalgamation for the reference-free dimensionality reduction of zero-laden compositional data. 2020; bioRxiv doi:28 February 2020, preprint: not peer reviewed 10.1101/2020.02.27.968677. [DOI] [PMC free article] [PubMed]
- 107. Espinoza J.L., Torralba M., Leong P., Saffery R., Bockmann M., Kuelbs C., Singh S., Hughes T., Craig J.M., Nelson K.E.et al.. Differential network analysis of oral microbiome metatranscriptomes identifies community scale metabolic restructuring in dental caries. PNAS Nexus. 2022; 1:pgac239. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 108. Ondov B.D., Bergman N.H., Phillippy A.M.. Interactive metagenomic visualization in a Web browser. BMC Bioinf. 2011; 12:385. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 109. Huerta-Cepas J., Serra F., Bork P.. ETE 3: reconstruction, analysis, and visualization of phylogenomic data. Mol. Biol. Evol. 2016; 33:1635–1638. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 110. Bos R.P., Kaul D., Zettler E.R., Hoffman J.M., Dupont C.L., Amaral-Zettler L.A., Mincer T.J.. Plastics select for distinct early colonizing microbial populations with reproducible traits across environmental gradients. Environ. Microbiol. 2023; 25:2761–2775. [DOI] [PubMed] [Google Scholar]
- 111. Michaud J.M., Thompson L.R., Kaul D., Espinoza J.L., Richter R.A., Xu Z.Z., Lee C., Pham K.M., Beall C.M., Malfatti F.et al.. Taxon-specific aerosolization of bacteria and viruses in an experimental ocean-atmosphere mesocosm. Nat. Commun. 2018; 9:2017. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 112. Chamas A., Moon H., Zheng J., Qiu Y., Tabassum T., Jang J.H., Abu-Omar M., Scott S.L., Suh S.. Degradation rates of plastics in the environment. ACS Sustain. Chem. Eng. 2020; 8:3494–3511. [Google Scholar]
- 113. Carney Almroth B., Eggert H.. Marine plastic pollution: sources, impacts, and policy issues. 2019; 13:317–326. [Google Scholar]
- 114. Jambeck J.R., Geyer R., Wilcox C., Siegler T.R., Perryman M., Andrady A., Narayan R., Law K.L.. Plastic waste inputs from land into the ocean. Science. 2015; 347:768–771. [DOI] [PubMed] [Google Scholar]
- 115. Geyer R., Jambeck J.R., Law K.L.. Production, use, and fate of all plastics ever made. Sci. Adv. 2017; 3:e17700782. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 116. Landrigan P.J., Stegeman J.J., Fleming L.E., Allemand D., Anderson D.M., Backer L.C., Brucker-Davis F., Chevalier N., Corra L., Czerucka D.et al.. Human health and ocean pollution. Ann Glob Health. 2020; 86:151. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 117. Zhang E., Kim M., Rueda L., Rochman C., VanWormer E., Moore J., Shapiro K.. Association of zoonotic protozoan parasites with microplastics in seawater and implications for human and wildlife health. Sci. Rep. 2022; 12:6532. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 118. Liu Z., Zhuan Q., Zhang L., Meng L., Fu X., Hou Y.. Polystyrene microplastics induced female reproductive toxicity in mice. J. Hazard. Mater. 2022; 424:127629. [DOI] [PubMed] [Google Scholar]
- 119. Schwabl P., Koppel S., Konigshofer P., Bucsics T., Trauner M., Reiberger T., Liebmann B.. Detection of various microplastics in human stool: a prospective case series. Ann. Intern. Med. 2019; 171:453–457. [DOI] [PubMed] [Google Scholar]
- 120. Ragusa A., Svelato A., Santacroce C., Catalano P., Notarstefano V., Carnevali O., Papa F., Rongioletti M.C.A., Baiocco F., Draghi S.et al.. Plasticenta: first evidence of microplastics in human placenta. Environ. Int. 2021; 146:106274. [DOI] [PubMed] [Google Scholar]
- 121. Kulikovskiy M., Genkal S., Maltsev Y., Glushchenko A., Kuznetsova I., Kapustin D., Gusev E., Martynenko N., Kociolek J.P.. Resurrection of the diatom genus Stephanocyclus (Coscinodiscophyceae: Stephanodiscaceae) on the basis of an integrated molecular and morphological approach. Fottea. 2022; 22:181–191. [Google Scholar]
- 122. Shah A.A., Hasan F., Hameed A., Ahmed S.. Biological degradation of plastics: a comprehensive review. Biotechnol. Adv. 2008; 26:246–265. [DOI] [PubMed] [Google Scholar]
- 123. Yoshida S., Hiraga K., Takehana T., Taniguchi I., Yamaji H., Maeda Y., Toyohara K., Miyamoto K., Kimura Y., Oda K.. A bacterium that degrades and assimilates poly(ethylene terephthalate). Science. 2016; 351:1196–1199. [DOI] [PubMed] [Google Scholar]
- 124. Gambarini V., Pantos O., Kingsbury J.M., Weaver L., Handley K.M., Lear G.. PlasticDB: A database of microorganisms and proteins linked to plastic biodegradation. Database (Oxford). 2022; 2022:baac008. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 125. Ramach K., ran V., Kanna G.R., Elumalai S. Biodegradation of polyethylene by green photosynthetic microalgae. J. Bioremed. Biodegrad. 2017; 8:381. [Google Scholar]
- 126. Sanniyasi E., Gopal R.K., Gunasekar D.K., Raj P.P.. Biodegradation of low-density polyethylene (LDPE) sheet by microalga, Uronema africanum Borge. Sci. Rep. 2021; 11:17233. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 127. Deng B., Yue Y., Yang J., Yang M., Xing Q., Peng H., Wang F., Li M., Ma L., Zhai C.. Improving the activity and thermostability of PETase from Ideonella sakaiensis through modulating its post-translational glycan modification. Commun. Biol. 2023; 6:39. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 128. Arnal G., Anglade J., Gavalda S., Tournier V., Chabot N., Bornscheuer U.T., Weber G., Marty A.. Assessment of four engineered PET degrading enzymes considering large-scale industrial applications. ACS Catal. 2023; 13:13156–13166. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 129. Hempel F., Bozarth A.S., Lindenkamp N., Klingl A., Zauner S., Linne U., Steinbüchel A., Maier U.G.. Microalgae as bioreactors for bioplastic production. Microb. Cell Fact. 2011; 10:81. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 130. Kirstein I.V., Kirmizi S., Wichels A., Garin-Fernandez A., Erler R., Löder M., Gerdts G.. Dangerous hitchhikers? Evidence for potentially pathogenic Vibrio spp. on microplastic particles. Mar. Environ. Res. 2016; 120:1–8. [DOI] [PubMed] [Google Scholar]
- 131. Goldstein M.C., Carson H.S., Eriksen M.. Relationship of diversity and habitat area in North Pacific plastic-associated rafting communities. Mar. Biol. 2014; 161:1441–1453. [Google Scholar]
- 132. Keswani A., Oliver D.M., Gutierrez T., Quilliam R.S.. Microbial hitchhikers on marine plastic debris: human exposure risks at bathing waters and beach environments. Mar. Environ. Res. 2016; 118:10–19. [DOI] [PubMed] [Google Scholar]
- 133. Vancaester E., Depuydt T., Osuna-Cruz C.M., Vandepoele K.. Comprehensive and functional analysis of horizontal gene transfer events in diatoms. Mol. Biol. Evol. 2020; 37:3243–3257. [DOI] [PubMed] [Google Scholar]
- 134. Reynolds E.D., Cove J.H.. Resistance to telithromycin is conferred by msr(A), msrC and msr(D) in Staphylococcus aureus. J. Antimicrob. Chemother. 2005; 56:1179–1180. [DOI] [PubMed] [Google Scholar]
- 135. Novotna G., Janata J.. A new evolutionary variant of the streptogramin A resistance protein, Vga(A)LC, from Staphylococcus haemolyticus with shifted substrate specificity towards lincosamides. Antimicrob. Agents Chemother. 2006; 50:4070–4076. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 136. Singh K.V., Weinstock G.M., Murray B.E.. An Enterococcus faecalis ABC homologue (Lsa) is required for the resistance of this species to clindamycin and quinupristin-dalfopristin. Antimicrob. Agents Chemother. 2002; 46:1845–1850. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 137. Ross J.I., Eady E.A., Cove J.H., Cunliffe W.J., Baumberg S., Wootton J.C.. Inducible erythromycin resistance in staphylococci is encoded by a member of the ATP-binding transport super-gene family. Mol. Microbiol. 1990; 4:1207–1214. [DOI] [PubMed] [Google Scholar]
- 138. Wang Y., Lv Y., Cai J., Schwarz S., Cui L., Hu Z., Zhang R., Li J., Zhao Q., He T.et al.. A novel gene, optrA, that confers transferable resistance to oxazolidinones and phenicols and its presence in Enterococcus faecalis and Enterococcus faecium of human and animal origin. J. Antimicrob. Chemother. 2015; 70:2182–2190. [DOI] [PubMed] [Google Scholar]
- 139. Gentry D.R., McCloskey L., Gwynn M.N., Rittenhouse S.F., Scangarella N., Shawar R., Holmes D.J.. Genetic characterization of Vga ABC proteins conferring reduced susceptibility to pleuromutilins in Staphylococcus aureus. Antimicrob. Agents Chemother. 2008; 52:4507–4509. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 140. Allignet J., Loncle V., El Solh N.. Sequence of a staphylococcal plasmid gene, vga, encoding a putative ATP-binding protein involved in resistance to virginiamycin A-like antibiotics. Gene. 1992; 117:45–51. [DOI] [PubMed] [Google Scholar]
- 141. Sharkey L.K.R., Edwards T.A., O’Neill A.J. ABC-F proteins mediate antibiotic resistance through ribosomal protection. mBio. 2016; 7:e01975-15. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 142. Murina V., Kasari M., Takada H., Hinnu M., Saha C.K., Grimshaw J.W., Seki T., Reith M., Putrinš M., Tenson T.et al.. ABCF ATPases involved in protein synthesis, ribosome assembly and antibiotic resistance: structural and functional diversification across the tree of life. J. Mol. Biol. 2019; 431:3568. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 143. Ingebrigtsen R.A., Hansen E., Andersen J.H., Eilertsen H.C.. Light and temperature effects on bioactivity in diatoms. J. Appl. Phycol. 2016; 28:939–950. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 144. Lauritano C., Andersen J.H., Hansen E., Albrigtsen M., Escalera L., Esposito F., Helland K., Hanssen K., Romano G., Ianora A.. Bioactivity screening of microalgae for antioxidant, anti-inflammatory, anticancer, anti-diabetes, and antibacterial activities. Front Mar. Sci. 2016; 10.3389/fmars.2016.00068. [DOI] [Google Scholar]
- 145. Samarakoon K.W., Ko J.Y., Shah M.M.R., Lee J.H., Kang M.C., O-Nam K., Lee J.B., Jeon Y.J.. In vitro studies of anti-inflammatory and anticancer activities of organic solvent extracts from cultured marine microalgae. ALGAE. 2013; 28:111–119. [Google Scholar]
- 146. Lavy A., Naveh Y., Coleman R., Mokady S., Werman M.J.. Dietary Dunaliella bardawil, a beta-carotene-rich alga, protects against acetic acid-induced small bowel inflammation in rats. Inflamm. Bowel Dis. 2003; 9:372–379. [DOI] [PubMed] [Google Scholar]
- 147. Sipes K., Almatari A., Eddie A., Williams D., Spirina E., Rivkina E., Liang R., Onstott T.C., Vishnivetskaya T.A., Lloyda K.G.. Eight metagenome-assembled genomes provide evidence for microbial adaptation in 20,000- to 1,000,000-year-old Siberian permafrost. Appl. Environ. Microb. 2021; 87:e0097221. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 148. Veremeeva A., Gubin S.. Modern tundra landscapes of the Kolyma Lowland and their evolution in the Holocene. Permafr Periglac Process. 2009; 20:399–406. [Google Scholar]
- 149. Strauss J., Schirrmeister L., Grosse G., Fortier D., Hugelius G., Knoblauch C., Romanovsky V., Schädel C., Schneider von Deimling T., Schuur E.A.G.et al.. Deep Yedoma permafrost: a synthesis of depositional characteristics and carbon vulnerability. Earth Sci. Rev. 2017; 172:75–86. [Google Scholar]
- 150. Grosse G., Robinson J.E., Bryant R., Taylor M.D., Harper W., DeMasi A., Kyker-Snowman E., Veremeeva A., Schirrmeister L., Harden J.. Distribution of late Pleistocene ice-rich syngenetic permafrost of the Yedoma Suite in east and central Siberia, Russia. Open-File Rep. 2013; 2013:1078. [Google Scholar]
- 151. MacKelprang R., Waldrop M.P., Deangelis K.M., David M.M., Chavarria K.L., Blazewicz S.J., Rubin E.M., Jansson J.K.. Metagenomic analysis of a permafrost microbial community reveals a rapid response to thaw. Nature. 2011; 480:368–371. [DOI] [PubMed] [Google Scholar]
- 152. Gilichinsky D., Rivkina E., Shcherbakova V., Laurinavichuis K., Tiedje J.. Supercooled water brines within permafrost—an unknown ecological niche for microorganisms: a model for astrobiology. Astrobiology. 2004; 3:331–341. [DOI] [PubMed] [Google Scholar]
- 153. Paez-Espino D., Eloe-Fadrosh E.A., Pavlopoulos G.A., Thomas A.D., Huntemann M., Mikhailova N., Rubin E., Ivanova N.N., Kyrpides N.C.. Uncovering Earth's virome. Nature. 2016; 536:425–430. [DOI] [PubMed] [Google Scholar]
- 154. Frey B., Rime T., Phillips M., Stierli B., Hajdas I., Widmer F., Hartmann M.. Microbial diversity in European alpine permafrost and active layers. FEMS Microbiol. Ecol. 2016; 92:18. [DOI] [PubMed] [Google Scholar]
- 155. Gittel A., Bárta J., Kohoutová I., Mikutta R., Owens S., Gilbert J., Schnecker J., Wild B., Hannisdal B., Maerz J.et al.. Distinct microbial communities associated with buried soils in the Siberian tundra. ISME J. 2013; 8:841–853. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 156. Schaefer K., Elshorbany Y., Jafarov E., Schuster P.F., Striegl R.G., Wickland K.P., Sunderland E.M.. Potential impacts of mercury released from thawing permafrost. Nat. Commun. 2020; 11:4650. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 157. Tarbier B., Hugelius G., Kristina Sannel A.B., Baptista-Salazar C., Jonsson S.. Permafrost thaw increases methylmercury formation in subarctic fennoscandia. Environ. Sci. Technol. 2021; 55:6710–6717. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 158. Langer M., von Deimling T.S., Westermann S., Rolph R., Rutte R., Antonova S., Rachold V., Schultz M., Oehme A., Grosse G.. Thawing permafrost poses environmental threat to thousands of sites with legacy industrial contamination. Nat. Commun. 2023; 14:1721. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 159. Yu C., Sun Y., Zhong X., Yu Z., Li X., Yi P., Jin H., Luo D.. Arsenic in permafrost-affected rivers and lakes of Tibetan Plateau, China. Environ. Pollut. Bioavail. 2009; 31:226–232. [Google Scholar]
- 160. Arnison P.G., Bibb M.J., Bierbaum G., Bowers A.A., Bugni T.S., Bulaj G., Camarero J.A., Campopiano D.J., Challis G.L., Clardy J.et al.. Ribosomally synthesized and post-translationally modified peptide natural products: overview and recommendations for a universal nomenclature. Nat. Prod. Rep. 2013; 30:108–160. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 161. Sofia H.J., Chen G., Hetzler B.G., Reyes-Spindola J.F., Miller N.E.. Radical SAM, a novel protein superfamily linking unresolved steps in familiar biosynthetic pathways with radical mechanisms: functional characterization using new analysis and information visualization methods. Nucleic Acids Res. 2001; 29:1097. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 162. Paoli L., Ruscheweyh H.J., Forneris C.C., Hubrich F., Kautsar S., Bhushan A., Lotti A., Clayssen Q., Salazar G., Milanese A.et al.. Biosynthetic potential of the global ocean microbiome. Nature. 2022; 607:111–118. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 163. Ahmad S., Saleem M., Riaz N., Lee Y.S., Diri R., Noor A., Almasri D., Bagalagel A., Elsebai M.F.. The natural polypeptides as significant elastase inhibitors. Front. Pharmacol. 2020; 11:688. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 164. Makarova K.S., Wolf Y.I., Iranzo J., Shmakov S.A., Alkhnbashi O.S., Brouns S.J.J., Charpentier E., Cheng D., Haft D.H., Horvath P.et al.. Evolutionary classification of CRISPR–Cas systems: a burst of class 2 and derived variants. Nat. Rev. Microbiol. 2019; 18:67–83. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 165. Pinilla-Redondo R., Mayo-Muñoz D., Russel J., Garrett R.A., Randau L., Sørensen S.J., Shah S.A.. Type IV CRISPR–Cas systems are highly diverse and involved in competition between plasmids. Nucleic Acids Res. 2020; 48:2000–2012. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 166. McGinn J., Marraffini L.A.. Molecular mechanisms of CRISPR-Cas spacer acquisition. Nat. Rev. Micro. 2019; 17:7–12. [DOI] [PubMed] [Google Scholar]
- 167. Salgado O., Guajardo-Leiva S., Moya-Beltrán A., Barbosa C., Ridley C., Tamayo-Leiva J., Quatrini R., Mojica F.J.M., Díez B.. Global phylogenomic novelty of the Cas1 gene from hot spring microbial communities. Front. Microbiol. 2022; 13:1069452. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 168. Wang Y., Ye J., Ju F., Liu L., Boyd J.A., Deng Y., Parks D.H., Jiang X., Yin X., Woodcroft B.J.et al.. Successional dynamics and alternative stable states in a saline activated sludge microbial community over 9 years. Microbiome. 2021; 9:199. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 169. Selkova P., Vasileva A., Pobegalov G., Musharova O., Arseniev A., Kazalov M., Zyubko T., Shcheglova N., Artamonova T., Khodorkovskii M.et al.. Position of Deltaproteobacteria Cas12e nuclease cleavage sites depends on spacer length of guide RNA. RNA Biol. 2020; 17:1472. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 170. Altae-Tran H., Kannan S., Suberski A.J., Mears K.S., Demircioglu F.E., Moeller L., Kocalar S., Oshiro R., Makarova K.S., Macrae R.K.et al.. Uncovering the functional diversity of rare CRISPR-Cas systems with deep terascale clustering. Science. 2023; 382:eadi1910. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 171. Shmakov S.A., Wolf Y.I., Savitskaya E., Severinov K.V., Koonin E.V.. Mapping CRISPR spaceromes reveals vast host-specific viromes of prokaryotes. Commun. Biol. 2020; 3:321. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 172. Zhang R., Mirdita M., Karin E.L., Norroy C., Galiez C., Söding J.. SpacePHARER: sensitive identification of phages from CRISPR spacers in prokaryotic hosts. Bioinformatics. 2021; 37:3364. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 173. Park H., Kim Y., Kimball J.S.. Widespread permafrost vulnerability and soil active layer increases over the high northern latitudes inferred from satellite remote sensing and process model assessments. Remote Sens. Environ. 2016; 175:349–358. [Google Scholar]
- 174. Boike J., Juszak I., Lange S., Chadburn S., Burke E., Paul Overduin P., Roth K., Ippisch O., Bornemann N., Stern L.et al.. A 20-year record (1998–2017) of permafrost, active layer and meteorological conditions at a high Arctic permafrost research site (Bayelva, Spitsbergen). Earth Syst. Sci. Data. 2018; 10:355–390. [Google Scholar]
- 175. Tamocai C., Canadell J.G., Schuur E.A.G., Kuhry P., Mazhitova G., Zimov S.. Soil organic carbon pools in the northern circumpolar permafrost region. Global Biogeochem. Cycles. 2009; 28:5227–5242. [Google Scholar]
- 176. Varliero G., Rafiq M., Singh S., Summerfield A., Sgouridis F., Cowan D.A., Barker G.. Microbial characterisation and Cold-Adapted Predicted Protein (CAPP) database construction from the active layer of Greenland's permafrost. FEMS Microbiol. Ecol. 2021; 97:127. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 177. Prentice M.B., Gilbertson M.L.J., Storm D.J., Turner W.C., Walsh D.P., Pinkerton M.E., Kamath P.L.. Metagenomic sequencing sheds light on microbes putatively associated with pneumonia-related fatalities of white-tailed deer (Odocoileus virginianus). Microb Genom. 2024; 10:001214. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 178. Hanberry B.B. Addressing regional relationships between white-tailed deer densities and land classes. Ecol. Evol. 2021; 11:13570–13578. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 179. Caserta L.C., Martins M., Butt S.L., Hollingshead N.A., Covaleda L.M., Ahmed S., Everts M.R.R., Schuler K.L., Diel D.G.. White-tailed deer (Odocoileus virginianus) may serve as a wildlife reservoir for nearly extinct SARS-CoV-2 variants of concern. Proc. Natl. Acad. Sci. U.S.A. 2023; 120:e2215067120. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 180. Pickering B., Lung O., Maguire F., Kruczkiewicz P., Kotwa J.D., Buchanan T., Gagnier M., Guthrie J.L., Jardine C.M., Marchand-Austin A.et al.. Divergent SARS-CoV-2 variant emerges in white-tailed deer with deer-to-human transmission. Nat. Microbiol. 2022; 7:2011–2024. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 181. Gilbertson M.L.J., Brandell E.E., Pinkerton M.E., Meaux N.M., Hunsaker M., Jarosinski D., Ellarson W., Walsh D.P., Storm D.J., Turner W.C. Cause of death, pathology, and chronic wasting disease status of white-tailed deer (Odocoileus virginianus) mortalities in Wisconsin, USA. J. Wildl. Dis. 2022; 58:803–815. [DOI] [PubMed] [Google Scholar]
- 182. Winans S., Yu H.J., de los Santos K., Wang G.Z., KewalRamani V.N., Goff S.P.. A point mutation in HIV-1 integrase redirects proviral integration into centromeric repeats. Nat. Commun. 2022; 13:1474. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 183. Diner R.E., Noddings C.M., Lian N.C., Kang A.K., McQuaid J.B., Jablanovic J., Espinoza J.L., Nguyen N.A., Anzelmatti M.A., Jansson J.et al.. Diatom centromeres suggest a mechanism for nuclear DNA acquisition. Proc. Natl. Acad. Sci. U.S.A. 2017; 114:E6015–E6024. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 184. Little R.D., Porta G., Carle G.F., Schlessinger D., D’Urso M. Yeast artificial chromosomes with 200- to 800-kilobase inserts of human DNA containing HLA, V kappa, 5S, and Xq24-Xq28 sequences. Proc. Natl. Acad. Sci. U.S.A. 1989; 86:1598–1602. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 185. Brown D.M., Chan Y.A., Desai P.J., Grzesik P., Oldfield L.M., Vashee S., Way J.C., Silver P.A., Glass J.I.. Efficient size-independent chromosome delivery from yeast to cultured cell lines. Nucleic Acids Res. 2017; 45:e50. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 186. Aiyer S., Swapna G.V.T., Malani N., Aramini J.M., Schneider W.M., Plumb M.R., Ghanem M., Larue R.C., Sharma A., Studamire B.et al.. Altering murine leukemia virus integration through disruption of the integrase and BET protein family interaction. Nucleic Acids Res. 2014; 42:5917–5928. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 187. Dyda F., Hickman A.B., Jenkins T.M., Engelman A., Craigie R., Davies D.R.. Crystal structure of the catalytic domain of HIV-1 integrase: similarity to other polynucleotidyl transferases. Science. 1994; 266:1981–1986. [DOI] [PubMed] [Google Scholar]
- 188. Das D., Georgiadis M.M.. The crystal structure of the monomeric reverse transcriptase from Moloney murine leukemia virus. Structure. 2004; 12:819–829. [DOI] [PubMed] [Google Scholar]
- 189. Badarinarayan S.S., Sauter D.. Switching sides: how endogenous retroviruses protect us from viral onfections. J. Virol. 2021; 95:e02299-20. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 190. Carlson C.J., Zipfel C.M., Garnier R., Bansal S.. Global estimates of mammalian viral diversity accounting for host sharing. Nature Ecology & Evolution 2019 3:7. 2019; 3:1070–1075. [DOI] [PubMed] [Google Scholar]
- 191. Gray G.C., Robie E.R., Studstill C.J., Nunn C.L.. Mitigating future respiratory virus pandemics: New threats and approaches to consider. Viruses. 2021; 13:637. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 192. Jones K.E., Patel N.G., Levy M.A., Storeygard A., Balk D., Gittleman J.L., Daszak P.. Global trends in emerging infectious diseases. Nature. 2008; 451:990–993. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 193. Glud H.A., George S., Skovgaard K., Larsen L.E.. Zoonotic and reverse zoonotic transmission of viruses between humans and pigs. APMIS. 2021; 129:675. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 194. Kamath P.L., Manlove K., Cassirer E.F., Cross P.C., Besser T.E.. Genetic structure of Mycoplasma ovipneumoniae informs pathogen spillover dynamics between domestic and wild Caprinae in the western United States. Sci. Rep. 2019; 9:15318. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 195. Hill N.J., Bishop M.A., Trovão N.S., Ineson K.M., Schaefer A.L., Puryear W.B., Zhou K., Foss A.D., Clark D.E., MacKenzie K.G.et al.. Ecological divergence of wild birds drives avian influenza spillover and global spread. PLoS Pathog. 2022; 18:e1010062. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 196. Joly D.O., Ribic C.A., Langenberg J.A., Beheler K., Batha C.A., Dhuey B.J., Rolley R.E., Bartelt G., Van Deelen T.R., Samuel M.D.. Chronic wasting disease in free-ranging Wisconsin white-tailed deer. Emerg. Infect. Dis. 2003; 9:599. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 197. Wetterstrand K.A. DNA Sequencing Costs: Data from the NHGRI Genome Sequencing Program (GSP). 2020; (Accessed date 29/04/2020)https://www.genome.gov/about-genomics/fact-sheets/DNA-Sequencing-Costs-Data.
- 198. Sayers E.W., Cavanaugh M., Clark K., Pruitt K.D., Sherry S.T., Yankie L., Karsch-Mizrachi I.. GenBank 2023 update. Nucleic Acids Res. 2023; 51:D141. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 199. Shaffer M., Borton M.A., McGivern B.B., Zayed A.A., La Rosa S.L., 0003 3527 8101 Solden, L.M., Liu P., Narrowe A.B., Rodríguez-Ramos J., Bolduc B.et al.. DRAM for distilling microbial metabolism to automate the curation of microbiome function. Nucleic Acids Res. 2020; 48:8883–8900. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 200. Schwengers O., Jelonek L., Dieckmann M.A., Beyvers S., Blom J., Goesmann A.. Bakta: rapid and standardized annotation of bacterial genomes via alignment-free sequence identification. Microb Genom. 2021; 7:685. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 201. Rocha U., Coelho Kasmanas J., Kallies R., Saraiva J.P., Toscan R.B., Štefanič P., Bicalho M.F., Borim Correa F., Baştürk M.N., Fousekis E.et al.. MuDoGeR: Multi-Domain Genome recovery from metagenomes made easy. Mol. Ecol. Resour. 2024; 24:e13904. [DOI] [PubMed] [Google Scholar]
- 202. Alexander H., Hu S.K., Krinos A.I., Pachiadaki M., Tully B.J., Neely C.J., Reiter T.. Eukaryotic genomes from a global metagenomic data set illuminate trophic modes and biogeography of ocean plankton. mBio. 2023; 14:e0167623. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 203. Neely C.J., Hu S.K., Alexander H., Tully B.J.. The high-throughput gene prediction of more than 1,700 eukaryote genomes using the software package EukMetaSanity. 2021; bioRxiv doi:26 July 2021, preprint: not peer reviewed 10.1101/2021.07.25.453296. [DOI]
- 204. Zhu Q., Huang S., Gonzalez A., McGrath I., McDonald D., Haiminen N., Armstrong G., Vázquez-Baeza Y., Yu J., Kuczynski J.et al.. Phylogeny-aware analysis of metagenome community ecology based on matched reference genomes while bypassing taxonomy. Msystems. 2022; 7:e0016722. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 205. Eren A.M., Esen O.C., Quince C., Vineis J.H., Morrison H.G., Sogin M.L., Delmont T.O.. Anvi’o: An advanced analysis and visualization platformfor ’omics data. PeerJ. 2015; 2015:e1319. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 206. Larralde M., Zeller G.. PyHMMER: aPython library binding to HMMER for efficient sequence analysis. Bioinformatics. 2023; 39:btad214. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 207. Pavlopoulos G.A., Baltoumas F.A., Liu S., Selvitopi O., Camargo A.P., Nayfach S., Azad A., Roux S., Call L., Ivanova N.N.et al.. Unraveling the functional dark matter through global metagenomics. Nature. 2023; 622:594–602. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 208. Hamamsy T., Morton J.T., Blackwell R., Berenberg D., Carriero N., Gligorijevic V., Strauss C.E.M., Leman J.K., Cho K., Bonneau R.. Protein remote homology detection and structural alignment using deep learning. Nat. Biotechnol. 2024; 42:975–985. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 209. Krinos A., Hu S., Cohen N., Alexander H.. EUKulele: taxonomic annotation of the unsung eukaryotic microbes. J. Open Source Softw. 2021; 6:2817. [Google Scholar]
- 210. Lewin H.A., Robinson G.E., Kress W.J., Baker W.J., Coddington J., Crandall K.A., Durbin R., Edwards S.V., Forest F., Gilbert M.T.P.et al.. Earth BioGenome Project: sequencing life for the future of life. Proc. Natl. Acad. Sci. U.S.A. 2018; 115:4325–4333. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 211. Exposito-Alonso M., Drost H.G., Burbano H.A., Weigel D.. The Earth BioGenome project: opportunities and challenges for plant genomics and conservation. Plant J. 2020; 102:222–229. [DOI] [PubMed] [Google Scholar]
- 212. Core Writing Team Lee H., Romero J.. IPCC, 2023: Summary for Policymakers. Climate Change 2023: Synthesis Report. Contribution of Working Groups I, II and III to the Sixth Assessment Report of the Intergovernmental Panel on Climate Change. 2023; Geneva, Switzerland. [Google Scholar]
- 213. Cardinale B.J., Duffy J.E., Gonzalez A., Hooper D.U., Perrings C., Venail P., Narwani A., MacE G.M., Tilman D., Wardle D.A.et al.. Biodiversity loss and its impact on humanity. Nature. 2012; 486:59–67. [DOI] [PubMed] [Google Scholar]
- 214. Imai Y., Meyer K.J., Iinishi A., Favre-Godal Q., Green R., Manuse S., Caboni M., Mori M., Niles S., Ghiglieri M.et al.. A new antibiotic selectively kills Gram-negative pathogens. Nature. 2019; 576:459–464. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 215. Ling L.L., Schneider T., Peoples A.J., Spoering A.L., Engels I., Conlon B.P., Mueller A., Schäberle T.F., Hughes D.E., Epstein S.et al.. A new antibiotic kills pathogens without detectable resistance. Nature. 2015; 517:455–459. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 216. Espinoza J.L., Dupont C.L., O’Rourke A., Beyhan S., Morales P., Spoering A., Meyer K.J., Chan A.P., Choi Y., Nierman W.C.et al.. Predicting antimicrobial mechanism-of-action from transcriptomes: a generalizable explainable artificial intelligence approach. PLoS Comput. Biol. 2021; 17:e1008857. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 217. Mann J. Natural products in cancer chemotherapy: past, present and future. Nat. Rev. Cancer. 2002; 2:143–148. [DOI] [PubMed] [Google Scholar]
- 218. Frediansyah A., Sofyantoro F., Alhumaid S., Mutair A.A., Albayat H., Altaweil H.I., Al-Afghani H.M., Alramadhan A.A., Alghazal M.R., Turkistani S.A.et al.. Microbial natural products with antiviral activities, including anti-SARS-CoV-2: a review. Molecules. 2022; 27:4305. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 219. Davies J., Stoett P.. Biodiversity loss is dire, don’t get distracted. Nature. 2018; 564:345. [DOI] [PubMed] [Google Scholar]
- 220. Jaureguiberry P., Titeux N., Wiemers M., Bowler D.E., Coscieme L., Golden A.S., Guerra C.A., Jacob U., Takahashi Y., Settele J.et al.. The direct drivers of recent global anthropogenic biodiversity loss. Sci. Adv. 2022; 8:9982. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 221. Rosenberg K.V., Dokter A.M., Blancher P.J., Sauer J.R., Smith A.C., Smith P.A., Stanton J.C., Panjabi A., Helft L., Parr M.et al.. Decline of the North American avifauna. Science. 2019; 366:120–124. [DOI] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
The source code for VEBA (https://github.com/jolespin/veba), the clustered MicroEuk database (https://zenodo.org/records/10139451), and the analysis for case studies (https://zenodo.org/records/10780433) are publicly available. The original studies for the Plastisphere microbiome (BioProject: PRJNA777294), MarineAerosol microbiome (BioProject: PRJEB20421), Siberian permafrost microbiome (BioProject: PRJNA596250), and white-tailed deer lung microbiome (BioProject: PRJNA1025254) are available on NCBI (https://www.ncbi.nlm.nih.gov/bioproject/).