Generated January 10, 2025

Intro and Resources

Intro

This Narrative is created for the intro to KBase workshop for PAG to be presented January 10, 2025. It very closely follows the KBase Case Study Narrative that was used in the Current Plant Biology publication A KBase case study on genome-wide transcriptomics and plant primary metabolism in response to drought stress in Sorghum..

Case Study Backgound

This study takes transcription data from a Sorghum bicolor drought study. The original study from Varoquaux et al subjected the Sorghum RTx430 genotype to 8 weeks of water deprivation to simulate drought conditions.

There are 12 sets of RNA-seq reads used in this analysis. The conditions are well-watered controls (ww) and drought-stressed (dr) from each of the leaves and roots, with 3 replicates for each.

For full details, please see the paper linked above.

Quick References

Some quick links to references are attached here.

Presentation slides

KBase Case Study Narrative

KBase Case Study Publication

Import Files

Upload Files

First upload files to the "staging area." This is a temporary storage where raw files are held until processed. These files aren't usable in KBase per se and have to be read. The staging area is regularly purged to remove files older than 90 days.

Import Files

To get the files read into a usable format, they must be imported. You can import either by selecting the appropriate import type from the dropdown or by using the spreadsheet import specification option.

Either option results in the same import cell. In my experience, CSV upload is faster once you get above 15-20 files.

Once the files are verified to be correct and the correct desired output object name is selected, click "Run" to start the import.

This will read the uploaded files as save the contents behind the scenes in the KBase internal representation.

Import Genome and Reads

In this case, we will import the Genome using the GFF+FASTA files by uploading them to staging, then importing together.

In the case of reads, the use case this demo is based on used the app Import SRA File as Reads From Web. If you have publicly available reads such as on NCBI's Sequence Read Archive, this app will combine the upload/import steps "under the hood" and upload them then import them all in one app.

In this demo, the reads are copied from the original Narrative.

Import a GFF3 and FASTA file from your staging area into your Narrative as a Genome data object
This app completed without errors in 8m 57s.
Objects
Created Object Name Type Description
SbicolorRTx430_genome Genome Imported Genome
Links
v1 - KBaseGenomes.Genome-11.1
The viewer for the data in this Cell is available at the original Narrative here: https://narrative.kbase.us/narrative/203090
Output from Import GFF3/FASTA file as Genome from Staging Area
The viewer for the output created by this App is available at the original Narrative here: https://narrative.kbase.us/narrative/203090
v1 - KBaseGenomes.Genome-11.1
The viewer for the data in this Cell is available at the original Narrative here: https://narrative.kbase.us/narrative/203090

Annotate Plant Enzymes with OrthoFinder

The GFF provided from JGI does not have functional annotation, only structural. In the app below, we use OrthoFinder to provide the functional annotation.

At the moment, OrthoFinder in KBase is the only app for plant annotation and it does require structural annotations to be provided. We do not currently have an app to perform structural annotation.

Annotates transcripts in a Genome object with metabolic functions using OrthoFinder.
This app completed without errors in 5h 48m 51s.
Objects
Created Object Name Type Description
SbicolorRTx430_genome_orthofinder Genome Plant genome SbicolorRTx430_genome annotated with metabolic functions
Links
Files
These are only available in the live Narrative: https://narrative.kbase.us/narrative/203090
  • OrthoFinder_Output.txt - Output text generated by OrthoFinder
v1 - KBaseGenomes.Genome-11.1
The viewer for the data in this Cell is available at the original Narrative here: https://narrative.kbase.us/narrative/203090

Create RNA-Seq SampleSet

The RNA-seq apps in KBase operate starting with an RNA-seq SampleSet. This object links the 12 reads libraries into groups that are operated on together. We'll have 4 condition labels (roots and leaves, well-watered and drought-stressed) each with 3 replicates.

Take care when creating SampleSets. Some apps rely on outputs of other apps which means if you make an error at this stage you may need to redo the entire chain.

Allows users to provide RNA-seq reads and the corresponding metadata to create an RNASeqSampleSet data object.
This app completed without errors in 4s.
No output found.
Output from Create RNA-seq SampleSet
The viewer for the output created by this App is available at the original Narrative here: https://narrative.kbase.us/narrative/203090

Assess read quality with FastQC

We can run FastQC to assess the quality of our reads. Since this is a demo dataset with pre-cleaned reads, we already know the quality is good.

If these reads needed to be cleaned, we could use apps like Trimmomatic to process the reads. Use the "apps using this type as input" filter to quickly filter apps to those that take reads as input to find all apps that can operate on this type.

A quality control application for high throughput sequence data.
This app completed without errors in 24m 15s.
Links
Files
These are only available in the live Narrative: https://narrative.kbase.us/narrative/203090
  • RTx430_leaves_ww_r3_203090_14_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_leaves_dr_r1_203090_15_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_leaves_ww_r2_203090_13_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_leaves_dr_r2_203090_16_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_leaves_dr_r3_203090_17_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_roots_dr_r2_203090_10_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_roots_ww_r2_203090_7_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_roots_dr_r1_203090_9_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_roots_ww_r3_203090_8_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_roots_ww_r1_203090_6_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_leaves_ww_r1_203090_12_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report
  • RTx430_roots_dr_r3_203090_11_1.single_fastqc.zip - Zip file generated by fastqc that contains original images seen in the report

Align Reads with HISAT2

The first step of the RNA-seq workflow is to align with HISAT.

HISAT2 is normally the longest-running app in this pipeline.

HISAT2 produces one RNASeqAlignment per reads library (12 in this case) as well as 1 ReadsAlignmentSet. If you want to use these outputs in external apps or custom code, you can download the alignments as BAM or SAM files.

The app also produces a QualiMap report which can be viewed in a separate tab or window.

Align sequencing reads to long reference sequences using HISAT2.
This app completed without errors in 2h 52m 50s.
Objects
Created Object Name Type Description
RTx430_leaves_ww_r2_alignment RNASeqAlignment Reads 203090/18/1;203090/13/1 aligned to Genome 203090/25/1
RTx430_roots_ww_r2_alignment RNASeqAlignment Reads 203090/18/1;203090/7/1 aligned to Genome 203090/25/1
RTx430_roots_dr_r2_alignment RNASeqAlignment Reads 203090/18/1;203090/10/1 aligned to Genome 203090/25/1
RTx430_roots_dr_r1_alignment RNASeqAlignment Reads 203090/18/1;203090/9/1 aligned to Genome 203090/25/1
RTx430_leaves_ww_r3_alignment RNASeqAlignment Reads 203090/18/1;203090/14/1 aligned to Genome 203090/25/1
RTx430_leaves_dr_r2_alignment RNASeqAlignment Reads 203090/18/1;203090/16/1 aligned to Genome 203090/25/1
RTx430_roots_dr_r3_alignment RNASeqAlignment Reads 203090/18/1;203090/11/1 aligned to Genome 203090/25/1
RTx430_roots_ww_r3_alignment RNASeqAlignment Reads 203090/18/1;203090/8/1 aligned to Genome 203090/25/1
RTx430_roots_ww_r1_alignment RNASeqAlignment Reads 203090/18/1;203090/6/1 aligned to Genome 203090/25/1
RTx430_leaves_dr_r1_alignment RNASeqAlignment Reads 203090/18/1;203090/15/1 aligned to Genome 203090/25/1
RTx430_leaves_dr_r3_alignment RNASeqAlignment Reads 203090/18/1;203090/17/1 aligned to Genome 203090/25/1
RTx430_leaves_ww_r1_alignment RNASeqAlignment Reads 203090/18/1;203090/12/1 aligned to Genome 203090/25/1
RTx430_sampleset_alignment_set ReadsAlignmentSet Set of all new alignments
Summary
Created 12 alignments from the given alignment set.
Links

Assemble Transcipts with StringTie

The ReadsAlignmentSet links all the RNASeqAlignments together for the next step.

In this step, we assemble the reads using StringTie.

StringTie produces expression objects for each alignment, which can be downloaded as a zip file containing several files. This is documented in by a dependency of StringTie, Ballgown, in their documentation.

The app also produces two ExpressionMatrices, TPM (transcripts per million) and FPKM (fragments per kilobase of transcript, per million fragments mapped). Both of these are downloadable as Excel/CSV.

As with alignment, it will also produce an ExpressionSet which is our input for the next step.

Assemble the transcripts from RNA-seq read alignments using StringTie.
This app completed without errors in 33m 8s.
Objects
Created Object Name Type Description
RTx430_sampleset_expression_set ExpressionSet ExpressionSet generated by StringTie
RTx430_leaves_ww_r1_expression RNASeqExpression Expression generated by StringTie
RTx430_leaves_ww_r2_expression RNASeqExpression Expression generated by StringTie
RTx430_leaves_ww_r3_expression RNASeqExpression Expression generated by StringTie
RTx430_leaves_dr_r1_expression RNASeqExpression Expression generated by StringTie
RTx430_leaves_dr_r2_expression RNASeqExpression Expression generated by StringTie
RTx430_leaves_dr_r3_expression RNASeqExpression Expression generated by StringTie
RTx430_roots_ww_r1_expression RNASeqExpression Expression generated by StringTie
RTx430_roots_ww_r2_expression RNASeqExpression Expression generated by StringTie
RTx430_roots_ww_r3_expression RNASeqExpression Expression generated by StringTie
RTx430_roots_dr_r1_expression RNASeqExpression Expression generated by StringTie
RTx430_roots_dr_r2_expression RNASeqExpression Expression generated by StringTie
RTx430_roots_dr_r3_expression RNASeqExpression Expression generated by StringTie
RTx430_sampleset_FPKM_ExpressionMatrix ExpressionMatrix FPKM ExpressionMatrix generated by StringTie
RTx430_sampleset_TPM_ExpressionMatrix ExpressionMatrix TPM ExpressionMatrix generated by StringTie
Links
Files
These are only available in the live Narrative: https://narrative.kbase.us/narrative/203090
  • stringtie_result.zip - File(s) generated by StringTie App
v1 - KBaseRNASeq.RNASeqExpression-2.0
The viewer for the data in this Cell is available at the original Narrative here: https://narrative.kbase.us/narrative/203090

Create Average Expression Matrix

To find the average abundances for each gene in each condition, the normalized expression matrix is averaged across the biological replicates for each condition.

This average expression matrix “RTx430_sampleset_TPM_ExpressionMatrix_average” is used in a later step to assign reaction level expression scores to study plant primary metabolism.

Create an average ExpressionMatrix data object with one column per condition.
This app completed without errors in 23s.
Objects
Created Object Name Type Description
RTx430_sampleset_TPM_ExpressionMatrix_average ExpressionMatrix Average ExpressionMatrix
Create an average ExpressionMatrix data object with one column per condition.
This app completed without errors in 23s.
Objects
Created Object Name Type Description
RTx430_sampleset_FPKM_ExpressionMatrix_average ExpressionMatrix Average ExpressionMatrix

Differential Expression with DESeq2

The output ExpressionSet from StringTie feeds directly into DESeq2 for differential expression.

This app produces a DifferentialExpressionMatrix for each comparison which can be downloaded for further analysis.

Create differential expression matrix based on a given threshold cutoff
This app completed without errors in 25m 7s.
Objects
Created Object Name Type Description
RTx430_sampleset_expression_set_deseq DifferentialExpressionMatrixSet DifferentialExpressionMatrixSet generated by DESeq2
RTx430_sampleset_expression_set_deseq-roots_ww-VS-leaves_dr DifferentialExpressionMatrix DifferentialExpressionMatrix generated by DESeq2
RTx430_sampleset_expression_set_deseq-roots_dr-VS-roots_ww DifferentialExpressionMatrix DifferentialExpressionMatrix generated by DESeq2
RTx430_sampleset_expression_set_deseq-roots_dr-VS-leaves_dr DifferentialExpressionMatrix DifferentialExpressionMatrix generated by DESeq2
RTx430_sampleset_expression_set_deseq-roots_ww-VS-leaves_ww DifferentialExpressionMatrix DifferentialExpressionMatrix generated by DESeq2
RTx430_sampleset_expression_set_deseq-leaves_dr-VS-leaves_ww DifferentialExpressionMatrix DifferentialExpressionMatrix generated by DESeq2
RTx430_sampleset_expression_set_deseq-roots_dr-VS-leaves_ww DifferentialExpressionMatrix DifferentialExpressionMatrix generated by DESeq2
Links
Files
These are only available in the live Narrative: https://narrative.kbase.us/narrative/203090
  • DESeq2_result.zip - File(s) generated by DESeq2 App
  • DESeq2_plot.zip - Visualization plots by DESeq2 App
Create differential expression matrix based on a given threshold cutoff
This app produced errors.
No output found.

Create Up/Down Regulated FeatureSet and ExpressionMatrix

This app allows us to subset the expression matrix to only consider features that are up- or down-regulated by a certain amount.

This doesn't do any new analysis but rather filters the existing matrix to a smaller set. It also creates FeatureSets. FeatureSets are groups of genes or other features inside the Genome object. A FeatureSet is used in some apps like BLAST to examine a smaller set of genes more closely.

Create up/down regulated FeatureSet and ExpressionMatrix from differential expression data based on given cutoffs.
This app completed without errors in 4m 2s.
Objects
Created Object Name Type Description
RTx430_sampleset_expression_set_deseq_roots_ww-leaves_dr_up_feature_set FeatureSet Upper FeatureSet Object
RTx430_sampleset_expression_set_deseq_roots_dr-roots_ww_up_feature_set FeatureSet Upper FeatureSet Object
RTx430_sampleset_expression_set_deseq_roots_dr-leaves_dr_up_feature_set FeatureSet Upper FeatureSet Object
RTx430_sampleset_expression_set_deseq_roots_ww-leaves_ww_up_feature_set FeatureSet Upper FeatureSet Object
RTx430_sampleset_expression_set_deseq_leaves_dr-leaves_ww_up_feature_set FeatureSet Upper FeatureSet Object
RTx430_sampleset_expression_set_deseq_roots_dr-leaves_ww_up_feature_set FeatureSet Upper FeatureSet Object
RTx430_sampleset_expression_set_deseq_roots_ww-leaves_dr_down_feature_set FeatureSet Lower FeatureSet Object
RTx430_sampleset_expression_set_deseq_roots_dr-roots_ww_down_feature_set FeatureSet Lower FeatureSet Object
RTx430_sampleset_expression_set_deseq_roots_dr-leaves_dr_down_feature_set FeatureSet Lower FeatureSet Object
RTx430_sampleset_expression_set_deseq_roots_ww-leaves_ww_down_feature_set FeatureSet Lower FeatureSet Object
RTx430_sampleset_expression_set_deseq_leaves_dr-leaves_ww_down_feature_set FeatureSet Lower FeatureSet Object
RTx430_sampleset_expression_set_deseq_roots_dr-leaves_ww_down_feature_set FeatureSet Lower FeatureSet Object
roots_ww-leaves_dr_filtered_expression_matrix ExpressionMatrix Filtered ExpressionMatrix Object
roots_dr-roots_ww_filtered_expression_matrix ExpressionMatrix Filtered ExpressionMatrix Object
roots_dr-leaves_dr_filtered_expression_matrix ExpressionMatrix Filtered ExpressionMatrix Object
roots_ww-leaves_ww_filtered_expression_matrix ExpressionMatrix Filtered ExpressionMatrix Object
leaves_dr-leaves_ww_filtered_expression_matrix ExpressionMatrix Filtered ExpressionMatrix Object
roots_dr-leaves_ww_filtered_expression_matrix ExpressionMatrix Filtered ExpressionMatrix Object
Links

Metabolic Reconstruction

The app Reconstruct Plant Metabolism app allows us to create a plant metabolic model based on the genome annotations performed earlier.

This type of model behaves similarly to bacterial/fungal metabolic models, for which we have detailed tutorials and documentation on our YouTube channel and docs.kbase.us.

Reconstruct the metabolic network of a plant based on an annotated genome.
This app completed without errors in 4m 10s.
Objects
Created Object Name Type Description
SbicolorRTx430_genome_orthofinder_model FBAModel FBAModel: SbicolorRTx430_genome_orthofinder_model
Links
Output from Reconstruct Plant Metabolism
The viewer for the output created by this App is available at the original Narrative here: https://narrative.kbase.us/narrative/203090

Integration of Abundance with Metabolism

This app allows us to map our previously calculated expression abundances in the expression matrix with the model constructed above.

Below I've run the app with all 3 drought leave expression matrices.

Integrate gene abundances with a plant primary metabolic network
This app completed without errors in 2m 7s.
Objects
Created Object Name Type Description
leaves_abundances ReactionMatrix Reaction matrix: leaves_abundances
Links

Visualization of Metabolic Pathway

This lets us map the metabolic model visually using the Escher Pathway Viewer.

We can combine the model that we produced above with the expression data to show the difference in expression on the map.

Display Metabolic Pathways
This app completed without errors in 33s.
Summary
message_in_app /kb/module/work/tmp/20036701-895d-4403-8075-785541cd2582
Links

References

  • Kumari, S., Kumar, V., Beilsmith, K., Seaver, S. M. D., Canon, S., Dehal, P., Gu, T., Joachimiak, M., Lerma-Ortiz, C., Liu, F., Lu, Z., Pearson, E., Ranjan, P., Riel, W., Henry, C. S., Arkin, A. P., & Ware, D. (2021). A KBase case study on genome-wide transcriptomics and plant primary metabolism in response to drought stress in Sorghum. In Current Plant Biology (Vol. 28, p. 100229). Elsevier BV. https://doi.org/10.1016/j.cpb.2021.100229

  • Kumari S, Kumar V, Beilsmith K, Seaver SMD, Canon S, Dehal P, et al. A KBase case study on genome-wide transcriptomics and plant primary metabolism in response to drought stress in Sorghum. Current Plant Biology. Elsevier BV; 2021. p. 100229. doi:10.1016/j.cpb.2021.100229

  • Varoquaux N, Cole B, Gao C, Pierroz G, Baker CR, Patel D, et al. Transcriptomic analysis of field-droughted sorghum from seedling to maturity reveals biotic and metabolic responses. Proceedings of the National Academy of Sciences. Proceedings of the National Academy of Sciences; 2019. pp. 27124–27132. doi:10.1073/pnas.1907500116

  • Ballgown documentation: https://github.com/alyssafrazee/ballgown

Released Apps

  1. Align Reads using HISAT2 - v2.1.0
    • Kim D, Langmead B, Salzberg SL. HISAT: a fast spliced aligner with low memory requirements. Nature Methods. 2015;12: 357 360. doi:10.1038/nmeth.3317
    • Kim D, Pertea G, Trapnell C, Pimentel H, Kelley R, Salzberg SL. TopHat2: accurate alignment of transcriptomes in the presence of insertions, deletions and gene fusions. Genome Biology. 2013;14: R36. doi:10.1186/gb-2013-14-4-r36
  2. Annotate Plant Enzymes with OrthoFinder
    • Emms DM, Kelly S. OrthoFinder: solving fundamental biases in whole genome comparisons dramatically improves orthogroup inference accuracy. Genome Biol. 2015;16. doi:10.1186/s13059-015-0721-2
    • OrthoFinder GitHub source:
    • PlantSEED Github source:
  3. Assemble Transcripts using StringTie - v2.1.5
    • Frazee AC, Pertea G, Jaffe AE, Langmead B, Salzberg SL, Leek JT. Ballgown bridges the gap between transcriptome assembly and expression analysis. Nat Biotechnol. 2015;33: 243 246. doi:10.1038/nbt.3172
    • https://www.nature.com/articles/nmeth.3317
    • Kim D, Pertea G, Trapnell C, Pimentel H, Kelley R, Salzberg SL. TopHat2: accurate alignment of transcriptomes in the presence of insertions, deletions and gene fusions. Genome Biology. 2013;14: R36. doi:10.1186/gb-2013-14-4-r36
    • Pertea M, Pertea GM, Antonescu CM, Chang T-C, Mendell JT, Salzberg SL. StringTie enables improved reconstruction of a transcriptome from RNA-seq reads. Nature Biotechnology. 2015;33: 290 295. doi:10.1038/nbt.3122
    • Trapnell C, Pachter L, Salzberg SL. TopHat: discovering splice junctions with RNA-Seq. Bioinformatics. 2009;25: 1105 1111. doi:10.1093/bioinformatics/btp120
    • Trapnell C, Roberts A, Goff L, Pertea G, Kim D, Kelley DR, et al. Differential gene and transcript expression analysis of RNA-seq experiments with TopHat and Cufflinks. Nat Protoc. 2012;7: 562 578. doi:10.1038/nprot.2012.016
  4. Assess Read Quality with FastQC - v0.12.1
    • FastQC source: Bioinformatics Group at the Babraham Institute, UK.
  5. Create Average ExpressionMatrix
    • Arkin AP, Cottingham RW, Henry CS, Harris NL, Stevens RL, Maslov S, et al. KBase: The United States Department of Energy Systems Biology Knowledgebase. Nature Biotechnology. 2018;36: 566. doi: 10.1038/nbt.4163
  6. Create Differential Expression Matrix using DESeq2 - v1.20.0
    • Love MI, Huber W, Anders S. Moderated estimation of fold change and dispersion for RNA-seq data with DESeq2. Genome Biology. 2014;15: 550. doi:10.1186/s13059-014-0550-8
  7. Create RNA-seq SampleSet
    • Arkin AP, Cottingham RW, Henry CS, Harris NL, Stevens RL, Maslov S, et al. KBase: The United States Department of Energy Systems Biology Knowledgebase. Nature Biotechnology. 2018;36: 566. doi: 10.1038/nbt.4163
  8. Create Up/Down Regulated FeatureSet and ExpressionMatrix
    • Arkin AP, Cottingham RW, Henry CS, Harris NL, Stevens RL, Maslov S, et al. KBase: The United States Department of Energy Systems Biology Knowledgebase. Nature Biotechnology. 2018;36: 566. doi: 10.1038/nbt.4163
  9. Import GFF3/FASTA file as Genome from Staging Area
    no citations
  10. Integrate Abundances with Metabolism
    • [1] Seaver SMD, Bradbury LM, Frelin O, Zarecki R, Ruppin E, Hanson AD, Henry CS Improved evidence-based genome-scale metabolic models for maize leaf, embryo, and endosperm. Front Plant Sci. 2015;6: 142. doi: 10.3389/fpls.2015.00142
  11. Reconstruct Plant Metabolism
    • [1] Seaver SMD, Lerma-Ortiz C, Conrad N, Mikaili A, Sreedasyam A, Hanson AD, et al. PlantSEED enables automated annotation and reconstruction of plant primary metabolism with improved compartmentalization and comparative consistency. Plant J. 2018;95: 1102 1113. doi:10.1111/tpj.14003
    • [2] Seaver SMD, Gerdes S, Frelin O, Lerma-Ortiz C, Bradbury LMT, Zallot R, et al. High-throughput comparison, functional annotation, and metabolic modeling of plant genomes using the PlantSEED resource. Proc Natl Acad Sci USA. 2014;111: 9645 9650. doi:10.1073/pnas.1401329111
    • [3] GitHub source:
    • [4] Emms DM, Kelly S. OrthoFinder: solving fundamental biases in whole genome comparisons dramatically improves orthogroup inference accuracy. Genome Biol. 2015;16. doi:10.1186/s13059-015-0721-2
    • [5] Henry CS, DeJongh M, Best AA, Frybarger PM, Linsay B, Stevens RL. High-throughput generation, optimization and analysis of genome-scale metabolic models. Nat Biotechnol. 2010;28: 977 982. doi:10.1038/nbt.1672
    • [6] Overbeek R, Olson R, Pusch GD, Olsen GJ, Davis JJ, Disz T, et al. The SEED and the Rapid Annotation of microbial genomes using Subsystems Technology (RAST). Nucleic Acids Res. 2014;42: D206 D214. doi:10.1093/nar/gkt1226
    • [7] Latendresse M. Efficiently gap-filling reaction networks. BMC Bioinformatics. 2014;15: 225. doi:10.1186/1471-2105-15-225
    • [8] Dreyfuss JM, Zucker JD, Hood HM, Ocasio LR, Sachs MS, Galagan JE. Reconstruction and Validation of a Genome-Scale Metabolic Model for the Filamentous Fungus Neurospora crassa Using FARM. PLOS Computational Biology. 2013;9: e1003126. doi:10.1371/journal.pcbi.1003126
    • [9] Mahadevan R, Schilling CH. The effects of alternate optimal solutions in constraint-based genome-scale metabolic models. Metab Eng. 2003;5: 264 276.

Apps in Beta

  1. Escher Pathway Viewer
    • [1] King, Z. A., Dr ger, A., Ebrahim, A., Sonnenschein, N., Lewis, N. E., & Palsson, B. . (2015). Escher: A Web Application for Building, Sharing, and Embedding Data-Rich Visualizations of Biological Pathways. PLOS Computational Biology, 11(8), e1004321.
    • [2] Rowe, E., Palsson, B. ., & King, Z. A. (2018). Escher-FBA: a web application for interactive flux balance analysis. BMC Systems Biology, 12(1), 84.