Refinement of genome-scale reconstructions through the DEMETER pipeline

Author: Almut Heinken, PhD, National University of Ireland Galway

01/2021

Introduction

This tutorial introduces the semi-automated reconstruction pipeline DEMETER (Data-drivEn METabolic nEtwork Refinement) and its use for semi-automated, data-driven reconstruction of microbial strains [1]. DEMETER was first applied to the reconstruction of 773 human gut microbial organisms [2]. More recently, DEMETER was used to reconstruct 7,206 human microbial strains, resulting in AGORA2, an update to AGORA both in size and scope [3]. While DEMETER was built with reconstructing human gut microbial reconstructions in mind and is tailored towards this purpose, it can be applied to any types of bacterial or archaeal microorganisms. The minimal prerequisite is the availability of a sequenced genome for the target organism. The tutorial demonstrates how to use DEMETER to build a refined genome-scale reconstruction for one or more target organisms from a draft reconstruction retrieved from KBase. Steps include input data collection, input data integration, running the refinement pipeline, and testing the refined reconstruction against the input data. Steps Figure 1 summarizes the steps used to create a curated reconstruction.
Figure 1: Overview of the DEMETER pipeline [1]. The pipeline consists of 1. collection of draft reconstructions, comparative genomic data, biochemical and physiological data, and drug structures and microbial conversion reactions, 2. conversion of data into a MATLAB-readable format, and integration into pipeline functions, and 3. data-driven refinement of KBase draft reconstructions with continuous testing against input data and subsequent update to pipeline functions to correct for false predictions.
DEMETER has been designed to handle large-scale tasks of refining hundreds or even thousands of draft reconstructions. This may be time-consuming. It is recommended to use parallel computing for improved efficiency. If the pipeline run is interrupted, it can be rerun and already performed steps will be skipped.

Requirements

This tutorial requires the Parallel Computing Toolbox, Bioinformatics Toolbox, and Statistics and Machine Learning Toolbox add-ons in MATLAB.

Step 1: Data collection and data integration

This part explains how to collect input data and convert it into a format readible by the pipeline. The minimal input for building a refined reconstruction is a KBase draft reconstruction. Recommended inputs include taxonomic information on the target organism, experimental data if the species is not yet found in the already collected data, and comparative genomic analyses.

1.1. KBase draft reconstructions-required

Create KBase draft reconstruction(s) for the target organism(s) by using the apps at kbase.us/. A template narrative to facilitate this is available at https://narrative.kbase.us/narrative/ws.82195.obj.8. The narrative assumes that the genomes to reconstruct are available as FASTA files and imported into the Staging Area as a zipped file. Alternatively, genomes available in KBase can be directly imported into the Narrative. Note that it will not be possible to reconstruct organisms without a sequenced genome. Export the generated draft reconstructions by downloading them.
Next, please place all draft reconstructions that you want to refine into one folder. For the sake of this tutorial, we will use four AGORA2 strains as well as six example strains that were randomly chosen from genomes present at KBase and are not present in AGORA2. Draft reconstructions for these strains have already been retrieved from KBase and placed into the folder cobratoolbox/papers/2021_demeter/exampleDraftReconstructions. Alternatively, they are available in the template narrative https://narrative.kbase.us/narrative/81207.
% Start DEMETER by initializing the COBRA Toolbox.
initCobraToolbox
_____ _____ _____ _____ _____ | / ___| / _ \ | _ \ | _ \ / ___ \ | COnstraint-Based Reconstruction and Analysis | | | | | | | |_| | | |_| | | |___| | | The COBRA Toolbox - 2021 | | | | | | | _ { | _ / | ___ | | | |___ | |_| | | |_| | | | \ \ | | | | | Documentation: \_____| \_____/ |_____/ |_| \_\ |_| |_| | http://opencobra.github.io/cobratoolbox | > Checking if git is installed ... Done (version: 2.30.1). > Checking if the repository is tracked using git ... Done. > Checking if curl is installed ... Done. > Checking if remote can be reached ... Done. > Initializing and updating submodules (this may take a while)... Done. > Adding all the files of The COBRA Toolbox ... Done. > Define CB map output... set to svg. > TranslateSBML is installed and working properly. > Configuring solver environment variables ... - [*---] ILOG_CPLEX_PATH: /Applications/CPLEX_Studio129/cplex/matlab/x86-64_osx - [*---] GUROBI_PATH: /Library/gurobi912/mac64/matlab - [----] TOMLAB_PATH: --> set this path manually after installing the solver ( see instructions ) - [----] MOSEK_PATH: --> set this path manually after installing the solver ( see instructions ) Done. > Checking available solvers and solver interfaces ... 0 0 Check osense*c - A'*lam - w = 0 (stationarity): 0 0 > [gurobi] Primal optimality condition in solveCobraLP satisfied. > [gurobi] Dual optimality condition in solveCobraLP satisfied. Original LP has 1 row, 2 columns, 1 non-zero Objective value = 0 OPTIMAL SOLUTION FOUND BY LP PRESOLVER > [glpk] Primal optimality condition in solveCobraLP satisfied. -------------------------------------------------------- pdco.m Version pdco5 of 15 Jun 2018 Primal-dual barrier method to minimize a convex function subject to linear constraints Ax + r = b, bl <= x <= bu Michael Saunders SOL and ICME, Stanford University Contributors: Byunggyoo Kim (SOL), Chris Maes (ICME) Santiago Akle (ICME), Matt Zahr (ICME) Aekaansh Verma (ME) -------------------------------------------------------- The objective is linear The matrix A is an explicit sparse matrix m = 1 n = 2 nnz(A) = 1 max |b | = 0 max |x0| = 1.0e+00 xsize = 1.0e+00 max |y0| = 1 max |z0| = 1.0e+00 zsize = 1.0e+00 x0min = 1 featol = 1.0e-06 d1max = 1.0e-04 z0min = 1 opttol = 1.0e-06 d2max = 5.0e-04 mu0 = 1.0e-01 steptol = 0.99 bigcenter= 1000 LSMR/MINRES: atol1 = 1.0e-10 atol2 = 1.0e-15 btol = 0.0e+00 conlim = 1.0e+12 itnlim = 10 show = 0 Method = 2 (1 or 11=chol 2 or 12=QR 3 or 13=LSMR 4 or 14=MINRES 21=SQD(LU) 22=SQD(MA57)) Eliminating dy before dx Bounds: [0,inf] [-inf,0] Finite bl Finite bu Two bnds Fixed Free 0 0 0 0 0 2 0 [0, bu] [bl, 0] excluding fixed variables 0 0 Itn mu stepx stepz Pinf Dinf Cinf Objective nf center QR 0 -6.6 -99.0 -Inf 1.2500000e-07 1.0 1 -1.0 1.000 1.000 -99.0 -99.0 -Inf 0.0000000e+00 1 1.0 1 2 -3.0 1.000 1.000 -99.0 -99.0 -Inf 0.0000000e+00 1 1.0 3 -5.0 1.000 1.000 -99.0 -99.0 -Inf 0.0000000e+00 1 1.0 4 -7.0 1.000 1.000 -99.0 -99.0 -Inf 0.0000000e+00 1 1.0 Converged max |x| = 0.000 max |y| = 0.000 max |z| = 0.000 scaled max |x| = 0.000 max |y| = 0.000 max |z| = 0.000 unscaled max |x| and max |z| exclude fixed variables PDitns = 4 QRitns = 0 cputime = 0.2 Distribution of vector x z [ 1, 10 ) 0 2 [ 0.1, 1 ) 0 0 [ 0.01, 0.1 ) 0 0 [ 0.001, 0.01 ) 0 0 [ 0.0001, 0.001 ) 0 0 [ 1e-05, 0.0001 ) 0 0 [ 1e-06, 1e-05 ) 0 0 [ 1e-07, 1e-06 ) 0 0 [ 1e-08, 1e-07 ) 0 0 [ 0, 1e-08 ) 2 0 Elapsed time is 0.165924 seconds. > [pdco] Primal optimality condition in solveCobraLP satisfied. > [pdco] Dual optimality condition in solveCobraLP satisfied. Elapsed time is 0.001496 seconds. In 0.0033641 sec, file written to /Users/almut.heinken/Documents/Code/cobratoolbox/binary/maci64/bin/minos/data/FBA/qFBA.txt Done. > Setting default solvers ... Done. > Saving the MATLAB path ... Done. - The MATLAB path was saved in the default location. > Summary of available solvers and solver interfaces Support LP MILP QP MIQP NLP EP ------------------------------------------------------------------------------ gurobi active 1 1 1 1 - - ibm_cplex active 0 0 0 0 - - tomlab_cplex active 0 0 0 0 - - glpk active 1 1 - - - - mosek active 0 - 0 - - 0 matlab active 1 - - - 1 - pdco active 1 - 1 - - 1 quadMinos active 1 - - - - - dqqMinos active 1 - 1 - - - cplex_direct active 0 0 0 - - - cplexlp active 0 - - - - - qpng passive - - 1 - - - tomlab_snopt passive - - - - 0 - lp_solve legacy 1 - - - - - ------------------------------------------------------------------------------ Total - 7 2 4 1 1 1 + Legend: - = not applicable, 0 = solver not compatible or not installed, 1 = solver installed. > You can solve LP problems using: 'gurobi' - 'glpk' - 'pdco' > You can solve MILP problems using: 'gurobi' - 'glpk' > You can solve QP problems using: 'gurobi' - 'pdco' > You can solve MIQP problems using: 'gurobi' > You can solve NLP problems using: > You can solve EP problems using: 'pdco' > Checking for available updates ... > You cannot update your fork using updateCobraToolbox() because this is a development branch. > The current branch is: demeterFixes > The last commit to the current branch is: 4fcaac > You can use MATLAB.devTools (https://github.com/opencobra/MATLAB.devTools) to update your fork. removing: /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/thermo/componentContribution/new removing: /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/thermo/groupContribution/new removing: /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/thermo/inchi/new removing: /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/thermo/molFiles/new removing: /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/thermo/protons/new removing: /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/thermo/trainingModel/new
Please ensure that the COBRA/papers folder is up to date and in the MATLAB path as DEMETER depends on files located in COBRA/papers/demeter.
Set a solver (recommended: IBM CPLEX)
solverOK=changeCobraSolver('ibm_cplex','LP');
> changeCobraSolver: Solver ibm_cplex is not installed.
 
global CBTDIR
To start DEMETER, define the path to the folder where the draft reconstructions are located (required).
draftFolder = [CBTDIR filesep 'papers' filesep '2021_demeter' filesep 'exampleDraftReconstructions'];

1.2. Taxonomic and strain information

Information on the taxonomic classification and organism properties (e.g., gram status, oxygen status, metabolism type, pathogenicity) has been collected for all 7,206 AGORA2 strains and is available in the file "input/AGORA2_infoFile.xlsx". It is highly recommmended to collect taxonomic information for your organism as this enables the propagation of experimental data from related strains that are already present in AGORA2. Taxonomic information can be retrieved from NCBI Taxonomy: https://www.ncbi.nlm.nih.gov/taxonomy/. Note that this step can be skipped, but will prevent informing the refined reconstructions through available experimental data. To provide taxonomic information for your organisms, prepare a file in the same format as cobratoolbox/papers/2021_demeter/example_infoFile.xlsx. Please provide the path to the file with taxonomic information as the variable infoFilePath.
infoFilePath = [CBTDIR filesep 'papers' filesep '2021_demeter' filesep 'example_infoFile.xlsx'];
IMPORTANT: The IDs in the column 'MicrobeID' need to match the names of the resulting refined reconstructions exactly. Prepare the file with taxonomic information accordingly. During the pipeline run, the names of draft reconstruction files will be adapted. To find out what the names of the refined reconstructions will be, run the function
refinedModelIDs = printRefinedModelIDs(draftFolder);

1.3. Propagating existing experimental data

The DEMETER pipeline contains experimental data for >1,500 microbial species for (i) carbon sources, (ii) fermentation pathways, (iii) growth requirements, (iv) consumed metabolites, and (v) secreted metabolites. The data are stored in MATLAB-readable format in the input folder as the files CarbonSourcesTable.txt, FermentationTable.txt, NutrientRequirementsTable.txt, secretionProductTable.txt, and uptakeTable.txt. If a strain related to your organism is already present in the DEMETER resource and has data available, this data can be propagated to your new organism. This requires taxonomic information organized in a table as described in the previous step. Note that you can still adapt the experimental data to strain-specific findings and add new data afterwards as needed. The input file with taxonomic information will also be supplemented with gram staining information if possible, which serves to additionally inform and refine the reconstructions. If no related organisms are already present in DEMETER from which gram status information can be propagated, gram status can be retrieved from literature searches or by querying the Integrated Microbial Genomes Database (https://img.jgi.doe.gov/) [4].

1.4. Using compatative genomic data as input data for DEMETER

It is possible to inform the reconstruction with comparative genomics data retrieved from PubSEED. This will require either retrieving publicly available spreadsheets from PubSEED or the generation of such spreadsheets through PubSEED (https://pubseed.theseed.org). Under https://pubseed.theseed.org/seedviewer.cgi?page=SubsystemSelect, over 1,000 curated subsystems for thousands of bacteria are available that can serve as input for DEMETER. See "Subsystem Spreadsheet" tab on PubSeed or cobratoolbox/papers/2021_demeter/exampleSpreadsheets for an example. To map the strains in subsystems to strains to reconstruct, the column PubSeedID needs to contain the translation to the respective IDs in the PubSeed spreadsheets.
Moreover, appropriate reactions in VMH nomenclature need to be mapped to each functional role in the spreadsheet (see "Functional Role" tab on PubSeed). Functional roles need to be provided as columns and mapped to corresponding reactions through the file cobratoolbox/papers/2021_demeter/input/InReactions.txt.
If comparative genomics data is available for your organism(s), please place it in a folder and provide the path to the folder as the variable spreadsheetFolder.
spreadsheetFolder = [CBTDIR filesep 'papers' filesep '2021_demeter' filesep 'exampleSpreadsheets'];
Additionally, the PubSEED IDs for each strain to refine, as well as the annotation version, need to be added to the "PubSeedID" and "Annotation version ID" columns, respectively, in the taxonomic information file as shown in example_infoFile.xlsx.
To propagate available gram staining information, comparative genomics data, and experimental data to your organism(s), use the code
[infoFilePath,inputDataFolder] = prepareInputData(infoFilePath,'spreadsheetFolder',spreadsheetFolder);
Warning: Directory already exists.
i = 1
i = 1
i = 1
i = 2
i = 3
i = 4
The variable adaptedInfoFilePath contains the path to the taxonomic information file adapted with gram staining information.

1.5. Manual gathering of experimental data as input data for DEMETER

In the folder inputDataFolder, you will find experimental data for your organism(s) retrieved and propagated from the already available data that had been collected for DEMETER. It is highly recommended that you manually inspect the propagated experimental data for your organism(s) at this point to verify it as organisms may differ on the strain level. Moreover, it is recommended that you perform additional literature searches to inform the refinement of your organism(s). As you can see from inspection of the newly generated text files, for three of the four new strains used in this tutorial, experimental data could be propagated from already reconstructed strains of the same species. For the fourth strain, Acetitomaculum ruminis DSM 5522, no related strain in present in DEMETER. To find experimental data on this organism, we go to PubMed (https://pubmed.ncbi.nlm.nih.gov/) and enter "Acetitomaculum ruminis" as a search term. This yields a published reference describing the metabolism of this species: PubMed ID 2500921, https://link.springer.com/article/10.1007/BF00416597. The paper reports that A. ruminis generates acetate through the acetogen pathway and uses formate and glucose as carbon sources. By converting this data into a MATLAB-readable format, we can ensure the associated pathways are present in the refined reconstruction.
To incorporate this data into the files with experimental data, use the following code.
Read the file with carbon source information.
data=readInputTableForPipeline([inputDataFolder filesep 'CarbonSourcesTable.txt']);
Add information that glucose is used as a carbon source.
findRow=find(strcmp(data(:,1),'Acetitomaculum_ruminis_DSM_5522'));
findCol=find(strcmp(data(1,:),'D-glucose'));
data{findRow,findCol}='1';
writetable(cell2table(data),[inputDataFolder filesep 'CarbonSourcesTable'],'FileType','text','WriteVariableNames',false,'Delimiter','tab');
Read the file with information on consumed metabolites.
data=readInputTableForPipeline([inputDataFolder filesep 'uptakeTable.txt']);
Add information that formate is consumed.
findRow=find(strcmp(data(:,1),'Acetitomaculum_ruminis_DSM_5522'));
findCol=strcmp(data(1,:),'Formate');
data{findRow,findCol}='1';
writetable(cell2table(data),[inputDataFolder filesep 'uptakeTable'],'FileType','text','WriteVariableNames',false,'Delimiter','tab');
Read the file with fermentation product information.
data=readInputTableForPipeline([inputDataFolder filesep 'FermentationTable.txt']);
Add information that the acetogen pathway is used.
findRow=find(strcmp(data(:,1),'Acetitomaculum_ruminis_DSM_5522'));
findCol=find(strcmp(data(1,:),'Acetogen pathway'));
data{findRow,findCol}='1';
writetable(cell2table(data),[inputDataFolder filesep 'FermentationTable'],'FileType','text','WriteVariableNames',false,'Delimiter','tab');
Alternatively, you can inspect the files manually and edit as needed.
To check the experimental data available that will be used for refinement for each strain to reconstruct, run the function:
curationStatus = getCurationStatus(infoFilePath,inputDataFolder,false);
Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property.
Set 'PreserveVariableNames' to true to use the original column headers as table variable names.
2 indicates that experimental data is available to curate the reconstruction. 1 indicates that published literature is available but contains no usable data. 0 indicates no available experimental data.

Step 2: Iterative refinement

2.1. Running the DEMETER pipeline

With the experimental and comparative genomic data in place, the pipeline can be run. This will result in a refined reconstruction for each strain in the draft reconstruction folder as a mat file and optionally as a SBML file. Moreover, a summary of refinement steps, such as addition and removal of reactions during gap-filling, will be provided. Steps that are automatically carried out during this step include # translation of KBase reaction and metabolite to Virtual Metabolic Human [5] (https://www.vmh.life) nomenclature, # expansion of the reconstruction by pathways supported by experimental data, # refinement of pathways and gene rules against comparative genomic data, and # quality control ensuring e.g., thermodynamic feasibility.
Define the number of workers for parallel computing.
numWorkers = 4;
Define a name for the reconstruction resource (optional)
reconVersion = 'TutorialExample';
Run the pipeline.
[reconVersion,refinedFolder,translatedDraftsFolder,summaryFolder] = runPipeline(draftFolder, 'infoFilePath', infoFilePath, 'inputDataFolder', inputDataFolder, 'numWorkers', numWorkers, 'reconVersion', reconVersion);
Starting parallel pool (parpool) using the 'local' profile ... Connected to the parallel pool (number of workers: 4). ans = Pool with properties: Connected: true NumWorkers: 4 Cluster: local AttachedFiles: {} AutoAddClientPath: true IdleTimeout: 30 minutes (30 minutes remaining) SpmdEnabled: true Each model.subSystems{x} has been changed to a character array. Warning: Reaction with the same name already exists in the model, updating the reaction > In addReaction (line 129) In translateKBaseModel2VMHModel (line 145) In refinementPipeline (line 67) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) bio1 41.257 h[c] + 0.00719528 thmpp[c] + 0.00719528 ribflv[c] + 0.00719528 nad[c] + 0.00719528 fe2[c] + 0.00719528 fe3[c] + 41.2914 atp[c] + 0.00719528 nadp[c] + 0.261005 glu_L[c] + 0.261005 gln_L[c] + 0.0282247 utp[c] + 0.00719528 fmn[c] + 0.00719528 fad[c] + 0.113498 met_L[c] + 0.00719528 amet[c] + 0.00719528 coa[c] + 0.00719528 gthrd[c] + 0.0424026 gtp[c] + 0.148326 asp_L[c] + 0.267561 ala_L[c] + 0.00719528 uacgam[c] + 0.323695 lys_L[c] + 0.148326 asn_L[c] + 0.00719528 so4[c] + 0.193398 arg_L[c] + 0.0261242 ctp[c] + 0.216753 ser_L[c] + 0.0544956 trp_L[c] + 0.176189 phe_L[c] + 0.11104 tyr_L[c] + 0.186842 thr_L[c] + 0.409331 gly[c] + 0.056954 cys_L[c] + 0.00719528 thf[c] + 0.00719528 10fthf[c] + 0.00719528 5mthf[c] + 0.34746 leu_L[c] + 0.0176985 datp[c] + 0.0819482 his_L[c] + 0.307716 val_L[c] + 0.161028 pro_L[c] + 0.0091793 dgtp[c] + 0.270429 ile_L[c] + 0.0176985 dttp[c] + 0.00719528 sheme[c] + 0.00719528 adocbl[c] + 0.00180606 udcpdp[c] + 0.00719528 cobalt2[c] + 0.00719528 pydx5p[c] + 0.00719528 pheme[c] + 0.00719528 zn2[c] + 0.00719528 btn[c] + 0.0091793 dctp[c] + 0.00719528 ACP[c] + 0.00719528 ca2[c] + 0.00719528 cu2[c] + 0.00719528 k[c] + 0.00719528 mg2[c] + 0.00719528 mn2[c] + 0.00719528 spmd[c] + 0.00719528 ptrc[c] + 0.00719528 q8[c] + 0.00719528 mqn8[c] + 0.00719528 2dmmq8[c] + 0.00858713 pg180[c] + 0.00858713 pe180[c] + 0.00180606 glyc45tca[c] + 0.00180606 glyc45tcaglc[c] + 0.00180606 glyc45tcaala_D[c] + 0.00180606 tcam[c] + 0.00180606 PGP[c] + 0.00858713 pei17[c] + 0.00858713 peai17[c] + 0.00858713 pgi17[c] + 0.00858713 pgai17[c] + 0.00180606 sttca1[c] + 0.00180606 i17tca1[c] + 0.00180606 ai17tca1[c] + 0.00180606 sttcaglc[c] + 0.00180606 i17tcaglc[c] + 0.00180606 ai17tcaglc[c] + 0.00180606 sttcaacgam[c] + 0.00180606 i17tcaacgam[c] + 0.00180606 ai17tcaacgam[c] + 0.00180606 sttcaala_D[c] + 0.00180606 i17tcaala_D[c] + 0.00180606 ai17tcaala_D[c] + 0.00858713 clpn180[c] + 0.00858713 clpni17[c] + 0.00858713 clpnai17[c] + 0.00719528 cl[c] + proteinsynth[c] + dnarep[c] + rnatrans[c] -> biomass[c] + 45.354 h2o[c] + 0.184902 ppi[c] + 41.2498 pi[c] + 41.257 adp[c] + 0.00719528 dmbzid[c] + 0.00719528 cbi[c] + 0.00719528 apoACP[c] + 0.00722423 PGPm1[c] Adding the following Metabolites to the model: Warning: Reaction with the same name already exists in the model, updating the reaction > In addReaction (line 129) In translateKBaseModel2VMHModel (line 145) In refinementPipeline (line 67) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction with the same name already exists in the model, updating the reaction > In addReaction (line 129) In translateKBaseModel2VMHModel (line 145) In refinementPipeline (line 67) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) 10fthf5glu[c] 10fthf[c] 10m3hddcaACP[c] 10m3hundecACP[c] 10m3oddcaACP[c] 10m3oundecACP[c] 10mddcaACP[c] 10mtddec2eACP[c] 10mundecACP[c] 11m3hddcaACP[c] 11m3oddcaACP[c] 11mddcaACP[c] 11mtddec2eACP[c] 12daihdglyc[c] 12dgr180[c] 12dihdglyc[c] 12m3hmyrsACP[c] 12m3htridecACP[c] 12m3omyrsACP[c] 12m3otridecACP[c] 12mmyrsACP[c] 12mtmrs2eACP[c] 12mtridecACP[c] 13dpg[c] 13m3hmyrsACP[c] 13m3omyrsACP[c] 13mmyrsACP[c] 13mtmrs2eACP[c] 14m3hpalmACP[c] 14m3hpentdecACP[c] 14m3opalmACP[c] 14m3opentdecACP[c] 14mpalmACP[c] 14mpentdecACP[c] 14mtpalm2eACP[c] 15m3hpalmACP[c] 15m3opalmACP[c] 15mpalmACP[c] 15mtpalm2eACP[c] 1agpe120[c] 1agpe140[c] 1agpe141[c] 1agpe160[c] 1agpe161[c] 1agpe180[c] 1agpe181[c] 1agpg120[c] 1agpg140[c] 1agpg141[c] 1agpg160[c] 1agpg161[c] 1agpg180[c] 1agpg181[c] 1aihpdecg3p[c] 1aipdecg3p[c] 1ddecg3p[c] 1hdec9eg3p[c] 1hdecg3p[c] 1ihdecg3p[c] 1ihpdecg3p[c] 1ipdecg3p[c] 1itdecg3p[c] 1odec11eg3p[c] 1odecg3p[c] 1pipdn2c[c] 1pyr5c[c] 1tdec7eg3p[c] 1tdecg3p[c] 23dhdp[c] 23dhmb[c] 23dhmp[c] 25aics[c] 25dhpp[c] 26dap_LL[c] 26dap_M[c] 2agpe120[c] 2agpe140[c] 2agpe141[c] 2agpe160[c] 2agpe161[c] 2agpe180[c] 2agpe181[c] 2agpg120[c] 2agpg140[c] 2agpg141[c] 2agpg160[c] 2agpg161[c] 2agpg180[c] 2agpg181[c] 2ahbut[c] 2ahhmd[c] 2ahhmp[c] 2c25dho[c] 2cpr5p[c] 2dda7p[c] 2ddecg3p[c] 2dhp[c] 2dmmq8[c] 2dmmql8[c] 2hdec9eg3p[c] 2hdecg3p[c] 2hymeph[c] 2ippm[c] 2mb2coa[c] 2mbcoa[c] 2mbutACP[c] 2me4p[c] 2mecdp[c] 2mp2coa[c] 2mpropACP[c] 2obut[c] 2odec11eg3p[c] 2odecg3p[c] 2ohph[c] 2ombz[c] 2ommb[c] 2omph[c] 2oph[c] 2p4c2me[c] 2pg[c] 2pglyc[c] 2shchc[c] 2tdec7eg3p[c] 2tdecg3p[c] 33hmeoxobut[c] 34hpp[c] 3aib_D[c] 3c2hmp[c] 3c3hmp[c] 3c4mop[c] 3dhq[c] 3dhsk[c] 3h3mop[c] 3haACP[c] 3hbcoa[c] 3hcddec5eACP[c] 3hcmrs7eACP[c] 3hcvac11eACP[c] 3hdcoa[c] 3hddcoa[c] 3hddecACP[c] 3hdecACP[c] 3hhdcoa[c] 3hhexACP[c] 3hibutcoa[c] 3hmbcoa[c] 3hmrsACP[c] 3hocoa[c] 3hoctACP[c] 3hoctaACP[c] 3hpalmACP[c] 3hpcoa[c] 3htdcoa[c] 3ig3p[c] 3mbutACP[c] 3mob[c] 3mop[c] 3oddecACP[c] 3odecACP[c] 3ohexACP[c] 3omrsACP[c] 3ooctACP[c] 3ooctdACP[c] 3opalmACP[c] 3ophb[c] 3pg[c] 3php[c] 3psme[c] 3uib[c] 4abz[c] 4adcho[c] 4c2me[c] 4h2oglt[c] 4hba[c] 4hbz[c] 4hthr[c] 4m3hhexACP[c] 4m3hpentACP[c] 4m3ohexACP[c] 4m3opentACP[c] 4mhetz[c] 4mhexACP[c] 4mop[c] 4mpentACP[c] 4mpetz[c] 4mthex2eACP[c] 4pasp[c] 4per[c] 4ppan[c] 4ppcys[c] 4r5au[c] 56dthm[c] 56dura[c] 5aizc[c] 5aop[c] 5aprbu[c] 5apru[c] 5forthf[c] 5fthf[c] 5hxudidzcba[c] 5m3hhexACP[c] 5m3ohexACP[c] 5mhexACP[c] 5mta[c] 5mthex2eACP[c] 5mthf[c] 5mtr[c] 5odhf2a[c] 5prdmbz[c] 6a2ohxnt[c] 6m3hheptACP[c] 6m3hocACP[c] 6m3oheptACP[c] 6m3oocACP[c] 6mheptACP[c] 6mocACP[c] 6mtoct2eACP[c] 6pgg[c] 7m3hocACP[c] 7m3oocACP[c] 7mocACP[c] 7mtoct2eACP[c] 8aonn[c] 8m3hdcaACP[c] 8m3hnonACP[c] 8m3odcaACP[c] 8m3ononACP[c] 8mdcaACP[c] 8mnonACP[c] 8mtdec2eACP[c] 9m3hdcaACP[c] 9m3odcaACP[c] 9mdcaACP[c] 9mtdec2eACP[c] ACP[c] C11821[c] CE5656[c] HC01231[c] HC01434[c] HC01651[c] HC01652[c] HC01710[c] Largn[c] Lcyst[c] Lcyst[e] PGP[c] PGPm1[c] aacoa[c] abt[c] acACP[c] ac[c] ac[e] acac[c] acald[c] acbdma14gapuc[c] accoa[c] acg5p[c] acg5sa[c] acgam1p[c] acgam6p[c] acgam[c] acgam[e] acglu[c] achms[c] acmana[c] acnam[c] acorn[c] acser[c] actACP[c] actp[c] adcobdam[c] adcobhex[c] ade[c] adn[c] adocbi[c] adocbip[c] adocbl[c] adocbl[e] adp[c] adpglc[c] adprib[c] agdpcbi[c] ahcys[c] ahdt[c] ai15tca1[c] ai17tca1[c] ai17tcaacgam[c] ai17tcaala_D[c] ai17tcaglc[c] aicar[c] aihpdcoa[c] aipdcoa[c] air[c] akg[c] ala_B[c] ala_D[c] ala_D[e] ala_L[c] ala_L[e] alaala[c] alaasp[c] alaasp[e] alac_S[c] alagln[c] alagln[e] alaglu[c] alaglu[e] alagly[c] alagly[e] alahis[c] alahis[e] alaleu[c] alaleu[e] alathr[c] alathr[e] alltn[c] alltn_R[c] alpro[c] amet[c] amet[e] amob[c] amob[e] amp[c] anth[c] apoACP[c] apoC_Lys_btn[c] appl[c] applp[c] aps[c] arab_L[c] arbt6p[c] arbt[e] arg_L[c] arg_L[e] argsuc[c] asn_L[c] asn_L[e] aso3[c] aso4[c] asp_L[c] asp_L[e] aspsa[c] athr_L[c] atp[c] b2coa[c] biomass[c] btal[c] btn[c] btn[e] btn_co2[c] btoh[c] but2eACP[c] butACP[c] butso3[c] butso3[e] ca2[c] ca2[e] cala[c] cbasp[c] cbi[c] cbl1[c] cbl1[e] cbl2[c] cbl2[e] cbp[c] cd2[c] cd2[e] cdp[c] cdpdaihpdecg[c] cdpdaipdecg[c] cdpdddecg[c] cdpdhdec9eg[c] cdpdhdecg[c] cdpdihdecg[c] cdpdihpdecg[c] cdpdipdecg[c] cdpditdecg[c] cdpdodec11eg[c] cdpdodecg[c] cdpdtdec7eg[c] cdpdtdecg[c] cdpglyc[c] cellb[c] cgly[c] cgly[e] chor[c] chtbs[c] cit[c] citr_L[c] cl[c] cl[e] clpn140[c] clpn160[c] clpn180[c] clpnai15[c] clpnai17[c] clpni14[c] clpni15[c] clpni16[c] clpni17[c] cmp[c] co1dam[c] co2[c] co2[e] coa[c] coa[e] cobalt2[c] cobalt2[e] cobya[c] copre2[c] copre3[c] copre4[c] copre5[c] copre8[c] cpppg3[c] cro4[c] cro4[e] ctp[c] cu2[c] cu2[e] cys_L[c] cys_L[e] cyst_L[c] cytbdox[c] cytbdr[c] cytd[c] dadp[c] damp[c] dann[c] datp[c] db4p[c] dc2coa[c] dcaACP[c] dca[c] dcamp[c] dcdp[c] dcmp[c] dctp[c] dd2coa[c] ddcaACP[c] ddca[c] dgdp[c] dgmp[c] dgsn[c] dgtp[c] dha[c] dhap[c] dhf[c] dhlam[c] dhlpro[c] dhna[c] dhor_S[c] dhpt[c] dhptd[c] diglcpg140[c] diglcpg160[c] diglcpg180[c] diglcpgai15[c] diglcpgai17[c] diglcpgi14[c] diglcpgi15[c] diglcpgi16[c] diglcpgi17[c] dmbzid[c] dmlz[c] dmpp[c] dms[c] dmso[c] dnad[c] dnarep[c] dpcoa[c] dscl[c] dtdp4d6dg[c] dtdp4d6dm[c] dtdp[c] dtdpglu[c] dtdprmn[c] dtmp[c] dttp[c] dttp[e] dudp[c] dump[c] dutp[c] dxyl5p[c] e4hglu[c] e4p[c] eig3p[c] etha[c] etha[e] ethso3[c] ethso3[e] etoh[c] f1p[c] f6p[c] fa11[c] fa12[c] fa1[c] fa3[c] fa4[c] fa6[c] fad[c] fadh2[c] fdp[c] fdxox[c] fdxrd[c] fe2[c] fe2[e] fe3[c] fe3[e] fgam[c] ficytC[c] fmn[c] focytC[c] fol[c] fol[e] for[c] for[e] fpram[c] fprica[c] frdp[c] fru[c] fru[e] fum[c] g1p[c] g3p[c] g3pe[c] g3pg[c] g6p[c] g6p_B[c] galt1p[c] galt[e] gam1p[c] gam6p[c] gam[e] gar[c] gdp[c] gdpormn[c] gdprmn[c] gdptp[c] ggdp[c] glc_D[c] glc_D[e] glc_bD[c] gln_L[c] gln_L[e] glu1sa[c] glu5p[c] glu5sa[c] glu_D[c] glu_L[c] glu_L[e] glucys[c] glutrna[c] gly[c] gly[e] glyald[c] glyasn[c] glyasn[e] glyasp[c] glyasp[e] glyc3p[c] glyc45tca[c] glyc45tcaala_D[c] glyc45tcaglc[c] glyc[c] glyclt[c] glycogen[c] glycogenb[e] glycys[c] glycys[e] glygln[c] glygln[e] glyglu[c] glyglu[e] glyleu[c] glyleu[e] glymet[c] glymet[e] glyphe[c] glyphe[e] glypro[c] glypro[e] glytyr[c] glytyr[e] gmp[c] grdp[c] gthox[c] gthrd[c] gtp[c] h2mb4p[c] h2o2[c] h2o[c] h2o[e] h2s[c] h[c] h[e] hco3[c] hcys_L[c] hdca[c] hdcea[c] hdcoa[c] hdd2coa[c] hdeACP[c] hepdp[c] hethmpp[c] hexACP[c] hexdp[c] hexs[c] hexs[e] hg2[c] hg2[e] hgbyr[c] his_L[c] his_L[e] hisp[c] histd[c] histl_L[c] hmbil[c] hom_L[c] hqn[c] hxan[c] hxan[e] i14tca1[c] i15tca1[c] i16tca1[c] i17tca1[c] i17tcaacgam[c] i17tcaala_D[c] i17tcaglc[c] iasp[c] ibcoa[c] ichor[c] icit[c] idp[c] ihdcoa[c] ihpdcoa[c] ile_L[c] ile_L[e] imacp[c] imp[c] indole[c] ipdcoa[c] ipdp[c] isetac[c] isetac[e] itdcoa[c] itp[c] ivcoa[c] k[c] k[e] l2a6o[c] lac_D[c] lac_L[c] leu_L[c] leu_L[e] lgt_S[c] lipoate[c] lpam[c] lpro[c] lys_L[c] lys_L[e] m12dahglyc[c] m12dihglyc[c] m12dsglyc[c] madg[c] malACP[c] mal_L[c] malcoa[c] malt6p[c] malt[c] malt[e] malthp[c] malthx[c] maltpt[c] malttr[c] maltttr[c] man1p[c] man6p[c] man[e] mbdg[c] melib[c] meoh[c] met_D[c] met_D[e] met_L[c] met_L[e] metala[c] metala[e] methf[c] metsox_R_L[c] metsox_R_L[e] metsox_S_L[c] metsox_S_L[e] mg2[c] mg2[e] mlthf[c] mn2[c] mn2[e] mnl1p[c] mnl[e] mobd[c] mobd[e] mops[c] mops[e] mql8[c] mqn8[c] mso3[c] mso3[e] mthgxl[c] murein4p4p[c] murein4px4p4p[c] murein4px4p[c] murein4px4px4p[c] murein5p4p[c] murein5px4p[c] myrsACP[c] myrstca1[c] n6all26d[c] na1[c] na1[e] nac[c] nac[e] nad[c] nadh[c] nadp[c] nadph[c] nh4[c] nh4[e] nicrnt[c] nmn[c] o2[c] o2[e] oaa[c] oc2coa[c] ocACP[c] ocdcaACP[c] ocdca[c] ocdca[e] ocdcea[c] ocmhmxbq[c] octdp[c] octeACP[c] odecoa[c] ohpb[c] orn[c] orot5p[c] orot[c] pa120[c] pa140[c] pa141[c] pa160[c] pa161[c] pa180[c] pa181[c] paai15[c] paai17[c] pai14[c] pai15[c] pai16[c] pai17[c] palmACP[c] palmtca1[c] pan4p[c] pant_R[c] pap[c] pb[c] pb[e] pe180[c] peai17[c] pei17[c] pendp[c] pep[c] pg120[c] pg140[c] pg141[c] pg160[c] pg161[c] pg180[c] pg181[c] pgai15[c] pgai17[c] pgi14[c] pgi15[c] pgi16[c] pgi17[c] pgp120[c] pgp140[c] pgp141[c] pgp160[c] pgp161[c] pgp180[c] pgp181[c] pgpai15[c] pgpai17[c] pgpi14[c] pgpi15[c] pgpi16[c] pgpi17[c] phe_L[c] phe_L[e] pheme[c] pheme[e] phom[c] phpyr[c] phthr[c] pi[c] pi[e] pmtcoa[c] pnto_R[c] pnto_R[e] ppa[c] ppap[c] ppbng[c] ppcoa[c] pphn[c] ppi[c] pppg9[c] pppi[c] pram[c] pran[c] prbamp[c] prbatp[c] pre1[c] pre3a[c] pre3b[c] pre4[c] pre5[c] pre8[c] prfp[c] prl45tca[c] prl45tcaala[c] prl45tcaglc[c] prlp[c] pro_L[c] pro_L[e] proteinsynth[c] protrna[c] prpncoa[c] prpp[c] psai17[c] psd5p[c] pser_L[c] psi17[c] ptrc[c] ptrc[e] pydx5p[c] pydx[c] pydx[e] pyr[c] q8[c] q8h2[c] quln[c] r5p[c] raffin[c] rdmbzi[c] rhcys[c] ribflv[c] ribflv[e] rnatrans[c] ru5p_D[c] s17bp[c] s7p[c] salc6p[c] salcn[e] sbt6p[c] sbt_D[e] sbzcoa[c] scl[c] seasmet[c] selmeth[c] ser_L[c] ser_L[e] sheme[c] skm5p[c] skm[c] so3[c] so4[c] so4[e] spmd[c] spmd[e] stcoa[c] sttca1[c] sttcaacgam[c] sttcaala_D[c] sttcaglc[c] suc6p[c] sucbz[c] succ[c] succoa[c] suchms[c] sucr[e] sulfac[c] sulfac[e] t3c11vaceACP[c] t3c5ddeceACP[c] t3c7mrseACP[c] tag6p_D[c] tagdp_D[c] tartr_L[c] taur[c] taur[e] tcam[c] td2coa[c] tdcoa[c] tddec2eACP[c] tdeACP[c] tdec2eACP[c] thdp[c] thex2eACP[c] thf[c] thfglu[c] thm[c] thm[e] thmpp[c] thr_L[c] thr_L[e] thrp[c] thym[c] tma[c] tmao[c] tmrs2eACP[c] toct2eACP[c] toctd2eACP[c] tpalm2eACP[c] trdox[c] trdrd[c] tre6p[c] tre[e] trnaglu[c] trnapro[c] trp_L[c] trp_L[e] tsul[c] tsul[e] ttc_ggdp[c] ttdca[c] ttdcea[c] tyr_L[c] tyr_L[e] u3aga[c] uGgl[c] uGgla[c] uaGgla[c] uaaAgla[c] uaaAgtla[c] uaaGgla[c] uaaGgtla[c] uaagmda[c] uaagtmda[c] uaccg[c] uacgam[c] uacmam[c] uagmda[c] uama[c] uamag[c] uamr[c] udcpdp[c] udcpp[c] udp[c] udpacgal[c] udpg[c] udpgal[c] udpgalfur[c] ugmd[c] ugmda[c] um4p[c] ump[c] unaga[c] up4g[c] uppg3[c] ura[c] ura[e] urea[c] utp[c] val_L[c] val_L[e] xan[c] xan[e] xmp[c] xu5p_D[c] zn2[c] zn2[e] addMultipleReactions: Adding the following reactions to the model: 23DHMPO 23dhmp[c] + nadp[c] <=> 3h3mop[c] + h[c] + nadph[c] 26DAPLLAT 26dap_LL[c] + akg[c] <=> glu_L[c] + h2o[c] + h[c] + thdp[c] 2AHBUTI 2ahbut[c] <=> 3h3mop[c] 2MBCOATA 2mbcoa[c] + ACP[c] <=> 2mbutACP[c] + coa[c] 2OMMBOX 2ommb[c] + nadph[c] + o2[c] -> h2o[c] + nadp[c] + ocmhmxbq[c] 2OMPHH 2omph[c] + o2[c] -> 2ombz[c] + h2o[c] 2S6HCC akg[c] + h[c] + ichor[c] <=> 2shchc[c] + co2[c] + pyr[c] 3HAD100 3hdecACP[c] -> h2o[c] + tdec2eACP[c] 3HAD10M12 10m3hddcaACP[c] -> 10mtddec2eACP[c] + h2o[c] 3HAD11M12 11m3hddcaACP[c] -> 11mtddec2eACP[c] + h2o[c] 3HAD120 3hddecACP[c] -> h2o[c] + tddec2eACP[c] 3HAD121 3hcddec5eACP[c] -> h2o[c] + t3c5ddeceACP[c] 3HAD12M14 12m3hmyrsACP[c] -> 12mtmrs2eACP[c] + h2o[c] 3HAD13M14 13m3hmyrsACP[c] -> 13mtmrs2eACP[c] + h2o[c] 3HAD140 3hmrsACP[c] -> h2o[c] + tmrs2eACP[c] 3HAD141 3hcmrs7eACP[c] -> h2o[c] + t3c7mrseACP[c] 3HAD14M16 14m3hpalmACP[c] -> 14mtpalm2eACP[c] + h2o[c] 3HAD15M16 15m3hpalmACP[c] -> 15mtpalm2eACP[c] + h2o[c] 3HAD160 3hpalmACP[c] -> h2o[c] + tpalm2eACP[c] 3HAD180 3hoctaACP[c] -> h2o[c] + toctd2eACP[c] 3HAD181 3hcvac11eACP[c] -> h2o[c] + t3c11vaceACP[c] 3HAD40 3haACP[c] -> but2eACP[c] + h2o[c] 3HAD4M6 4m3hhexACP[c] -> 4mthex2eACP[c] + h2o[c] 3HAD5M6 5m3hhexACP[c] -> 5mthex2eACP[c] + h2o[c] 3HAD60 3hhexACP[c] -> h2o[c] + thex2eACP[c] 3HAD6M8 6m3hocACP[c] -> 6mtoct2eACP[c] + h2o[c] 3HAD7M8 7m3hocACP[c] -> 7mtoct2eACP[c] + h2o[c] 3HAD80 3hoctACP[c] -> h2o[c] + toct2eACP[c] 3HAD8M10 8m3hdcaACP[c] -> 8mtdec2eACP[c] + h2o[c] 3HAD9M10 9m3hdcaACP[c] -> 9mtdec2eACP[c] + h2o[c] 3HPCOAHL 3hpcoa[c] <=> h2o[c] + prpncoa[c] 3MOBS 3c3hmp[c] + coa[c] + h[c] <=> 3mob[c] + accoa[c] + h2o[c] 3OAR100 3odecACP[c] + h[c] + nadph[c] <=> 3hdecACP[c] + nadp[c] 3OAR10M11 10m3oundecACP[c] + h[c] + nadph[c] <=> 10m3hundecACP[c] + nadp[c] 3OAR10M12 10m3oddcaACP[c] + h[c] + nadph[c] <=> 10m3hddcaACP[c] + nadp[c] 3OAR11M12 11m3oddcaACP[c] + h[c] + nadph[c] <=> 11m3hddcaACP[c] + nadp[c] 3OAR120 3oddecACP[c] + h[c] + nadph[c] <=> 3hddecACP[c] + nadp[c] 3OAR12M13 12m3otridecACP[c] + h[c] + nadph[c] <=> 12m3htridecACP[c] + nadp[c] 3OAR12M14 12m3omyrsACP[c] + h[c] + nadph[c] <=> 12m3hmyrsACP[c] + nadp[c] 3OAR13M14 13m3omyrsACP[c] + h[c] + nadph[c] <=> 13m3hmyrsACP[c] + nadp[c] 3OAR140 3omrsACP[c] + h[c] + nadph[c] <=> 3hmrsACP[c] + nadp[c] 3OAR14M15 14m3opentdecACP[c] + h[c] + nadph[c] <=> 14m3hpentdecACP[c] + nadp[c] 3OAR14M16 14m3opalmACP[c] + h[c] + nadph[c] <=> 14m3hpalmACP[c] + nadp[c] 3OAR15M16 15m3opalmACP[c] + h[c] + nadph[c] <=> 15m3hpalmACP[c] + nadp[c] 3OAR160 3opalmACP[c] + h[c] + nadph[c] <=> 3hpalmACP[c] + nadp[c] 3OAR180 3ooctdACP[c] + h[c] + nadph[c] <=> 3hoctaACP[c] + nadp[c] 3OAR40 actACP[c] + h[c] + nadph[c] <=> 3haACP[c] + nadp[c] 3OAR4M5 4m3opentACP[c] + h[c] + nadph[c] <=> 4m3hpentACP[c] + nadp[c] 3OAR4M6 4m3ohexACP[c] + h[c] + nadph[c] <=> 4m3hhexACP[c] + nadp[c] 3OAR5M6 5m3ohexACP[c] + h[c] + nadph[c] <=> 5m3hhexACP[c] + nadp[c] 3OAR60 3ohexACP[c] + h[c] + nadph[c] <=> 3hhexACP[c] + nadp[c] 3OAR6M7 6m3oheptACP[c] + h[c] + nadph[c] <=> 6m3hheptACP[c] + nadp[c] 3OAR6M8 6m3oocACP[c] + h[c] + nadph[c] <=> 6m3hocACP[c] + nadp[c] 3OAR7M8 7m3oocACP[c] + h[c] + nadph[c] <=> 7m3hocACP[c] + nadp[c] 3OAR80 3ooctACP[c] + h[c] + nadph[c] <=> 3hoctACP[c] + nadp[c] 3OAR8M10 8m3odcaACP[c] + h[c] + nadph[c] <=> 8m3hdcaACP[c] + nadp[c] 3OAR8M9 8m3ononACP[c] + h[c] + nadph[c] <=> 8m3hnonACP[c] + nadp[c] 3OAR9M10 9m3odcaACP[c] + h[c] + nadph[c] <=> 9m3hdcaACP[c] + nadp[c] 3OAS100 h[c] + malACP[c] + ocACP[c] -> 3odecACP[c] + ACP[c] + co2[c] 3OAS10M11 10mundecACP[c] + h[c] + malACP[c] -> 12m3otridecACP[c] + ACP[c] + co2[c] 3OAS10M12 10mddcaACP[c] + h[c] + malACP[c] -> 12m3omyrsACP[c] + ACP[c] + co2[c] 3OAS11M12 11mddcaACP[c] + h[c] + malACP[c] -> 13m3omyrsACP[c] + ACP[c] + co2[c] 3OAS120 dcaACP[c] + h[c] + malACP[c] -> 3oddecACP[c] + ACP[c] + co2[c] 3OAS12M13 12mtridecACP[c] + h[c] + malACP[c] -> 14m3opentdecACP[c] + ACP[c] + co2[c] 3OAS12M14 12mmyrsACP[c] + h[c] + malACP[c] -> 14m3opalmACP[c] + ACP[c] + co2[c] 3OAS13M14 13mmyrsACP[c] + h[c] + malACP[c] -> 15m3opalmACP[c] + ACP[c] + co2[c] 3OAS140 ddcaACP[c] + h[c] + malACP[c] -> 3omrsACP[c] + ACP[c] + co2[c] 3OAS160 h[c] + malACP[c] + myrsACP[c] -> 3opalmACP[c] + ACP[c] + co2[c] 3OAS180 h[c] + malACP[c] + palmACP[c] -> 3ooctdACP[c] + ACP[c] + co2[c] 3OAS2M3 2mpropACP[c] + h[c] + malACP[c] -> 4m3opentACP[c] + ACP[c] + co2[c] 3OAS3M4 3mbutACP[c] + h[c] + malACP[c] -> 5m3ohexACP[c] + ACP[c] + co2[c] 3OAS4M3O6 2mbutACP[c] + h[c] + malACP[c] -> 4m3ohexACP[c] + ACP[c] + co2[c] 3OAS4M5 4mpentACP[c] + h[c] + malACP[c] -> 6m3oheptACP[c] + ACP[c] + co2[c] 3OAS4M6 4mhexACP[c] + h[c] + malACP[c] -> 6m3oocACP[c] + ACP[c] + co2[c] 3OAS5M6 5mhexACP[c] + h[c] + malACP[c] -> 7m3oocACP[c] + ACP[c] + co2[c] 3OAS60 butACP[c] + h[c] + malACP[c] -> 3ohexACP[c] + ACP[c] + co2[c] 3OAS6M7 6mheptACP[c] + h[c] + malACP[c] -> 8m3ononACP[c] + ACP[c] + co2[c] 3OAS6M8 6mocACP[c] + h[c] + malACP[c] -> 8m3odcaACP[c] + ACP[c] + co2[c] 3OAS7M8 7mocACP[c] + h[c] + malACP[c] -> 9m3odcaACP[c] + ACP[c] + co2[c] 3OAS80 h[c] + hexACP[c] + malACP[c] -> 3ooctACP[c] + ACP[c] + co2[c] 3OAS8M10 8mdcaACP[c] + h[c] + malACP[c] -> 10m3oddcaACP[c] + ACP[c] + co2[c] 3OAS8M9 8mnonACP[c] + h[c] + malACP[c] -> 10m3oundecACP[c] + ACP[c] + co2[c] 3OAS9M10 9mdcaACP[c] + h[c] + malACP[c] -> 11m3oddcaACP[c] + ACP[c] + co2[c] 4HTHRS h2o[c] + phthr[c] -> 4hthr[c] + pi[c] 5AIZCDC 5aizc[c] + h[c] -> air[c] + co2[c] 6PHBG h2o[c] + salc6p[c] -> 2hymeph[c] + g6p[c] 6PHBG2 h2o[c] + salc6p[c] -> 2hymeph[c] + g6p_B[c] AACOAT acac[c] + atp[c] + coa[c] -> aacoa[c] + amp[c] + ppi[c] AACPS2 ACP[c] + atp[c] + ttdcea[c] -> amp[c] + ppi[c] + tdeACP[c] AACPS4 ACP[c] + atp[c] + hdcea[c] -> amp[c] + hdeACP[c] + ppi[c] AACPS7 ACP[c] + atp[c] + ddca[c] -> amp[c] + ddcaACP[c] + ppi[c] AACPS8 ACP[c] + atp[c] + dca[c] -> amp[c] + dcaACP[c] + ppi[c] AB6PGH arbt6p[c] + h2o[c] -> g6p[c] + hqn[c] AB6PGH2 arbt6p[c] + h2o[c] -> g6p_B[c] + hqn[c] ABTOXy abt[c] + nadp[c] <=> arab_L[c] + h[c] + nadph[c] ACALD acald[c] + coa[c] + nad[c] <=> accoa[c] + h[c] + nadh[c] ACBIPGT adocbip[c] + gtp[c] + h[c] -> agdpcbi[c] + ppi[c] ACCOACL accoa[c] + btn_co2[c] -> apoC_Lys_btn[c] + malcoa[c] ACGAMT uacgam[c] + udcpp[c] -> ump[c] + unaga[c] ACGApts acgam[e] + pep[c] -> acgam6p[c] + pyr[c] ACGK acglu[c] + atp[c] -> acg5p[c] + adp[c] ACGS accoa[c] + glu_L[c] -> acglu[c] + coa[c] + h[c] ACHBPL 2obut[c] + hethmpp[c] <=> 2ahbut[c] + thmpp[c] ACKr ac[c] + atp[c] <=> actp[c] + adp[c] ACLS_a h[c] + pyr[c] + thmpp[c] -> co2[c] + hethmpp[c] ACLS_b alac_S[c] + thmpp[c] <=> hethmpp[c] + pyr[c] ACNAMS acmana[c] + h2o[c] + pep[c] -> acnam[c] + pi[c] ACOAAGPAT140 1tdecg3p[c] + tdcoa[c] -> coa[c] + pa140[c] ACOAAGPAT160 1hdecg3p[c] + pmtcoa[c] -> coa[c] + pa160[c] ACOAAGPAT180 1odecg3p[c] + stcoa[c] -> coa[c] + pa180[c] ACOAAGPATAI15 1aipdecg3p[c] + aipdcoa[c] -> coa[c] + h[c] + paai15[c] ACOAAGPATAI17 1aihpdecg3p[c] + aihpdcoa[c] -> coa[c] + paai17[c] ACOAAGPATI14 1itdecg3p[c] + itdcoa[c] -> coa[c] + h[c] + pai14[c] ACOAAGPATI15 1ipdecg3p[c] + ipdcoa[c] -> coa[c] + h[c] + pai15[c] ACOAAGPATI16 1ihdecg3p[c] + ihdcoa[c] -> coa[c] + h[c] + pai16[c] ACOAAGPATI17 1ihpdecg3p[c] + ihpdcoa[c] -> coa[c] + pai17[c] ACOATA ACP[c] + accoa[c] <=> acACP[c] + coa[c] ACOTA acorn[c] + akg[c] <=> acg5sa[c] + glu_L[c] ACPS1 apoACP[c] + coa[c] -> ACP[c] + h[c] + pap[c] ACt2r ac[e] + h[e] <=> ac[c] + h[c] ADCL 4adcho[c] -> 4abz[c] + h[c] + pyr[c] ADCOBASr adcobhex[c] + appl[c] <=> adocbi[c] + h2o[c] ADCPS1 adcobhex[c] + appl[c] + atp[c] -> adocbi[c] + adp[c] + h[c] + pi[c] ADCPS2 adcobhex[c] + applp[c] + atp[c] -> adocbip[c] + adp[c] + h[c] + pi[c] ADCS chor[c] + gln_L[c] -> 4adcho[c] + glu_L[c] ADCYRS adcobdam[c] + 4 atp[c] + 4 gln_L[c] + 4 h2o[c] -> adcobhex[c] + 4 adp[c] + 4 glu_L[c] + 4 h[c] + 4 pi[c] ADK1 amp[c] + atp[c] <=> 2 adp[c] ADK2 amp[c] + pppi[c] <=> adp[c] + ppi[c] ADNK1 adn[c] + atp[c] -> adp[c] + amp[c] + h[c] ADOCBIK adocbi[c] + atp[c] -> adocbip[c] + adp[c] + h[c] ADOCBIK2 adocbi[c] + gtp[c] -> adocbip[c] + gdp[c] + h[c] ADOCBLS agdpcbi[c] + rdmbzi[c] -> adocbl[c] + gmp[c] + h[c] ADOCBLabc adocbl[e] + atp[c] + h2o[c] -> adocbl[c] + adp[c] + h[c] + pi[c] ADPRDP adprib[c] + h2o[c] -> amp[c] + 2 h[c] + r5p[c] ADPT ade[c] + prpp[c] -> amp[c] + ppi[c] ADSL1r dcamp[c] <=> amp[c] + fum[c] ADSL2r 25aics[c] <=> aicar[c] + fum[c] ADSS asp_L[c] + gtp[c] + imp[c] -> dcamp[c] + gdp[c] + 2 h[c] + pi[c] AGPAT120 1ddecg3p[c] + ddcaACP[c] -> ACP[c] + pa120[c] AGPAT140 1tdecg3p[c] + myrsACP[c] -> ACP[c] + pa140[c] AGPAT141 1tdec7eg3p[c] + tdeACP[c] -> ACP[c] + pa141[c] AGPAT160 1hdecg3p[c] + palmACP[c] -> ACP[c] + pa160[c] AGPAT161 1hdec9eg3p[c] + hdeACP[c] -> ACP[c] + pa161[c] AGPAT180 1odecg3p[c] + ocdcaACP[c] -> ACP[c] + pa180[c] AGPAT181 1odec11eg3p[c] + octeACP[c] -> ACP[c] + pa181[c] AGPR acg5sa[c] + nadp[c] + pi[c] <=> acg5p[c] + h[c] + nadph[c] AHC ahcys[c] + h2o[c] <=> adn[c] + hcys_L[c] AHCYSNS_r ahcys[c] + h2o[c] <=> ade[c] + rhcys[c] AHEXASE3 chtbs[c] + h2o[c] <=> 2 acgam[c] AHSERL2 achms[c] + h2s[c] -> ac[c] + h[c] + hcys_L[c] AHSERL3 achms[c] + trdrd[c] + tsul[c] <=> ac[c] + h[c] + hcys_L[c] + so3[c] + trdox[c] AICART 10fthf[c] + aicar[c] <=> fprica[c] + thf[c] AIHDUDPMG 12daihdglyc[c] + udpg[c] <=> h[c] + m12dahglyc[c] + udp[c] AIHDUPDG m12dahglyc[c] + udpg[c] <=> diglcpgai17[c] + h[c] + udp[c] AIHPDCOATA 14mpalmACP[c] + coa[c] <=> ACP[c] + aihpdcoa[c] AIPDCOATA 12mmyrsACP[c] + coa[c] <=> ACP[c] + aipdcoa[c] AIRC4 air[c] + atp[c] + hco3[c] -> 5aizc[c] + adp[c] + h[c] + pi[c] ALAALA 2 ala_D[c] + atp[c] -> adp[c] + alaala[c] + h[c] + pi[c] ALAASP1c alaasp[c] + h2o[c] <=> ala_L[c] + asp_L[c] ALAASPabc alaasp[e] + atp[c] + h2o[c] -> adp[c] + alaasp[c] + h[c] + pi[c] ALACI alac_S[c] <=> 33hmeoxobut[c] ALAGLN1c alagln[c] + h2o[c] <=> ala_L[c] + gln_L[c] ALAGLNabc alagln[e] + atp[c] + h2o[c] -> adp[c] + alagln[c] + h[c] + pi[c] ALAGLU1c alaglu[c] + h2o[c] <=> ala_L[c] + glu_L[c] ALAGLUabc alaglu[e] + atp[c] + h2o[c] -> adp[c] + alaglu[c] + h[c] + pi[c] ALAGLY1c alagly[c] + h2o[c] <=> ala_L[c] + gly[c] ALAGLYabc alagly[e] + atp[c] + h2o[c] -> adp[c] + alagly[c] + h[c] + pi[c] ALAHIS1c alahis[c] + h2o[c] <=> ala_L[c] + his_L[c] ALAHISabc alahis[e] + atp[c] + h2o[c] -> adp[c] + alahis[c] + h[c] + pi[c] ALALEU1c alaleu[c] + h2o[c] <=> ala_L[c] + leu_L[c] ALALEUabc alaleu[e] + atp[c] + h2o[c] -> adp[c] + alaleu[c] + h[c] + pi[c] ALAPGPL 45 ala_D[c] + 45 atp[c] + prl45tca[c] -> 45 amp[c] + 45 h2o[c] + 45 ppi[c] + prl45tcaala[c] ALAR ala_L[c] <=> ala_D[c] ALATHR1c alathr[c] + h2o[c] <=> ala_L[c] + thr_L[c] ALATHRabc alathr[e] + atp[c] + h2o[c] -> adp[c] + alathr[c] + h[c] + pi[c] ALAt2r ala_L[e] + h[e] <=> ala_L[c] + h[c] ALCD19 glyald[c] + h[c] + nadh[c] <=> glyc[c] + nad[c] ALCD2x etoh[c] + nad[c] <=> acald[c] + h[c] + nadh[c] ALCD4 btoh[c] + nad[c] <=> btal[c] + h[c] + nadh[c] ALLTNRS 5hxudidzcba[c] + h[c] -> alltn_R[c] + co2[c] AMALT1 malt[c] + malttr[c] -> glc_D[c] + maltttr[c] AMALT2 malt[c] + maltttr[c] -> glc_D[c] + maltpt[c] AMALT3 malt[c] + maltpt[c] -> glc_D[c] + malthx[c] AMALT4 malt[c] + malthx[c] -> glc_D[c] + malthp[c] AMAOTr 8aonn[c] + amet[c] <=> amob[c] + dann[c] AMETt2 amet[e] + h[e] -> amet[c] + h[c] AMMQT8r 2dmmq8[c] + amet[c] <=> ahcys[c] + h[c] + mqn8[c] AMPSO3OX amp[c] + fad[c] + 2 h[c] + so3[c] <=> aps[c] + fadh2[c] AMPTASECG cgly[c] + h2o[c] -> cys_L[c] + gly[c] AMPTASEGC glycys[c] + h2o[c] -> cys_L[c] + gly[c] ANPRT anth[c] + prpp[c] -> ppi[c] + pran[c] ANS chor[c] + gln_L[c] -> anth[c] + glu_L[c] + h[c] + pyr[c] ANS2 chor[c] + nh4[c] -> anth[c] + h2o[c] + h[c] + pyr[c] AOXHEXCYCL 6a2ohxnt[c] <=> 1pipdn2c[c] + h2o[c] APRAUR 5apru[c] + h[c] + nadph[c] -> 5aprbu[c] + nadp[c] ARBTpts arbt[e] + pep[c] -> arbt6p[c] + pyr[c] ARGN arg_L[c] + h2o[c] -> orn[c] + urea[c] ARGSL argsuc[c] <=> arg_L[c] + fum[c] ARGSSr asp_L[c] + atp[c] + citr_L[c] <=> amp[c] + argsuc[c] + h[c] + ppi[c] ARGt2 arg_L[e] + h[e] -> arg_L[c] + h[c] ASAD aspsa[c] + nadp[c] + pi[c] <=> 4pasp[c] + h[c] + nadph[c] ASNS1 asp_L[c] + atp[c] + gln_L[c] + h2o[c] -> amp[c] + asn_L[c] + glu_L[c] + h[c] + ppi[c] ASNt2r asn_L[e] + h[e] <=> asn_L[c] + h[c] ASPCT asp_L[c] + cbp[c] -> cbasp[c] + h[c] + pi[c] ASPK asp_L[c] + atp[c] <=> 4pasp[c] + adp[c] ASPO1 asp_L[c] + h2o[c] + o2[c] -> h2o2[c] + nh4[c] + oaa[c] ASPO6 asp_L[c] + o2[c] -> h2o2[c] + h[c] + iasp[c] ASPT asp_L[c] -> fum[c] + nh4[c] ASPTA akg[c] + asp_L[c] <=> glu_L[c] + oaa[c] ASPt2r asp_L[e] + h[e] <=> asp_L[c] + h[c] ASR aso4[c] + 2 gthrd[c] -> aso3[c] + gthox[c] + h2o[c] ATPPRT atp[c] + prpp[c] -> ppi[c] + prbatp[c] ATPS4 adp[c] + 4 h[e] + pi[c] -> atp[c] + h2o[c] + 3 h[c] BGLA cellb[c] + h2o[c] -> 2 glc_D[c] BGLA1 6pgg[c] + h2o[c] -> g6p[c] + glc_D[c] BGLAr cellb[c] + h2o[c] <=> 2 glc_bD[c] BPNT h2o[c] + pap[c] -> amp[c] + pi[c] BTNCL apoC_Lys_btn[c] + atp[c] + hco3[c] <=> adp[c] + btn_co2[c] + h[c] + pi[c] BTNabc atp[c] + btn[e] + h2o[c] -> adp[c] + btn[c] + h[c] + pi[c] BTNt2 btn[e] + h[e] <=> btn[c] + h[c] BUP2 3uib[c] + h2o[c] + 2 h[c] -> 3aib_D[c] + co2[c] + nh4[c] BUTSO3abc atp[c] + butso3[e] + h2o[c] -> adp[c] + butso3[c] + h[c] + pi[c] CAt4i ca2[e] + h[c] -> ca2[c] + h[e] CBIAT atp[c] + cbi[c] + h[c] <=> adocbi[c] + pppi[c] CBL1abc atp[c] + cbl1[e] + h2o[c] -> adp[c] + cbl1[c] + h[c] + pi[c] CBL2D 2 cbl1[c] + h[c] + nad[c] <=> 2 cbl2[c] + nadh[c] CBL2abc atp[c] + cbl2[e] + h2o[c] -> adp[c] + cbl2[c] + h[c] + pi[c] CBMKr atp[c] + co2[c] + nh4[c] <=> adp[c] + cbp[c] + 2 h[c] CBPS 2 atp[c] + gln_L[c] + h2o[c] + hco3[c] -> 2 adp[c] + cbp[c] + glu_L[c] + 2 h[c] + pi[c] CD2abc1 atp[c] + cd2[c] + h2o[c] -> adp[c] + cd2[e] + h[c] + pi[c] CDPGLYCGPT acbdma14gapuc[c] + 45 cdpglyc[c] <=> 45 cmp[c] + 45 h[c] + prl45tca[c] CDPMEK 4c2me[c] + atp[c] -> 2p4c2me[c] + adp[c] + h[c] CGLYabc atp[c] + cgly[e] + h2o[c] -> adp[c] + cgly[c] + h[c] + pi[c] CHORM chor[c] -> pphn[c] CHORS 3psme[c] -> chor[c] + pi[c] CHRPL chor[c] -> 4hbz[c] + pyr[c] CLPNS140 2 pg140[c] <=> clpn140[c] + glyc[c] CLPNS160 2 pg160[c] <=> clpn160[c] + glyc[c] CLPNS180 2 pg180[c] <=> clpn180[c] + glyc[c] CLPNSAI15 2 pgai15[c] <=> clpnai15[c] + glyc[c] CLPNSAI17 2 pgai17[c] <=> clpnai17[c] + glyc[c] CLPNSI14 2 pgi14[c] <=> clpni14[c] + glyc[c] CLPNSI15 2 pgi15[c] <=> clpni15[c] + glyc[c] CLPNSI16 2 pgi16[c] <=> clpni16[c] + glyc[c] CLPNSI17 2 pgi17[c] <=> clpni17[c] + glyc[c] CMLDC 2c25dho[c] + h[c] -> 5odhf2a[c] + co2[c] CO2t co2[e] <=> co2[c] COAti coa[e] -> coa[c] COBALTt5 cobalt2[c] <=> cobalt2[e] CPC2MT amet[c] + copre2[c] -> ahcys[c] + copre3[c] + h[c] CPC3MT amet[c] + copre3[c] -> ahcys[c] + copre4[c] CPC4MT amet[c] + copre4[c] -> ahcys[c] + copre5[c] + h[c] CPC8MM copre8[c] <=> cobya[c] CPPPGO cpppg3[c] + 2 h[c] + o2[c] -> 2 co2[c] + 2 h2o[c] + pppg9[c] CRO4t3 cro4[c] + h[e] <=> cro4[e] + h[c] CTPS1 atp[c] + nh4[c] + utp[c] -> adp[c] + ctp[c] + 2 h[c] + pi[c] CTPS2 atp[c] + gln_L[c] + h2o[c] + utp[c] -> adp[c] + ctp[c] + glu_L[c] + 2 h[c] + pi[c] CYOBDOX cytbdr[c] + 4 h[c] + 0.5 o2[c] -> cytbdox[c] + h2o[c] + 2 h[e] CYOBDR cytbdox[c] + q8h2[c] <=> cytbdr[c] + 2 h[e] + q8[c] CYRDAAT atp[c] + co1dam[c] + h[c] -> adcobdam[c] + pppi[c] CYSDS cys_L[c] + h2o[c] -> h2s[c] + nh4[c] + pyr[c] CYSS acser[c] + h2s[c] -> ac[c] + cys_L[c] + h[c] CYSS3r acser[c] + trdrd[c] + tsul[c] <=> ac[c] + cys_L[c] + h[c] + so3[c] + trdox[c] CYSTL cyst_L[c] + h2o[c] -> hcys_L[c] + nh4[c] + pyr[c] CYSt2r cys_L[e] + h[e] <=> cys_L[c] + h[c] CYTBD 2 h[c] + 0.5 o2[c] + q8h2[c] -> h2o[c] + 2 h[e] + q8[c] CYTDK3 cytd[c] + itp[c] -> cmp[c] + h[c] + idp[c] CYTK1 atp[c] + cmp[c] <=> adp[c] + cdp[c] CYTK2 atp[c] + dcmp[c] <=> adp[c] + dcdp[c] Cuabc atp[c] + cu2[e] + h2o[c] -> adp[c] + cu2[c] + h[c] + pi[c] Cut1 atp[c] + cu2[c] + h2o[c] -> adp[c] + cu2[e] + h[c] + pi[c] DALAt2r ala_D[e] + h[e] <=> ala_D[c] + h[c] DAPDA h2o[c] + n6all26d[c] <=> 26dap_LL[c] + ac[c] DAPDC 26dap_M[c] + h[c] -> co2[c] + lys_L[c] DAPDH 2 h[c] + nadph[c] + nh4[c] + thdp[c] -> 26dap_M[c] + nadp[c] DAPE 26dap_LL[c] <=> 26dap_M[c] DASYN120 ctp[c] + h[c] + pa120[c] -> cdpdddecg[c] + ppi[c] DASYN140 ctp[c] + h[c] + pa140[c] -> cdpdtdecg[c] + ppi[c] DASYN141 ctp[c] + h[c] + pa141[c] -> cdpdtdec7eg[c] + ppi[c] DASYN160 ctp[c] + h[c] + pa160[c] -> cdpdhdecg[c] + ppi[c] DASYN161 ctp[c] + h[c] + pa161[c] -> cdpdhdec9eg[c] + ppi[c] DASYN180 ctp[c] + h[c] + pa180[c] -> cdpdodecg[c] + ppi[c] DASYN181 ctp[c] + h[c] + pa181[c] -> cdpdodec11eg[c] + ppi[c] DASYNAI15 ctp[c] + h[c] + paai15[c] -> cdpdaipdecg[c] + ppi[c] DASYNAI17 ctp[c] + h[c] + paai17[c] -> cdpdaihpdecg[c] + ppi[c] DASYNI14 ctp[c] + h[c] + pai14[c] -> cdpditdecg[c] + ppi[c] DASYNI15 ctp[c] + h[c] + pai15[c] -> cdpdipdecg[c] + ppi[c] DASYNI16 ctp[c] + h[c] + pai16[c] -> cdpdihdecg[c] + ppi[c] DASYNI17 ctp[c] + h[c] + pai17[c] -> cdpdihpdecg[c] + ppi[c] DB4PS ru5p_D[c] -> db4p[c] + for[c] + h[c] DCMPDA dcmp[c] + h2o[c] + h[c] <=> dump[c] + nh4[c] DDPA e4p[c] + h2o[c] + pep[c] -> 2dda7p[c] + pi[c] DGK1 atp[c] + dgmp[c] <=> adp[c] + dgdp[c] DHAD1 23dhmb[c] -> 3mob[c] + h2o[c] DHAD2 23dhmp[c] -> 3mop[c] + h2o[c] DHAPT dha[c] + pep[c] -> dhap[c] + pyr[c] DHDPRy 23dhdp[c] + h[c] + nadph[c] -> nadp[c] + thdp[c] DHDPS aspsa[c] + pyr[c] -> 23dhdp[c] + 2 h2o[c] + h[c] DHFOR2 dhf[c] + nadp[c] <=> fol[c] + nadph[c] DHFR dhf[c] + h[c] + nadph[c] <=> nadp[c] + thf[c] DHFS atp[c] + dhpt[c] + glu_L[c] -> adp[c] + dhf[c] + h[c] + pi[c] DHNAOT4 dhna[c] + h[c] + octdp[c] -> 2dmmql8[c] + co2[c] + ppi[c] DHORD2 dhor_S[c] + q8[c] -> orot[c] + q8h2[c] DHORD5 dhor_S[c] + mqn8[c] -> mql8[c] + orot[c] DHORTS dhor_S[c] + h2o[c] <=> cbasp[c] + h[c] DHPM1 56dura[c] + h2o[c] -> cala[c] + h[c] DHPM2 56dthm[c] + h2o[c] -> 3uib[c] + h[c] DHPPDA 25dhpp[c] + h2o[c] + h[c] -> 5apru[c] + nh4[c] DHPS 2ahhmp[c] + 4abz[c] -> dhpt[c] + h2o[c] DHQS 2dda7p[c] -> 3dhq[c] + pi[c] DHQTi 3dhq[c] -> 3dhsk[c] + h2o[c] DMATT dmpp[c] + ipdp[c] -> grdp[c] + ppi[c] DMPPS h2mb4p[c] + h[c] + nadh[c] -> dmpp[c] + h2o[c] + nad[c] DMPPS2r h2mb4p[c] + h[c] + nadph[c] <=> dmpp[c] + h2o[c] + nadp[c] DMQMT2 amet[c] + ocmhmxbq[c] <=> ahcys[c] + q8[c] DMSOR1 dmso[c] + mql8[c] -> dms[c] + h2o[c] + mqn8[c] DMSOR2 2dmmql8[c] + dmso[c] -> 2dmmq8[c] + dms[c] + h2o[c] DM_dhptd(c) dhptd[c] <=> DPRr 2dhp[c] + h[c] + nadph[c] <=> nadp[c] + pant_R[c] DTTPti dttp[c] -> dttp[e] DURAD 56dura[c] + nadp[c] <=> h[c] + nadph[c] + ura[c] DURAD2 56dthm[c] + nadp[c] <=> h[c] + nadph[c] + thym[c] DUTPDP dutp[c] + h2o[c] -> dump[c] + h[c] + ppi[c] DXPRIr dxyl5p[c] + h[c] + nadph[c] <=> 2me4p[c] + nadp[c] DXPS g3p[c] + h[c] + pyr[c] -> co2[c] + dxyl5p[c] E4PD e4p[c] + h2o[c] + nad[c] <=> 4per[c] + 2 h[c] + nadh[c] EAR10M12x 10mtddec2eACP[c] + h[c] + nadh[c] -> 10mddcaACP[c] + nad[c] EAR11M12x 11mtddec2eACP[c] + h[c] + nadh[c] -> 11mddcaACP[c] + nad[c] EAR12M14x 12mtmrs2eACP[c] + h[c] + nadh[c] -> 12mmyrsACP[c] + nad[c] EAR13M14x 13mtmrs2eACP[c] + h[c] + nadh[c] -> 13mmyrsACP[c] + nad[c] EAR14M16x 14mtpalm2eACP[c] + h[c] + nadh[c] -> 14mpalmACP[c] + nad[c] EAR15M16x 15mtpalm2eACP[c] + h[c] + nadh[c] -> 15mpalmACP[c] + nad[c] EAR4M6x 4mthex2eACP[c] + h[c] + nadh[c] -> 4mhexACP[c] + nad[c] EAR5M6x 5mthex2eACP[c] + h[c] + nadh[c] -> 5mhexACP[c] + nad[c] EAR6M8x 6mtoct2eACP[c] + h[c] + nadh[c] -> 6mocACP[c] + nad[c] EAR7M8x 7mtoct2eACP[c] + h[c] + nadh[c] -> 7mocACP[c] + nad[c] EAR8M10x 8mtdec2eACP[c] + h[c] + nadh[c] -> 8mdcaACP[c] + nad[c] EAR9M10x 9mtdec2eACP[c] + h[c] + nadh[c] -> 9mdcaACP[c] + nad[c] ECOAH1 3hbcoa[c] <=> b2coa[c] + h2o[c] ECOAH12 2mp2coa[c] + h2o[c] -> 3hibutcoa[c] ECOAH3 3hocoa[c] <=> h2o[c] + oc2coa[c] ECOAH4 3hdcoa[c] <=> dc2coa[c] + h2o[c] ECOAH5 3hddcoa[c] <=> dd2coa[c] + h2o[c] ECOAH6 3htdcoa[c] <=> h2o[c] + td2coa[c] ECOAH7 3hhdcoa[c] <=> h2o[c] + hdd2coa[c] ECOAH9 2mb2coa[c] + h2o[c] <=> 3hmbcoa[c] EHGLAT akg[c] + e4hglu[c] -> 4h2oglt[c] + glu_L[c] ENO 2pg[c] <=> h2o[c] + pep[c] ETHAAL etha[c] -> acald[c] + nh4[c] ETHAt2 etha[e] + h[e] -> etha[c] + h[c] ETHSO3abc atp[c] + ethso3[e] + h2o[c] -> adp[c] + ethso3[c] + h[c] + pi[c] EX_Lcyst(e) Lcyst[e] <=> EX_ac(e) ac[e] <=> EX_acgam(e) acgam[e] <=> EX_adocbl(e) adocbl[e] <=> EX_ala_D(e) ala_D[e] <=> EX_ala_L(e) ala_L[e] <=> EX_alaasp(e) alaasp[e] <=> EX_alagln(e) alagln[e] <=> EX_alaglu(e) alaglu[e] <=> EX_alagly(e) alagly[e] <=> EX_alahis(e) alahis[e] <=> EX_alaleu(e) alaleu[e] <=> EX_alathr(e) alathr[e] <=> EX_amet(e) amet[e] <=> EX_amob(e) amob[e] <=> EX_arbt(e) arbt[e] <=> EX_arg_L(e) arg_L[e] <=> EX_asn_L(e) asn_L[e] <=> EX_asp_L(e) asp_L[e] <=> EX_biomass(e) biomass[c] <=> EX_btn(e) btn[e] <=> EX_butso3(e) butso3[e] <=> EX_ca2(e) ca2[e] <=> EX_cbl1(e) cbl1[e] <=> EX_cbl2(e) cbl2[e] <=> EX_cd2(e) cd2[e] <=> EX_cgly(e) cgly[e] <=> EX_cl(e) cl[e] <=> EX_co2(e) co2[e] <=> EX_coa(e) coa[e] <=> EX_cobalt2(e) cobalt2[e] <=> EX_cro4(e) cro4[e] <=> EX_cu2(e) cu2[e] <=> EX_cys_L(e) cys_L[e] <=> EX_dttp(e) dttp[e] <=> EX_etha(e) etha[e] <=> EX_ethso3(e) ethso3[e] <=> EX_fe2(e) fe2[e] <=> EX_fe3(e) fe3[e] <=> EX_fol(e) fol[e] <=> EX_for(e) for[e] <=> EX_fru(e) fru[e] <=> EX_galt(e) galt[e] <=> EX_gam(e) gam[e] <=> EX_glc_D(e) glc_D[e] <=> EX_gln_L(e) gln_L[e] <=> EX_glu_L(e) glu_L[e] <=> EX_gly(e) gly[e] <=> EX_glyasn(e) glyasn[e] <=> EX_glyasp(e) glyasp[e] <=> EX_glycogenb(e) glycogenb[e] <=> EX_glycys(e) glycys[e] <=> EX_glygln(e) glygln[e] <=> EX_glyglu(e) glyglu[e] <=> EX_glyleu(e) glyleu[e] <=> EX_glymet(e) glymet[e] <=> EX_glyphe(e) glyphe[e] <=> EX_glypro(e) glypro[e] <=> EX_glytyr(e) glytyr[e] <=> EX_h(e) h[e] <=> EX_h2o(e) h2o[e] <=> EX_hexs(e) hexs[e] <=> EX_hg2(e) hg2[e] <=> EX_his_L(e) his_L[e] <=> EX_hxan(e) hxan[e] <=> EX_ile_L(e) ile_L[e] <=> EX_isetac(e) isetac[e] <=> EX_k(e) k[e] <=> EX_leu_L(e) leu_L[e] <=> EX_lys_L(e) lys_L[e] <=> EX_malt(e) malt[e] <=> EX_man(e) man[e] <=> EX_met_D(e) met_D[e] <=> EX_met_L(e) met_L[e] <=> EX_metala(e) metala[e] <=> EX_metsox_R_L(e) metsox_R_L[e] <=> EX_metsox_S_L(e) metsox_S_L[e] <=> EX_mg2(e) mg2[e] <=> EX_mn2(e) mn2[e] <=> EX_mnl(e) mnl[e] <=> EX_mobd(e) mobd[e] <=> EX_mops(e) mops[e] <=> EX_mso3(e) mso3[e] <=> EX_na1(e) na1[e] <=> EX_nac(e) nac[e] <=> EX_nh4(e) nh4[e] <=> EX_o2(e) o2[e] <=> EX_ocdca(e) ocdca[e] <=> EX_pb(e) pb[e] <=> EX_phe_L(e) phe_L[e] <=> EX_pheme(e) pheme[e] <=> EX_pi(e) pi[e] <=> EX_pnto_R(e) pnto_R[e] <=> EX_pro_L(e) pro_L[e] <=> EX_ptrc(e) ptrc[e] <=> EX_pydx(e) pydx[e] <=> EX_ribflv(e) ribflv[e] <=> EX_salcn(e) salcn[e] <=> EX_sbt_D(e) sbt_D[e] <=> EX_ser_L(e) ser_L[e] <=> EX_so4(e) so4[e] <=> EX_spmd(e) spmd[e] <=> EX_sucr(e) sucr[e] <=> EX_sulfac(e) sulfac[e] <=> EX_taur(e) taur[e] <=> EX_thm(e) thm[e] <=> EX_thr_L(e) thr_L[e] <=> EX_tre(e) tre[e] <=> EX_trp_L(e) trp_L[e] <=> EX_tsul(e) tsul[e] <=> EX_tyr_L(e) tyr_L[e] <=> EX_ura(e) ura[e] <=> EX_val_L(e) val_L[e] <=> EX_xan(e) xan[e] <=> EX_zn2(e) zn2[e] <=> FACOAL140i atp[c] + coa[c] + ttdca[c] -> amp[c] + ppi[c] + tdcoa[c] FACOAL160i atp[c] + coa[c] + hdca[c] -> amp[c] + pmtcoa[c] + ppi[c] FACOAL161 atp[c] + coa[c] + hdcea[c] <=> amp[c] + hdcoa[c] + ppi[c] FACOAL180i atp[c] + coa[c] + ocdca[c] -> amp[c] + ppi[c] + stcoa[c] FACOAL181 atp[c] + coa[c] + ocdcea[c] <=> amp[c] + odecoa[c] + ppi[c] FACOALAI15 atp[c] + coa[c] + fa4[c] <=> aipdcoa[c] + amp[c] + ppi[c] FACOALAI17 atp[c] + coa[c] + fa12[c] <=> aihpdcoa[c] + amp[c] + ppi[c] FACOALI14 atp[c] + coa[c] + fa1[c] <=> amp[c] + itdcoa[c] + ppi[c] FACOALI15 atp[c] + coa[c] + fa3[c] <=> amp[c] + ipdcoa[c] + ppi[c] FACOALI16 atp[c] + coa[c] + fa6[c] <=> amp[c] + ihdcoa[c] + ppi[c] FACOALI17 atp[c] + coa[c] + fa11[c] <=> amp[c] + ihpdcoa[c] + ppi[c] FBA fdp[c] <=> dhap[c] + g3p[c] FBA2 f1p[c] <=> dhap[c] + glyald[c] FBA3 s17bp[c] <=> dhap[c] + e4p[c] FBP fdp[c] + h2o[c] -> f6p[c] + pi[c] FDHr for[c] + nad[c] <=> co2[c] + nadh[c] FE2DH 2 fe2[c] + h[c] + nad[c] <=> 2 fe3[c] + nadh[c] FE2abc atp[c] + fe2[e] + h2o[c] -> adp[c] + fe2[c] + h[c] + pi[c] FE3abc atp[c] + fe3[e] + h2o[c] -> adp[c] + fe3[c] + h[c] + pi[c] FFSD h2o[c] + suc6p[c] -> fru[c] + g6p[c] FMNAT atp[c] + fmn[c] + h[c] -> fad[c] + ppi[c] FOLD3 2ahhmd[c] + 4abz[c] -> dhpt[c] + ppi[c] FOLt fol[e] + h[e] <=> fol[c] + h[c] FOMETR 5fthf[c] + h[c] <=> h2o[c] + methf[c] FORTHFC 5forthf[c] + 2 h[c] <=> methf[c] + nh4[c] FORt2r for[e] + h[e] <=> for[c] + h[c] FPGS7 10fthf[c] + atp[c] + 4 glu_L[c] -> 10fthf5glu[c] + adp[c] + 3 h2o[c] + h[c] + pi[c] FPGS_tm atp[c] + glu_L[c] + thf[c] -> adp[c] + h[c] + pi[c] + thfglu[c] FRD2 fum[c] + mql8[c] -> mqn8[c] + succ[c] FRD3 2dmmql8[c] + fum[c] -> 2dmmq8[c] + succ[c] FRTT frdp[c] + ipdp[c] -> ggdp[c] + ppi[c] FRUpts fru[e] + pep[c] -> f1p[c] + pyr[c] FT frdp[c] + ipdp[c] -> ppi[c] + ttc_ggdp[c] FTHFCL 5fthf[c] + atp[c] -> adp[c] + methf[c] + pi[c] FTHFL atp[c] + for[c] + thf[c] -> 10fthf[c] + adp[c] + pi[c] FUM fum[c] + h2o[c] <=> mal_L[c] G1PACT accoa[c] + gam1p[c] -> acgam1p[c] + coa[c] + h[c] G1PTT dttp[c] + g1p[c] + h[c] -> dtdpglu[c] + ppi[c] G1SAT glu1sa[c] <=> 5aop[c] G3PAT120 ddcaACP[c] + glyc3p[c] -> 1ddecg3p[c] + ACP[c] G3PAT140 glyc3p[c] + myrsACP[c] -> 1tdecg3p[c] + ACP[c] G3PAT141 glyc3p[c] + tdeACP[c] -> 1tdec7eg3p[c] + ACP[c] G3PAT160 glyc3p[c] + palmACP[c] -> 1hdecg3p[c] + ACP[c] G3PAT161 glyc3p[c] + hdeACP[c] -> 1hdec9eg3p[c] + ACP[c] G3PAT180 glyc3p[c] + ocdcaACP[c] -> 1odecg3p[c] + ACP[c] G3PAT181 glyc3p[c] + octeACP[c] -> 1odec11eg3p[c] + ACP[c] G3PATAI15 aipdcoa[c] + glyc3p[c] + h[c] -> 1aipdecg3p[c] + coa[c] G3PATAI17 aihpdcoa[c] + glyc3p[c] -> 1aihpdecg3p[c] + coa[c] G3PATI14 glyc3p[c] + h[c] + itdcoa[c] -> 1itdecg3p[c] + coa[c] G3PATI15 glyc3p[c] + h[c] + ipdcoa[c] -> 1ipdecg3p[c] + coa[c] G3PATI16 glyc3p[c] + h[c] + ihdcoa[c] -> 1ihdecg3p[c] + coa[c] G3PATI17 glyc3p[c] + ihpdcoa[c] -> 1ihpdecg3p[c] + coa[c] G3PCT ctp[c] + glyc3p[c] + h[c] -> cdpglyc[c] + ppi[c] G3PD1 glyc3p[c] + nad[c] <=> dhap[c] + h[c] + nadh[c] G3PD2 glyc3p[c] + nadp[c] <=> dhap[c] + h[c] + nadph[c] G5SADs glu5sa[c] -> 1pyr5c[c] + h2o[c] + h[c] G5SDr glu5p[c] + h[c] + nadph[c] <=> glu5sa[c] + nadp[c] + pi[c] G6PI g6p[c] <=> g6p_B[c] G6PI3 g6p_B[c] <=> f6p[c] GALTpts galt[e] + pep[c] -> galt1p[c] + pyr[c] GALU g1p[c] + h[c] + utp[c] <=> ppi[c] + udpg[c] GAMpts gam[e] + pep[c] -> gam6p[c] + pyr[c] GAPD g3p[c] + nad[c] + pi[c] <=> 13dpg[c] + h[c] + nadh[c] GARFTi 10fthf[c] + gar[c] -> fgam[c] + h[c] + thf[c] GCCb alpro[c] + thf[c] -> dhlpro[c] + mlthf[c] + nh4[c] GCCc dhlpro[c] + nad[c] -> h[c] + lpro[c] + nadh[c] GF6PTA f6p[c] + gln_L[c] -> gam6p[c] + glu_L[c] GGTA cgly[c] + glu_L[c] -> gthrd[c] + h2o[c] GGTT ggdp[c] + ipdp[c] -> pendp[c] + ppi[c] GHMT2r ser_L[c] + thf[c] <=> gly[c] + h2o[c] + mlthf[c] GK1 atp[c] + gmp[c] <=> adp[c] + gdp[c] GK2 datp[c] + gmp[c] <=> dadp[c] + gdp[c] GLCP glycogen[c] + pi[c] -> g1p[c] GLCS1 adpglc[c] -> adp[c] + glycogen[c] + h[c] GLCpts glc_D[e] + pep[c] -> g6p[c] + pyr[c] GLGC atp[c] + g1p[c] + h[c] -> adpglc[c] + ppi[c] GLNS atp[c] + glu_L[c] + nh4[c] -> adp[c] + gln_L[c] + h[c] + pi[c] GLNSP1 atp[c] + nh4[c] + uaaAgla[c] -> adp[c] + h[c] + pi[c] + uaaAgtla[c] GLNSP2 atp[c] + nh4[c] + uaaGgla[c] -> adp[c] + h[c] + pi[c] + uaaGgtla[c] GLNSP3 atp[c] + nh4[c] + uaagmda[c] -> adp[c] + h[c] + pi[c] + uaagtmda[c] GLNabc atp[c] + gln_L[e] + h2o[c] -> adp[c] + gln_L[c] + h[c] + pi[c] GLNt2r gln_L[e] + h[e] <=> gln_L[c] + h[c] GLU5K atp[c] + glu_L[c] -> adp[c] + glu5p[c] GLUCYS atp[c] + cys_L[c] + glu_L[c] -> adp[c] + glucys[c] + h[c] + pi[c] GLUDy glu_L[c] + h2o[c] + nadp[c] <=> akg[c] + h[c] + nadph[c] + nh4[c] GLUN gln_L[c] + h2o[c] -> glu_L[c] + nh4[c] GLUOX 2 glu_L[c] + nadp[c] <=> akg[c] + gln_L[c] + h[c] + nadph[c] GLUPRT gln_L[c] + h2o[c] + prpp[c] -> glu_L[c] + ppi[c] + pram[c] GLUR glu_D[c] <=> glu_L[c] GLUTRR glutrna[c] + h[c] + nadph[c] -> glu1sa[c] + nadp[c] + trnaglu[c] GLUTRS atp[c] + glu_L[c] + trnaglu[c] -> amp[c] + glutrna[c] + ppi[c] GLUt2r glu_L[e] + h[e] <=> glu_L[c] + h[c] GLYASN1c glyasn[c] + h2o[c] <=> asn_L[c] + gly[c] GLYASNabc atp[c] + glyasn[e] + h2o[c] -> adp[c] + glyasn[c] + h[c] + pi[c] GLYASP1c glyasp[c] + h2o[c] <=> asp_L[c] + gly[c] GLYASPabc atp[c] + glyasp[e] + h2o[c] -> adp[c] + glyasp[c] + h[c] + pi[c] GLYCYSabc atp[c] + glycys[e] + h2o[c] -> adp[c] + glycys[c] + h[c] + pi[c] GLYGLN1c glygln[c] + h2o[c] <=> gln_L[c] + gly[c] GLYGLNabc atp[c] + glygln[e] + h2o[c] -> adp[c] + glygln[c] + h[c] + pi[c] GLYGLU1c glyglu[c] + h2o[c] <=> glu_L[c] + gly[c] GLYGLUabc atp[c] + glyglu[e] + h2o[c] -> adp[c] + glyglu[c] + h[c] + pi[c] GLYK atp[c] + glyc[c] -> adp[c] + glyc3p[c] + h[c] GLYLEUHYDROc glyleu[c] + h2o[c] <=> gly[c] + leu_L[c] GLYLEUPEPT1tc glyleu[e] + h[e] -> glyleu[c] + h[c] GLYMET1c glymet[c] + h2o[c] <=> gly[c] + met_L[c] GLYMETabc atp[c] + glymet[e] + h2o[c] -> adp[c] + glymet[c] + h[c] + pi[c] GLYOX h2o[c] + lgt_S[c] -> gthrd[c] + h[c] + lac_D[c] GLYPHEHYc glyphe[c] + h2o[c] <=> gly[c] + phe_L[c] GLYPHEabc atp[c] + glyphe[e] + h2o[c] -> adp[c] + glyphe[c] + h[c] + pi[c] GLYPROPRO1c glypro[c] + h2o[c] <=> gly[c] + pro_L[c] GLYPROabc atp[c] + glypro[e] + h2o[c] -> adp[c] + glypro[c] + h[c] + pi[c] GLYTYR1c glytyr[c] + h2o[c] <=> gly[c] + tyr_L[c] GLYTYRabc atp[c] + glytyr[e] + h2o[c] -> adp[c] + glytyr[c] + h[c] + pi[c] GLYt2r gly[e] + h[e] <=> gly[c] + h[c] GMPS2 atp[c] + gln_L[c] + h2o[c] + xmp[c] -> amp[c] + glu_L[c] + gmp[c] + 2 h[c] + ppi[c] GPDDA2 g3pe[c] + h2o[c] -> etha[c] + glyc3p[c] + h[c] GRTT grdp[c] + ipdp[c] -> frdp[c] + ppi[c] GTHP 2 gthrd[c] + h2o2[c] -> gthox[c] + 2 h2o[c] GTPCI gtp[c] + h2o[c] -> ahdt[c] + for[c] + h[c] GTPCII gtp[c] + 3 h2o[c] -> 25dhpp[c] + for[c] + 2 h[c] + ppi[c] GTPDPK atp[c] + gtp[c] -> amp[c] + gdptp[c] + h[c] H2CO3D co2[c] + h2o[c] <=> h[c] + hco3[c] H2Ot h2o[e] <=> h2o[c] HBZOPT 4hbz[c] + octdp[c] -> 3ophb[c] + ppi[c] HDG3PACT glyc3p[c] + ihdcoa[c] <=> 1hdecg3p[c] + coa[c] HEMEti atp[c] + h2o[c] + pheme[e] -> adp[c] + h[c] + pheme[c] + pi[c] HETT hepdp[c] + ipdp[c] -> octdp[c] + ppi[c] HETZK 4mhetz[c] + atp[c] -> 4mpetz[c] + adp[c] + h[c] HEX1 atp[c] + glc_D[c] -> adp[c] + g6p[c] + h[c] HEX7 atp[c] + fru[c] -> adp[c] + f6p[c] + h[c] HEXSabc atp[c] + h2o[c] + hexs[e] -> adp[c] + h[c] + hexs[c] + pi[c] HEXTT hexdp[c] + ipdp[c] -> hepdp[c] + ppi[c] HEXb atp[c] + glc_bD[c] -> adp[c] + g6p_B[c] + h[c] HG2abc atp[c] + h2o[c] + hg2[c] -> adp[c] + h[c] + hg2[e] + pi[c] HISTDOX histd[c] + nad[c] <=> h[c] + histl_L[c] + nadh[c] HISTLOX h2o[c] + histl_L[c] + nad[c] -> 2 h[c] + his_L[c] + nadh[c] HISTP h2o[c] + hisp[c] -> histd[c] + pi[c] HISabc atp[c] + h2o[c] + his_L[e] -> adp[c] + h[c] + his_L[c] + pi[c] HISt2r h[e] + his_L[e] <=> h[c] + his_L[c] HMBS h2o[c] + 4 ppbng[c] -> hmbil[c] + 4 nh4[c] HPPK 2ahhmp[c] + atp[c] -> 2ahhmd[c] + amp[c] + h[c] HSDx hom_L[c] + nad[c] <=> aspsa[c] + h[c] + nadh[c] HSDy hom_L[c] + nadp[c] <=> aspsa[c] + h[c] + nadph[c] HSK atp[c] + hom_L[c] -> adp[c] + h[c] + phom[c] HSST hom_L[c] + succoa[c] -> coa[c] + suchms[c] HSTPTr akg[c] + hisp[c] <=> glu_L[c] + imacp[c] HYXNt hxan[e] <=> hxan[c] IAHDGK 12daihdglyc[c] + atp[c] -> adp[c] + h[c] + paai17[c] IBCOATA ACP[c] + ibcoa[c] <=> 2mpropACP[c] + coa[c] ICHORS chor[c] <=> ichor[c] IG3PS gln_L[c] + prlp[c] -> aicar[c] + eig3p[c] + glu_L[c] + h[c] IGPDH eig3p[c] -> h2o[c] + imacp[c] IGPS 2cpr5p[c] + h[c] -> 3ig3p[c] + co2[c] + h2o[c] IHDCOATA 14mpentdecACP[c] + coa[c] <=> ACP[c] + ihdcoa[c] IHDUDPG m12dihglyc[c] + udpg[c] <=> diglcpgi17[c] + h[c] + udp[c] IHDUDPMG 12dihdglyc[c] + udpg[c] <=> h[c] + m12dihglyc[c] + udp[c] IHPDCOATA 15mpalmACP[c] + coa[c] <=> ACP[c] + ihpdcoa[c] ILETA akg[c] + ile_L[c] <=> 3mop[c] + glu_L[c] ILEabc atp[c] + h2o[c] + ile_L[e] -> adp[c] + h[c] + ile_L[c] + pi[c] ILEt2r h[e] + ile_L[e] <=> h[c] + ile_L[c] IMPC h2o[c] + imp[c] <=> fprica[c] IMPD h2o[c] + imp[c] + nad[c] -> h[c] + nadh[c] + xmp[c] IPDCOATA 13mmyrsACP[c] + coa[c] <=> ACP[c] + ipdcoa[c] IPDDI ipdp[c] <=> dmpp[c] IPDPS h2mb4p[c] + h[c] + nadh[c] -> h2o[c] + ipdp[c] + nad[c] IPDPS2 h2mb4p[c] + h[c] + nadph[c] -> h2o[c] + ipdp[c] + nadp[c] IPMDr 3c2hmp[c] + nad[c] <=> 3c4mop[c] + h[c] + nadh[c] IPPMIa 3c2hmp[c] <=> 2ippm[c] + h2o[c] IPPMIb 2ippm[c] + h2o[c] <=> 3c3hmp[c] ISETACabc atp[c] + h2o[c] + isetac[e] -> adp[c] + h[c] + isetac[c] + pi[c] ITDCOATA 12mtridecACP[c] + coa[c] <=> ACP[c] + itdcoa[c] IVCOATA ACP[c] + ivcoa[c] <=> 3mbutACP[c] + coa[c] KARA1 23dhmb[c] + nadp[c] <=> alac_S[c] + h[c] + nadph[c] KARA3 23dhmb[c] + nadp[c] <=> 33hmeoxobut[c] + h[c] + nadph[c] KAS14 acACP[c] + h[c] + malACP[c] -> ACP[c] + actACP[c] + co2[c] Kt3r h[e] + k[c] <=> h[c] + k[e] L2A6ODs l2a6o[c] -> h2o[c] + h[c] + thdp[c] LARGNAT Largn[c] + oaa[c] <=> asp_L[c] + pphn[c] LCYSTabc Lcyst[e] + atp[c] + h2o[c] -> Lcyst[c] + adp[c] + h[c] + pi[c] LDH_L lac_L[c] + nad[c] <=> h[c] + nadh[c] + pyr[c] LEUTA akg[c] + leu_L[c] <=> 4mop[c] + glu_L[c] LEUabc atp[c] + h2o[c] + leu_L[e] -> adp[c] + h[c] + leu_L[c] + pi[c] LEUt2r h[e] + leu_L[e] <=> h[c] + leu_L[c] LPLIPAL1A120 1ddecg3p[c] + h2o[c] -> ddca[c] + glyc3p[c] + h[c] LPLIPAL1A140 1tdecg3p[c] + h2o[c] -> glyc3p[c] + h[c] + ttdca[c] LPLIPAL1A141 1tdec7eg3p[c] + h2o[c] -> glyc3p[c] + h[c] + ttdcea[c] LPLIPAL1A160 1hdecg3p[c] + h2o[c] -> glyc3p[c] + h[c] + hdca[c] LPLIPAL1A161 1hdec9eg3p[c] + h2o[c] -> glyc3p[c] + h[c] + hdcea[c] LPLIPAL1A180 1odecg3p[c] + h2o[c] -> glyc3p[c] + h[c] + ocdca[c] LPLIPAL1A181 1odec11eg3p[c] + h2o[c] -> glyc3p[c] + h[c] + ocdcea[c] LPLIPAL1E120 1agpe120[c] + h2o[c] -> ddca[c] + g3pe[c] + h[c] LPLIPAL1E140 1agpe140[c] + h2o[c] -> g3pe[c] + h[c] + ttdca[c] LPLIPAL1E141 1agpe141[c] + h2o[c] -> g3pe[c] + h[c] + ttdcea[c] LPLIPAL1E160 1agpe160[c] + h2o[c] -> g3pe[c] + h[c] + hdca[c] LPLIPAL1E161 1agpe161[c] + h2o[c] -> g3pe[c] + h[c] + hdcea[c] LPLIPAL1E180 1agpe180[c] + h2o[c] -> g3pe[c] + h[c] + ocdca[c] LPLIPAL1E181 1agpe181[c] + h2o[c] -> g3pe[c] + h[c] + ocdcea[c] LPLIPAL1G120 1agpg120[c] + h2o[c] -> ddca[c] + g3pg[c] + h[c] LPLIPAL1G140 1agpg140[c] + h2o[c] -> g3pg[c] + h[c] + ttdca[c] LPLIPAL1G141 1agpg141[c] + h2o[c] -> g3pg[c] + h[c] + ttdcea[c] LPLIPAL1G160 1agpg160[c] + h2o[c] -> g3pg[c] + h[c] + hdca[c] LPLIPAL1G161 1agpg161[c] + h2o[c] -> g3pg[c] + h[c] + hdcea[c] LPLIPAL1G180 1agpg180[c] + h2o[c] -> g3pg[c] + h[c] + ocdca[c] LPLIPAL1G181 1agpg181[c] + h2o[c] -> g3pg[c] + h[c] + ocdcea[c] LPLIPAL2A120 2ddecg3p[c] + h2o[c] -> ddca[c] + glyc3p[c] + 2 h[c] LPLIPAL2A140 2tdecg3p[c] + h2o[c] -> glyc3p[c] + 2 h[c] + ttdca[c] LPLIPAL2A141 2tdec7eg3p[c] + h2o[c] -> glyc3p[c] + 2 h[c] + ttdcea[c] LPLIPAL2A160 2hdecg3p[c] + h2o[c] -> glyc3p[c] + 2 h[c] + hdca[c] LPLIPAL2A161 2hdec9eg3p[c] + h2o[c] -> glyc3p[c] + 2 h[c] + hdcea[c] LPLIPAL2A180 2odecg3p[c] + h2o[c] -> glyc3p[c] + 2 h[c] + ocdca[c] LPLIPAL2A181 2odec11eg3p[c] + h2o[c] -> glyc3p[c] + 2 h[c] + ocdcea[c] LPLIPAL2E120 2agpe120[c] + h2o[c] -> ddca[c] + g3pe[c] + h[c] LPLIPAL2E140 2agpe140[c] + h2o[c] -> g3pe[c] + h[c] + ttdca[c] LPLIPAL2E141 2agpe141[c] + h2o[c] -> g3pe[c] + h[c] + ttdcea[c] LPLIPAL2E160 2agpe160[c] + h2o[c] -> g3pe[c] + h[c] + hdca[c] LPLIPAL2E161 2agpe161[c] + h2o[c] -> g3pe[c] + h[c] + hdcea[c] LPLIPAL2E180 2agpe180[c] + h2o[c] -> g3pe[c] + h[c] + ocdca[c] LPLIPAL2E181 2agpe181[c] + h2o[c] -> g3pe[c] + h[c] + ocdcea[c] LPLIPAL2G120 2agpg120[c] + h2o[c] -> ddca[c] + g3pg[c] + h[c] LPLIPAL2G140 2agpg140[c] + h2o[c] -> g3pg[c] + h[c] + ttdca[c] LPLIPAL2G141 2agpg141[c] + h2o[c] -> g3pg[c] + h[c] + ttdcea[c] LPLIPAL2G160 2agpg160[c] + h2o[c] -> g3pg[c] + h[c] + hdca[c] LPLIPAL2G161 2agpg161[c] + h2o[c] -> g3pg[c] + h[c] + hdcea[c] LPLIPAL2G180 2agpg180[c] + h2o[c] -> g3pg[c] + h[c] + ocdca[c] LPLIPAL2G181 2agpg181[c] + h2o[c] -> g3pg[c] + h[c] + ocdcea[c] LYSt3r h[e] + lys_L[c] <=> h[c] + lys_L[e] L_LACD2 lac_L[c] + q8[c] -> pyr[c] + q8h2[c] L_LACD3 lac_L[c] + mqn8[c] -> mql8[c] + pyr[c] L_LACDr 2 ficytC[c] + lac_L[c] <=> 2 focytC[c] + 2 h[c] + pyr[c] MADGBG h2o[c] + madg[c] <=> glc_D[c] + meoh[c] MALTpts malt[e] + pep[c] -> malt6p[c] + pyr[c] MANpts man[e] + pep[c] -> man6p[c] + pyr[c] MBDGBG h2o[c] + mbdg[c] <=> glc_D[c] + meoh[c] MCOATA ACP[c] + malcoa[c] <=> coa[c] + malACP[c] MDDCP1 h2o[c] + murein5px4p[c] <=> ala_D[c] + murein4px4p[c] MDDCP4 h2o[c] + murein5p4p[c] <=> ala_D[c] + murein4p4p[c] MDDEP1 h2o[c] + murein4px4p[c] <=> murein4p4p[c] MDDEP4 h2o[c] + murein4px4px4p[c] <=> murein4px4p4p[c] ME2 mal_L[c] + nadp[c] -> co2[c] + nadph[c] + pyr[c] MECDPDH2 2mecdp[c] + nadh[c] -> h2mb4p[c] + h2o[c] + nad[c] MECDPS 2p4c2me[c] -> 2mecdp[c] + cmp[c] MEPCT 2me4p[c] + ctp[c] + h[c] -> 4c2me[c] + ppi[c] METALA1c h2o[c] + metala[c] <=> ala_L[c] + met_L[c] METALAabc atp[c] + h2o[c] + metala[e] -> adp[c] + h[c] + metala[c] + pi[c] METATr atp[c] + h2o[c] + met_L[c] <=> amet[c] + pi[c] + ppi[c] METDabc atp[c] + h2o[c] + met_D[e] -> adp[c] + h[c] + met_D[c] + pi[c] METFR 5mthf[c] + nadp[c] <=> 2 h[c] + mlthf[c] + nadph[c] METSOX1abc atp[c] + h2o[c] + metsox_S_L[e] -> adp[c] + h[c] + metsox_S_L[c] + pi[c] METSOX2abc atp[c] + h2o[c] + metsox_R_L[e] -> adp[c] + h[c] + metsox_R_L[c] + pi[c] METSr 5mthf[c] + hcys_L[c] <=> h[c] + met_L[c] + thf[c] METabc atp[c] + h2o[c] + met_L[e] -> adp[c] + h[c] + met_L[c] + pi[c] METt2r h[e] + met_L[e] <=> h[c] + met_L[c] MG2abc atp[c] + h2o[c] + mg2[e] -> adp[c] + h[c] + mg2[c] + pi[c] MGSA dhap[c] -> mthgxl[c] + pi[c] MGt5 mg2[c] <=> mg2[e] MNLpts mnl[e] + pep[c] -> mnl1p[c] + pyr[c] MNt2 h[e] + mn2[e] -> h[c] + mn2[c] MOBDabc atp[c] + h2o[c] + mobd[e] -> adp[c] + h[c] + mobd[c] + pi[c] MOPSabc atp[c] + h2o[c] + mops[e] -> adp[c] + h[c] + mops[c] + pi[c] MSO3abc atp[c] + h2o[c] + mso3[e] -> adp[c] + h[c] + mso3[c] + pi[c] MTAN 5mta[c] + h2o[c] -> 5mtr[c] + ade[c] MTHFC h2o[c] + methf[c] <=> 10fthf[c] + h[c] MTHFD mlthf[c] + nadp[c] <=> methf[c] + nadph[c] NACUP nac[e] -> nac[c] NADDP h2o[c] + nad[c] -> amp[c] + 2 h[c] + nmn[c] NADH6 4.5 h[c] + nadh[c] + q8[c] -> 3.5 h[e] + nad[c] + q8h2[c] NADH7 3 h[c] + mqn8[c] + nadh[c] -> 2 h[e] + mql8[c] + nad[c] NADH8 2dmmq8[c] + 3.8 h[c] + nadh[c] -> 2dmmql8[c] + 2.8 h[e] + nad[c] NADK atp[c] + nad[c] -> adp[c] + h[c] + nadp[c] NADK2 dttp[c] + nad[c] -> dtdp[c] + h[c] + nadp[c] NADS1 atp[c] + dnad[c] + nh4[c] -> amp[c] + h[c] + nad[c] + ppi[c] NADS2 atp[c] + dnad[c] + gln_L[c] + h2o[c] -> amp[c] + glu_L[c] + h[c] + nad[c] + ppi[c] NAPRT h[c] + nac[c] + prpp[c] -> nicrnt[c] + ppi[c] NDPK1 atp[c] + gdp[c] <=> adp[c] + gtp[c] NDPK2 atp[c] + udp[c] <=> adp[c] + utp[c] NDPK3 atp[c] + cdp[c] <=> adp[c] + ctp[c] NH4tb nh4[e] <=> nh4[c] NNATr atp[c] + h[c] + nicrnt[c] -> dnad[c] + ppi[c] NNDMBRT dmbzid[c] + nicrnt[c] -> 5prdmbz[c] + h[c] + nac[c] NNDPR 2 h[c] + prpp[c] + quln[c] -> co2[c] + nicrnt[c] + ppi[c] NPHS sbzcoa[c] -> coa[c] + dhna[c] NTP3 gtp[c] + h2o[c] -> gdp[c] + h[c] + pi[c] NTPTP1 dgtp[c] + h2o[c] -> dgsn[c] + pppi[c] O2t5i o2[e] -> o2[c] OAASr cit[c] + coa[c] + h[c] <=> accoa[c] + h2o[c] + oaa[c] OBTFL 2obut[c] + coa[c] -> for[c] + ppcoa[c] OCBT cbp[c] + orn[c] <=> citr_L[c] + h[c] + pi[c] OCDCAt2 h[e] + ocdca[e] -> h[c] + ocdca[c] OHPBAT glu_L[c] + ohpb[c] <=> akg[c] + phthr[c] OHPHM 2ohph[c] + amet[c] -> 2omph[c] + ahcys[c] + h[c] OIVD1r 4mop[c] + coa[c] + nad[c] <=> co2[c] + ivcoa[c] + nadh[c] OIVD3 3mop[c] + coa[c] + nad[c] -> 2mbcoa[c] + co2[c] + nadh[c] OMPDC h[c] + orot5p[c] -> co2[c] + ump[c] OPHBDC 3ophb[c] + h[c] -> 2oph[c] + co2[c] OPHHX 2oph[c] + 0.5 o2[c] -> 2ohph[c] ORNTAC acorn[c] + glu_L[c] <=> acglu[c] + orn[c] OROTPT orot[c] + prpp[c] -> orot5p[c] + ppi[c] P1CM amet[c] + pre1[c] <=> ahcys[c] + dscl[c] P5CRyr nadp[c] + pro_L[c] <=> 1pyr5c[c] + 2 h[c] + nadph[c] PAI17P h2o[c] + pai17[c] -> 12dihdglyc[c] + pi[c] PAPA180 h2o[c] + pa180[c] -> 12dgr180[c] + pi[c] PAPPT2 uGgla[c] + udcpp[c] -> uaGgla[c] + ump[c] PAPPT3 udcpp[c] + ugmda[c] -> uagmda[c] + ump[c] PBt atp[c] + h2o[c] + pb[c] -> adp[c] + h[c] + pb[e] + pi[c] PC11M amet[c] + pre4[c] -> ahcys[c] + h[c] + pre5[c] PC17M amet[c] + pre3b[c] -> ahcys[c] + 3 h[c] + pre4[c] PC20M amet[c] + dscl[c] -> ahcys[c] + h[c] + pre3a[c] PC8XM h[c] + pre8[c] -> hgbyr[c] PDHc dhlam[c] + nad[c] -> h[c] + lpam[c] + nadh[c] PEPGLY PGPm1[c] + h[c] + uaagmda[c] -> PGP[c] + co2[c] + udcpdp[c] PFK atp[c] + f6p[c] -> adp[c] + fdp[c] + h[c] PFK_2 atp[c] + tag6p_D[c] -> adp[c] + h[c] + tagdp_D[c] PFK_3 atp[c] + s7p[c] -> adp[c] + h[c] + s17bp[c] PFL coa[c] + pyr[c] -> accoa[c] + for[c] PGAMT gam1p[c] <=> gam6p[c] PGCDr 3pg[c] + nad[c] <=> 3php[c] + h[c] + nadh[c] PGI g6p[c] <=> f6p[c] PGK 3pg[c] + atp[c] <=> 13dpg[c] + adp[c] PGLYCP 2pglyc[c] + h2o[c] -> glyclt[c] + pi[c] PGM 2pg[c] <=> 3pg[c] PGPGT prl45tca[c] + 45 udpg[c] <=> 45 h[c] + prl45tcaglc[c] + 45 udp[c] PGPP120 h2o[c] + pgp120[c] -> pg120[c] + pi[c] PGPP140 h2o[c] + pgp140[c] -> pg140[c] + pi[c] PGPP141 h2o[c] + pgp141[c] -> pg141[c] + pi[c] PGPP160 h2o[c] + pgp160[c] -> pg160[c] + pi[c] PGPP161 h2o[c] + pgp161[c] -> pg161[c] + pi[c] PGPP180 h2o[c] + pgp180[c] -> pg180[c] + pi[c] PGPP181 h2o[c] + pgp181[c] -> pg181[c] + pi[c] PGPPAI15 h2o[c] + pgpai15[c] -> pgai15[c] + pi[c] PGPPAI17 h2o[c] + pgpai17[c] -> pgai17[c] + pi[c] PGPPI14 h2o[c] + pgpi14[c] -> pgi14[c] + pi[c] PGPPI15 h2o[c] + pgpi15[c] -> pgi15[c] + pi[c] PGPPI16 h2o[c] + pgpi16[c] -> pgi16[c] + pi[c] PGPPI17 h2o[c] + pgpi17[c] -> pgi17[c] + pi[c] PGSA120 cdpdddecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp120[c] PGSA140 cdpdtdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp140[c] PGSA141 cdpdtdec7eg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp141[c] PGSA160 cdpdhdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp160[c] PGSA161 cdpdhdec9eg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp161[c] PGSA180 cdpdodecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp180[c] PGSA181 cdpdodec11eg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp181[c] PGSAAI15 cdpdaipdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpai15[c] PGSAAI17 cdpdaihpdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpai17[c] PGSAI14 cdpditdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpi14[c] PGSAI15 cdpdipdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpi15[c] PGSAI16 cdpdihdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpi16[c] PGSAI17 cdpdihpdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpi17[c] PHETA1 akg[c] + phe_L[c] <=> glu_L[c] + phpyr[c] PHEt2r h[e] + phe_L[e] <=> h[c] + phe_L[c] PIt7 3 na1[e] + pi[e] <=> 3 na1[c] + pi[c] PLIPA1E180rev 2agpe180[c] + h[c] + ocdca[c] -> h2o[c] + pe180[c] PLPS g3p[c] + gln_L[c] + ru5p_D[c] -> glu_L[c] + 3 h2o[c] + h[c] + pi[c] + pydx5p[c] PMANM man1p[c] <=> man6p[c] PMTCOATA coa[c] + palmACP[c] <=> ACP[c] + pmtcoa[c] PNTK atp[c] + pnto_R[c] -> 4ppan[c] + adp[c] + h[c] PNTOt2 h[e] + pnto_R[e] <=> h[c] + pnto_R[c] POR4 accoa[c] + co2[c] + fdxrd[c] <=> coa[c] + fdxox[c] + h[c] + pyr[c] PPA h2o[c] + ppi[c] -> h[c] + 2 pi[c] PPAKr adp[c] + ppap[c] <=> atp[c] + ppa[c] PPBNGS 2 5aop[c] -> 2 h2o[c] + h[c] + ppbng[c] PPCDC 4ppcys[c] + h[c] -> co2[c] + pan4p[c] PPCKr atp[c] + oaa[c] <=> adp[c] + co2[c] + pep[c] PPNCL3 4ppan[c] + atp[c] + cys_L[c] -> 4ppcys[c] + amp[c] + h[c] + ppi[c] PPND nad[c] + pphn[c] -> 34hpp[c] + co2[c] + nadh[c] PPND2 nadp[c] + pphn[c] -> 34hpp[c] + co2[c] + nadph[c] PPNDH h[c] + pphn[c] -> co2[c] + h2o[c] + phpyr[c] PPS atp[c] + h2o[c] + pyr[c] -> amp[c] + 2 h[c] + pep[c] + pi[c] PPTT ipdp[c] + pendp[c] -> hexdp[c] + ppi[c] PRAGS atp[c] + gly[c] + pram[c] -> adp[c] + gar[c] + h[c] + pi[c] PRAI pran[c] <=> 2cpr5p[c] PRAIS atp[c] + fpram[c] -> adp[c] + air[c] + 2 h[c] + pi[c] PRAMPC h2o[c] + prbamp[c] -> prfp[c] PRASCSi 5aizc[c] + asp_L[c] + atp[c] -> 25aics[c] + adp[c] + h[c] + pi[c] PRATPP h2o[c] + prbatp[c] -> h[c] + ppi[c] + prbamp[c] PRFGS atp[c] + fgam[c] + gln_L[c] + h2o[c] -> adp[c] + fpram[c] + glu_L[c] + h[c] + pi[c] PRMICI prfp[c] <=> prlp[c] PRO1x nad[c] + pro_L[c] -> 1pyr5c[c] + 2 h[c] + nadh[c] PROTRS atp[c] + pro_L[c] + trnapro[c] -> amp[c] + ppi[c] + protrna[c] PROt2r h[e] + pro_L[e] <=> h[c] + pro_L[c] PROt4r na1[e] + pro_L[e] <=> na1[c] + pro_L[c] PRPPS atp[c] + r5p[c] <=> amp[c] + h[c] + prpp[c] PSCVT pep[c] + skm5p[c] <=> 3psme[c] + pi[c] PSDAI17 h[c] + psai17[c] -> co2[c] + peai17[c] PSDI17 h[c] + psi17[c] -> co2[c] + pei17[c] PS...

Inspection of the output of the pipeline

Let us have a look at the results of the pipeline run. The refined reconstruction in mat format are located in the folder "RefinedReconstructions", and in SBML format in "RefinedReconstructions_SBML". The folder "TranslatedDraftReconstructions" contains the draft reconstructions with exchange reactions translated (no other changes were made to this version). The folder "RefinementSummary" contains a detailed overview of the gap-filling and expansion performed for each refined reconstruction. If the files "untranslatedMets.txt" and "untranslatedRxns.txt", are present and contain any entries, it is recommended to translate these metabolites and/or reactions. Go to Part 2.3 for more details.

2.2. Testing the refined reconstructions

DEMETER includes a comprehensive test suite that was developed to ensure good quality and agreement with known metabolic traits of the reconstructed strains in AGORA2 [3].
To run the test suite, enter the code.
[testResultsFolder,curationReport] = runTestSuiteTools(refinedFolder, infoFilePath, inputDataFolder, reconVersion, 'translatedDraftsFolder', translatedDraftsFolder, 'numWorkers', numWorkers);
Warning: Directory already exists.
Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Model grows on unlimited media (aerobic), flux through BOF: 3.397560e+01 mmol/gDW/h Model grows on unlimited media (aerobic), flux through BOF: 4.867244e+01 mmol/gDW/h Model grows on unlimited media (aerobic), flux through BOF: 3.981277e+01 mmol/gDW/h Model grows on unlimited media (aerobic), flux through BOF: 6.761999e+01 mmol/gDW/h Warning: Model cannot grow on unlimited media (anaerobic) > In testGrowth (line 72) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ttdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ttdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_akg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_akg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cit(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cit(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_csn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_csn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cytd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cytd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dad_2(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dad_2(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dcyt(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dcyt(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ddca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ddca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dgsn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dgsn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_etoh(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_etoh(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fe3dcit(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fe3dcit(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fum(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fum(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc3p(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc3p(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gsn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gsn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthox(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthox(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthrd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthrd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gua(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gua(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2s(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2s(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hom_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hom_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_indole(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_indole(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ins(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ins(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lac_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lac_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lanost(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lanost(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mal_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mal_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn7(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn7(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ncam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ncam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_nmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_nmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no2(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no2(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no3(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no3(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orot(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orot(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pime(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pime(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydx5p(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydx5p(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydxn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydxn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_q8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_q8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_sel(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_sel(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_sheme(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_sheme(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_succ(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_succ(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thymd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thymd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_urea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_urea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_uri(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_uri(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_duri(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_duri(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_meoh(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_meoh(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Model cannot grow on complex medium (aerobic) > In testGrowth (line 96) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Model cannot grow on complex medium (anaerobic) > In testGrowth (line 112) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Model cannot grow on unlimited media (anaerobic) > In testGrowth (line 72) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ac(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ac(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ala_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ala_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cytd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cytd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dad_2(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dad_2(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dcyt(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dcyt(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Model cannot grow on unlimited media (anaerobic) > In testGrowth (line 72) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds ...
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
Report for draft models: All models are able to produce biomass on rich medium. 10 models are unable to produce biomass on rich medium under anaerobic conditions. 7 models are unable to produce biomass on complex medium. 10 models are unable to produce biomass on complex medium under anaerobic conditions. Report for refined models: All models are able to produce biomass on rich medium. All models are able to produce biomass on rich medium under anaerobic conditions. All models are able to produce biomass on complex medium.
Warning: Directory already exists.
Each model.subSystems{x} is a character array, and this format is retained. Testing flux through the ATP demand reaction Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ttdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ttdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_akg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_akg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cit(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cit(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_csn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_csn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cytd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cytd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dad_2(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dad_2(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dcyt(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dcyt(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ddca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ddca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dgsn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dgsn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_etoh(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_etoh(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fe3dcit(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fe3dcit(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fum(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fum(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc3p(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc3p(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gsn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gsn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthox(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthox(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthrd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthrd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gua(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gua(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2s(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2s(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hom_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hom_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_indole(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_indole(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ins(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ins(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lac_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lac_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lanost(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lanost(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mal_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mal_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn7(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn7(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ncam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ncam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_nmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_nmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no2(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no2(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no3(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no3(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orot(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orot(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pime(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pime(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydx5p(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydx5p(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydxn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydxn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_q8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_q8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_sel(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_sel(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_sheme(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_sheme(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_succ(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_succ(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thymd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thymd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_urea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_urea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_uri(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_uri(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_duri(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_duri(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_meoh(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_meoh(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Aerobic ATP flux on complex medium: 61 mmol/gDW/h Anaerobic ATP flux on complex medium: 1.560000e+01 mmol/gDW/h Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Testing flux through the ATP demand reaction Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ac(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ac(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Testing flux through the ATP demand reaction Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 83...
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
Report for draft models: 3 models produce too much ATP under aerobic conditions. 3 models produce too much ATP under anaerobic conditions. Report for refined models: All models produce reasonable amounts of ATP under aerobic conditions. All models produce reasonable amounts of ATP under anaerobic conditions. > changeCobraSolver: Gurobi interface added to MATLAB path. > changeCobraSolver: Gurobi interface added to MATLAB path. > changeCobraSolver: Gurobi interface added to MATLAB path. > changeCobraSolver: Gurobi interface added to MATLAB path.
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
Finished refinement and testing of the project TutorialExample. 10 draft reconstructions have been refined. Growth requirements were refined for 6 reconstructions. 83.33 % of reconstructions agree with all known media.

Biomass production

Test and plot whether all reconstructions can produce reasonable amounts of biomass on the Western diet and on "rich" medium (consisting of every metabolite the model can consume) aerobically and anaerobically.
You can see that for the examples, all refined reconstructions produce biomass under anaerobic conditions and on Western diet while no draft reconstruction can grow anaerobically. If the refined reconstructions for your own organisms are unable to produce biomass under any conditions, proceed to Step 2.3 of the pipeline.

ATP production

% Test and plot whether all reconstructions produce reasonable amounts of ATP on the Western diet aerobically and anaerobically.
You can see that for the examples, all refined reconstructions produce realistic amounts of ATP on Western diet while the draft reconstructions produce near unlimited amounts of ATP. If the refined reconstructions for your own organisms produce too much ATP, proceed to Step 2.3 of the pipeline below.

QC/QA and test against available experimental and comparative genomic data

The variable curationReport contains a summary of the results of performed quality control and quality assurance tests.
The folder "TestResults" contains information on tests against the available experimental data that passed or failed the test suite. Carefully inspect these results. If there are any false negative predictions for your organism(s), proceed to Step 2.3 of the pipeline below.
To view the results for the tutorial example, run the following code.
Sensitivity of reconstructions for capturing the experimental data
testResults1 = readtable([testResultsFolder filesep reconVersion '_refined' filesep 'TutorialExample_Properties.xls'], 'ReadVariableNames', false);
testResults1 = table2cell(testResults1);
Fraction of refined reconstructions that agree with all experimental data
testResults2 = readtable([testResultsFolder filesep reconVersion '_refined' filesep 'TutorialExample_PercentagesAgreement.xls'], 'ReadVariableNames', false);
testResults2 = table2cell(testResults2);
The test suite also reports any cases of leaking metabolites, mass- and charge-imbalanced reactions, incorrectly formulated gene rules. Inspect these cases. Note that some mass- and charge-imbalanced reactions currently cannot be corrected.

2.3. Debugging the refined reconstructions

2.3.1. Translation from KBase to VMH nomenclature

For the tutorial example, all metabolites and reactions have been translated. For your own reconstructions, check the files "untranslatedMets.txt" and "untranslatedRxns.txt", if present, for any KBase metabolites and reactions that are not yet translated to VMH nomenclature. This requires the reconstruction tool rBioNet [6]. To prepare the use of rBioNet, run the function
createRBioNetDBFromVMHDB

Translating metabolites

If the files 'untranslatedMets.txt' contains metabolites, run the code
if isfile([summaryFolder filesep 'untranslatedMets.txt'])
[translatedMets]=translateKBaseToVMHMets('untranslatedMets.txt');
end
Carefully inspect the output 'translatedMets.txt'. If you are satisfied with the translation, add the KBase IDs with the corresponding VMH IDs to the file cobratoolbox/papers/2021_demeter/input/MetaboliteTranslationTable.txt.
Metabolites that could not be translated this way will need to be inspected manually. Try finding them in the VMH database by consulting KEGG (https://www.genome.jp/kegg) [7] or HMDB (https://hmdb.ca) [8] IDs. For metabolites that are not yet present in the VMH database, formulate a metabolite ID following the standards of the field as described in Thiele and Palsson [9]. Afterwards, add the new metabolites to the file cobratoolbox/papers/2021_demeter/input/MetaboliteDatabase.txt while ensuring that the format of the file is kept. Also add the KBase to VMH metabolite translation to the file cobratoolbox/papers/2021_demeter/input/MetaboliteTranslationTable.txt.

Translating reactions

If the files 'untranslatedRxns.txt' contains reactions, run the code
if isfile([summaryFolder filesep 'untranslatedRxns.txt'])
[translatedRxns]=propagateKBaseMetTranslationToRxns('untranslatedRxns.txt');
end
When translated from KBase to VMH nomenclature, some reactions will afterwards be mass-and charge-imbalanced. Especially the proton in the reaction will need to be adjusted.To test if any translated reactions are now unbalanced, use the reconstruction tool rBioNet [6].
Afterwards, run the command
ReconstructionTool
This opens an interface. Choose File -> Add Text File -> With Reactions -> Load text file.
Choose the text file translatedRxns.txt that was just generated. When it says "Metabolites not in Database", choose Yes. When it says "Unbalanced reactions", carefully inspect every reaction with unbalance charge or atoms. Adjust the formulas in the file translatedRxns.txt accordingly and save the file afterwards. Note that some mass- and charge-imbalanced reactions currently cannot be corrected.
Now we will check if the mass-and charge-balanced but untranslated reactions are already present in the VMH database but not yet translated. To check which of the translated reactions are already present in the VMH reaction database, run the function
if isfile('translatedRxns.txt')
[sameReactions,similarReactions] = mapKBaseToVMHReactions('translatedRxns.txt');
end
After verifying the content of the output variable sameReactions, add the KBase reaction IDs with the corresponding VMH reaction IDs to the file cobratoolbox/papers/2021_demeter/input/ReactionTranslationTable.txt
Note that multiple KBase reactions may translate to the same VMH reaction. Now inspect the content of the output variable similarReactions. Typically, this will contain reactions that are reversible in KBase but irreversible in VMH. It is optional but recommended that you also add these reactions to ReactionTranslationTable.txt.
For reactions that are not yet present in the VMH database, formulate a reaction ID following the standards of the field as described in Thiele and Palsson [9]. Import the reactions in ReconstructionTool as described above to ensure they are mass-and charge-balanced. Afterwards, add the new reactions to the file cobratoolbox/papers/2021_demeter/input/ReactionDatabase.txt
while ensuring that the format of the file is kept. Also assign subsystems to the reactions following the existing nomenclature in the database. Also add the KBase to VMH reaction translation to cobratoolbox/papers/2021_demeter/input/ReactionTranslationTable.txt.

2.3.2 Debugging the reconstructions

After performing the data-driven refinement, there may still be reconstructions that cannot grow anaerobically and/or on Western diet, produce unrealistic amounts of ATP on Western diet, or do not agree with experimental data. Since DEMETER was built on the principle of inspecting patterns of reactions across many reconstructions, there may still be reconstructions (especially of non-gut organisms) with previously unobserved patterns that are not yet caught by the gap-filling functions in DEMETER.
Too inspect and attempt to correct these reconstructions, a suite of debugging tools is available. The suite will gap-fill the reconstructions that fail tests and re-test them afterwards.
To run the debugging suite, enter the code
[debuggingReport, fixedModels, failedModels]=runDebuggingTools(refinedFolder,testResultsFolder,inputDataFolder,reconVersion,'numWorkers',numWorkers);
Starting parallel pool (parpool) using the 'local' profile ... Connected to the parallel pool (number of workers: 4). ans = Pool with properties: Connected: true NumWorkers: 4 Cluster: local AttachedFiles: {} AutoAddClientPath: true IdleTimeout: 30 minutes (30 minutes remaining) SpmdEnabled: true Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. bio1 0.0071953 10fthf[c] + 0.0071953 2dmmq8[c] + 0.0071953 5mthf[c] + 0.0071953 ACP[c] + 0.0018061 PGP[c] + 0.0071953 adocbl[c] + 0.0018061 ai17tca1[c] + 0.0018061 ai17tcaacgam[c] + 0.0018061 ai17tcaala_D[c] + 0.0018061 ai17tcaglc[c] + 0.26756 ala_L[c] + 0.0071953 amet[c] + 0.1934 arg_L[c] + 0.14833 asn_L[c] + 0.14833 asp_L[c] + 41.2914 atp[c] + 0.0071953 btn[c] + 0.0071953 ca2[c] + 0.0071953 cl[c] + 0.0085871 clpn180[c] + 0.0085871 clpnai17[c] + 0.0085871 clpni17[c] + 0.0071953 coa[c] + 0.0071953 cobalt2[c] + 0.026124 ctp[c] + 0.0071953 cu2[c] + 0.056954 cys_L[c] + 0.017622 datp[c] + 0.0092556 dctp[c] + 0.0092556 dgtp[c] + dnarep[c] + 0.017622 dttp[c] + 0.0071953 fad[c] + 0.0071953 fe2[c] + 0.0071953 fe3[c] + 0.0071953 fmn[c] + 0.261 gln_L[c] + 0.261 glu_L[c] + 0.40933 gly[c] + 0.0018061 glyc45tca[c] + 0.0018061 glyc45tcaala_D[c] + 0.0018061 glyc45tcaglc[c] + 0.0071953 gthrd[c] + 0.042403 gtp[c] + 41.257 h[c] + 0.081948 his_L[c] + 0.0018061 i17tca1[c] + 0.0018061 i17tcaacgam[c] + 0.0018061 i17tcaala_D[c] + 0.0018061 i17tcaglc[c] + 0.27043 ile_L[c] + 0.0071953 k[c] + 0.34746 leu_L[c] + 0.3237 lys_L[c] + 0.1135 met_L[c] + 0.0071953 mg2[c] + 0.0071953 mn2[c] + 0.0071953 mqn8[c] + 0.0071953 nad[c] + 0.0071953 nadp[c] + 0.0085871 pe180[c] + 0.0085871 peai17[c] + 0.0085871 pei17[c] + 0.0085871 pg180[c] + 0.0085871 pgai17[c] + 0.0085871 pgi17[c] + 0.17619 phe_L[c] + 0.0071953 pheme[c] + 0.16103 pro_L[c] + proteinsynth[c] + 0.0071953 ptrc[c] + 0.0071953 pydx5p[c] + 0.0071953 q8[c] + 0.0071953 ribflv[c] + rnatrans[c] + 0.21675 ser_L[c] + 0.0071953 sheme[c] + 0.0071953 so4[c] + 0.0071953 spmd[c] + 0.0018061 sttca1[c] + 0.0018061 sttcaacgam[c] + 0.0018061 sttcaala_D[c] + 0.0018061 sttcaglc[c] + 0.0018061 tcam[c] + 0.0071953 thf[c] + 0.0071953 thmpp[c] + 0.18684 thr_L[c] + 0.054496 trp_L[c] + 0.11104 tyr_L[c] + 0.0071953 uacgam[c] + 0.0018061 udcpdp[c] + 0.028225 utp[c] + 0.30772 val_L[c] + 0.0071953 zn2[c] -> 0.0072242 PGPm1[c] + 41.257 adp[c] + 0.0071953 apoACP[c] + biomass[c] + 0.0071953 cbi[c] + 0.0071953 dmbzid[c] + 45.354 h2o[c] + 41.2498 pi[c] + 0.1849 ppi[c] Adding the following Metabolites to the model: bio1 0.0071953 10fthf[c] + 0.0071953 2dmmq8[c] + 0.0071953 5mthf[c] + 0.0071953 ACP[c] + 0.0018061 PGP[c] + 0.0071953 adocbl[c] + 0.0018061 ai17tca1[c] + 0.0018061 ai17tcaacgam[c] + 0.0018061 ai17tcaala_D[c] + 0.0018061 ai17tcaglc[c] + 0.26756 ala_L[c] + 0.0071953 amet[c] + 0.1934 arg_L[c] + 0.14833 asn_L[c] + 0.14833 asp_L[c] + 41.2914 atp[c] + 0.0071953 btn[c] + 0.0071953 ca2[c] + 0.0071953 cl[c] + 0.0085871 clpn180[c] + 0.0085871 clpnai17[c] + 0.0085871 clpni17[c] + 0.0071953 coa[c] + 0.0071953 cobalt2[c] + 0.026124 ctp[c] + 0.0071953 cu2[c] + 0.056954 cys_L[c] + 0.019069 datp[c] + 0.0078106 dctp[c] + 0.0078106 dgtp[c] + dnarep[c] + 0.019069 dttp[c] + 0.0071953 fad[c] + 0.0071953 fe2[c] + 0.0071953 fe3[c] + 0.0071953 fmn[c] + 0.261 gln_L[c] + 0.261 glu_L[c] + 0.40933 gly[c] + 0.0018061 glyc45tca[c] + 0.0018061 glyc45tcaala_D[c] + 0.0018061 glyc45tcaglc[c] + 0.0071953 gthrd[c] + 0.042403 gtp[c] + 41.257 h[c] + 0.081948 his_L[c] + 0.0018061 i17tca1[c] + 0.0018061 i17tcaacgam[c] + 0.0018061 i17tcaala_D[c] + 0.0018061 i17tcaglc[c] + 0.27043 ile_L[c] + 0.0071953 k[c] + 0.34746 leu_L[c] + 0.3237 lys_L[c] + 0.1135 met_L[c] + 0.0071953 mg2[c] + 0.0071953 mn2[c] + 0.0071953 mqn8[c] + 0.0071953 nad[c] + 0.0071953 nadp[c] + 0.0085871 pe180[c] + 0.0085871 peai17[c] + 0.0085871 pei17[c] + 0.0085871 pg180[c] + 0.0085871 pgai17[c] + 0.0085871 pgi17[c] + 0.17619 phe_L[c] + 0.0071953 pheme[c] + 0.16103 pro_L[c] + proteinsynth[c] + 0.0071953 ptrc[c] + 0.0071953 pydx5p[c] + 0.0071953 q8[c] + 0.0071953 ribflv[c] + rnatrans[c] + 0.21675 ser_L[c] + 0.0071953 sheme[c] + 0.0071953 so4[c] + 0.0071953 spmd[c] + 0.0018061 sttca1[c] + 0.0018061 sttcaacgam[c] + 0.0018061 sttcaala_D[c] + 0.0018061 sttcaglc[c] + 0.0018061 tcam[c] + 0.001806 teich_45_BS[c] + 0.0071953 thf[c] + 0.0071953 thmpp[c] + 0.18684 thr_L[c] + 0.054496 trp_L[c] + 0.11104 tyr_L[c] + 0.0071953 uacgam[c] + 0.0018061 udcpdp[c] + 0.001806 udpglcur[c] + 0.028225 utp[c] + 0.30772 val_L[c] + 0.0071953 zn2[c] -> 0.0072242 PGPm1[c] + 41.257 adp[c] + 0.0071953 apoACP[c] + biomass[c] + 0.0071953 cbi[c] + 0.0071953 dmbzid[c] + 45.354 h2o[c] + 41.2498 pi[c] + 0.18491 ppi[c] Adding the following Metabolites to the model: bio1 0.0071953 10fthf[c] + 0.0071953 2dmmq8[c] + 0.0071953 5mthf[c] + 0.0071953 ACP[c] + 0.0018061 PGP[c] + 0.0071953 adocbl[c] + 0.26756 ala_L[c] + 0.0071953 amet[c] + 0.1934 arg_L[c] + 0.14833 asn_L[c] + 0.14833 asp_L[c] + 41.2914 atp[c] + 0.0071953 btn[c] + 0.0071953 ca2[c] + 0.0071953 cl[c] + 0.0085871 clpn180[c] + 0.0085871 clpnai17[c] + 0.0085871 clpni17[c] + 0.0071953 coa[c] + 0.0071953 cobalt2[c] + 0.025039 colipa[c] + 0.026124 ctp[c] + 0.0071953 cu2[c] + 0.056954 cys_L[c] + 0.0089548 datp[c] + 0.017914 dctp[c] + 0.017914 dgtp[c] + dnarep[c] + 0.02504 dtdprmn[c] + 0.0089548 dttp[c] + 0.0071953 fad[c] + 0.0071953 fe2[c] + 0.0071953 fe3[c] + 0.0071953 fmn[c] + 0.261 gln_L[c] + 0.261 glu_L[c] + 0.40933 gly[c] + 0.0071953 gthrd[c] + 0.042403 gtp[c] + 41.257 h[c] + 0.081948 his_L[c] + 0.27043 ile_L[c] + 0.0071953 k[c] + 0.02504 kdo2lipid4L[c] + 0.34746 leu_L[c] + 0.3237 lys_L[c] + 0.1135 met_L[c] + 0.0071953 mg2[c] + 0.0071953 mn2[c] + 0.0071953 mqn8[c] + 0.0071953 nad[c] + 0.0071953 nadp[c] + 0.0085871 pe180[c] + 0.0085871 peai17[c] + 0.0085871 pei17[c] + 0.0085871 pg180[c] + 0.0085871 pgai17[c] + 0.0085871 pgi17[c] + 0.17619 phe_L[c] + 0.0071953 pheme[c] + 0.16103 pro_L[c] + proteinsynth[c] + 0.0071953 ptrc[c] + 0.0071953 pydx5p[c] + 0.0071953 q8[c] + 0.0071953 ribflv[c] + rnatrans[c] + 0.21675 ser_L[c] + 0.0071953 sheme[c] + 0.0071953 so4[c] + 0.0071953 spmd[c] + 0.0071953 thf[c] + 0.0071953 thmpp[c] + 0.18684 thr_L[c] + 0.054496 trp_L[c] + 0.11104 tyr_L[c] + 0.0071953 uacgam[c] + 0.0018061 udcpdp[c] + 0.028225 utp[c] + 0.30772 val_L[c] + 0.0071953 zn2[c] -> 0.0072242 PGPm1[c] + 41.257 adp[c] + 0.0071953 apoACP[c] + biomass[c] + 0.0071953 cbi[c] + 0.0071953 dmbzid[c] + 45.354 h2o[c] + 41.2498 pi[c] + 0.18488 ppi[c] Adding the following Metabolites to the model: bio1 0.0071953 10fthf[c] + 0.0071953 2dmmq8[c] + 0.0071953 5mthf[c] + 0.0071953 ACP[c] + 0.0018061 PGP[c] + 0.0071953 adocbl[c] + 0.26756 ala_L[c] + 0.0071953 amet[c] + 0.1934 arg_L[c] + 0.14833 asn_L[c] + 0.14833 asp_L[c] + 41.2914 atp[c] + 0.0071953 btn[c] + 0.0071953 ca2[c] + 0.0071953 cl[c] + 0.0085871 clpn180[c] + 0.0085871 clpnai17[c] + 0.0085871 clpni17[c] + 0.0071953 coa[c] + 0.0071953 cobalt2[c] + 0.025039 colipa[c] + 0.026124 ctp[c] + 0.0071953 cu2[c] + 0.056954 cys_L[c] + 0.016458 datp[c] + 0.010418 dctp[c] + 0.010418 dgtp[c] + dnarep[c] + 0.02504 dtdprmn[c] + 0.016458 dttp[c] + 0.0071953 fad[c] + 0.0071953 fe2[c] + 0.0071953 fe3[c] + 0.0071953 fmn[c] + 0.261 gln_L[c] + 0.261 glu_L[c] + 0.40933 gly[c] + 0.0071953 gthrd[c] + 0.042403 gtp[c] + 41.257 h[c] + 0.081948 his_L[c] + 0.27043 ile_L[c] + 0.0071953 k[c] + 0.02504 kdo2lipid4L[c] + 0.34746 leu_L[c] + 0.3237 lys_L[c] + 0.1135 met_L[c] + 0.0071953 mg2[c] + 0.0071953 mn2[c] + 0.0071953 mqn8[c] + 0.0071953 nad[c] + 0.0071953 nadp[c] + 0.0085871 pe180[c] + 0.0085871 peai17[c] + 0.0085871 pei17[c] + 0.0085871 pg180[c] + 0.0085871 pgai17[c] + 0.0085871 pgi17[c] + 0.17619 phe_L[c] + 0.0071953 pheme[c] + 0.16103 pro_L[c] + proteinsynth[c] + 0.0071953 ptrc[c] + 0.0071953 pydx5p[c] + 0.0071953 q8[c] + 0.0071953 ribflv[c] + rnatrans[c] + 0.21675 ser_L[c] + 0.0071953 sheme[c] + 0.0071953 so4[c] + 0.0071953 spmd[c] + 0.0071953 thf[c] + 0.0071953 thmpp[c] + 0.18684 thr_L[c] + 0.054496 trp_L[c] + 0.11104 tyr_L[c] + 0.0071953 uacgam[c] + 0.0018061 udcpdp[c] + 0.028225 utp[c] + 0.30772 val_L[c] + 0.0071953 zn2[c] -> 0.0072242 PGPm1[c] + 41.257 adp[c] + 0.0071953 apoACP[c] + biomass[c] + 0.0071953 cbi[c] + 0.0071953 dmbzid[c] + 45.354 h2o[c] + 41.2498 pi[c] + 0.1849 ppi[c] Adding the following Metabolites to the model: 10fthf5glu[c] 10fthf[c] 10m3hddcaACP[c] 10m3oddcaACP[c] 10mddcaACP[c] 10mtddec2eACP[c] 11m3hddcaACP[c] 11m3oddcaACP[c] 11mddcaACP[c] 11mtddec2eACP[c] 12daihdglyc[c] 12dgr180[c] 12dihdglyc[c] 12m3hmyrsACP[c] 12m3omyrsACP[c] 12mmyrsACP[c] 12mtmrs2eACP[c] 13dpg[c] 13m3hmyrsACP[c] 13m3omyrsACP[c] 13mmyrsACP[c] 13mtmrs2eACP[c] 14m3hpalmACP[c] 14m3opalmACP[c] 14mpalmACP[c] 14mtpalm2eACP[c] 15m3hpalmACP[c] 15m3opalmACP[c] 15mpalmACP[c] 15mtpalm2eACP[c] 1aihpdecg3p[c] 1aipdecg3p[c] 1ddecg3p[c] 1hdec9eg3p[c] 1hdecg3p[c] 1ihdecg3p[c] 1ihpdecg3p[c] 1ipdecg3p[c] 1itdecg3p[c] 1odec11eg3p[c] 1odecg3p[c] 1pyr5c[c] 1tdec7eg3p[c] 1tdecg3p[c] 23camp[c] 23ccmp[c] 23cgmp[c] 23cump[c] 23dhdp[c] 25aics[c] 25dhpp[c] 26dap_M[c] 26dap_M[e] 2c25dho[c] 2dda7p[c] 2ddg6p[c] 2dmmq8[c] 2dmmql8[c] 2dr5p[c] 2hmc[c] 2hymeph[c] 2maacoa[c] 2mahmp[c] 2mbcoa[c] 2mbutACP[c] 2mop[c] 2obut[c] 2ohph[c] 2ombzl[c] 2omhmbl[c] 2ommbl[c] 2omph[c] 2oph[c] 2pg[c] 2shchc[c] 34hpp[c] 3amp[c] 3cmp[c] 3dhq[c] 3dhsk[c] 3gmp[c] 3haACP[c] 3hadpcoa[c] 3hbcoa[c] 3hdcoa[c] 3hddcoa[c] 3hddecACP[c] 3hdecACP[c] 3hhcoa[c] 3hhdcoa[c] 3hhexACP[c] 3hmbcoa[c] 3hmp[c] 3hmrsACP[c] 3hocoa[c] 3hoctACP[c] 3hoctaACP[c] 3hpalmACP[c] 3htdcoa[c] 3mbutACP[c] 3mop[c] 3odcoa[c] 3oddcoa[c] 3oddecACP[c] 3odecACP[c] 3ohcoa[c] 3ohdcoa[c] 3ohexACP[c] 3omrsACP[c] 3oocoa[c] 3ooctACP[c] 3ooctdACP[c] 3opalmACP[c] 3ophb[c] 3otdcoa[c] 3pg[c] 3php[c] 3psme[c] 3ump[c] 4abz[c] 4abz[e] 4ahmmp[c] 4ampm[c] 4h2oglt[c] 4hba[c] 4hbz[c] 4m3hhexACP[c] 4m3ohexACP[c] 4mhexACP[c] 4mop[c] 4mpetz[c] 4mthex2eACP[c] 4pasp[c] 4per[c] 4ppan[c] 4ppcys[c] 4r5au[c] 5aop[c] 5aprbu[c] 5apru[c] 5dpmev[c] 5fthf[c] 5m3hhexACP[c] 5m3ohexACP[c] 5mhexACP[c] 5mta[c] 5mthex2eACP[c] 5mthf[c] 5mtr[c] 5odhf2a[c] 5pmev[c] 5prdmbz[c] 6m3hocACP[c] 6m3oocACP[c] 6mocACP[c] 6mtoct2eACP[c] 6pgc[c] 6pgg[c] 6pgl[c] 7m3hocACP[c] 7m3oocACP[c] 7mocACP[c] 7mtoct2eACP[c] 8m3hdcaACP[c] 8m3odcaACP[c] 8mdcaACP[c] 8mtdec2eACP[c] 9m3hdcaACP[c] 9m3odcaACP[c] 9mdcaACP[c] 9mtdec2eACP[c] ACP[c] PGP[c] PGPm1[c] aacoa[c] abt[c] acACP[c] ac[c] ac[e] acac[c] acald[c] acbdma14gapuc[c] accoa[c] acgam1p[c] acgam6p[c] acgam[e] acmana[c] acmum6p[c] acorn[c] actACP[c] actp[c] ade[c] ade[e] adn[c] adocbi[c] adocbip[c] adocbl[c] adocbl[e] adp[c] adprib[c] agdpcbi[c] ahcys[c] ahcys[e] ai15tca1[c] ai15tcaacgam[c] ai15tcaala_D[c] ai15tcaglc[c] ai17tca1[c] ai17tcaacgam[c] ai17tcaala_D[c] ai17tcaglc[c] aicar[c] aihpdcoa[c] aipdcoa[c] akg[c] akg[e] ala_D[c] ala_D[e] ala_L[c] ala_L[e] alaala[c] alaasp[c] alaasp[e] alagln[c] alagln[e] alaglu[c] alaglu[e] alagly[c] alagly[e] alahis[c] alahis[e] alaleu[c] alaleu[e] alathr[c] alathr[e] amet[c] ametam[c] amp[c] apoACP[c] arab_L[c] arab_L[e] arbt6p[c] arbt[e] arg_L[c] arg_L[e] asn_L[c] asn_L[e] aso3[c] aso3[e] aso4[c] aso4[e] asp_L[c] asp_L[e] aspsa[c] atp[c] biomass[c] btcoa[c] btn[c] btn[e] but2eACP[c] butACP[c] ca2[c] ca2[e] camp[c] cbasp[c] cbi[c] cbp[c] cd2[c] cd2[e] cdp[c] cdpdaihpdecg[c] cdpdaipdecg[c] cdpdddecg[c] cdpdhdec9eg[c] cdpdhdecg[c] cdpdihdecg[c] cdpdihpdecg[c] cdpdipdecg[c] cdpditdecg[c] cdpdodec11eg[c] cdpdodecg[c] cdpdtdec7eg[c] cdpdtdecg[c] cdpglyc[c] cellb[e] cgly[c] cgly[e] chol[c] chor[c] chor[e] cit[c] citr_L[c] cl[c] cl[e] clpn140[c] clpn160[c] clpn180[c] clpnai15[c] clpnai17[c] clpni14[c] clpni15[c] clpni16[c] clpni17[c] cmp[c] co2[c] co2[e] coa[c] cobalt2[c] cobalt2[e] ctp[c] cu2[c] cu2[e] cys_L[c] cys_L[e] cyst_L[c] cytd[c] dad_2[c] dadp[c] damp[c] datp[c] db4p[c] dcaACP[c] dca[c] dcacoa[c] dcamp[c] dcdp[c] dcmp[c] dctp[c] dcyt[c] ddcaACP[c] ddca[c] ddcacoa[c] dextrin[c] dextrin[e] dgal6p[c] dgdp[c] dgmp[c] dgsn[c] dgtp[c] dha[c] dhap[c] dhf[c] dhna[c] dhor_S[c] dhpt[c] didp[c] diglcpg140[c] diglcpg160[c] diglcpg180[c] diglcpgai15[c] diglcpgai17[c] diglcpgi14[c] diglcpgi15[c] diglcpgi16[c] diglcpgi17[c] dimp[c] din[c] ditp[c] dma[c] dmbzid[c] dmlarg[c] dmlz[c] dmpp[c] dnad[c] dnarep[c] dpcoa[c] drib[c] drib[e] dscl[c] dtdp[c] dtmp[c] dttp[c] dudp[c] dump[c] duri[c] dutp[c] dxyl5p[c] e4hglu[c] e4p[c] etha[c] etoh[c] f1p[c] f6p[c] fa11[c] fa12[c] fa1[c] fa3[c] fa4[c] fa6[c] fad[c] fadh2[c] fdp[c] fe2[c] fe3[c] fe3[e] ficytC[c] fmn[c] focytC[c] fol[c] fol[e] for[c] for[e] frdp[c] fru[c] fru[e] fum[c] fum[e] g1p[c] g1p_B[c] g3p[c] g3pc[c] g3pe[c] g3pg[c] g3ps[c] g6p[c] g6p_B[c] gal1p[c] gal[c] galt1p[c] galt[e] gam1p[c] gam6p[c] gam[e] gdp[c] gdptp[c] ggdp[c] glc_D[c] glc_D[e] glc_bD[c] glcn[c] glcn[e] gln_L[c] gln_L[e] glu1sa[c] glu5sa[c] glu_D[c] glu_L[c] glu_L[e] glucys[c] glutrna[c] glx[c] gly[c] gly[e] glyald[c] glyasn[c] glyasn[e] glyasp[c] glyasp[e] glyc3p[c] glyc3p[e] glyc45tca[c] glyc45tcaala_D[c] glyc45tcaglc[c] glyc[c] glyc[e] glyc_R[c] glyclt[c] glycys[c] glycys[e] glygln[c] glygln[e] glyglu[c] glyglu[e] glyleu[c] glyleu[e] glymet[c] glymet[e] glyphe[c] glyphe[e] glypro[c] glypro[e] glytyr[c] glytyr[e] gmp[c] grdp[c] gsn[c] gthrd[c] gtp[c] gua[c] h2[c] h2o2[c] h2o[c] h2o[e] h2s[c] h2s[e] h[c] h[e] hco3[c] hdca[c] hdcea[c] hdcoa[c] hdeACP[c] hepdp[c] hexACP[c] hexdp[c] hg2[c] hg2[e] his_L[c] his_L[e] hmbil[c] hmgcoa[c] hqn[c] hxan[c] hxan[e] hxcoa[c] i14tca1[c] i14tcaacgam[c] i14tcaala_D[c] i14tcaglc[c] i15tca1[c] i15tcaacgam[c] i15tcaala_D[c] i15tcaglc[c] i16tca1[c] i16tcaacgam[c] i16tcaala_D[c] i16tcaglc[c] i17tca1[c] i17tcaacgam[c] i17tcaala_D[c] i17tcaglc[c] iasp[c] ichor[c] idp[c] ihdcoa[c] ihpdcoa[c] ile_L[c] ile_L[e] imp[c] ins[c] ins[e] ipdcoa[c] ipdp[c] isomal[c] itdcoa[c] itp[c] ivcoa[c] k[c] k[e] l2a6o[c] lac6p[c] lac_D[c] lac_D[e] lac_L[c] lac_L[e] lcts[e] leu_L[c] leu_L[e] lys_L[c] lys_L[e] m12dahglyc[c] m12dihglyc[c] m12dsglyc[c] malACP[c] mal_L[c] mal_L[e] malcoa[c] malt6p[c] malt[c] malt[e] malthp[c] malthx[c] malthx[e] maltpt[c] malttr[c] malttr[e] maltttr[c] man6p[c] man[e] melib[c] met_D[c] met_D[e] met_L[c] met_L[e] metala[c] metala[e] methf[c] metsox_R_L[c] metsox_R_L[e] metsox_S_L[c] metsox_S_L[e] mev_R[c] mg2[c] mg2[e] mlthf[c] mn2[c] mn2[e] mnl1p[c] mnl[e] mql8[c] mqn7[e] mqn8[c] mqn8[e] murein4p4p[c] murein4px4p4p[c] murein4px4p[c] murein4px4px4p[c] murein5p4p[c] murein5px4p[c] myrsACP[c] myrstca1[c] myrstcaacgam[c] myrstcaala_D[c] myrstcaglc[c] na1[c] na1[e] nac[c] nac[e] nad[c] nadh[c] nadp[c] nadph[c] ncam[c] ncam[e] nh4[c] nh4[e] nicrnt[c] o2[c] o2[e] oaa[c] ocACP[c] occoa[c] ocdcaACP[c] ocdca[c] ocdca[e] ocdcea[c] octdp[c] octeACP[c] odecoa[c] orn[c] orn[e] orot5p[c] orot[c] oxadpcoa[c] oxalc[c] pa120[c] pa140[c] pa141[c] pa160[c] pa161[c] pa180[c] pa181[c] paai15[c] paai17[c] pai14[c] pai15[c] pai16[c] pai17[c] palmACP[c] palmtca1[c] palmtcaacgam[c] palmtcaala_D[c] palmtcaglc[c] pan4p[c] pap[c] paps[c] pb[c] pb[e] pdx5p[c] pe180[c] peai17[c] pei17[c] pendp[c] pep[c] peptmet_L[c] peptmetox_L[c] pg140[c] pg160[c] pg180[c] pgai15[c] pgai17[c] pgi14[c] pgi15[c] pgi16[c] pgi17[c] pgp120[c] pgp140[c] pgp141[c] pgp160[c] pgp161[c] pgp180[c] pgp181[c] pgpai15[c] pgpai17[c] pgpi14[c] pgpi15[c] pgpi16[c] pgpi17[c] phe_L[c] phe_L[e] pheme[c] pheme[e] pi[c] pi[e] pmtcoa[c] pnto_R[c] pnto_R[e] ppa[c] ppap[c] ppbng[c] ppcoa[c] ppi[c] ppi[e] pppi[c] ppt[c] ppt[e] prl45tca[c] prl45tcaala[c] prl45tcaglc[c] pro_L[c] pro_L[e] proteinsynth[c] protrna[c] prpp[c] ps180[c] psai17[c] psd5p[c] psi17[c] ptrc[c] ptrc[e] pydx5p[c] pydx[c] pydx[e] pydxn[c] pydxn[e] pyr[c] pyr[e] q8[c] q8[e] q8h2[c] quln[c] r1p[c] r5p[c] raffin[c] rdmbzi[c] rhcys[c] rib_D[c] rib_D[e] ribflv[c] ribflv[e] rnatrans[c] ru5p_D[c] s17bp[c] s7p[c] salc6p[c] salcn[e] sbt6p[c] sbt_D[e] sbzcoa[c] scl[c] seasmet[c] selmeth[c] ser_D[c] ser_D[e] ser_L[c] ser_L[e] sheme[c] sheme[e] skm5p[c] skm[c] so3[c] so4[c] so4[e] spmd[c] spmd[e] stcoa[c] sttca1[c] sttcaacgam[c] sttcaala_D[c] sttcaglc[c] suc6p[c] sucbz[c] succ[c] succ[e] sucr[c] sucr[e] sucsal[c] tag6p_D[c] tagdp_D[c] tcam[c] tdcoa[c] tddec2eACP[c] tdeACP[c] tdec2eACP[c] teich_45_BS[c] thdp[c] thex2eACP[c] thf[c] thfglu[c] thm[c] thm[e] thmpp[c] thr_L[c] thr_L[e] thymd[c] thymd[e] tmrs2eACP[c] toct2eACP[c] toctd2eACP[c] tpalm2eACP[c] trdox[c] trdrd[c] tre6p[c] tre[c] tre[e] trnaglu[c] trnapro[c] trp_L[c] trp_L[e] ttc_ggdp[c] ttdca[c] ttdcea[c] tyr_L[c] tyr_L[e] u3aga[c] uGgl[c] uGgla[c] uaGgla[c] uaaAgla[c] uaaAgtla[c] uaaGgla[c] uaaGgtla[c] uaagmda[c] uaagtmda[c] uaccg[c] uacgam[c] uacmam[c] uagmda[c] uama[c] uamag[c] uamr[c] udcpdp[c] udcpp[c] udp[c] udpacgal[c] udpg[c] udpgal[c] udpgalfur[c] ugmd[c] ugmda[c] um4p[c] ump[c] unaga[c] uppg3[c] ura[c] ura[e] uri[c] utp[c] val_L[c] val_L[e] xan[c] xan[e] xmp[c] xtsn[c] xu5p_D[c] zn2[c] zn2[e] addMultipleReactions: Adding the following reactions to the model: 23PDE2 23cump[c] + h2o[c] -> 3ump[c] + h[c] 23PDE4 23ccmp[c] + h2o[c] -> 3cmp[c] + h[c] 23PDE7 23camp[c] + h2o[c] -> 3amp[c] + h[c] 23PDE9 23cgmp[c] + h2o[c] -> 3gmp[c] + h[c] 2HMCOXT 2hmc[c] <=> oxalc[c] 2MBCOATA 2mbcoa[c] + ACP[c] <=> 2mbutACP[c] + coa[c] 2S6HCC akg[c] + h[c] + ichor[c] <=> 2shchc[c] + co2[c] + pyr[c] 3HAD100 3hdecACP[c] -> h2o[c] + tdec2eACP[c] 3HAD10M12 10m3hddcaACP[c] -> 10mtddec2eACP[c] + h2o[c] 3HAD11M12 11m3hddcaACP[c] -> 11mtddec2eACP[c] + h2o[c] 3HAD120 3hddecACP[c] -> h2o[c] + tddec2eACP[c] 3HAD12M14 12m3hmyrsACP[c] -> 12mtmrs2eACP[c] + h2o[c] 3HAD13M14 13m3hmyrsACP[c] -> 13mtmrs2eACP[c] + h2o[c] 3HAD140 3hmrsACP[c] -> h2o[c] + tmrs2eACP[c] 3HAD14M16 14m3hpalmACP[c] -> 14mtpalm2eACP[c] + h2o[c] 3HAD15M16 15m3hpalmACP[c] -> 15mtpalm2eACP[c] + h2o[c] 3HAD160 3hpalmACP[c] -> h2o[c] + tpalm2eACP[c] 3HAD180 3hoctaACP[c] -> h2o[c] + toctd2eACP[c] 3HAD40 3haACP[c] -> but2eACP[c] + h2o[c] 3HAD4M6 4m3hhexACP[c] -> 4mthex2eACP[c] + h2o[c] 3HAD5M6 5m3hhexACP[c] -> 5mthex2eACP[c] + h2o[c] 3HAD60 3hhexACP[c] -> h2o[c] + thex2eACP[c] 3HAD6M8 6m3hocACP[c] -> 6mtoct2eACP[c] + h2o[c] 3HAD7M8 7m3hocACP[c] -> 7mtoct2eACP[c] + h2o[c] 3HAD80 3hoctACP[c] -> h2o[c] + toct2eACP[c] 3HAD8M10 8m3hdcaACP[c] -> 8mtdec2eACP[c] + h2o[c] 3HAD9M10 9m3hdcaACP[c] -> 9mtdec2eACP[c] + h2o[c] 3OAR100 3odecACP[c] + h[c] + nadph[c] <=> 3hdecACP[c] + nadp[c] 3OAR10M12 10m3oddcaACP[c] + h[c] + nadph[c] <=> 10m3hddcaACP[c] + nadp[c] 3OAR11M12 11m3oddcaACP[c] + h[c] + nadph[c] <=> 11m3hddcaACP[c] + nadp[c] 3OAR120 3oddecACP[c] + h[c] + nadph[c] <=> 3hddecACP[c] + nadp[c] 3OAR12M14 12m3omyrsACP[c] + h[c] + nadph[c] <=> 12m3hmyrsACP[c] + nadp[c] 3OAR13M14 13m3omyrsACP[c] + h[c] + nadph[c] <=> 13m3hmyrsACP[c] + nadp[c] 3OAR140 3omrsACP[c] + h[c] + nadph[c] <=> 3hmrsACP[c] + nadp[c] 3OAR14M16 14m3opalmACP[c] + h[c] + nadph[c] <=> 14m3hpalmACP[c] + nadp[c] 3OAR15M16 15m3opalmACP[c] + h[c] + nadph[c] <=> 15m3hpalmACP[c] + nadp[c] 3OAR160 3opalmACP[c] + h[c] + nadph[c] <=> 3hpalmACP[c] + nadp[c] 3OAR180 3ooctdACP[c] + h[c] + nadph[c] <=> 3hoctaACP[c] + nadp[c] 3OAR40 actACP[c] + h[c] + nadph[c] <=> 3haACP[c] + nadp[c] 3OAR4M6 4m3ohexACP[c] + h[c] + nadph[c] <=> 4m3hhexACP[c] + nadp[c] 3OAR5M6 5m3ohexACP[c] + h[c] + nadph[c] <=> 5m3hhexACP[c] + nadp[c] 3OAR60 3ohexACP[c] + h[c] + nadph[c] <=> 3hhexACP[c] + nadp[c] 3OAR6M8 6m3oocACP[c] + h[c] + nadph[c] <=> 6m3hocACP[c] + nadp[c] 3OAR7M8 7m3oocACP[c] + h[c] + nadph[c] <=> 7m3hocACP[c] + nadp[c] 3OAR80 3ooctACP[c] + h[c] + nadph[c] <=> 3hoctACP[c] + nadp[c] 3OAR8M10 8m3odcaACP[c] + h[c] + nadph[c] <=> 8m3hdcaACP[c] + nadp[c] 3OAR9M10 9m3odcaACP[c] + h[c] + nadph[c] <=> 9m3hdcaACP[c] + nadp[c] 3OAS100 h[c] + malACP[c] + ocACP[c] -> 3odecACP[c] + ACP[c] + co2[c] 3OAS10M12 10mddcaACP[c] + h[c] + malACP[c] -> 12m3omyrsACP[c] + ACP[c] + co2[c] 3OAS11M12 11mddcaACP[c] + h[c] + malACP[c] -> 13m3omyrsACP[c] + ACP[c] + co2[c] 3OAS120 dcaACP[c] + h[c] + malACP[c] -> 3oddecACP[c] + ACP[c] + co2[c] 3OAS12M14 12mmyrsACP[c] + h[c] + malACP[c] -> 14m3opalmACP[c] + ACP[c] + co2[c] 3OAS13M14 13mmyrsACP[c] + h[c] + malACP[c] -> 15m3opalmACP[c] + ACP[c] + co2[c] 3OAS140 ddcaACP[c] + h[c] + malACP[c] -> 3omrsACP[c] + ACP[c] + co2[c] 3OAS160 h[c] + malACP[c] + myrsACP[c] -> 3opalmACP[c] + ACP[c] + co2[c] 3OAS180 h[c] + malACP[c] + palmACP[c] -> 3ooctdACP[c] + ACP[c] + co2[c] 3OAS3M4 3mbutACP[c] + h[c] + malACP[c] -> 5m3ohexACP[c] + ACP[c] + co2[c] 3OAS4M3O6 2mbutACP[c] + h[c] + malACP[c] -> 4m3ohexACP[c] + ACP[c] + co2[c] 3OAS4M6 4mhexACP[c] + h[c] + malACP[c] -> 6m3oocACP[c] + ACP[c] + co2[c] 3OAS5M6 5mhexACP[c] + h[c] + malACP[c] -> 7m3oocACP[c] + ACP[c] + co2[c] 3OAS60 butACP[c] + h[c] + malACP[c] -> 3ohexACP[c] + ACP[c] + co2[c] 3OAS6M8 6mocACP[c] + h[c] + malACP[c] -> 8m3odcaACP[c] + ACP[c] + co2[c] 3OAS7M8 7mocACP[c] + h[c] + malACP[c] -> 9m3odcaACP[c] + ACP[c] + co2[c] 3OAS80 h[c] + hexACP[c] + malACP[c] -> 3ooctACP[c] + ACP[c] + co2[c] 3OAS8M10 8mdcaACP[c] + h[c] + malACP[c] -> 10m3oddcaACP[c] + ACP[c] + co2[c] 3OAS9M10 9mdcaACP[c] + h[c] + malACP[c] -> 11m3oddcaACP[c] + ACP[c] + co2[c] 4ABZt2 4abz[e] + h[e] -> 4abz[c] + h[c] 5MTHFOR fadh2[c] + h[c] + mlthf[c] <=> 5mthf[c] + fad[c] 6PGALSZ2i h2o[c] + lac6p[c] <=> dgal6p[c] + glc_bD[c] 6PHBG h2o[c] + salc6p[c] -> 2hymeph[c] + g6p[c] 6PHBG2 h2o[c] + salc6p[c] -> 2hymeph[c] + g6p_B[c] AACOAT acac[c] + atp[c] + coa[c] -> aacoa[c] + amp[c] + ppi[c] AACPS2 ACP[c] + atp[c] + ttdcea[c] -> amp[c] + ppi[c] + tdeACP[c] AACPS4 ACP[c] + atp[c] + hdcea[c] -> amp[c] + hdeACP[c] + ppi[c] AACPS7 ACP[c] + atp[c] + ddca[c] -> amp[c] + ddcaACP[c] + ppi[c] AACPS8 ACP[c] + atp[c] + dca[c] -> amp[c] + dcaACP[c] + ppi[c] AB6PGH arbt6p[c] + h2o[c] -> g6p[c] + hqn[c] AB6PGH2 arbt6p[c] + h2o[c] -> g6p_B[c] + hqn[c] ABTOXy abt[c] + nadp[c] <=> arab_L[c] + h[c] + nadph[c] ACACT1r 2 accoa[c] <=> aacoa[c] + coa[c] ACACT2r accoa[c] + btcoa[c] <=> 3ohcoa[c] + coa[c] ACACT3r accoa[c] + hxcoa[c] <=> 3oocoa[c] + coa[c] ACACT4r accoa[c] + occoa[c] <=> 3odcoa[c] + coa[c] ACACT5r accoa[c] + dcacoa[c] <=> 3oddcoa[c] + coa[c] ACACT6r accoa[c] + ddcacoa[c] <=> 3otdcoa[c] + coa[c] ACACT7r accoa[c] + tdcoa[c] <=> 3ohdcoa[c] + coa[c] ACALD acald[c] + coa[c] + nad[c] <=> accoa[c] + h[c] + nadh[c] ACBIPGT adocbip[c] + gtp[c] + h[c] -> agdpcbi[c] + ppi[c] ACCOAC accoa[c] + atp[c] + hco3[c] -> adp[c] + h[c] + malcoa[c] + pi[c] ACGAMT uacgam[c] + udcpp[c] -> ump[c] + unaga[c] ACGApts acgam[e] + pep[c] -> acgam6p[c] + pyr[c] ACKr ac[c] + atp[c] <=> actp[c] + adp[c] ACM6PH acmum6p[c] + h2o[c] -> acgam6p[c] + lac_D[c] ACOAAGPAT140 1tdecg3p[c] + tdcoa[c] -> coa[c] + pa140[c] ACOAAGPAT160 1hdecg3p[c] + pmtcoa[c] -> coa[c] + pa160[c] ACOAAGPAT180 1odecg3p[c] + stcoa[c] -> coa[c] + pa180[c] ACOAAGPATAI15 1aipdecg3p[c] + aipdcoa[c] -> coa[c] + h[c] + paai15[c] ACOAAGPATAI17 1aihpdecg3p[c] + aihpdcoa[c] -> coa[c] + paai17[c] ACOAAGPATI14 1itdecg3p[c] + itdcoa[c] -> coa[c] + h[c] + pai14[c] ACOAAGPATI15 1ipdecg3p[c] + ipdcoa[c] -> coa[c] + h[c] + pai15[c] ACOAAGPATI16 1ihdecg3p[c] + ihdcoa[c] -> coa[c] + h[c] + pai16[c] ACOAAGPATI17 1ihpdecg3p[c] + ihpdcoa[c] -> coa[c] + pai17[c] ACOATA ACP[c] + accoa[c] <=> acACP[c] + coa[c] ACODAr acorn[c] + h2o[c] <=> ac[c] + orn[c] ACPS1 apoACP[c] + coa[c] -> ACP[c] + h[c] + pap[c] ACYP 13dpg[c] + h2o[c] -> 3pg[c] + h[c] + pi[c] ACYP_2 actp[c] + h2o[c] -> ac[c] + h[c] + pi[c] ACtr ac[e] <=> ac[c] ADA adn[c] + h2o[c] + h[c] -> ins[c] + nh4[c] ADK1 amp[c] + atp[c] <=> 2 adp[c] ADK2 amp[c] + pppi[c] <=> adp[c] + ppi[c] ADMDC amet[c] + h[c] -> ametam[c] + co2[c] ADNCYC atp[c] -> camp[c] + ppi[c] ADNUC adn[c] + h2o[c] -> ade[c] + rib_D[c] ADOCBIK adocbi[c] + atp[c] -> adocbip[c] + adp[c] + h[c] ADOCBLS agdpcbi[c] + rdmbzi[c] -> adocbl[c] + gmp[c] + h[c] ADOCBLabc adocbl[e] + atp[c] + h2o[c] -> adocbl[c] + adp[c] + h[c] + pi[c] ADPRDP adprib[c] + h2o[c] -> amp[c] + 2 h[c] + r5p[c] ADPT ade[c] + prpp[c] -> amp[c] + ppi[c] ADSL1r dcamp[c] <=> amp[c] + fum[c] ADSL2r 25aics[c] <=> aicar[c] + fum[c] ADSS asp_L[c] + gtp[c] + imp[c] -> dcamp[c] + gdp[c] + 2 h[c] + pi[c] AGDC acgam6p[c] + h2o[c] -> ac[c] + gam6p[c] AGPAT120 1ddecg3p[c] + ddcaACP[c] -> ACP[c] + pa120[c] AGPAT140 1tdecg3p[c] + myrsACP[c] -> ACP[c] + pa140[c] AGPAT141 1tdec7eg3p[c] + tdeACP[c] -> ACP[c] + pa141[c] AGPAT160 1hdecg3p[c] + palmACP[c] -> ACP[c] + pa160[c] AGPAT161 1hdec9eg3p[c] + hdeACP[c] -> ACP[c] + pa161[c] AGPAT180 1odecg3p[c] + ocdcaACP[c] -> ACP[c] + pa180[c] AGPAT181 1odec11eg3p[c] + octeACP[c] -> ACP[c] + pa181[c] AHCYSNS_r ahcys[c] + h2o[c] <=> ade[c] + rhcys[c] AHCYSts ahcys[c] -> ahcys[e] AIHDUDPMG 12daihdglyc[c] + udpg[c] <=> h[c] + m12dahglyc[c] + udp[c] AIHDUPDG m12dahglyc[c] + udpg[c] <=> diglcpgai17[c] + h[c] + udp[c] AIHPDCOATA 14mpalmACP[c] + coa[c] <=> ACP[c] + aihpdcoa[c] AKGt2r akg[e] + h[e] <=> akg[c] + h[c] ALAALA 2 ala_D[c] + atp[c] -> adp[c] + alaala[c] + h[c] + pi[c] ALAASP1c alaasp[c] + h2o[c] <=> ala_L[c] + asp_L[c] ALAASPabc alaasp[e] + atp[c] + h2o[c] -> adp[c] + alaasp[c] + h[c] + pi[c] ALAGLN1c alagln[c] + h2o[c] <=> ala_L[c] + gln_L[c] ALAGLNabc alagln[e] + atp[c] + h2o[c] -> adp[c] + alagln[c] + h[c] + pi[c] ALAGLU1c alaglu[c] + h2o[c] <=> ala_L[c] + glu_L[c] ALAGLUabc alaglu[e] + atp[c] + h2o[c] -> adp[c] + alaglu[c] + h[c] + pi[c] ALAGLY1c alagly[c] + h2o[c] <=> ala_L[c] + gly[c] ALAGLYabc alagly[e] + atp[c] + h2o[c] -> adp[c] + alagly[c] + h[c] + pi[c] ALAHIS1c alahis[c] + h2o[c] <=> ala_L[c] + his_L[c] ALAHISabc alahis[e] + atp[c] + h2o[c] -> adp[c] + alahis[c] + h[c] + pi[c] ALALEU1c alaleu[c] + h2o[c] <=> ala_L[c] + leu_L[c] ALALEUabc alaleu[e] + atp[c] + h2o[c] -> adp[c] + alaleu[c] + h[c] + pi[c] ALAPAT4te ala_L[e] <=> ala_L[c] ALAPGPL 45 ala_D[c] + 45 atp[c] + prl45tca[c] -> 45 amp[c] + 45 h2o[c] + 45 ppi[c] + prl45tcaala[c] ALAR ala_L[c] <=> ala_D[c] ALATHR1c alathr[c] + h2o[c] <=> ala_L[c] + thr_L[c] ALATHRabc alathr[e] + atp[c] + h2o[c] -> adp[c] + alathr[c] + h[c] + pi[c] ALAt2 ala_L[e] + h[e] -> ala_L[c] + h[c] ALCD19 glyald[c] + h[c] + nadh[c] <=> glyc[c] + nad[c] ALCD2x etoh[c] + nad[c] <=> acald[c] + h[c] + nadh[c] AMMQT8r 2dmmq8[c] + amet[c] <=> ahcys[c] + h[c] + mqn8[c] AMPTASECG cgly[c] + h2o[c] -> cys_L[c] + gly[c] AMPTASEGC glycys[c] + h2o[c] -> cys_L[c] + gly[c] APRAUR 5apru[c] + h[c] + nadph[c] -> 5aprbu[c] + nadp[c] ARBTpts arbt[e] + pep[c] -> arbt6p[c] + pyr[c] ARBabc arab_L[e] + atp[c] + h2o[c] -> adp[c] + arab_L[c] + h[c] + pi[c] ARGDA arg_L[c] + h2o[c] -> citr_L[c] + nh4[c] ARGt2 arg_L[e] + h[e] -> arg_L[c] + h[c] ASAD aspsa[c] + nadp[c] + pi[c] <=> 4pasp[c] + h[c] + nadph[c] ASNS1 asp_L[c] + atp[c] + gln_L[c] + h2o[c] -> amp[c] + asn_L[c] + glu_L[c] + h[c] + ppi[c] ASNS2 asp_L[c] + atp[c] + nh4[c] -> amp[c] + asn_L[c] + h[c] + ppi[c] ASNt2r asn_L[e] + h[e] <=> asn_L[c] + h[c] ASO3t aso3[e] <=> aso3[c] ASO4t aso4[e] <=> aso4[c] ASPCT asp_L[c] + cbp[c] -> cbasp[c] + h[c] + pi[c] ASPK asp_L[c] + atp[c] <=> 4pasp[c] + adp[c] ASPO5 asp_L[c] + fum[c] -> h[c] + iasp[c] + succ[c] ASPTA akg[c] + asp_L[c] <=> glu_L[c] + oaa[c] ASPt2r asp_L[e] + h[e] <=> asp_L[c] + h[c] ATPS4 adp[c] + 4 h[e] + pi[c] -> atp[c] + h2o[c] + 3 h[c] BGLA1 6pgg[c] + h2o[c] -> g6p[c] + glc_D[c] BPNT h2o[c] + pap[c] -> amp[c] + pi[c] BTNt2 btn[e] + h[e] <=> btn[c] + h[c] CAt4i ca2[e] + h[c] -> ca2[c] + h[e] CBIAT atp[c] + cbi[c] + h[c] <=> adocbi[c] + pppi[c] CBMKr atp[c] + co2[c] + nh4[c] <=> adp[c] + cbp[c] + 2 h[c] CBPS 2 atp[c] + gln_L[c] + h2o[c] + hco3[c] -> 2 adp[c] + cbp[c] + glu_L[c] + 2 h[c] + pi[c] CD2abc1 atp[c] + cd2[c] + h2o[c] -> adp[c] + cd2[e] + h[c] + pi[c] CD2t6r cd2[c] + h[e] + k[e] <=> cd2[e] + h[c] + k[c] CDPGLYCGPT acbdma14gapuc[c] + 45 cdpglyc[c] <=> 45 cmp[c] + 45 h[c] + prl45tca[c] CELBpts cellb[e] + pep[c] -> 6pgg[c] + pyr[c] CGLYabc atp[c] + cgly[e] + h2o[c] -> adp[c] + cgly[c] + h[c] + pi[c] CHORS 3psme[c] -> chor[c] + pi[c] CHORt chor[e] + h[e] <=> chor[c] + h[c] CHRPL chor[c] -> 4hbz[c] + pyr[c] CITL cit[c] -> ac[c] + oaa[c] CLPNS140 2 pg140[c] <=> clpn140[c] + glyc[c] CLPNS160 2 pg160[c] <=> clpn160[c] + glyc[c] CLPNS180 2 pg180[c] <=> clpn180[c] + glyc[c] CLPNSAI15 2 pgai15[c] <=> clpnai15[c] + glyc[c] CLPNSAI17 2 pgai17[c] <=> clpnai17[c] + glyc[c] CLPNSI14 2 pgi14[c] <=> clpni14[c] + glyc[c] CLPNSI15 2 pgi15[c] <=> clpni15[c] + glyc[c] CLPNSI16 2 pgi16[c] <=> clpni16[c] + glyc[c] CLPNSI17 2 pgi17[c] <=> clpni17[c] + glyc[c] CMLDC 2c25dho[c] + h[c] -> 5odhf2a[c] + co2[c] CO2t co2[e] <=> co2[c] COBALTt5 cobalt2[c] <=> cobalt2[e] CTPS1 atp[c] + nh4[c] + utp[c] -> adp[c] + ctp[c] + 2 h[c] + pi[c] CTPS2 atp[c] + gln_L[c] + h2o[c] + utp[c] -> adp[c] + ctp[c] + glu_L[c] + 2 h[c] + pi[c] CYSDS cys_L[c] + h2o[c] -> h2s[c] + nh4[c] + pyr[c] CYSTGL cyst_L[c] + h2o[c] -> 2obut[c] + cys_L[c] + nh4[c] CYSt2r cys_L[e] + h[e] <=> cys_L[c] + h[c] CYTD cytd[c] + h2o[c] + h[c] -> nh4[c] + uri[c] CYTDK1 atp[c] + cytd[c] -> adp[c] + cmp[c] + h[c] CYTDK2 cytd[c] + gtp[c] -> cmp[c] + gdp[c] + h[c] CYTDK3 cytd[c] + itp[c] -> cmp[c] + h[c] + idp[c] CYTDK4 cytd[c] + utp[c] -> cmp[c] + h[c] + udp[c] CYTK1 atp[c] + cmp[c] <=> adp[c] + cdp[c] CYTK2 atp[c] + dcmp[c] <=> adp[c] + dcdp[c] Cuabc atp[c] + cu2[e] + h2o[c] -> adp[c] + cu2[c] + h[c] + pi[c] Cut1 atp[c] + cu2[c] + h2o[c] -> adp[c] + cu2[e] + h[c] + pi[c] DADA dad_2[c] + h2o[c] + h[c] -> din[c] + nh4[c] DADNK atp[c] + dad_2[c] -> adp[c] + damp[c] + h[c] DALAt2r ala_D[e] + h[e] <=> ala_D[c] + h[c] DAPMDH 26dap_M[c] + h2o[c] + nadp[c] <=> h[c] + l2a6o[c] + nadph[c] + nh4[c] DAPabc 26dap_M[e] + atp[c] + h2o[c] -> 26dap_M[c] + adp[c] + h[c] + pi[c] DASYN120 ctp[c] + h[c] + pa120[c] -> cdpdddecg[c] + ppi[c] DASYN140 ctp[c] + h[c] + pa140[c] -> cdpdtdecg[c] + ppi[c] DASYN141 ctp[c] + h[c] + pa141[c] -> cdpdtdec7eg[c] + ppi[c] DASYN160 ctp[c] + h[c] + pa160[c] -> cdpdhdecg[c] + ppi[c] DASYN161 ctp[c] + h[c] + pa161[c] -> cdpdhdec9eg[c] + ppi[c] DASYN180 ctp[c] + h[c] + pa180[c] -> cdpdodecg[c] + ppi[c] DASYN181 ctp[c] + h[c] + pa181[c] -> cdpdodec11eg[c] + ppi[c] DASYNAI15 ctp[c] + h[c] + paai15[c] -> cdpdaipdecg[c] + ppi[c] DASYNAI17 ctp[c] + h[c] + paai17[c] -> cdpdaihpdecg[c] + ppi[c] DASYNI14 ctp[c] + h[c] + pai14[c] -> cdpditdecg[c] + ppi[c] DASYNI15 ctp[c] + h[c] + pai15[c] -> cdpdipdecg[c] + ppi[c] DASYNI16 ctp[c] + h[c] + pai16[c] -> cdpdihdecg[c] + ppi[c] DASYNI17 ctp[c] + h[c] + pai17[c] -> cdpdihpdecg[c] + ppi[c] DB4PS ru5p_D[c] -> db4p[c] + for[c] + h[c] DCMPDAi dcmp[c] + h2o[c] + h[c] -> dump[c] + nh4[c] DCYTD dcyt[c] + h2o[c] + h[c] -> duri[c] + nh4[c] DDPA e4p[c] + h2o[c] + pep[c] -> 2dda7p[c] + pi[c] DEXTRINASE dextrin[c] + 5 h2o[c] -> 6 glc_D[c] DEXTRINabc atp[c] + dextrin[e] + h2o[c] -> adp[c] + dextrin[c] + h[c] + pi[c] DGK1 atp[c] + dgmp[c] <=> adp[c] + dgdp[c] DHAPT dha[c] + pep[c] -> dhap[c] + pyr[c] DHDPRy 23dhdp[c] + h[c] + nadph[c] -> nadp[c] + thdp[c] DHDPS aspsa[c] + pyr[c] -> 23dhdp[c] + 2 h2o[c] + h[c] DHFOR2 dhf[c] + nadp[c] <=> fol[c] + nadph[c] DHFR dhf[c] + h[c] + nadph[c] <=> nadp[c] + thf[c] DHFS atp[c] + dhpt[c] + glu_L[c] -> adp[c] + dhf[c] + h[c] + pi[c] DHNAOT4 dhna[c] + h[c] + octdp[c] -> 2dmmql8[c] + co2[c] + ppi[c] DHORDfum dhor_S[c] + fum[c] -> orot[c] + succ[c] DHORTS dhor_S[c] + h2o[c] <=> cbasp[c] + h[c] DHPPDA 25dhpp[c] + h2o[c] + h[c] -> 5apru[c] + nh4[c] DHQS 2dda7p[c] -> 3dhq[c] + pi[c] DHQTi 3dhq[c] -> 3dhsk[c] + h2o[c] DMATT dmpp[c] + ipdp[c] -> grdp[c] + ppi[c] DMLARGAH dmlarg[c] + h2o[c] <=> citr_L[c] + dma[c] DMQMT 2omhmbl[c] + amet[c] -> ahcys[c] + h[c] + q8h2[c] DM_4HBA 4hba[c] -> DM_5MTR 5mtr[c] -> DM_HQN hqn[c] -> DM_atp_c_ atp[c] + h2o[c] -> adp[c] + h[c] + pi[c] DM_teich_45_BS(c) teich_45_BS[c] -> DPCOAK atp[c] + dpcoa[c] -> adp[c] + coa[c] + h[c] DPMVDc 5dpmev[c] + atp[c] -> adp[c] + co2[c] + ipdp[c] + pi[c] DRBK atp[c] + drib[c] -> 2dr5p[c] + adp[c] + h[c] DRIBabc atp[c] + drib[e] + h2o[c] -> adp[c] + drib[c] + h[c] + pi[c] DSERt2r h[e] + ser_D[e] <=> h[c] + ser_D[c] DTMPK atp[c] + dtmp[c] -> adp[c] + dtdp[c] DURIK1 atp[c] + duri[c] -> adp[c] + dump[c] + h[c] DUTPDP dutp[c] + h2o[c] -> dump[c] + h[c] + ppi[c] DXPS g3p[c] + h[c] + pyr[c] -> co2[c] + dxyl5p[c] D_LACD 2 ficytC[c] + lac_D[c] -> 2 focytC[c] + 2 h[c] + pyr[c] D_LACt2 h[e] + lac_D[e] <=> h[c] + lac_D[c] E4PD e4p[c] + h2o[c] + nad[c] <=> 4per[c] + 2 h[c] + nadh[c] EAR100x h[c] + nadh[c] + tdec2eACP[c] -> dcaACP[c] + nad[c] EAR10M12 10mtddec2eACP[c] + h[c] + nadph[c] -> 10mddcaACP[c] + nadp[c] EAR11M12x 11mtddec2eACP[c] + h[c] + nadh[c] -> 11mddcaACP[c] + nad[c] EAR120x h[c] + nadh[c] + tddec2eACP[c] -> ddcaACP[c] + nad[c] EAR12M14x 12mtmrs2eACP[c] + h[c] + nadh[c] -> 12mmyrsACP[c] + nad[c] EAR13M14x 13mtmrs2eACP[c] + h[c] + nadh[c] -> 13mmyrsACP[c] + nad[c] EAR140x h[c] + nadh[c] + tmrs2eACP[c] -> myrsACP[c] + nad[c] EAR14M16 14mtpalm2eACP[c] + h[c] + nadph[c] -> 14mpalmACP[c] + nadp[c] EAR15M16 15mtpalm2eACP[c] + h[c] + nadph[c] -> 15mpalmACP[c] + nadp[c] EAR160x h[c] + nadh[c] + tpalm2eACP[c] -> nad[c] + palmACP[c] EAR180x h[c] + nadh[c] + toctd2eACP[c] -> nad[c] + ocdcaACP[c] EAR40x but2eACP[c] + h[c] + nadh[c] -> butACP[c] + nad[c] EAR4M6 4mthex2eACP[c] + h[c] + nadph[c] -> 4mhexACP[c] + nadp[c] EAR5M6 5mthex2eACP[c] + h[c] + nadph[c] -> 5mhexACP[c] + nadp[c] EAR60x h[c] + nadh[c] + thex2eACP[c] -> hexACP[c] + nad[c] EAR6M8x 6mtoct2eACP[c] + h[c] + nadh[c] -> 6mocACP[c] + nad[c] EAR7M8x 7mtoct2eACP[c] + h[c] + nadh[c] -> 7mocACP[c] + nad[c] EAR80x h[c] + nadh[c] + toct2eACP[c] -> nad[c] + ocACP[c] EAR8M10x 8mtdec2eACP[c] + h[c] + nadh[c] -> 8mdcaACP[c] + nad[c] EAR9M10x 9mtdec2eACP[c] + h[c] + nadh[c] -> 9mdcaACP[c] + nad[c] EDA 2ddg6p[c] -> g3p[c] + pyr[c] EDD 6pgc[c] -> 2ddg6p[c] + h2o[c] EHGLAT akg[c] + e4hglu[c] -> 4h2oglt[c] + glu_L[c] ENO 2pg[c] <=> h2o[c] + pep[c] EX_26dap_M(e) 26dap_M[e] <=> EX_4abz(e) 4abz[e] <=> EX_ac(e) ac[e] <=> EX_acgam(e) acgam[e] <=> EX_ade(e) ade[e] <=> EX_adocbl(e) adocbl[e] <=> EX_ahcys(e) ahcys[e] <=> EX_akg(e) akg[e] <=> EX_ala_D(e) ala_D[e] <=> EX_ala_L(e) ala_L[e] <=> EX_alaasp(e) alaasp[e] <=> EX_alagln(e) alagln[e] <=> EX_alaglu(e) alaglu[e] <=> EX_alagly(e) alagly[e] <=> EX_alahis(e) alahis[e] <=> EX_alaleu(e) alaleu[e] <=> EX_alathr(e) alathr[e] <=> EX_arab_L(e) arab_L[e] <=> EX_arbt(e) arbt[e] <=> EX_arg_L(e) arg_L[e] <=> EX_asn_L(e) asn_L[e] <=> EX_aso3(e) aso3[e] <=> EX_aso4(e) aso4[e] <=> EX_asp_L(e) asp_L[e] <=> EX_biomass(e) biomass[c] <=> EX_btn(e) btn[e] <=> EX_ca2(e) ca2[e] <=> EX_cd2(e) cd2[e] <=> EX_cellb(e) cellb[e] <=> EX_cgly(e) cgly[e] <=> EX_chor(e) chor[e] <=> EX_cl(e) cl[e] <=> EX_co2(e) co2[e] <=> EX_cobalt2(e) cobalt2[e] <=> EX_cu2(e) cu2[e] <=> EX_cys_L(e) cys_L[e] <=> EX_dextrin(e) dextrin[e] <=> EX_drib(e) drib[e] <=> EX_fe3(e) fe3[e] <=> EX_fol(e) fol[e] <=> EX_for(e) for[e] <=> EX_fru(e) fru[e] <=> EX_fum(e) fum[e] <=> EX_galt(e) galt[e] <=> EX_gam(e) gam[e] <=> EX_glc_D(e) glc_D[e] <=> EX_glcn(e) glcn[e] <=> EX_gln_L(e) gln_L[e] <=> EX_glu_L(e) glu_L[e] <=> EX_gly(e) gly[e] <=> EX_glyasn(e) glyasn[e] <=> EX_glyasp(e) glyasp[e] <=> EX_glyc(e) glyc[e] <=> EX_glyc3p(e) glyc3p[e] <=> EX_glycys(e) glycys[e] <=> EX_glygln(e) glygln[e] <=> EX_glyglu(e) glyglu[e] <=> EX_glyleu(e) glyleu[e] <=> EX_glymet(e) glymet[e] <=> EX_glyphe(e) glyphe[e] <=> EX_glypro(e) glypro[e] <=> EX_glytyr(e) glytyr[e] <=> EX_h(e) h[e] <=> EX_h2o(e) h2o[e] <=> EX_h2s(e) h2s[e] <=> EX_hg2(e) hg2[e] <=> EX_his_L(e) his_L[e] <=> EX_hxan(e) hxan[e] <=> EX_ile_L(e) ile_L[e] <=> EX_ins(e) ins[e] <=> EX_k(e) k[e] <=> EX_lac_D(e) lac_D[e] <=> EX_lac_L(e) lac_L[e] <=> EX_lcts(e) lcts[e] <=> EX_leu_L(e) leu_L[e] <=> EX_lys_L(e) lys_L[e] <=> EX_mal_L(e) mal_L[e] <=> EX_malt(e) malt[e] <=> EX_malthx(e) malthx[e] <=> EX_malttr(e) malttr[e] <=> EX_man(e) man[e] <=> EX_met_D(e) met_D[e] <=> EX_met_L(e) met_L[e] <=> EX_metala(e) metala[e] <=> EX_metsox_R_L(e) metsox_R_L[e] <=> EX_metsox_S_L(e) metsox_S_L[e] <=> EX_mg2(e) mg2[e] <=> EX_mn2(e) mn2[e] <=> EX_mnl(e) mnl[e] <=> EX_mqn7(e) mqn7[e] <=> EX_mqn8(e) mqn8[e] <=> EX_na1(e) na1[e] <=> EX_nac(e) nac[e] <=> EX_ncam(e) ncam[e] <=> EX_nh4(e) nh4[e] <=> EX_o2(e) o2[e] <=> EX_ocdca(e) ocdca[e] <=> EX_orn(e) orn[e] <=> EX_pb(e) pb[e] <=> EX_phe_L(e) phe_L[e] <=> EX_pheme(e) pheme[e] <=> EX_pi(e) pi[e] <=> EX_pnto_R(e) pnto_R[e] <=> EX_ppi(e) ppi[e] <=> EX_ppt(e) ppt[e] <=> EX_pro_L(e) pro_L[e] <=> EX_ptrc(e) ptrc[e] <=> EX_pydx(e) pydx[e] <=> EX_pydxn(e) pydxn[e] <=> EX_pyr(e) pyr[e] <=> EX_q8(e) q8[e] <=> EX_rib_D(e) rib_D[e] <=> EX_ribflv(e) ribflv[e] <=> EX_salcn(e) salcn[e] <=> EX_sbt_D(e) sbt_D[e] <=> EX_ser_D(e) ser_D[e] <=> EX_ser_L(e) ser_L[e] <=> EX_sheme(e) sheme[e] <=> EX_so4(e) so4[e] <=> EX_spmd(e) spmd[e] <=> EX_succ(e) succ[e] <=> EX_sucr(e) sucr[e] <=> EX_thm(e) thm[e] <=> EX_thr_L(e) thr_L[e] <=> EX_thymd(e) thymd[e] <=> EX_tre(e) tre[e] <=> EX_trp_L(e) trp_L[e] <=> EX_tyr_L(e) tyr_L[e] <=> EX_ura(e) ura[e] <=> EX_val_L(e) val_L[e] <=> EX_xan(e) xan[e] <=> EX_zn2(e) zn2[e] <=> F6PE4PL f6p[c] + pi[c] -> actp[c] + e4p[c] + h2o[c] FACOAL140i atp[c] + coa[c] + ttdca[c] -> amp[c] + ppi[c] + tdcoa[c] FACOAL160i atp[c] + coa[c] + hdca[c] -> amp[c] + pmtcoa[c] + ppi[c] FACOAL161 atp[c] + coa[c] + hdcea[c] <=> amp[c] + hdcoa[c] + ppi[c] FACOAL180i atp[c] + coa[c] + ocdca[c] -> amp[c] + ppi[c] + stcoa[c] FACOAL181i atp[c] + coa[c] + ocdcea[c] -> amp[c] + odecoa[c] + ppi[c] FACOALAI15 atp[c] + coa[c] + fa4[c] <=> aipdcoa[c] + amp[c] + ppi[c] FACOALAI17 atp[c] + coa[c] + fa12[c] <=> aihpdcoa[c] + amp[c] + ppi[c] FACOALI14 atp[c] + coa[c] + fa1[c] <=> amp[c] + itdcoa[c] + ppi[c] FACOALI15 atp[c] + coa[c] + fa3[c] <=> amp[c] + ipdcoa[c] + ppi[c] FACOALI16 atp[c] + coa[c] + fa6[c] <=> amp[c] + ihdcoa[c] + ppi[c] FACOALI17 atp[c] + coa[c] + fa11[c] <=> amp[c] + ihpdcoa[c] + ppi[c] FBA fdp[c] <=> dhap[c] + g3p[c] FBA2 f1p[c] <=> dhap[c] + glyald[c] FBA3 s17bp[c] <=> dhap[c] + e4p[c] FE2DH 2 fe2[c] + h[c] + nad[c] <=> 2 fe3[c] + nadh[c] FE3abc atp[c] + fe3[e] + h2o[c] -> adp[c] + fe3[c] + h[c] + pi[c] FERO 4 fe2[c] + 4 h[c] + o2[c] -> 4 fe3[c] + 2 h2o[c] FFSD h2o[c] + suc6p[c] -> fru[c] + g6p[c] FMNAT atp[c] + fmn[c] + h[c] -> fad[c] + ppi[c] FOLt fol[e] + h[e] <=> fol[c] + h[c] FOMETR 5fthf[c] + h[c] <=> h2o[c] + methf[c] FORt for[e] <=> for[c] FPGS7 10fthf[c] + atp[c] + 4 glu_L[c] -> 10fthf5glu[c] + adp[c] + 3 h2o[c] + h[c] + pi[c] FPGS_tm atp[c] + glu_L[c] + thf[c] -> adp[c] + h[c] + pi[c] + thfglu[c] FRD2 fum[c] + mql8[c] -> mqn8[c] + succ[c] FRD3 2dmmql8[c] + fum[c] -> 2dmmq8[c] + succ[c] FRD7 fum[c] + q8h2[c] -> q8[c] + succ[c] FRTT frdp[c] + ipdp[c] -> ggdp[c] + ppi[c] FRUK atp[c] + f1p[c] -> adp[c] + fdp[c] + h[c] FRUpts fru[e] + pep[c] -> f1p[c] + pyr[c] FT frdp[c] + ipdp[c] -> ppi[c] + ttc_ggdp[c] FTHFCL 5fthf[c] + atp[c] -> adp[c] + methf[c] + pi[c] FTHFD 10fthf[c] + h2o[c] -> for[c] + h[c] + thf[c] FTHFL atp[c] + for[c] + thf[c] -> 10fthf[c] + adp[c] + pi[c] FUM fum[c] + h2o[c] <=> mal_L[c] G1PACT accoa[c] + gam1p[c] -> acgam1p[c] + coa[c] + h[c] G1SAT glu1sa[c] <=> 5aop[c] G3PAT120 ddcaACP[c] + glyc3p[c] -> 1ddecg3p[c] + ACP[c] G3PAT140 glyc3p[c] + myrsACP[c] -> 1tdecg3p[c] + ACP[c] G3PAT141 glyc3p[c] + tdeACP[c] -> 1tdec7eg3p[c] + ACP[c] G3PAT160 glyc3p[c] + palmACP[c] -> 1hdecg3p[c] + ACP[c] G3PAT161 glyc3p[c] + hdeACP[c] -> 1hdec9eg3p[c] + ACP[c] G3PAT180 glyc3p[c] + ocdcaACP[c] -> 1odecg3p[c] + ACP[c] G3PAT181 glyc3p[c] + octeACP[c] -> 1odec11eg3p[c] + ACP[c] G3PATAI15 aipdcoa[c] + glyc3p[c] + h[c] -> 1aipdecg3p[c] + coa[c] G3PATAI17 aihpdcoa[c] + glyc3p[c] -> 1aihpdecg3p[c] + coa[c] G3PATI14 glyc3p[c] + h[c] + itdcoa[c] -> 1itdecg3p[c] + coa[c] G3PATI15 glyc3p[c] + h[c] + ipdcoa[c] -> 1ipdecg3p[c] + coa[c] G3PATI16 glyc3p[c] + h[c] + ihdcoa[c] -> 1ihdecg3p[c] + coa[c] G3PATI17 glyc3p[c] + ihpdcoa[c] -> 1ihpdecg3p[c] + coa[c] G3PCT ctp[c] + glyc3p[c] + h[c] -> cdpglyc[c] + ppi[c] G3PD1 glyc3p[c] + nad[c] <=> dhap[c] + h[c] + nadh[c] G3PD2 glyc3p[c] + nadp[c] -> dhap[c] + h[c] + nadph[c] G5SADs glu5sa[c] -> 1pyr5c[c] + h2o[c] + h[c] G6PBDH g6p_B[c] + nadp[c] <=> 6pgl[c] + h[c] + nadph[c] G6PDA gam6p[c] + h2o[c] -> f6p[c] + nh4[c] G6PDH2 g6p[c] + nadp[c] -> 6pgl[c] + h[c] + nadph[c] G6PI g6p[c] <=> g6p_B[c] G6PI3 g6p_B[c] <=> f6p[c] GALK atp[c] + gal[c] -> adp[c] + gal1p[c] + h[c] GALM1r glc_bD[c] <=> glc_D[c] GALT gal1p[c] + h[c] + utp[c] <=> ppi[c] + udpgal[c] GALTpts galt[e] + pep[c] -> galt1p[c] + pyr[c] GALU g1p[c] + h[c] + utp[c] <=> ppi[c] + udpg[c] GAMpts gam[e] + pep[c] -> gam6p[c] + pyr[c] GAPD g3p[c] + nad[c] + pi[c] <=> 13dpg[c] + h[c] + nadh[c] GF6PTA f6p[c] + gln_L[c] -> gam6p[c] + glu_L[c] GGTA cgly[c] + glu_L[c] -> gthrd[c] + h2o[c] GGTT ggdp[c] + ipdp[c] -> pendp[c] + ppi[c] GHMT2r ser_L[c] + thf[c] <=> gly[c] + h2o[c] + mlthf[c] GK1 atp[c] + gmp[c] <=> adp[c] + gdp[c] GK2 datp[c] + gmp[c] <=> dadp[c] + gdp[c] GLCDe glc_D[e] + h2o[e] + q8[c] -> glcn[e] + h[e] + q8h2[c] GLCNt2r glcn[e] + h[e] <=> glcn[c] + h[c] GLCTR4r pi[c] + sucr[c] <=> fru[c] + g1p[c] GLCabc atp[c] + glc_D[e] + h2o[c] -> adp[c] + glc_D[c] + h[c] + pi[c] GLCpts glc_D[e] + pep[c] -> g6p[c] + pyr[c] GLNS atp[c] + glu_L[c] + nh4[c] -> adp[c] + gln_L[c] + h[c] + pi[c] GLNSP1 atp[c] + nh4[c] + uaaAgla[c] -> adp[c] + h[c] + pi[c] + uaaAgtla[c] GLNSP2 atp[c] + nh4[c] + uaaGgla[c] -> adp[c] + h[c] + pi[c] + uaaGgtla[c] GLNSP3 atp[c] + nh4[c] + uaagmda[c] -> adp[c] + h[c] + pi[c] + uaagtmda[c] GLNabc atp[c] + gln_L[e] + h2o[c] -> adp[c] + gln_L[c] + h[c] + pi[c] GLUCYS atp[c] + cys_L[c] + glu_L[c] -> adp[c] + glucys[c] + h[c] + pi[c] GLUR glu_D[c] <=> glu_L[c] GLUTRR glutrna[c] + h[c] + nadph[c] -> glu1sa[c] + nadp[c] + trnaglu[c] GLUTRS atp[c] + glu_L[c] + trnaglu[c] -> amp[c] + glutrna[c] + ppi[c] GLUt2r glu_L[e] + h[e] <=> glu_L[c] + h[c] GLYASN1c glyasn[c] + h2o[c] <=> asn_L[c] + gly[c] GLYASNabc atp[c] + glyasn[e] + h2o[c] -> adp[c] + glyasn[c] + h[c] + pi[c] GLYASP1c glyasp[c] + h2o[c] <=> asp_L[c] + gly[c] GLYASPabc atp[c] + glyasp[e] + h2o[c] -> adp[c] + glyasp[c] + h[c] + pi[c] GLYC3Pabc atp[c] + glyc3p[e] + h2o[c] -> adp[c] + glyc3p[c] + h[c] + pi[c] GLYCTO1 glyclt[c] + o2[c] -> glx[c] + h2o2[c] GLYCTO2 glyclt[c] + q8[c] -> glx[c] + q8h2[c] GLYCTO3 glyclt[c] + mqn8[c] -> glx[c] + mql8[c] GLYCTO4 2dmmq8[c] + glyclt[c] -> 2dmmql8[c] + glx[c] GLYCYSabc atp[c] + glycys[e] + h2o[c] -> adp[c] + glycys[c] + h[c] + pi[c] GLYCt glyc[c] <=> glyc[e] GLYGLN1c glygln[c] + h2o[c] <=> gln_L[c] + gly[c] GLYGLNabc atp[c] + glygln[e] + h2o[c] -> adp[c] + glygln[c] + h[c] + pi[c] GLYGLU1c glyglu[c] + h2o[c] <=> glu_L[c] + gly[c] GLYGLUabc atp[c] + glyglu[e] + h2o[c] -> adp[c] + glyglu[c] + h[c] + pi[c] GLYK atp[c] + glyc[c] -> adp[c] + glyc3p[c] + h[c] GLYLEUHYDROc glyleu[c] + h2o[c] <=> gly[c] + leu_L[c] GLYLEUPEPT1tc glyleu[e] + h[e] -> glyleu[c] + h[c] GLYMET1c glymet[c] + h2o[c] <=> gly[c] + met_L[c] GLYMETabc atp[c] + glymet[e] + h2o[c] -> adp[c] + glymet[c] + h[c] + pi[c] GLYPHEHYc glyphe[c] + h2o[c] <=> gly[c] + phe_L[c] GLYPHEabc atp[c] + glyphe[e] + h2o[c] -> adp[c] + glyphe[c] + h[c] + pi[c] GLYPROPRO1c glypro[c] + h2o[c] <=> gly[c] + pro_L[c] GLYPROabc atp[c] + glypro[e] + h2o[c] -> adp[c] + glypro[c] + h[c] + pi[c] GLYTYR1c glytyr[c] + h2o[c] <=> gly[c] + tyr_L[c] GLYTYRabc atp[c] + glytyr[e] + h2o[c] -> adp[c] + glytyr[c] + h[c] + pi[c] GLYt2r gly[e] + h[e] <=> gly[c] + h[c] GMPR gmp[c] + 2 h[c] + nadph[c] -> imp[c] + nadp[c] + nh4[c] GMPS2 atp[c] + gln_L[c] + h2o[c] + xmp[c] -> amp[c] + glu_L[c] + gmp[c] + 2 h[c] + ppi[c] GND 6pgc[c] + nadp[c] -> co2[c] + nadph[c] + ru5p_D[c] GND2 6pgc[c] + nad[c] -> co2[c] + nadh[c] + ru5p_D[c] GNK atp[c] + glcn[c] -> 6pgc[c] + adp[c] + h[c] GNNUC gsn[c] + h2o[c] -> gua[c] + rib_D[c] GPDDA1 g3pc[c] + h2o[c] -> chol[c] + glyc3p[c] + h[c] GPDDA2 g3pe[c] + h2o[c] -> etha[c] + glyc3p[c] + h[c] GPDDA3 g3ps[c] + h2o[c] -> glyc3p[c] + h[c] + ser_L[c] GPDDA4 g3pg[c] + h2o[c] -> glyc3p[c] + glyc[c] + h[c] GRTT grdp[c] + ipdp[c] -> frdp[c] + ppi[c] GTHS atp[c] + glucys[c] + gly[c] -> adp[c] + gthrd[c] + h[c] + pi[c] GTPCII gtp[c] + 3 h2o[c] -> 25dhpp[c] + for[c] + 2 h[c] + ppi[c] GTPDPK atp[c] + gtp[c] -> amp[c] + gdptp[c] + h[c] GUAPRT gua[c] + prpp[c] -> gmp[c] + ppi[c] H2CO3D co2[c] + h2o[c] <=> h[c] + hco3[c] H2Ot h2o[e] <=> h2o[c] HACD1 aacoa[c] + h[c] + nadh[c] <=> 3hbcoa[c] + nad[c] HACD2 3ohcoa[c] + h[c] + nadh[c] <=> 3hhcoa[c] + nad[c] HACD3 3oocoa[c] + h[c] + nadh[c] <=> 3hocoa[c] + nad[c] HACD4 3odcoa[c] + h[c] + nadh[c] <=> 3hdcoa[c] + nad[c] HACD5 3oddcoa[c] + h[c] + nadh[c] <=> 3hddcoa[c] + nad[c] HACD6 3otdcoa[c] + h[c] + nadh[c] <=> 3htdcoa[c] + nad[c] HACD7 3ohdcoa[c] + h[c] + nadh[c] <=> 3hhdcoa[c] + nad[c] HACD9 3hmbcoa[c] + nad[c] <=> 2maacoa[c] + h[c] + nadh[c] HADPCOADH3 3hadpcoa[c] + nad[c] -> h[c] + nadh[c] + oxadpcoa[c] HBZOPT 4hbz[c] + octdp[c] -> 3ophb[c] + ppi[c] HDG3PACT glyc3p[c] + ihdcoa[c] <=> 1hdecg3p[c] + coa[c] HEMEti atp[c] + h2o[c] + pheme[e] -> adp[c] + h[c] + pheme[c] + pi[c] HETT hepdp[c] + ipdp[c] -> octdp[c] + ppi[c] HEX1 atp[c] + glc_D[c] -> adp[c] + g6p[c] + h[c] HEX7 atp[c] + fru[c] -> adp[c] + f6p[c] + h[c] HEXTT hexdp[c] + ipdp[c] -> hepdp[c] + ppi[c] HG2abc atp[c] + h2o[c] + hg2[c] -> adp[c] + h[c] + hg2[e] + pi[c] HIBD 3hmp[c] + nad[c] -> 2mop[c] + h[c] + nadh[c] HISt2r h[e] + his_L[e] <=> h[c] + his_L[c] HMBS h2o[c] + 4 ppbng[c] -> hmbil[c] + 4 nh4[c] HMGCOAS coa[c] + h[c] + hmgcoa[c] <=> aacoa[c] + accoa[c] + h2o[c] HMPK1 4ahmmp[c] + atp[c] -> 4ampm[c] + adp[c] + h[c] HXPRT hxan[c] + prpp[c] -> imp[c] + ppi[c] HYD1 h2[c] + 2 h[c] + q8[c] -> 2 h[e] + q8h2[c] HYXNt hxan[e] <=> hxan[c] ICHORS chor[c] <=> ichor[c] IHDUDPG m12dihglyc[c] + udpg[c] <=> diglcpgi17[c] + h[c] + udp[c] IHDUDPMG 12dihdglyc[c] + udpg[c] <=> h[c] + m12dihglyc[c] + udp[c] IHPDCOATA 15mpalmACP[c] + coa[c] <=> ACP[c] + ihpdcoa[c] ILETA akg[c] + ile_L[c] <=> 3mop[c] + glu_L[c] ILEt2r h[e] + ile_L[e] <=> h[c] + ile_L[c] IMPD h2o[c] + imp[c] + nad[c] -> h[c] + nadh[c] + xmp[c] INSH h2o[c] + ins[c] -> hxan[c] + rib_D[c] INSt2i h[e] + ins[e] -> h[c] + ins[c] IPDDI ipdp[c] <=> dmpp[c] ISOMALT h2o[c] + isomal[c] -> 2 glc_D[c] IVCOATA ACP[c] + ivcoa[c] <=> 3mbutACP[c] + coa[c] KAS14 acACP[c] + h[c] + malACP[c] -> ACP[c] + actACP[c] + co2[c] Kt1r k[e] <=> k[c] L2A6OD2s h2o[c] + h[c] + thdp[c] -> l2a6o[c] L2A6ODs l2a6o[c] -> h2o[c] + h[c] + thdp[c] LACpts lcts[e] + pep[c] -> lac6p[c] + pyr[c] LDH_D lac_D[c] + nad[c] <=> h[c] + nadh[c] + pyr[c] LDH_D2 lac_D[c] + q8[c] -> pyr[c] + q8h2[c] LDH_L lac_L[c] + nad[c] <=> h[c] + nadh[c] + pyr[c] LEUt2r h[e] + leu_L[e] <=> h[c] + leu_L[c] LLEUDr h2o[c] + leu_L[c] + nad[c] <=> 4mop[c] + h[c] + nadh[c] + nh4[c] LYSt3r h[e] + lys_L[c] <=> h[c] + lys_L[e] L_LACD 2 ficytC[c] + lac_L[c] -> 2 focytC[c] + 2 h[c] + pyr[c] L_LACD2 lac_L[c] + q8[c] -> pyr[c] + q8h2[c] L_LACD3 lac_L[c] + mqn8[c] -> mql8[c] + pyr[c] L_LACt2r h[e] + lac_L[e] <=> h[c] + lac_L[c] MACCOAT 2maacoa[c] + coa[c] -> accoa[c] + ppcoa[c] MALNAt mal_L[e] + na1[e] <=> mal_L[c] + na1[c] MALT h2o[c] + malt[c] -> 2 glc_D[c] MALT6PH h2o[c] + malt6p[c] -> g6p[c] + glc_D[c] MALTHXabc atp[c] + h2o[c] + malthx[e] -> adp[c] + h[c] + malthx[c] + pi[c] MALTTRabc atp[c] + h2o[c] + malttr[e] -> adp[c] + h[c] + malttr[c] + pi[c] MALTabc atp[c] + h2o[c] + malt[e] -> adp[c] + h[c] + malt[c] + pi[c] MALTpts malt[e] + pep[c] -> malt6p[c] + pyr[c] MALt2r h[e] + mal_L[e] <=> h[c] + mal_L[c] MAN6PI man6p[c] <=> f6p[c] MANpts man[e] + pep[c] -> man6p[c] + pyr[c] MCOATA ACP[c] + malcoa[c] <=> coa[c] + malACP[c] MDDCP1 h2o[c] + murein5px4p[c] <=> ala_D[c] + murein4px4p[c] MDDCP4 h2o[c] + murein5p4p[c] <=> ala_D[c] + murein4p4p[c] MDDEP1 h2o[c] + murein4px4p[c] <=> murein4p4p[c] MDDEP4 h2o[c] + murein4px4px4p[c] <=> murein4px4p4p[c] MDH mal_L[c] + nad[c] <=> h[c] + nadh[c] + oaa[c] ME1 mal_L[c] + nad[c] -> co2[c] + nadh[c] + pyr[c] METALA1c h2o[c] + metala[c] <=> ala_L[c] + met_L[c] METALAabc atp[c] + h2o[c] + metala[e] -> adp[c] + h[c] + metala[c] + pi[c] METAT atp[c] + h2o[c] + met_L[c] -> amet[c] + pi[c] + ppi[c] METDabc atp[c] + h2o[c] + met_D[e] -> adp[c] + h[c] + met_D[c] + pi[c] METSOX1abc atp[c] + h2o[c] + metsox_S_L[e] -> adp[c] + h[c] + metsox_S_L[c] + pi[c] METSOX2abc atp[c] + h2o[c] + metsox_R_L[e] -> adp[c] + h[c] + metsox_R_L[c] + pi[c] METSOXR1r metsox_S_L[c] + trdrd[c] <=> h2o[c] + met_L[c] + trdox[c] METabc atp[c] + h2o[c] + met_L[e] -> adp[c] + h[c] + met_L[c] + pi[c] MEVK1c atp[c] + mev_R[c] -> 5pmev[c] + adp[c] + h[c] MG2abc atp[c] + h2o[c] + mg2[e] -> adp[c] + h[c] + mg2[c] + pi[c] MGt5 mg2[c] <=> mg2[e] MLTG1 h2o[c] + malttr[c] -> glc_D[c] + malt[c] MLTG2 h2o[c] + maltttr[c] -> glc_D[c] + malttr[c] MLTG3 h2o[c] + maltpt[c] -> glc_D[c] + maltttr[c] MLTG4 h2o[c] + malthx[c] -> glc_D[c] + maltpt[c] MLTG5 h2o[c] + malthp[c] -> glc_D[c] + malthx[c] MLTP4 malt[c] + pi[c] <=> g1p_B[c] + glc_D[c] MNLpts mnl[e] + pep[c] -> mnl1p[c] + pyr[c] MNabc atp[c] + h2o[c] + mn2[e] -> adp[c] + h[c] + mn2[c] + pi[c] MTAN 5mta[c] + h2o[c] -> 5mtr[c] + ade[c] MTHFC h2o[c] + methf[c] <=> 10fthf[c] + h[c] MTHFD mlthf[c] + nadp[c] <=> methf[c] + nadph[c] NACUP nac[e] -> nac[c] NADH10 h[c] + mqn8[c] + nadh[c] -> mql8[c] + nad[c] NADH5 h[c] + nadh[c] + q8[c] -> nad[c] + q8h2[c] NADH9 2dmmq8[c] + h[c] + nadh[c] -> 2dmmql8[c] + nad[c] NADK atp[c] + nad[c] -> adp[c] + h[c] + nadp[c] NADK2 dttp[c] + nad[c] -> dtdp[c] + h[c] + nadp[c] NADS1 atp[c] + dnad[c] + nh4[c] -> amp[c] + h[c] + nad[c] + ppi[c] NAPRT h[c] + nac[c] + prpp[c] -> nicrnt[c] + ppi[c] NAt3 h[e] + na1[c] -> h[c] + na1[e] NCAMt2r h[c] + ncam[c] <=> h[e] + ncam[e] NDPK1 atp[c] + gdp[c] <=> adp[c] + gtp[c] NDPK10 atp[c] + didp[c] <=> adp[c] + ditp[c] NDPK2 atp[c] + udp[c] <=> adp[c] + utp[c] NDPK3 atp[c] + cdp[c] <=> adp[c] + ctp[c] NDPK4 atp[c] + dtdp[c] <=> adp[c] + dttp[c] NDPK5 atp[c] + dgdp[c] <=> adp[c] + dgtp[c] NDPK6 atp[c] + dudp[c] <=> adp[c] + dutp[c] NDPK7 atp[c] + dcdp[c] <=> adp[c] + dctp[c] NDPK8 atp[c] + dadp[c] <=> adp[c] + datp[c] NDPK9 atp[c] + idp[c] <=> adp[c] + itp[c] NH4tb nh4[e] <=> nh4[c] NNATr atp[c] + h[c] + nicrnt[c] -> dnad[c] + ppi[c] NNDMBRT dmbzid[c] + nicrnt[c] -> 5prdmbz[c] + h[c] + nac[c] NNDPR 2 h[c] + prpp[c] + quln[c] -> co2[c] + nicrnt[c] + ppi[c] NPHS sbzcoa[c] -> coa[c] + dhna[c] NTD12 dimp[c] + h2o[c] -> din[c] + pi[c] NTD3 dcmp[c] + h2o[c] -> dcyt[c] + pi[c] NTD8 dgmp[c] + h2o[c] -> dgsn[c] + pi[c] NTP3 gtp[c] + h2o[c] -> gdp[c] + h[c] + pi[c] O2t5i o2[e] -> o2[c] OCBT cbp[c] + orn[c] <=> citr_L[c] + h[c] + pi[c] OCDCAt2 h[e] + ocdca[e] -> h[c] + ocdca[c] OHPHM 2ohph[c] + amet[c] -> 2omph[c] + ahcys[c] + h[c] OIVD1r 4mop[c] + coa[c] + nad[c] <=> co2[c] + ivcoa[c] + nadh[c] OIVD3 3mop[c] + coa[c] + nad[c] -> 2mbcoa[c] + co2[c] + nadh[c] OMBZLM 2ombzl[c] + amet[c] -> 2ommbl[c] + ahcys[c] + h[c] OMMBLHX3 2ommbl[c] + 2 atp[c] + 3 h2o[c] + nad[c] -> 2omhmbl[c] + 2 adp[c] + 3 h[c] + nadh[c] + 2 pi[c] OMPDC h[c] + orot5p[c] -> co2[c] + ump[c] OMPHHX3 2omph[c] + 2 atp[c] + 3 h2o[c] + nad[c] -> 2ombzl[c] + 2 adp[c] + 3 h[c] + nadh[c] + 2 pi[c] OPHBDC 3ophb[c] + h[c] -> 2oph[c] + co2[c] OPHHX3 2oph[c] + 2 atp[c] + 3 h2o[c] + nad[c] -> 2ohph[c] + 2 adp[c] + 3 h[c] + nadh[c] + 2 pi[c] ORNCD orn[c] -> nh4[c] + pro_L[c] ORNDC h[c] + orn[c] -> co2[c] + ptrc[c] OROTPT orot[c] + prpp[c] -> orot5p[c] + ppi[c] PAAI17P h2o[c] + paai17[c] -> 12daihdglyc[c] + pi[c] PAI17P h2o[c] + pai17[c] -> 12dihdglyc[c] + pi[c] PAPA180 h2o[c] + pa180[c] -> 12dgr180[c] + pi[c] PAPPT2 uGgla[c] + udcpp[c] -> uaGgla[c] + ump[c] PAPPT3 udcpp[c] + ugmda[c] -> uagmda[c] + ump[c] PBt atp[c] + h2o[c] + pb[c] -> adp[c] + h[c] + pb[e] + pi[c] PDX5PO o2[c] + pdx5p[c] -> h2o2[c] + pydx5p[c] PEPGLY PGPm1[c] + h[c] + uaagmda[c] -> PGP[c] + co2[c] + udcpdp[c] PFK atp[c] + f6p[c] -> adp[c] + fdp[c] + h[c] PFK_2 atp[c] + tag6p_D[c] -> adp[c] + h[c] + tagdp_D[c] PFK_3 atp[c] + s7p[c] -> adp[c] + h[c] + s17bp[c] PGAMT gam1p[c] <=> gam6p[c] PGCDr 3pg[c] + nad[c] <=> 3php[c] + h[c] + nadh[c] PGI g6p[c] <=> f6p[c] PGK 3pg[c] + atp[c] <=> 13dpg[c] + adp[c] PGL 6pgl[c] + h2o[c] -> 6pgc[c] + h[c] PGM 2pg[c] <=> 3pg[c] PGMT g1p[c] <=> g6p[c] PGMT2 g1p_B[c] <=> g6p_B[c] PGPGT prl45tca[c] + 45 udpg[c] <=> 45 h[c] + prl45tcaglc[c] + 45 udp[c] PGPP180 h2o[c] + pgp180[c] -> pg180[c] + pi[c] PGPPAI17 h2o[c] + pgpai17[c] -> pgai17[c] + pi[c] PGPPI17 h2o[c] + pgpi17[c] -> pgi17[c] + pi[c] PGSA120 cdpdddecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp120[c] PGSA140 cdpdtdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp140[c] PGSA141 cdpdtdec7eg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp141[c] PGSA160 cdpdhdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp160[c] PGSA161 cdpdhdec9eg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp161[c] PGSA180 cdpdodecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp180[c] PGSA181 cdpdodec11eg[c] + glyc3p[c] -> cmp[c] + h[c] + pgp181[c] PGSAAI15 cdpdaipdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpai15[c] PGSAAI17 cdpdaihpdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpai17[c] PGSAI14 cdpditdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpi14[c] PGSAI15 cdpdipdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpi15[c] PGSAI16 cdpdihdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpi16[c] PGSAI17 cdpdihpdecg[c] + glyc3p[c] -> cmp[c] + h[c] + pgpi17[c] PHEt2r h[e] + phe_L[e] <=> h[c] + phe_L[c] PHPB2i aacoa[c] + h[c] + nadph[c] -> 3hbcoa[c] + nadp[c] PIabc atp[c] + h2o[c] + pi[e] -> adp[c] + h[c] + 2 pi[c] PIt6b h[e] + pi[e] <=> h[c] + pi[c] PMEVKc 5pmev[c] + atp[c] -> 5dpmev[c] + adp[c] PMPK 4ampm[c] + atp[c] -> 2mahmp[c] + adp[c] PNTK atp[c] + pnto_R[c] -> 4ppan[c] + adp[c] + h[c] PNTOt2 h[e] + pnto_R[e] <=> h[c] + pnto_R[c] PPA h2o[c] + ppi[c] -> h[c] + 2 pi[c] PPAKr adp[c] + ppap[c] <=> atp[c] + ppa[c] PPBNGS 2 5aop[c] -> 2 h2o[c] + h[c] + ppbng[c] PPCDC 4ppcys[c] + h[c] -> co2[c] + pan4p[c] PPIt2e h[c] + ppi[c] -> h[e] + ppi[e] PPNCL3 4ppan[c] + atp[c] + cys_L[c] -> 4ppcys[c] + amp[c] + h[c] + ppi[c] PPS atp[c] + h2o[c] + pyr[c] -> amp[c] + 2 h[c] + pep[c] + pi[c] PPTT ipdp[c] + pendp[c] -> hexdp[c] + ppi[c] PPTabc atp[c] + h2o[c] + ppt[e] <=> adp[c] + h[c] + pi[c] + ppt[c] PROTRS atp[c] + pro_L[c] + trnapro[c] -> amp[c] + ppi[c] + protrna[c] PROt2r h[e] + pro_L[e] <=> h[c] + pro_L[c] PRPPS atp[c] + r5p[c] <=> amp[c] + h[c] + prpp[c] PSCVT pep[c] + skm5p[c] <=> 3psme[c] + pi[c] PSD180 h[c] + ps180[c] -> co2[c] + pe180[c] PSDAI17 h[c] + psai17[c] -> co2[c] + peai17[c] PSDI17 h[c] + psi17[c] -> co2[c] + pei17[c] PSSA180 cdpdodecg[c] + ser_L[c] -> cmp[c] + h[c] + ps180[c] PSSAAI17 cdpdaihpdecg[c] + ser_L[c] -> cmp[c] + h[c] + psai17[c] PSSAI17 cdpdihpdecg[c] + ser_L[c] -> cmp[c] + h[c] + psi17[c] PTA2 pi[c] + ppcoa[c] -> coa[c] + ppap[c] PTAr accoa[c] + pi[c] <=> actp[c] + coa[c] PTPAT atp[c] + h[c] + pan4p[c] -> dpcoa[c] + ppi[c] PTRCabc atp[c] + h2o[c] + ptrc[e] -> adp[c] + h[c] + pi[c] + ptrc[c] PYDXK atp[c] + pydx[c] -> adp[c] + h[c] + pydx5p[c] PYDXNK atp[c] + pydxn[c] -> adp[c] + h[c] + pdx5p[c] PYDXNabc atp[c] + h2o[c] + pydxn[e] -> adp[c] + h[c] + pi[c] + pydxn[c] PYDXtr pydx[e] <=> pydx[c] PYK adp[c] + h[c] + pep[c] -> atp[c] + pyr[c] PYNP2r pi[c] + uri[c] <=> r1p[c] + ura[c] PYROX h[c] + o2[c] + pi[c] + pyr[c] -> actp[c] + co2[c] + h2o2[c] PYRt2r h[e] + pyr[e] <=> h[c] + pyr[c] Q8abc atp[c] + h2o[c] + q8[e] -> adp[c] + h[c] + pi[c] + q8[c] QULNS dhap[c] + iasp[c] -> 2 h2o[c] + pi[c] + quln[c] RAFH h2o[c] + raffin[c] -> fru[c] + melib[c] RBFK atp[c] + ribflv[c] -> adp[c] + fmn[c] + h[c] RBFSa 4r5au[c] + db4p[c] -> dmlz[c] + 2 h2o[c] + pi[c] RBFSb 2 dmlz[c] -> 4r5au[c] + ribflv[c] RBK atp[c] + rib_D[c] -> adp[c] + h[c] + r5p[c] RE3009C paps[c] + trdrd[c] -> 2 h[c] + pap[c] + so3[c] + trdox[c] RIBABCte atp[c] + h2o[c] + rib_D[c] -> adp[c] + h[c] + pi[c] + rib_D[e] RIBFLVt2r h[e] + ribflv[e] <=> h[c] + ribflv[c] RIBabc atp[c] + h2o[c] + rib_D[e] -> adp[c] + h[c] + pi[c] + rib_D[c] RNDR2 gdp[c] + trdrd[c] -> dgdp[c] + h2o[c] + trdox[c] RNTR1 atp[c] + trdrd[c] -> datp[c] + h2o[c] + trdox[c] RNTR2 gtp[c] + trdrd[c] -> dgtp[c] + h2o[c] + trdox[c] RNTR3 ctp[c] + trdrd[c] -> dctp[c] + h2o[c] + trdox[c] RNTR4 trdrd[c] + utp[c] -> dutp[c] + h2o[c] + trdox[c] RPE ru5p_D[c] <=> xu5p_D[c] RPI r5p[c] <=> ru5p_D[c] RZ5PP 5prdmbz[c] + h2o[c] -> pi[c] + rdmbzi[c] SALCpts pep[c] + salcn[e] -> pyr[c] + salc6p[c] SBTpts pep[c] + sbt_D[e] -> pyr[c] + sbt6p[c] SELMETAT atp[c] + h2o[c] + selmeth[c] -> pi[c] + ppi[c] + seasmet[c] SERt2r h[e] + ser_L[e] <=> h[c] + ser_L[c] SGAT glyc3p[c] + stcoa[c] -> 1odecg3p[c] + coa[c] SHCHD2 dscl[c] + nad[c] -> h[c] + nadh[c] + scl[c] SHCHF fe2[c] + scl[c] -> 3 h[c] + sheme[c] SHEMEabc atp[c] + h2o[c] + sheme[e] -> adp[c] + h[c] + pi[c] + sheme[c] SHK3Dr 3dhsk[c] + h[c] + nadph[c] <=> nadp[c] + skm[c] SHKK atp[c] + skm[c] -> adp[c] + h[c] + skm5p[c] SO4t2 h[e] + so4[e] <=> h[c] + so4[c] SPMDabc atp[c] + h2o[c] + spmd[e] -> adp[c] + h[c] + pi[c] + spmd[c] SPMS ametam[c] + ptrc[c] -> 5mta[c] + h[c] + spmd[c] SSALxr h2o[c] + nad[c] + sucsal[c] <=> 2 h[c] + nadh[c] + succ[c] SUCBZL atp[c] + coa[c] + sucbz[c] -> amp[c] + ppi[c] + sbzcoa[c] SUCBZS 2shchc[c] -> h2o[c] + sucbz[c] SUCCt succ[c] <=> succ[e] SUCD1 fad[c] + succ[c] <=> fadh2[c] + fum[c] SUCDi q8[c] + succ[c] -> fum[c] + q8h2[c] SUCR h2o[c]...
Warning: Directory already exists.
Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Model grows on unlimited media (aerobic), flux through BOF: 3.705852e+01 mmol/gDW/h Model grows on unlimited media (anaerobic), flux through BOF: 3.705852e+01 mmol/gDW/h Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ttdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ttdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cys_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cys_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ser_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ser_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arg_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arg_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lys_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lys_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_asn_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_asn_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_asp_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_asp_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thr_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thr_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_tyr_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_tyr_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gly(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gly(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_akg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_akg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amet(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amet(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cit(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cit(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_csn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_csn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cytd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cytd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dad_2(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dad_2(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dcyt(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dcyt(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ddca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ddca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dgsn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dgsn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_etoh(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_etoh(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fe3dcit(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fe3dcit(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fum(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fum(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc3p(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc3p(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gsn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gsn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthox(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthox(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthrd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthrd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gua(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gua(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2s(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2s(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hom_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hom_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_indole(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Model grows on unlimited media (aerobic), flux through BOF: 6.068227e+01 mmol/gDW/h Model grows on unlimited media (aerobic), flux through BOF: 6.429268e+01 mmol/gDW/h Model grows on unlimited media (anaerobic), flux through BOF: 6.429268e+01 mmol/gDW/h Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cys_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cys_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thr_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thr_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gln_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gln_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amet(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amet(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Model grows on unlimited media (aerobic), flux through BOF: 5.042479e+01 mmol/gDW/h Model grows on unlimited media (anaerobic), flux through BOF: 5.040614e+01 mmol/gDW/h Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ttdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ttdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testGrowth (line 84) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46)...
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
Report for refined models: All models are able to produce biomass on rich medium. All models are able to produce biomass on rich medium under anaerobic conditions. All models are able to produce biomass on complex medium.
Warning: Directory already exists.
Each model.subSystems{x} is a character array, and this format is retained. Testing flux through the ATP demand reaction Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glcn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_drib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rib_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_xyl_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_oxa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cellb(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ttdca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ttdca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cys_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cys_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ser_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ser_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arg_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arg_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lys_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lys_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_asn_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_asn_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_asp_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_asp_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thr_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thr_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_tyr_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_tyr_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gly(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gly(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_akg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_akg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amet(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amet(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_amp(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arab_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chor(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cit(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cit(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_csn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_csn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cytd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cytd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dad_2(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dad_2(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dcyt(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dcyt(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ddca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ddca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dgsn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_dgsn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_etoh(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_etoh(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fe3dcit(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fe3dcit(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fum(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fum(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glu_D(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc3p(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc3p(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gsn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gsn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthox(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthox(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthrd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gthrd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gua(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gua(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2s(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_h2s(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hom_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hom_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_indole(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_indole(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Warning: Reaction EX_ins(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ins(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lac_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lac_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lanost(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lanost(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mal_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mal_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn7(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn7(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_mqn8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_nac(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_nac(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ncam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ncam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_nmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_nmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no2(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no2(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no3(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_no3(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orot(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_orot(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pime(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pime(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydx(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydx(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydx5p(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydx5p(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydxn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_pydxn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_sel(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_sel(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thymd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thymd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_urea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_urea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_uri(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_uri(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_duri(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_duri(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_meoh(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_meoh(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Aerobic ATP flux on complex medium: 4.437500e+01 mmol/gDW/h Anaerobic ATP flux on complex medium: 1.650000e+01 mmol/gDW/h Testing flux through the ATP demand reaction Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gal(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_fuc_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_rmn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lcts(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_strch1(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_melib(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arachd(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_chsterol(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_glyc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_hdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlc(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlnca(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_lnlncg(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ocdcea(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_octa(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cys_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_cys_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arg_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_arg_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_his_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_his_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_asn_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_asn_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thr_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_thr_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_tyr_L(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_tyr_L(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gly(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_gly(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_26dap_M(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2dmmq8(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_2obut(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_3mop(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4abz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_4hbz(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acald(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acmana(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_acnam(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ade(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_adn(e) not in model > In changeRxnBounds (line 59) In useDiet (line 54) In testATP (line 30) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_ala_D(e) not in model > In changeRxnBounds (line 50) In useDiet (line 54) In testATP (line 30) ...
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
Report for refined models: All models produce reasonable amounts of ATP under aerobic conditions. All models produce reasonable amounts of ATP under anaerobic conditions. > changeCobraSolver: Gurobi interface added to MATLAB path. > changeCobraSolver: Gurobi interface added to MATLAB path. > changeCobraSolver: Gurobi interface added to MATLAB path. > changeCobraSolver: Gurobi interface added to MATLAB path. > The compatibility can only be evaluated on the following mac OS versions: macOS 10.13+. > The compatibility can only be evaluated on the following mac OS versions: macOS 10.13+. > The compatibility can only be evaluated on the following mac OS versions: macOS 10.13+. > The compatibility can only be evaluated on the following mac OS versions: macOS 10.13+. > The solver compatibility is not tested with MATLAB R2019b. Each model.subSystems{x} is a character array, and this format is retained. > The solver compatibility is not tested with MATLAB R2019b. Each model.subSystems{x} is a character array, and this format is retained. > The solver compatibility is not tested with MATLAB R2019b. Each model.subSystems{x} is a character array, and this format is retained. > The solver compatibility is not tested with MATLAB R2019b. Each model.subSystems{x} is a character array, and this format is retained. All metabolites have formulas. All metabolites have formulas. All metabolites have formulas. All metabolites have formulas. Model contains 0 (0.00%) imbalanced reactions. Mass imbalanced reactions: 0 Charge imbalanced reactions: 0 L = 1601 L = 1330 L = 1238 L = 1195 L = 1168 L = 1140 L = 1113 L = 1086 L = 1070 Model contains 5 (0.37%) imbalanced reactions. Mass imbalanced reactions: 1 Charge imbalanced reactions: 0 L = 1354 L = 1175 L = 779 L = 751 L = 677 L = 665 L = 653 L = 637 L = 625 L = 616 L = 607 L = 593 L = 586 L = 577 Model contains 0 (0.00%) imbalanced reactions. Mass imbalanced reactions: 0 Charge imbalanced reactions: 0 L = 1646 L = 1387 L = 932 L = 900 L = 884 L = 858 L = 840 L = 826 L = 817 L = 810 L = 803 L = 796 L = 1050 L = 1040 L = 1032 L = 1026 L = 1014 L = 968 L = 962 L = 958 L = 954 L = 949 L = 945 L = 910 L = 906 L = 893 L = 888 L = 881 L = 869 L = 862 L = 852 L = 844 L = 841 L = 836 L = 584 L = 581 L = 578 L = 576 L = 532 L = 515 L = 507 L = 500 L = 496 L = 492 L = 488 L = 484 L = 482 Model contains 6 (0.61%) imbalanced reactions. Mass imbalanced reactions: 2 Charge imbalanced reactions: 1 L = 983 L = 534 L = 514 L = 501 L = 491 L = 483 L = 479 L = 472 L = 467 L = 460 L = 453 L = 449 L = 442 L = 433 L = 393 L = 387 L = 385 L = 385 L = 385 L = 385 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testCarbonSources (line 85) In runTestsOnModel (line 177) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) L = 569 L = 565 L = 562 L = 559 L = 556 L = 552 L = 549 L = 536 L = 530 L = 527 L = 525 L = 521 L = 512 L = 510 L = 506 L = 504 L = 502 L = 499 L = 497 L = 493 L = 491 L = 480 L = 474 L = 471 L = 466 L = 465 L = 465 L = 465 L = 463 L = 463 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. No experimental data on growth requirements available for the organism. L = 480 L = 477 L = 474 L = 474 L = 474 L = 474 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Brevibacillus_laterosporus_GI_9" not found in bile acid product data file. > In testBileAcidBiosynthesis (line 39) In runTestsOnModel (line 248) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) L = 780 L = 776 L = 771 L = 763 L = 759 L = 755 L = 672 L = 646 L = 637 L = 626 L = 614 L = 605 L = 603 L = 601 L = 596 L = 593 L = 590 L = 589 L = 588 L = 587 L = 583 L = 583 L = 583 L = 583 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testCarbonSources (line 85) In runTestsOnModel (line 177) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) Warning: Microbe "Brevibacillus_laterosporus_GI_9" not found in drug metabolite data file. > In testDrugMetabolism (line 39) In runTestsOnModel (line 259) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Brevibacillus_laterosporus_GI_9" not found in putrefaction pathway data file. > In testPutrefactionPathways (line 37) In runTestsOnModel (line 270) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Brevibacillus_laterosporus_GI_9" not found in aromatic amino acid degradation data file. > In testAromaticAADegradation (line 38) In runTestsOnModel (line 294) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (963,983) >> Only 1 reactions of 983 are solved (~ 0.10%). >> 0 reactions out of 1 are minimized (0.00%). >> 0 reactions out of 1 are maximized (0.00%). >> 1 reaction out of 1 is minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 1 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:36:36 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 1. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 1. -- End time: Mon Sep 27 14:36:37 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testCarbonSources (line 85) In runTestsOnModel (line 177) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testFermentationProducts (line 85) In runTestsOnModel (line 194) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (963,983) >> Only 1 reactions of 983 are solved (~ 0.10%). >> 0 reactions out of 1 are minimized (0.00%). >> 0 reactions out of 1 are maximized (0.00%). >> 1 reaction out of 1 is minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 1 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:36:41 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 1. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 1. -- End time: Mon Sep 27 14:36:41 2021 No experimental data on growth requirements available for the organism. > changeCobraSolver: Gurobi interface added to MATLAB path. > The compatibility can only be evaluated on the following mac OS versions: macOS 10.13+. > The solver compatibility is not tested with MATLAB R2019b. Each model.subSystems{x} is a character array, and this format is retained. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testMetaboliteUptake (line 87) In runTestsOnModel (line 223) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (963,983) >> Only 1 reactions of 983 are solved (~ 0.10%). >> 0 reactions out of 1 are minimized (0.00%). >> 0 reactions out of 1 are maximized (0.00%). >> 1 reaction out of 1 is minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 1 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:36:43 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 1. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 1. -- End time: Mon Sep 27 14:36:43 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Acetitomaculum_ruminis_DSM_5522" not found in bile acid product data file. > In testBileAcidBiosynthesis (line 39) In runTestsOnModel (line 248) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1392,1601) >> Only 13 reactions of 1601 are solved (~ 0.81%). >> 0 reactions out of 13 are minimized (0.00%). >> 0 reactions out of 13 are maximized (0.00%). >> 13 reactions out of 13 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 13 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:36:40 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 13. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 13. -- End time: Mon Sep 27 14:36:40 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1454,1646) >> Only 13 reactions of 1646 are solved (~ 0.79%). >> 0 reactions out of 13 are minimized (0.00%). >> 0 reactions out of 13 are maximized (0.00%). >> 13 reactions out of 13 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 13 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:36:42 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 13. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 13. -- End time: Mon Sep 27 14:36:42 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: Microbe "Acetitomaculum_ruminis_DSM_5522" not found in drug metabolite data file. > In testDrugMetabolism (line 39) In runTestsOnModel (line 259) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Acetitomaculum_ruminis_DSM_5522" not found in putrefaction pathway data file. > In testPutrefactionPathways (line 37) In runTestsOnModel (line 270) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Acetitomaculum_ruminis_DSM_5522" not found in aromatic amino acid degradation data file. > In testAromaticAADegradation (line 38) In runTestsOnModel (line 294) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testFermentationProducts (line 85) In runTestsOnModel (line 194) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1392,1601) >> Only 4 reactions of 1601 are solved (~ 0.25%). >> 0 reactions out of 4 are minimized (0.00%). >> 0 reactions out of 4 are maximized (0.00%). >> 4 reactions out of 4 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 4 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:36:46 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 4. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 4. -- End time: Mon Sep 27 14:36:46 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Model grows on at least one carbon source on defined medium for the organism (aerobic), flux through BOF: 0 mmol/gDW/h > changeCobraSolver: Gurobi interface added to MATLAB path. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testFermentationProducts (line 85) In runTestsOnModel (line 194) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1454,1646) >> Only 2 reactions of 1646 are solved (~ 0.12%). >> 0 reactions out of 2 are minimized (0.00%). >> 0 reactions out of 2 are maximized (0.00%). >> 2 reactions out of 2 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 2 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:36:49 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 2. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 2. -- End time: Mon Sep 27 14:36:49 2021 No experimental data on growth requirements available for the organism. > The compatibility can only be evaluated on the following mac OS versions: macOS 10.13+. > The solver compatibility is not tested with MATLAB R2019b. Each model.subSystems{x} is a character array, and this format is retained. Model grows on at least one carbon source on defined medium for the organism (anaerobic), flux through BOF: 0 mmol/gDW/h Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Acinetobacter_pittii_TG6411" not found in putrefaction pathway data file. > In testPutrefactionPathways (line 37) In runTestsOnModel (line 270) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. All metabolites have formulas. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Achromobacter_insuavis_AXX_A" not found in putrefaction pathway data file. > In testPutrefactionPathways (line 37) In runTestsOnModel (line 270) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Model contains 4 (0.38%) imbalanced reactions. Mass imbalanced reactions: 1 Charge imbalanced reactions: 0 L = 1056 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > changeCobraSolver: Gurobi interface added to MATLAB path. L = 993 L = 936 L = 909 L = 895 L = 892 L = 889 L = 885 L = 882 L = 880 L = 873 L = 863 L = 853 L = 851 L = 849 L = 847 L = 845 L = 833 L = 831 L = 829 L = 825 L = 819 L = 815 L = 812 L = 807 L = 484 L = 478 L = 477 L = 476 L = 472 L = 471 L = 470 L = 469 L = 465 L = 463 L = 462 L = 461 L = 460 L = 459 L = 457 L = 455 L = 454 L = 446 L = 443 L = 422 L = 418 L = 415 L = 414 L = 413 L = 412 L = 407 L = 403 L = 402 L = 398 L = 396 L = 393 L = 392 L = 389 L = 388 > changeCobraSolver: Gurobi interface added to MATLAB path. > The compatibility can only be evaluated on the following mac OS versions: macOS 10.13+. > The solver compatibility is not tested with MATLAB R2019b. Each model.subSystems{x} is a character array, and this format is retained. > The compatibility can only be evaluated on the following mac OS versions: macOS 10.13+. > The solver compatibility is not tested with MATLAB R2019b. Each model.subSystems{x} is a character array, and this format is retained. L = 386 L = 383 L = 381 L = 380 L = 367 L = 366 L = 364 L = 351 L = 341 L = 337 L = 334 L = 334 L = 334 L = 334 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. No experimental data on growth requirements available for the organism. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Streptococcus_ratti_FA_1_DSM_20564" not found in bile acid product data file. > In testBileAcidBiosynthesis (line 39) In runTestsOnModel (line 248) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Microbe "Streptococcus_ratti_FA_1_DSM_20564" not found in drug metabolite data file. > In testDrugMetabolism (line 39) In runTestsOnModel (line 259) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Streptococcus_ratti_FA_1_DSM_20564" not found in putrefaction pathway data file. > In testPutrefactionPathways (line 37) In runTestsOnModel (line 270) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Streptococcus_ratti_FA_1_DSM_20564" not found in aromatic amino acid degradation data file. > In testAromaticAADegradation (line 38) In runTestsOnModel (line 294) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) > changeCobraSolver: Gurobi interface added to MATLAB path. All metabolites have formulas. Model contains 5 (0.37%) imbalanced reactions. Mass imbalanced reactions: 1 Charge imbalanced reactions: 0 L = 1364 L = 780 L = 679 L = 651 L = 597 L = 559 L = 539 L = 513 L = 489 L = 471 L = 448 L = 429 L = 415 L = 401 L = 397 L = 394 L = 384 L = 378 L = 378 L = 378 L = 378 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. All metabolites have formulas. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testCarbonSources (line 85) In runTestsOnModel (line 177) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) All metabolites have formulas. Model contains 0 (0.00%) imbalanced reactions. Mass imbalanced reactions: 0 Charge imbalanced reactions: 0 L = 1007 Model contains 4 (0.36%) imbalanced reactions. Mass imbalanced reactions: 1 Charge imbalanced reactions: 0 L = 1100 L = 611 L = 582 L = 529 L = 496 L = 462 L = 440 L = 428 L = 411 L = 405 L = 395 L = 388 L = 376 L = 365 L = 360 L = 354 L = 350 L = 344 L = 341 L = 340 L = 334 L = 329 L = 328 L = 327 L = 326 L = 324 L = 311 L = 311 L = 311 L = 311 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. L = 872 L = 831 L = 781 L = 710 L = 671 L = 657 L = 642 L = 622 L = 615 L = 606 L = 299 L = 294 L = 290 L = 289 L = 286 L = 281 L = 280 L = 263 L = 252 L = 252 L = 252 L = 252 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1172,1364) >> Only 21 reactions of 1364 are solved (~ 1.54%). >> 0 reactions out of 21 are minimized (0.00%). >> 0 reactions out of 21 are maximized (0.00%). >> 21 reactions out of 21 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 21 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:37:15 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 21. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 21. -- End time: Mon Sep 27 14:37:15 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. > The compatibility can only be evaluated on the following mac OS versions: macOS 10.13+. > The solver compatibility is not tested with MATLAB R2019b. Each model.subSystems{x} is a character array, and this format is retained. All metabolites have formulas. Model contains 0 (0.00%) imbalanced reactions. Mass imbalanced reactions: 0 Charge imbalanced reactions: 0 L = 1757 L = 1467 L = 1384 L = 1335 L = 1286 L = 1255 L = 1227 L = 1203 L = 1184 L = 1148 L = 1139 L = 1101 L = 1088 L = 1075 L = 1063 L = 1044 L = 1022 L = 1014 L = 1002 L = 997 L = 993 L = 983 L = 978 L = 971 L = 967 L = 963 L = 921 L = 917 L = 912 L = 908 L = 904 L = 901 L = 888 L = 884 L = 876 L = 863 L = 860 L = 855 L = 615 L = 612 L = 611 L = 610 L = 608 L = 602 L = 597 L = 591 L = 567 L = 554 Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testFermentationProducts (line 85) In runTestsOnModel (line 194) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1172,1364) >> Only 9 reactions of 1364 are solved (~ 0.66%). >> 0 reactions out of 9 are minimized (0.00%). >> 0 reactions out of 9 are maximized (0.00%). >> 9 reactions out of 9 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 9 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:37:20 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 9. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 9. -- End time: Mon Sep 27 14:37:20 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Model grows on at least one carbon source on defined medium for the organism (aerobic), flux through BOF: 2.844425e-01 mmol/gDW/h Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testCarbonSources (line 85) In runTestsOnModel (line 177) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (995,1100) >> Only 5 reactions of 1100 are solved (~ 0.45%). >> 0 reactions out of 5 are minimized (0.00%). >> 0 reactions out of 5 are maximized (0.00%). >> 5 reactions out of 5 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 5 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:37:20 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 5. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 5. -- End time: Mon Sep 27 14:37:20 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testCarbonSources (line 85) In runTestsOnModel (line 177) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (955,1007) >> Only 5 reactions of 1007 are solved (~ 0.50%). >> 0 reactions out of 5 are minimized (0.00%). >> 0 reactions out of 5 are maximized (0.00%). >> 5 reactions out of 5 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 5 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:37:20 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 5. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 5. -- End time: Mon Sep 27 14:37:20 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Model grows on at least one carbon source on defined medium for the organism (aerobic), flux through BOF: 1.226250e-01 mmol/gDW/h Model grows on at least one carbon source on defined medium for the organism (anaerobic), flux through BOF: 1.226250e-01 mmol/gDW/h Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Prevotella_bivia_DNF00320" not found in bile acid product data file. > In testBileAcidBiosynthesis (line 39) In runTestsOnModel (line 248) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Model cannot grow on defined medium for the organism (anaerobic) > In testGrowthOnDefinedMedia (line 170) In runTestsOnModel (line 204) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testFermentationProducts (line 85) In runTestsOnModel (line 194) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (995,1100) >> Only 4 reactions of 1100 are solved (~ 0.36%). >> 0 reactions out of 4 are minimized (0.00%). >> 0 reactions out of 4 are maximized (0.00%). >> 4 reactions out of 4 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 4 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:37:27 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 4. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 4. -- End time: Mon Sep 27 14:37:27 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Model grows on at least one carbon source on defined medium for the organism (aerobic), flux through BOF: 5.699668e-01 mmol/gDW/h Warning: Microbe "Prevotella_bivia_DNF00320" not found in drug metabolite data file. > In testDrugMetabolism (line 39) In runTestsOnModel (line 259) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Prevotella_bivia_DNF00320" not found in putrefaction pathway data file. > In testPutrefactionPathways (line 37) In runTestsOnModel (line 270) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Prevotella_bivia_DNF00320" not found in aromatic amino acid degradation data file. > In testAromaticAADegradation (line 38) In runTestsOnModel (line 294) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) > changeCobraSolver: Gurobi interface added to MATLAB path. L = 542 L = 531 L = 527 L = 526 L = 525 L = 522 L = 520 L = 517 L = 517 L = 517 L = 517 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testDrugMetabolism (line 75) In runTestsOnModel (line 259) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1172,1364) >> Only 1 reactions of 1364 are solved (~ 0.07%). >> 0 reactions out of 1 are minimized (0.00%). >> 0 reactions out of 1 are maximized (0.00%). >> 1 reaction out of 1 is minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 1 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:37:30 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 1. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 1. -- End time: Mon Sep 27 14:37:30 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testPutrefactionPathways (line 69) In runTestsOnModel (line 270) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1172,1364) >> Only 4 reactions of 1364 are solved (~ 0.29%). >> 0 reactions out of 4 are minimized (0.00%). >> 0 reactions out of 4 are maximized (0.00%). >> 4 reactions out of 4 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 4 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:37:32 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 4. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 4. -- End time: Mon Sep 27 14:37:32 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Model cannot grow on defined medium for the organism (anaerobic) > In testGrowthOnDefinedMedia (line 170) In runTestsOnModel (line 204) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. > The compatibility can only be evaluated on the following mac OS versions: macOS 10.13+. > The solver compatibility is not tested with MATLAB R2019b. Each model.subSystems{x} is a character array, and this format is retained. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testCarbonSources (line 85) In runTestsOnModel (line 177) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testSecretionProducts (line 86) In runTestsOnModel (line 237) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (995,1100) >> Only 9 reactions of 1100 are solved (~ 0.82%). >> 0 reactions out of 9 are minimized (0.00%). >> 0 reactions out of 9 are maximized (0.00%). >> 9 reactions out of 9 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 9 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:37:34 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 9. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 9. -- End time: Mon Sep 27 14:37:34 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Lactobacillus_brevis_EW" not found in bile acid product data file. > In testBileAcidBiosynthesis (line 39) In runTestsOnModel (line 248) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Microbe "Lactobacillus_brevis_EW" not found in drug metabolite data file. > In testDrugMetabolism (line 39) In runTestsOnModel (line 259) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Lactobacillus_brevis_EW" not found in putrefaction pathway data file. > In testPutrefactionPathways (line 37) In runTestsOnModel (line 270) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Microbe "Lactobacillus_brevis_EW" not found in aromatic amino acid degradation data file. > In testAromaticAADegradation (line 38) In runTestsOnModel (line 294) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1506,1757) >> Only 27 reactions of 1757 are solved (~ 1.54%). >> 0 reactions out of 27 are minimized (0.00%). >> 0 reactions out of 27 are maximized (0.00%). >> 27 reactions out of 27 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 27 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:37:35 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 27. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 27. -- End time: Mon Sep 27 14:37:35 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. Model grows on at least one carbon source on defined medium for the organism (aerobic), flux through BOF: 1.039479e-01 mmol/gDW/h Model grows on at least one carbon source on defined medium for the organism (anaerobic), flux through BOF: 0 mmol/gDW/h Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creating variable names for the table. The original column headers are saved in the VariableDescriptions property. Set 'PreserveVariableNames' to true to use the original column headers as table variable names. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In testMetaboliteUptake (line 87) In runTestsOnModel (line 223) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1506,1757) >> Only 1 reactions of 1757 are solved (~ 0.06%). >> 0 reactions out of 1 are minimized (0.00%). >> 0 reactions out of 1 are maximized (0.00%). >> 1 reaction out of 1 is minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 1 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:37:44 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 1. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 1. -- End time: Mon Sep 27 14:37:44 2021 Warning: Column headers from the file were modified to make them valid MATLAB identifiers before creatin...
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
obj =
Violin with properties: ScatterPlot: [1×1 Scatter] ViolinPlot: [] BoxPlot: [] WhiskerPlot: [] MedianPlot: [] NotchPlots: [] MeanPlot: [1×1 Line] ShowNotches: 1 ShowMean: 1
If any models still fail a test as indicated by the output variable failedModels, inspect the results in debuggingFolder -> Retest.
For models that still produce too much ATP, run the debugging function
futileCycleReactions = identifyFutileCycles(model);
Inspect the models that do not agree with experimental data manually to find out which steps of the biosynthesis pathway are blocked.
If this should be unsuccessful, feel free to open an issue at the COBRA Toolbox GitHub.

3.1 Analysis and vidualization of model properties and features

Once refined reconstructions have been successfully created, the DEMETER pipeline also provides functions to retrieve properties of the reconstructions, e.g., average size and gene count and stochiometric consistency. Moreover, the pipeline enables the computation of reaction content, uptake and secretion profiles, and internal metabolite biosynthesis profiles per reconstruction and their subssequent clustering by taxon.
Run the computation and visualization of model properties.
computeModelProperties(refinedFolder, infoFilePath, reconVersion, 'numWorkers', numWorkers);
Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (963,983) >> Only 102 reactions of 983 are solved (~ 10.38%). >> 0 reactions out of 102 are minimized (0.00%). >> 0 reactions out of 102 are maximized (0.00%). >> 102 reactions out of 102 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. > The version of CPLEX is 129. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1392,1601) >> Only 143 reactions of 1601 are solved (~ 8.93%). >> 0 reactions out of 143 are minimized (0.00%). >> 0 reactions out of 143 are maximized (0.00%). >> 143 reactions out of 143 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of reactions retrieved is 102 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:41:11 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 102. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 102. -- End time: Mon Sep 27 14:41:11 2021 >> The number of reactions retrieved is 143 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:41:11 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 143. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 143. -- End time: Mon Sep 27 14:41:11 2021 Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1454,1646) >> Only 140 reactions of 1646 are solved (~ 8.51%). >> 0 reactions out of 140 are minimized (0.00%). >> 0 reactions out of 140 are maximized (0.00%). >> 140 reactions out of 140 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 140 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:41:11 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 140. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 140. -- End time: Mon Sep 27 14:41:12 2021 >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1164,1354) >> Only 117 reactions of 1354 are solved (~ 8.64%). >> 0 reactions out of 117 are minimized (0.00%). >> 0 reactions out of 117 are maximized (0.00%). >> 117 reactions out of 117 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 117 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:41:11 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 117. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 117. -- End time: Mon Sep 27 14:41:12 2021 Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (955,1007) >> Only 83 reactions of 1007 are solved (~ 8.24%). >> 0 reactions out of 83 are minimized (0.00%). >> 0 reactions out of 83 are maximized (0.00%). >> 83 reactions out of 83 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 83 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:41:16 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 83. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 83. -- End time: Mon Sep 27 14:41:16 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1172,1364) >> Only 162 reactions of 1364 are solved (~ 11.88%). >> 0 reactions out of 162 are minimized (0.00%). >> 0 reactions out of 162 are maximized (0.00%). >> 162 reactions out of 162 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 162 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:41:17 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 162. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 162. -- End time: Mon Sep 27 14:41:17 2021 >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (995,1100) >> Only 144 reactions of 1100 are solved (~ 13.09%). >> 0 reactions out of 144 are minimized (0.00%). >> 0 reactions out of 144 are maximized (0.00%). >> 144 reactions out of 144 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 144 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:41:18 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 144. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 144. -- End time: Mon Sep 27 14:41:18 2021 > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (857,941) >> Only 132 reactions of 941 are solved (~ 14.03%). >> 0 reactions out of 132 are minimized (0.00%). >> 0 reactions out of 132 are maximized (0.00%). >> 132 reactions out of 132 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 132 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:41:19 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 132. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 132. -- End time: Mon Sep 27 14:41:19 2021 Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (977,1056) >> Only 112 reactions of 1056 are solved (~ 10.61%). >> 0 reactions out of 112 are minimized (0.00%). >> 0 reactions out of 112 are maximized (0.00%). >> 112 reactions out of 112 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 112 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:41:18 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 112. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 112. -- End time: Mon Sep 27 14:41:19 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1506,1757) >> Only 156 reactions of 1757 are solved (~ 8.88%). >> 0 reactions out of 156 are minimized (0.00%). >> 0 reactions out of 156 are maximized (0.00%). >> 156 reactions out of 156 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 156 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:41:22 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 156. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 156. -- End time: Mon Sep 27 14:41:22 2021 Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained.
Warning: Directory already exists.
ans = 3 ans = 1 Each model.subSystems{x} is a character array, and this format is retained. ans = 2 Each model.subSystems{x} is a character array, and this format is retained. ans = 4 Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daihdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daihdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dihdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dihdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3omyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3omyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3otridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3otridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtmrs2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtmrs2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13dpg(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13dpg(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3omyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3omyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mtmrs2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mtmrs2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpalm2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpalm2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3hpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3hpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3opalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3opalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mtpalm2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mtpalm2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe120(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe120(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe140(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe140(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe141(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe141(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe160(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe160(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe161(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe161(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe180(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe180(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe181(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpe181(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg120(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg120(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg140(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg140(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg141(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg141(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg160(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg160(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg161(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg161(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg180(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg180(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg181(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1agpg181(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aihpdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aihpdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aipdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aipdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ddecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ddecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdec9eg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdec9eg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daihdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daihdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daipdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daipdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr120(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr120(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr140(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr140(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr141(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr141(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr160(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr160(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr161(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr161(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr181(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr181(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dihdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dihdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dipdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dipdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12ditdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12ditdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dixdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dixdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3omyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3omyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3otridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3otridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtmrs2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtmrs2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mttritec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mttritec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12npthldl(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12npthldl(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13dpg(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13dpg(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3omyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3omyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mtmrs2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mtmrs2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daihdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daihdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daipdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daipdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr120(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr120(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr140(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr140(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr141(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr141(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr160(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr160(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr161(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr161(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr181(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr181(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dihdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dihdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dipdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dipdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12ditdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12ditdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dixdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dixdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daihdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daihdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daipdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12daipdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr120(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr120(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr140(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr140(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr141(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr141(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr160(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr160(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr161(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr161(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr180(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr181(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dgr181(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dihdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dihdglyc(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dipdglyc(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12dipdglyc(...

3.2. Visualization of the features of large-scale reconstruction resources and their subsets

We can also use the properties module in DEMETER to analyze and visualize the features of large-scale reconstruction resources, e.g., AGORA [1]. We can also do this for a subset of AGORA reconstructions. For instance, we can cluster all representatives of a given taxon, e.g., Bacteroidetes, by similarity. Note that this part of the tutorial is time-consuming.
Download all AGORA reconstructions.
system('curl -LJO https://github.com/VirtualMetabolicHuman/AGORA/archive/master.zip')
% Total % Received % Xferd Average Speed Time Time Time Current Dload Upload Total Spent Left Speed 0 0 0 0 0 0 0 0 --:--:-- --:--:-- --:--:-- 0 0 0 0 0 0 0 0 0 --:--:-- --:--:-- --:--:-- 0 100 132 100 132 0 0 267 0 --:--:-- --:--:-- --:--:-- 267 100 3990k 0 3990k 0 0 2912k 0 --:--:-- 0:00:01 --:--:-- 2912k 100 24.5M 0 24.5M 0 0 10.3M 0 --:--:-- 0:00:02 --:--:-- 20.5M 100 44.1M 0 44.1M 0 0 13.2M 0 --:--:-- 0:00:03 --:--:-- 20.4M 100 64.0M 0 64.0M 0 0 14.6M 0 --:--:-- 0:00:04 --:--:-- 19.9M 100 82.9M 0 82.9M 0 0 15.4M 0 --:--:-- 0:00:05 --:--:-- 19.8M 100 102M 0 102M 0 0 16.2M 0 --:--:-- 0:00:06 --:--:-- 19.8M 100 117M 0 117M 0 0 15.9M 0 --:--:-- 0:00:07 --:--:-- 18.6M 100 121M 0 121M 0 0 14.4M 0 --:--:-- 0:00:08 --:--:-- 15.3M 100 124M 0 124M 0 0 13.3M 0 --:--:-- 0:00:09 --:--:-- 12.2M 100 128M 0 128M 0 0 12.4M 0 --:--:-- 0:00:10 --:--:-- 9345k 100 132M 0 132M 0 0 11.6M 0 --:--:-- 0:00:11 --:--:-- 5997k 100 135M 0 135M 0 0 10.9M 0 --:--:-- 0:00:12 --:--:-- 3767k 100 139M 0 139M 0 0 10.4M 0 --:--:-- 0:00:13 --:--:-- 3755k 100 143M 0 143M 0 0 10.0M 0 --:--:-- 0:00:14 --:--:-- 3799k 100 148M 0 148M 0 0 9871k 0 --:--:-- 0:00:15 --:--:-- 4006k 100 152M 0 152M 0 0 9561k 0 --:--:-- 0:00:16 --:--:-- 4192k 100 156M 0 156M 0 0 9240k 0 --:--:-- 0:00:17 --:--:-- 4266k 100 160M 0 160M 0 0 8929k 0 --:--:-- 0:00:18 --:--:-- 4201k 100 163M 0 163M 0 0 8678k 0 --:--:-- 0:00:19 --:--:-- 4181k 100 167M 0 167M 0 0 8441k 0 --:--:-- 0:00:20 --:--:-- 4037k 100 171M 0 171M 0 0 8221k 0 --:--:-- 0:00:21 --:--:-- 3860k 100 175M 0 175M 0 0 8033k 0 --:--:-- 0:00:22 --:--:-- 3840k 100 179M 0 179M 0 0 7858k 0 --:--:-- 0:00:23 --:--:-- 3907k 100 182M 0 182M 0 0 7690k 0 --:--:-- 0:00:24 --:--:-- 3878k 100 186M 0 186M 0 0 7544k 0 --:--:-- 0:00:25 --:--:-- 3883k 100 190M 0 190M 0 0 7399k 0 --:--:-- 0:00:26 --:--:-- 3876k 100 193M 0 193M 0 0 7241k 0 --:--:-- 0:00:27 --:--:-- 3709k 100 197M 0 197M 0 0 7127k 0 --:--:-- 0:00:28 --:--:-- 3727k 100 201M 0 201M 0 0 7023k 0 --:--:-- 0:00:29 --:--:-- 3773k 100 204M 0 204M 0 0 6888k 0 --:--:-- 0:00:30 --:--:-- 3567k 100 208M 0 208M 0 0 6807k 0 --:--:-- 0:00:31 --:--:-- 3700k 100 212M 0 212M 0 0 6715k 0 --:--:-- 0:00:32 --:--:-- 3824k 100 215M 0 215M 0 0 6616k 0 --:--:-- 0:00:33 --:--:-- 3725k 100 228M 0 228M 0 0 6813k 0 --:--:-- 0:00:34 --:--:-- 5575k 100 243M 0 243M 0 0 7060k 0 --:--:-- 0:00:35 --:--:-- 8094k 100 256M 0 256M 0 0 7226k 0 --:--:-- 0:00:36 --:--:-- 9850k 100 273M 0 273M 0 0 7502k 0 --:--:-- 0:00:37 --:--:-- 12.2M 100 291M 0 291M 0 0 7792k 0 --:--:-- 0:00:38 --:--:-- 15.2M 100 309M 0 309M 0 0 8035k 0 --:--:-- 0:00:39 --:--:-- 15.8M 100 328M 0 328M 0 0 8330k 0 --:--:-- 0:00:40 --:--:-- 16.9M 100 336M 0 336M 0 0 8343k 0 --:--:-- 0:00:41 --:--:-- 16.1M 100 340M 0 340M 0 0 8235k 0 --:--:-- 0:00:42 --:--:-- 13.4M 100 344M 0 344M 0 0 8130k 0 --:--:-- 0:00:43 --:--:-- 10.4M 100 347M 0 347M 0 0 8035k 0 --:--:-- 0:00:44 --:--:-- 8029k 100 351M 0 351M 0 0 7943k 0 --:--:-- 0:00:45 --:--:-- 4842k 100 356M 0 356M 0 0 7887k 0 --:--:-- 0:00:46 --:--:-- 4117k 100 360M 0 360M 0 0 7804k 0 --:--:-- 0:00:47 --:--:-- 4154k 100 364M 0 364M 0 0 7725k 0 --:--:-- 0:00:48 --:--:-- 4218k 100 368M 0 368M 0 0 7637k 0 --:--:-- 0:00:49 --:--:-- 4124k 100 370M 0 370M 0 0 7547k 0 --:--:-- 0:00:50 --:--:-- 3924k 100 375M 0 375M 0 0 7486k 0 --:--:-- 0:00:51 --:--:-- 3781k 100 379M 0 379M 0 0 7416k 0 --:--:-- 0:00:52 --:--:-- 3743k 100 382M 0 382M 0 0 7347k 0 --:--:-- 0:00:53 --:--:-- 3696k 100 386M 0 386M 0 0 7273k 0 --:--:-- 0:00:54 --:--:-- 3684k 100 389M 0 389M 0 0 7207k 0 --:--:-- 0:00:55 --:--:-- 3801k 100 393M 0 393M 0 0 7154k 0 --:--:-- 0:00:56 --:--:-- 3737k 100 397M 0 397M 0 0 7098k 0 --:--:-- 0:00:57 --:--:-- 3768k 100 401M 0 401M 0 0 7040k 0 --:--:-- 0:00:58 --:--:-- 3768k 100 405M 0 405M 0 0 6993k 0 --:--:-- 0:00:59 --:--:-- 3939k 100 409M 0 409M 0 0 6941k 0 --:--:-- 0:01:00 --:--:-- 4007k 100 412M 0 412M 0 0 6885k 0 --:--:-- 0:01:01 --:--:-- 3862k 100 417M 0 417M 0 0 6860k 0 --:--:-- 0:01:02 --:--:-- 4130k 100 421M 0 421M 0 0 6816k 0 --:--:-- 0:01:03 --:--:-- 4209k 100 425M 0 425M 0 0 6773k 0 --:--:-- 0:01:04 --:--:-- 4160k 100 430M 0 430M 0 0 6740k 0 --:--:-- 0:01:05 --:--:-- 4296k 100 434M 0 434M 0 0 6702k 0 --:--:-- 0:01:06 --:--:-- 4444k 100 438M 0 438M 0 0 6665k 0 --:--:-- 0:01:07 --:--:-- 4235k 100 442M 0 442M 0 0 6627k 0 --:--:-- 0:01:08 --:--:-- 4225k 100 446M 0 446M 0 0 6587k 0 --:--:-- 0:01:09 --:--:-- 4190k 100 450M 0 450M 0 0 6552k 0 --:--:-- 0:01:10 --:--:-- 4090k 100 454M 0 454M 0 0 6521k 0 --:--:-- 0:01:11 --:--:-- 4122k 100 458M 0 458M 0 0 6488k 0 --:--:-- 0:01:12 --:--:-- 4101k 100 462M 0 462M 0 0 6459k 0 --:--:-- 0:01:13 --:--:-- 4179k 100 466M 0 466M 0 0 6428k 0 --:--:-- 0:01:14 --:--:-- 4230k 100 470M 0 470M 0 0 6401k 0 --:--:-- 0:01:15 --:--:-- 4274k 100 475M 0 475M 0 0 6373k 0 --:--:-- 0:01:16 --:--:-- 4263k 100 479M 0 479M 0 0 6345k 0 --:--:-- 0:01:17 --:--:-- 4291k 100 483M 0 483M 0 0 6314k 0 --:--:-- 0:01:18 --:--:-- 4174k 100 486M 0 486M 0 0 6281k 0 --:--:-- 0:01:19 --:--:-- 4091k 100 490M 0 490M 0 0 6247k 0 --:--:-- 0:01:20 --:--:-- 3942k 100 494M 0 494M 0 0 6223k 0 --:--:-- 0:01:21 --:--:-- 3938k 100 498M 0 498M 0 0 6194k 0 --:--:-- 0:01:22 --:--:-- 3849k 100 502M 0 502M 0 0 6168k 0 --:--:-- 0:01:23 --:--:-- 3885k 100 506M 0 506M 0 0 6145k 0 --:--:-- 0:01:24 --:--:-- 3998k 100 510M 0 510M 0 0 6127k 0 --:--:-- 0:01:25 --:--:-- 4188k 100 514M 0 514M 0 0 6102k 0 --:--:-- 0:01:26 --:--:-- 4135k 100 518M 0 518M 0 0 6082k 0 --:--:-- 0:01:27 --:--:-- 4235k 100 522M 0 522M 0 0 6061k 0 --:--:-- 0:01:28 --:--:-- 4280k 100 526M 0 526M 0 0 6040k 0 --:--:-- 0:01:29 --:--:-- 4247k 100 530M 0 530M 0 0 6018k 0 --:--:-- 0:01:30 --:--:-- 4156k 100 534M 0 534M 0 0 5994k 0 --:--:-- 0:01:31 --:--:-- 4126k 100 538M 0 538M 0 0 5971k 0 --:--:-- 0:01:32 --:--:-- 4032k 100 542M 0 542M 0 0 5950k 0 --:--:-- 0:01:33 --:--:-- 4000k 100 554M 0 554M 0 0 6015k 0 --:--:-- 0:01:34 --:--:-- 5589k 100 573M 0 573M 0 0 6161k 0 --:--:-- 0:01:35 --:--:-- 8717k 100 592M 0 592M 0 0 6294k 0 --:--:-- 0:01:36 --:--:-- 11.4M 100 608M 0 608M 0 0 6395k 0 --:--:-- 0:01:37 --:--:-- 13.8M 100 627M 0 627M 0 0 6539k 0 --:--:-- 0:01:38 --:--:-- 17.1M 100 645M 0 645M 0 0 6651k 0 --:--:-- 0:01:39 --:--:-- 18.1M 100 662M 0 662M 0 0 6764k 0 --:--:-- 0:01:40 --:--:-- 17.9M 100 682M 0 682M 0 0 6891k 0 --:--:-- 0:01:41 --:--:-- 18.0M 100 701M 0 701M 0 0 7015k 0 --:--:-- 0:01:42 --:--:-- 18.7M 100 721M 0 721M 0 0 7145k 0 --:--:-- 0:01:43 --:--:-- 18.5M 100 737M 0 737M 0 0 7241k 0 --:--:-- 0:01:44 --:--:-- 18.6M 100 757M 0 757M 0 0 7364k 0 --:--:-- 0:01:45 --:--:-- 18.9M 100 776M 0 776M 0 0 7473k 0 --:--:-- 0:01:46 --:--:-- 18.8M 100 787M 0 787M 0 0 7517k 0 --:--:-- 0:01:47 --:--:-- 17.3M 100 791M 0 791M 0 0 7485k 0 --:--:-- 0:01:48 --:--:-- 14.1M 100 795M 0 795M 0 0 7450k 0 --:--:-- 0:01:49 --:--:-- 11.5M 100 799M 0 799M 0 0 7416k 0 --:--:-- 0:01:50 --:--:-- 8510k 100 802M 0 802M 0 0 7384k 0 --:--:-- 0:01:51 --:--:-- 5493k 100 806M 0 806M 0 0 7350k 0 --:--:-- 0:01:52 --:--:-- 3779k 100 809M 0 809M 0 0 7312k 0 --:--:-- 0:01:53 --:--:-- 3568k 100 813M 0 813M 0 0 7281k 0 --:--:-- 0:01:54 --:--:-- 3561k 100 816M 0 816M 0 0 7246k 0 --:--:-- 0:01:55 --:--:-- 3466k 100 819M 0 819M 0 0 7214k 0 --:--:-- 0:01:56 --:--:-- 3414k 100 822M 0 822M 0 0 7182k 0 --:--:-- 0:01:57 --:--:-- 3395k 100 826M 0 826M 0 0 7152k 0 --:--:-- 0:01:58 --:--:-- 3521k 100 830M 0 830M 0 0 7124k 0 --:--:-- 0:01:59 --:--:-- 3541k 100 833M 0 833M 0 0 7094k 0 --:--:-- 0:02:00 --:--:-- 3588k 100 837M 0 837M 0 0 7063k 0 --:--:-- 0:02:01 --:--:-- 3570k 100 840M 0 840M 0 0 7034k 0 --:--:-- 0:02:02 --:--:-- 3583k 100 844M 0 844M 0 0 7007k 0 --:--:-- 0:02:03 --:--:-- 3578k 100 847M 0 847M 0 0 6981k 0 --:--:-- 0:02:04 --:--:-- 3570k 100 851M 0 851M 0 0 6955k 0 --:--:-- 0:02:05 --:--:-- 3641k 100 855M 0 855M 0 0 6931k 0 --:--:-- 0:02:06 --:--:-- 3720k 100 859M 0 859M 0 0 6907k 0 --:--:-- 0:02:07 --:--:-- 3813k 100 863M 0 863M 0 0 6885k 0 --:--:-- 0:02:08 --:--:-- 3882k 100 866M 0 866M 0 0 6859k 0 --:--:-- 0:02:09 --:--:-- 3814k 100 870M 0 870M 0 0 6835k 0 --:--:-- 0:02:10 --:--:-- 3801k 100 874M 0 874M 0 0 6813k 0 --:--:-- 0:02:11 --:--:-- 3832k 100 877M 0 877M 0 0 6791k 0 --:--:-- 0:02:12 --:--:-- 3802k 100 881M 0 881M 0 0 6767k 0 --:--:-- 0:02:13 --:--:-- 3730k 100 884M 0 884M 0 0 6743k 0 --:--:-- 0:02:14 --:--:-- 3748k 100 888M 0 888M 0 0 6720k 0 --:--:-- 0:02:15 --:--:-- 3728k 100 892M 0 892M 0 0 6700k 0 --:--:-- 0:02:16 --:--:-- 3731k 100 896M 0 896M 0 0 6682k 0 --:--:-- 0:02:17 --:--:-- 3817k 100 896M 0 896M 0 0 6680k 0 --:--:-- 0:02:17 --:--:-- 3846k curl: Saved to filename 'AGORA-master.zip'
ans = 0
unzip('AGORA-master')
modPath = [pwd filesep 'AGORA-master' filesep 'CurrentVersion' filesep 'AGORA_1_03' filesep' 'AGORA_1_03_mat'];
Define the path to the file with taxonomic information on AGORA.
infoFilePath = 'AGORA_infoFile.xlsx';
Define the column header which contain the information that should be used to extract a subset.
subHeader = 'Phylum';
Define the feature for which the subset of reconstructions should be extracted.
subFeature = 'Bacteroidetes';
Define the folder where the results from the extracted subset should be saved (optional, default folder will be used otherwise).
subsetFolder = [pwd filesep 'extractedModels'];
Run the extraction of the subset.
[extractedSubset,subsetFolder] = extractReconstructionResourceSubset(modPath, infoFilePath, subHeader, subFeature, subsetFolder);
Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array. Each model.subSystems{x} has been changed to a character array.
Define the folder where the results from the extracted subset will be saved (optional).
subsetPropertiesFolder = [pwd filesep 'subsetProperties'];
Define a name for the subset (optional).
subsetVersion = 'Bacteroidetes';
We will now compute the properties of the extracted reconstruction subset. If the subset contains enough reconstructions, tSNE plots, a visual representation of the similarity between the reconstructed strains, are also generated.
propertiesFolder = computeModelProperties(subsetFolder, infoFilePath, subsetVersion, 'numWorkers', numWorkers, 'propertiesFolder', subsetPropertiesFolder);
Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1007,1147) >> Only 138 reactions of 1147 are solved (~ 12.03%). >> 0 reactions out of 138 are minimized (0.00%). >> 0 reactions out of 138 are maximized (0.00%). >> 138 reactions out of 138 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 138 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:31 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 138. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 138. -- End time: Mon Sep 27 14:54:31 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1072,1251) >> Only 155 reactions of 1251 are solved (~ 12.39%). >> 0 reactions out of 155 are minimized (0.00%). >> 0 reactions out of 155 are maximized (0.00%). >> 155 reactions out of 155 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 155 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:35 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 155. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 155. -- End time: Mon Sep 27 14:54:35 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (860,893) >> Only 95 reactions of 893 are solved (~ 10.64%). >> 0 reactions out of 95 are minimized (0.00%). >> 0 reactions out of 95 are maximized (0.00%). >> 95 reactions out of 95 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 95 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:38 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 95. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 95. -- End time: Mon Sep 27 14:54:38 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (953,1066) >> Only 97 reactions of 1066 are solved (~ 9.10%). >> 0 reactions out of 97 are minimized (0.00%). >> 0 reactions out of 97 are maximized (0.00%). >> 97 reactions out of 97 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 97 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:40 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 97. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 97. -- End time: Mon Sep 27 14:54:40 2021 Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1091,1222) >> Only 108 reactions of 1222 are solved (~ 8.84%). >> 0 reactions out of 108 are minimized (0.00%). >> 0 reactions out of 108 are maximized (0.00%). >> 108 reactions out of 108 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 108 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:31 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 108. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 108. -- End time: Mon Sep 27 14:54:32 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (983,1100) >> Only 105 reactions of 1100 are solved (~ 9.55%). >> 0 reactions out of 105 are minimized (0.00%). >> 0 reactions out of 105 are maximized (0.00%). >> 105 reactions out of 105 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 105 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:35 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 105. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 105. -- End time: Mon Sep 27 14:54:35 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1105,1261) >> Only 107 reactions of 1261 are solved (~ 8.49%). >> 0 reactions out of 107 are minimized (0.00%). >> 0 reactions out of 107 are maximized (0.00%). >> 107 reactions out of 107 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 107 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:38 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 107. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 107. -- End time: Mon Sep 27 14:54:38 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1114,1306) >> Only 160 reactions of 1306 are solved (~ 12.25%). >> 0 reactions out of 160 are minimized (0.00%). >> 0 reactions out of 160 are maximized (0.00%). >> 160 reactions out of 160 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 160 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:41 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 160. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 160. -- End time: Mon Sep 27 14:54:42 2021 Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (996,1101) >> Only 104 reactions of 1101 are solved (~ 9.45%). >> 0 reactions out of 104 are minimized (0.00%). >> 0 reactions out of 104 are maximized (0.00%). >> 104 reactions out of 104 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 104 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:31 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 104. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 104. -- End time: Mon Sep 27 14:54:32 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1042,1192) >> Only 129 reactions of 1192 are solved (~ 10.82%). >> 0 reactions out of 129 are minimized (0.00%). >> 0 reactions out of 129 are maximized (0.00%). >> 129 reactions out of 129 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 129 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:35 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 129. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 129. -- End time: Mon Sep 27 14:54:35 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1061,1186) >> Only 116 reactions of 1186 are solved (~ 9.78%). >> 0 reactions out of 116 are minimized (0.00%). >> 0 reactions out of 116 are maximized (0.00%). >> 116 reactions out of 116 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 116 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:38 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 116. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 116. -- End time: Mon Sep 27 14:54:38 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (973,1085) >> Only 105 reactions of 1085 are solved (~ 9.68%). >> 0 reactions out of 105 are minimized (0.00%). >> 0 reactions out of 105 are maximized (0.00%). >> 105 reactions out of 105 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 105 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:40 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 105. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 105. -- End time: Mon Sep 27 14:54:41 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (804,858) >> Only 91 reactions of 858 are solved (~ 10.61%). >> 0 reactions out of 91 are minimized (0.00%). >> 0 reactions out of 91 are maximized (0.00%). >> 91 reactions out of 91 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 91 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:31 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 91. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 91. -- End time: Mon Sep 27 14:54:31 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1000,1111) >> Only 113 reactions of 1111 are solved (~ 10.17%). >> 0 reactions out of 113 are minimized (0.00%). >> 0 reactions out of 113 are maximized (0.00%). >> 113 reactions out of 113 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 113 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:35 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 113. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 113. -- End time: Mon Sep 27 14:54:35 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1088,1227) >> Only 109 reactions of 1227 are solved (~ 8.88%). >> 0 reactions out of 109 are minimized (0.00%). >> 0 reactions out of 109 are maximized (0.00%). >> 109 reactions out of 109 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 109 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:39 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 109. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 109. -- End time: Mon Sep 27 14:54:39 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1040,1185) >> Only 130 reactions of 1185 are solved (~ 10.97%). >> 0 reactions out of 130 are minimized (0.00%). >> 0 reactions out of 130 are maximized (0.00%). >> 130 reactions out of 130 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 130 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:41 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 130. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 130. -- End time: Mon Sep 27 14:54:41 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1117,1255) >> Only 109 reactions of 1255 are solved (~ 8.69%). >> 0 reactions out of 109 are minimized (0.00%). >> 0 reactions out of 109 are maximized (0.00%). >> 109 reactions out of 109 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 109 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:47 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 109. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 109. -- End time: Mon Sep 27 14:54:47 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1092,1264) >> Only 142 reactions of 1264 are solved (~ 11.23%). >> 0 reactions out of 142 are minimized (0.00%). >> 0 reactions out of 142 are maximized (0.00%). >> 142 reactions out of 142 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 142 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:50 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 142. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 142. -- End time: Mon Sep 27 14:54:50 2021 > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1112,1294) >> Only 145 reactions of 1294 are solved (~ 11.21%). >> 0 reactions out of 145 are minimized (0.00%). >> 0 reactions out of 145 are maximized (0.00%). >> 145 reactions out of 145 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 145 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:48 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 145. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 145. -- End time: Mon Sep 27 14:54:49 2021 Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1122,1313) >> Only 152 reactions of 1313 are solved (~ 11.58%). >> 0 reactions out of 152 are minimized (0.00%). >> 0 reactions out of 152 are maximized (0.00%). >> 152 reactions out of 152 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 152 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:48 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 152. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 152. -- End time: Mon Sep 27 14:54:49 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1087,1240) >> Only 138 reactions of 1240 are solved (~ 11.13%). >> 0 reactions out of 138 are minimized (0.00%). >> 0 reactions out of 138 are maximized (0.00%). >> 138 reactions out of 138 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 138 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:48 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 138. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 138. -- End time: Mon Sep 27 14:54:48 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1059,1213) >> Only 118 reactions of 1213 are solved (~ 9.73%). >> 0 reactions out of 118 are minimized (0.00%). >> 0 reactions out of 118 are maximized (0.00%). >> 118 reactions out of 118 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 118 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:51 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 118. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 118. -- End time: Mon Sep 27 14:54:51 2021 > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1128,1268) >> Only 118 reactions of 1268 are solved (~ 9.31%). >> 0 reactions out of 118 are minimized (0.00%). >> 0 reactions out of 118 are maximized (0.00%). >> 118 reactions out of 118 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 118 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:51 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 118. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 118. -- End time: Mon Sep 27 14:54:51 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1089,1217) >> Only 107 reactions of 1217 are solved (~ 8.79%). >> 0 reactions out of 107 are minimized (0.00%). >> 0 reactions out of 107 are maximized (0.00%). >> 107 reactions out of 107 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 107 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:53 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 107. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 107. -- End time: Mon Sep 27 14:54:53 2021 > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1097,1239) >> Only 123 reactions of 1239 are solved (~ 9.93%). >> 0 reactions out of 123 are minimized (0.00%). >> 0 reactions out of 123 are maximized (0.00%). >> 123 reactions out of 123 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 123 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:54:52 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 123. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 123. -- End time: Mon Sep 27 14:54:52 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (964,1042) >> Only 113 reactions of 1042 are solved (~ 10.84%). >> 0 reactions out of 113 are minimized (0.00%). >> 0 reactions out of 113 are maximized (0.00%). >> 113 reactions out of 113 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 113 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:57:14 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 113. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 113. -- End time: Mon Sep 27 14:57:15 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (981,1058) >> Only 92 reactions of 1058 are solved (~ 8.70%). >> 0 reactions out of 92 are minimized (0.00%). >> 0 reactions out of 92 are maximized (0.00%). >> 92 reactions out of 92 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 92 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:57:15 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 92. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 92. -- End time: Mon Sep 27 14:57:15 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (934,988) >> Only 111 reactions of 988 are solved (~ 11.23%). >> 0 reactions out of 111 are minimized (0.00%). >> 0 reactions out of 111 are maximized (0.00%). >> 111 reactions out of 111 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 111 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:57:14 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 111. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 111. -- End time: Mon Sep 27 14:57:14 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (1001,1109) >> Only 110 reactions of 1109 are solved (~ 9.92%). >> 0 reactions out of 110 are minimized (0.00%). >> 0 reactions out of 110 are maximized (0.00%). >> 110 reactions out of 110 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 110 >> Log files will be stored at /Users/almut.heinken/Documents/Code/cobratoolbox/src/analysis/FVA/fastFVA/logFiles -- Start time: Mon Sep 27 14:57:16 2021 >> #Task.ID = 1; logfile: cplexint_logfile_1.log -- Minimization (iRound = 0). Number of reactions: 110. - printLevel 1 -- Maximization (iRound = 1). Number of reactions: 110. -- End time: Mon Sep 27 14:57:16 2021 Each model.subSystems{x} is a character array, and this format is retained. > The version of CPLEX is 129. > The version of CPLEX is 129. Warning: The most recent cplexFVA binaries are only tested for CPLEX version 128. However, you have installed version 129. If you experience an error using fastFVA, you need to run: >> generateMexFastFVA() in order to generate a new cplexFVA binary file that matches cplex version129 > In fastFVA>checkFastFVAbin (line 778) In fastFVA (line 130) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) >> Solving Model.S. (uncoupled) >> The number of arguments is: input: 6, output 4. >> Size of stoichiometric matrix: (970,1036) >> Only 101 reactions of 1036 are solved (~ 9.75%). >> 0 reactions out of 101 are minimized (0.00%). >> 0 reactions out of 101 are maximized (0.00%). >> 101 reactions out of 101 are minimized and maximized (100.00%). WARNING: The Sequential Version might take a long time. >> The number of reactions retrieved is 101 >> Log files ...
Warning: Directory already exists.
ans = 1 ans = 2 ans = 3 ans = 4 Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Each model.subSystems{x} is a character array, and this format is retained. Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Each model.subSystems{x} is a character array, and this format is retained. Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3hundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10m3oundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3omyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3omyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3otridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3otridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtmrs2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtmrs2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mttritec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mttritec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13dpg(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13dpg(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3omyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3omyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mtmrs2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mtmrs2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpalm2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpalm2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpentdec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpentdec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3hpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3hpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3opalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3opalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mtpalm2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mtpalm2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aihpdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aihpdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aipdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aipdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ddecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ddecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdec9eg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdec9eg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12ethd(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12ethd(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3omyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3omyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3otridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3otridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtmrs2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtmrs2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mttritec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mttritec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12ppd_R(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12ppd_R(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12ppd_S(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12ppd_S(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13dpg(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13dpg(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3omyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3omyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mtmrs2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mtmrs2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpalm2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpalm2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpentdec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpentdec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3hpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3hpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3opalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3opalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mtpalm2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mtpalm2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aihpdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aihpdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aipdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mtundec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10mundecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3hddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11m3oddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mddcaACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_11mtddec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3htridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3omyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3omyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3otridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12m3otridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtmrs2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtmrs2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtridecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mtridecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mttritec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_12mttritec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13dpg(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13dpg(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3hmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3hmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3omyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13m3omyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mmyrsACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mmyrsACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mtmrs2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_13mtmrs2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3hpentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14m3opentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpentdecACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mpentdecACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpalm2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpalm2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpentdec2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_14mtpentdec2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3hpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihpdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihpdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ipdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ipdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1itdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1itdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1odec11eg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1odec11eg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1odecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_10fthf5glu(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aipdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ddecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ddecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdec9eg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdec9eg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihpdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihpdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ipdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ipdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1itdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1itdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1odec11eg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1odec11eg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1odecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3hpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3opalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15m3opalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mpalmACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mpalmACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mtpalm2eACP(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_15mtpalm2eACP(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aihpdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aihpdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aipdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1aipdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ddecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ddecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdec9eg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdec9eg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1hdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihpdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ihpdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ipdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1ipdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1itdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1itdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1odec11eg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1odec11eg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1odecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1odecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1pyr5c(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1pyr5c(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1tdec7eg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1tdec7eg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1tdecg3p(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_1tdecg3p(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_23dhdp(e) not in model > In changeRxnBounds (line 50) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_23dhdp(e) not in model > In changeRxnBounds (line 59) In parallel_function>make_general_channel/channel_general (line 837) In remoteParallelFunction (line 46) Warning: Reaction EX_25aics(e) not in mode...

References

[1] Heinken A, Magnúsdóttir S, Fleming RMT, Thiele I, DEMETER: efficient simultaneous curation of genome-scale reconstructions guided by experimental data and refined gene annotations. Bioinformatics (2021).
[2] Magnúsdóttir S, Heinken A, Kutt L, Ravcheev DA et al, Generation of genome-scale metabolic reconstructions for 773 members of the human gut microbiota. Nat Biotechnol. 35(1):81-89 (2017).
[3] Heinken A, Acharya G, Ravcheev DA, Hertel J et al, AGORA2: Large scale reconstruction of the microbiome highlights wide-spread drug-metabolising capacities. bioRxiv (2020).
[4] Chen IA, Chu K, Palaniappan K, Ratner A et al, The IMG/M data management and analysis system v.6.0: new tools and advanced capabilities. Nucleic Acids Res. 49(D1):D751-D763 (2021).
[5] Noronha A, Modamio J, Jarosz Y, Guerard E et al., The Virtual Metabolic Human database: integrating human and gut microbiome metabolism with nutrition and disease. Nucleic Acids Res 47(D1):D614-D624 (2019).
[6] Thorleifsson SG, Thiele I, rBioNet: A COBRA toolbox extension for reconstructing high-quality biochemical networks. Bioinformatics 27(14):2009-10 (2010).
[7] Kanehisa M, Furumichi M, Sato Y, Ishiguro-Watanabe M, Tanabe M, KEGG: integrating viruses and cellular organisms. Nucleic Acids Res. 49(D1):D545-D551 (2021).
[8] Wishart DS, Feunang YD, Marcu A, Guo AC, et al., HMDB 4.0 — The Human Metabolome Database for 2018. Nucleic Acids Res. 46(D1):D608-17 (2018).
[9] Thiele I, Palsson BØ, A protocol for generating a high-quality genome-scale metabolic reconstruction. Nat Protoc 5(1):93-121 (2010).