Next Article in Journal
The Potential Usefulness of the Expanded Carrier Screening to Identify Hereditary Genetic Diseases: A Case Report from Real-World Data
Next Article in Special Issue
Genome Assembly and Microsatellite Marker Development Using Illumina and PacBio Sequencing in the Carex pumila (Cyperaceae) from Korea
Previous Article in Journal
Analyzes In Silico Indicate the lncRNAs MIR31HG and LINC00939 as Possible Epigenetic Inhibitors of the Osteogenic Differentiation in PDLCs
Previous Article in Special Issue
Cloning, Identification, and Functional Analysis of the Chalcone Isomerase Gene from Astragalus sinicus
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

SAMBA: Structure-Learning of Aquaculture Microbiomes Using a Bayesian Approach

by
Beatriz Soriano
1,2,3,*,†,
Ahmed Ibrahem Hafez
2,†,
Fernando Naya-Català
1,
Federico Moroni
1,
Roxana Andreea Moldovan
2,4,5,
Socorro Toxqui-Rodríguez
1,
María Carla Piazzon
1,
Vicente Arnau
3,6,
Carlos Llorens
2 and
Jaume Pérez-Sánchez
1,*
1
Institute of Aquaculture Torre de la Sal (IATS), Consejo Superior de Investigaciones Científicas (CSIC), 12595 Ribera de Cabanes, Spain
2
Biotechvana, Parc Científic Universitat de València, 46980 Paterna, Spain
3
Institute for Integrative Systems Biology (I2SysBio), Universitat de Valencia and CSIC (UVEG-CSIC), 46980 Paterna, Spain
4
Health Research Institute INCLIVA, 46010 Valencia, Spain
5
Bioinformatics and Biostatistics Unit, Principe Felipe Research Center (CIPF), 46012 Valencia, Spain
6
Foundation for the Promotion of Sanitary and Biomedical Research of the Valencian Community (FISABIO), 46020 Valencia, Spain
*
Authors to whom correspondence should be addressed.
These authors contributed equally to this work.
Genes 2023, 14(8), 1650; https://doi.org/10.3390/genes14081650
Submission received: 28 June 2023 / Revised: 14 August 2023 / Accepted: 17 August 2023 / Published: 19 August 2023
(This article belongs to the Special Issue Application of Bioinformatics in Plants and Animals)

Abstract

:
Gut microbiomes of fish species consist of thousands of bacterial taxa that interact among each other, their environment, and the host. These complex networks of interactions are regulated by a diverse range of factors, yet little is known about the hierarchy of these interactions. Here, we introduce SAMBA (Structure-Learning of Aquaculture Microbiomes using a Bayesian Approach), a computational tool that uses a unified Bayesian network approach to model the network structure of fish gut microbiomes and their interactions with biotic and abiotic variables associated with typical aquaculture systems. SAMBA accepts input data on microbial abundance from 16S rRNA amplicons as well as continuous and categorical information from distinct farming conditions. From this, SAMBA can create and train a network model scenario that can be used to (i) infer information of how specific farming conditions influence the diversity of the gut microbiome or pan-microbiome, and (ii) predict how the diversity and functional profile of that microbiome would change under other variable conditions. SAMBA also allows the user to visualize, manage, edit, and export the acyclic graph of the modelled network. Our study presents examples and test results of Bayesian network scenarios created by SAMBA using data from a microbial synthetic community, and the pan-microbiome of gilthead sea bream (Sparus aurata) in different feeding trials. It is worth noting that the usage of SAMBA is not limited to aquaculture systems as it can be used for modelling microbiome–host network relationships of any vertebrate organism, including humans, in any system and/or ecosystem.

1. Introduction

Gut microbiomes in fish and other vertebrates are subjected to complex and dynamic fluctuations that are driven by several factors associated with the host (e.g., genotype, physiological status, pathobiology) and its environment, lifestyle and diet [1]. In turn, each of these factors can contribute to improve the sustainability of industrial aquaculture [2]. Hence, the complex relationships between the physical and biological components of aquaculture systems in the context of climate change and human population growth are one of the key future challenges in animal food production [3,4]. Current research on gilthead sea bream (S. aurata), a highly cultured species in the Mediterranean, indicated that the gut microbiota is a reliable criterion to evaluate the success of selective breeding with changes in diet composition [5,6,7]. However, our understanding about these kinds of dynamics is at an infancy state, due to their inherent complexity, the multiple biotic and abiotic factors involved, and the enormous variability of mucosal microbial populations among distinct individuals of the same population [8,9]. For this reason, there is a growing interest to develop tools that can model how fish microbiomes and their hosts interact under variable farming conditions. Along these lines, Bayesian networks (BN) and structure learning [10,11,12] may be especially useful due to their capacity to infer directional relationships in microbial communities [13,14]. Certainly, BNs are probabilistic graphical models based on the Bayes Theorem that represent and evaluate the conditional dependencies among a set of variables via directed acyclic graphs (DAG). In such models, variables and their interrelations of dependency are represented as nodes and edges, respectively [15]. Structure learning refers to the process to learn the structure of the DAG from the available data, creating a model where an edge between two nodes indicates direct stochastic dependency, while no connection (edge) between two nodes identifies that the corresponding variables are independent or conditionally independent [13].
BNs have been used to promote the sustainable development of aquaculture systems [16]. However, they are yet to be applied to reveal dynamic interactions between different biotic and abiotic factors. Moreover, BN tools are typically tailor-made solutions created using command line interface (CLI) software packages (e.g., bnlearn), but they are complex to manage and often restricted to expert bioinformaticians and computational biologists [17]. Indeed, most user-friendly BN tools with Graphical User Interfaces (GUI), such as ShinyBN [18] or BayesiaLab [19], only work with discrete variables and small datasets. In addition, while the recently released BayeSuites tool [11] manages continuous variables and large datasets, it currently cannot make inferences and establish conditional probability distributions based on discrete variables. To address these issues, we created SAMBA (Structure-Learning of Aquaculture Microbiomes using a Bayesian Approach), a new BN tool to investigate microbiome systems or microbiome–host network dynamics in aquaculture systems by modelling how fish gut microbiomes and/or pan-microbiomes interact with the various biotic and abiotic factors. Here, we provided examples of the functionality of the tool’s web-interface, and evaluated SAMBA performance when building and estimating the conditional dependencies among the variables in the DAG model. To this end, we will use two training datasets of different natures and complexities: i) an artificial microbial community with few taxa and defined composition; and ii) real fish microbial communities of S. aurata resulting from a given time and aquaculture infrastructure, with diet as the main changing experimental variable. This first approach with SAMBA is fundamental not only from a testing point of view, but also to “feed” the tool with complex datasets. These experimental data will compose a reservoir of information that will make SAMBA a reliable predictive tool for investigating changing and sometimes poorly predictable scenarios.

2. Materials and Methods

2.1. SAMBA Modules

SAMBA is currently available in a GitHub public repository. The URL for downloading the input data is reported in the Data Availability Statement. The tool can be installed on personal computers, and it is based on a backend engine core that consists of a set of workflows and pipelines implemented in R and Python using third-party software dependencies. The frontend component of SAMBA consists of a web-based Graphical User Interface (GUI) implemented using shiny [20] to provide a friendly and intuitive interface to manage the engine core. Functions and tasks of SAMBA are structured in five modules: “Build”, “Inference”, “Prediction”, “Viewer”, and “Downloads”. A User Guide including technical details about the algorithmic basis of SAMBA is provided in Supplementary File S1.
“Build”: This module creates and trains BN models from the provided input data using a pipeline based on the bnlearn R package [17]. This module works with continuous and discrete variables. However, a discretization optional step is implemented using one of the following methods: interval, quantile or Hartemink [21]. For those continuous variables that are not discretized, a Shapiro [22] test is performed to know if they follow a normal distribution. For further information, please refer to Supplementary File S1. To create the BN models, SAMBA allows the user to fit distribution parameters. The current implementation includes a normal distribution in a logarithmic scale (Log-Normal) and a generalized linear model, the Zero-inflated Negative Binomial (ZINB) distribution, that better fits highly dispersed data with an excess of zeros in the taxa abundance counts [23]. The hc() function of bnlearn learns the structure of a BN using a hill-climbing (HC) greedy search (score-based algorithms). According to Scutari et al. (2019) [24], these algorithms are usually faster and more accurate for both small and large sample sizes. The HC search [25] explores the space of the DAG by single-arc addition, removal, or reversals. It also assigns a rate to the BN model using catching, decomposability, and three equivalence score functions to reduce the number of duplicated tests [17]. The three score functions are the Akaike Information Criterion (AIC), Bayesian Information Criterion (BIC), and Multinomial log-likelihood (loglik). The score method is adjusted for the hc() method so that a higher score is generally preferred.
The training of the model constructed by the “Build” module is performed by using the bn.fit() function of bnlearn or the aforesaid bn.fit() combined with the zeroinfl() function from the pscl package [26]. The bn.fit() function fits, assigns, or replaces the parameters of a BN conditional on its structure, while zeroinfl() fits zero-inflated regression models for count data via maximum likelihood. Once the parameters have been fitted, the strength of each connection is calculated using BIC and Mutual Information (MI) criterion [27] and the arc.strength() function of bnlearn to remove all links with strength values greater than the user-defined threshold. The future() function of the future package [28] allows the user to continue using other functions in the app while a model is being computed.
“Inference”: This interface uses functions of bnlearn and dagitty [29] to infer how the diversity of the pan-microbiome indexed in the BN is influenced by the experimental variables (season, diet composition, temperature, genetics, etc.). The “Inference” module provides two different report options: conditional probability tables (CPTs) and DAG. The CPT option uses a cosponsoring quantile-quantile plot of the fitted node to show the type of relationships among different taxa under different experimental variables. The DAG option creates a DAG from the bnlearn output using the dagitty() method of dagitty and allows the markov blanket of a given node to be extracted from the DAG using a markovBlanket() method.
“Prediction”: This interface allows the user to manage two predictive pipelines. The first, “Predict abundances” is a workflow based on bnlearn and pscl that predicts how taxa abundance counts will likely change based on changes in one or more farming variables selected as conditional evidence. In the Log-Normal Distribution mode, normalized frequencies in log scale are obtained via the cpdist() function of bnlearn. In the ZINB distribution mode, a custom sampling method samples from the fitted ZINB models of each taxon in the BN. The second pipeline of this module, “Predict Metagenomes”, infers the metagenome of a given pan-microbiome under specific experimental variables. It uses PICRUSt2 [30], which includes two different database annotation protocols: MetaCyc [31] and KEGG [32]. For more details about the PICRUSt2 workflow and its dependencies [33,34,35,36,37] please refer to Supplementary File S1.
“Viewer”: This module provides the user with tools to visualize, edit, customize, navigate, and export the DAG in various graphical formats. The “Viewer” is implemented using commands from several different packages. The subgraph() function of bnlearn plots the graph. VisIgraph() and the renderVisNetwork() functions of visNetwork [38] provide an interactive display of the DAG. The strength.viewer() function of bnviewer [39] shows the strength of the probabilistic relationships of the BN nodes. It also uses model averaging to build a graph containing only significant links. The decompose() function of the igraph package [40] visualizes specific node groups and, thus, allows users to work with a specific subgraph. CPTs with conditional probability information about the inter-relations of each node can be displayed in the viewer using the datatable() and dataTableProxy() functions of the DT package [41]. These functions allow the user to browse and filter information from the DAG. The “Viewer” also integrates a sidebar with tools for highlighting, selecting, and/or editing specific nodes and features using functions from the VisNetwork package, such as visOptions(), visRedraw(), visSetSelection(), visUpdateNodes(), and visUpdateEdges(). It also contains JavaScript code introduced through the runjs() function of the shiny package [42] and the JS() function of the htmlwidgets package [43]. Graphs can be downloaded as HTML, PNG, JPEG, or PDF files. A screenshot can be taken of the current network and exported using the shinyscreenshot package [44].
“Downloads”: This is a repository for the user to download.zip files containing results and output files from the “Build” module (the output includes normalized counts, link strengths, and a RData file containing the BN model) or the “Prediction” module (provided by metagenomic prediction).

2.2. Artificial Testing Dataset (Sequencing and Dataset Definition)

Semi-synthetic bacterial community ZymoBIOMICS™ Microbial Community Standard II (Zymo Research Corp., Irvine, CA, USA) was used as the dataset for constructing network models with SAMBA. This “mock community” is composed of eight bacteria (Listeria monocytogenes, Pseudomonas aeruginosa, Bacillus subtilis, Salmonella enterica, Escherichia coli, Lactobacillus fermentum, Enterococcus faecalis, and Staphylococcus aureus) with known differential abundances, distributed on a log scale, ranging from 0.00001% (S. aureus) to 95.9% (L. monocytogenes). PCR conditions and sequencing procedures were performed as described by Toxqui-Rodriguez et al. (2023) [45]. Briefly, eight replicates of the mock community were sequenced using the Oxford Nanopore Technologies MinION platform. The complete 16S rRNA gene (V1–V9) was sequenced using an R9.4/FLO-MIN106 flow cell with the 16S Barcoding Kit 1–24 (SQK–16S024) protocol version 16S_9086_v1_revR_14Aug2019. Reads were then demultiplexed and basecalled using MinKNOW v21.11.17 and Guppy v5.1.12. The resulting reads were preprocessed using Porechop v0.2.4 [46] for adapter removal, NanoFilt [47] for length-filtering between 1200 and 1800 bp, and yacrd [48] for chimera removal. Taxonomy assignment and abundance quantification was performed using Minimap2 [49] aligning sequences against the SILVA database [50]. The two PCR conditions were optimized starting from the recommendations of the kit’s manufacturer: PCR1 (temperature of annealing 55 °C, 25 PCR cycles) and PCR2 (temperature of annealing 52 °C, 30 PCR cycles) [45]. The raw abundance counts (with the exception of S. aureus, which was not detected after taxonomic assignment) and the PCR conditions to sequence the mock community were used as input to SAMBA. The mock community was utilized to test the accuracy of the SAMBA modules for BN model construction and prediction based on data with no biological variability. To this end, the BN model was created by the HC algorithm (no limit on the number of iterations, terminated by algorithm convergence) and utilizing all 8 replicates of the mock dataset. After building, the RData of the BN model were used as an input to the “Prediction” pipeline to predict the most likely abundances of each taxon using the log-normal distribution and default parameters. The most likely abundance values were extracted from the prediction module after setting the corresponding values for the PCR experimental variable. Full details about this dataset are provided in Supplementary File S2 and the URL for downloading the input data are reported in the Data Availability Statement.

2.3. Empirically Testing S. aurata Dataset (Sequencing, Experimental Design, Rearing Conditions, and Dataset Definition)

Intestinal pan-microbiome data were taken from the results of three published experimental trials that used S. aurata as a case study host model [51,52,53]. The S. aurata dataset included 844 taxa classified at the genus level that were obtained by sequencing the V3-V4 hypervariable regions of 16S rRNA, using the Illumina MiSeq system (2 × 300 paired-end run) (Illumina Inc., San Diego, CA, USA) at the Genomics Unit from the Madrid Science Park Foundation (FPCM, Campus de Cantoblanco, Spain). The autochthonous microbiota populations were sequenced from both the anterior and/or posterior intestine sections of 72 randomly selected specimens of S. aurata. Briefly, the trials were conducted in parallel (spring–summer 2020) at the Institute of Aquaculture Torre de la Sal under natural light and temperature conditions (40°5′ N; 0°10′ E), using fish with the same genetic background (sibling animals from the same hatchery batch; Avramar, Burriana, Spain). The resulting microbial populations were investigated in relation to different feeding scenarios (LSAQUA, EGGHYDRO, GAIN_PRE), which are summarized in Table 1. In the LSAQUA trial, fish meal (FM) was either partially (50%) or completely (100%) substituted with a protein replacer of processed animal proteins (PAPs) and bacterial single-cell proteins (SCPs). In the EGGHYDRO trial, combinations of FM and fish oil (FO) were used with or without a bioactive egg white hydrolysate. In the GAIN_PRE trial, FM was completely replaced with alternative protein sources (aquaculture by-product meal, insect meal, microbial biomass, and plant proteins) supplemented with a commercially available health-promoting feed additive. The performance of SAMBA was tested using the S. aurata dataset to build and train a BN model under the following parameters: BN score (BIC), taxa distribution (ZINB), link strength thresholds (MI < 0.05; BIC < 0), and a prevalence filter of 50 (which dismiss those taxa that are present in less than 50% of the samples with at least a minimum abundance of 1 read count). The experimental variables (Table 1) were considered independent so that predictions could be made for scenarios that were not directly tested in the methodology. The BN model was created by the HC algorithm (no limit on the number of iterations, terminated by algorithm convergence), utilizing 72 samples in the dataset. The predictive performance of SAMBA was evaluated in the EGGHYDRO trial. In addition, to further assess the predictive function of SAMBA, we tested how the modification of a variable condition, specifically FM, would affect the microbiome abundances of EGGHYDRO trial Scenario 3. This virtual Scenario, called as Scenario 4, was designed with the following experimental variables: FM > 20; FO ≤ 4; “AI” Tissue; “EWH” additive. The S. aurata dataset can be downloaded as reported in the Data Availability Statement.

3. Results and Discussion

Modelling the complex relationships of physical and biological components are particularly relevant for fish farming because the dynamics and hierarchies of the fish microbiomes and pan-microbiomes can reveal insights into the effects of genetics, environment, or traceability factors. In this article, we introduce SAMBA, the software implementation of a BN approach to learn, build, and train BN models from input datasets with quantitative and qualitative variables (including taxa abundance raw counts). As shown in Figure 1, SAMBA has a user-friendly GUI interface that provides access to five modules (“Build”, “Inference”, “Prediction”, “Viewer” and “Downloads”), which overcomes the usual computational complexity that exists in the modelling of BNs (see Supplementary File S1 for technical details). The application can be used to investigate the causal relationships between microbiomes and their hosts by deciphering how the taxa population are related each to other and influenced by the experimental variables. SAMBA can also be used to navigate the built BN model and to inspect the distribution of conditional dependences among the distinct variables, identifying those that provide statistically significant information about how a change in feed formulation, or any other environmental condition, may derive in a modulatory effect in the microbial profile. Additionally, SAMBA conditional BN dependencies provide a system biology perspective that, in comparison to conventional analyses based on the relative abundance of the taxonomic groups, is highly informative because the user may find combined actions between taxa without making independence assumptions, as normally performed in a usual 16S count analysis.
To test the potential and predictive power of SAMBA, we fed the tool with two training datasets (the mock community and the S. aurata dataset) to create two BN models. First, given its simplicity and semi-synthetic nature (no natural inter-sample dispersion among the abundance counts of the modelled taxa and only PCR conditions as experimental variable), the mock community offers a controlled scenario for assessing and showing the accuracy of SAMBA for making microbiota predictions. In Figure 2A, we show the DAG resulting from the mock community BN model, which depicts how the seven taxa of this community are connected each to other in the network as a result of their abundances and the experimental PCR condition (with the exception of L. fermentum, which is not affected by the PCR condition because it was the least abundant taxon). Predictions based on the mock community BN model were also performed and provided in Supplementary File S2. In addition, Figure 2B,C contains two correlation plots which show a remarkable linearity between the observed and the predicted abundances (under the two PCR conditions) of the seven taxa constituting the mock community. These two analyses are both supported by correlation coefficients over 0.99 for both PCR1 and PCR2 conditions, and with p-values for a F-test of 6.12 × 10−10 and 1.48 × 10−22 in the analysis of variance (see Supplementary File S2). We can, thus, conclude that SAMBA predictions accurately approximate the real-world observation from lab-made microbial simplified scenarios, which could be particularly helpful in designing and exploring synthetic biology experiments.
The second BN approach based on the S. aurata dataset was performed to assess how SAMBA builds and manages BN models using microbiome data from real-world experimentation (i.e., with high levels of dispersion in the taxa abundance counts). In Figure 3A, we show the DAG of the BN built using the S. aurata dataset. The prevalence filter of 50% reduced the number of taxa to 45. This number represents the core microbiome present in at least 36 of the 72 samples. This is a useful feature of SAMBA as it allows the user to focus not only on the whole dataset or the most abundant OTUs in the bacterial populations (the usual approach of 16S metagenomic analyses), but also on different subsets by managing the filtration parameters of the interface. Extracting functional and quantitative information from the DAG with SAMBA is easy and intuitive with the inference module. In particular, an example of how these results can be obtained is reported in Figure 3B, with the Markov blanket graph extracted from the total DAG. The image shows that the node representing Pseudomonas is the child of the nodes representing the experimental variables FO, FM and Phyllobacterium that indirectly connects Pseudomonas with Clostridium sensu stricto. The coefficient for conditional probability distribution that is significant for the node Pseudomonas, and the results of a Z test for each coefficient are shown in Supplementary File S3. According to this, it is possible to observe in Figure 3B that the FM variable (in its three states) has a significant impact on the abundance of Pseudomonas. In contrast, the variable FO only significantly impacts Pseudomonas when FO ≤ 4, but not when 4 < FO < 12. Additional to the dependences that occur between the experimental variables and taxa, the Markov blanket also offers information regarding the taxa–taxa interaction. The presence of Phyllobacterium in the pan-microbiome is significant in respect to Pseudomonas. This relationship means that the abundance of Phyllobacterium influences the abundance of Pseudomonas. Nevertheless, the impact of Phyllobacterium is less than that of FM and FO, which are the main causes for the variability in abundance of Pseudomonas in the S. aurata BN model. All these findings make SAMBA a useful tool, which allows the user to go one step forward in the comprehension of the inner dynamics of the microbial community. Regarding this, another example of functional information that can be obtained from the DAG is represented by the edges between OTUs and experimental variables. As the case of Pseudomonas, SAMBA detected other causal relationships, which connected other important genera like Streptococcus, Sphingomonas, Photobacterium, Massilia, Corynebacterium and Staphylococcus (Figure 3A) with components of the diet, such as FM, FO, and additives. The identification of which bacteria are more susceptible to changing in a diet and the magnitude by which they change their abundance, represents a cornerstone for nutrition in aquaculture. Defining the links that determine the pan-microbiome community structure when different feed conditions (as the case of the present experiments) or different environmental conditions are applied, provides a powerful forecasting tool to be used to face aquaculture challenges, such as the achievement of a more sustainable production sector through new innovative feed formulations.
The S. aurata dataset was also used to test the predictive capability of SAMBA. The profile of taxa abundances was predicted for the three feeding scenarios of the EGGHYDRO trial (Scenarios 1, 2 and 3 in Table 1), using the distribution of probabilities provided by the S. aurata BN model. Full predictive reports for Scenarios 1, 2 and 3 are available in Supplementary File S4, which shows that the probability density value of the range of the generated samples (the (P(M+SD)) was above 0.60 for 44 of the 45 taxa in Scenario 1; for 39 of the 45 taxa in Scenario 2; and for 42 of the 45 taxa in Scenario 3. This means that under Scenarios 1, 2 and 3 the ranges of predicted values made by SAMBA are significant for 98%, 87%, and 93% of the taxa, respectively. Moreover, with some reasonable exceptions, the mean, median, standard deviation, and quantiles overlap with the SAMBA predictions (Figure 4 and Figure 5). Another approach that we used to test the predictive performance of SAMBA involved the creation of a confusion matrix. This table, reported in Supplementary File S4, were designed calculating different parameters using the same profile of predicted taxa abundances obtained from the three feeding scenarios of the EGGHYDRO trial (Scenarios 1, 2 and 3 in Table 1) discussed before. The assessment was calculated using a linear regression (Pearson Correlation) between the predicted and observed values, and a True/False Positive and Negative classification. In particular, the evaluation was performed considering True Positive when the predicted value fell within the range defined by the average ± the standard deviation of the real observation, and was instead a False Positive when it was out of that range. On the other hand, the values were considered True Negative when the prediction was 0 and it fell within the range of the real observation, while a False Negative when the prediction was 0 and out of that range. The precision of the measurements and, hence, the tool, was then expressed as the rate between TP and the sum of TP and FP. The results display a strong statistical significance (p < 0.001) in the linear regression for all three feeding scenarios, with adjusted R2 parameter ranges of 0.69–0.79, 0.61–0.86 and 0.62–0.85. The number of FP predictions detected was minimum and the FN absent, with a precision (calculated as the rate between TP and the sum of TP and FP) very similar for all the scenarios considered (between 0.79–0.83). Thus, we conclude that SAMBA accurately predicts taxa abundances in a large matrix of data, even if their abundance distribution show significant dispersion due to the inter-sample biological variability, like real microbiota data [8,9]. Scenario 4 also tested the predictive capability of SAMBA by combining information from two different trials. More specifically, Scenario 4 predicted how the profile of taxa abundances of Scenario 3 would likely change under the experimental condition of Scenario 1 when FM > 20 (Supplementary File S4). In Figure 5, we also plotted mean, median, standard deviation, and quantiles obtained from Scenario 4 to compare with those from Scenario 3. The figure shows how the predicted abundance of some taxa significantly changed in response to FM. Thus, this suggests that SAMBA allowed the exploration of virtual scenarios using the BN model. This feature of SAMBA is useful for improving both the productivity and sustainability of fish farms as it can simulate, a priori, the effects in the microbiome–host inter-relations under different conditions (e.g., new diet, additives, or a modification of the environmental conditions).
When considered together, our results highlight the capacity of SAMBA to identify which FM or FO dietary levels have a significant influence on the microbiota profile of farmed fish. Understanding these associations emphasizes the ability of SAMBA to predict changes in the microbial communities of S. aurata as a case study of aquatic farmed animals. In addition to this, the information that comes from taxa interactions can give interesting information on the dynamics of a collaborative and/or competitive nature that rule a complex environment, such as the intestinal biome. The future use of SAMBA will expand the available testable experimental conditions, allow users to customize their analysis, and introduce their personal expertise and knowledge when modelling a microbe population. SAMBA can, therefore, be a valuable tool for making the research in the aquaculture field more dynamic. In any case, the use of SAMBA is not restricted to fish farming and aquaculture, as it can be adapted to build microbial-host BN models from other systems and/or vertebrate organisms, including humans. In fact, the input dataset accepted by SAMBA only consists of two files: one with the abundance counts per bacterial taxa and another with the experimental/environmental variables. In the present case study, the experimental variables were discrete (ergo categorical). However, the tool is able to manage both continuous and categorical experimental variables, such as sex, age, specimen size, genetic background, tissue, season, diet composition, pH, temperature, phenotypes, and more. Furthermore, in this version of SAMBA, we used a single-omics (16S amplicons originated from Oxford Nanopore Technologies MinION platform as well as Illumina MiSeq system) model to assess microbiome–host network interrelations. However, future updates will integrate multi-omics variables from RNAseq and Methylseq, as well as other layers of information. This will extend the applicability of SAMBA to other topics where BNs have been proven to be effective, such as behavioral and welfare assessments, epigenomics, and genomics and transcriptomics [54,55,56].
Regarding data distribution, the tool is currently limited to two models (Log-normal and ZINB). Future versions will include other generalized linear models such as Negative Binomial, Poisson, and γ [23,57]. Additionally, different normalization methods, including for instance scaling factors for data correction per sample depth and gene size, will be considered (RPKM, FPKM, TPM, RMS, etc.) [58]. We also aim to implement tools for determining the minimum training sample size needed to detect a significant effect for a given experiment [59]. Meanwhile, the first SAMBA release highlighted the potential of this tool as a valid approach to investigate how the experimental variables influence microbial biomes. SAMBA, with a user-friendly interface, allows any user to exploit its full potential (all-in-one solution), without the need to know programming languages and/or combine multiple platforms. The tool deconstructs and quantifies the structure of network relationships affecting the microbial dynamics of a given microbiome dataset and allows us to obtain realistic predictions not only from tested, but also from inferred experimental conditions. Therefore, repetitive SAMBA executions with new datasets and the further implementation of multi-omics data will continually improve the output of this platform, making it a valuable easy-to-use advancement in aquaculture practice for physiologists and nutritionists, as well as fish farmers and breeders.

Supplementary Materials

The following supporting information can be downloaded at: https://www.mdpi.com/article/10.3390/genes14081650/s1, Supplementary File S1: SAMBA’s User Guide. The file contains the technical details and algorithmic basis of the SAMBA’s implementation and a user guide, with graphical examples, indicating how to use the different modules that compose SAMBA. Supplementary File S2: Coefficient for conditional probability distribution for the node Pseudomonas extracted from the DAG represented in Figure 5 and Z test for significance. Supplementary File S3: Mock community BN model. Excel file with three tabs: Tab1) Summary of results and input data; Tab2) Regression analysis and F-test for ANOVA under PCR1 condition; Tab3) Regression analysis and F-test for ANOVA under PCR2 condition. Supplementary File S4: S. aurata BN model. Excel file with four tabs for the EGGHYDRO trial predictions; Tab1) Scenario 1 (under experimental variables FM > 20; 4 < FO < 12; “AI” Tissue; “NO_Adds” additive); Tab2) Scenario 2 (10 < FM ≤ 20; FO ≤ 4; “AI” Tissue; “NO_ADDS” additive); Tab3) Scenario 3 (FM ≤ 10; FO ≤ 4; “AI” Tissue; “EWH” additive); Tab4) Scenario 4 (FM > 20; FO ≤ 4; “AI” Tissue; “EWH” additive); Tab5). Confusion matrix of Scenario 1, 2, and 3.

Author Contributions

Conceptualization, B.S., A.I.H., F.N.-C., M.C.P., V.A., C.L. and J.P.-S.; methodology, B.S., A.I.H., F.N.-C., C.L. and J.P.-S.; software programming, B.S., A.I.H. and R.A.M.; application testing, F.N.-C., F.M. and S.T.-R.; manuals and tutorial resources, B.S., C.L. and R.A.M.; writing and manuscript preparation, B.S., F.N.-C., A.I.H., F.M., M.C.P., C.L. and J.P.-S. All authors have read and agreed to the published version of the manuscript.

Funding

This work was supported by the Spanish MCIN project Bream-AquaINTECH (RTI2018–094128-B-I00, AEI/FEDER, UE) to JP-S. This study also forms part of the ThinkInAzul programme and was supported by MCINN with funding from European Union NextGenerationEU (PRTR-C17.I1) and by Generalitat Valenciana (THINKINAZUL/2021/024) to JP-S. BS was supported by a pre-doctoral research fellowship from Industrial Doctorate of MINECO (DI-17-09134). FN-C was supported by a research contract from the EU H2020 Research Innovation Program under grant agreement no. 818367 (AquaIMPACT). FM was funded by a research contract from the EU H2020 Research Innovation Program under grant agreement no. 871108 (AQUAEXCEL3.0). MCP was funded by a Ramón y Cajal Postdoctoral Research Fellowship (RYC2018-024049-I co-funded by AEI, European Social Fund (ESF) and ACOND/2022 Generalitat Valenciana).

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

The source code of SAMBA as well as a dataset for testing the application are available at https://github.com/biotechvana/SAMBA (accessed on 23 June 2023). The two testing datasets (“Mock_community” and “S. aurata_dataset”) used to evaluate the performance and accuracy of SAMBA as well as the R.Data file with their respective BN models are available at the Web site of SAMBA with the following URL address https://github.com/biotechvana/SAMBA/tree/main/Testings_datasets (accessed on 23 June 2023). Each dataset includes two files containing the experimental variables (i.e., diet, tissue, additive, etc.), and the raw counts of all taxa per amplicon sample. This URL also includes another dataset named “metagenome_testing_dataset”, which is provided for users interested in training examples for metagenome predictions using the “Prediction” module of SAMBA. Original Fastq files from Mock community, the LSAQUA, EGGHYDRO, and GAIN_PRE trials are available at the SRA archive with the following bioproject accessions PRJNA891255; PRJNA713764; PRJNA705868; PRJNA750446.

Acknowledgments

We thank Nathan J Robinson for critical reading and corrections. We also thank the reviewers of the Genes Journal for their criticisms and suggestions that helped us to improve our article.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Egerton, S.; Culloty, S.; Whooley, J.; Stanton, C.; Ross, R.P. The Gut Microbiota of Marine Fish. Front. Microbiol. 2018, 9, 873. [Google Scholar] [CrossRef]
  2. Terova, G.; Naya-Català, F.; Rimoldi, S.; Piazzon, M.C.; Torrecillas, S.; Toxqui, M.S.; Fontanillas, R.; Calduch-Giner, J.; Hostins, B.; Sitjà-Bobadilla, A.; et al. Highlights from gut microbiota survey in farmed fish—European sea bass and gilthead sea bream case studies. Aquac. Eur. 2022, 47, 5–10. [Google Scholar]
  3. Abberton, M.; Batley, J.; Bentley, A.; Bryant, J.; Cai, H.; Cockram, J.; de Oliveira, A.C.; Cseke, L.J.; Dempewolf, H.; De Pace, C.; et al. Global agricultural intensification during climate change: A role for genomics. Plant Biotechnol. J. 2016, 14, 1095–1098. [Google Scholar] [CrossRef]
  4. Poore, J.; Nemecek, T. Reducing food’s environmental impacts through producers and consumers. Science 2018, 360, 987–992. [Google Scholar] [CrossRef]
  5. Piazzon, M.C.; Naya-Català, F.; Perera, E.; Palenzuela, O.; Sitjà-Bobadilla, A.; Pérez-Sánchez, J. Genetic selection for growth drives differences in intestinal microbiota composition and parasite disease resistance in gilthead sea bream. Microbiome 2020, 8, 168. [Google Scholar] [CrossRef]
  6. Naya-Català, F.; Piazzon, M.C.; Calduch-Giner, J.A.; Sitjà-Bobadilla, A.; Pérez-Sánchez, J. Diet and Host Genetics Drive the Bacterial and Fungal Intestinal Metatranscriptome of Gilthead Sea Bream. Front. Microbiol. 2022, 13, 883738. [Google Scholar] [CrossRef]
  7. Naya-Català, F.; Piazzon, M.C.; Torrecillas, S.; Toxqui-Rodríguez, S.; Calduch-Giner, J.; Fontanillas, R.; Sitjà-Bobadilla, A.; Montero, D.; Pérez-Sánchez, J. Genetics and Nutrition Drive the Gut Microbiota Succession and Host-Transcriptome Interactions through the Gilthead Sea Bream (Sparus aurata) Production Cycle. Biology 2022, 11, 1744. [Google Scholar] [CrossRef]
  8. Faust, K. Open challenges for microbial network construction and analysis. ISME J. 2021, 15, 3111–3118. [Google Scholar] [CrossRef]
  9. Liu, Z.; Ma, A.; Mathé, E.; Merling, M.; Ma, Q.; Liu, B. Network analyses in microbiome based on high-throughput multi-omics data. Brief. Bioinform. 2021, 22, 1639–1655. [Google Scholar] [CrossRef]
  10. Scutari, M. Structure variability in Bayesian networks. arXiv 2009, arXiv:0909.1685. [Google Scholar]
  11. Michiels, M.; Larrañaga, P.; Bielza, C. BayeSuites: An open web framework for massive Bayesian networks focused on neuroscience. Neurocomputing 2021, 428, 166–181. [Google Scholar] [CrossRef]
  12. Hobbs, E.T.; Pereira, T.; O’Neill, P.K.; Erill, I. A Bayesian inference method for the analysis of transcriptional regulatory networks in metagenomic data. Algorithms Mol. Biol. 2016, 11, 19. [Google Scholar] [CrossRef] [PubMed]
  13. Sazal, M.; Mathee, K.; Ruiz-Perez, D.; Cickovski, T.; Narasimhan, G. Inferring directional relationships in microbial communities using signed Bayesian networks. BMC Genom. 2020, 21, 663. [Google Scholar] [CrossRef] [PubMed]
  14. Sazal, M.; Stebliankin, V.; Mathee, K.; Yoo, C.; Narasimhan, G. Causal effects in microbiomes using interventional calculus. Sci. Rep. 2021, 11, 5724. [Google Scholar] [CrossRef]
  15. Yang, X. Mathematical foundations. In Introduction to Algorithms for Data Mining and Machine Learning; Yang, X.S., Ed.; Academic Press: Cambridge, MA, USA, 2019; pp. 19–43. [Google Scholar]
  16. Yuniarti, I.; Glenk, K.; McVittie, A.; Nomosatryo, S.; Triwisesa, E.; Suryono, T.; Santoso, A.B.; Ridwansyah, I. An application of Bayesian Belief Networks to assess management scenarios for aquaculture in a complex tropical lake system in Indonesia. PLoS ONE 2021, 16, e0250365. [Google Scholar] [CrossRef]
  17. Scutari, M. Learning Bayesian Networks with the bnlearn R Package. J. Stat. Softw. 2010, 35, 1–22. [Google Scholar] [CrossRef]
  18. Chen, J.; Zhang, R.; Dong, X.; Lin, L.; Zhu, Y.; He, J.; Christiani, D.C.; Wei, Y.; Chen, F. shinyBN: An online application for interactive Bayesian network inference and visualization. BMC Bioinform. 2019, 20, 711. [Google Scholar] [CrossRef]
  19. Conrady, S.; Jouffe, L. Bayesian Networks and BayesiaLab: A Practical Introduction for Researchers; Bayesia: Franklin, TN, USA, 2015; Volume 9. [Google Scholar]
  20. Chang, W.; Cheng, J.; Allaire, J.; Stievert, C.; Schloerke, B.; Xie, Y.; Allen, J.; McPherson, J.; Dipert, A.; Borges, B. shiny: Web Application Framework for r. R package Version 1.7.4. Available online: https://cran.r-project.org/web/packages/shiny/index.html (accessed on 23 June 2023).
  21. Hartemink, A.J. Principled Computational Methods for the Validation Discovery of Genetic Regulatory Networks; Massachusetts Institute of Technology: Cambridge, MA, USA, 2001. [Google Scholar]
  22. Shapiro, S.S.; Wilk, M.B. An Analysis of Variance Test for Normality (Complete Samples). Biometrika 1965, 52, 591–611. [Google Scholar] [CrossRef]
  23. Hall, D.B. Zero-inflated Poisson and binomial regression with random effects: A case study. Biometrics 2000, 56, 1030–1039. [Google Scholar] [CrossRef]
  24. Scutari, M.; Graafland, C.E.; Gutiérrez, J.M. Who learns better Bayesian network structures: Accuracy and speed of structure learning algorithms. Int. J. Approx. Reason. 2019, 115, 235–253. [Google Scholar] [CrossRef]
  25. Selman, B.; Gomes, C.P. Hill-climbing Search. In Encyclopedia of Cognitive Science; Nadel, L., Ed.; Wiley: New York, NY, USA, 2006; pp. 333–336. ISBN 9780470018866. [Google Scholar] [CrossRef]
  26. Zeileis, A.; Kleiber, C.; Jackman, S. Regression Models for Count Data in R. J. Stat. Softw. 2008, 27, 1–25. [Google Scholar] [CrossRef]
  27. de Campos, L.M. A Scoring Function for Learning Bayesian Networks Based on Mutual Information and Conditional Independence Tests. J. Mach. Learn. Res. 2006, 7, 2149–2187. [Google Scholar]
  28. Bengtsson, H. A Unifying Framework for Parallel and Distributes Processing in R using Futures. R J. 2021, 13, 273–291. [Google Scholar] [CrossRef]
  29. Textor, J.; van der Zander, B.; Gilthorpe, M.S.; Liskiewicz, M.; Ellison, G.T. Robust causal inference using directed acyclic graphs: The R package ‘dagitty’. Int. J. Epidemiol. 2016, 45, 1887–1894. [Google Scholar] [CrossRef]
  30. Douglas, G.M.; Maffei, V.J.; Zaneveld, J.R.; Yurgel, S.N.; Brown, J.R.; Taylor, C.M.; Huttenhower, C.; Langille, M.G.I. PICRUSt2 for prediction of metagenome functions. Nat. Biotechnol. 2020, 38, 685–688. [Google Scholar] [CrossRef]
  31. Caspi, R.; Altman, T.; Billington, R.; Dreher, K.; Foerster, H.; Fulcher, C.A.; Holland, T.A.; Keseler, I.M.; Kothari, A.; Kubo, A.; et al. The MetaCyc database of metabolic pathways and enzymes and the BioCyc collection of Pathway/Genome Databases. Nucleic Acids Res. 2014, 42, D459–D471. [Google Scholar] [CrossRef]
  32. Kanehisa, M.; Furumichi, M.; Sato, Y.; Kawashima, M.; Ishiguro-Watanabe, M. KEGG for taxonomy-based analysis of pathways and genomes. Nucleic Acids Res. 2023, 51, D587–D592. [Google Scholar] [CrossRef]
  33. Chen, I.A.; Chu, K.; Palaniappan, K.; Pillay, M.; Ratner, A.; Huang, J.; Huntemann, M.; Varghese, N.; White, J.R.; Seshadri, R.; et al. IMG/M v.5.0: An integrated data management and comparative analysis system for microbial genomes and microbiomes. Nucleic Acids Res. 2019, 47, D666–D677. [Google Scholar] [CrossRef]
  34. Potter, S.C.; Luciani, A.; Eddy, S.R.; Park, Y.; Lopez, R.; Finn, R.D. HMMER web server: 2018 update. Nucleic Acids Res. 2018, 46, W200–W204. [Google Scholar] [CrossRef]
  35. Barbera, P.; Kozlov, A.M.; Czech, L.; Morel, B.; Darriba, D.; Flouri, T.; Stamatakis, A. EPA-ng: Massively Parallel Evolutionary Placement of Genetic Sequences. Syst. Biol. 2018, 68, 365–369. [Google Scholar] [CrossRef]
  36. Janssen, S.; McDonald, D.; Gonzalez, A.; Navas-Molina, J.A.; Jiang, L.; Xu, Z.Z.; Winker, K.; Kado, D.M.; Orwoll, E.; Manary, M.; et al. Phylogenetic Placement of Exact Amplicon Sequences Improves Associations with Clinical Information. mSystems 2018, 3, e00021-18. [Google Scholar] [CrossRef]
  37. Czech, L.; Barbera, P.; Stamatakis, A. Genesis and Gappa: Processing, analyzing and visualizing phylogenetic (placement) data. Bioinformatics 2020, 36, 3263–3265. [Google Scholar] [CrossRef]
  38. Almende, B.; Thieurmel, B.; Robert, T. visNetwork: Network Visualization Using’vis. js’ Library. R Package Version 2.0.9. Available online: https://cran.r-project.org/web/packages/visNetwork/index.html (accessed on 23 June 2023).
  39. Fernandes, R. bnviewer: Bayesian Networks Interactive Visualization and Explainable Artificial Intelligence. R Package Version 0.1.6. Available online: https://cran.r-project.org/web/packages/bnviewer/index.html (accessed on 23 June 2023).
  40. Csardi, G.; Nepusz, T. The igraph software package for complex network research. InterJournal Complex. Syst. 2006, 1695, 1–9. [Google Scholar]
  41. Xie, Y.; Cheng, J.; Tan, X. DT: A Wrapper of the JavaScript Library ‘DataTables’. R Package Version 0.26. Available online: https://cran.r-project.org/web/packages/DT/index.html (accessed on 23 June 2023).
  42. Attali, D. shinyjs: Easily Improve the User Experience of Your Shiny Apps in Seconds. R Package Version 2.1.0. Available online: https://cran.r-project.org/web/packages/shinyjs/index.html (accessed on 23 June 2023).
  43. Vaidyanathan, R.; Xie, Y.; Allaire, J.J.; Cheng, J.; Sievert, C.; Russell, K. htmlwidgets: HTML Widgets for R. R Package Version 1.6.0. Available online: https://cran.r-project.org/web/packages/htmlwidgets/index.html (accessed on 23 June 2023).
  44. Attali, D.; von Hertzen, N.; Grey, E. shinyscreenshot: Capture Screenshots of Entire Pages or Parts of Pages in ‘Shiny’. R Package Version 0.2.0. Available online: https://cran.r-project.org/web/packages/shinyscreenshot/index.html (accessed on 23 June 2023).
  45. Toxqui-Rodriguez, S.; Naya-Català, F.; Sitja-Bobadilla, A.; Piazzon, M.C.; Perez-Sanchez, J. Fish microbiomics: Strengths and limitations of MinION sequencing of gilthead sea bream (Sparus aurata) intestinal microbiota. Aquaculture 2023, 569, 739388. [Google Scholar] [CrossRef]
  46. Wick, R.R.; Judd, L.M.; Gorrie, C.L.; Holt, K.E. Completing bacterial genome assemblies with multiplex MinION sequencing. Microb. Genom. 2017, 3, e000132. [Google Scholar] [CrossRef]
  47. De Coster, W.; D’Hert, S.; Schultz, D.T.; Cruts, M.; Van Broeckhoven, C. NanoPack: Visualizing and processing long-read sequencing data. Bioinformatics 2018, 34, 2666–2669. [Google Scholar] [CrossRef]
  48. Marijon, P.; Chikhi, R.; Varré, J.S. yacrd and fpa: Upstream tools for long-read genome assembly. Bioinformatics 2020, 36, 3894–3896. [Google Scholar] [CrossRef] [PubMed]
  49. Li, H. Minimap2: Pairwise alignment for nucleotide sequences. Bioinformatics 2018, 34, 3094–3100. [Google Scholar] [CrossRef]
  50. Yilmaz, P.; Parfrey, L.W.; Yarza, P.; Gerken, J.; Pruesse, E.; Quast, C.; Schweer, T.; Peplies, J.; Ludwig, W.; Glöckner, F.O. The SILVA and “All-species Living Tree Project (LTP)” taxonomic frameworks. Nucleic Acids Res. 2014, 42, D643–D648. [Google Scholar] [CrossRef]
  51. Solé-Jiménez, P.; Naya-Català, F.; Piazzon, M.C.; Estensoro, I.; Calduch-Giner, J.À.; Sitjà-Bobadilla, A.; Van Mullem, D.; Pérez-Sánchez, J. Reshaping of Gut Microbiota in Gilthead Sea Bream Fed Microbial and Processed Animal Proteins as the Main Dietary Protein Source. Front. Mar. Sci. 2021, 8, 705041. [Google Scholar] [CrossRef]
  52. Naya-Català, F.; Wiggers, G.A.; Piazzon, M.C.; López-Martínez, M.I.; Estensoro, I.; Calduch-Giner, J.A.; Martínez-Cuesta, M.C.; Requena, T.; Sitjà-Bobadilla, A.; Miguel, M.; et al. Modulation of Gilthead Sea Bream Gut Microbiota by a Bioactive Egg White Hydrolysate: Interactions Between Bacteria and Host Lipid Metabolism. Front. Mar. Sci. 2021, 8, 698484. [Google Scholar] [CrossRef]
  53. Piazzon, M.C.; Naya-Català, F.; Pereira, G.V.; Estensoro, I.; Del Pozo, R.; Calduch-Giner, J.A.; Nuez-Ortín, W.G.; Palenzuela, O.; Sitjà-Bobadilla, A.; Dias, J.; et al. A novel fish meal-free diet formulation supports proper growth and does not impair intestinal parasite susceptibility in gilthead sea bream (Sparus aurata) with a reshape of gut microbiota and tissue-specific gene expression patterns. Aquaculture 2022, 558, 738362. [Google Scholar] [CrossRef]
  54. Wang, Q.; Chen, R.; Cheng, F.; Wei, Q.; Ji, Y.; Yang, H.; Zhong, X.; Tao, R.; Wen, Z.; Sutcliffe, J.S.; et al. A Bayesian framework that integrates multi-omics data and gene networks predicts risk genes from schizophrenia GWAS data. Nat. Neurosci. 2019, 22, 691–699. [Google Scholar] [CrossRef] [PubMed]
  55. Ruiz-Perez, D.; Lugo-Martinez, J.; Bourguignon, N.; Mathee, K.; Lerner, B.; Bar-Joseph, Z.; Narasimhan, G. Dynamic Bayesian Networks for Integrating Multi-omics Time Series Microbiome Data. mSystems 2021, 6, e01105-20. [Google Scholar] [CrossRef] [PubMed]
  56. Zenere, A.; Rundquist, O.; Gustafsson, M.; Altafini, C. Multi-omics protein-coding units as massively parallel Bayesian networks: Empirical validation of causality structure. iScience 2022, 25, 104048. [Google Scholar] [CrossRef] [PubMed]
  57. Nelder, J.A.; Wedderburn, R.W.M. Generalized Linear Models. J. R. Stat. Soc. 1972, 135, 370–384. [Google Scholar] [CrossRef]
  58. Yang, L.; Chen, J. A comprehensive evaluation of microbial differential abundance analysis methods: Current status and potential solutions. Microbiome 2022, 10, 130. [Google Scholar] [CrossRef]
  59. Hu, J.; Zou, W.; Wang, J.; Pang, L. Minimum training sample size requirements for achieving high prediction accuracy with the BN model: A case study regarding seismic liquefaction. Expert. Syst. Appl. 2021, 185, 115702. [Google Scholar] [CrossRef]
Figure 1. Graphical description of the functions and interface panels in each module of SAMBA. Green circles represent modules and blue squares represent interfaces.
Figure 1. Graphical description of the functions and interface panels in each module of SAMBA. Green circles represent modules and blue squares represent interfaces.
Genes 14 01650 g001
Figure 2. (A) Screenshot of the BN model created by SAMBA for the mock community showing how the distinct taxa are related to each other; (B) correlation analysis between the average predictions for the seven taxa relative to the normalized average values of abundances, in log scale, under PCR1 condition; (C) same correlation analysis but under PCR2 condition.
Figure 2. (A) Screenshot of the BN model created by SAMBA for the mock community showing how the distinct taxa are related to each other; (B) correlation analysis between the average predictions for the seven taxa relative to the normalized average values of abundances, in log scale, under PCR1 condition; (C) same correlation analysis but under PCR2 condition.
Genes 14 01650 g002
Figure 3. (A) S. aurata model DAG built with SAMBA using the ZINB distribution showing the significant edges calculated between the experimental variables. Experimental variables are in pink while taxa are blue. (B) Markov blanket of Pseudomonas node extracted from the total DAG. Taxa are represented with rectangles while experimental variables are represented with ovals. The Pseudomonas node is green, nodes with direct relationships with Pseudomonas (FM, FO and Phyllobacterium) are orange, and nodes with indirect relationships are yellow. The p values refer to whether a taxon or a variable has a significant influence (p < 0.05) on the Pseudomonas node.
Figure 3. (A) S. aurata model DAG built with SAMBA using the ZINB distribution showing the significant edges calculated between the experimental variables. Experimental variables are in pink while taxa are blue. (B) Markov blanket of Pseudomonas node extracted from the total DAG. Taxa are represented with rectangles while experimental variables are represented with ovals. The Pseudomonas node is green, nodes with direct relationships with Pseudomonas (FM, FO and Phyllobacterium) are orange, and nodes with indirect relationships are yellow. The p values refer to whether a taxon or a variable has a significant influence (p < 0.05) on the Pseudomonas node.
Genes 14 01650 g003
Figure 4. BoxPlot comparisons between predictions (red) and experimental observations (black) in log scale for Scenario 1 and Scenario 2. In both cases, the box plot for each taxon covers a range of values defined by the average abundance for that taxon and its standard deviations. The 25 and 75% quantiles as well as the median abundance values are represented as boxes.
Figure 4. BoxPlot comparisons between predictions (red) and experimental observations (black) in log scale for Scenario 1 and Scenario 2. In both cases, the box plot for each taxon covers a range of values defined by the average abundance for that taxon and its standard deviations. The 25 and 75% quantiles as well as the median abundance values are represented as boxes.
Genes 14 01650 g004
Figure 5. BoxPlot comparisons between predictions and experimental observations in log scale for Scenario 3 and Scenario 4 which is a prediction about how Scenario 3 would likely change when changing the FM conditions. Predictions for Scenario 3 are represented in red and observations black. Predictions for Scenario 4 are represented green. No observed data are provided for Scenario 4 because it is a virtual scenario that is derived from combining experimental condition FM of Scenario 1 with the experimental conditions for FO, TISSUE, and ADDITIVE of Scenario 3. As in Figure 4, each box plot includes information from the average abundance and standard deviations for each taxon plus the quantiles 25 and 75 and the median for the distribution of abundance counts. Taxa that are significantly influenced by variable FM are highlighted with an asterisk (see also Figure 3).
Figure 5. BoxPlot comparisons between predictions and experimental observations in log scale for Scenario 3 and Scenario 4 which is a prediction about how Scenario 3 would likely change when changing the FM conditions. Predictions for Scenario 3 are represented in red and observations black. Predictions for Scenario 4 are represented green. No observed data are provided for Scenario 4 because it is a virtual scenario that is derived from combining experimental condition FM of Scenario 1 with the experimental conditions for FO, TISSUE, and ADDITIVE of Scenario 3. As in Figure 4, each box plot includes information from the average abundance and standard deviations for each taxon plus the quantiles 25 and 75 and the median for the distribution of abundance counts. Taxa that are significantly influenced by variable FM are highlighted with an asterisk (see also Figure 3).
Genes 14 01650 g005
Table 1. Experimental variables for the three gilthead sea bream farming trials.
Table 1. Experimental variables for the three gilthead sea bream farming trials.
Feeding ScenariosFMFOTissueAdditive/Substitute
LSAQUA
Scenario 110 < FM ≤ 204 < FO < 12AINO_ADDS
Scenario 2≤104 < FO < 12AILSAQUA
Scenario 3≤104 < FO < 12AILSAQUA
EGGHYDRO
Scenario 1>204 < FO < 12AINO_ADDS
Scenario 210 < FM ≤ 20≤4AINO_ADDS
Scenario 3≤10≤4AIEWH
GAIN_PRE
Scenario 110 < FM ≤ 20≤4PINO_ADDS
Scenario 2≤104 < FO < 12PISANA
FM = fish meal; FO = fish oil; TISSUE defines the targeted intestinal portion (AI = Anterior; PI = Posterior); ADDITIVE/SUBSTITUTE denotes the existence of an additive or commercial protein replacer (NO_ADDS = without additives; SANA = with SANACORE®GM; EWH = with egg white hydrolysate; LSAQUA50 = 50% of FM substitution with LSAqua SusPro®; LSAQUA100 = 100% of FM substitution with LSAqua SusPro®).
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Soriano, B.; Hafez, A.I.; Naya-Català, F.; Moroni, F.; Moldovan, R.A.; Toxqui-Rodríguez, S.; Piazzon, M.C.; Arnau, V.; Llorens, C.; Pérez-Sánchez, J. SAMBA: Structure-Learning of Aquaculture Microbiomes Using a Bayesian Approach. Genes 2023, 14, 1650. https://doi.org/10.3390/genes14081650

AMA Style

Soriano B, Hafez AI, Naya-Català F, Moroni F, Moldovan RA, Toxqui-Rodríguez S, Piazzon MC, Arnau V, Llorens C, Pérez-Sánchez J. SAMBA: Structure-Learning of Aquaculture Microbiomes Using a Bayesian Approach. Genes. 2023; 14(8):1650. https://doi.org/10.3390/genes14081650

Chicago/Turabian Style

Soriano, Beatriz, Ahmed Ibrahem Hafez, Fernando Naya-Català, Federico Moroni, Roxana Andreea Moldovan, Socorro Toxqui-Rodríguez, María Carla Piazzon, Vicente Arnau, Carlos Llorens, and Jaume Pérez-Sánchez. 2023. "SAMBA: Structure-Learning of Aquaculture Microbiomes Using a Bayesian Approach" Genes 14, no. 8: 1650. https://doi.org/10.3390/genes14081650

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop