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 |
A data frame contains the labels and groups of the contents of metabolic reconstruction
contentTypes
contentTypes
the contents of the metabolic reconstruction
the classfication of the labels
A data frame contains the details of the transformation of the metabolic reconstruction
conversionMatrix
conversionMatrix
A data frame contains 93 rows and 67 variables:
the key words of the steps of metabolic reconstruction
the values filter the steps after the mapping
the steps of metabolic reonstruction
the classification of the steps
1 means the output of Species name.
1 means the output of Taxon ID.
1 means the output of NCBI.
1 means the output of Uniprot.
1 means the output of KEGG.
1 means the output of MetaCyc.
1 means the output of PubChem.
1 means the output of Brenda.
1 means the output of Download.
1 means the output of Genetic information.
1 means the output of Protein information.
1 means the output of Genome sequence.
1 means the output of Protein sequence.
1 means the output of Metabolic function information.
1 means the output of Metabolites.
1 means the output of Cofactor.
1 means the output of Nucleotides.
1 means the output of Amino acid.
1 means the output of Molecular weight.
1 means the output of Dry weight.
1 means the output of Metabolic reaction.
1 means the output of Terminal metabolite.
1 means the output of Secretion.
1 means the output of Biomass reaction.
1 means the output of Demand reaction.
1 means the output of Sink reaction.
1 means the output of Gap reaction.
1 means the output of Spontaneous reaction.
1 means the output of Extracellular and periplasmic transport reactions reaction.
1 means the output of Exchange reaction.
1 means the output of Intracellular transport reaction.
1 means the output of Reaction flux.
1 means the output of GPR.
1 means the output of Blast comparison.
1 means the output of Homology.
1 means the output of Homology gene.
1 means the output of Stoichiometric matrix.
1 means the output of Knockout.
1 means the output of Target reaction.
1 means the output of Restrictions.
1 means the output of Growth conditions.
1 means the output of min | max.
1 means the output of Reconstruction data.
1 means the output of FVA.
1 means the output of Metabolic flux.
1 means the output of Metabolic Statistics.
1 means the output of Neutral molecular formula.
1 means the output of Charged molecular formula.
1 means the output of Literature data collection.
1 means the output of Conservation of mass and charge.
1 means the output of Gibbs free energy.
1 means the output of Cell compartment information.
1 means the output of Subsystem information.
1 means the output of Metabolite Identification.
1 means the output of Unite.
1 means the output of Manual planning.
1 means the output of Coefficient.
1 means the output of Scatter plot.
1 means the output of Test Report.
1 means the output of Type III path.
1 means the output of SBML file.
1 means the output of Mat file.
1 means the output of Excel file.
A data frame contains the labels and groups of the transformation of metabolic reconstruction
conversionTypes
conversionTypes
A data frame contains 63 rows and 2 variables:
the transformation of the metabolic reconstruction
the classfication of the labels
Drawing of metabolic process matrix diagram and phylogenetic tree diagram
draw_conversion_tree(infomatrix, Matrix, stepTypes, conversionTypes)
draw_conversion_tree(infomatrix, Matrix, stepTypes, conversionTypes)
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 |
a plot
p1 <- draw_conversion_tree(matrixProcessConversion, conversionMatrix, stepTypes, conversionTypes)
p1 <- draw_conversion_tree(matrixProcessConversion, conversionMatrix, stepTypes, conversionTypes)
Drawing of metabolic process matrix diagram and phylogenetic tree diagram
draw_step_tree(infomatrix, Matrix, stepTypes, contentTypes)
draw_step_tree(infomatrix, Matrix, stepTypes, contentTypes)
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 |
a plot
p1 <- draw_step_tree(matrixProcess, stepsMatrix, stepTypes, contentTypes)
p1 <- draw_step_tree(matrixProcess, stepsMatrix, stepTypes, contentTypes)
get_term_matrix
get_term_matrix(data)
get_term_matrix(data)
data |
information of data text |
words matrix
wordsMatrix <- get_term_matrix(text)
wordsMatrix <- get_term_matrix(text)
A variable containing the contents of the metabolic reconstruction:
inputTxt
inputTxt
A data frame with characters:
the contents of the metabolic reconstruction
map_word_to_step
map_word_to_step(wordsMatrix, stepsMatrix)
map_word_to_step(wordsMatrix, stepsMatrix)
wordsMatrix |
The word matrix generated by the function TermDocumentMatrix in the tm package. |
stepsMatrix |
Manually constructed metabolic process matrix. |
Specific metabolic process matrix based on text content mapping.
matrixProcess <- map_word_to_step(wordsMatrix, stepsMatrix)
matrixProcess <- map_word_to_step(wordsMatrix, stepsMatrix)
A data frame produced by the function map_word_to_step
matrixProcess
matrixProcess
A data frame contains 67 variables
the number of the steps used in a article.
-1 means the input of Species name. 1 means the output of Species name.
-1 means the input of Taxon ID. 1 means the output of Taxon ID.
-1 means the input of KEGG reaction. 1 means the output of KEGG reaction.
-1 means the input of NCBI gene. 1 means the output of NCBI gene.
-1 means the input of Uniprot gene. 1 means the output of Uniprot.
-1 means the input of MetaCyc gene. 1 means the output of MetaCyc.
-1 means the input of PubChem molecular formula. 1 means the output of PubChem molecular formula.
identify whether input the Brenda. -1 means the input of Brenda. 1 means the output of Brenda.
-1 means the input of Chebi information. 1 means the the output of Chebi information.
-1 means the input of Web GCM. 1 means the the output of Web GCM.
-1 means the input of spontaneous reaction. 1 means the the output of spontaneous reaction.
-1 means the input of Extracellular and periplasmic transport reactions. 1 means the the output of Extracellular and periplasmic transport reactions.
-1 means the input of exchange reaction. 1 means the the output of exchange reaction.
-1 means the input of missing exchange reaction. 1 means the the output of missing exchange reaction.
-1 means the input of intracellular transport reaction. 1 means the the output of intracellular transport reaction.
-1 means the input of gene. 1 means the the output of gene.
-1 means the input of protein. 1 means the the output of protein.
-1 means the input of knockout. 1 means the the output of knockout.
-1 means the input of stoichiometric matrix. 1 means the the output of stoichiometric matrix.
-1 means the input of objective reaction. 1 means the the output of objective reaction.
-1 means the input of constraints. 1 means the the output of constraints.
-1 means the input of secretion. 1 means the the output of secretion.
-1 means the input of mutisecretion. 1 means the the output of mutisecretion.
-1 means the input of rich media. 1 means the the output of rich media.
-1 means the input of genome sequence. 1 means the the output of genome sequence.
-1 means the input of proteome sequence. 1 means the the output of proteome sequence.
-1 means the input of amino acid weight. 1 means the the output of amino acid weight.
-1 means the input of amino acid molecular weight. 1 means the the output of amino acid molecular weight.
-1 means the input of nucleotide weight. 1 means the the output of nucleotide weight.
-1 means the input of nucleotide molecular weight. 1 means the the output of nucleotide molecular weight.
-1 means the input of dry weight. 1 means the the output of dry weight.
-1 means the input of biomass reaction. 1 means the the output of biomass reaction.
-1 means the input of demand reaction. 1 means the the output of demand reaction.
-1 means the input of sink reaction. 1 means the the output of sink reaction.
-1 means the input of gap reaction. 1 means the the output of gap reaction.
-1 means the input of gap reaction. 1 means the the output of gap reaction.
-1 means the input of genetic information. 1 means the the output of genetic information.
-1 means the input of metabolic function. 1 means the the output of metabolic function.
-1 means the input of metabolites. 1 means the the output of metabolites.
-1 means the input of biomass metabolites. 1 means the the output of biomass metabolites.
-1 means the input of metabolic reaction. 1 means the the output of metabolic reaction.
-1 means the input of reconstruction data. 1 means the the output of reconstruction data.
-1 means the input of data statistics. 1 means the the output of data statistics.
-1 means the input of neutral molecular formula. 1 means the the output of neutral molecular formula.
-1 means the input of charged molecular formula. 1 means the the output of charged molecular formula.
-1 means the input of conservation of mass and charge. 1 means the the output of conservation of mass and charge.
-1 means the input of gibbs free energy information. 1 means the the output of gibbs free energy information.
-1 means the input of mass-charge conservation assessment. 1 means the the output of conservation assessment.
-1 means the input of cellular compartment. 1 means the the output of cellular compartment.
-1 means the input of subsystem information. 1 means the the output of subsystem information.
-1 means the input of identifiers in KEGG. 1 means the the output of identifiers in KEGG.
-1 means the input of identifiers in MetaCyc. 1 means the the output of identifiers in MetaCyc.
-1 means the input of uniform identifier. 1 means the the output of uniform identifier.
-1 means the input of coefficient. 1 means the the output of coefficient.
-1 means the input of scatter plot. 1 means the the output of scatter plot.
-1 means the input of terminal metabolite. 1 means the the output of terminal metabolite.
-1 means the input of Type III pathway. 1 means the the output of Type III pathway.
-1 means the input of network gap. 1 means the the output of network gap.
-1 means the input of growth. 1 means the the output of growth.
-1 means the input of block reaction. 1 means the the output of block reaction.
-1 means the input of metabolic flux. 1 means the the output of metabolic flux.
1 means the output of model PredictCorrectly.
-1 means the input of model growing too fast. 1 means the the output of model growing too fast.
-1 means the input of SBML file. 1 means the the output of SBML file.
-1 means the input of Mat file. 1 means the the output of Mat file.
-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
matrixProcessConversion
matrixProcessConversion
A data frame contains 64 variables
the number of the steps used in a article.
1 means the output of Species name.
1 means the output of Taxon ID.
1 means the output of NCBI.
1 means the output of Uniprot.
1 means the output of KEGG.
1 means the output of MetaCyc.
1 means the output of PubChem.
1 means the output of Brenda.
1 means the output of Download.
1 means the output of Genetic information.
1 means the output of Protein information.
1 means the output of Genome sequence.
1 means the output of Protein sequence.
1 means the output of Metabolic function information.
1 means the output of Metabolites.
1 means the output of Cofactor.
1 means the output of Nucleotides.
1 means the output of Amino acid.
1 means the output of Molecular weight.
1 means the output of Dry weight.
1 means the output of Metabolic reaction.
1 means the output of Terminal metabolite.
1 means the output of Secretion.
1 means the output of Biomass reaction.
1 means the output of Demand reaction.
1 means the output of Sink reaction.
1 means the output of Gap reaction.
1 means the output of Spontaneous reaction.
1 means the output of Extracellular and periplasmic transport reactions reaction.
1 means the output of Exchange reaction.
1 means the output of Intracellular transport reaction.
1 means the output of Reaction flux.
1 means the output of GPR.
1 means the output of Blast comparison.
1 means the output of Homology.
1 means the output of Homology gene.
1 means the output of Stoichiometric matrix.
1 means the output of Knockout.
1 means the output of Target reaction.
1 means the output of Restrictions.
1 means the output of Growth conditions.
1 means the output of min | max.
1 means the output of Reconstruction data.
1 means the output of FVA.
1 means the output of Metabolic flux.
1 means the output of Metabolic Statistics.
1 means the output of Neutral molecular formula.
1 means the output of Charged molecular formula.
1 means the output of Literature data collection.
1 means the output of Conservation of mass and charge.
1 means the output of Gibbs free energy.
1 means the output of Cell compartment information.
1 means the output of Subsystem information.
1 means the output of Metabolite Identification.
1 means the output of Unite.
1 means the output of Manual planning.
1 means the output of Coefficient.
1 means the output of Scatter plot.
1 means the output of Test Report.
1 means the output of Type III path.
1 means the output of SBML file.
1 means the output of Mat file.
1 means the output of Excel file.
A data frame produced by the function map_to_word in the function vizProcess
matrixProcessFile
matrixProcessFile
A data frame contains with 3 variables
the steps used in the metabolic reconstruction
the number that steps used in the metbolic reconstructoin occur in an article
the order of the steps used in the metabolic reconstruction
slotsFunction
slots(variablesFile)
slots(variablesFile)
variablesFile |
A data frame contains three different variables. |
A data frame contains the details of the steps of the metabolic reconstruction
stepsMatrix
stepsMatrix
A data frame with 93 rows and 70 variables:
the key words of the steps of metabolic reconstruction
the values filter the steps after the mapping
the steps of metabolic reonstruction
the classification of the steps
-1 means the input of Species name. 1 means the output of Species name.
-1 means the input of Taxon ID. 1 means the output of Taxon ID.
-1 means the input of KEGG reaction. 1 means the output of KEGG reaction.
-1 means the input of NCBI gene. 1 means the output of NCBI gene.
-1 means the input of Uniprot gene. 1 means the output of Uniprot.
-1 means the input of MetaCyc gene. 1 means the output of MetaCyc.
-1 means the input of PubChem molecular formula. 1 means the output of PubChem molecular formula.
identify whether input the Brenda. -1 means the input of Brenda. 1 means the output of Brenda.
-1 means the input of Chebi information. 1 means the the output of Chebi information.
-1 means the input of Web GCM. 1 means the the output of Web GCM.
-1 means the input of spontaneous reaction. 1 means the the output of spontaneous reaction.
-1 means the input of Extracellular and periplasmic transport reactions. 1 means the the output of Extracellular and periplasmic transport reactions.
-1 means the input of exchange reaction. 1 means the the output of exchange reaction.
-1 means the input of missing exchange reaction. 1 means the the output of missing exchange reaction.
-1 means the input of intracellular transport reaction. 1 means the the output of intracellular transport reaction.
-1 means the input of gene. 1 means the the output of gene.
-1 means the input of protein. 1 means the the output of protein.
-1 means the input of knockout. 1 means the the output of knockout.
-1 means the input of stoichiometric matrix. 1 means the the output of stoichiometric matrix.
-1 means the input of objective reaction. 1 means the the output of objective reaction.
-1 means the input of constraints. 1 means the the output of constraints.
-1 means the input of secretion. 1 means the the output of secretion.
-1 means the input of mutisecretion. 1 means the the output of mutisecretion.
-1 means the input of rich media. 1 means the the output of rich media.
-1 means the input of genome sequence. 1 means the the output of genome sequence.
-1 means the input of proteome sequence. 1 means the the output of proteome sequence.
-1 means the input of amino acid weight. 1 means the the output of amino acid weight.
-1 means the input of amino acid molecular weight. 1 means the the output of amino acid molecular weight.
-1 means the input of nucleotide weight. 1 means the the output of nucleotide weight.
-1 means the input of nucleotide molecular weight. 1 means the the output of nucleotide molecular weight.
-1 means the input of dry weight. 1 means the the output of dry weight.
-1 means the input of biomass reaction. 1 means the the output of biomass reaction.
-1 means the input of demand reaction. 1 means the the output of demand reaction.
-1 means the input of sink reaction. 1 means the the output of sink reaction.
-1 means the input of gap reaction. 1 means the the output of gap reaction.
-1 means the input of gap reaction. 1 means the the output of gap reaction.
-1 means the input of genetic information. 1 means the the output of genetic information.
-1 means the input of metabolic function. 1 means the the output of metabolic function.
-1 means the input of metabolites. 1 means the the output of metabolites.
-1 means the input of biomass metabolites. 1 means the the output of biomass metabolites.
-1 means the input of metabolic reaction. 1 means the the output of metabolic reaction.
-1 means the input of reconstruction data. 1 means the the output of reconstruction data.
-1 means the input of data statistics. 1 means the the output of data statistics.
-1 means the input of neutral molecular formula. 1 means the the output of neutral molecular formula.
-1 means the input of charged molecular formula. 1 means the the output of charged molecular formula.
-1 means the input of conservation of mass and charge. 1 means the the output of conservation of mass and charge.
-1 means the input of conservation of gibbs free energy information. 1 means the the output of gibbs free energy information.
-1 means the input of mass-charge conservation assessment. 1 means the the output of mass-charge conservation assessment.
-1 means the input of cellular compartment. 1 means the the output of cellular compartment.
-1 means the input of subsystem information. 1 means the the output of subsystem information.
-1 means the input of subsystem information. 1 means the the output of subsystem information.
-1 means the input of identifiers in MetaCyc. 1 means the the output of identifiers in MetaCyc.
-1 means the input of uniform identifier. 1 means the the output of uniform identifier.
-1 means the input of coefficient. 1 means the the output of coefficient.
-1 means the input of scatter plot. 1 means the the output of scatter plot.
-1 means the input of terminal metabolite. 1 means the the output of terminal metabolite.
-1 means the input of Type III pathway. 1 means the the output of Type III pathway.
-1 means the input of network gap. 1 means the the output of network gap.
-1 means the input of growth. 1 means the the output of growth.
-1 means the input of block reaction. 1 means the the output of block reaction.
-1 means the input of metabolic flux. 1 means the the output of metabolic flux.
-1 means the input of model predict correctly. 1 means the the output of model predict correctly.
-1 means the input of model growing too fast. 1 means the the output of model growing too fast.
-1 means the input of SBML file. 1 means the the output of SBML file.
-1 means the input of Mat file. 1 means the the output of Mat file.
-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
stepTypes
stepTypes
A data frame contains 93 rows and 2 variables:
the steps of the metabolic reconstruction
the classfication of the labels
Input the txt and output the visualization of the steps, transformation and databases and tools.
Sysrecon( inputTxt, stepsMatrix, stepTypes, conversionMatrix, conversionTypes, toolsMatrix, toolsTypes, contentTypes )
Sysrecon( inputTxt, stepsMatrix, stepTypes, conversionMatrix, conversionTypes, toolsMatrix, toolsTypes, contentTypes )
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. |
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).
The pictures that visualize the steps, transformation and databases and tools of the metabolic reconstruction.
exam <- Sysrecon(inputTxt, stepsMatrix, stepTypes, conversionMatrix, conversionTypes, toolsMatrix, toolsTypes, contentTypes)
exam <- Sysrecon(inputTxt, stepsMatrix, stepTypes, conversionMatrix, conversionTypes, toolsMatrix, toolsTypes, contentTypes)
systemrecon-class
label
label
An object of class character
of length 72.
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.
text
text
An object of class character
of length 1.
A data frame contains the details of the databases and tools of the metabolic reconstruction
toolsMatrix
toolsMatrix
A data frame contains the 93 rows and 46 varibales.
the key words of the steps of metabolic reconstruction
the values filter the steps after the mapping
the steps of metabolic reonstruction
the classification of the steps
1 means the output of UniProt Knowledgebase.
1 means the output of NCBI Gene.
1 means the output of KEGG Genes.
1 means the output of KEGG Genome.
1 means the output of NCBI Protein.
1 means the output of KEGG Pathway.
1 means the output of KEGG Compound.
1 means the output of KEGG Reaction.
1 means the output of BioCyc.
1 means the output of MetaCyc Compound.
1 means the output of MetaCyc Reaction.
1 means the output of KEGGREST.
1 means the output of COBRA.
1 means the output of RAVEN.
1 means the output of CarveMe.
1 means the output of AuReMe.
1 means the output of MetaDraft.
1 means the output of ModelSEED.
1 means the output of Pathway Tools.
1 means the output of Merlin.
1 means the output of AGORA.
1 means the output of COBRApy.
1 means the output of BLAST.
1 means the output of Experiment or literature.
1 means the output of BRENDA.
1 means the output of minval.
1 means the output of ChEBI.
1 means the output of PubChem-compound.
1 means the output of ChEMBL compound.
1 means the output of Rhea.
1 means the output of pKa DB.
1 means the output of rsbml.
1 means the output of Pipeline Pilot.
1 means the output of Sybil.
1 means the output of BUSCA.
1 means the output of PSORT.
1 means the output of PASUB.
1 means the output of PubChem substance.
1 means the output of STRING.
1 means the output of Manual planning.
1 means the output of CMR.
1 means the output of g2f.
A data frame contains the labels and groups of the databases and tools of metabolic reconstruction
toolsTypes
toolsTypes
the databases and tools of the metabolic reconstruction
the classfication of the labels
Create a function can visualiaze the steps used in the metabolic reconstruction.
vizProcess(text, stepsMatrix, stepTypes, contentTypes)
vizProcess(text, stepsMatrix, stepTypes, contentTypes)
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. |
The pictures that visualize the steps of the metabolic reconstruction.
exam <- vizProcess(text, stepsMatrix, stepTypes,contentTypes)
exam <- vizProcess(text, stepsMatrix, stepTypes,contentTypes)
Input the txt and output the visualization of the steps, transformation and databases and tools.
vizTools(text, toolsMatrix, stepTypes, toolsTypes)
vizTools(text, toolsMatrix, stepTypes, toolsTypes)
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. |
The pictures that visualize the databases and tools of the metabolic reconstruction.
exam <- vizTools(text, toolsMatrix, stepTypes, toolsTypes)
exam <- vizTools(text, toolsMatrix, stepTypes, toolsTypes)
Input the txt and output the visualization of the steps, transformation and databases and tools.
vizTransformation(text, conversionMatrix, stepTypes, conversionTypes)
vizTransformation(text, conversionMatrix, stepTypes, conversionTypes)
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. |
The pictures that visualize the transformation of the metabolic reconstruction.
exam <- vizTransformation(text, conversionMatrix, stepTypes, conversionTypes)
exam <- vizTransformation(text, conversionMatrix, stepTypes, conversionTypes)
A data frame produced by the function get_term_matrix
wordsMatrix
wordsMatrix
A data frame contains 4 variables
the frequency of the word occurs in a article.
the words type that often occurs in a article.
the longest type of a word.
the shortest type of a word.