Package 'Sysrecon'

Title: Systematical Metabolic Reconstruction
Description: In the past decade, genome-scale metabolic reconstructions have widely been used to comprehend the systems biology of metabolic pathways within an organism. Different GSMs are constructed using various techniques that require distinct steps, but the input data, information conversion and software tools are neither concisely defined nor mathematically or programmatically formulated in a context-specific manner.The tool that quantitatively and qualitatively specifies each reconstruction steps and can generate a template list of reconstruction steps dynamically selected from a reconstruction step reservoir, constructed based on all available published papers.
Authors: Shilin Ouyang [aut, cre], Zihao Li [aut], Jiamin Hu [aut], Miyuan Cao [aut], Feng Yu [aut], Longfei Mao [aut], RStudio [cph, fnd]
Maintainer: Shilin Ouyang <[email protected]>
License: GPL-3
Version: 0.1.2
Built: 2025-02-25 04:32:36 UTC
Source: https://github.com/oyshilin/sysrecon

Help Index


A data frame contains the labels and groups of the contents of metabolic reconstruction

Description

A data frame contains the labels and groups of the contents of metabolic reconstruction

Usage

contentTypes

Format

label

the contents of the metabolic reconstruction

group

the classfication of the labels


A data frame contains the details of the transformation of the metabolic reconstruction

Description

A data frame contains the details of the transformation of the metabolic reconstruction

Usage

conversionMatrix

Format

A data frame contains 93 rows and 67 variables:

MarkerWords

the key words of the steps of metabolic reconstruction

ThresholdValue

the values filter the steps after the mapping

Steps

the steps of metabolic reonstruction

Group

the classification of the steps

SpeciesName

1 means the output of Species name.

TaxonID

1 means the output of Taxon ID.

NCBI

1 means the output of NCBI.

Uniprot

1 means the output of Uniprot.

KEGG

1 means the output of KEGG.

MetaCyc

1 means the output of MetaCyc.

PubChem

1 means the output of PubChem.

Brenda

1 means the output of Brenda.

Download

1 means the output of Download.

GeneticInformation

1 means the output of Genetic information.

ProteinInformation

1 means the output of Protein information.

GenomeSequence

1 means the output of Genome sequence.

ProteinSequence

1 means the output of Protein sequence.

MetabolicFunctionInformation

1 means the output of Metabolic function information.

Metabolites

1 means the output of Metabolites.

Cofactor

1 means the output of Cofactor.

Nucleotides

1 means the output of Nucleotides.

AminoAcid

1 means the output of Amino acid.

MolecularWeight

1 means the output of Molecular weight.

DryWeight

1 means the output of Dry weight.

MetabolicReaction

1 means the output of Metabolic reaction.

TerminalMetabolite

1 means the output of Terminal metabolite.

Secretion

1 means the output of Secretion.

BiomassReaction

1 means the output of Biomass reaction.

DemandReaction

1 means the output of Demand reaction.

SinkReaction

1 means the output of Sink reaction.

GapReaction

1 means the output of Gap reaction.

SpontaneousReaction

1 means the output of Spontaneous reaction.

ExtracellularAndPeriplasmicTransportReactions

1 means the output of Extracellular and periplasmic transport reactions reaction.

ExchangeReaction

1 means the output of Exchange reaction.

IntracellularTransportReaction

1 means the output of Intracellular transport reaction.

ReactionFlux

1 means the output of Reaction flux.

GPR

1 means the output of GPR.

BlastComparison

1 means the output of Blast comparison.

Homology

1 means the output of Homology.

HomologousGene

1 means the output of Homology gene.

StoichiometricMatrix

1 means the output of Stoichiometric matrix.

Knockout

1 means the output of Knockout.

TargetReaction

1 means the output of Target reaction.

Restrictions

1 means the output of Restrictions.

GrowthConditions

1 means the output of Growth conditions.

MinORMax

1 means the output of min | max.

ReconstructionData

1 means the output of Reconstruction data.

FVA

1 means the output of FVA.

MetabolicFlux

1 means the output of Metabolic flux.

Statistics

1 means the output of Metabolic Statistics.

NeutralMolecularFormula

1 means the output of Neutral molecular formula.

ChargedMolecularFormula

1 means the output of Charged molecular formula.

LiteratureDataCollection

1 means the output of Literature data collection.

ConservationOfMassAndCharge

1 means the output of Conservation of mass and charge.

GibbsFreeEnergy

1 means the output of Gibbs free energy.

CellCompartmentInformation

1 means the output of Cell compartment information.

SubsystemInformation

1 means the output of Subsystem information.

MetaboliteIdentification

1 means the output of Metabolite Identification.

Unite

1 means the output of Unite.

ManualPlanning

1 means the output of Manual planning.

Coefficient

1 means the output of Coefficient.

ScatterPlot

1 means the output of Scatter plot.

TestReport

1 means the output of Test Report.

TypeIIIPath

1 means the output of Type III path.

SBML

1 means the output of SBML file.

Mat

1 means the output of Mat file.

Excel

1 means the output of Excel file.


A data frame contains the labels and groups of the transformation of metabolic reconstruction

Description

A data frame contains the labels and groups of the transformation of metabolic reconstruction

Usage

conversionTypes

Format

A data frame contains 63 rows and 2 variables:

label

the transformation of the metabolic reconstruction

group

the classfication of the labels


draw_conversion_tree

Description

Drawing of metabolic process matrix diagram and phylogenetic tree diagram

Usage

draw_conversion_tree(infomatrix, Matrix, stepTypes, conversionTypes)

Arguments

infomatrix

Matrix generated using the words2steps function

Matrix

The matrix about the step or transformation or databases and tools used in the metabolic reconstruction

stepTypes

Grouping information for reconstruction processes

conversionTypes

Grouping information for conversion content

Value

a plot

Examples

p1 <- draw_conversion_tree(matrixProcessConversion, conversionMatrix,
   stepTypes, conversionTypes)

draw_step_tree

Description

Drawing of metabolic process matrix diagram and phylogenetic tree diagram

Usage

draw_step_tree(infomatrix, Matrix, stepTypes, contentTypes)

Arguments

infomatrix

Matrix generated using the words2steps function

Matrix

The matrix about the steps or transformation or the databases and tools of the metabolic reconstruction.

stepTypes

Grouping information for metabolic processes

contentTypes

Grouping information for metabolic content

Value

a plot

Examples

p1 <- draw_step_tree(matrixProcess, stepsMatrix, stepTypes, contentTypes)

get_term_matrix

Description

get_term_matrix

Usage

get_term_matrix(data)

Arguments

data

information of data text

Value

words matrix

Examples

wordsMatrix <- get_term_matrix(text)

inputTxt

Description

A variable containing the contents of the metabolic reconstruction:

Usage

inputTxt

Format

A data frame with characters:

V1

the contents of the metabolic reconstruction


map_word_to_step

Description

map_word_to_step

Usage

map_word_to_step(wordsMatrix, stepsMatrix)

Arguments

wordsMatrix

The word matrix generated by the function TermDocumentMatrix in the tm package.

stepsMatrix

Manually constructed metabolic process matrix.

Value

Specific metabolic process matrix based on text content mapping.

Examples

matrixProcess <- map_word_to_step(wordsMatrix, stepsMatrix)

A data frame produced by the function map_word_to_step

Description

A data frame produced by the function map_word_to_step

Usage

matrixProcess

Format

A data frame contains 67 variables

degree

the number of the steps used in a article.

SpeciesName

-1 means the input of Species name. 1 means the output of Species name.

TaxonID

-1 means the input of Taxon ID. 1 means the output of Taxon ID.

KEGG

-1 means the input of KEGG reaction. 1 means the output of KEGG reaction.

NCBI

-1 means the input of NCBI gene. 1 means the output of NCBI gene.

Uniprot

-1 means the input of Uniprot gene. 1 means the output of Uniprot.

MetaCyc

-1 means the input of MetaCyc gene. 1 means the output of MetaCyc.

PubChem

-1 means the input of PubChem molecular formula. 1 means the output of PubChem molecular formula.

Brenda

identify whether input the Brenda. -1 means the input of Brenda. 1 means the output of Brenda.

Chebi

-1 means the input of Chebi information. 1 means the the output of Chebi information.

WebGCM

-1 means the input of Web GCM. 1 means the the output of Web GCM.

SpontaneousReaction

-1 means the input of spontaneous reaction. 1 means the the output of spontaneous reaction.

ExtracellularAndPeriplasmicTransportReactions

-1 means the input of Extracellular and periplasmic transport reactions. 1 means the the output of Extracellular and periplasmic transport reactions.

ExchangeReaction

-1 means the input of exchange reaction. 1 means the the output of exchange reaction.

MissingExchangeReaction

-1 means the input of missing exchange reaction. 1 means the the output of missing exchange reaction.

IntracellularTransportReaction

-1 means the input of intracellular transport reaction. 1 means the the output of intracellular transport reaction.

Gene

-1 means the input of gene. 1 means the the output of gene.

Protein

-1 means the input of protein. 1 means the the output of protein.

Knockout

-1 means the input of knockout. 1 means the the output of knockout.

StoichiometricMatrix

-1 means the input of stoichiometric matrix. 1 means the the output of stoichiometric matrix.

ObjectiveReaction

-1 means the input of objective reaction. 1 means the the output of objective reaction.

Constraints

-1 means the input of constraints. 1 means the the output of constraints.

Secretion

-1 means the input of secretion. 1 means the the output of secretion.

Mutisecretion

-1 means the input of mutisecretion. 1 means the the output of mutisecretion.

RichMedia

-1 means the input of rich media. 1 means the the output of rich media.

GenomeSequence

-1 means the input of genome sequence. 1 means the the output of genome sequence.

ProteomeSequence

-1 means the input of proteome sequence. 1 means the the output of proteome sequence.

AminoAcidWeight

-1 means the input of amino acid weight. 1 means the the output of amino acid weight.

AminoAcidMolecularWeight

-1 means the input of amino acid molecular weight. 1 means the the output of amino acid molecular weight.

NucleotideWeight

-1 means the input of nucleotide weight. 1 means the the output of nucleotide weight.

NucleotideMolecularWeight

-1 means the input of nucleotide molecular weight. 1 means the the output of nucleotide molecular weight.

DryWeight

-1 means the input of dry weight. 1 means the the output of dry weight.

BiomassReaction

-1 means the input of biomass reaction. 1 means the the output of biomass reaction.

DemandReaction

-1 means the input of demand reaction. 1 means the the output of demand reaction.

SinkReaction

-1 means the input of sink reaction. 1 means the the output of sink reaction.

GapReaction

-1 means the input of gap reaction. 1 means the the output of gap reaction.

MinORMax

-1 means the input of gap reaction. 1 means the the output of gap reaction.

GeneticInformation

-1 means the input of genetic information. 1 means the the output of genetic information.

MetabolicFunction

-1 means the input of metabolic function. 1 means the the output of metabolic function.

Metabolites

-1 means the input of metabolites. 1 means the the output of metabolites.

BiomassMetabolites

-1 means the input of biomass metabolites. 1 means the the output of biomass metabolites.

MetabolicReaction

-1 means the input of metabolic reaction. 1 means the the output of metabolic reaction.

ReconstructionData

-1 means the input of reconstruction data. 1 means the the output of reconstruction data.

DataStatistics

-1 means the input of data statistics. 1 means the the output of data statistics.

NeutralMolecularFormula

-1 means the input of neutral molecular formula. 1 means the the output of neutral molecular formula.

ChargedMolecularFormula

-1 means the input of charged molecular formula. 1 means the the output of charged molecular formula.

ConservationOfMassAndCharge

-1 means the input of conservation of mass and charge. 1 means the the output of conservation of mass and charge.

GibbsFreeEnergyInformation

-1 means the input of gibbs free energy information. 1 means the the output of gibbs free energy information.

Mass_ChargeConservationAssessment

-1 means the input of mass-charge conservation assessment. 1 means the the output of conservation assessment.

CellularCompartment

-1 means the input of cellular compartment. 1 means the the output of cellular compartment.

SubsystemInformation

-1 means the input of subsystem information. 1 means the the output of subsystem information.

IdentifiersInKEGG

-1 means the input of identifiers in KEGG. 1 means the the output of identifiers in KEGG.

IdentifiersInMetaCyc

-1 means the input of identifiers in MetaCyc. 1 means the the output of identifiers in MetaCyc.

UniformIdentifier

-1 means the input of uniform identifier. 1 means the the output of uniform identifier.

Coefficient

-1 means the input of coefficient. 1 means the the output of coefficient.

ScatterPlot

-1 means the input of scatter plot. 1 means the the output of scatter plot.

TerminalMetabolite

-1 means the input of terminal metabolite. 1 means the the output of terminal metabolite.

TypeIIIPathway

-1 means the input of Type III pathway. 1 means the the output of Type III pathway.

NetworkGap

-1 means the input of network gap. 1 means the the output of network gap.

Growth

-1 means the input of growth. 1 means the the output of growth.

BlockReaction

-1 means the input of block reaction. 1 means the the output of block reaction.

MetabolicFlux

-1 means the input of metabolic flux. 1 means the the output of metabolic flux.

ModelPredictCorrectly

1 means the output of model PredictCorrectly.

ModelGrowingTooFast

-1 means the input of model growing too fast. 1 means the the output of model growing too fast.

SBML

-1 means the input of SBML file. 1 means the the output of SBML file.

Mat

-1 means the input of Mat file. 1 means the the output of Mat file.

Excel

-1 means the input of Excel file. 1 means the the output of Excel file.


A data frame produced by the function map_word_to_step

Description

A data frame produced by the function map_word_to_step

Usage

matrixProcessConversion

Format

A data frame contains 64 variables

degree

the number of the steps used in a article.

SpeciesName

1 means the output of Species name.

TaxonID

1 means the output of Taxon ID.

NCBI

1 means the output of NCBI.

Uniprot

1 means the output of Uniprot.

KEGG

1 means the output of KEGG.

MetaCyc

1 means the output of MetaCyc.

PubChem

1 means the output of PubChem.

Brenda

1 means the output of Brenda.

Download

1 means the output of Download.

GeneticInformation

1 means the output of Genetic information.

ProteinInformation

1 means the output of Protein information.

GenomeSequence

1 means the output of Genome sequence.

ProteinSequence

1 means the output of Protein sequence.

MetabolicFunctionInformation

1 means the output of Metabolic function information.

Metabolites

1 means the output of Metabolites.

Cofactor

1 means the output of Cofactor.

Nucleotides

1 means the output of Nucleotides.

AminoAcid

1 means the output of Amino acid.

MolecularWeight

1 means the output of Molecular weight.

DryWeight

1 means the output of Dry weight.

MetabolicReaction

1 means the output of Metabolic reaction.

TerminalMetabolite

1 means the output of Terminal metabolite.

Secretion

1 means the output of Secretion.

BiomassReaction

1 means the output of Biomass reaction.

DemandReaction

1 means the output of Demand reaction.

SinkReaction

1 means the output of Sink reaction.

GapReaction

1 means the output of Gap reaction.

SpontaneousReaction

1 means the output of Spontaneous reaction.

ExtracellularAndPeriplasmicTransportReactions

1 means the output of Extracellular and periplasmic transport reactions reaction.

ExchangeReaction

1 means the output of Exchange reaction.

IntracellularTransportReaction

1 means the output of Intracellular transport reaction.

ReactionFlux

1 means the output of Reaction flux.

GPR

1 means the output of GPR.

BlastComparison

1 means the output of Blast comparison.

Homology

1 means the output of Homology.

HomologousGene

1 means the output of Homology gene.

StoichiometricMatrix

1 means the output of Stoichiometric matrix.

Knockout

1 means the output of Knockout.

TargetReaction

1 means the output of Target reaction.

Restrictions

1 means the output of Restrictions.

GrowthConditions

1 means the output of Growth conditions.

MinORMax

1 means the output of min | max.

ReconstructionData

1 means the output of Reconstruction data.

FVA

1 means the output of FVA.

MetabolicFlux

1 means the output of Metabolic flux.

Statistics

1 means the output of Metabolic Statistics.

NeutralMolecularFormula

1 means the output of Neutral molecular formula.

ChargedMolecularFormula

1 means the output of Charged molecular formula.

LiteratureDataCollection

1 means the output of Literature data collection.

ConservationOfMassAndCharge

1 means the output of Conservation of mass and charge.

GibbsFreeEnergy

1 means the output of Gibbs free energy.

CellCompartmentInformation

1 means the output of Cell compartment information.

SubsystemInformation

1 means the output of Subsystem information.

MetaboliteIdentification

1 means the output of Metabolite Identification.

Unite

1 means the output of Unite.

ManualPlanning

1 means the output of Manual planning.

Coefficient

1 means the output of Coefficient.

ScatterPlot

1 means the output of Scatter plot.

TestReport

1 means the output of Test Report.

TypeIIIPath

1 means the output of Type III path.

SBML

1 means the output of SBML file.

Mat

1 means the output of Mat file.

Excel

1 means the output of Excel file.


A data frame produced by the function map_to_word in the function vizProcess

Description

A data frame produced by the function map_to_word in the function vizProcess

Usage

matrixProcessFile

Format

A data frame contains with 3 variables

step

the steps used in the metabolic reconstruction

degree

the number that steps used in the metbolic reconstructoin occur in an article

step_ID

the order of the steps used in the metabolic reconstruction


slotsFunction

Description

slotsFunction

Usage

slots(variablesFile)

Arguments

variablesFile

A data frame contains three different variables.


A data frame contains the details of the steps of the metabolic reconstruction

Description

A data frame contains the details of the steps of the metabolic reconstruction

Usage

stepsMatrix

Format

A data frame with 93 rows and 70 variables:

MarkerWords

the key words of the steps of metabolic reconstruction

ThresholdValue

the values filter the steps after the mapping

Steps

the steps of metabolic reonstruction

Group

the classification of the steps

SpeciesName

-1 means the input of Species name. 1 means the output of Species name.

TaxonID

-1 means the input of Taxon ID. 1 means the output of Taxon ID.

KEGG

-1 means the input of KEGG reaction. 1 means the output of KEGG reaction.

NCBI

-1 means the input of NCBI gene. 1 means the output of NCBI gene.

Uniprot

-1 means the input of Uniprot gene. 1 means the output of Uniprot.

MetaCyc

-1 means the input of MetaCyc gene. 1 means the output of MetaCyc.

PubChem

-1 means the input of PubChem molecular formula. 1 means the output of PubChem molecular formula.

Brenda

identify whether input the Brenda. -1 means the input of Brenda. 1 means the output of Brenda.

Chebi

-1 means the input of Chebi information. 1 means the the output of Chebi information.

WebGCM

-1 means the input of Web GCM. 1 means the the output of Web GCM.

SpontaneousReaction

-1 means the input of spontaneous reaction. 1 means the the output of spontaneous reaction.

ExtracellularAndPeriplasmicTransportReactions

-1 means the input of Extracellular and periplasmic transport reactions. 1 means the the output of Extracellular and periplasmic transport reactions.

ExchangeReaction

-1 means the input of exchange reaction. 1 means the the output of exchange reaction.

MissingExchangeReaction

-1 means the input of missing exchange reaction. 1 means the the output of missing exchange reaction.

IntracellularTransportReaction

-1 means the input of intracellular transport reaction. 1 means the the output of intracellular transport reaction.

Gene

-1 means the input of gene. 1 means the the output of gene.

Protein

-1 means the input of protein. 1 means the the output of protein.

Knockout

-1 means the input of knockout. 1 means the the output of knockout.

StoichiometricMatrix

-1 means the input of stoichiometric matrix. 1 means the the output of stoichiometric matrix.

ObjectiveReaction

-1 means the input of objective reaction. 1 means the the output of objective reaction.

Constraints

-1 means the input of constraints. 1 means the the output of constraints.

Secretion

-1 means the input of secretion. 1 means the the output of secretion.

Mutisecretion

-1 means the input of mutisecretion. 1 means the the output of mutisecretion.

RichMedia

-1 means the input of rich media. 1 means the the output of rich media.

GenomeSequence

-1 means the input of genome sequence. 1 means the the output of genome sequence.

ProteomeSequence

-1 means the input of proteome sequence. 1 means the the output of proteome sequence.

AminoAcidWeight

-1 means the input of amino acid weight. 1 means the the output of amino acid weight.

AminoAcidMolecularWeight

-1 means the input of amino acid molecular weight. 1 means the the output of amino acid molecular weight.

NucleotideWeight

-1 means the input of nucleotide weight. 1 means the the output of nucleotide weight.

NucleotideMolecularWeight

-1 means the input of nucleotide molecular weight. 1 means the the output of nucleotide molecular weight.

DryWeight

-1 means the input of dry weight. 1 means the the output of dry weight.

BiomassReaction

-1 means the input of biomass reaction. 1 means the the output of biomass reaction.

DemandReaction

-1 means the input of demand reaction. 1 means the the output of demand reaction.

SinkReaction

-1 means the input of sink reaction. 1 means the the output of sink reaction.

GapReaction

-1 means the input of gap reaction. 1 means the the output of gap reaction.

MinORMax

-1 means the input of gap reaction. 1 means the the output of gap reaction.

GeneticInformation

-1 means the input of genetic information. 1 means the the output of genetic information.

MetabolicFunction

-1 means the input of metabolic function. 1 means the the output of metabolic function.

Metabolites

-1 means the input of metabolites. 1 means the the output of metabolites.

BiomassMetabolites

-1 means the input of biomass metabolites. 1 means the the output of biomass metabolites.

MetabolicReaction

-1 means the input of metabolic reaction. 1 means the the output of metabolic reaction.

ReconstructionData

-1 means the input of reconstruction data. 1 means the the output of reconstruction data.

DataStatistics

-1 means the input of data statistics. 1 means the the output of data statistics.

NeutralMolecularFormula

-1 means the input of neutral molecular formula. 1 means the the output of neutral molecular formula.

ChargedMolecularFormula

-1 means the input of charged molecular formula. 1 means the the output of charged molecular formula.

ConservationOfMassAndCharge

-1 means the input of conservation of mass and charge. 1 means the the output of conservation of mass and charge.

GibbsFreeEnergyInformation

-1 means the input of conservation of gibbs free energy information. 1 means the the output of gibbs free energy information.

Mass_ChargeConservationAssessment

-1 means the input of mass-charge conservation assessment. 1 means the the output of mass-charge conservation assessment.

CellularCompartment

-1 means the input of cellular compartment. 1 means the the output of cellular compartment.

SubsystemInformation

-1 means the input of subsystem information. 1 means the the output of subsystem information.

IdentifiersInKEGG

-1 means the input of subsystem information. 1 means the the output of subsystem information.

IdentifiersInMetaCyc

-1 means the input of identifiers in MetaCyc. 1 means the the output of identifiers in MetaCyc.

UniformIdentifier

-1 means the input of uniform identifier. 1 means the the output of uniform identifier.

Coefficient

-1 means the input of coefficient. 1 means the the output of coefficient.

ScatterPlot

-1 means the input of scatter plot. 1 means the the output of scatter plot.

TerminalMetabolite

-1 means the input of terminal metabolite. 1 means the the output of terminal metabolite.

TypeIIIPathway

-1 means the input of Type III pathway. 1 means the the output of Type III pathway.

NetworkGap

-1 means the input of network gap. 1 means the the output of network gap.

Growth

-1 means the input of growth. 1 means the the output of growth.

BlockReaction

-1 means the input of block reaction. 1 means the the output of block reaction.

MetabolicFlux

-1 means the input of metabolic flux. 1 means the the output of metabolic flux.

ModelPredictCorrectly

-1 means the input of model predict correctly. 1 means the the output of model predict correctly.

ModelGrowingTooFast

-1 means the input of model growing too fast. 1 means the the output of model growing too fast.

SBML

-1 means the input of SBML file. 1 means the the output of SBML file.

Mat

-1 means the input of Mat file. 1 means the the output of Mat file.

Excel

-1 means the input of Excel file. 1 means the the output of Excel file.


A data frame contains the labels and groups of the steps of metabolic reconstruction

Description

A data frame contains the labels and groups of the steps of metabolic reconstruction

Usage

stepTypes

Format

A data frame contains 93 rows and 2 variables:

label

the steps of the metabolic reconstruction

group

the classfication of the labels


Sysrecon

Description

Input the txt and output the visualization of the steps, transformation and databases and tools.

Usage

Sysrecon(
  inputTxt,
  stepsMatrix,
  stepTypes,
  conversionMatrix,
  conversionTypes,
  toolsMatrix,
  toolsTypes,
  contentTypes
)

Arguments

inputTxt

A txt contains the methods and contents of the metabolic reconstruction in articles.

stepsMatrix

A data frame the marker words, threshold value, steps, group and other information about the metabolic reconstruction. The default file is in the data.

stepTypes

A data frame the labels and groups of the metabolic reconstructions steps. The default file is in the data.

conversionMatrix

A data frame contains the marker words, threshold value, steps, group and other transformation information about the metabolic reconstruction. The default file is in the data.

conversionTypes

A data frame contains the labels and groups of the metabolic reconstructions transformation. The default file is in the data.

toolsMatrix

A data frame contains the marker words, threshold value, steps, group and other information about the metabolic reconstruction databases and tools. The default file is in the data.

toolsTypes

A data frame contains the databases and the tools used in the metabolic reconstruction.

contentTypes

A data frame contains the labels and groups of the metabolic reconstructions content The default file is in the data.

Details

Input takes a data.frame x with two variables v and w and returns the maximum knapsack value and which elements (rows in the data.frame).

Value

The pictures that visualize the steps, transformation and databases and tools of the metabolic reconstruction.

Examples

exam <- Sysrecon(inputTxt, stepsMatrix, stepTypes, conversionMatrix, conversionTypes,
  toolsMatrix, toolsTypes, contentTypes)

systemrecon-class

Description

systemrecon-class

Usage

label

Format

An object of class character of length 72.

Slots

Taxon_id

Taxonomy ID

NCBI_gene

Gene information from NCBI

Uniprot_gene

Gene information from Uniprot

Genetic_information

Genetic information

KEGG_reaction

Reactions in KEGG

MetaCyc_reaction

Reactions in MetaCyc

Metabolic_function

Metabolic function

Metabolic_reaction

Metabolic reaction

Metabolites_id

Metabolites ID

Reconstruction_data

Reconstruction data

Genome_sequence

Genome sequence

Genome_sequence_reference

Reference of genome sequence

Reconstruction_data_reference

Reference of reconstruction data

Data_statistics_metabolites

Data statistics of metabolites

PubChem_molecular_formula

Molecular formula in PubChem database

Brenda_molecular_formula

Molecular formula in Brenda database

Neutral_molecular_formula

Neutral molecular formula

Charged_molecular_formula

Charged molecular formula

Chebi_molecular_formula

Chebi molecular formula

Conservation_of_mass_and_charge

Conservation of mass and charge

Web_GCM_Gibbs

Web GCM Gibbs

Gibbs_free_energy_information

Information of gibbs free energy

Gene_id

Gene ID

Protein_id

Protein ID

Cellular_compartment

Information of cellualr compartment

Subsystem_information

Subsystem information

Uniform_identifier_metabolites

Uniform identifiers of metabollites

Spontaneous_reactions

Spontaneous reactions

Extracellular_and_periplasmic_transport_reactions

Extracellular and periplasmic transport reactions

Exchange_reactions

Exchange reactions

Intracellular_transport_reactions

ntracellular transport reactions

Amino_acid_weight

Amino acid weight

Amino_acid_molecular_weight

Amino acid_molecular weight

Dry_weight

Dry weight

Amino_acid_coefficient

Amino acid coefficient

Nucleotide_coefficient

Nucleotide coefficient

Nucleotide_weight

Nucleotide weight

Nucleotide_molecular_weight

Nucleotide molecular weight

Biomass_reactions

Biomass reactions

Demand_reactions

Demand reactions

Sink_reactions

Sink reactions

Scatter_plot_stoichiometric_matrix

Scatter plot of stoichiometric matrix

Objective_reaction

Objective reaction

Constraints

Constraints of the model

Mass_charge_conservation_assessment

assessment of conservation of mass and charge

Terminal_metabolites

Terminal metabolites

Gap_reactions

Gap reactions

Missing_exchange_reactions

Missing exchange reactions

Type_III_pathway

Type III pathway

Network_gaps

Network gaps

Biomass_metabolites

Biomass metabolites

miniaml_or_maxiaml

miniaml or maxiaml

Metabolic_flux_value

Value of metabolic flux

Growth

Prediction of the growth of model

Secretion_product

Product of secretion

Mutisecretion

Multisecretion

Rich_media

Environment of rich media

Block_reactions

Block reactions

Knockout

Knockout the single gene or reaction

Model_predict_correctly

Predict the model correctly

Model_growing_too_fast

Assess whether the model grow too fast

Cofactors

Cofactors

FBA

Flux balance analysis

GPR

Gene-protein reaction

Output

Output the file

Iteration

Iteration

Test

Test

Assessment

Assessment

Identifiers_metabolites

Identifiers of metabolites

Output_file

Output the file

Elemental_balance

Elemental balance

Biomass_metabolites_coefficient

Coefficients of biomass and metabolites


A list of characters from the inputTxt.

Description

A list of characters from the inputTxt.

Usage

text

Format

An object of class character of length 1.


A data frame contains the details of the databases and tools of the metabolic reconstruction

Description

A data frame contains the details of the databases and tools of the metabolic reconstruction

Usage

toolsMatrix

Format

A data frame contains the 93 rows and 46 varibales.

MarkerWords

the key words of the steps of metabolic reconstruction

ThresholdValue

the values filter the steps after the mapping

Steps

the steps of metabolic reonstruction

Group

the classification of the steps

UniProtKnowledgeBase

1 means the output of UniProt Knowledgebase.

NCBI_Gene

1 means the output of NCBI Gene.

KEGG_Genes

1 means the output of KEGG Genes.

KEGG_Genome

1 means the output of KEGG Genome.

NCBI_Protein

1 means the output of NCBI Protein.

KEGG_Pathway

1 means the output of KEGG Pathway.

KEGG_Compound

1 means the output of KEGG Compound.

KEGG_Reaction

1 means the output of KEGG Reaction.

BioCyc

1 means the output of BioCyc.

MetaCycCompound

1 means the output of MetaCyc Compound.

MetaCycReaction

1 means the output of MetaCyc Reaction.

KEGGREST

1 means the output of KEGGREST.

COBRA

1 means the output of COBRA.

RAVEN

1 means the output of RAVEN.

CarveMe

1 means the output of CarveMe.

AuReMe

1 means the output of AuReMe.

MetaDraft

1 means the output of MetaDraft.

ModelSEED

1 means the output of ModelSEED.

PathwayTools

1 means the output of Pathway Tools.

Merlin

1 means the output of Merlin.

AGORA

1 means the output of AGORA.

COBRApy

1 means the output of COBRApy.

BLAST

1 means the output of BLAST.

ExperimentOrLiterature

1 means the output of Experiment or literature.

BRENDA

1 means the output of BRENDA.

minval

1 means the output of minval.

ChEBI

1 means the output of ChEBI.

PubChem_Compound

1 means the output of PubChem-compound.

ChEMBL_Compound

1 means the output of ChEMBL compound.

Rhea

1 means the output of Rhea.

pKa_DB

1 means the output of pKa DB.

rsbml

1 means the output of rsbml.

PipelinePilot

1 means the output of Pipeline Pilot.

Sybil

1 means the output of Sybil.

BUSCA

1 means the output of BUSCA.

PSORT

1 means the output of PSORT.

PASUB

1 means the output of PASUB.

PubChem_Substance

1 means the output of PubChem substance.

STRING

1 means the output of STRING.

ManualPlanning

1 means the output of Manual planning.

CMR

1 means the output of CMR.

g2f

1 means the output of g2f.


A data frame contains the labels and groups of the databases and tools of metabolic reconstruction

Description

A data frame contains the labels and groups of the databases and tools of metabolic reconstruction

Usage

toolsTypes

Format

label

the databases and tools of the metabolic reconstruction

group

the classfication of the labels


vizProcess

Description

Create a function can visualiaze the steps used in the metabolic reconstruction.

Usage

vizProcess(text, stepsMatrix, stepTypes, contentTypes)

Arguments

text

The characters processed with the collapse = ' '.

stepsMatrix

A data frame contains the marker words, threshold value, steps, group and other information about the metabolic reconstruction. The default file is in the data.

stepTypes

A data frame contains the labels and groups of the metabolic reconstructions steps. The default file is in the data.

contentTypes

A data frame contains the labels and groups of the metabolic reconstructions content The default file is in the data.

Value

The pictures that visualize the steps of the metabolic reconstruction.

Examples

exam <- vizProcess(text, stepsMatrix, stepTypes,contentTypes)

vizTools

Description

Input the txt and output the visualization of the steps, transformation and databases and tools.

Usage

vizTools(text, toolsMatrix, stepTypes, toolsTypes)

Arguments

text

The characters processed with the collapse = ' '.

toolsMatrix

A data frame contains the marker words, threshold value, steps, group and other information about the metabolic reconstruction databases and tools. The default file is in the data.

stepTypes

A data frame contains the labels and groups of the metabolic reconstructions steps. The default file is in the data.

toolsTypes

A data frame contains the databases and the tools used in the metabolic reconstruction.

Value

The pictures that visualize the databases and tools of the metabolic reconstruction.

Examples

exam <- vizTools(text, toolsMatrix, stepTypes, toolsTypes)

vizTransformation

Description

Input the txt and output the visualization of the steps, transformation and databases and tools.

Usage

vizTransformation(text, conversionMatrix, stepTypes, conversionTypes)

Arguments

text

The characters processed with the collapse = ' '.

conversionMatrix

A data frame contains the marker words, threshold value, steps, group and other transformation information about the metabolic reconstruction. The default file is in the data.

stepTypes

A data frame contains the labels and groups of the metabolic reconstructions steps. The default file is in the data.

conversionTypes

A data frame contains the labels and groups of the metabolic reconstructions transformation. The default file is in the data.

Value

The pictures that visualize the transformation of the metabolic reconstruction.

Examples

exam <- vizTransformation(text, conversionMatrix, stepTypes, conversionTypes)

A data frame produced by the function get_term_matrix

Description

A data frame produced by the function get_term_matrix

Usage

wordsMatrix

Format

A data frame contains 4 variables

freq

the frequency of the word occurs in a article.

prevalent

the words type that often occurs in a article.

longest

the longest type of a word.

shortest

the shortest type of a word.