diff --git a/.gitmodules b/.gitmodules index 1d2a0d7004..5f8345fb3c 100644 --- a/.gitmodules +++ b/.gitmodules @@ -46,3 +46,6 @@ path = external/base/samplers/looplessFluxSampler url = https://github.com/rmtfleming/looplessFluxSampler ignore = dirty +[submodule "external/base/utilities/condalab"] + path = external/base/utilities/condalab + url = https://github.com/sg-s/condalab diff --git a/external/base/utilities/condalab b/external/base/utilities/condalab new file mode 160000 index 0000000000..95b33cedfd --- /dev/null +++ b/external/base/utilities/condalab @@ -0,0 +1 @@ +Subproject commit 95b33cedfd46ee4306ab380fa868cba189b9172c diff --git a/external/dataIntegration/mCADRE/pruningModel.m b/external/dataIntegration/mCADRE/pruningModel.m index 5c4b7d76ec..33ad4e53de 100644 --- a/external/dataIntegration/mCADRE/pruningModel.m +++ b/external/dataIntegration/mCADRE/pruningModel.m @@ -66,7 +66,17 @@ model_rem = removeRxns(tissueModel, r); end % Check for inactive reactions after removal of r - [fluxConsistentMetBool,fluxConsistentRxnBool] = findFluxConsistentSubset(model_rem,paramConsistency); + try + [fluxConsistentMetBool,fluxConsistentRxnBool] = findFluxConsistentSubset(model_rem,paramConsistency); + rStatus_and_not_error = true; + catch + rStatus_and_not_error = false; + end + else + rStatus_and_not_error = false; + end + + if rStatus_and_not_error inactive_G= [ r; model_rem.rxns(fluxConsistentRxnBool==0)]; inactiveCore = intersect(inactive_G, coreRxn); diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/analyzeMgPipeResults.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/analyzeMgPipeResults.m index 0eaa701a12..8def2a7e93 100644 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/analyzeMgPipeResults.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/analyzeMgPipeResults.m @@ -113,7 +113,7 @@ function analyzeMgPipeResults(infoFilePath,resPath,varargin) cd(violinPath) % create violin plots for net uptake and secretion files - if any(contains(fileList{i,1},{'net_uptake_fluxes.csv','net_secretion_fluxes.csv'})) + if any(strcmp(fileList{i,1},{'net_uptake_fluxes.csv','net_secretion_fluxes.csv'})) makeViolinPlots(sampleData, infoFile, 'stratification',sampleGroupHeaders{j}, 'plottedFeature', filename, 'unit', 'mmol/person/day') end cd(currentDir) diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/calculateReactionAbundance.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/calculateReactionAbundance.m old mode 100755 new mode 100644 index 177534c0ee..e4a885e71a --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/calculateReactionAbundance.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/calculateReactionAbundance.m @@ -1,438 +1,357 @@ -function [ReactionAbundance,TaxonomyInfo] = calculateReactionAbundance(abundancePath, modelPath, infoFilePath, rxnsList, numWorkers) -% Part of the Microbiome Modeling Toolbox. This function calculates and -% plots the total abundance of reactions of interest in a given microbiome -% sample based on the strain-level composition. -% Reaction presence or absence in each strain is derived from the reaction content -% of the respective AGORA model. Two results are given: the total abundance, -% and the abundance on different taxonomical levels. -% -% USAGE -% -% [ReactionAbundance,TaxonomyInfo] = calculateReactionAbundance(abundancePath, modelPath, infoFilePath, rxnsList, numWorkers) -% -% INPUTS: -% abundancePath: Path to the .csv file with the abundance data. -% Example: 'cobratoolbox/papers/018_microbiomeModelingToolbox/examples/normCoverage.csv' -% modelPath: Folder containing the strain-specific AGORA models -% OPTIONAL INPUTS: -% infoFilePath: Path to the spreadsheet with the taxonomy -% information on organisms (default: -% AGORA_infoFile.xlsx) -% rxnsList: List of reactions for which the abundance -% should be calculated (if left empty: all -% reactions in all models) -% numWorkers: Number of workers used for parallel pool. If -% left empty, the parallel pool will not be -% started. Parallellization is recommended if -% all reactions are computed. -% -% OUTPUT: -% ReactionAbundance Structure with abundance for each microbiome -% and reaction in total and on taxon levels -% TaxonomyInfo: Taxonomical information on each taxon level -% -% .. Author: - Almut Heinken, 03/2018 -% 10/2018: changed input to location of the csv file with the -% abundance data -% 01/2020: adapted to be suitable for pan-models - -% read the csv file with the abundance data -abundance = readtable(abundancePath, 'ReadVariableNames', false); -abundance = table2cell(abundance); -if isnumeric(abundance{2, 1}) - abundance(:, 1) = []; -end - -% - -% load the models -for i = 2:size(abundance, 1) - model = readCbModel([modelPath filesep abundance{i, 1} '.mat']); - modelsList{i, 1} = model; -end - -if ~exist('rxnsList', 'var') || isempty(rxnsList) % define reaction list if not entered - fprintf('No reaction list entered. Abundances will be calculated for all reactions in all models. \n') - % get model list from abundance input file - for i = 2:size(abundance, 1) - model = modelsList{i, 1}; - rxnsList = vertcat(model.rxns, rxnsList); - end - rxnsList = unique(rxnsList); -end - -% Get the taxonomy information -if exist('infoFilePath','var') - taxonomy = readtable(infoFilePath, 'ReadVariableNames', false); - taxonomy = table2cell(taxonomy); -else - taxonomy = readtable('AGORA_infoFile.xlsx', 'ReadVariableNames', false); - taxonomy = table2cell(taxonomy); -end - -% load the models found in the individuals and extract which reactions are -% in which model -for i = 2:size(abundance, 1) - model = modelsList{i, 1}; - ReactionPresence{i, 1} = abundance{i, 1}; - for j = 1:length(rxnsList) - ReactionPresence{1, j + 1} = rxnsList{j}; - if ~isempty(find(ismember(model.rxns, rxnsList{j}))) - ReactionPresence{i, j + 1} = 1; - else - ReactionPresence{i, j + 1} = 0; - end - end -end - -% put together a Matlab structure of the results -ReactionAbundance = struct; - -% prepare table for the total abundance -for j = 1:length(rxnsList) - ReactionAbundance.('Total'){1, j + 1} = rxnsList{j}; -end - -TaxonomyLevels = { - 'Phylum' - 'Class' - 'Order' - 'Family' - 'Genus' - 'Species' -}; -% extract the list of entries on each taxonomical level -for t = 1:size(TaxonomyLevels, 1) - % find the columns corresponding to each taxonomy level and the list of - % unique taxa - taxonCol = find(strcmp(taxonomy(1, :), TaxonomyLevels{t})); - % find and save all entries - taxa = unique(taxonomy(2:end, taxonCol)); - % exclude unclassified entries - taxa(strncmp('unclassified', taxa, taxonCol)) = []; - TaxonomyLevels{t, 2} = taxa; - % define the correct columns in taxonomy table - TaxonomyLevels{t, 3} = taxonCol; - % prepare table for the abundance on taxon levels - cnt = 2; - for j = 1:length(rxnsList) - for l = 1:length(TaxonomyLevels{t, 2}) - ReactionAbundance.(TaxonomyLevels{t, 1}){1, cnt} = strcat(TaxonomyLevels{t, 2}{l}, '_', rxnsList{j}); - cnt = cnt + 1; - end - end -end - -% Find the right column for the input data (strains, species,..) -taxa=taxonomy(2:end,1); -if length(intersect(abundance(2:end,1),taxa))==size(abundance,1)-1 - inputTaxa=taxa; - inputCol=1; -else - abundance(:,1)=regexprep(abundance(:,1),'pan','','once'); - inputTaxa={}; - for i=2:size(taxonomy,2) - taxa=strrep(taxonomy(:,i),' ','_'); - taxa=strrep(taxa,'.','_'); - taxa=strrep(taxa,'/','_'); - taxa=strrep(taxa,'-','_'); - taxa=strrep(taxa,'__','_'); - if length(intersect(abundance(2:end,1),taxa))==size(abundance,1)-1 - inputTaxa=taxa; - inputCol=i; - end - end -end -if isempty(inputTaxa) - error('Some taxa in the abundance file are not found in the taxonomy file!') -end - -for i = 2:size(abundance, 2) - %% calculate reaction abundance for the samples one by one - fprintf(['Calculating reaction abundance for sample ', num2str(i - 1), ' of ' num2str(size(abundance, 2) - 1) '.. \n']) - ReactionAbundance.('Total'){i, 1} = abundance{1, i}; - if ~isempty(taxonomy) - for t = 1:size(TaxonomyLevels, 1) - ReactionAbundance.(TaxonomyLevels{t, 1}){i, 1} = abundance{1, i}; - end - end - % use parallel pool if workers specified as input - if exist('numWorkers', 'var') && numWorkers > 0 - poolobj = gcp('nocreate'); - if isempty(poolobj) - parpool(numWorkers) - end - % create tables in which abundances for each individual for - % all reactions/taxa are stored - totalAbun = zeros(length(rxnsList), 1); - if ~isempty(taxonomy) - phylumAbun = zeros(length(rxnsList), length(TaxonomyLevels{1, 2})); - classAbun = zeros(length(rxnsList), length(TaxonomyLevels{2, 2})); - orderAbun = zeros(length(rxnsList), length(TaxonomyLevels{3, 2})); - familyAbun = zeros(length(rxnsList), length(TaxonomyLevels{4, 2})); - genusAbun = zeros(length(rxnsList), length(TaxonomyLevels{5, 2})); - speciesAbun = zeros(length(rxnsList), length(TaxonomyLevels{6, 2})); - end - parfor j = 1:length(rxnsList) - % store the abundance for each reaction and taxon separately in a - % temporary file to enable parallellization - if ~isempty(taxonomy) - tmpPhyl = zeros(length(rxnsList), length(TaxonomyLevels{1, 2})); - tmpClass = zeros(length(rxnsList), length(TaxonomyLevels{2, 2})); - tmpOrder = zeros(length(rxnsList), length(TaxonomyLevels{3, 2})); - tmpFamily = zeros(length(rxnsList), length(TaxonomyLevels{4, 2})); - tmpGenus = zeros(length(rxnsList), length(TaxonomyLevels{5, 2})); - tmpSpecies = zeros(length(rxnsList), length(TaxonomyLevels{6, 2})); - end - for k = 2:size(abundance, 1) - % check if the reaction is present in the strain - if ReactionPresence{k, j + 1} == 1 - % calculate total abundance - totalAbun(j) = totalAbun(j) + str2double(abundance{k, i}); - if ~isempty(taxonomy) - % calculate phylum abundance - t = 1; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - tmpPhyl(1, taxonCol) = tmpPhyl(1, taxonCol) + str2double(abundance{k, i}); - end - % calculate class abundance - t = 2; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - tmpClass(1, taxonCol) = tmpClass(1, taxonCol) + str2double(abundance{k, i}); - end - % calculate order abundance - t = 3; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - tmpOrder(1, taxonCol) = tmpOrder(1, taxonCol) + str2double(abundance{k, i}); - end - % calculate family abundance - t = 4; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - tmpFamily(1, taxonCol) = tmpFamily(1, taxonCol) + str2double(abundance{k, i}); - end - % calculate genus abundance - t = 5; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - tmpGenus(1, taxonCol) = tmpGenus(1, taxonCol) + str2double(abundance{k, i}); - end - % calculate species abundance - t = 6; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - tmpSpecies(1, taxonCol) = tmpSpecies(1, taxonCol) + str2double(abundance{k, i}); - end - end - end - end - if ~isempty(taxonomy) - phylumAbun(j, :) = tmpPhyl(1, :); - classAbun(j, :) = tmpClass(1, :); - orderAbun(j, :) = tmpOrder(1, :); - familyAbun(j, :) = tmpFamily(1, :); - genusAbun(j, :) = tmpGenus(1, :); - speciesAbun(j, :) = tmpSpecies(1, :); - end - end - else - % create tables in which abundances for each individual for - % all reactions/taxa are stored - % no parallellization-takes longer - totalAbun = zeros(length(rxnsList), 1); - if ~isempty(taxonomy) - phylumAbun = zeros(length(rxnsList), length(TaxonomyLevels{1, 2})); - classAbun = zeros(length(rxnsList), length(TaxonomyLevels{2, 2})); - orderAbun = zeros(length(rxnsList), length(TaxonomyLevels{3, 2})); - familyAbun = zeros(length(rxnsList), length(TaxonomyLevels{4, 2})); - genusAbun = zeros(length(rxnsList), length(TaxonomyLevels{5, 2})); - speciesAbun = zeros(length(rxnsList), length(TaxonomyLevels{6, 2})); - end - for j = 1:length(rxnsList) - for k = 2:size(abundance, 1) - % check if the reaction is present in the strain - if ReactionPresence{k, j + 1} == 1 - % calculate total abundance - totalAbun(j) = totalAbun(j) + str2double(abundance{k, i}); - if ~isempty(taxonomy) - % calculate phylum abundance - t = 1; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - phylumAbun(j, taxonCol) = phylumAbun(j, taxonCol) + str2double(abundance{k, i}); - end - % calculate class abundance - t = 2; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - classAbun(j, taxonCol) = classAbun(j, taxonCol) + str2double(abundance{k, i}); - end - % calculate order abundance - t = 3; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - orderAbun(j, taxonCol) = orderAbun(j, taxonCol) + str2double(abundance{k, i}); - end - % calculate family abundance - t = 4; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - familyAbun(j, taxonCol) = familyAbun(j, taxonCol) + str2double(abundance{k, i}); - end - % calculate genus abundance - t = 5; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - genusAbun(j, taxonCol) = genusAbun(j, taxonCol) + str2double(abundance{k, i}); - end - % calculate species abundance - t = 6; - findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); - if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) - taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); - speciesAbun(j, taxonCol) = speciesAbun(j, taxonCol) + str2double(abundance{k, i}); - end - end - end - end - end - end - %% store the abundances total and on taxonomic levels calculated for the individual in the output structure - for j = 1:length(rxnsList) - ReactionAbundance.('Total'){i, j + 1} = totalAbun(j); - % abundance on taxon levels - end - if ~isempty(taxonomy) - % phylum abundance - t = 1; - cnt = 2; - for j = 1:length(rxnsList) - for l = 1:length(TaxonomyLevels{t, 2}) - ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = phylumAbun(j, l); - cnt = cnt + 1; - end - end - % class abundance - t = 2; - cnt = 2; - for j = 1:length(rxnsList) - for l = 1:length(TaxonomyLevels{t, 2}) - ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = classAbun(j, l); - cnt = cnt + 1; - end - end - % order abundance - t = 3; - cnt = 2; - for j = 1:length(rxnsList) - for l = 1:length(TaxonomyLevels{t, 2}) - ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = orderAbun(j, l); - cnt = cnt + 1; - end - end - % family abundance - t = 4; - cnt = 2; - for j = 1:length(rxnsList) - for l = 1:length(TaxonomyLevels{t, 2}) - ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = familyAbun(j, l); - cnt = cnt + 1; - end - end - % genus abundance - t = 5; - cnt = 2; - for j = 1:length(rxnsList) - for l = 1:length(TaxonomyLevels{t, 2}) - ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = genusAbun(j, l); - cnt = cnt + 1; - end - end - % species abundance - t = 6; - cnt = 2; - for j = 1:length(rxnsList) - for l = 1:length(TaxonomyLevels{t, 2}) - ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = speciesAbun(j, l); - cnt = cnt + 1; - end - end - end -end - -% finally, delete empty columns to avoid unneccessarily big file sizes -fprintf('Finalizing the output file... \n') - -fNames = fieldnames(ReactionAbundance); -for i = 1:length(fNames) - cnt = 1; - delArray = []; - for j = 2:size(ReactionAbundance.(fNames{i}), 2) - cValues = string(ReactionAbundance.(fNames{i})(2:end, j)); - cTotal = sum(str2double(cValues)); - if cTotal < 0.000000001 - delArray(1, cnt) = j; - cnt = cnt + 1; - end - end - if ~isempty(delArray) - ReactionAbundance.(fNames{i})(:, delArray) = []; - end -end - -% export taxonomical information -taxonCol = 'Phylum'; -% remove unnecessary columns -taxonomy(:,taxonCol+1:end)=[]; - -for t = 2:size(TaxonomyLevels, 1) - taxa=ReactionAbundance.(TaxonomyLevels{t})(2:end,1); - TaxonomyReduced=taxonomy; - taxonCol = find(strcmp(taxonomy(1, :), TaxonomyLevels{t})); - TaxonomyReduced(:,1:taxonCol-1)=[]; - % remove duplicate entries - [C,IA] = unique(TaxonomyReduced(:,1),'stable'); - % remove unclassified taxa - findUncl=find(contains(C,'unclassified')); - IA(findUncl,:)=[]; - TaxonomyInfo.(TaxonomyLevels{t})=TaxonomyReduced(IA,:); -end - -% Plot the calculated reaction abundances. -for i = 1:length(fNames) - xlabels = ReactionAbundance.(fNames{i})(1, 2:end); - ylabels = ReactionAbundance.(fNames{i})(2:end, 1); - data = string(ReactionAbundance.(fNames{i})(2:end, 2:end)); - data = str2double(data); - figure; - imagesc(data) - colormap('hot') - colorbar - if length(xlabels) < 50 - set(gca, 'xtick', 1:length(xlabels)); - xticklabels(xlabels); - xtickangle(90) - end - if length(ylabels) < 50 - set(gca, 'ytick', 1:length(ylabels)); - yticklabels(ylabels); - end - set(gca, 'TickLabelInterpreter', 'none'); - title(fNames{i}) -end - -end +function [ReactionAbundance,TaxonomyInfo] = calculateReactionAbundance(abundancePath, modelPath, infoFilePath, rxnsList, numWorkers) +% Part of the Microbiome Modeling Toolbox. This function calculates and +% plots the total abundance of reactions of interest in a given microbiome +% sample based on the strain-level composition. +% Reaction presence or absence in each strain is derived from the reaction content +% of the respective AGORA model. Two results are given: the total abundance, +% and the abundance on different taxonomical levels. +% +% USAGE +% +% [ReactionAbundance,TaxonomyInfo] = calculateReactionAbundance(abundancePath, modelPath, infoFilePath, rxnsList, numWorkers) +% +% INPUTS: +% abundancePath: Path to the .csv file with the abundance data. +% Example: 'cobratoolbox/papers/018_microbiomeModelingToolbox/examples/normCoverage.csv' +% modelPath: Folder containing the strain-specific AGORA models +% OPTIONAL INPUTS: +% infoFilePath: Path to the spreadsheet with the taxonomy +% information on organisms (default: +% AGORA_infoFile.xlsx) +% rxnsList: List of reactions for which the abundance +% should be calculated (if left empty: all +% reactions in all models) +% numWorkers: Number of workers used for parallel pool. If +% left empty, the parallel pool will not be +% started. Parallellization is recommended if +% all reactions are computed. +% +% OUTPUT: +% ReactionAbundance Structure with abundance for each microbiome +% and reaction in total and on taxon levels +% TaxonomyInfo: Taxonomical information on each taxon level +% +% .. Author: - Almut Heinken, 03/2018 +% 10/2018: changed input to location of the csv file with the +% abundance data +% 01/2020: adapted to be suitable for pan-models + +% read the csv file with the abundance data +abundance = readtable(abundancePath, 'ReadVariableNames', false); +abundance = table2cell(abundance); +if isnumeric(abundance{2, 1}) + abundance(:, 1) = []; +end + +% + +% load the models +for i = 2:size(abundance, 1) + model = readCbModel([modelPath filesep abundance{i, 1} '.mat']); + modelsList{i, 1} = model; +end + +if ~exist('rxnsList', 'var') || isempty(rxnsList) % define reaction list if not entered + fprintf('No reaction list entered. Abundances will be calculated for all reactions in all models. \n') + % get model list from abundance input file + for i = 2:size(abundance, 1) + model = modelsList{i, 1}; + rxnsList = vertcat(model.rxns, rxnsList); + end + rxnsList = unique(rxnsList); +end + +% Get the taxonomy information +if exist('infoFilePath','var') && ~isempty(infoFilePath) + taxonomy = readtable(infoFilePath, 'ReadVariableNames', false); + taxonomy = table2cell(taxonomy); +else + taxonomy = readtable('AGORA_infoFile.xlsx', 'ReadVariableNames', false); + taxonomy = table2cell(taxonomy); +end + +% load the models found in the individuals and extract which reactions are +% in which model +for i = 2:size(abundance, 1) + model = modelsList{i, 1}; + ReactionPresence{i, 1} = abundance{i, 1}; + for j = 1:length(rxnsList) + ReactionPresence{1, j + 1} = rxnsList{j}; + if ~isempty(find(ismember(model.rxns, rxnsList{j}))) + ReactionPresence{i, j + 1} = 1; + else + ReactionPresence{i, j + 1} = 0; + end + end +end + +% put together a Matlab structure of the results +ReactionAbundance = struct; + +% prepare table for the total abundance +for j = 1:length(rxnsList) + ReactionAbundance.('Total'){1, j + 1} = rxnsList{j}; +end + +TaxonomyLevels = { + 'Phylum' + 'Class' + 'Order' + 'Family' + 'Genus' + 'Species' + }; +% extract the list of entries on each taxonomical level +for t = 1:size(TaxonomyLevels, 1) + % find the columns corresponding to each taxonomy level and the list of + % unique taxa + taxonCol = find(strcmp(taxonomy(1, :), TaxonomyLevels{t})); + % find and save all entries + taxa = unique(taxonomy(2:end, taxonCol)); + % exclude unclassified entries + taxa(strncmp('unclassified', taxa, taxonCol)) = []; + TaxonomyLevels{t, 2} = taxa; + % define the correct columns in taxonomy table + TaxonomyLevels{t, 3} = taxonCol; + % prepare table for the abundance on taxon levels + cnt = 2; + for j = 1:length(rxnsList) + for l = 1:length(TaxonomyLevels{t, 2}) + ReactionAbundance.(TaxonomyLevels{t, 1}){1, cnt} = strcat(TaxonomyLevels{t, 2}{l}, '_', rxnsList{j}); + cnt = cnt + 1; + end + end +end + +% Find the right column for the input data (strains, species,..) +taxa=taxonomy(2:end,1); +if length(intersect(abundance(2:end,1),taxa))==size(abundance,1)-1 + inputTaxa=taxa; + inputCol=1; +else + abundance(:,1)=regexprep(abundance(:,1),'pan','','once'); + inputTaxa={}; + for i=2:size(taxonomy,2) + taxa=strrep(taxonomy(:,i),' ','_'); + taxa=strrep(taxa,'.','_'); + taxa=strrep(taxa,'/','_'); + taxa=strrep(taxa,'-','_'); + taxa=strrep(taxa,'__','_'); + if length(intersect(abundance(2:end,1),taxa))==size(abundance,1)-1 + inputTaxa=taxa; + inputCol=i; + end + end +end +if isempty(inputTaxa) + error('Some taxa in the abundance file are not found in the taxonomy file!') +end + +for i = 2:size(abundance, 2) + %% calculate reaction abundance for the samples one by one + fprintf(['Calculating reaction abundance for sample ', num2str(i - 1), ' of ' num2str(size(abundance, 2) - 1) '.. \n']) + ReactionAbundance.('Total'){i, 1} = abundance{1, i}; + for t = 1:size(TaxonomyLevels, 1) + ReactionAbundance.(TaxonomyLevels{t, 1}){i, 1} = abundance{1, i}; + end + % use parallel pool if workers specified as input + if exist('numWorkers', 'var') && numWorkers > 0 + poolobj = gcp('nocreate'); + if isempty(poolobj) + parpool(numWorkers) + end + end + % create tables in which abundances for each individual for + % all reactions/taxa are stored + totalAbun = zeros(length(rxnsList), 1); + phylumAbun = zeros(length(rxnsList), length(TaxonomyLevels{1, 2})); + classAbun = zeros(length(rxnsList), length(TaxonomyLevels{2, 2})); + orderAbun = zeros(length(rxnsList), length(TaxonomyLevels{3, 2})); + familyAbun = zeros(length(rxnsList), length(TaxonomyLevels{4, 2})); + genusAbun = zeros(length(rxnsList), length(TaxonomyLevels{5, 2})); + speciesAbun = zeros(length(rxnsList), length(TaxonomyLevels{6, 2})); + + parfor j = 1:length(rxnsList) + + % store the abundance for each reaction and taxon separately in a + % temporary file to enable parallellization + tmpPhyl = zeros(length(rxnsList), length(TaxonomyLevels{1, 2})); + tmpClass = zeros(length(rxnsList), length(TaxonomyLevels{2, 2})); + tmpOrder = zeros(length(rxnsList), length(TaxonomyLevels{3, 2})); + tmpFamily = zeros(length(rxnsList), length(TaxonomyLevels{4, 2})); + tmpGenus = zeros(length(rxnsList), length(TaxonomyLevels{5, 2})); + tmpSpecies = zeros(length(rxnsList), length(TaxonomyLevels{6, 2})); + + for k = 2:size(abundance, 1) + % check if the reaction is present in the strain + if ReactionPresence{k, j + 1} == 1 + % calculate total abundance + totalAbun(j) = totalAbun(j) + str2double(abundance{k, i}); + % calculate phylum abundance + t = 1; + findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); + if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) + taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); + tmpPhyl(1, taxonCol) = tmpPhyl(1, taxonCol) + str2double(abundance{k, i}); + end + % calculate class abundance + t = 2; + findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); + if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) + taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); + tmpClass(1, taxonCol) = tmpClass(1, taxonCol) + str2double(abundance{k, i}); + end + % calculate order abundance + t = 3; + findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); + if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) + taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); + tmpOrder(1, taxonCol) = tmpOrder(1, taxonCol) + str2double(abundance{k, i}); + end + % calculate family abundance + t = 4; + findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); + if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) + taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); + tmpFamily(1, taxonCol) = tmpFamily(1, taxonCol) + str2double(abundance{k, i}); + end + % calculate genus abundance + t = 5; + findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); + if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) + taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); + tmpGenus(1, taxonCol) = tmpGenus(1, taxonCol) + str2double(abundance{k, i}); + end + % calculate species abundance + t = 6; + findTax = taxonomy(find(strcmp(abundance{k, 1}, inputTaxa)), TaxonomyLevels{t, 3}); + if any(strcmp(findTax{1}, TaxonomyLevels{t, 2})) + taxonCol = find(strcmp(findTax{1}, TaxonomyLevels{t, 2})); + tmpSpecies(1, taxonCol) = tmpSpecies(1, taxonCol) + str2double(abundance{k, i}); + end + end + end + phylumAbun(j, :) = tmpPhyl(1, :); + classAbun(j, :) = tmpClass(1, :); + orderAbun(j, :) = tmpOrder(1, :); + familyAbun(j, :) = tmpFamily(1, :); + genusAbun(j, :) = tmpGenus(1, :); + speciesAbun(j, :) = tmpSpecies(1, :); + end + %% store the abundances total and on taxonomic levels calculated for the individual in the output structure + for j = 1:length(rxnsList) + ReactionAbundance.('Total'){i, j + 1} = totalAbun(j); + % abundance on taxon levels + end + % phylum abundance + t = 1; + cnt = 2; + for j = 1:length(rxnsList) + for l = 1:length(TaxonomyLevels{t, 2}) + ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = phylumAbun(j, l); + cnt = cnt + 1; + end + end + % class abundance + t = 2; + cnt = 2; + for j = 1:length(rxnsList) + for l = 1:length(TaxonomyLevels{t, 2}) + ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = classAbun(j, l); + cnt = cnt + 1; + end + end + % order abundance + t = 3; + cnt = 2; + for j = 1:length(rxnsList) + for l = 1:length(TaxonomyLevels{t, 2}) + ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = orderAbun(j, l); + cnt = cnt + 1; + end + end + % family abundance + t = 4; + cnt = 2; + for j = 1:length(rxnsList) + for l = 1:length(TaxonomyLevels{t, 2}) + ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = familyAbun(j, l); + cnt = cnt + 1; + end + end + % genus abundance + t = 5; + cnt = 2; + for j = 1:length(rxnsList) + for l = 1:length(TaxonomyLevels{t, 2}) + ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = genusAbun(j, l); + cnt = cnt + 1; + end + end + % species abundance + t = 6; + cnt = 2; + for j = 1:length(rxnsList) + for l = 1:length(TaxonomyLevels{t, 2}) + ReactionAbundance.(TaxonomyLevels{t}){i, cnt} = speciesAbun(j, l); + cnt = cnt + 1; + end + end +end + +% finally, delete empty columns to avoid unneccessarily big file sizes +fprintf('Finalizing the output file... \n') + +fNames = fieldnames(ReactionAbundance); +for i = 1:length(fNames) + cValues = string(ReactionAbundance.(fNames{i})(2:end, 2:end)); + rownames=ReactionAbundance.(fNames{i})(:,1); + ReactionAbundance.(fNames{i})(:,1)=[]; + cTotal = sum(str2double(cValues),1); + ReactionAbundance.(fNames{i})(:,find(cTotal<0.000000001))=[]; + ReactionAbundance.(fNames{i})=[rownames,ReactionAbundance.(fNames{i})]; + ReactionAbundance.(fNames{i}){1,1}='Samples'; +end + +% export taxonomical information +taxonCol = 'Phylum'; +% remove unnecessary columns +taxonomy(:,taxonCol+1:end)=[]; + +for t = 2:size(TaxonomyLevels, 1) + taxa=ReactionAbundance.(TaxonomyLevels{t})(2:end,1); + TaxonomyReduced=taxonomy; + taxonCol = find(strcmp(taxonomy(1, :), TaxonomyLevels{t})); + TaxonomyReduced(:,1:taxonCol-1)=[]; + % remove duplicate entries + [C,IA] = unique(TaxonomyReduced(:,1),'stable'); + % remove unclassified taxa + findUncl=find(contains(C,'unclassified')); + IA(findUncl,:)=[]; + TaxonomyInfo.(TaxonomyLevels{t})=TaxonomyReduced(IA,:); +end + +% Plot the calculated reaction abundances. +for i = 1:length(fNames) + xlabels = ReactionAbundance.(fNames{i})(2:end,1); + ylabels = ReactionAbundance.(fNames{i})(1,2:end); + data = string(ReactionAbundance.(fNames{i})(2:end, 2:end)); + data = str2double(data); + figure; + imagesc(data') + colormap('hot') + colorbar + if length(xlabels) < 50 + set(gca, 'xtick', 1:length(xlabels)); + xticklabels(xlabels); + xtickangle(90) + end + if length(ylabels) < 50 + set(gca, 'ytick', 1:length(ylabels)); + yticklabels(ylabels); + end + set(gca, 'TickLabelInterpreter', 'none'); + title(fNames{i}) +end + +end \ No newline at end of file diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/calculateSubsystemAbundance.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/calculateSubsystemAbundance.m index ae3a5b1083..090b5bd7f1 100644 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/calculateSubsystemAbundance.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/calculateSubsystemAbundance.m @@ -17,7 +17,7 @@ % AUTHOR % - Almut Heinken, 08/2020 -reactionDatabase = readtable('reactionDatabase.txt', 'Delimiter', 'tab','TreatAsEmpty',['UND. -60001','UND. -2011','UND. -62011'], 'ReadVariableNames', false); +reactionDatabase = readtable('ReactionDatabase.txt', 'Delimiter', 'tab','TreatAsEmpty',['UND. -60001','UND. -2011','UND. -62011'], 'ReadVariableNames', false); reactionDatabase=table2cell(reactionDatabase); reactionAbundance = readtable(reactionAbundancePath, 'ReadVariableNames', false); @@ -54,6 +54,4 @@ end end -writetable(cell2table(subsystemAbundance),'SubsystemAbundance.txt','FileType','text','WriteVariableNames',false,'Delimiter','\t'); - end \ No newline at end of file diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/fastCalculateReactionAbundance.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/fastCalculateReactionAbundance.m new file mode 100644 index 0000000000..48e4acdcc6 --- /dev/null +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/additionalAnalysis/fastCalculateReactionAbundance.m @@ -0,0 +1,119 @@ +function ReactionAbundance = fastCalculateReactionAbundance(abundancePath, modelPath, rxnsList, numWorkers) +% Part of the Microbiome Modeling Toolbox. This function calculates and +% plots the total abundance of reactions of interest in a given microbiome +% sample based on the strain-level composition. +% Reaction presence or absence in each strain is derived from the reaction content +% of the respective AGORA model. +% +% USAGE +% +% ReactionAbundance = fastCalculateReactionAbundance(abundancePath, modelPath, rxnsList, numWorkers) +% +% INPUTS: +% abundancePath: Path to the .csv file with the abundance data. +% Example: 'cobratoolbox/papers/018_microbiomeModelingToolbox/examples/normCoverage.csv' +% modelPath: Folder containing the strain-specific AGORA models +% OPTIONAL INPUTS: +% rxnsList: List of reactions for which the abundance +% should be calculated (if left empty: all +% reactions in all models) +% numWorkers: Number of workers used for parallel pool. If +% left empty, the parallel pool will not be +% started. Parallellization is recommended if +% all reactions are computed. +% +% OUTPUT: +% ReactionAbundance Table with total abundance for each microbiome +% and reaction +% +% .. Author: - Almut Heinken, 04/2021 + +% read the csv file with the abundance data +abundance = readtable(abundancePath, 'ReadVariableNames', false); +abundance = table2cell(abundance); +if isnumeric(abundance{2, 1}) + abundance(:, 1) = []; +end + +% load the models +for i = 2:size(abundance, 1) + model = readCbModel([modelPath filesep abundance{i, 1} '.mat']); + modelsList{i, 1} = model; +end + +if ~exist('rxnsList', 'var') || isempty(rxnsList) % define reaction list if not entered + fprintf('No reaction list entered. Abundances will be calculated for all reactions in all models. \n') + % get model list from abundance input file + for i = 2:size(abundance, 1) + model = modelsList{i, 1}; + rxnsList = vertcat(model.rxns, rxnsList); + end + rxnsList = unique(rxnsList); +end + +% load the models found in the individuals and extract which reactions are +% in which model +for i = 2:size(abundance, 1) + model = modelsList{i, 1}; + ReactionPresence{i, 1} = abundance{i, 1}; + for j = 1:length(rxnsList) + ReactionPresence{1, j + 1} = rxnsList{j}; + if ~isempty(find(ismember(model.rxns, rxnsList{j}))) + ReactionPresence{i, j + 1} = '1'; + else + ReactionPresence{i, j + 1} = '0'; + end + end +end +ReactionPresence{1,1}='Strains'; + + +% prepare table for the total abundance +ReactionAbundance = {}; +for i = 1:length(rxnsList) + ReactionAbundance{1, i + 1} = rxnsList{i}; +end +for i = 2:size(abundance, 2) + ReactionAbundance{i, 1} = abundance{1, i}; +end + +% use parallel pool if workers specified as input +if exist('numWorkers', 'var') && numWorkers > 0 + poolobj = gcp('nocreate'); + if isempty(poolobj) + parpool(numWorkers) + end +end + +clear abundance + +totalAbun={}; +parfor i = 2:size(ReactionAbundance, 1) + i + % reload the file to avoid running out of memory + abundance = readtable(abundancePath, 'ReadVariableNames', false); + abundance = table2cell(abundance); + if isnumeric(abundance{2, 1}) + abundance(:, 1) = []; + end + + % temporarily store reaction abundances + totalAbun{i} = zeros(length(rxnsList), 1); + + for j = 2:size(abundance, 1) + % find all reactions present in the strain + presentRxns = find(strcmp(ReactionPresence(j,2:end),'1')); + + for k = 1:length(presentRxns) + % summarize total abundance + totalAbun{i}(presentRxns(k),1) = totalAbun{i}(presentRxns(k),1) + str2double(abundance{j,i}); + end + end +end + +% collect the temporarily stored abundances to put together the table +for i = 2:size(ReactionAbundance, 1) + ReactionAbundance(i,2:end) = num2cell(totalAbun{i}); +end + +end \ No newline at end of file diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/adaptVMHDietToAGORA.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/adaptVMHDietToAGORA.m index cd991c1355..a8bcf706da 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/adaptVMHDietToAGORA.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/adaptVMHDietToAGORA.m @@ -51,7 +51,7 @@ % Define the list of metabolites required by at least one AGORA model for % growth -essentialMetabolites = {'EX_12dgr180(e)'; 'EX_26dap_M(e)'; 'EX_2dmmq8(e)'; 'EX_2obut(e)'; 'EX_3mop(e)'; 'EX_4abz(e)'; 'EX_4hbz(e)'; 'EX_ac(e)'; 'EX_acgam(e)'; 'EX_acmana(e)'; 'EX_acnam(e)'; 'EX_ade(e)'; 'EX_adn(e)'; 'EX_adocbl(e)'; 'EX_adpcbl(e)'; 'EX_ala_D(e)'; 'EX_ala_L(e)'; 'EX_amet(e)'; 'EX_amp(e)'; 'EX_arab_D(e)'; 'EX_arab_L(e)'; 'EX_arg_L(e)'; 'EX_asn_L(e)'; 'EX_btn(e)'; 'EX_ca2(e)'; 'EX_cbl1(e)'; 'EX_cgly(e)'; 'EX_chor(e)'; 'EX_chsterol(e)'; 'EX_cit(e)'; 'EX_cl(e)'; 'EX_cobalt2(e)'; 'EX_csn(e)'; 'EX_cu2(e)'; 'EX_cys_L(e)'; 'EX_cytd(e)'; 'EX_dad_2(e)'; 'EX_dcyt(e)'; 'EX_ddca(e)'; 'EX_dgsn(e)'; 'EX_fald(e)'; 'EX_fe2(e)'; 'EX_fe3(e)'; 'EX_fol(e)'; 'EX_for(e)'; 'EX_gal(e)'; 'EX_glc_D(e)'; 'EX_gln_L(e)'; 'EX_glu_L(e)'; 'EX_gly(e)'; 'EX_glyc(e)'; 'EX_glyc3p(e)'; 'EX_gsn(e)'; 'EX_gthox(e)'; 'EX_gthrd(e)'; 'EX_gua(e)'; 'EX_h(e)'; 'EX_h2o(e)'; 'EX_h2s(e)'; 'EX_his_L(e)'; 'EX_hxan(e)'; 'EX_ile_L(e)'; 'EX_k(e)'; 'EX_lanost(e)'; 'EX_leu_L(e)'; 'EX_lys_L(e)'; 'EX_malt(e)'; 'EX_met_L(e)'; 'EX_mg2(e)'; 'EX_mn2(e)'; 'EX_mqn7(e)'; 'EX_mqn8(e)'; 'EX_nac(e)'; 'EX_ncam(e)'; 'EX_nmn(e)'; 'EX_no2(e)'; 'EX_ocdca(e)'; 'EX_ocdcea(e)'; 'EX_orn(e)'; 'EX_phe_L(e)'; 'EX_pheme(e)'; 'EX_pi(e)'; 'EX_pnto_R(e)'; 'EX_pro_L(e)'; 'EX_ptrc(e)'; 'EX_pydx(e)'; 'EX_pydxn(e)'; 'EX_q8(e)'; 'EX_rib_D(e)'; 'EX_ribflv(e)'; 'EX_ser_L(e)'; 'EX_sheme(e)'; 'EX_so4(e)'; 'EX_spmd(e)'; 'EX_thm(e)'; 'EX_thr_L(e)'; 'EX_thymd(e)'; 'EX_trp_L(e)'; 'EX_ttdca(e)'; 'EX_tyr_L(e)'; 'EX_ura(e)'; 'EX_val_L(e)'; 'EX_xan(e)'; 'EX_xyl_D(e)'; 'EX_zn2(e)'; 'EX_glu_D(e)'; 'EX_melib(e)'; 'EX_chtbs(e)'; 'EX_metsox_S_L(e)'; 'EX_hdca(e)'; 'EX_gam(e)'; 'EX_indole(e)'; 'EX_glcn(e)'; 'EX_coa(e)'}; +essentialMetabolites = {'EX_12dgr180(e)'; 'EX_26dap_M(e)'; 'EX_2dmmq8(e)'; 'EX_2obut(e)'; 'EX_3mop(e)'; 'EX_4abz(e)'; 'EX_4hbz(e)'; 'EX_ac(e)'; 'EX_acgam(e)'; 'EX_acmana(e)'; 'EX_acnam(e)'; 'EX_ade(e)'; 'EX_adn(e)'; 'EX_adocbl(e)'; 'EX_ala_D(e)'; 'EX_ala_L(e)'; 'EX_amet(e)'; 'EX_amp(e)'; 'EX_arab_D(e)'; 'EX_arab_L(e)'; 'EX_arg_L(e)'; 'EX_asn_L(e)'; 'EX_btn(e)'; 'EX_ca2(e)'; 'EX_cbl1(e)'; 'EX_cgly(e)'; 'EX_chor(e)'; 'EX_chsterol(e)'; 'EX_cit(e)'; 'EX_cl(e)'; 'EX_cobalt2(e)'; 'EX_csn(e)'; 'EX_cu2(e)'; 'EX_cys_L(e)'; 'EX_cytd(e)'; 'EX_dad_2(e)'; 'EX_dcyt(e)'; 'EX_ddca(e)'; 'EX_dgsn(e)'; 'EX_fald(e)'; 'EX_fe2(e)'; 'EX_fe3(e)'; 'EX_fol(e)'; 'EX_for(e)'; 'EX_gal(e)'; 'EX_glc_D(e)'; 'EX_gln_L(e)'; 'EX_glu_L(e)'; 'EX_gly(e)'; 'EX_glyc(e)'; 'EX_glyc3p(e)'; 'EX_gsn(e)'; 'EX_gthox(e)'; 'EX_gthrd(e)'; 'EX_gua(e)'; 'EX_h(e)'; 'EX_h2o(e)'; 'EX_h2s(e)'; 'EX_his_L(e)'; 'EX_hxan(e)'; 'EX_ile_L(e)'; 'EX_k(e)'; 'EX_lanost(e)'; 'EX_leu_L(e)'; 'EX_lys_L(e)'; 'EX_malt(e)'; 'EX_met_L(e)'; 'EX_mg2(e)'; 'EX_mn2(e)'; 'EX_mqn7(e)'; 'EX_mqn8(e)'; 'EX_nac(e)'; 'EX_ncam(e)'; 'EX_nmn(e)'; 'EX_no2(e)'; 'EX_ocdca(e)'; 'EX_ocdcea(e)'; 'EX_orn(e)'; 'EX_phe_L(e)'; 'EX_pheme(e)'; 'EX_pi(e)'; 'EX_pnto_R(e)'; 'EX_pro_L(e)'; 'EX_ptrc(e)'; 'EX_pydx(e)'; 'EX_pydxn(e)'; 'EX_q8(e)'; 'EX_rib_D(e)'; 'EX_ribflv(e)'; 'EX_ser_L(e)'; 'EX_sheme(e)'; 'EX_so4(e)'; 'EX_spmd(e)'; 'EX_thm(e)'; 'EX_thr_L(e)'; 'EX_thymd(e)'; 'EX_trp_L(e)'; 'EX_ttdca(e)'; 'EX_tyr_L(e)'; 'EX_ura(e)'; 'EX_val_L(e)'; 'EX_xan(e)'; 'EX_xyl_D(e)'; 'EX_zn2(e)'; 'EX_glu_D(e)'; 'EX_melib(e)'; 'EX_chtbs(e)'; 'EX_metsox_S_L(e)'; 'EX_hdca(e)'; 'EX_gam(e)'; 'EX_indole(e)'; 'EX_glcn(e)'; 'EX_coa(e)'; 'EX_man(e)'; 'EX_fum(e)'; 'EX_succ(e)'; 'EX_no3(e)'; 'EX_ins(e)'; 'EX_uri(e)'; 'EX_drib(e)'; 'EX_pime(e)'; 'EX_lac_L(e)'; 'EX_glypro(e)'; 'EX_urea(e)'; 'EX_duri(e)'; 'EX_h2(e)'; 'EX_mal_L(e)'; 'EX_tre(e)'; 'EX_orot(e)'}; % fix any exchange nomenclature issues adaptedDietConstraints(:, 1) = strrep(adaptedDietConstraints(:, 1), '[e]', '(e)'); diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/buildModelStorage.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/buildModelStorage.m new file mode 100644 index 0000000000..5ae37cfa92 --- /dev/null +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/buildModelStorage.m @@ -0,0 +1,78 @@ +function [exch,modelStoragePath] = buildModelStorage(microbeNames,modPath) + +currentDir=pwd; +mkdir('modelStorage') +cd('modelStorage') +modelStoragePath = pwd; + +exch = {}; +for j = 1:size(microbeNames, 1) + model = readCbModel([modPath filesep microbeNames{j,1} '.mat']); + %exch = union(exch, model.mets(find(sum(model.S(:, strncmp('EX_', model.rxns, 3)), 2) ~= 0))); + exStruct = findSExRxnInd(model); + new_exch = findMetsFromRxns(model,model.rxns(exStruct.ExchRxnBool & ~exStruct.biomassBool)); + exch = union(exch,new_exch); +end + +% get already built reconstructions +dInfo = dir(modelStoragePath); +modelList={dInfo.name}; +modelList=modelList'; +modelList=strrep(modelList,'.mat',''); +microbesNames=setdiff(microbeNames,modelList); + + +if length(microbesNames)>0 + %% create a new extracellular space [u] for microbes + for j = 1:size(microbeNames, 1) + model = readCbModel([modPath filesep microbeNames{j,1} '.mat']); + % temp fix + if isfield(model,'C') + model=rmfield(model,'C'); + model=rmfield(model,'d'); + end + % + + % removing possible constraints of the bacs + selExc = findExcRxns(model); + Reactions2 = model.rxns(find(selExc)); + allex = Reactions2(strmatch('EX', Reactions2)); + biomass = allex(find(strncmp(allex,'bio',3))); + finrex = setdiff(allex, biomass); + model = changeRxnBounds(model, finrex, -1000, 'l'); + model = changeRxnBounds(model, finrex, 1000, 'u'); + + % removing blocked reactions from the bacs + %BlockedRxns = identifyFastBlockedRxns(model,model.rxns, printLevel); + %model= removeRxns(model, BlockedRxns); + %BlockedReaction = findBlockedReaction(model,'L2') + + model = convertOldStyleModel(model); + exmod = model.rxns(strncmp('EX_', model.rxns, 3)); % find exchange reactions + eMets = model.mets(~cellfun(@isempty, strfind(model.mets, '[e]'))); % exchanged metabolites + dummyMicEU = createModel(); + %dummyMicEU = makeDummyModel(2 * size(eMets, 1), size(eMets, 1)); + dummyMicEUmets = [strcat(strcat(microbeNames{j, 1}, '_'), regexprep(eMets, '\[e\]', '\[u\]')); regexprep(eMets, '\[e\]', '\[u\]')]; + dummyMicEU = addMultipleMetabolites(dummyMicEU,dummyMicEUmets); + nMets = numel(eMets); + S = [speye(nMets);-speye(nMets)]; + lbs = repmat(-1000,nMets,1); + ubs = repmat(1000,nMets,1); + names = strcat(strcat(microbeNames{j, 1}, '_'), 'IEX_', regexprep(eMets, '\[e\]', '\[u\]'), 'tr'); + dummyMicEU = addMultipleReactions(dummyMicEU,names,dummyMicEUmets,S,'lb',lbs,'ub',ubs); + model = removeRxns(model, exmod); + model.rxns = strcat(strcat(microbeNames{j, 1}, '_'), model.rxns); + model.mets = strcat(strcat(microbeNames{j, 1}, '_'), regexprep(model.mets, '\[e\]', '\[u\]')); % replace [e] with [u] + [model] = mergeTwoModels(dummyMicEU, model, 2, false, false); + + %finish up by A: removing duplicate reactions + %We will lose information here, but we will just remove the duplicates. + [model,rxnToRemove,rxnToKeep]= checkDuplicateRxn(model,'S',1,0,1); + + writeCbModel(model,'format','mat','fileName',[microbeNames{j,1} '.mat']); % store model + end +end + +cd(currentDir) + +end \ No newline at end of file diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/createPersonalizedModel.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/createPersonalizedModel.m index 27cddfe691..b3db602737 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/createPersonalizedModel.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/createPersonalizedModel.m @@ -28,7 +28,7 @@ createdModels = {}; % use the setup model containing every strain in every sample -parfor k = 1:length(sampNames) +for k = 1:length(sampNames) mgmodel = model; abunRed = abundance(:,k+1); @@ -64,7 +64,7 @@ % Coupling constraints for bacteria for i = 1:length(presBac) IndRxns=find(strncmp(mgmodel.rxns,[presBac{i,1} '_'],length(presBac{i,1})+1));%finding indixes of specific reactions - % find the name of biomass reacion in the microbe model + % find the name of biomass reaction in the microbe model bioRxn=mgmodel.rxns{find(strncmp(mgmodel.rxns,strcat(presBac{i,1},'_bio'),length(char(strcat(presBac{i,1},'_bio')))))}; mgmodel=coupleRxnList2Rxn(mgmodel,mgmodel.rxns(IndRxns(1:length(mgmodel.rxns(IndRxns(:,1)))-1,1)),bioRxn,400,0); %couple the specific reactions end diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/fastSetupCreator.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/fastSetupCreator.m index a25377e0e6..750de3eb47 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/fastSetupCreator.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/fastSetupCreator.m @@ -1,4 +1,4 @@ -function model = fastSetupCreator(modPath, microbeNames, host, objre, numWorkers) +function model = fastSetupCreator(exch, modelStoragePath, microbeNames, host, objre, buildSetupAll) % creates a microbiota model (min 1 microbe) that can be coupled with a host % model. Microbes and host are connected with a lumen compartment [u], host % can secrete metabolites into body fluids [b]. Diet is simulated as uptake @@ -25,35 +25,22 @@ % host: Host COBRA model structure, can be left empty if % there is no host model % objre: char with reaction name of objective function of microbeNames -% numWorkers: integer indicating the number of cores to use for parallelization +% buildSetupAll: boolean indicating the strategy that should be used to +% build personalized models: if true, build a global setup model +% containing all organisms in at least model (default), false: create +% models one by one (recommended for more than ~500 organisms total) % % OUTPUT: % model: COBRA model structure with all models combined % % .. Author: Stefania Magnusdottir and Federico Baldini 2016-2018 - -% set parallel pool -if numWorkers > 1 - poolobj = gcp('nocreate'); - if isempty(poolobj) - parpool(numWorkers) - end -end +% - Almut Heinken, 04/2021: adapted strategy for improved speed. if ~isempty(host) % Get list of all exchanged metabolites %exch = host.mets(find(sum(host.S(:, strncmp('EX_', host.rxns, 3)), 2) ~= 0)); exStruct = findSExRxnInd(host); - exch = findMetsFromRxns(host,host.rxns(exStruct.ExchRxnBool & ~exStruct.biomassBool)); -else - exch = {}; + exch = union(exch,findMetsFromRxns(host,host.rxns(exStruct.ExchRxnBool & ~exStruct.biomassBool))); end - for j = 1:size(microbeNames, 1) - model = readCbModel([modPath filesep microbeNames{j,1} '.mat']); - %exch = union(exch, model.mets(find(sum(model.S(:, strncmp('EX_', model.rxns, 3)), 2) ~= 0))); - exStruct = findSExRxnInd(model); - new_exch = findMetsFromRxns(model,model.rxns(exStruct.ExchRxnBool & ~exStruct.biomassBool)); - exch = union(exch,new_exch); - end % The biomass 'biomass[c]' should not be inserted in the list of exchanges. % Hence it will be removed. @@ -71,20 +58,20 @@ nMets = numel(umets); stoich = [-speye(nMets),-speye(nMets),sparse(nMets,nMets),sparse(nMets,nMets);... - sparse(nMets,nMets),speye(nMets),-speye(nMets),sparse(nMets,nMets);... - sparse(nMets,nMets),sparse(nMets,nMets),speye(nMets),-speye(nMets)]; + sparse(nMets,nMets),speye(nMets),-speye(nMets),sparse(nMets,nMets);... + sparse(nMets,nMets),sparse(nMets,nMets),speye(nMets),-speye(nMets)]; lbs = [repmat(-1000,nMets,1);zeros(nMets,1);zeros(nMets,1);repmat(-1000,nMets,1)]; ubs = repmat(1000,4*nMets,1); rxnNames = [strcat('EX_',mets(1:nMets));... - strcat('DUt_',strrep(umets,'[e]',''));... - strcat('UFEt_',strrep(umets,'[e]',''));... - strcat('EX_',strrep(umets, '[e]', '[fe]'))]; + strcat('DUt_',strrep(umets,'[e]',''));... + strcat('UFEt_',strrep(umets,'[e]',''));... + strcat('EX_',strrep(umets, '[e]', '[fe]'))]; dummy = addMultipleReactions(dummy,rxnNames,mets,stoich,'lb',lbs,'ub',ubs'); order = [1:nMets;nMets+1:2*nMets;2*nMets+1:3*nMets;3*nMets+1:4*nMets]; order = order(:); dummy = updateFieldOrderForType(dummy,'rxns',order); %Now, we could 'reorder' this reaction list but I'm not sure its necessary. -% +% % cnt = 0; % for j = 1:size(exch, 1) % mdInd = find(ismember(dummy.mets, strrep(exch{j, 1}, '[e]', '[d]'))); @@ -119,175 +106,155 @@ %% create a new extracellular space [b] for host if ~isempty(host) -exMets = find(~cellfun(@isempty, strfind(host.mets, '[e]'))); % find all mets that appear in [e] -exRxns = host.rxns(strncmp('EX_', host.rxns, 3)); % find exchanges in host -exMetRxns = find(sum(abs(host.S(exMets, :)), 1) ~= 0); % find reactions that contain mets from [e] -exMetRxns = exMetRxns'; -exMetRxnsMets = find(sum(abs(host.S(:, exMetRxns)), 2) ~= 0); % get all metabolites of [e] containing rxns -dummyHostB = createModel(); %makeDummyModel(size(exMetRxnsMets, 1), size(exMetRxns, 1)); -dummyHostB = addMultipleMetabolites(dummyHostB,strcat({'Host_'}, regexprep(host.mets(exMetRxnsMets), '\[e\]', '\[b\]'))); -dummyHostB = addMultipleReactions(dummyHostB,strcat({'Host_'}, host.rxns(exMetRxns), {'b'}),dummyHostB.mets,host.S(exMetRxnsMets, exMetRxns),'c',host.c(exMetRxns),'lb',host.lb(exMetRxns),'ub',host.ub(exMetRxns)); -%dummyHostB.rxns = ; -%dummyHostB.mets = strcat({'Host_'}, regexprep(host.mets(exMetRxnsMets), '\[e\]', '\[b\]')); % replace [e] with [b] -%dummyHostB.S = host.S(exMetRxnsMets, exMetRxns); -%dummyHostB.c = host.c(exMetRxns); -%dummyHostB.lb = host.lb(exMetRxns); -%dummyHostB.ub = host.ub(exMetRxns); - - -% remove exchange reactions from host while leaving demand and sink -% reactions -host = removeRxns(host, exRxns); -host.mets = strcat({'Host_'}, host.mets); -host.rxns = strcat({'Host_'}, host.rxns); - -% use mergeToModels without combining genes -[host] = mergeTwoModels(dummyHostB, host, 2, false, false); - -% Change remaining [e] (transporters) to [u] to transport diet metabolites -exMets2 = ~cellfun(@isempty, strfind(host.mets, '[e]')); % again, find all mets that appear in [e] -% exMetRxns2=find(sum(host.S(exMets2,:),1)~=0);%find reactions that contain mets from [e] -% exMetRxns2=exMetRxns2'; -% exMetRxnsMets2=find(sum(host.S(:,exMetRxns2),2)~=0);%get all metabolites of [e] containing rxns -% host.mets=regexprep(host.mets,'\[e\]','\[u\]');%replace [e] with [u] -dummyHostEU = createModel(); -%makeDummyModel(2 * size(exMets2, 1), size(exMets2, 1)); -hostmets = host.mets(exMets2); -dummyHostEUmets = [strrep(strrep(hostmets, 'Host_', ''), '[e]', '[u]'); hostmets]; -dummyHostEU = addMultipleMetabolites(dummyHostEU,dummyHostEUmets); -nMets = numel(hostmets); -S = [-speye(nMets),speye(nMets)]; -lbs = repmat(-1000,nMets,1); -ubs = repmat(1000,nMets,1); -names = strrep(strcat('Host_IEX_', strrep(hostmets, 'Host_', ''), 'tr'), '[e]', '[u]'); -dummyHostEU = addMultipleReactions(dummyHostEU,names,dummyHostEUmets,S','lb',lbs,'ub',ubs); -% for j = 1:size(exMets2, 1) -% dummyHostEU.rxns{j, 1} = strrep(strcat('Host_IEX_', strrep(host.mets{exMets2(j), 1}, 'Host_', ''), 'tr'), '[e]', '[u]'); -% metU = find(ismember(dummyHostEU.mets, strrep(strrep(host.mets{exMets2(j)}, 'Host_', ''), '[e]', '[u]'))); -% metE = find(ismember(dummyHostEU.mets, host.mets{exMets2(j)})); -% dummyHostEU.S(metU, j) = 1; -% dummyHostEU.S(metE, j) = -1; -% dummyHostEU.lb(j) = -1000; -% dummyHostEU.ub(j) = 1000; -% end -[host] = mergeTwoModels(dummyHostEU, host, 2, false, false); -end - - -%% create a new extracellular space [u] for microbes, code runs in parallel -modelStorage = cell(size(microbeNames)); -% MexGJoined=MexGHost; -parfor j = 1:size(microbeNames, 1) - model = readCbModel([modPath filesep microbeNames{j,1} '.mat']); + exMets = find(~cellfun(@isempty, strfind(host.mets, '[e]'))); % find all mets that appear in [e] + exRxns = host.rxns(strncmp('EX_', host.rxns, 3)); % find exchanges in host + exMetRxns = find(sum(abs(host.S(exMets, :)), 1) ~= 0); % find reactions that contain mets from [e] + exMetRxns = exMetRxns'; + exMetRxnsMets = find(sum(abs(host.S(:, exMetRxns)), 2) ~= 0); % get all metabolites of [e] containing rxns + dummyHostB = createModel(); %makeDummyModel(size(exMetRxnsMets, 1), size(exMetRxns, 1)); + dummyHostB = addMultipleMetabolites(dummyHostB,strcat({'Host_'}, regexprep(host.mets(exMetRxnsMets), '\[e\]', '\[b\]'))); + dummyHostB = addMultipleReactions(dummyHostB,strcat({'Host_'}, host.rxns(exMetRxns), {'b'}),dummyHostB.mets,host.S(exMetRxnsMets, exMetRxns),'c',host.c(exMetRxns),'lb',host.lb(exMetRxns),'ub',host.ub(exMetRxns)); + %dummyHostB.rxns = ; + %dummyHostB.mets = strcat({'Host_'}, regexprep(host.mets(exMetRxnsMets), '\[e\]', '\[b\]')); % replace [e] with [b] + %dummyHostB.S = host.S(exMetRxnsMets, exMetRxns); + %dummyHostB.c = host.c(exMetRxns); + %dummyHostB.lb = host.lb(exMetRxns); + %dummyHostB.ub = host.ub(exMetRxns); - % removing possible constraints of the bacs - selExc = findExcRxns(model); - Reactions2 = model.rxns(find(selExc)); - allex = Reactions2(strmatch('EX', Reactions2)); - biomass = allex(strmatch(objre, allex)); - finrex = setdiff(allex, biomass); - model = changeRxnBounds(model, finrex, -1000, 'l'); - model = changeRxnBounds(model, finrex, 1000, 'u'); - % removing blocked reactions from the bacs - %BlockedRxns = identifyFastBlockedRxns(model,model.rxns, printLevel); - %model= removeRxns(model, BlockedRxns); - %BlockedReaction = findBlockedReaction(model,'L2') + % remove exchange reactions from host while leaving demand and sink + % reactions + host = removeRxns(host, exRxns); + host.mets = strcat({'Host_'}, host.mets); + host.rxns = strcat({'Host_'}, host.rxns); - model = convertOldStyleModel(model); - exmod = model.rxns(strncmp('EX_', model.rxns, 3)); % find exchange reactions - eMets = model.mets(~cellfun(@isempty, strfind(model.mets, '[e]'))); % exchanged metabolites - dummyMicEU = createModel(); - %dummyMicEU = makeDummyModel(2 * size(eMets, 1), size(eMets, 1)); - dummyMicEUmets = [strcat(strcat(microbeNames{j, 1}, '_'), regexprep(eMets, '\[e\]', '\[u\]')); regexprep(eMets, '\[e\]', '\[u\]')]; - dummyMicEU = addMultipleMetabolites(dummyMicEU,dummyMicEUmets); - nMets = numel(eMets); - S = [speye(nMets);-speye(nMets)]; + % use mergeToModels without combining genes + [host] = mergeTwoModels(dummyHostB, host, 2, false, false); + + % Change remaining [e] (transporters) to [u] to transport diet metabolites + exMets2 = ~cellfun(@isempty, strfind(host.mets, '[e]')); % again, find all mets that appear in [e] + % exMetRxns2=find(sum(host.S(exMets2,:),1)~=0);%find reactions that contain mets from [e] + % exMetRxns2=exMetRxns2'; + % exMetRxnsMets2=find(sum(host.S(:,exMetRxns2),2)~=0);%get all metabolites of [e] containing rxns + % host.mets=regexprep(host.mets,'\[e\]','\[u\]');%replace [e] with [u] + dummyHostEU = createModel(); + %makeDummyModel(2 * size(exMets2, 1), size(exMets2, 1)); + hostmets = host.mets(exMets2); + dummyHostEUmets = [strrep(strrep(hostmets, 'Host_', ''), '[e]', '[u]'); hostmets]; + dummyHostEU = addMultipleMetabolites(dummyHostEU,dummyHostEUmets); + nMets = numel(hostmets); + S = [-speye(nMets),speye(nMets)]; lbs = repmat(-1000,nMets,1); ubs = repmat(1000,nMets,1); - names = strcat(strcat(microbeNames{j, 1}, '_'), 'IEX_', regexprep(eMets, '\[e\]', '\[u\]'), 'tr'); - dummyMicEU = addMultipleReactions(dummyMicEU,names,dummyMicEUmets,S,'lb',lbs,'ub',ubs); - model = removeRxns(model, exmod); - model.rxns = strcat(strcat(microbeNames{j, 1}, '_'), model.rxns); - model.mets = strcat(strcat(microbeNames{j, 1}, '_'), regexprep(model.mets, '\[e\]', '\[u\]')); % replace [e] with [u] - [model] = mergeTwoModels(dummyMicEU, model, 2, false, false); - modelStorage{j, 1} = model; % store model + names = strrep(strcat('Host_IEX_', strrep(hostmets, 'Host_', ''), 'tr'), '[e]', '[u]'); + dummyHostEU = addMultipleReactions(dummyHostEU,names,dummyHostEUmets,S','lb',lbs,'ub',ubs); + % for j = 1:size(exMets2, 1) + % dummyHostEU.rxns{j, 1} = strrep(strcat('Host_IEX_', strrep(host.mets{exMets2(j), 1}, 'Host_', ''), 'tr'), '[e]', '[u]'); + % metU = find(ismember(dummyHostEU.mets, strrep(strrep(host.mets{exMets2(j)}, 'Host_', ''), '[e]', '[u]'))); + % metE = find(ismember(dummyHostEU.mets, host.mets{exMets2(j)})); + % dummyHostEU.S(metU, j) = 1; + % dummyHostEU.S(metE, j) = -1; + % dummyHostEU.lb(j) = -1000; + % dummyHostEU.ub(j) = 1000; + % end + [host] = mergeTwoModels(dummyHostEU, host, 2, false, false); end -%% Merge the models in a parallel way - -% Find the base 2 log of the number of models (how many branches are needed), and merge the models two by two: -% In each column of model storage the number of models decreases of half -%(because they have been pairwise merged) till the last column where only -% one big model is contained. The models that are not pairwise merged -%(because number of rows is not even ) are stored and then merged -% sequentially to the big model. - - -pos = {}; % array where the position of models that cannot be merged pairwise (because their number in that iter is not -% even) in the original modelStorage vector is stored -dim = size(microbeNames, 1); -for j = 2:(floor(log2(size(microbeNames, 1))) + 1) % +1 because it starts with one column shifted - if mod(dim, 2) == 1 % check if number is even or not - halfdim = dim - 1; % approximated half dimension (needed to find how many iters to do - % for the pairwise merging - pos{1, j} = halfdim + 1; % find index of extramodel - halfdim = halfdim / 2; - else - halfdim = dim / 2; % no need for approximation +if buildSetupAll + % Merge the models in a parallel way + % First load the stored models with lumen compartment in place + modelStorage = {}; + for i = 1:size(microbeNames, 1) + loadedModel = readCbModel([modelStoragePath filesep microbeNames{i,1} '.mat']); + modelStorage{i, 1} = loadedModel; end - FirstSaveStore=modelStorage(:,(j-1)); - % SecondSaveStore=modelStorage(:,(j-1)); %changes 010318 - modelStorage(1:(dim-1),(j-1))={[]}; %this line will erase all the models from the container - %with the only exception of the last one that might be needed to be - %merged separately. This prevents a dramatic increase in ram usage in - %each iteration as result of stoaring all the merging three. - parfor k=1:halfdim - parind = k; - parind=parind+(k-1); - FirstMod=FirstSaveStore(parind); - % SecondMod=SecondSaveStore(parind+1);%changes 010318 - SecondMod=FirstSaveStore(parind+1);%changes 010318 - % modelStorage{k,j} = mergeTwoModels(FirstMod{1},SecondMod{1},1,false,false)%changes 010318 - modelStorage{k,j} = mergeTwoModels(FirstMod{1},SecondMod{1},1,false,false) + % Find the base 2 log of the number of models (how many branches are needed), and merge the models two by two: + % In each column of model storage the number of models decreases of half + %(because they have been pairwise merged) till the last column where only + % one big model is contained. The models that are not pairwise merged + %(because number of rows is not even ) are stored and then merged + % sequentially to the big model. + + pos = {}; % array where the position of models that cannot be merged pairwise (because their number in that iter is not + % even) in the original modelStorage vector is stored + dim = size(microbeNames, 1); + for j = 2:(floor(log2(size(microbeNames, 1))) + 1) % +1 because it starts with one column shifted + if mod(dim, 2) == 1 % check if number is even or not + halfdim = dim - 1; % approximated half dimension (needed to find how many iters to do + % for the pairwise merging + pos{1, j} = halfdim + 1; % find index of extramodel + halfdim = halfdim / 2; + else + halfdim = dim / 2; % no need for approximation + end + FirstSaveStore=modelStorage(:,(j-1)); + % SecondSaveStore=modelStorage(:,(j-1)); %changes 010318 + modelStorage(1:(dim-1),(j-1))={[]}; %this line will erase all the models from the container + %with the only exception of the last one that might be needed to be + %merged separately. This prevents a dramatic increase in ram usage in + %each iteration as result of stoaring all the merging three. + + for k=1:halfdim + parind = k; + parind=parind+(k-1); + FirstMod=FirstSaveStore(parind); + % SecondMod=SecondSaveStore(parind+1);%changes 010318 + SecondMod=FirstSaveStore(parind+1);%changes 010318 + % modelStorage{k,j} = mergeTwoModels(FirstMod{1},SecondMod{1},1,false,false)%changes 010318 + modelStorage{k,j} = mergeTwoModels(FirstMod{1},SecondMod{1},1,false,false); + end + dim = halfdim; end - dim = halfdim; -end - -% Merging the models remained alone and non-pairwise matched -if isempty(pos)== 1 %all the models were pairwise-merged -[model] = modelStorage{1,(floor(log2(size(microbeNames,1)))+1)}; -else - position = pos(1,:); %finding positions of non merged models - nexmod = find(~cellfun(@isempty,pos(1,:))); - toMerge = cell2mat(position(nexmod));%list of models still to merge - if (length(toMerge)) > 1 %more than 1 model was not pairwise merged - for k=2:(length(toMerge)+1) - if k==2 - [model] = mergeTwoModels(modelStorage{toMerge(1,k-1),(nexmod(k-1))-1},modelStorage{toMerge(1,k),(nexmod(k))-1},1,false,false); - elseif k > 3 - [model] = mergeTwoModels(modelStorage{toMerge(1,k-1),(nexmod(k-1))-1},model,1,false,false); + + % Merging the models remained alone and non-pairwise matched + if isempty(pos)== 1 %all the models were pairwise-merged + [model] = modelStorage{1,(floor(log2(size(microbeNames,1)))+1)}; + else + position = pos(1,:); %finding positions of non merged models + nexmod = find(~cellfun(@isempty,pos(1,:))); + toMerge = cell2mat(position(nexmod));%list of models still to merge + if (length(toMerge)) > 1 %more than 1 model was not pairwise merged + for k=2:(length(toMerge)+1) + if k==2 + [model] = mergeTwoModels(modelStorage{toMerge(1,k-1),(nexmod(k-1))-1},modelStorage{toMerge(1,k),(nexmod(k))-1},1,false,false); + elseif k > 3 + [model] = mergeTwoModels(modelStorage{toMerge(1,k-1),(nexmod(k-1))-1},model,1,false,false); + end end + [model] = mergeTwoModels(modelStorage{1,(floor(log2(size(microbeNames,1)))+1)},model,1,false,false); + end + if (length(toMerge)) == 1 %1 model was not pairwise merged + [model] = mergeTwoModels(modelStorage{1,(floor(log2(size(microbeNames,1)))+1)},modelStorage{toMerge(1,1),(nexmod-1)},1,false,false); end - [model] = mergeTwoModels(modelStorage{1,(floor(log2(size(microbeNames,1)))+1)},model,1,false,false); end - if (length(toMerge)) == 1 %1 model was not pairwise merged - [model] = mergeTwoModels(modelStorage{1,(floor(log2(size(microbeNames,1)))+1)},modelStorage{toMerge(1,1),(nexmod-1)},1,false,false); + +else + % merge in non-parallel way + for i = 2:size(microbeNames, 1) + if i==2 + model1 = readCbModel([modelStoragePath filesep microbeNames{1,1} '.mat']); + modelNew = readCbModel([modelStoragePath filesep microbeNames{i,1} '.mat']); + model = mergeTwoModels(model1,modelNew,1,false,false); + else + modelNew = readCbModel([modelStoragePath filesep microbeNames{i,1} '.mat']); + model = mergeTwoModels(model,modelNew,1,false,false); + end end end +% Merging with host if present + +% temp fix +if isfield(model,'C') + model=rmfield(model,'C'); +end +% -% Merging with host if present if ~isempty(host) [model] = mergeTwoModels(host,model,1,false,false); end [model] = mergeTwoModels(dummy,model,2,false,false); -%finish up by A: removing duplicate reactions -%We will lose information here, but we will just remove the duplicates. -[model,rxnToRemove,rxnToKeep]= checkDuplicateRxn(model,'S',1,0,1); - end - diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/getIndividualSizeName.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/getIndividualSizeName.m index f0e4397669..3c84985fa8 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/getIndividualSizeName.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/getIndividualSizeName.m @@ -1,17 +1,20 @@ -function [sampNames, organisms] = getIndividualSizeName(abunFilePath) +function [sampNames, organisms, exMets] = getIndividualSizeName(abunFilePath,modPath) % This function automatically detects organisms, names and number of individuals present % in the study. % % USAGE: % -% [sampNames, organisms] = getIndividualSizeName(abunFilePath) +% [sampNames, organisms, exMets] = getIndividualSizeName(abunFilePath) % % INPUTS: -% abunFilePath: char with path and name of file from which to retrieve information +% abunFilePath: char with path and name of file from which to retrieve information +% modPath: char with path of directory where models are stored % % OUTPUTS: -% sampNamess: nx1 cell array cell array with names of individuals in the study -% organisms: nx1 cell array cell array with names of organisms in the study +% sampNames: nx1 cell array cell array with names of individuals in the study +% organisms: nx1 cell array cell array with names of organisms in the study +% exMets: cell array with all unique extracellular metabolites +% contained in the models % % .. Author: Federico Baldini 2017-2018 % Almut Heinken, 03/2021: simplified inputs @@ -65,4 +68,17 @@ % getting info on present strains organisms = oldsampNames(2:height(oldsampNames), 2); organisms = table2cell(organisms); % extracted names of models + +parfor i = 1:length(organisms) % find the unique set of all the reactions contained in the models + model =readCbModel([modPath filesep organisms{i,1} '.mat']); + models{i, 1} = model; +end + +exMets = {}; +for i = 1:length(organisms) % find the unique set of all the reactions contained in the models + model = models{i, 1}; + findmets = model.mets(find(contains(model.mets,'[e]'))); + exMets = union(exMets,findmets); +end + end diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/getMappingInfo.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/getMappingInfo.m index 40ec164c02..60052bed07 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/getMappingInfo.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/getMappingInfo.m @@ -31,7 +31,6 @@ % % .. Author: Federico Baldini 2017-2018 - reac = {}; % array with unique set of all the reactions present in the models exMets = {}; % array with unique set of all the extracellular metabolites present in the models diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/initMgPipe.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/initMgPipe.m index eb1fa8ddca..fbb6176b4c 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/initMgPipe.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/initMgPipe.m @@ -1,9 +1,10 @@ function [init, netSecretionFluxes, netUptakeFluxes, Y, modelStats, summary, statistics] = initMgPipe(modPath, abunFilePath, computeProfiles, varargin) -% This function is called from the MgPipe driver `StartMgPipe` takes care of saving some variables -% in the environment (in case that the function is called without a driver), does some checks on the -% inputs, and automatically launches MgPipe. As matter of fact, if all the inputs are properly inserted -% in the function it can replace the driver. - +% This function initializes the mgPipe pipeline and sets the optional input +% variables if not defined. +% +% USAGE +% [init, netSecretionFluxes, netUptakeFluxes, Y, modelStats, summary, statistics] = initMgPipe(modPath, abunFilePath, computeProfiles, varargin) +% % INPUTS: % modPath: char with path of directory where models are stored % abunFilePath: char with path and name of file from which to retrieve abundance information @@ -12,7 +13,10 @@ % % OPTIONAL INPUTS: % resPath: char with path of directory where results are saved -% dietFilePath: char with path of directory where the diet is saved +% dietFilePath: char with path of directory where the diet is saved. +% Can also be a character array with a separate diet for +% each individual, in that case, size(dietFilePath,1) +% needs to equal the length of samples. % infoFilePath: char with path to stratification criteria if available % hostPath: char with path to host model, e.g., Recon3D (default: empty) % hostBiomassRxn: char with name of biomass reaction in host (default: empty) @@ -55,6 +59,8 @@ % - Almut Heinken 02/2021: added option for creation of each % personalized model separately and % output of model stats +% - Almut Heinken 03/2021: inserted error message if +% abundances are not normalized. % Define default input parameters if not specified @@ -128,6 +134,13 @@ error('Path to file with dietary information is incorrect!'); end +% test if abundances are normalized +abundance = table2cell(readtable(abunFilePath,'ReadVariableNames',false)); +totalAbun=sum(str2double(abundance(2:end,2:end)),1); +if any(totalAbun > 1.01) + error('Abundances are not normalized. Please run the function normalizeCoverage!') +end + if strcmp(infoFilePath, '') patStat = false; else diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/mgPipe.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/mgPipe.m index ca6be02951..c88d0ef576 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/mgPipe.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/mgPipe.m @@ -1,5 +1,5 @@ function [netSecretionFluxes, netUptakeFluxes, Y, modelStats, summary, statistics] = mgPipe(modPath, abunFilePath, computeProfiles, resPath, dietFilePath, infoFilePath, hostPath, hostBiomassRxn, hostBiomassRxnFlux, objre, buildSetupAll, saveConstrModels, figForm, numWorkers, rDiet, pDiet, includeHumanMets, lowerBMBound, repeatSim, adaptMedium) -% MgPipe is a MATLAB based pipeline to integrate microbial abundances +% mgPipe is a MATLAB based pipeline to integrate microbial abundances % (coming from metagenomic data) with constraint based modeling, creating % individuals' personalized models. % The pipeline is divided in 3 parts: @@ -9,7 +9,7 @@ % integrating abundance data retrieved from metagenomics. For each organism, % reactions are coupled to the objective function. % [PART 3] Simulations under different diet regimes. -% MgPipe was created (and tested) for AGORA 1.0 please first download AGORA +% mgPipe was created (and tested) for AGORA 1.0 please first download AGORA % version 1.0 from https://www.vmh.life/#downloadview and place the mat files % into a folder. % @@ -28,7 +28,7 @@ % hostBiomassRxn: char with name of biomass reaction in host (default: empty) % hostBiomassRxnFlux: double with the desired flux through the host % biomass reaction (default: zero) -% objre: char with reaction name of objective function of microbeNames +% objre: char with reaction name of objective function % buildSetupAll: boolean indicating the strategy that should be used to % build personalized models: if true, build a global setup model % containing all organisms in at least model (default), false: create @@ -65,11 +65,6 @@ % - Almut Heinken, 01/21: added option for creation of each personalized model separately %% PIPELINE: [PART 1] -% The number of microbeNames, their names, the number of samples and their identifiers -% are automatically detected from the input file. - -[sampNames,microbeNames]=getIndividualSizeName(abunFilePath); -%% % If PART1 was already % computed: if the associated file is already present in the results folder its % execution is skipped else its execution starts @@ -93,20 +88,61 @@ end end - % Computing genetic information - [reac,exMets,micRea,binOrg,patOrg,reacPat,reacNumb,reacSet,reacTab,reacAbun,reacNumber]=getMappingInfo(modPath,microbeNames,abunFilePath); - writetable(cell2table(reacAbun,'VariableNames',['Reactions';sampNames]'),strcat(resPath,'reactions.csv')); + abundance = table2cell(readtable(abunFilePath)); - %Create tables and save all the created variables - reacTab=[array2table(reac),array2table(reacTab,'VariableNames',sampNames')],[resPath 'compfile' filesep 'ReacTab.csv']; - reacSet=cell2table(reacSet,'VariableNames',sampNames'); - reacPat=[array2table(microbeNames),array2table(reacPat,'VariableNames',sampNames')]; -end + % The number of microbeNames, their names, the number of samples and their identifiers + % are automatically detected from the input file. + [sampNames,microbeNames,exMets]=getIndividualSizeName(abunFilePath,modPath); + + % remove rows of organisms that are not present in any sample + microbeNames(sum(cell2mat(abundance(:,2:end)),2)<0.0000001,:)=[]; + abundance(sum(cell2mat(abundance(:,2:end)),2)<0.0000001,:)=[]; + + % Extracellular spaces simulating the lumen are built and stored for + % each microbe. + [exch,modelStoragePath]=buildModelStorage(microbeNames,modPath); + + % Computing reaction presence + ReactionPresence=calculateReactionPresence(abunFilePath, modPath, {}); + writetable(cell2table(ReactionPresence),[resPath filesep 'ReactionPresence.csv'], 'WriteVariableNames', false); -% Plotting genetic information -[PCoA]=plotMappingInfo(resPath,patOrg,reacPat,reacTab,reacNumber,infoFilePath,figForm,sampNames,microbeNames); + % Computing reaction abundance + ReactionAbundance = fastCalculateReactionAbundance(abunFilePath, modPath, {}, numWorkers); + writetable(cell2table(ReactionAbundance'),[resPath filesep 'ReactionAbundance.csv'], 'WriteVariableNames', false); + + % Computing subsystem abundance + subsystemAbundance = calculateSubsystemAbundance([resPath filesep 'ReactionAbundance.csv']); + writetable(cell2table(subsystemAbundance),[resPath filesep 'SubsystemAbundance.csv'], 'WriteVariableNames', false); -save([resPath filesep 'mapInfo.mat'],'binOrg', 'mapP', 'exMets', 'micRea', 'patOrg', 'PCoA', 'reac', 'reacAbun', 'reacNumb', 'reacNumber', 'reacPat', 'reacSet', 'reacTab', 'sampNames', 'microbeNames') + % plot subsystem abundance + data=cell2mat(subsystemAbundance(2:end,2:end)); + xlabels=subsystemAbundance(1,2:end); + ylabels=subsystemAbundance(2:end,1); + figure; + imagesc(data) + colormap('hot') + colorbar + if length(xlabels)<30 + set(gca,'xtick',1:length(xlabels)); + xticklabels(xlabels); + xtickangle(90) + end + set(gca,'ytick',1:length(ylabels)); + yticklabels(ylabels); + ax=gca; + + if length(ylabels)<50 + ax.YAxis.FontSize = 8; + else + ax.YAxis.FontSize = 6; + end + set(gca,'TickLabelInterpreter', 'none'); + title('Relative reaction abundances summarized by subsystem') + print(strcat(resPath, 'Subsystem_abundances'), figForm) + + % save mapping info + save([resPath filesep 'mapInfo.mat'], 'mapP', 'exMets', 'exch', 'sampNames', 'microbeNames', 'modelStoragePath','abundance','-v7.3') +end %end of trigger for Autoload %% PIPELINE: [PART 2.1] @@ -158,16 +194,19 @@ % are also added. Models that are already existent will not be recreated, and % new microbiota models will be saved in the results folder. -abundance = table2cell(readtable(abunFilePath)); - -% remove rows of organisms that are not present in any sample -abundance(sum(cell2mat(abundance(:,2:end)),2)<0.0000001,:)=[]; +% set parallel pool +if numWorkers > 1 + poolobj = gcp('nocreate'); + if isempty(poolobj) + parpool(numWorkers) + end +end % if there is 500 reconstruction total or less, use fast setup creator to % carve each personalized model from one large setup model. if buildSetupAll if modbuild == 1 - setup=fastSetupCreator(modPath, microbeNames, host, objre, numWorkers); + setup=fastSetupCreator(exch, modelStoragePath, microbeNames, host, objre, buildSetupAll); setup.name='Global reconstruction with lumen / fecal compartments no host'; setup.recon=0; if ~isempty(host) @@ -178,7 +217,11 @@ end if modbuild==0 - load(strcat(resPath,'Setup_allbacs.mat')) + if ~isempty(host) + load(strcat(resPath,'Setup_host_allbacs.mat')) + else + load(strcat(resPath,'Setup_allbacs.mat')) + end end [createdModels]=createPersonalizedModel(abundance,resPath,setup,sampNames,microbeNames,host,hostBiomassRxn); @@ -188,28 +231,31 @@ % define what counts as zero abundance tol=0.0000001; - for i=1:length(sampNames) - % Here, we will not be starting from one joined model containing all - % reconstructions. Instead, each personalized model will be created separately.) - % get the list of models for each sample and remove the ones not in - % this sample - - % retrieving current model ID - if ~isempty(host) - mId = ['host_microbiota_model_samp_', sampNames{i,1}, '.mat']; + clear('microbeNames','exMets','abundance') + + steps=50; + % proceed in batches for improved effiency + for j=1:steps:length(sampNames) + if length(sampNames)-j>=steps-1 + endPnt=steps-1; else - mId = ['microbiota_model_samp_', sampNames{i,1}, '.mat']; + endPnt=length(sampNames)-j; end - % if the model doesn't exist yet - mapP = detectOutput(resPath, mId); - if isempty(mapP) - microbeNamesSample = microbeNames; - abunRed=abundance(:,i+1); - abunRed=[abundance(:,1),abunRed]; + parfor i=j:j+endPnt + % Here, we will not be starting from one joined model containing all + % reconstructions. Instead, each personalized model will be created separately.) + % get the list of models for each sample and remove the ones not in + % this sample + mappingData=load([resPath filesep 'mapInfo.mat']) + microbeNamesSample = mappingData.microbeNames; + abunRed=mappingData.abundance(:,i+1); + abunRed=[mappingData.abundance(:,1),abunRed]; microbeNamesSample(cell2mat(abunRed(:,2)) < tol,:)=[]; abunRed(cell2mat(abunRed(:,2)) < tol,:)=[]; - setupModel = fastSetupCreator(modPath, microbeNamesSample, host, objre, numWorkers); + setupModel = fastSetupCreator(exch, modelStoragePath, microbeNamesSample, host, objre, buildSetupAll); + + % create personalized models for the batch createdModel=createPersonalizedModel(abunRed,resPath,setupModel,sampNames(i,1),microbeNamesSample,host,hostBiomassRxn); end end @@ -222,13 +268,16 @@ % analysis for all the exchange reactions of the diet and fecal compartment is % also computed and saved in a file called "simRes". -[exchanges, netProduction, netUptake, presol, inFesMat] = microbiotaModelSimulator(resPath, exMets, sampNames, dietFilePath, hostPath, hostBiomassRxn, hostBiomassRxnFlux, numWorkers, rDiet, pDiet, saveConstrModels, computeProfiles, includeHumanMets, lowerBMBound, repeatSim, adaptMedium); -% Finally, NMPCs (net maximal production capability) are computed in a metabolite -% resolved manner and saved in a comma delimited file in the results folder. NMPCs -% indicate the maximal production of each metabolite and are computing summing -% the maximal secretion flux with the maximal uptake flux. Similarity of metabolic -% profiles (using the different NMPCs as features) between individuals are also -% evaluated with classical multidimensional scaling. +load([resPath filesep 'mapInfo.mat']) +if computeProfiles || saveConstrModels + [exchanges, netProduction, netUptake, presol, inFesMat] = microbiotaModelSimulator(resPath, exMets, sampNames, dietFilePath, hostPath, hostBiomassRxn, hostBiomassRxnFlux, numWorkers, rDiet, pDiet, saveConstrModels, computeProfiles, includeHumanMets, lowerBMBound, repeatSim, adaptMedium); + % Finally, NMPCs (net maximal production capability) are computed in a metabolite + % resolved manner and saved in a comma delimited file in the results folder. NMPCs + % indicate the maximal production of each metabolite and are computing summing + % the maximal secretion flux with the maximal uptake flux. Similarity of metabolic + % profiles (using the different NMPCs as features) between individuals are also + % evaluated with classical multidimensional scaling. +end if computeProfiles [netSecretionFluxes, netUptakeFluxes, Y] = mgSimResCollect(resPath, sampNames, exchanges, rDiet, pDiet, infoFilePath, netProduction, netUptake, figForm); @@ -237,6 +286,7 @@ netUptakeFluxes={}; Y=[]; delete('simRes.mat','intRes.mat') + rmdir([resPath filesep 'modelStorage'],'s') end % get stats on microbiome models-number of reactions and metabolites diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/microbiotaModelSimulator.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/microbiotaModelSimulator.m index d7bdb1ca09..676a5d6132 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/microbiotaModelSimulator.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/microbiotaModelSimulator.m @@ -50,6 +50,13 @@ % .. Author: Federico Baldini, 2017-2018 % Almut Heinken, 03/2021: simplified inputs +% set a solver if not done yet +global CBT_LP_SOLVER +solver = CBT_LP_SOLVER; +if isempty(solver) + initCobraToolbox(false); %Don't update the toolbox automatically +end + for i=1:length(exMets) exchanges{i,1} = ['EX_' exMets{i}]; end @@ -219,12 +226,6 @@ end end - % set a solver if not done yet - global CBT_LP_SOLVER - solver = CBT_LP_SOLVER; - if isempty(solver) - initCobraToolbox(false); %Don't update the toolbox automatically - end solution_allOpen = solveCobraLP(buildLPproblemFromModel(model)); % solution_allOpen=solveCobraLPCPLEX(model,2,0,0,[],0); if solution_allOpen.stat==0 diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/normalizeCoverage.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/normalizeCoverage.m index 738a86b684..a595266b9b 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/normalizeCoverage.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/normalizeCoverage.m @@ -31,6 +31,17 @@ coverage = table2cell(readtable(abunFilePath,'ReadVariableNames',false)); coverage{1,1}='ID'; + +% delete samples that are all zeros (if applies) +totalAbun=sum(str2double(coverage(2:end,2:end)),1); +allzero=find(totalAbun<0.0000001); +if ~isempty(allzero) + for i=1:length(allzero) + allzero(i)=allzero(i)+1; + end + coverage(:,allzero)=[]; +end + abundanceNew = coverage; for i=2:size(coverage,2) diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/plotMappingInfo.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/plotMappingInfo.m index 84aa5b8f32..0c46a12561 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/plotMappingInfo.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/mgPipe/plotMappingInfo.m @@ -185,7 +185,7 @@ % hold on % end - print(strcat(resPath, 'PCoA reactions'), figForm) + print(strcat(resPath, 'PCoA_reactions'), figForm) else disp('noPcoA will be plotted') end diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/createMultipleSpeciesModel.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/createMultipleSpeciesModel.m index 474466e5b3..70aa2e5b99 100644 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/createMultipleSpeciesModel.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/createMultipleSpeciesModel.m @@ -162,7 +162,7 @@ for i = 1:modelNumber model=models{i, 1}; biomassReaction=model.rxns(find(strncmp(model.rxns, 'bio', 3))); - model = removeBalancedCycles(model, biomassReaction, database,unionRxns); + model = removeFutileCycles(model, biomassReaction, database,unionRxns); models{i, 1} = model; end %% define some variables diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/joinModelsPairwiseFromList.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/joinModelsPairwiseFromList.m index 24bf4456bf..8e743d2ace 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/joinModelsPairwiseFromList.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/joinModelsPairwiseFromList.m @@ -56,6 +56,22 @@ function joinModelsPairwiseFromList(modelList, modelFolder, varargin) mergeGenesFlag = parser.Results.mergeGenesFlag; pairwiseModelFolder = parser.Results.pairwiseModelFolder; +% initialize COBRA Toolbox and parallel pool +global CBT_LP_SOLVER +if isempty(CBT_LP_SOLVER) + initCobraToolbox +end +solver = CBT_LP_SOLVER; + +if numWorkers>0 && ~isempty(ver('parallel')) + % with parallelization + poolobj = gcp('nocreate'); + if isempty(poolobj) + parpool(numWorkers) + end +end +environment = getEnvironment(); + pairedModelInfo = {}; cnt = 1; @@ -67,105 +83,66 @@ function joinModelsPairwiseFromList(modelList, modelFolder, varargin) existingModels(find(strcmp(existingModels(:,1),'..')),:)=[]; % then join all models in modelList +inputModels={}; for i = 1:size(modelList, 1) - + % Load the reconstructions to be joined - inputModels={}; model=readCbModel([modelFolder filesep modelList{i,1} '.mat']); inputModels{i}=model; for k = i + 1:size(modelList, 1) model=readCbModel([modelFolder filesep modelList{k,1} '.mat']); inputModels{k}=model; end - - if numWorkers > 0 - % with parallelization - poolobj = gcp('nocreate'); - if isempty(poolobj) - parpool(numWorkers) - end - pairedModelsTemp = {}; - - parfor k = i + 1:size(modelList, 1) - model1 = inputModels{i}; - model2 = inputModels{k}; - models = { - model1 - model2 - }; - nameTagsModels = { - strcat(modelList{i}, '_') - strcat(modelList{k}, '_') - }; - if ~contains(existingModels,['pairedModel', '_', modelList{i}, '_', modelList{k}, '.mat']) - [pairedModel] = createMultipleSpeciesModel(models, 'nameTagsModels', nameTagsModels,'mergeGenesFlag', mergeGenesFlag); - [pairedModel] = coupleRxnList2Rxn(pairedModel, pairedModel.rxns(strmatch(nameTagsModels{1, 1}, pairedModel.rxns)), strcat(nameTagsModels{1, 1}, model1.rxns(find(strncmp(model1.rxns, 'bio', 3)))), c, u); - [pairedModel] = coupleRxnList2Rxn(pairedModel, pairedModel.rxns(strmatch(nameTagsModels{2, 1}, pairedModel.rxns)), strcat(nameTagsModels{2, 1}, model2.rxns(find(strncmp(model2.rxns, 'bio', 3)))), c, u); - pairedModelsTemp{k} = pairedModel; - else - pairedModelsTemp{k} = {}; - end + + pairedModelsTemp = {}; + + parfor k = i + 1:size(modelList, 1) + restoreEnvironment(environment); + changeCobraSolver(solver, 'LP', 0, -1); + + model1 = inputModels{i}; + model2 = inputModels{k}; + models = { + model1 + model2 + }; + nameTagsModels = { + strcat(modelList{i}, '_') + strcat(modelList{k}, '_') + }; + if isempty(contains(existingModels,['pairedModel', '_', modelList{i}, '_', modelList{k}, '.mat'])) + [pairedModel] = createMultipleSpeciesModel(models, 'nameTagsModels', nameTagsModels,'mergeGenesFlag', mergeGenesFlag); + [pairedModel] = coupleRxnList2Rxn(pairedModel, pairedModel.rxns(strmatch(nameTagsModels{1, 1}, pairedModel.rxns)), strcat(nameTagsModels{1, 1}, model1.rxns(find(strncmp(model1.rxns, 'bio', 3)))), c, u); + [pairedModel] = coupleRxnList2Rxn(pairedModel, pairedModel.rxns(strmatch(nameTagsModels{2, 1}, pairedModel.rxns)), strcat(nameTagsModels{2, 1}, model2.rxns(find(strncmp(model2.rxns, 'bio', 3)))), c, u); + pairedModelsTemp{k} = pairedModel; + else + pairedModelsTemp{k} = {}; end - for k = i + 1:size(modelList, 1) - % keep track of the generated models and populate the output file with - % information on joined models - model1 = inputModels{i}; - pairedModelInfo{cnt, 1} = ['pairedModel', '_', modelList{i}, '_', modelList{k}, '.mat']; - pairedModelInfo{cnt, 2} = modelList{i}; - pairedModelInfo{cnt, 3} = model1.rxns(find(strncmp(model1.rxns, 'bio', 3))); - model2 = inputModels{k}; - pairedModelInfo{cnt, 4} = modelList{k}; - pairedModelInfo{cnt, 5} = model2.rxns(find(strncmp(model2.rxns, 'bio', 3))); - % save file regularly - if floor(cnt/1000) == cnt/1000 + end + + for k = i + 1:size(modelList, 1) + % keep track of the generated models and populate the output file with + % information on joined models + model1 = inputModels{i}; + pairedModelInfo{cnt, 1} = ['pairedModel', '_', modelList{i}, '_', modelList{k}, '.mat']; + pairedModelInfo{cnt, 2} = modelList{i}; + pairedModelInfo{cnt, 3} = model1.rxns(find(strncmp(model1.rxns, 'bio', 3))); + model2 = inputModels{k}; + pairedModelInfo{cnt, 4} = modelList{k}; + pairedModelInfo{cnt, 5} = model2.rxns(find(strncmp(model2.rxns, 'bio', 3))); + % save file regularly + if floor(cnt/1000) == cnt/1000 save([pairwiseModelFolder filesep 'pairedModelInfo'],'pairedModelInfo'); - end - - if ~contains(existingModels,['pairedModel', '_', modelList{i}, '_', modelList{k}, '.mat']) - pairedModel=pairedModelsTemp{k}; - save([pairwiseModelFolder filesep pairedModelInfo{cnt,1}],'pairedModel'); - end - cnt = cnt + 1; end - else - % without parallelization - for j = i + 1:size(modelList, 1) - model1 = inputModels{i}; - model2 = inputModels{j}; - models = { - model1 - model2 - }; - nameTagsModels = { - strcat(modelList{i}, '_') - strcat(modelList{j}, '_') - }; - % keep track of the generated models and populate the output file with - % information on joined models - pairedModelInfo{cnt, 1} = ['pairedModel', '_', modelList{i}, '_', modelList{j}, '.mat']; - pairedModelInfo{cnt, 2} = modelList{i}; - pairedModelInfo{cnt, 3} = model1.rxns(find(strncmp(model1.rxns, 'bio', 3))); - pairedModelInfo{cnt, 4} = modelList{j}; - pairedModelInfo{cnt, 5} = model2.rxns(find(strncmp(model2.rxns, 'bio', 3))); - % save file regularly - if floor(cnt/1000) == cnt/1000 - save([pairwiseModelFolder filesep 'pairedModelInfo'],'pairedModelInfo'); - end - - if ~contains(existingModels,['pairedModel', '_', modelList{i}, '_', modelList{j}, '.mat']) - [pairedModel] = createMultipleSpeciesModel(models, 'nameTagsModels', nameTagsModels,'mergeGenesFlag', mergeGenesFlag); - [pairedModel] = coupleRxnList2Rxn(pairedModel, pairedModel.rxns(strmatch(nameTagsModels{1, 1}, pairedModel.rxns)), strcat(nameTagsModels{1, 1}, model1.rxns(find(strncmp(model1.rxns, 'bio', 3)))), c, u); - [pairedModel] = coupleRxnList2Rxn(pairedModel, pairedModel.rxns(strmatch(nameTagsModels{2, 1}, pairedModel.rxns)), strcat(nameTagsModels{2, 1}, model2.rxns(find(strncmp(model2.rxns, 'bio', 3)))), c, u); - pairedModels{cnt, 1} = pairedModel; - save([pairwiseModelFolder filesep pairedModelInfo{cnt,1}],'pairedModel'); - else - pairedModels{cnt, 1} = {}; - end - cnt = cnt + 1; + + if isempty(contains(existingModels,['pairedModel', '_', modelList{i}, '_', modelList{k}, '.mat'])) + pairedModel=pairedModelsTemp{k}; + save([pairwiseModelFolder filesep pairedModelInfo{cnt,1}],'pairedModel'); end + cnt = cnt + 1; end end save([pairwiseModelFolder filesep 'pairedModelInfo'],'pairedModelInfo'); -end +end \ No newline at end of file diff --git a/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/simulatePairwiseInteractions.m b/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/simulatePairwiseInteractions.m index cad80b01ae..afede59287 100755 --- a/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/simulatePairwiseInteractions.m +++ b/src/analysis/multiSpecies/microbiomeModelingToolbox/pairwiseInteractionModeling/simulatePairwiseInteractions.m @@ -118,20 +118,20 @@ solutionsTmp={}; if isfile([pairwiseModelFolder filesep 'pairedModelInfo.mat']) -load([pairwiseModelFolder filesep 'pairedModelInfo.mat']) +load([pairwiseModelFolder filesep 'pairedModelInfo.mat'],'pairedModelInfo') else error('Pairwise models have not been created. Please run joinModelsPairwiseFromList first.') end -parfor i = 1:size(pairedModelInfo, 1) +info=pairedModelInfo; +parfor i = 1:size(info, 1) restoreEnvironment(environment); changeCobraSolver(solver, 'LP', 0, -1); changeCobraSolverParams('LP', 'logFile', 0); % load the model - fileToLoad=load([pairwiseModelFolder filesep pairedModelInfo{i,1}]); - toLoad=fieldnames(fileToLoad); - pairedModel=fileToLoad.(toLoad{1}); + filename=[pairwiseModelFolder filesep info{i,1}]; + pairedModel=readCbModel(filename); pairedModelOrg=pairedModel; % if a diet was input if ~isempty(inputDiet) @@ -139,8 +139,8 @@ end % for each paired model, set both biomass objective functions as % objectives - biomass1 = strcat(pairedModelInfo{i, 2}, '_', pairedModelInfo{i, 3}); - biomass2 = strcat(pairedModelInfo{i, 4}, '_', pairedModelInfo{i, 5}); + biomass1 = strcat(info{i, 2}, '_', info{i, 3}); + biomass2 = strcat(info{i, 4}, '_', info{i, 5}); model1biomass = find(ismember(pairedModel.rxns, biomass1)); pairedModel.c(model1biomass, 1) = 1; model2biomass = find(ismember(pairedModel.rxns, biomass2)); @@ -160,7 +160,7 @@ end pairedModel = changeObjective(pairedModel, biomass1); % disable flux through the second model - pairedModel = changeRxnBounds(pairedModel, pairedModel.rxns(strmatch(strcat(pairedModelInfo{i, 4}, '_'), pairedModel.rxns)), 0, 'b'); + pairedModel = changeRxnBounds(pairedModel, pairedModel.rxns(strmatch(strcat(info{i, 4}, '_'), pairedModel.rxns)), 0, 'b'); % calculate single biomass solutionSingle1 = solveCobraLP(buildLPproblemFromModel(pairedModel,false)); % silence model 1 and optimize model 2 @@ -172,7 +172,7 @@ end pairedModel = changeObjective(pairedModel, biomass2); % disable flux through the first model - pairedModel = changeRxnBounds(pairedModel, pairedModel.rxns(strmatch(strcat(pairedModelInfo{i, 2}, '_'), pairedModel.rxns)), 0, 'b'); + pairedModel = changeRxnBounds(pairedModel, pairedModel.rxns(strmatch(strcat(info{i, 2}, '_'), pairedModel.rxns)), 0, 'b'); % calculate single biomass solutionSingle2 = solveCobraLP(buildLPproblemFromModel(pairedModel,false)); diff --git a/src/analysis/thermo/componentContribution/new/componentContribution.m b/src/analysis/thermo/componentContribution/new/componentContribution.m index 2342f6e3dc..ce4967e9ff 100644 --- a/src/analysis/thermo/componentContribution/new/componentContribution.m +++ b/src/analysis/thermo/componentContribution/new/componentContribution.m @@ -1,19 +1,18 @@ -function [model, solution] = componentContribution(model, trainingData, param) +function [model, solution] = componentContribution(model, combinedModel, param) % Perform the component contribution method % % USAGE: % -% [model, params] = componentContribution(model, trainingData) +% [model, params] = componentContribution(model, combinedModel) % % INPUTS: % model: COBRA structure -% trainingData: structure from `prepareTrainingData` with the following fields: +% combinedModel: structure from `prepareTrainingData` with the following fields: % % * .S - the stoichiometric matrix of measured reactions % * .G - the group incidence matrix % * .dG0 - the observation vector (standard Gibbs energy of reactions) -% * .weights - the weight vector for each reaction in `S` -% * .Model2TrainingMap +% * .test2CombinedModelMap % % OUTPUTS: % model: structure with the following fields: @@ -43,14 +42,13 @@ end fprintf('Running Component Contribution method\n'); -[S,G,DrG0,weights]=deal(trainingData.S, trainingData.G, trainingData.dG0, trainingData.weights); +[S,G,DrG0]=deal(combinedModel.S, combinedModel.G, combinedModel.dG0); [mlt, nlt] = size(S); %assert Generate an error when a condition is violated. assert (size(G, 1) == mlt); assert (size(DrG0, 1) == nlt); assert (size(DrG0, 2) == 1); -assert (length(weights) == size(S, 2)); %% %[inv_A, r, P_R, P_N] = invertProjection(A, epsilon) @@ -108,26 +106,28 @@ % Linear regression for the reactant layer (aka RC) [inv_S, r_rc, P_R_rc, P_N_rc] = invertProjection(S); - % calculate the reactant contribution - DfG0_rc = inv_S'* DrG0; + % reactant contribution + DfG0_rc = inv_S' * DrG0; + + % residual error (unweighted squared error divided by N - rank) + e_rc = (DrG0 - S' * DfG0_rc); + MSE_rc = (e_rc' * e_rc) / (min(size(S)) - r_rc); % Linear regression for the group layer (aka GC) [inv_GS, r_gc, P_R_gc, P_N_gc] = invertProjection(GS); - % calculate the group contribution - DgG0_gc = inv_GS'* DrG0; - - % Calculate the contributions in the stoichiometric space - DfG0_cc = P_R_rc * DfG0_rc + P_N_rc * G * DgG0_gc; - - % Calculate the residual error (unweighted squared error divided by N - rank) - e_rc = (DrG0 - S' * DfG0_rc); - MSE_rc = (e_rc' * e_rc) / (min(size(S)) - r_rc); + % group contribution + DgG0_gc = inv_GS' * DrG0; e_gc = (DrG0 - GS' * DgG0_gc); - MSE_gc = (e_gc' * e_gc) / (min(size(GS)) - r_gc); + % component contribution + %DfG0_cc = (P_R_rc * inv_S' + P_N_rc * G * inv_GS')* DrG0; + DfG0_cc = P_R_rc * DfG0_rc + P_N_rc * G * DgG0_gc; + + e_cc = (DrG0 - S' * DfG0_cc); + MSE_cc = (e_cc' * e_cc) / (min(size(GS)) - r_gc); end %DrG0_cc = S'*DfG0_cc; @@ -162,22 +162,29 @@ % Put all the calculated data in 'solution' for the sake of debugging if param.debug + %reactant contribution solution.DfG0_rc = DfG0_rc; - solution.DgG0_gc = DgG0_gc; + solution.inv_S = inv_S; + solution.P_R_rc = P_R_rc; + solution.e_rc = e_rc; + solution.MSE_rc = MSE_rc; solution.V_rc = V_rc; + + %group contribution + solution.DgG0_gc = DgG0_gc; + solution.inv_GS = inv_GS; + solution.P_N_rc = P_N_rc; + solution.e_gc = e_gc; + solution.MSE_gc = MSE_gc; solution.V_gc = V_gc; + + % component contribution + solution.DfG0_cc = DfG0_cc; + solution.e_cc = e_cc; + solution.MSE_cc = MSE_cc; + solution.V_inf = V_inf; - solution.MSE_rc = MSE_rc; - solution.MSE_gc = MSE_gc; solution.MSE_inf = MSE_inf; - solution.P_R_rc = P_R_rc; - solution.P_N_rc = P_N_rc; - - DgG0_gc = solution.DgG0_gc(solution.DgG0_gc~=0); - DgG0_gc_sorted = sort(DgG0_gc); - figure; - plot(DgG0_gc_sorted,'.') - title('Sorted nonzero DgG0_gc') else solution = []; end @@ -187,8 +194,8 @@ % Map estimates back to model -model.DfG0 = DfG0_cc(trainingData.Model2TrainingMap); -model.covf = cov_dG0(trainingData.Model2TrainingMap, trainingData.Model2TrainingMap); +model.DfG0 = DfG0_cc(combinedModel.test2CombinedModelMap); +model.covf = cov_dG0(combinedModel.test2CombinedModelMap, combinedModel.test2CombinedModelMap); %model.DfG0_Uncertainty = diag(sqrt(model.covf)); diag_conf=diag(model.covf); @@ -218,11 +225,7 @@ if ~real(model.DrG0_Uncertainty) error('DrG0_Uncertainty has a complex part') end -model.DrG0_Uncertainty(~model.SIntRxnBool,1)=NaN; -% model.DrG0_Uncertainty(model.DrG0_Uncertainty >= 1e3) = 1e10; % Set large uncertainty in reaction energies to inf -% model.DrG0_Uncertainty(sum(model.S~=0)==1) = 1e10; % set uncertainty of exchange, demand and sink reactions to inf - -% Debug -% model.G = trainingData.G(trainingData.Model2TrainingMap,:); -% model.groups = trainingData.groups; -% model.has_gv = trainingData.has_gv(trainingData.Model2TrainingMap); +model.DrG0_Uncertainty(~model.SIntRxnBool,1)=inf; +%model.DrG0_Uncertainty(model.DrG0_Uncertainty >= 1e3) = 1e10; % Set large uncertainty in reaction energies to inf + + diff --git a/src/analysis/thermo/componentContribution/new/createGroupIncidenceMatrix.m b/src/analysis/thermo/componentContribution/new/createGroupIncidenceMatrix.m deleted file mode 100644 index 7e116e5638..0000000000 --- a/src/analysis/thermo/componentContribution/new/createGroupIncidenceMatrix.m +++ /dev/null @@ -1,176 +0,0 @@ -function trainingModel = createGroupIncidenceMatrix(model, trainingModel, mappingScore, printLevel) -% Initialize `G` matrix, and then use the python script "inchi2gv.py" to decompose each of the -% compounds that has an 'InChI' and save the decomposition as a row in the `G` matrix. -% -% USAGE: -% -% trainingModel = createGroupIncidenceMatrix(model, trainingModel) -% -% INPUTS: -% model: -% model.mets m x 1 metabolite ids -% model.inchi.nonstandard m x 1 cell array of nonstandard InChI -% -% trainingModel: -% trainingModel.S: p x n stoichiometric matrix of training data -% trainingModel.metKEGGID: p x 1 cell array of metabolite KEGGID -% trainingModel.inchi.nonstandard: p x 1 cell array of nonstandard InChI -% trainingModel.Model2TrainingMap: m x 1 mapping of model.mets to training data metabolites -% trainingModel.mappingScore -% -% OUTPUT: -% trainingModel: -% trainingModel.S: k x n stoichiometric matrix of training + test data -% trainingModel.G: k x g group incicence matrix -% trainingModel.groups: g x 1 cell array of group definitions -% trainingModel.trainingMetBool k x 1 boolean indicating training metabolites in G -% trainingModel.testMetBool k x 1 boolean indicating test metabolites in G -% trainingModel.groupDecomposableBool: k x 1 boolean indicating metabolites with group decomposition -% trainingModel.cids_that_dont_decompose: z x 1 ids of compounds that do not decomopose -% - -% dG0: n x 1 standard Gibbs energy -% dG0_prime: n x 1 standard transformed Gibbs energy -% T: n x 1 temperature -% I: n x 1 ionic strength -% pH: n x 1 pH -% pMg: n x 1 pMg -% weights: n x 1 weights -% balance: n x 1 boolean indicating balanced reactions -% -% groupDecomposableBool: m x 1 boolean indicating metabolites with group decomposition -% cids: m x 1 compound ids - -% std_inchi: m x 1 standard InChI -% std_inchi_stereo: m x 1 standard InChI -% std_inchi_stereo_charge: m x 1 standard InChI - -% Ematrix: m x e elemental matrix -% kegg_pKa: [628×1 struct] -% -% G: m x g group incicence matrix -% groups: g x 1 cell array of group definitions -% -% Model2TrainingMap: mlt x 1 mapping of model.mets to training data metabolites -% - -if ~exist('printLevel','var') - printLevel=0; -end - - -fprintf('Creating group incidence matrix\n'); - -% first just run the script to get the list of group names -fullpath = which('getGroupVectorFromInchi.m'); -fullpath = regexprep(fullpath,'getGroupVectorFromInchi.m',''); - - -[status,result] = system('python2 --version'); -if status~=0 - % https://github.com/bdu91/group-contribution/blob/master/compound_groups.py - % Bin Du et al. Temperature-Dependent Estimation of Gibbs Energies Using an Updated Group-Contribution Method - [status,groupsTemp] = system(['python ' fullpath 'compound_groups.py -l']); - if status~=0 - error('createGroupIncidenceMatrix: call to compound_groups.py failed') - end -else - if 1 - inchi2gv = 'inchi2gv'; - else - inchi2gv = 'compound_groups'; - end - [status,groupsTemp] = system(['python2 ' fullpath inchi2gv '.py -l']);%seems to only work with python 2, poor coding to not check the status here! - if status~=0 - fprintf('%s\n','If you get a python error like: undefined symbol: PyFPE_jbuf, then see the following:') - fprintf('%s\n','https://stackoverflow.com/questions/36190757/numpy-undefined-symbol-pyfpe-jbuf/47703373') - error('createGroupIncidenceMatrix: call to inchi2gv.py failed') - end -end - -if isnumeric(trainingModel.cids_that_dont_decompose) - eval(['trainingModel.cids_that_dont_decompose = {' regexprep(sprintf('''C%05d''; ',trainingModel.cids_that_dont_decompose),'(;\s)$','') '};']); -end - -groups = regexp(groupsTemp,'\n','split')'; -clear groupsTemp; -trainingModel.groups = groups(~cellfun(@isempty, groups)); -trainingModel.G = sparse(length(trainingModel.metKEGGID), length(trainingModel.groups)); -trainingModel.groupDecomposableBool = false(size(trainingModel.metKEGGID)); -trainingModel.testMetBool = false(size(trainingModel.metKEGGID)); -for i = 1:length(trainingModel.metKEGGID) - [score, modelRow] = max(full(mappingScore(:,i))); - if score == 0 - inchi = trainingModel.inchi.nonstandard{i}; - else - % if there is a match to the model, use the InChI from there to be consistent with later transforms - inchi = model.inchi.nonstandard{modelRow}; - trainingModel.testMetBool(i)=1; - end - - % There might be compounds in the model but not in the training data that also cannot be - % decomposed, we need to take care of them too (e.g. DMSO - C11143) - if isempty(inchi) || any(ismember(trainingModel.metKEGGID{i}, trainingModel.cids_that_dont_decompose)) - trainingModel.G(:, end+1) = 0; % add a unique 1 in a new column for this undecomposable compound - trainingModel.G(i, end) = 1; - trainingModel.groupDecomposableBool(i) = false; - else - group_def = getGroupVectorFromInchi(inchi); - if length(group_def) == length(trainingModel.groups) - trainingModel.G(i, 1:length(group_def)) = group_def; - trainingModel.groupDecomposableBool(i) = true; - elseif isempty(group_def) - warning(['createGroupIncidenceMatrix: undecomposable inchi: ' inchi]) - trainingModel.G(:, end+1) = 0; % add a unique 1 in a new column for this undecomposable compound - trainingModel.G(i, end) = 1; - trainingModel.groupDecomposableBool(i) = false; - trainingModel.cids_that_dont_decompose = [trainingModel.cids_that_dont_decompose; trainingModel.metKEGGID{i}]; - else - fprintf('InChI = %s\n', inchi); - fprintf('*************\n%s\n', getGroupVectorFromInchi(inchi, printLevel)); - error(sprintf('ERROR: while trying to decompose compound C%05d', trainingModel.metKEGGID{i})); - end - end -end -trainingModel.G = sparse(trainingModel.G); - -trainingModel.Model2TrainingMap = zeros(size(model.mets)); -done = {}; - -for n = 1:length(model.mets) - % first find all metabolites with the same name (can be in different compartments) - met = model.mets{n}(1:end-3); - if any(strcmp(met, done)) % this compound was already mapped - continue; - end - done = [done; {met}]; - metIdx = strmatch([met '['], model.mets); - inchi = model.inchi.nonstandard{n}; - - [score, trainingRow] = max(full(mappingScore(n,:))); - if score == 0 % this compound is not in the training data - trainingRow = size(trainingModel.G, 1) + 1; - trainingModel.S(trainingRow, :) = 0; % Add an empty row to S - trainingModel.testMetBool(i)=1; - % Add a row in G for this compound, either with its group vector, - % or with a unique 1 in a new column dedicated to this compound - trainingModel.G(trainingRow, :) = 0; - group_def = getGroupVectorFromInchi(inchi); - if length(group_def) == length(trainingModel.groups) - trainingModel.G(trainingRow, 1:length(group_def)) = group_def; - trainingModel.groupDecomposableBool(trainingRow) = true; - - elseif isempty(group_def) - trainingModel.G(:, end+1) = 0; % add a unique 1 in a new column for this undecomposable compound - trainingModel.G(trainingRow, end) = 1; - trainingModel.groupDecomposableBool(trainingRow) = false; - else - error('The length of the group vector is different than the number of groups'); - end - end - trainingModel.Model2TrainingMap(metIdx) = trainingRow; % map the model met to this NIST compound -end - -[m,g]=size(trainingModel.G); -trainingModel.trainingMetBool=false(m,1); -trainingModel.trainingMetBool(1:length(trainingModel.metKEGGID),1)=1; \ No newline at end of file diff --git a/src/analysis/thermo/experimentalData/groupContribution/gcmMetList_Ecoli_core.mat b/src/analysis/thermo/experimentalData/groupContribution/gcmMetList_Ecoli_core.mat deleted file mode 100644 index 93ad39bf0e..0000000000 Binary files a/src/analysis/thermo/experimentalData/groupContribution/gcmMetList_Ecoli_core.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/groupContribution/gcmMetList_Recon1.mat b/src/analysis/thermo/experimentalData/groupContribution/gcmMetList_Recon1.mat deleted file mode 100644 index e05b6ea709..0000000000 Binary files a/src/analysis/thermo/experimentalData/groupContribution/gcmMetList_Recon1.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/groupContribution/gcmMetList_iAF1260.mat b/src/analysis/thermo/experimentalData/groupContribution/gcmMetList_iAF1260.mat deleted file mode 100644 index 40dd4f7c3b..0000000000 Binary files a/src/analysis/thermo/experimentalData/groupContribution/gcmMetList_iAF1260.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/groupContribution/jankowskiGroupData.mat b/src/analysis/thermo/experimentalData/groupContribution/jankowskiGroupData.mat deleted file mode 100644 index 28ff79885c..0000000000 Binary files a/src/analysis/thermo/experimentalData/groupContribution/jankowskiGroupData.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/groupContribution/metGroupCont_Ecoli_iAF1260.mat b/src/analysis/thermo/experimentalData/groupContribution/metGroupCont_Ecoli_iAF1260.mat deleted file mode 100644 index 71fc12463a..0000000000 Binary files a/src/analysis/thermo/experimentalData/groupContribution/metGroupCont_Ecoli_iAF1260.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/groupContribution/metGroupCont_ReconX.mat b/src/analysis/thermo/experimentalData/groupContribution/metGroupCont_ReconX.mat deleted file mode 100644 index a500d51f43..0000000000 Binary files a/src/analysis/thermo/experimentalData/groupContribution/metGroupCont_ReconX.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/groupContribution/metSpeciespKa_Recon1.mat b/src/analysis/thermo/experimentalData/groupContribution/metSpeciespKa_Recon1.mat deleted file mode 100644 index d9cce73bee..0000000000 Binary files a/src/analysis/thermo/experimentalData/groupContribution/metSpeciespKa_Recon1.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/reconstructions/Recon1.mat b/src/analysis/thermo/experimentalData/reconstructions/Recon1.mat deleted file mode 100644 index 12087ac8da..0000000000 Binary files a/src/analysis/thermo/experimentalData/reconstructions/Recon1.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/reconstructions/ReconX.mat b/src/analysis/thermo/experimentalData/reconstructions/ReconX.mat deleted file mode 100644 index 0c291a4961..0000000000 Binary files a/src/analysis/thermo/experimentalData/reconstructions/ReconX.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/reconstructions/ecoli_core_xls2model.mat b/src/analysis/thermo/experimentalData/reconstructions/ecoli_core_xls2model.mat deleted file mode 100644 index 7ba52597b3..0000000000 Binary files a/src/analysis/thermo/experimentalData/reconstructions/ecoli_core_xls2model.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/reconstructions/iAF1260_flux1.mat b/src/analysis/thermo/experimentalData/reconstructions/iAF1260_flux1.mat deleted file mode 100644 index bf16c9d5cf..0000000000 Binary files a/src/analysis/thermo/experimentalData/reconstructions/iAF1260_flux1.mat and /dev/null differ diff --git a/src/analysis/thermo/experimentalData/groupContribution/gc_data_Henry.txt b/src/analysis/thermo/groupContribution/jankowski/groupContribution/gc_data_Henry.txt similarity index 100% rename from src/analysis/thermo/experimentalData/groupContribution/gc_data_Henry.txt rename to src/analysis/thermo/groupContribution/jankowski/groupContribution/gc_data_Henry.txt diff --git a/src/analysis/thermo/experimentalData/groupContribution/gc_data_Jankowski.txt b/src/analysis/thermo/groupContribution/jankowski/groupContribution/gc_data_Jankowski.txt similarity index 100% rename from src/analysis/thermo/experimentalData/groupContribution/gc_data_Jankowski.txt rename to src/analysis/thermo/groupContribution/jankowski/groupContribution/gc_data_Jankowski.txt diff --git a/src/analysis/thermo/experimentalData/groupContribution/gcmOutputFile_Ecoli_core.txt b/src/analysis/thermo/groupContribution/jankowski/groupContribution/gcmOutputFile_Ecoli_core.txt similarity index 100% rename from src/analysis/thermo/experimentalData/groupContribution/gcmOutputFile_Ecoli_core.txt rename to src/analysis/thermo/groupContribution/jankowski/groupContribution/gcmOutputFile_Ecoli_core.txt diff --git a/src/analysis/thermo/experimentalData/groupContribution/gcmOutputFile_Recon1.txt b/src/analysis/thermo/groupContribution/jankowski/groupContribution/gcmOutputFile_Recon1.txt similarity index 100% rename from src/analysis/thermo/experimentalData/groupContribution/gcmOutputFile_Recon1.txt rename to src/analysis/thermo/groupContribution/jankowski/groupContribution/gcmOutputFile_Recon1.txt diff --git a/src/analysis/thermo/experimentalData/groupContribution/gcmOutputFile_iAF1260.txt b/src/analysis/thermo/groupContribution/jankowski/groupContribution/gcmOutputFile_iAF1260.txt similarity index 100% rename from src/analysis/thermo/experimentalData/groupContribution/gcmOutputFile_iAF1260.txt rename to src/analysis/thermo/groupContribution/jankowski/groupContribution/gcmOutputFile_iAF1260.txt diff --git a/src/analysis/thermo/groupContribution/plotConcVSdGft0GroupContUncertainty.m b/src/analysis/thermo/groupContribution/jankowski/plotConcVSdGft0GroupContUncertainty.m similarity index 100% rename from src/analysis/thermo/groupContribution/plotConcVSdGft0GroupContUncertainty.m rename to src/analysis/thermo/groupContribution/jankowski/plotConcVSdGft0GroupContUncertainty.m diff --git a/src/analysis/thermo/groupContribution/jankowski/setupComponentContribution.m b/src/analysis/thermo/groupContribution/jankowski/setupComponentContribution.m new file mode 100644 index 0000000000..60f500c6a1 --- /dev/null +++ b/src/analysis/thermo/groupContribution/jankowski/setupComponentContribution.m @@ -0,0 +1,132 @@ +function model = setupComponentContribution(model,molFileDir,cid,printLevel) +% Estimates standard transformed reaction Gibbs energy and directionality +% at in vivo conditions in multicompartmental metabolic reconstructions. +% Has external dependencies on the COBRA toolbox, the component +% contribution method, Python (with numpy and Open Babel bindings), +% ChemAxon's Calculator Plugins, and Open Babel. See details on +% availability at the end of help text. +% +% modelT = setupThermoModel(model,molfileDir,cid,T,cellCompartments,ph,... +% is,chi,concMin,concMax,confidenceLevel) +% +% INPUTS +% model Model structure with following fields: +% .S m x n stoichiometric matrix. +% .mets m x 1 array of metabolite identifiers. +% .rxns n x 1 array of reaction identifiers. +% .metFormulas m x 1 cell array of metabolite formulas. Formulas for +% protons should be H, and formulas for water should be +% H2O. +% .metCharges m x 1 numerical array of metabolite charges. +% +% OPTIONAL INPUTS +% molFileDir Path to a directory containing molfiles for the +% major tautomer of the major microspecies of +% each metabolite at pH 7. Molfiles should be +% named with the metabolite identifiers in +% model.mets (without compartment assignments). +% Not required if cid are specified. +% cid m x 1 cell array of KEGG Compound identifiers. +% Not required if molfiledir is specified. +% model.metCompartments m x 1 array of metabolite compartment +% assignments. Not required if metabolite +% identifiers are strings of the format ID[*] +% where * is the appropriate compartment +% identifier. +% +% OUTPUTS +% model Model structure with following additional fields: +% .inchi Structure containing four m x 1 cell array's of +% IUPAC InChI strings for metabolites, with varying +% levels of structural detail. +% .pKa m x 1 structure containing metabolite pKa values +% estimated with ChemAxon's Calculator Plugins. +% .pseudoisomers p x 4 matrix with the following columns: +% 1. Metabolite index. +% 2. Estimated pseudoisomer standard Gibbs energy. +% 3. Number of hydrogen atoms in pseudoisomer +% chemical formula. +% 4. Charge on pseudoisomer. +% +% WRITTEN OUTPUTS +% MetStructures.sdf An SDF containing all structures input to the +% component contribution method for estimation of +% standard Gibbs energies. +% +% +% Ronan M. T. Fleming, Sept. 2012 Version 1.0 +% Hulda S. H., Dec. 2012 Version 2.0 + + +%% Configure inputs +% Retreive molfiles from KEGG if KEGG ID are given. Otherwise use molfiles +% in molfileDir. +if ~exist('cid','var') + cid = []; +end +if ~exist('printLevel','var') + printLevel = 1; +end +%% Get metabolite structures +if ~isempty(cid) + molFileDir = 'molfilesFromKegg'; + fprintf('\nRetreiving molfiles from KEGG.\n'); + takeMajorMS = true; % Convert molfile from KEGG to major tautomer of major microspecies at pH 7 + pH = 7; + takeMajorTaut = true; + kegg2mol(cid,molFileDir,model.mets,takeMajorMS,pH,takeMajorTaut); % Retreive mol files +end + +if printLevel>0 +fprintf('Creating MetStructures.sdf from molfiles.\n') +end + +sdfFileName = 'MetStructures.sdf'; +includeRs = 0; % Do not include structures with R groups in SDF +[sdfMetList,noMolMetList] = mol2sdf(model.mets,molFileDir,sdfFileName,includeRs); + +if printLevel>0 +fprintf('Converting SDF to InChI strings.\n') +end +model.inchi = createInChIStruct(model.mets,sdfFileName); +compositeBool = ~cellfun('isempty',regexp(model.inchi.nonstandard,'\.')); % Remove InChI for composite compounds as they cause problems later. +model.inchi.standard(compositeBool) = cell(sum(compositeBool),1); +model.inchi.standardWithStereo(compositeBool) = cell(sum(compositeBool),1); +model.inchi.standardWithStereoAndCharge(compositeBool) = cell(sum(compositeBool),1); +model.inchi.nonstandard(compositeBool) = cell(sum(compositeBool),1); + +%% Estimate metabolite pKa values with ChemAxon calculator plugins and determine all relevant pseudoisomers. +if printLevel>0 +fprintf('Estimating metabolite pKa values.\n'); +end +npKas = 20; % Number of acidic and basic pKa values to estimate +takeMajorTaut = false; % Estimate pKa for input tautomer. Input tautomer is assumed to be the major tautomer for the major microspecies at pH 7. +model.pseudoisomers = estimate_pKa(model.mets,model.inchi.nonstandard,npKas,takeMajorTaut); % Estimate pKa and determine pseudoisomers +model.pseudoisomers = rmfield(model.pseudoisomers,'met'); + +% Add number of hydrogens and charge for metabolites with no InChI +if any(~[model.pseudoisomers.success]) && printLevel>0 + fprintf('Assuming that metabolite species in model.metFormulas are representative for metabolites where pKa could not be estimated.\n'); +end +nonphysicalMetSpecies = {}; +for i = 1:length(model.mets) + model_z = model.metCharges(i); % Get charge from model + model_nH = numAtomsOfElementInFormula(model.metFormulas{i},'H'); % Get number of hydrogens from metabolite formula in model + if ~model.pseudoisomers(i).success + model.pseudoisomers(i).zs = model_z; + model.pseudoisomers(i).nHs = model_nH; + model.pseudoisomers(i).majorMSpH7 = true; % Assume species in model is the major (and only) metabolite species %RF: this seems dubious + end + if ~any(model.pseudoisomers(i).nHs == model_nH) + nonphysicalMetSpecies = [nonphysicalMetSpecies; model.mets(i)]; + end +end +if ~isempty(nonphysicalMetSpecies) + nonphysicalMetSpecies = unique(regexprep(nonphysicalMetSpecies,'\[\w\]','')); + if printLevel>1 + fprintf('%s\n','#H in model.metFormulas does not match any of the species calculated mol file for metabolites:') + for n=1:length(nonphysicalMetSpecies) + fprintf('%s\n',nonphysicalMetSpecies{n});%,model.metFormulas{m}); + end + end +end diff --git a/src/analysis/thermo/groupContribution/new/createGroupIncidenceMatrix.m b/src/analysis/thermo/groupContribution/new/createGroupIncidenceMatrix.m index 7e116e5638..665bf5bc1f 100644 --- a/src/analysis/thermo/groupContribution/new/createGroupIncidenceMatrix.m +++ b/src/analysis/thermo/groupContribution/new/createGroupIncidenceMatrix.m @@ -1,6 +1,4 @@ -function trainingModel = createGroupIncidenceMatrix(model, trainingModel, mappingScore, printLevel) -% Initialize `G` matrix, and then use the python script "inchi2gv.py" to decompose each of the -% compounds that has an 'InChI' and save the decomposition as a row in the `G` matrix. +function combinedModel = createGroupIncidenceMatrix(model, trainingModel, param) % % USAGE: % @@ -15,19 +13,306 @@ % trainingModel.S: p x n stoichiometric matrix of training data % trainingModel.metKEGGID: p x 1 cell array of metabolite KEGGID % trainingModel.inchi.nonstandard: p x 1 cell array of nonstandard InChI -% trainingModel.Model2TrainingMap: m x 1 mapping of model.mets to training data metabolites -% trainingModel.mappingScore +% trainingModel.test2CombinedModelMap: m x 1 mapping of model.mets to training data metabolites +% trainingModel.mappingScore % % OUTPUT: -% trainingModel: -% trainingModel.S: k x n stoichiometric matrix of training + test data -% trainingModel.G: k x g group incicence matrix -% trainingModel.groups: g x 1 cell array of group definitions -% trainingModel.trainingMetBool k x 1 boolean indicating training metabolites in G -% trainingModel.testMetBool k x 1 boolean indicating test metabolites in G -% trainingModel.groupDecomposableBool: k x 1 boolean indicating metabolites with group decomposition -% trainingModel.cids_that_dont_decompose: z x 1 ids of compounds that do not decomopose -% +% combinedModel: +% combinedModel.S: k x n stoichiometric matrix of training padded with zero rows for metabolites exclusive to test data +% combinedModel.G: k x g group incicence matrix +% combinedModel.groups: g x 1 cell array of group definitions +% combinedModel.trainingMetBool k x 1 boolean indicating training metabolites in G +% combinedModel.testMetBool k x 1 boolean indicating test metabolites in G +% combinedModel.groupDecomposableBool: k x 1 boolean indicating metabolites with group decomposition +% combinedModel.inchiBool k x 1 boolean indicating metabolites with inchi + +% combinedModel.cids_that_dont_decompose: z x 1 ids of compounds that do not decomopose + +% + +if isempty(model) + model.inchi.nonstandard=[]; +end +if isempty(trainingModel) + trainingModel.inchi.nonstandard=[]; +end + +if ~exist('param','var') + param=struct(); +end +if ~isfield(param,'printLevel') + param.printLevel=0; +end + +%parameters for auto fragmentation +if ~isfield(param,'fragmentationMethod') + param.fragmentationMethod='abinito'; +end +if ~isfield(param,'modelCache') + param.modelCache=[]; +end +if ~isfield(param,'printLevel') + param.printLevel=0; +end +if ~isfield(param,'radius') + param.radius=1; +end +if ~isfield(param,'dGPredictorPath') + param.dGPredictorPath='/home/rfleming/work/sbgCloud/code/dGPredictor'; +end +if ~isfield(param,'canonicalise') + param.canonicalise=0; +end + +fprintf('Creating group incidence matrix\n'); + +switch param.fragmentationMethod + case 'abinito' + %function model = createFragmentIncidenceMatrix(inchi,radius,dGPredictorPath,canonicalise) + % model.G: k x g fragment incidence matrix + + + + %fragment each of the trainingModel inchi + if param.printLevel>0 + fprintf('%s\n','Ab inito fragmentation of each of the trainingModel inchi...') + end + trainingModelInchi=trainingModel.inchi.nonstandard; + [trainingModelFragmentedMol,trainingModelDecomposableBool,trainingModelInchiExistBool] = autoFragment(trainingModelInchi,param.radius,param.dGPredictorPath,param.canonicalise,'autoFragment_trainingModel',param.printLevel-1); + if param.printLevel>0 + fprintf('%s\n','...done.') + end + + %fragment each of the model inchi + if param.printLevel>0 + fprintf('%s\n','Ab inito fragmentation of each of the model inchi...') + end + modelInchi=model.inchi.nonstandard; + [modelFragmentedMol,modelDecomposableBool,modelInchiExistBool] = autoFragment(modelInchi,param.radius,param.dGPredictorPath,param.canonicalise,param.modelCache,param.printLevel-1); + if param.printLevel>0 + fprintf('%s\n','...done.') + end + + + + nTrainingModelMets=length(trainingModelFragmentedMol); + nModelMets=length(modelFragmentedMol); + + trainingFragmentSmiles = cell(0); + %collate the fragments in the training model + for i = 1:nTrainingModelMets + if trainingModelDecomposableBool(i) + if param.printLevel>1 + disp(trainingModelFragmentedMol(i).inchi) + trainingModelFragmentedMol(i).smilesCounts + end + if trainingModelInchiExistBool(i) + if isempty(trainingModelFragmentedMol(i).inchi) + trainingModelDecomposableBool(i)=0; + trainingModelInchiExistBool(i)=0; + else + trainingFragmentSmiles = [trainingFragmentSmiles;trainingModelFragmentedMol(i).smilesCounts.keys']; + end + else + trainingModelDecomposableBool(i)=0; + end + end + end + %set of unique fragments in the training model + uniqueTrainingFragmentSmiles = unique(trainingFragmentSmiles); + + testFragmentSmiles = cell(0); + %now the model mol + for i = 1:nModelMets + if modelDecomposableBool(i) + if param.printLevel>1 + disp(modelFragmentedMol(i).inchi) + modelFragmentedMol(i).smilesCounts + end + if modelInchiExistBool(i) + if isempty(modelFragmentedMol(i).inchi) + modelDecomposableBool(i)=0; + modelInchiExistBool(i)=0; + else + testFragmentSmiles = [testFragmentSmiles;modelFragmentedMol(i).smilesCounts.keys']; + end + else + modelDecomposableBool(i)=0; + end + end + end + %set of unique fragments in the test model + uniqueTestFragmentSmiles = unique(testFragmentSmiles); + + fragmentSmilesUniqueToTraining = setdiff(uniqueTrainingFragmentSmiles,uniqueTestFragmentSmiles); + if ~isempty(fragmentSmilesUniqueToTraining) + fprintf('%s\n',['There are ' int2str(length(fragmentSmilesUniqueToTraining)) ' fragments unique to the training model.']) + end + fragmentSmilesInCommon = intersect(uniqueTestFragmentSmiles,uniqueTrainingFragmentSmiles); + if ~isempty(fragmentSmilesInCommon) + fprintf('%s\n',['There are ' int2str(length(fragmentSmilesInCommon)) ' fragments in common between the training and test models.']) + end + fragmentSmilesUniqueToTest = setdiff(uniqueTestFragmentSmiles,uniqueTrainingFragmentSmiles); + if ~isempty(fragmentSmilesUniqueToTest) + fprintf('%s\n',['There are ' int2str(length(fragmentSmilesUniqueToTest)) ' fragments unique to the test model.']) + end + + %start based on training model + combinedModel = trainingModel; + + % combinedModel.groupDecomposableBool: k x 1 boolean indicating metabolites with group decomposition + combinedModel.groupDecomposableBool=[trainingModelDecomposableBool;modelDecomposableBool]; + combinedModel.inchiBool = [trainingModelInchiExistBool;modelInchiExistBool]; + % combinedModel.trainingMetBool k x 1 boolean indicating training metabolites in G + combinedModel.trainingMetBool = [true(nTrainingModelMets,1);false(nModelMets,1)]; + % combinedModel.testMetBool k x 1 boolean indicating test metabolites in G + combinedModel.testMetBool = [false(nTrainingModelMets,1);true(nModelMets,1)]; + + %fragments unique to the combined model + uniqueFragmentSmiles = unique([uniqueTrainingFragmentSmiles;uniqueTestFragmentSmiles]); + nFrag=length(uniqueFragmentSmiles); + nNonDecomposable=nnz(combinedModel.groupDecomposableBool==0); + + combinedModel.inchi.nonstandard = [trainingModelInchi;modelInchi]; + + nMets = nTrainingModelMets + nModelMets; + %preallocate the group incidence matrix + combinedModel.G = sparse(nMets,nFrag+nNonDecomposable); + + %use the keys to define the groups + combinedModel.groups = [uniqueFragmentSmiles;trainingModel.inchi.nonstandard(~trainingModelDecomposableBool);model.inchi.nonstandard(~modelDecomposableBool)]; + + %map each of the training model fragments to the consolidated list of fragments + d=1; + for i = 1:nTrainingModelMets + if trainingModelDecomposableBool(i) + bool = isKey(trainingModelFragmentedMol(i).smilesCounts,uniqueFragmentSmiles); + combinedModel.G(i,bool)=cell2mat(values(trainingModelFragmentedMol(i).smilesCounts)); + else + %non decomposable training molecule + combinedModel.G(i,nFrag+d) = 1; + d=d+1; + end + end + %map each of the test model fragments to the consolidated list of fragments + for i = 1:nModelMets + if modelDecomposableBool(i) + bool = isKey(modelFragmentedMol(i).smilesCounts,uniqueFragmentSmiles); + combinedModel.G(nTrainingModelMets+i,bool)=cell2mat(values(modelFragmentedMol(i).smilesCounts)); + else + if d>nNonDecomposable + error('inconsistent number of non-decomposable metabolites') + end + %non decomposable training molecule + combinedModel.G(nTrainingModelMets+i,nFrag+d) = 1; + d=d+1; + end + end + if d~=nNonDecomposable+1 + error('inconsistent number of non-decomposable metabolites') + end + + nExclusivelyTestMets = nnz(~combinedModel.trainingMetBool & combinedModel.testMetBool); + combinedModel.S = [trainingModel.S; sparse(nExclusivelyTestMets,size(trainingModel.S,2))]; % Add an empty row to S + combinedModel.mets=[trainingModel.mets;model.mets]; + combinedModel.rxns=trainingModel.rxns; + + uniqueMets = unique(combinedModel.mets); + if length(uniqueMets)~=length(combinedModel.mets) + error('combinedModel.mets is not a primary key') + end + if any(cellfun(@isempty,combinedModel.mets)) + error('combinedModel.mets is not a primary key') + end + + if 0 + save('debug_prior_to_regulariseGroupIncidenceMatrix') + + %analyse similar and duplicate metabolites + [groupM,inchiM] = regulariseGroupIncidenceMatrix(combinedModel,param.printLevel); + + %assume that metabolites with the same group decomposition are identical + test2CombinedModelM = groupM; + + %ignore duplicates within the training metabolite set + test2CombinedModelM(:,combinedModel.trainingMetBool)=0; + + %boolean identifier of duplicates + duplicatesBool = any(test2CombinedModelM,1); + + %add the test metabolites on the diagonal to preserve mapping to unique metabolites in test model + test2CombinedModelM = test2CombinedModelM + diag(combinedModel.testMetBool); + + %remove all duplicate metabolites from the arguments to the map + test2CombinedModelM = test2CombinedModelM(~duplicatesBool,:); + + combinedModel.test2CombinedModelMap=zeros(nModelMets,1); + for i=1:size(test2CombinedModelM,1) + if any(test2CombinedModelM(i,:)) + combinedModel.test2CombinedModelMap(test2CombinedModelM(i,combinedModel.testMetBool)~=0)=i; + end + end + if any(combinedModel.test2CombinedModelMap==0) + error('Mismatch in combinedModel.test2CombinedModelMap') + end + + % S: [6507×4149 double] + % rxns: {4149×1 cell} + % lb: [4149×1 double] + % cids: {672×1 cell} + % dG0_prime: [4149×1 double] + % T: [4149×1 double] + % I: [4149×1 double] + % pH: [4149×1 double] + % pMg: [4149×1 double] + % weights: [4149×1 double] + % balance: [4149×1 double] + % cids_that_dont_decompose: [43×1 double] + % mets: {6507×1 cell} + % metKEGGID: {672×1 cell} + % inchi: [1×1 struct] + % molBool: [672×1 logical] + % inchiBool: [6507×1 logical] + % compositeInchiBool: [672×1 logical] + % metFormulas: {672×1 cell} + % metCharges: [672×1 double] + % pseudoisomers: [672×1 struct] + % ub: [4149×1 double] + % dG0: [4149×1 double] + % groupDecomposableBool: [6507×1 logical] + % trainingMetBool: [6507×1 logical] + % testMetBool: [6507×1 logical] + % G: [6507×1536 double] + % groups: {1536×1 cell} + % test2CombinedModelMap: [5835×1 double] + + %save the original combined model + combinedModelOld = combinedModel; + clear combinedModel; + + %each row of the group incidence matrix should correspond to a unique metabolite + %account for any metabolites in the test dataset that are duplicated in the training dataset + combinedModel.S = combinedModelOld.S(~duplicatesBool,:); + combinedModel.mets = combinedModelOld.mets(~duplicatesBool); + combinedModel.inchi.nonstandard = combinedModelOld.inchi.nonstandard(~duplicatesBool); + combinedModel.inchiBool = combinedModelOld.inchiBool(~duplicatesBool); + combinedModel.groupDecomposableBool = combinedModelOld.groupDecomposableBool(~duplicatesBool); + combinedModel.trainingMetBool = combinedModelOld.trainingMetBool(~duplicatesBool); + combinedModel.testMetBool = combinedModelOld.testMetBool(~duplicatesBool); + combinedModel.rxns = combinedModelOld.rxns; + combinedModel.dG0 = combinedModelOld.dG0; + combinedModel.T = combinedModelOld.T; + combinedModel.pH = combinedModelOld.pH; + combinedModel.pMg = combinedModelOld.pMg; + combinedModel.I = combinedModelOld.I; + combinedModel.G = combinedModelOld.G(~duplicatesBool,:); + combinedModel.groups = combinedModelOld.groups; + combinedModel.test2CombinedModelMap = combinedModelOld.test2CombinedModelMap; + else + combinedModel.test2CombinedModelMap = (1:nModelMets)' + nTrainingModelMets; + end + case 'manual' + % % dG0: n x 1 standard Gibbs energy % dG0_prime: n x 1 standard transformed Gibbs energy @@ -51,126 +336,142 @@ % G: m x g group incicence matrix % groups: g x 1 cell array of group definitions % -% Model2TrainingMap: mlt x 1 mapping of model.mets to training data metabolites -% - -if ~exist('printLevel','var') - printLevel=0; -end - +% test2CombinedModelMap: mlt x 1 mapping of model.mets to training data metabolites -fprintf('Creating group incidence matrix\n'); - -% first just run the script to get the list of group names -fullpath = which('getGroupVectorFromInchi.m'); -fullpath = regexprep(fullpath,'getGroupVectorFromInchi.m',''); - - -[status,result] = system('python2 --version'); -if status~=0 - % https://github.com/bdu91/group-contribution/blob/master/compound_groups.py - % Bin Du et al. Temperature-Dependent Estimation of Gibbs Energies Using an Updated Group-Contribution Method - [status,groupsTemp] = system(['python ' fullpath 'compound_groups.py -l']); - if status~=0 - error('createGroupIncidenceMatrix: call to compound_groups.py failed') - end -else - if 1 - inchi2gv = 'inchi2gv'; - else - inchi2gv = 'compound_groups'; - end - [status,groupsTemp] = system(['python2 ' fullpath inchi2gv '.py -l']);%seems to only work with python 2, poor coding to not check the status here! - if status~=0 - fprintf('%s\n','If you get a python error like: undefined symbol: PyFPE_jbuf, then see the following:') - fprintf('%s\n','https://stackoverflow.com/questions/36190757/numpy-undefined-symbol-pyfpe-jbuf/47703373') - error('createGroupIncidenceMatrix: call to inchi2gv.py failed') - end -end + % Initialize `G` matrix, and then use the python script "inchi2gv.py" to decompose each of the + % compounds that has an 'InChI' and save the decomposition as a row in the `G` matrix. -if isnumeric(trainingModel.cids_that_dont_decompose) - eval(['trainingModel.cids_that_dont_decompose = {' regexprep(sprintf('''C%05d''; ',trainingModel.cids_that_dont_decompose),'(;\s)$','') '};']); -end + %Match between the metabolites in the model and the metabolites in the training model + mappingScore = getMappingScores(model, trainingModel); -groups = regexp(groupsTemp,'\n','split')'; -clear groupsTemp; -trainingModel.groups = groups(~cellfun(@isempty, groups)); -trainingModel.G = sparse(length(trainingModel.metKEGGID), length(trainingModel.groups)); -trainingModel.groupDecomposableBool = false(size(trainingModel.metKEGGID)); -trainingModel.testMetBool = false(size(trainingModel.metKEGGID)); -for i = 1:length(trainingModel.metKEGGID) - [score, modelRow] = max(full(mappingScore(:,i))); - if score == 0 - inchi = trainingModel.inchi.nonstandard{i}; - else - % if there is a match to the model, use the InChI from there to be consistent with later transforms - inchi = model.inchi.nonstandard{modelRow}; - trainingModel.testMetBool(i)=1; - end - - % There might be compounds in the model but not in the training data that also cannot be - % decomposed, we need to take care of them too (e.g. DMSO - C11143) - if isempty(inchi) || any(ismember(trainingModel.metKEGGID{i}, trainingModel.cids_that_dont_decompose)) - trainingModel.G(:, end+1) = 0; % add a unique 1 in a new column for this undecomposable compound - trainingModel.G(i, end) = 1; - trainingModel.groupDecomposableBool(i) = false; - else - group_def = getGroupVectorFromInchi(inchi); - if length(group_def) == length(trainingModel.groups) - trainingModel.G(i, 1:length(group_def)) = group_def; - trainingModel.groupDecomposableBool(i) = true; - elseif isempty(group_def) - warning(['createGroupIncidenceMatrix: undecomposable inchi: ' inchi]) - trainingModel.G(:, end+1) = 0; % add a unique 1 in a new column for this undecomposable compound - trainingModel.G(i, end) = 1; - trainingModel.groupDecomposableBool(i) = false; - trainingModel.cids_that_dont_decompose = [trainingModel.cids_that_dont_decompose; trainingModel.metKEGGID{i}]; + % first just run the script to get the list of group names + fullpath = which('getGroupVectorFromInchi.m'); + fullpath = regexprep(fullpath,'getGroupVectorFromInchi.m',''); + + + [status,result] = system('python2 --version'); + if status~=0 + % https://github.com/bdu91/group-contribution/blob/master/compound_groups.py + % Bin Du et al. Temperature-Dependent Estimation of Gibbs Energies Using an Updated Group-Contribution Method + [status,groupsTemp] = system(['python ' fullpath 'compound_groups.py -l']); + if status~=0 + error('createGroupIncidenceMatrix: call to compound_groups.py failed') + end else - fprintf('InChI = %s\n', inchi); - fprintf('*************\n%s\n', getGroupVectorFromInchi(inchi, printLevel)); - error(sprintf('ERROR: while trying to decompose compound C%05d', trainingModel.metKEGGID{i})); + if 1 + inchi2gv = 'inchi2gv'; + else + inchi2gv = 'compound_groups'; + end + [status,groupsTemp] = system(['python2 ' fullpath inchi2gv '.py -l']);%seems to only work with python 2, poor coding to not check the status here! + if status~=0 + fprintf('%s\n','If you get a python error like: undefined symbol: PyFPE_jbuf, then see the following:') + fprintf('%s\n','https://stackoverflow.com/questions/36190757/numpy-undefined-symbol-pyfpe-jbuf/47703373') + error('createGroupIncidenceMatrix: call to inchi2gv.py failed') + end end - end -end -trainingModel.G = sparse(trainingModel.G); - -trainingModel.Model2TrainingMap = zeros(size(model.mets)); -done = {}; - -for n = 1:length(model.mets) - % first find all metabolites with the same name (can be in different compartments) - met = model.mets{n}(1:end-3); - if any(strcmp(met, done)) % this compound was already mapped - continue; - end - done = [done; {met}]; - metIdx = strmatch([met '['], model.mets); - inchi = model.inchi.nonstandard{n}; - - [score, trainingRow] = max(full(mappingScore(n,:))); - if score == 0 % this compound is not in the training data - trainingRow = size(trainingModel.G, 1) + 1; - trainingModel.S(trainingRow, :) = 0; % Add an empty row to S - trainingModel.testMetBool(i)=1; - % Add a row in G for this compound, either with its group vector, - % or with a unique 1 in a new column dedicated to this compound - trainingModel.G(trainingRow, :) = 0; - group_def = getGroupVectorFromInchi(inchi); - if length(group_def) == length(trainingModel.groups) - trainingModel.G(trainingRow, 1:length(group_def)) = group_def; - trainingModel.groupDecomposableBool(trainingRow) = true; + + if isnumeric(trainingModel.cids_that_dont_decompose) + eval(['trainingModel.cids_that_dont_decompose = {' regexprep(sprintf('''C%05d''; ',trainingModel.cids_that_dont_decompose),'(;\s)$','') '};']); + end + + groups = regexp(groupsTemp,'\n','split')'; + clear groupsTemp; + trainingModel.groups = groups(~cellfun(@isempty, groups)); + trainingModel.G = sparse(length(trainingModel.metKEGGID), length(trainingModel.groups)); + trainingModel.groupDecomposableBool = false(size(trainingModel.metKEGGID)); + trainingModel.testMetBool = false(size(trainingModel.metKEGGID)); + trainingModel.trainingMetBool = false(size(trainingModel.metKEGGID)); + for i = 1:length(trainingModel.metKEGGID) + trainingModel.trainingMetBool(i)=1; + [score, modelRow] = max(full(mappingScore(:,i))); + if score == 0 + inchi = trainingModel.inchi.nonstandard{i}; + trainingModel.testMetBool(i)=0; + + else + % if there is a match to the model, use the InChI from there to be consistent with later transforms + inchi = model.inchi.nonstandard{modelRow}; + trainingModel.testMetBool(i)=1; + end - elseif isempty(group_def) - trainingModel.G(:, end+1) = 0; % add a unique 1 in a new column for this undecomposable compound - trainingModel.G(trainingRow, end) = 1; - trainingModel.groupDecomposableBool(trainingRow) = false; - else - error('The length of the group vector is different than the number of groups'); + % There might be compounds in the model but not in the training data that also cannot be + % decomposed, we need to take care of them too (e.g. DMSO - C11143) + if isempty(inchi) || any(ismember(trainingModel.metKEGGID{i}, trainingModel.cids_that_dont_decompose)) + trainingModel.G(:, end+1) = 0; % add a unique 1 in a new column for this undecomposable compound + trainingModel.G(i, end) = 1; + trainingModel.groupDecomposableBool(i) = false; + else + group_def = getGroupVectorFromInchi(inchi); + if length(group_def) == length(trainingModel.groups) + trainingModel.G(i, 1:length(group_def)) = group_def; + trainingModel.groupDecomposableBool(i) = true; + elseif isempty(group_def) + warning(['createGroupIncidenceMatrix: undecomposable inchi: ' inchi]) + trainingModel.G(:, end+1) = 0; % add a unique 1 in a new column for this undecomposable compound + trainingModel.G(i, end) = 1; + trainingModel.groupDecomposableBool(i) = false; + trainingModel.cids_that_dont_decompose = [trainingModel.cids_that_dont_decompose; trainingModel.metKEGGID{i}]; + else + fprintf('InChI = %s\n', inchi); + fprintf('*************\n%s\n', getGroupVectorFromInchi(inchi, param.printLevel)); + error(sprintf('ERROR: while trying to decompose compound C%05d', trainingModel.metKEGGID{i})); + end + end end - end - trainingModel.Model2TrainingMap(metIdx) = trainingRow; % map the model met to this NIST compound + trainingModel.G = sparse(trainingModel.G); + + + trainingModel.test2CombinedModelMap = zeros(size(model.mets)); + done = {}; + for n = 1:length(model.mets) + % first find all metabolites with the same name (can be in different compartments) + met = model.mets{n}(1:end-3); + if any(strcmp(met, done)) % this compound was already mapped + continue; + end + done = [done; {met}]; + + inchi = model.inchi.nonstandard{n}; + + [score, trainingRow] = max(full(mappingScore(n,:))); + if score == 0 % this compound is not in the training data + trainingRow = size(trainingModel.G, 1) + 1; + trainingModel.trainingMetBool(trainingRow)=1; + trainingModel.S(trainingRow, :) = 0; % Add an empty row to S + + % Add a row in G for this compound, either with its group vector, + % or with a unique 1 in a new column dedicate to this compound + trainingModel.G(trainingRow, :) = 0; + group_def = getGroupVectorFromInchi(inchi); + if length(group_def) == length(trainingModel.groups) + trainingModel.G(trainingRow, 1:length(group_def)) = group_def; + trainingModel.groupDecomposableBool(trainingRow) = true; + elseif isempty(group_def) + trainingModel.G(:, end+1) = 0; % add a unique 1 in a new column for this undecomposable compound + trainingModel.G(trainingRow, end) = 1; + trainingModel.groupDecomposableBool(trainingRow) = false; + else + error('The length of the group vector is different from the number of groups'); + end + end + + metIdx = contains(model.mets,[met '[']); + trainingModel.test2CombinedModelMap(metIdx) = trainingRow; % map the model met to this NIST compound + end + %new variable name for combined model + combinedModel = trainingModel; + otherwise + error(['Unrecognised param.fragmentationMethod =' param.fragmentationMethod]) end -[m,g]=size(trainingModel.G); -trainingModel.trainingMetBool=false(m,1); -trainingModel.trainingMetBool(1:length(trainingModel.metKEGGID),1)=1; \ No newline at end of file +boolGroup=~any(combinedModel.G,1); +if any(boolGroup) + error([int2str(nnz(boolGroup)) ' groups without any corresponding metabolite']) +end +boolMet=~any(combinedModel.G,2); +if any(boolMet) + error([int2str(nnz(boolMet)) ' metabolites without any corresponding group']) +end + + diff --git a/src/analysis/thermo/componentContribution/new/getMappingScores.m b/src/analysis/thermo/groupContribution/new/getMappingScores.m similarity index 100% rename from src/analysis/thermo/componentContribution/new/getMappingScores.m rename to src/analysis/thermo/groupContribution/new/getMappingScores.m diff --git a/src/analysis/thermo/groupContribution/new/regulariseGroupIncidenceMatrix.m b/src/analysis/thermo/groupContribution/new/regulariseGroupIncidenceMatrix.m new file mode 100644 index 0000000000..9ed7074c1f --- /dev/null +++ b/src/analysis/thermo/groupContribution/new/regulariseGroupIncidenceMatrix.m @@ -0,0 +1,95 @@ +function [groupM,inchiM] = regulariseGroupIncidenceMatrix(combinedModel,printLevel) +% within the combinedModel analyse the similar metabolites (having the same group decomposition vector) and the duplicates (also the same InChI) +% +% INPUT +% combinedModel +% printLevel +% +% OUTPUT +% groupM nMet xnTrainingMet x nTrainingMet logical matrix, true if metabolite is a duplicate +% inchiM nTrainingMet x nModelMet logical matrix, true if metabolite is a duplicate + +if~exist('printLevel','var') + printLevel=0; +end + +[nMets,nGroups]=size(combinedModel.G); + +%omit duplicate test metabolites defined as having the same group decomposition +[groupM,groupDuplicateBool,~,groupIA,groupIC] = duplicates(combinedModel.G); + +%add unique numbers instead of empty inchi +inchiApprox=combinedModel.inchi.nonstandard; +inchiApprox(~combinedModel.inchiBool)=cellfun(@int2str,num2cell((1:nnz(~combinedModel.inchiBool))'),'UniformOutput',0); +[inchiM,inchiDuplicateBool,~,inchiIA,inchiIC] = duplicates(inchiApprox); + +% combinedModel.trainingMetBool k x 1 boolean indicating training metabolites in G +nTrainingModelMets = nnz(combinedModel.trainingMetBool); +% combinedModel.testMetBool k x 1 boolean indicating test metabolites in G +nModelMets = nnz(combinedModel.testMetBool); + +printParent=1; +for i=1:nMets + if ~(groupDuplicateBool(i) || inchiDuplicateBool(i)) + duplicateInd=find(groupM(i,:) | inchiM(i,:)); + for k=1:length(duplicateInd) + j=duplicateInd(k); + %duplicates within the training set + if combinedModel.trainingMetBool(i) && combinedModel.trainingMetBool(j) + if strcmp(inchiApprox{i},inchiApprox{j}) + else + % D-Fructose 6-phosphate + % t*C00085 InChI=1/C6H13O9P/c7-2-6(10)5(9)4(8)3(15-6)1-14-16(11,12)13/h3-5,7-10H,1-2H2,(H2,11,12,13)/p-2/t3-,4-,5+,6?/m1/s1/fC6H11O9P/q-2 + % D-Fructose 1-phosphate + % t C01094 InChI=1/C6H13O9P/c7-1-3-4(8)5(9)6(10,15-3)2-14-16(11,12)13/h3-5,7-10H,1-2H2,(H2,11,12,13)/p-2/t3-,4-,5+,6?/m1/s1/fC6H11O9P/q-2 + if printLevel>0 && printParent + fprintf('%-20s%s\n',['train*' combinedModel.mets{i}],inchiApprox{i}) + printParent=0; + end + if printLevel>0 + fprintf('%-20s%s\n',['train ' combinedModel.mets{j}],inchiApprox{j}) + end + end + end + %duplicates between the training and test set + if combinedModel.trainingMetBool(i) && combinedModel.testMetBool(j) + if strcmp(inchiApprox{i},inchiApprox{j}) +% if printLevel>0 && printParent +% fprintf('%-20s%s\n',['train*' combinedModel.mets{i}],inchiApprox{i}) +% printParent=0; +% end +% if printLevel>0 +% fprintf('%-20s%s\n',['test ' combinedModel.mets{j}],inchiApprox{j}) +% end + else + if printLevel>0 && printParent + fprintf('%-20s%s\n',['train*' combinedModel.mets{i}],inchiApprox{i}) + printParent=0; + end + if printLevel>0 + fprintf('%-20s%s\n',['test ' combinedModel.mets{j}],inchiApprox{j}) + end + end + end + %duplicates within the test set + if combinedModel.testMetBool(i) && combinedModel.testMetBool(j) + if strcmp(inchiApprox{i},inchiApprox{j}) + else + if printLevel>0 && printParent + fprintf('%-20s%s\n',['test*' combinedModel.mets{i}],inchiApprox{i}) + printParent=0; + end + if printLevel>0 + fprintf('%-20s%s\n',['test ' combinedModel.mets{j}],inchiApprox{j}) + end + end + end + + end + if printParent==0 + printParent=1; + end + end +end + + diff --git a/src/analysis/thermo/componentContribution/old/getMappingScores.m b/src/analysis/thermo/groupContribution/old/getMappingScores.m similarity index 100% rename from src/analysis/thermo/componentContribution/old/getMappingScores.m rename to src/analysis/thermo/groupContribution/old/getMappingScores.m diff --git a/src/analysis/thermo/groupContribution/wang/.ipynb_checkpoints/Calling_Python_from_MATLAB-checkpoint.ipynb b/src/analysis/thermo/groupContribution/wang/.ipynb_checkpoints/Calling_Python_from_MATLAB-checkpoint.ipynb new file mode 100644 index 0000000000..956cbd9b30 --- /dev/null +++ b/src/analysis/thermo/groupContribution/wang/.ipynb_checkpoints/Calling_Python_from_MATLAB-checkpoint.ipynb @@ -0,0 +1,32 @@ +{ + "cells": [ + { + "cell_type": "code", + "execution_count": null, + "metadata": {}, + "outputs": [], + "source": [] + } + ], + "metadata": { + "kernelspec": { + "display_name": "Python 3", + "language": "python", + "name": "python3" + }, + "language_info": { + "codemirror_mode": { + "name": "ipython", + "version": 3 + }, + "file_extension": ".py", + "mimetype": "text/x-python", + "name": "python", + "nbconvert_exporter": "python", + "pygments_lexer": "ipython3", + "version": "3.8.5" + } + }, + "nbformat": 4, + "nbformat_minor": 4 +} diff --git a/src/analysis/thermo/groupContribution/wang/Calling_Python_from_MATLAB.ipynb b/src/analysis/thermo/groupContribution/wang/Calling_Python_from_MATLAB.ipynb new file mode 100644 index 0000000000..16935eab89 --- /dev/null +++ b/src/analysis/thermo/groupContribution/wang/Calling_Python_from_MATLAB.ipynb @@ -0,0 +1,406 @@ +{ + "cells": [ + { + "cell_type": "code", + "execution_count": 1, + "metadata": {}, + "outputs": [], + "source": [ + "import pandas" + ] + }, + { + "cell_type": "code", + "execution_count": 3, + "metadata": {}, + "outputs": [ + { + "name": "stdout", + "output_type": "stream", + "text": [ + "Help on function read_csv in module pandas.io.parsers:\n", + "\n", + "read_csv(filepath_or_buffer: Union[str, pathlib.Path, IO[~AnyStr]], sep=',', delimiter=None, header='infer', names=None, index_col=None, usecols=None, squeeze=False, prefix=None, mangle_dupe_cols=True, dtype=None, engine=None, converters=None, true_values=None, false_values=None, skipinitialspace=False, skiprows=None, skipfooter=0, nrows=None, na_values=None, keep_default_na=True, na_filter=True, verbose=False, skip_blank_lines=True, parse_dates=False, infer_datetime_format=False, keep_date_col=False, date_parser=None, dayfirst=False, cache_dates=True, iterator=False, chunksize=None, compression='infer', thousands=None, decimal: str = '.', lineterminator=None, quotechar='\"', quoting=0, doublequote=True, escapechar=None, comment=None, encoding=None, dialect=None, error_bad_lines=True, warn_bad_lines=True, delim_whitespace=False, low_memory=True, memory_map=False, float_precision=None)\n", + " Read a comma-separated values (csv) file into DataFrame.\n", + " \n", + " Also supports optionally iterating or breaking of the file\n", + " into chunks.\n", + " \n", + " Additional help can be found in the online docs for\n", + " `IO Tools `_.\n", + " \n", + " Parameters\n", + " ----------\n", + " filepath_or_buffer : str, path object or file-like object\n", + " Any valid string path is acceptable. The string could be a URL. Valid\n", + " URL schemes include http, ftp, s3, gs, and file. For file URLs, a host is\n", + " expected. A local file could be: file://localhost/path/to/table.csv.\n", + " \n", + " If you want to pass in a path object, pandas accepts any ``os.PathLike``.\n", + " \n", + " By file-like object, we refer to objects with a ``read()`` method, such as\n", + " a file handler (e.g. via builtin ``open`` function) or ``StringIO``.\n", + " sep : str, default ','\n", + " Delimiter to use. If sep is None, the C engine cannot automatically detect\n", + " the separator, but the Python parsing engine can, meaning the latter will\n", + " be used and automatically detect the separator by Python's builtin sniffer\n", + " tool, ``csv.Sniffer``. In addition, separators longer than 1 character and\n", + " different from ``'\\s+'`` will be interpreted as regular expressions and\n", + " will also force the use of the Python parsing engine. Note that regex\n", + " delimiters are prone to ignoring quoted data. Regex example: ``'\\r\\t'``.\n", + " delimiter : str, default ``None``\n", + " Alias for sep.\n", + " header : int, list of int, default 'infer'\n", + " Row number(s) to use as the column names, and the start of the\n", + " data. Default behavior is to infer the column names: if no names\n", + " are passed the behavior is identical to ``header=0`` and column\n", + " names are inferred from the first line of the file, if column\n", + " names are passed explicitly then the behavior is identical to\n", + " ``header=None``. Explicitly pass ``header=0`` to be able to\n", + " replace existing names. The header can be a list of integers that\n", + " specify row locations for a multi-index on the columns\n", + " e.g. [0,1,3]. Intervening rows that are not specified will be\n", + " skipped (e.g. 2 in this example is skipped). Note that this\n", + " parameter ignores commented lines and empty lines if\n", + " ``skip_blank_lines=True``, so ``header=0`` denotes the first line of\n", + " data rather than the first line of the file.\n", + " names : array-like, optional\n", + " List of column names to use. If the file contains a header row,\n", + " then you should explicitly pass ``header=0`` to override the column names.\n", + " Duplicates in this list are not allowed.\n", + " index_col : int, str, sequence of int / str, or False, default ``None``\n", + " Column(s) to use as the row labels of the ``DataFrame``, either given as\n", + " string name or column index. If a sequence of int / str is given, a\n", + " MultiIndex is used.\n", + " \n", + " Note: ``index_col=False`` can be used to force pandas to *not* use the first\n", + " column as the index, e.g. when you have a malformed file with delimiters at\n", + " the end of each line.\n", + " usecols : list-like or callable, optional\n", + " Return a subset of the columns. If list-like, all elements must either\n", + " be positional (i.e. integer indices into the document columns) or strings\n", + " that correspond to column names provided either by the user in `names` or\n", + " inferred from the document header row(s). For example, a valid list-like\n", + " `usecols` parameter would be ``[0, 1, 2]`` or ``['foo', 'bar', 'baz']``.\n", + " Element order is ignored, so ``usecols=[0, 1]`` is the same as ``[1, 0]``.\n", + " To instantiate a DataFrame from ``data`` with element order preserved use\n", + " ``pd.read_csv(data, usecols=['foo', 'bar'])[['foo', 'bar']]`` for columns\n", + " in ``['foo', 'bar']`` order or\n", + " ``pd.read_csv(data, usecols=['foo', 'bar'])[['bar', 'foo']]``\n", + " for ``['bar', 'foo']`` order.\n", + " \n", + " If callable, the callable function will be evaluated against the column\n", + " names, returning names where the callable function evaluates to True. An\n", + " example of a valid callable argument would be ``lambda x: x.upper() in\n", + " ['AAA', 'BBB', 'DDD']``. Using this parameter results in much faster\n", + " parsing time and lower memory usage.\n", + " squeeze : bool, default False\n", + " If the parsed data only contains one column then return a Series.\n", + " prefix : str, optional\n", + " Prefix to add to column numbers when no header, e.g. 'X' for X0, X1, ...\n", + " mangle_dupe_cols : bool, default True\n", + " Duplicate columns will be specified as 'X', 'X.1', ...'X.N', rather than\n", + " 'X'...'X'. Passing in False will cause data to be overwritten if there\n", + " are duplicate names in the columns.\n", + " dtype : Type name or dict of column -> type, optional\n", + " Data type for data or columns. E.g. {'a': np.float64, 'b': np.int32,\n", + " 'c': 'Int64'}\n", + " Use `str` or `object` together with suitable `na_values` settings\n", + " to preserve and not interpret dtype.\n", + " If converters are specified, they will be applied INSTEAD\n", + " of dtype conversion.\n", + " engine : {'c', 'python'}, optional\n", + " Parser engine to use. The C engine is faster while the python engine is\n", + " currently more feature-complete.\n", + " converters : dict, optional\n", + " Dict of functions for converting values in certain columns. Keys can either\n", + " be integers or column labels.\n", + " true_values : list, optional\n", + " Values to consider as True.\n", + " false_values : list, optional\n", + " Values to consider as False.\n", + " skipinitialspace : bool, default False\n", + " Skip spaces after delimiter.\n", + " skiprows : list-like, int or callable, optional\n", + " Line numbers to skip (0-indexed) or number of lines to skip (int)\n", + " at the start of the file.\n", + " \n", + " If callable, the callable function will be evaluated against the row\n", + " indices, returning True if the row should be skipped and False otherwise.\n", + " An example of a valid callable argument would be ``lambda x: x in [0, 2]``.\n", + " skipfooter : int, default 0\n", + " Number of lines at bottom of file to skip (Unsupported with engine='c').\n", + " nrows : int, optional\n", + " Number of rows of file to read. Useful for reading pieces of large files.\n", + " na_values : scalar, str, list-like, or dict, optional\n", + " Additional strings to recognize as NA/NaN. If dict passed, specific\n", + " per-column NA values. By default the following values are interpreted as\n", + " NaN: '', '#N/A', '#N/A N/A', '#NA', '-1.#IND', '-1.#QNAN', '-NaN', '-nan',\n", + " '1.#IND', '1.#QNAN', '', 'N/A', 'NA', 'NULL', 'NaN', 'n/a',\n", + " 'nan', 'null'.\n", + " keep_default_na : bool, default True\n", + " Whether or not to include the default NaN values when parsing the data.\n", + " Depending on whether `na_values` is passed in, the behavior is as follows:\n", + " \n", + " * If `keep_default_na` is True, and `na_values` are specified, `na_values`\n", + " is appended to the default NaN values used for parsing.\n", + " * If `keep_default_na` is True, and `na_values` are not specified, only\n", + " the default NaN values are used for parsing.\n", + " * If `keep_default_na` is False, and `na_values` are specified, only\n", + " the NaN values specified `na_values` are used for parsing.\n", + " * If `keep_default_na` is False, and `na_values` are not specified, no\n", + " strings will be parsed as NaN.\n", + " \n", + " Note that if `na_filter` is passed in as False, the `keep_default_na` and\n", + " `na_values` parameters will be ignored.\n", + " na_filter : bool, default True\n", + " Detect missing value markers (empty strings and the value of na_values). In\n", + " data without any NAs, passing na_filter=False can improve the performance\n", + " of reading a large file.\n", + " verbose : bool, default False\n", + " Indicate number of NA values placed in non-numeric columns.\n", + " skip_blank_lines : bool, default True\n", + " If True, skip over blank lines rather than interpreting as NaN values.\n", + " parse_dates : bool or list of int or names or list of lists or dict, default False\n", + " The behavior is as follows:\n", + " \n", + " * boolean. If True -> try parsing the index.\n", + " * list of int or names. e.g. If [1, 2, 3] -> try parsing columns 1, 2, 3\n", + " each as a separate date column.\n", + " * list of lists. e.g. If [[1, 3]] -> combine columns 1 and 3 and parse as\n", + " a single date column.\n", + " * dict, e.g. {'foo' : [1, 3]} -> parse columns 1, 3 as date and call\n", + " result 'foo'\n", + " \n", + " If a column or index cannot be represented as an array of datetimes,\n", + " say because of an unparseable value or a mixture of timezones, the column\n", + " or index will be returned unaltered as an object data type. For\n", + " non-standard datetime parsing, use ``pd.to_datetime`` after\n", + " ``pd.read_csv``. To parse an index or column with a mixture of timezones,\n", + " specify ``date_parser`` to be a partially-applied\n", + " :func:`pandas.to_datetime` with ``utc=True``. See\n", + " :ref:`io.csv.mixed_timezones` for more.\n", + " \n", + " Note: A fast-path exists for iso8601-formatted dates.\n", + " infer_datetime_format : bool, default False\n", + " If True and `parse_dates` is enabled, pandas will attempt to infer the\n", + " format of the datetime strings in the columns, and if it can be inferred,\n", + " switch to a faster method of parsing them. In some cases this can increase\n", + " the parsing speed by 5-10x.\n", + " keep_date_col : bool, default False\n", + " If True and `parse_dates` specifies combining multiple columns then\n", + " keep the original columns.\n", + " date_parser : function, optional\n", + " Function to use for converting a sequence of string columns to an array of\n", + " datetime instances. The default uses ``dateutil.parser.parser`` to do the\n", + " conversion. Pandas will try to call `date_parser` in three different ways,\n", + " advancing to the next if an exception occurs: 1) Pass one or more arrays\n", + " (as defined by `parse_dates`) as arguments; 2) concatenate (row-wise) the\n", + " string values from the columns defined by `parse_dates` into a single array\n", + " and pass that; and 3) call `date_parser` once for each row using one or\n", + " more strings (corresponding to the columns defined by `parse_dates`) as\n", + " arguments.\n", + " dayfirst : bool, default False\n", + " DD/MM format dates, international and European format.\n", + " cache_dates : bool, default True\n", + " If True, use a cache of unique, converted dates to apply the datetime\n", + " conversion. May produce significant speed-up when parsing duplicate\n", + " date strings, especially ones with timezone offsets.\n", + " \n", + " .. versionadded:: 0.25.0\n", + " iterator : bool, default False\n", + " Return TextFileReader object for iteration or getting chunks with\n", + " ``get_chunk()``.\n", + " chunksize : int, optional\n", + " Return TextFileReader object for iteration.\n", + " See the `IO Tools docs\n", + " `_\n", + " for more information on ``iterator`` and ``chunksize``.\n", + " compression : {'infer', 'gzip', 'bz2', 'zip', 'xz', None}, default 'infer'\n", + " For on-the-fly decompression of on-disk data. If 'infer' and\n", + " `filepath_or_buffer` is path-like, then detect compression from the\n", + " following extensions: '.gz', '.bz2', '.zip', or '.xz' (otherwise no\n", + " decompression). If using 'zip', the ZIP file must contain only one data\n", + " file to be read in. Set to None for no decompression.\n", + " thousands : str, optional\n", + " Thousands separator.\n", + " decimal : str, default '.'\n", + " Character to recognize as decimal point (e.g. use ',' for European data).\n", + " lineterminator : str (length 1), optional\n", + " Character to break file into lines. Only valid with C parser.\n", + " quotechar : str (length 1), optional\n", + " The character used to denote the start and end of a quoted item. Quoted\n", + " items can include the delimiter and it will be ignored.\n", + " quoting : int or csv.QUOTE_* instance, default 0\n", + " Control field quoting behavior per ``csv.QUOTE_*`` constants. Use one of\n", + " QUOTE_MINIMAL (0), QUOTE_ALL (1), QUOTE_NONNUMERIC (2) or QUOTE_NONE (3).\n", + " doublequote : bool, default ``True``\n", + " When quotechar is specified and quoting is not ``QUOTE_NONE``, indicate\n", + " whether or not to interpret two consecutive quotechar elements INSIDE a\n", + " field as a single ``quotechar`` element.\n", + " escapechar : str (length 1), optional\n", + " One-character string used to escape other characters.\n", + " comment : str, optional\n", + " Indicates remainder of line should not be parsed. If found at the beginning\n", + " of a line, the line will be ignored altogether. This parameter must be a\n", + " single character. Like empty lines (as long as ``skip_blank_lines=True``),\n", + " fully commented lines are ignored by the parameter `header` but not by\n", + " `skiprows`. For example, if ``comment='#'``, parsing\n", + " ``#empty\\na,b,c\\n1,2,3`` with ``header=0`` will result in 'a,b,c' being\n", + " treated as the header.\n", + " encoding : str, optional\n", + " Encoding to use for UTF when reading/writing (ex. 'utf-8'). `List of Python\n", + " standard encodings\n", + " `_ .\n", + " dialect : str or csv.Dialect, optional\n", + " If provided, this parameter will override values (default or not) for the\n", + " following parameters: `delimiter`, `doublequote`, `escapechar`,\n", + " `skipinitialspace`, `quotechar`, and `quoting`. If it is necessary to\n", + " override values, a ParserWarning will be issued. See csv.Dialect\n", + " documentation for more details.\n", + " error_bad_lines : bool, default True\n", + " Lines with too many fields (e.g. a csv line with too many commas) will by\n", + " default cause an exception to be raised, and no DataFrame will be returned.\n", + " If False, then these \"bad lines\" will dropped from the DataFrame that is\n", + " returned.\n", + " warn_bad_lines : bool, default True\n", + " If error_bad_lines is False, and warn_bad_lines is True, a warning for each\n", + " \"bad line\" will be output.\n", + " delim_whitespace : bool, default False\n", + " Specifies whether or not whitespace (e.g. ``' '`` or ``' '``) will be\n", + " used as the sep. Equivalent to setting ``sep='\\s+'``. If this option\n", + " is set to True, nothing should be passed in for the ``delimiter``\n", + " parameter.\n", + " low_memory : bool, default True\n", + " Internally process the file in chunks, resulting in lower memory use\n", + " while parsing, but possibly mixed type inference. To ensure no mixed\n", + " types either set False, or specify the type with the `dtype` parameter.\n", + " Note that the entire file is read into a single DataFrame regardless,\n", + " use the `chunksize` or `iterator` parameter to return the data in chunks.\n", + " (Only valid with C parser).\n", + " memory_map : bool, default False\n", + " If a filepath is provided for `filepath_or_buffer`, map the file object\n", + " directly onto memory and access the data directly from there. Using this\n", + " option can improve performance because there is no longer any I/O overhead.\n", + " float_precision : str, optional\n", + " Specifies which converter the C engine should use for floating-point\n", + " values. The options are `None` for the ordinary converter,\n", + " `high` for the high-precision converter, and `round_trip` for the\n", + " round-trip converter.\n", + " \n", + " Returns\n", + " -------\n", + " DataFrame or TextParser\n", + " A comma-separated values (csv) file is returned as two-dimensional\n", + " data structure with labeled axes.\n", + " \n", + " See Also\n", + " --------\n", + " DataFrame.to_csv : Write DataFrame to a comma-separated values (csv) file.\n", + " read_csv : Read a comma-separated values (csv) file into DataFrame.\n", + " read_fwf : Read a table of fixed-width formatted lines into DataFrame.\n", + " \n", + " Examples\n", + " --------\n", + " >>> pd.read_csv('data.csv') # doctest: +SKIP\n", + "\n" + ] + } + ], + "source": [ + "help(pandas.read_csv)" + ] + }, + { + "cell_type": "code", + "execution_count": 4, + "metadata": {}, + "outputs": [ + { + "ename": "NameError", + "evalue": "name 'python' is not defined", + "output_type": "error", + "traceback": [ + "\u001b[0;31m---------------------------------------------------------------------------\u001b[0m", + "\u001b[0;31mNameError\u001b[0m Traceback (most recent call last)", + "\u001b[0;32m\u001b[0m in \u001b[0;36m\u001b[0;34m\u001b[0m\n\u001b[0;32m----> 1\u001b[0;31m \u001b[0mpython\u001b[0m \u001b[0;34m-\u001b[0m\u001b[0;34m-\u001b[0m\u001b[0mversion\u001b[0m\u001b[0;34m\u001b[0m\u001b[0;34m\u001b[0m\u001b[0m\n\u001b[0m", + "\u001b[0;31mNameError\u001b[0m: name 'python' is not defined" + ] + } + ], + "source": [ + "python --version" + ] + }, + { + "cell_type": "code", + "execution_count": 5, + "metadata": {}, + "outputs": [ + { + "ename": "NameError", + "evalue": "name 'version' is not defined", + "output_type": "error", + "traceback": [ + "\u001b[0;31m---------------------------------------------------------------------------\u001b[0m", + "\u001b[0;31mNameError\u001b[0m Traceback (most recent call last)", + "\u001b[0;32m\u001b[0m in \u001b[0;36m\u001b[0;34m\u001b[0m\n\u001b[0;32m----> 1\u001b[0;31m \u001b[0mversion\u001b[0m\u001b[0;34m\u001b[0m\u001b[0;34m\u001b[0m\u001b[0m\n\u001b[0m", + "\u001b[0;31mNameError\u001b[0m: name 'version' is not defined" + ] + } + ], + "source": [ + "version" + ] + }, + { + "cell_type": "code", + "execution_count": 6, + "metadata": {}, + "outputs": [ + { + "ename": "ModuleNotFoundError", + "evalue": "No module named 'rdkit'", + "output_type": "error", + "traceback": [ + "\u001b[0;31m---------------------------------------------------------------------------\u001b[0m", + "\u001b[0;31mModuleNotFoundError\u001b[0m Traceback (most recent call last)", + "\u001b[0;32m\u001b[0m in \u001b[0;36m\u001b[0;34m\u001b[0m\n\u001b[0;32m----> 1\u001b[0;31m \u001b[0;32mfrom\u001b[0m \u001b[0mrdkit\u001b[0m \u001b[0;32mimport\u001b[0m \u001b[0mChem\u001b[0m\u001b[0;34m\u001b[0m\u001b[0;34m\u001b[0m\u001b[0m\n\u001b[0m", + "\u001b[0;31mModuleNotFoundError\u001b[0m: No module named 'rdkit'" + ] + } + ], + "source": [ + "from rdkit import Chem" + ] + }, + { + "cell_type": "code", + "execution_count": null, + "metadata": {}, + "outputs": [], + "source": [] + } + ], + "metadata": { + "kernelspec": { + "display_name": "Python 3", + "language": "python", + "name": "python3" + }, + "language_info": { + "codemirror_mode": { + "name": "ipython", + "version": 3 + }, + "file_extension": ".py", + "mimetype": "text/x-python", + "name": "python", + "nbconvert_exporter": "python", + "pygments_lexer": "ipython3", + "version": "3.8.5" + } + }, + "nbformat": 4, + "nbformat_minor": 4 +} diff --git a/src/analysis/thermo/groupContribution/wang/autoFragment.m b/src/analysis/thermo/groupContribution/wang/autoFragment.m new file mode 100644 index 0000000000..81a9a76440 --- /dev/null +++ b/src/analysis/thermo/groupContribution/wang/autoFragment.m @@ -0,0 +1,269 @@ +function [fragmentedMol,decomposableBool,inchiExistBool] = autoFragment(inchi,radius,dGPredictorPath,canonicalise,cacheName,printLevel) +%given one or more inchi, automatically fragment it into a set of smiles +%each centered around an atom with radius specifying the number of bonds to +%neighbouring atoms +% +% INPUT +% inchi n x 1 cell array of molecules each specified by InChI strings +% or a single InChI string as a char +% OPTIONAL INPUT +% radius number of bonds around each central smiles atom +% dGPredictorPath path to the folder containg a git clone of https://github.com/maranasgroup/dGPredictor +% path must be the full absolute path without ~/ +% cacheName fileName of cache to load (if it exists) or save to (if it does not exist) +% +% OUTPUT +% fragmentedMol n x 1 structure with the following fields for each inchi: +% *.inchi inchi string +% *.smilesCount Map structure +% Each Key is a canonical smiles string (not canonical smiles if canonicalise==0) +% Each value is the incidence of each smiles string in a molecule +% +% decomposableBool n x 1 logical vector, true if inchi is decomposable +% +% EXTERNAL DEPENDENCIES +% Python, see: +% [pyEnvironment,pySearchPath]=initPythonEnvironment(environmentName,reset) +% +% rdkit, e.g., installed in an Anaconda environment +% https://www.rdkit.org +% https://www.rdkit.org/docs/Install.html#introduction-to-anaconda +% +% dGPredictor +% https://github.com/maranasgroup/dGPredictor + +% Author Ronan M.T. Fleming 2021 + + +if isempty(inchi) + fragmentedMol=[]; + decomposableBool=[]; + return +end +if ~exist('inchi','var') + inchi='InChI=1S/C5H8O4/c6-4(7)2-1-3-5(8)9/h1-3H2,(H,6,7)(H,8,9)/p-2'; +end +if ~exist('radius','var') + radius=1; +end +if ~exist('dGPredictorPath','var') || isempty(dGPredictorPath) + %must be the full absolute path without ~/ + dGPredictorPath='/home/rfleming/work/sbgCloud/code/dGPredictor'; +end +if ~exist('canonicalise','var') + canonicalise=0; +end +if exist('cacheName','var') && ~isempty(cacheName) + aPath=which('autoFragment'); + cacheName = strrep(aPath,'autoFragment.m',['cache' filesep cacheName '.mat']); + if exist(cacheName,'file') + load(cacheName) + return + end +end +if ~exist('printLevel','var') + printLevel=0; +end + + +try + pythonPath = py_addpath(dGPredictorPath); + decompose_groups = py.importlib.import_module('decompose_groups'); +catch + current_py_path = get_py_path(); + [pyEnvironment,pySearchPath]=initPythonEnvironment('dGPredictor',1); + pythonPath = py_addpath(dGPredictorPath); + decompose_groups = py.importlib.import_module('decompose_groups'); +end + +inchiModule = py.importlib.import_module('rdkit.Chem.inchi'); + +if ischar(inchi) + inchiChar=inchi; + clear inchi; + inchi{1}=inchiChar; +end + +nInchi=length(inchi); + +for i=1:nInchi + if ~isempty(inchi{i}) + inchi{i}=strtrim(inchi{i}); + end +end +decomposableBool=true(nInchi,1); +inchiExistBool=true(nInchi,1); +fragmentedMol=struct(); +for i = 1:nInchi + if isempty(inchi{i}) + inchiExistBool(i)=0; + else + if printLevel>0 + fprintf('%u\t%s\n',i,inchi{i}) + end + mol=inchiModule.MolFromInchi(inchi{i}); + fragmentedMol(i,1).inchi=inchi{i}; + + try + %inchi='InChI=1S/C5H8O4/c6-4(7)2-1-3-5(8)9/h1-3H2,(H,6,7)(H,8,9)/p-2' + %smi_count = {'CCC': 3, 'CC(=O)[O-]': 2, 'C=O': 2, 'C[O-]': 2} + %Python dict with no properties. + smi_count = decompose_groups.count_substructures(uint8(radius),mol); + + %convert dictonary into map structure + %https://nl.mathworks.com/help/matlab/matlab_prog/overview-of-the-map-data-structure.html + %fragmentedMol(i).smilesCounts = containers.Map('KeyType','char','ValueType','double'); + fragmentedMol(i).smilesCounts = containers.Map(); + for raw_key = py.list(keys(smi_count)) + key = raw_key{1}; + value = double(smi_count{key}); + fragmentedMol(i,1).smilesCounts(string(key)) = value; + end + % data = smi_count; + % data = py.json.dumps(data); + % data = char(data); + % data = jsondecode(data); + catch + decomposableBool(i)=0; + end + end +end + +if canonicalise + ChemModule = py.importlib.import_module('rdkit.Chem'); + nMols=length(fragmentedMol); + for i = 1:nMols + if decomposableBool(i) + nFrag=length(fragmentedMol(i).smilesCounts); + fragmentSmiles = fragmentedMol(i).smilesCounts.keys; + canonSmiles=cell(nFrag,1); + for j=1:nFrag + if isempty(fragmentSmiles{j}) + canonSmiles{j} = fragmentSmiles{j}; + else + canonSmiles{j} = char(ChemModule.CanonSmiles(fragmentSmiles{j})); + end + end + [uniqueCanonSmiles,IA,IC] = unique(canonSmiles); + nUniqueFrag = length(uniqueCanonSmiles); + %canonical smiles fragments are not unique + if nFrag~=nUniqueFrag + fragmentCounts = fragmentedMol(i).smilesCounts.values; + %regenerate the smiles count map with only unique entries + %fragmentedMol(i).smilesCounts = containers.Map('KeyType','char','ValueType','double'); + %unique canonical smiles correspond to first indices given by IA + fragmentedMol(i).smilesCounts = containers.Map(canonSmiles(IA),fragmentCounts(IA)); + %add the counts of the duplicates + for j=1:nFrag + if ~any(j == IA) + fragmentedMol(i).smilesCounts(canonSmiles{j}) = fragmentedMol(i).smilesCounts(canonSmiles{j}) + cell2mat(fragmentCounts(j)); + end + end + fprintf('%s\n',['Consolidated duplicate canonical fragments for ' fragmentedMol(i).inchi]) + end + end + end +end + +if exist('cacheName','var') && ~isempty(cacheName) + save(cacheName,'fragmentedMol','decomposableBool','inchiExistBool') +end + + + +return +% +% % # dGPredictor +% % +% % ================================== +% % ### Requirements: +% % 1. RDkit (http://www.rdkit.org/) +% % 2. pandas (https://pandas.pydata.org/) +% % 3. Scikit-learn (https://scikit-learn.org/stable/) +% % 4. Streamlit==0.55.2 (https://streamlit.io/) +% +% %From the MATLAB command prompt, add the folder containing autoFragment.py to the Python search path. +% autoFragmentFolder = fileparts(which('autoFragment.m')); +% cd(autoFragmentFolder) +% pythonPath = py_addpath(autoFragmentFolder, 0); +% autoFragment = py.importlib.import_module('autofragment') +% %% +% % +% +% +% +% +% +% decompose_groups = py.importlib.import_module('/home/rfleming/work/sbgCloud/code/dGPredictor/decompose_groups'); +% +% db = py.pandas.read_csv(pyargs('filepath_or_buffer',[autoFragmentFolder filesep 'data' filesep 'test_compounds.csv'],'index_col','compound_id')); +% +% % https://nl.mathworks.com/help/matlab/matlab_external/accessing-elements-in-python-container-types.html +% % Indexing Features Not Supported in MATLAB: +% % Use of square brackets, []. +% % db_smiles = db['smiles_pH7'].to_dict() +% +% % https://nl.mathworks.com/help/matlab/matlab_external/python-dict-variables.html +% db_dict = db.to_dict(); +% +% db_struct = struct(db_dict); +% +% %dictionary object with just id & smiles +% db_smiles = db_struct.smiles_pH7; +% +% %% +% rdkit = py.importlib.import_module('rdkit'); +% +% mol = py.rdkit.Chem.MolFromSmiles(db_smiles) +% +% +% try +% +% catch e +% disp(e.message) +% if (isa(e,'matlab.exception.PyException')) +% e.ExceptionObject; +% end +% if contains(e.message,'libstdc') +% disp('Import of rdkit.Chem failed. Trying the following command ...') +% disp('mv /usr/local/bin/MATLAB/R2021a/sys/os/glnxa64/libstdc++.so.6 /usr/local/bin/MATLAB/R2021a/sys/os/glnxa64/deactivated.libstdc++.so.6') +% [success,response]=system('mv /usr/local/bin/MATLAB/R2021a/sys/os/glnxa64/libstdc++.so.6 /usr/local/bin/MATLAB/R2021a/sys/os/glnxa64/deactivated.libstdc++.so.6'); +% if success==0 +% chem = py.importlib.import_module('rdkit.Chem'); +% end +% else +% disp('Import of rdkit.Chem failed. Run py.importlib.import_module(''rdkit.Chem'') from the command line to debug.') +% end +% end +% +% InchiKey = char(chem.inchi.InchiToInchiKey(inchi)); +% +% return +% +% % chem = py.importlib.import_module('rdkit.Chem') +% % Error using __init__> (line 23) +% % Python Error: ImportError: /usr/local/bin/MATLAB/R2021a/interprocess/bin/glnxa64/pycli/../../../../sys/os/glnxa64/libstdc++.so.6: version `GLIBCXX_3.4.26' not found (required by +% % /usr/local/bin/anaconda3/envs/dGPredictor/lib/python3.8/site-packages/rdkit/Chem/../../../../libboost_regex.so.1.74.0) +% % +% % Error in _call_with_frames_removed (line 219) +% % +% % Error in exec_module (line 783) +% % +% % Error in _load_unlocked (line 671) +% % +% % Error in _find_and_load_unlocked (line 975) +% % +% % Error in _find_and_load (line 991) +% % +% % Error in _gcd_import (line 1014) +% % +% % Error in __init__>import_module (line 127) +% +% mol = py.rdkit.Chem.MolFromSmiles(db_smiles); +% +% +% +% %https://nl.mathworks.com/matlabcentral/answers/592918-using-matlab-with-ubuntu-anaconda-and-python +% autoFragment = py.importlib.import_module('autofragment') +% +% py.autofragment.decompse_ac(db_smiles) diff --git a/src/analysis/thermo/groupContribution/wang/autofragment.py b/src/analysis/thermo/groupContribution/wang/autofragment.py new file mode 100644 index 0000000000..20357df1c3 --- /dev/null +++ b/src/analysis/thermo/groupContribution/wang/autofragment.py @@ -0,0 +1,68 @@ +# autofragment.py +import pandas as pd +import pdb +import json +from rdkit import Chem + +def count_substructures(radius,molecule): + """Helper function for get the information of molecular signature of a + metabolite. The relaxed signature requires the number of each substructure + to construct a matrix for each molecule. + Parameters + ---------- + radius : int + the radius is bond-distance that defines how many neighbor atoms should + be considered in a reaction center. + molecule : Molecule + a molecule object create by RDkit (e.g. Chem.MolFromInchi(inchi_code) + or Chem.MolToSmiles(smiles_code)) + Returns + ------- + dict + dictionary of molecular signature for a molecule, + {smiles: molecular_signature} + """ + m = molecule + smi_count = dict() + atomList = [atom for atom in m.GetAtoms()] + + for i in range(len(atomList)): + env = Chem.FindAtomEnvironmentOfRadiusN(m,radius,i) + atoms=set() + for bidx in env: + atoms.add(m.GetBondWithIdx(bidx).GetBeginAtomIdx()) + atoms.add(m.GetBondWithIdx(bidx).GetEndAtomIdx()) + + # only one atom is in this environment, such as O in H2O + if len(atoms) == 0: + atoms = {i} + + smi = Chem.MolFragmentToSmiles(m,atomsToUse=list(atoms), + bondsToUse=env,canonical=True) + + if smi in smi_count: + smi_count[smi] = smi_count[smi] + 1 + else: + smi_count[smi] = 1 + return smi_count + +def decompse_ac(db_smiles,radius=1): + non_decomposable = [] + decompose_vector = dict() + + for cid in db_smiles: + # print cid + smiles_pH7 = db_smiles[cid] + try: + mol = Chem.MolFromSmiles(smiles_pH7) + mol = Chem.RemoveHs(mol) + # Chem.RemoveStereochemistry(mol) + smi_count = count_substructures(radius,mol) + decompose_vector[cid] = smi_count + + except Exception as e: + non_decomposable.append(cid) + + with open('./data/decompose_vector_ac.json','w') as fp: + json.dump(decompose_vector,fp) + diff --git a/src/analysis/thermo/groupContribution/wang/cache/autoFragment_Recon3DModel_301.mat b/src/analysis/thermo/groupContribution/wang/cache/autoFragment_Recon3DModel_301.mat new file mode 100644 index 0000000000..535782e278 Binary files /dev/null and b/src/analysis/thermo/groupContribution/wang/cache/autoFragment_Recon3DModel_301.mat differ diff --git a/src/analysis/thermo/groupContribution/wang/cache/autoFragment_trainingModel.mat b/src/analysis/thermo/groupContribution/wang/cache/autoFragment_trainingModel.mat new file mode 100644 index 0000000000..b60a1b6332 Binary files /dev/null and b/src/analysis/thermo/groupContribution/wang/cache/autoFragment_trainingModel.mat differ diff --git a/src/analysis/thermo/groupContribution/wang/cache/v1/autoFragment_Recon3DModel_301.mat b/src/analysis/thermo/groupContribution/wang/cache/v1/autoFragment_Recon3DModel_301.mat new file mode 100644 index 0000000000..e6a931983d Binary files /dev/null and b/src/analysis/thermo/groupContribution/wang/cache/v1/autoFragment_Recon3DModel_301.mat differ diff --git a/src/analysis/thermo/groupContribution/wang/cache/v1/autoFragment_trainingModel.mat b/src/analysis/thermo/groupContribution/wang/cache/v1/autoFragment_trainingModel.mat new file mode 100644 index 0000000000..c26cf3b647 Binary files /dev/null and b/src/analysis/thermo/groupContribution/wang/cache/v1/autoFragment_trainingModel.mat differ diff --git a/src/analysis/thermo/groupContribution/wang/call_python_from_matlab.m b/src/analysis/thermo/groupContribution/wang/call_python_from_matlab.m new file mode 100644 index 0000000000..a28ae88e2a --- /dev/null +++ b/src/analysis/thermo/groupContribution/wang/call_python_from_matlab.m @@ -0,0 +1,64 @@ + + +if 0 + %% Set RTLD_NOW and RTLD_DEEPBIND + %https://nl.mathworks.com/matlabcentral/answers/327193-calling-python-module-from-matlab-causes-segmentation-fault-in-h5py + py.sys.setdlopenflags(int32(10)); +else + %PythonEnvironment objects contain information about the settings and status of the Python® interpreter. + %MATLAB® communicates with the interpreter when you call a py. command. + %Python environment information is persistent across different MATLAB sessions. + + % Out-of-Process Execution of Python Functionality + % MATLAB® can run Python scripts and functions in a separate process. Running Python in a separate process enables you to: + % Use some third-party libraries in the Python code that are not compatible with MATLAB. + % Isolate the MATLAB process from crashes in the Python code. + PythonEnvironment = pyenv("ExecutionMode","OutOfProcess"); +end + +try + py.list('x','y',1) +catch e + e.message + if(isa(e,'matlab.exception.PyException')) + e.ExceptionObject + end +end + + + +try + py.help('pandas.read_csv') +catch e + e.message + if(isa(e,'matlab.exception.PyException')) + e.ExceptionObject + end +end + +%pandas.read_csv function signature +%pandas.read_csv = read_csv(filepath_or_buffer: Union[str, pathlib.Path, IO[~AnyStr]], sep=',', delimiter=None, header='infer', names=None, index_col=None, usecols=None, squeeze=False, prefix=None, mangle_dupe_cols=True, dtype=None, engine=None, converters=None, true_values=None, false_values=None, skipinitialspace=False, skiprows=None, skipfooter=0, nrows=None, na_values=None, keep_default_na=True, na_filter=True, verbose=False, skip_blank_lines=True, parse_dates=False, infer_datetime_format=False, keep_date_col=False, date_parser=None, dayfirst=False, cache_dates=True, iterator=False, chunksize=None, compression='infer', thousands=None, decimal: str = '.', lineterminator=None, quotechar='"', quoting=0, doublequote=True, escapechar=None, comment=None, encoding=None, dialect=None, error_bad_lines=True, warn_bad_lines=True, delim_whitespace=False, low_memory=True, memory_map=False, float_precision=None) + +%pyargs https://nl.mathworks.com/help/matlab/ref/pyargs.html +% Python command: +% db = pd.read_csv('./data/cache_compounds_20160818.csv',index_col='compound_id') +% MATLAB command using pyargs +db = py.pandas.read_csv(pyargs('filepath_or_buffer',[pyLibraryFolder filesep 'data' filesep 'test_compounds.csv'],'index_col','compound_id')); + + +order = py.dict(pyargs('soup',3.57,'bread',2.29,'bacon',3.91,'salad',5.00)) +% A dictionary has pairs of keys and values. Display the menu items in the variable order using the Python keys function. +keys(order) +values(order) + +if count(py.sys.path,'') == 0 + insert(py.sys.path,int32(0),''); +end + +mymod = py.importlib.import_module('mymod') + +N = py.list({'Jones','Johnson','James'}) + +names = py.mymod.search(N) + + diff --git a/src/analysis/thermo/groupContribution/wang/conda/dGPredictor_spec-file.txt b/src/analysis/thermo/groupContribution/wang/conda/dGPredictor_spec-file.txt new file mode 100644 index 0000000000..d5f31a6709 --- /dev/null +++ b/src/analysis/thermo/groupContribution/wang/conda/dGPredictor_spec-file.txt @@ -0,0 +1,213 @@ +# This file may be used to create an environment using: +# $ conda create --name --file +# platform: linux-64 +@EXPLICIT +https://conda.anaconda.org/conda-forge/linux-64/_libgcc_mutex-0.1-conda_forge.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/ca-certificates-2020.12.5-ha878542_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/ld_impl_linux-64-2.35.1-hea4e1c9_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libgfortran5-9.3.0-hff62375_19.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libstdcxx-ng-9.3.0-h6de172a_19.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pandoc-2.12-h7f98852_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libgfortran-ng-9.3.0-hff62375_19.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libgomp-9.3.0-h2828fa1_19.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/_openmp_mutex-4.5-1_gnu.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libgcc-ng-9.3.0-h2828fa1_19.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/abseil-cpp-20210324.0-h9c3ff4c_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/aws-c-common-0.5.2-h7f98852_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/brotli-1.0.9-h9c3ff4c_4.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/bzip2-1.0.8-h7f98852_4.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/c-ares-1.17.1-h7f98852_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/gflags-2.2.2-he1b5a44_1004.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/icu-68.1-h58526e2_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/jpeg-9d-h36c2ea0_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libev-4.33-h516909a_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libffi-3.3-h58526e2_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libiconv-1.16-h516909a_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libopenblas-0.3.12-pthreads_h4812303_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libsodium-1.0.18-h36c2ea0_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libutf8proc-2.6.1-h7f98852_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libuuid-2.32.1-h7f98852_1000.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libwebp-base-1.2.0-h7f98852_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/lz4-c-1.9.3-h9c3ff4c_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/ncurses-6.2-h58526e2_4.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/openssl-1.1.1k-h7f98852_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pcre-8.44-he1b5a44_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pixman-0.40.0-h36c2ea0_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pthread-stubs-0.4-h36c2ea0_1001.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/re2-2021.04.01-h9c3ff4c_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/snappy-1.1.8-he1b5a44_3.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xorg-kbproto-1.0.7-h7f98852_1002.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xorg-libice-1.0.10-h7f98852_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xorg-libxau-1.0.9-h7f98852_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xorg-libxdmcp-1.1.3-h7f98852_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xorg-renderproto-0.11.1-h7f98852_1002.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xorg-xextproto-7.3.0-h7f98852_1002.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xorg-xproto-7.0.31-h7f98852_1007.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xz-5.2.5-h516909a_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/yaml-0.2.5-h516909a_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/zlib-1.2.11-h516909a_1010.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/aws-c-cal-0.4.5-h76129ab_8.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/aws-checksums-0.1.11-h99e32c3_3.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/gettext-0.19.8.1-h0b5b191_1005.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/glog-0.4.0-h49b9bf7_3.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libblas-3.9.0-8_openblas.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libedit-3.1.20191231-he28a2e2_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libevent-2.1.10-hcdb4288_3.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libnghttp2-1.43.0-h812cca2_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libpng-1.6.37-h21135ba_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libprotobuf-3.15.8-h780b84a_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libssh2-1.9.0-ha56f1ee_6.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libxcb-1.13-h7f98852_1003.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libxml2-2.9.10-h72842e0_3.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/readline-8.0-he28a2e2_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/s2n-1.0.0-h9b69904_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/tk-8.6.10-h21135ba_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xorg-libsm-1.2.3-hd9c2040_1000.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/zeromq-4.3.4-h9c3ff4c_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/zstd-1.4.9-ha95c52a_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/aws-c-io-0.9.1-ha5b09cb_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/boost-cpp-1.74.0-hc6e9bd1_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/freetype-2.10.4-h0708190_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/grpc-cpp-1.37.0-h36de60a_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/krb5-1.17.2-h926e7f8_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libcblas-3.9.0-8_openblas.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libglib-2.68.1-h3e27bee_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/liblapack-3.9.0-8_openblas.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libthrift-0.14.1-he6d91bd_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libtiff-4.2.0-hdc55705_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/orc-1.6.7-heec2584_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/sqlite-3.35.4-h74cdb3f_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xorg-libx11-1.7.0-h7f98852_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/aws-c-event-stream-0.2.7-h6bac3ce_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/fontconfig-2.13.1-hba837de_1005.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/lcms2-2.12-hddcbb42_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/libcurl-7.76.0-hc4aaa36_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/openjpeg-2.4.0-hf7af979_0.tar.bz2 +https://repo.anaconda.com/pkgs/main/linux-64/python-3.8.8-hdb3f193_4.conda +https://conda.anaconda.org/conda-forge/linux-64/xorg-libxext-1.3.4-h7f98852_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/xorg-libxrender-0.9.10-h7f98852_1003.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/argh-0.26.2-pyh9f0ad1d_1002.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/astor-0.8.1-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/async_generator-1.10-py_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/attrs-20.3.0-pyhd3deb0d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/aws-sdk-cpp-1.8.151-hceb1b1e_1.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/backcall-0.2.0-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/backports-1.0-py_2.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/base58-2.1.0-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/blinker-1.4-py_1.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/cachetools-4.2.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/cairo-1.16.0-h6cf1ce9_1008.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/click-7.1.2-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/decorator-5.0.6-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/defusedxml-0.7.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/entrypoints-0.3-pyhd8ed1ab_1003.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/idna-2.10-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/ipython_genutils-0.2.0-py_1.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/jmespath-0.10.0-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/json5-0.9.5-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/jupyterlab_widgets-1.0.0-pyhd8ed1ab_1.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/nest-asyncio-1.5.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/olefile-0.46-pyh9f0ad1d_1.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/pandocfilters-1.4.2-py_1.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/parso-0.8.2-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/pickleshare-0.7.5-py_1003.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/prometheus_client-0.10.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/ptyprocess-0.7.0-pyhd3deb0d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/pycparser-2.20-pyh9f0ad1d_2.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/pyparsing-2.4.7-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/python_abi-3.8-1_cp38.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/pytz-2021.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/send2trash-1.5.0-py_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/six-1.15.0-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/smmap-3.0.5-pyh44b312d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/testpath-0.4.4-py_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/threadpoolctl-2.1.0-pyh5ca1d4c_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/toml-0.10.2-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/toolz-0.11.1-py_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/webencodings-0.5.1-py_1.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/wheel-0.36.2-pyhd3deb0d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/zipp-3.4.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/babel-2.9.0-pyhd3deb0d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/certifi-2020.12.5-py38h578d9bd_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/cffi-1.14.5-py38ha65f79e_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/chardet-4.0.0-py38h578d9bd_1.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/cycler-0.10.0-py_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/future-0.18.2-py38h578d9bd_3.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/gitdb-4.0.7-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/greenlet-1.0.0-py38h709712a_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/importlib-metadata-3.10.0-py38h578d9bd_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/jedi-0.18.0-py38h578d9bd_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/kiwisolver-1.3.1-py38h1fd1430_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/markupsafe-1.1.1-py38h497a2fe_3.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/mistune-0.8.4-py38h497a2fe_1003.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/numpy-1.20.2-py38h9894fe3_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/packaging-20.9-pyh44b312d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/pexpect-4.8.0-pyh9f0ad1d_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pillow-8.1.2-py38ha0e1e83_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pycairo-1.20.0-py38h323dad1_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pyrsistent-0.17.3-py38h497a2fe_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pysocks-1.7.1-py38h578d9bd_3.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/python-dateutil-2.8.1-py_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pyyaml-5.4.1-py38h497a2fe_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pyzmq-22.0.3-py38h2035c66_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/sniffio-1.2.0-py38h578d9bd_1.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/tomlkit-0.7.0-py38h578d9bd_3.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/tornado-6.1-py38h497a2fe_1.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/traitlets-5.0.5-py_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/tzlocal-2.1-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/validators-0.18.2-pyhd3deb0d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/anyio-2.2.0-py38h578d9bd_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/argon2-cffi-20.1.0-py38h497a2fe_2.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/arrow-cpp-3.0.0-py38hd6878d3_11_cpu.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/boost-1.74.0-py38hc10631b_3.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/brotlipy-0.7.0-py38h497a2fe_1001.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/cryptography-3.4.7-py38ha5dfef3_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/deprecation-2.1.0-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/gitpython-3.1.14-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/jupyter_core-4.7.1-py38h578d9bd_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pandas-1.2.3-py38h51da96c_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/reportlab-3.5.66-py38hadf75a6_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/scipy-1.6.2-py38h7b17777_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/setuptools-49.6.0-py38h578d9bd_3.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/sqlalchemy-1.4.7-py38h497a2fe_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/terminado-0.9.4-py38h578d9bd_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/watchdog-2.0.2-py38h578d9bd_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/backports.functools_lru_cache-1.6.4-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/bleach-3.3.0-pyh44b312d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/jinja2-2.11.3-pyh44b312d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/joblib-1.0.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/jsonschema-3.2.0-pyhd8ed1ab_3.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/jupyter-packaging-0.9.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/jupyter_client-6.1.12-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/matplotlib-base-3.4.1-py38hcc49a3a_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/parquet-cpp-1.5.1-2.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/pip-21.0.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/protobuf-3.15.8-py38h709712a_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/pygments-2.8.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/pyopenssl-20.0.1-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/altair-4.1.0-py_1.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/jupyterlab_pygments-0.1.2-pyh9f0ad1d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/nbformat-5.1.3-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/pyarrow-3.0.0-py38hc9229eb_11_cpu.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/rdkit-2020.09.2-py38h0d43b38_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/scikit-learn-0.24.1-py38h658cfdd_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/urllib3-1.26.4-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/wcwidth-0.2.5-pyh9f0ad1d_2.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/botocore-1.20.49-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/nbclient-0.5.3-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/prompt-toolkit-3.0.18-pyha770c72_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/requests-2.25.1-pyhd3deb0d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/ipython-7.22.0-py38hd0cf306_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/nbconvert-6.0.7-py38h578d9bd_3.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/s3transfer-0.3.6-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/boto3-1.17.49-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/ipykernel-5.5.3-py38hd0cf306_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/jupyter_server-1.6.1-py38h578d9bd_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/jupyterlab_server-2.4.0-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/notebook-6.3.0-py38h578d9bd_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/nbclassic-0.2.7-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/linux-64/widgetsnbextension-3.5.1-py38h578d9bd_4.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/ipywidgets-7.6.3-pyhd3deb0d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/jupyterlab-3.0.14-pyhd8ed1ab_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/pydeck-0.6.1-pyh44b312d_0.tar.bz2 +https://conda.anaconda.org/conda-forge/noarch/streamlit-0.80.0-pyhd8ed1ab_0.tar.bz2 diff --git a/src/analysis/thermo/groupContribution/wang/conda/spec-file.txt b/src/analysis/thermo/groupContribution/wang/conda/spec-file.txt new file mode 100644 index 0000000000..e515f394e4 Binary files /dev/null and b/src/analysis/thermo/groupContribution/wang/conda/spec-file.txt differ diff --git a/src/analysis/thermo/groupContribution/wang/createFragmentIncidenceMatrix.m b/src/analysis/thermo/groupContribution/wang/createFragmentIncidenceMatrix.m new file mode 100644 index 0000000000..9e180b0422 --- /dev/null +++ b/src/analysis/thermo/groupContribution/wang/createFragmentIncidenceMatrix.m @@ -0,0 +1,34 @@ +function model = createFragmentIncidenceMatrix(inchi,radius,dGPredictorPath,canonicalise) +% model.G: k x g fragment incidence matrix + +if ~exist('radius','var') + radius=1; +end + +%fragment each of the inchi +fragmentedMol = autoFragment(inchi,radius); +[fragmentedMol,decomposableBool] = autoFragment(inchi,radius,dGPredictorPath,canonicalise); + +nMols=length(fragmentedMol); + +%concatentate the maps into a consolidated map where the fragments are unique +fragmentsMap = containers.Map('KeyType','char','ValueType','double'); +for i = 1:nMols + fragmentsMap = [fragmentsMap;fragmentedMol(i).smilesCounts]; +end +nFrag=length(fragmentsMap); + +model.inchi = inchi; +model.frag = keys(fragmentsMap)'; + +%preallocate the fragment incidence matrix +model.G = sparse(nMols,nFrag); + +%iterate through each fragmented inchi +%map each of the fragments to the consolidated list of fragments +keySet = keys(fragmentsMap); +for i = 1:nMols + bool = isKey(fragmentedMol(i).smilesCounts,keySet); + model.G(i,bool)=cell2mat(values(fragmentedMol(i).smilesCounts)); +end + diff --git a/src/analysis/thermo/groupContribution/wang/data/test_compounds.csv b/src/analysis/thermo/groupContribution/wang/data/test_compounds.csv new file mode 100644 index 0000000000..c7eed913bf --- /dev/null +++ b/src/analysis/thermo/groupContribution/wang/data/test_compounds.csv @@ -0,0 +1,5 @@ +compound_id,database,atom_bag,inchi,majorMSpH7,nHs,pKas,smiles_pH7,zs +C00001,KEGG,"{u'e-': 10, u'H': 2, u'O': 1}",InChI=1S/H2O/h1H2,0,[2],[],O,[0] +C00002,KEGG,"{u'e-': 260, u'C': 10, u'H': 13, u'O': 13, u'N': 5, u'P': 3}","InChI=1S/C10H16N5O13P3/c11-8-5-9(13-2-12-8)15(3-14-5)10-7(17)6(16)4(26-10)1-25-30(21,22)28-31(23,24)27-29(18,19)20/h2-4,6-7,10,16-17H,1H2,(H,21,22)(H,23,24)(H2,11,12,13)(H2,18,19,20)/t4-,6-,7-,10-/m1/s1",2,"[11, 12, 13, 14, 15, 16, 17]","[12.6, 7.42, 5.0, 3.29, 2.53, 0.9]",Nc1c2ncn([C@@H]3O[C@H](COP(=O)([O-])OP(=O)([O-])OP(=O)(O)[O-])[C@@H](O)[C@H]3O)c2ncn1,"[-5, -4, -3, -2, -1, 0, 1]" +C00003,KEGG,"{u'e-': 344, u'C': 21, u'H': 26, u'O': 14, u'N': 7, u'P': 2}","InChI=1/C21H27N7O14P2/c22-17-12-19(25-7-24-17)28(8-26-12)21-16(32)14(30)11(41-21)6-39-44(36,37)42-43(34,35)38-5-10-13(29)15(31)20(40-10)27-3-1-2-9(4-27)18(23)33/h1-4,7-8,10-11,13-16,20-21,29-32H,5-6H2,(H5-,22,23,24,25,33,34,35,36,37)/p+1/t10-,11-,13-,14-,15-,16-,20-,21-/m1/s1/fC21H28N7O14P2/h34,36H,22-23H2/q+1",3,"[23, 24, 25, 26, 27, 28, 29]","[12.7, 11.94, 11.38, 5.0, 3.26, 1.86]",NC(=O)c1c[n+](ccc1)[C@@H]1O[C@H](COP(=O)([O-])OP(=O)([O-])OC[C@H]2O[C@H]([C@H](O)[C@@H]2O)n2cnc3c(N)ncnc23)[C@@H](O)[C@H]1O,"[-4, -3, -2, -1, 0, 1, 2]" +C00004,KEGG,"{u'e-': 346, u'C': 21, u'H': 27, u'O': 14, u'N': 7, u'P': 2}","InChI=1/C21H29N7O14P2/c22-17-12-19(25-7-24-17)28(8-26-12)21-16(32)14(30)11(41-21)6-39-44(36,37)42-43(34,35)38-5-10-13(29)15(31)20(40-10)27-3-1-2-9(4-27)18(23)33/h1,3-4,7-8,10-11,13-16,20-21,29-32H,2,5-6H2,(H2,23,33)(H,34,35)(H,36,37)(H2,22,24,25)/t10-,11-,13-,14-,15-,16-,20-,21-/m1/s1/f/h34,36H,22-23H2",2,"[25, 26, 27, 28, 29, 30]","[12.9, 12.28, 5.0, 3.26, 1.86]",NC(=O)C1=CN(C=CC1)[C@@H]1O[C@H](COP(=O)([O-])OP(=O)([O-])OC[C@H]2O[C@H]([C@H](O)[C@@H]2O)n2cnc3c(N)ncnc23)[C@@H](O)[C@H]1O,"[-4, -3, -2, -1, 0, 1]" diff --git a/src/analysis/thermo/groupContribution/wang/mymod.py b/src/analysis/thermo/groupContribution/wang/mymod.py new file mode 100644 index 0000000000..6b916ff45d --- /dev/null +++ b/src/analysis/thermo/groupContribution/wang/mymod.py @@ -0,0 +1,11 @@ +# mymod.py +"""Python module demonstrates passing MATLAB types to Python functions""" +def search(words): + """Return list of words containing 'son'""" + newlist = [w for w in words if 'son' in w] + return newlist + +def theend(words): + """Append 'The End' to list of words""" + words.append('The End') + return words \ No newline at end of file diff --git a/src/analysis/thermo/groupContribution/wang/test_autoFragment.m b/src/analysis/thermo/groupContribution/wang/test_autoFragment.m new file mode 100644 index 0000000000..012eecc168 --- /dev/null +++ b/src/analysis/thermo/groupContribution/wang/test_autoFragment.m @@ -0,0 +1,23 @@ +%test autofragmentation using dGPredictor +inchi='InChI=1/C9H19NO2S2/c10-7-14-6-5-8(13)3-1-2-4-9(11)12/h8,13H,1-7,10H2,(H,11,12)/f/h11H' +inchi='InChI=1/C9H19NO2S2/c10-7-14-6-5-8(13)3-1-2-4-9(11)12/h8,13H,1-7,10H2,(H,11,12)/f/h11H' +inchi='InChI=1/C9H19NO2S2/c10-7-14-6-5-8(13)3-1-2-4-9(11)12/h8,13H,1-7,10H2,(H,11,12)/f/h11H'; +inchi='InChI=1/C9H19NO2S2/c10-7-14-6-5-8(13)3-1-2-4-9(11)12/h8,13H,1-7,10H2,(H,11,12)/f/h11H'; +radius=1; +dGPredictorPath='/home/rfleming/work/sbgCloud/code/dGPredictor';%must be absolute path to the dGPredictor github repo, i.e. no ~/ +canonicalise=0; +cacheName=[]; +debug=0; + +[fragmentedMol2,decomposableBool,inchiExistBool] = autoFragment(inchi,radius,dGPredictorPath,canonicalise,cacheName,debug); + + +fragmentedMol.inchi='InChI=1/C9H19NO2S2/c10-7-14-6-5-8(13)3-1-2-4-9(11)12/h8,13H,1-7,10H2,(H,11,12)/f/h11H'; +fragmentedMol.smilesCounts=containers.Map({'C=O','CC(=O)O','CC(C)S','CCC','CCS','CN','CO','CS','CSC','NCS'},{[1],[1],[1],[5],[1],[1],[1],[1],[1],[1]}); + + +assert(isequal(fragmentedMol.smilesCounts.keys,fragmentedMol2.smilesCounts.keys)) +assert(isequal(fragmentedMol.smilesCounts.values,fragmentedMol2.smilesCounts.values)) + + +[fragmentedMol2,decomposableBool,inchiExistBool] = autoFragment({[]},radius,dGPredictorPath,canonicalise,cacheName,debug); \ No newline at end of file diff --git a/src/analysis/thermo/inchi/new/createInChIStruct.m b/src/analysis/thermo/inchi/new/createInChIStruct.m index b352200245..c7854ab3d9 100644 --- a/src/analysis/thermo/inchi/new/createInChIStruct.m +++ b/src/analysis/thermo/inchi/new/createInChIStruct.m @@ -38,6 +38,14 @@ inchiStruct.standardWithStereoAndCharge = cell(size(mets)); inchiStruct.nonstandard = cell(size(mets)); +%populate with empty string by default +for i=1:length(inchiStruct.standard) + inchiStruct.standard{i,1} = ''; + inchiStruct.standardWithStereo{i,1} = ''; + inchiStruct.standardWithStereoAndCharge{i,1} = ''; + inchiStruct.nonstandard{i,1} = ''; +end + molBool = false(length(mets),1); if isempty(sdfFileName) % create inchi from individual mol files @@ -53,11 +61,6 @@ inchiStruct.standardWithStereo{i,1} = mol2inchi(molFileName, '-xtT/noiso/nochg'); inchiStruct.standardWithStereoAndCharge{i,1} = mol2inchi(molFileName, '-xtT/noiso'); inchiStruct.nonstandard{i,1} = mol2inchi(molFileName, '-xtFT/noiso'); - else - inchiStruct.standard{i,1} = ''; - inchiStruct.standardWithStereo{i,1} = ''; - inchiStruct.standardWithStereoAndCharge{i,1} = ''; - inchiStruct.nonstandard{i,1} = ''; end end else @@ -80,15 +83,22 @@ end % Map InChIs to mets for i = 1:length(metList1) - inchiStruct.standard(ismember(mets,metList1{i})) = standard(i); - inchiStruct.standardWithStereo(ismember(mets,metList1{i})) = standardWithStereo(i); - inchiStruct.standardWithStereoAndCharge(ismember(mets,metList1{i})) = standardWithStereoAndCharge(i); - inchiStruct.nonstandard(ismember(mets,metList1{i})) = nonstandard(i); + inchiStruct.standard(ismember(mets,metList1{i})) = standard(i,1); + inchiStruct.standardWithStereo(ismember(mets,metList1{i})) = standardWithStereo(i,1); + inchiStruct.standardWithStereoAndCharge(ismember(mets,metList1{i})) = standardWithStereoAndCharge(i,1); + inchiStruct.nonstandard(ismember(mets,metList1{i})) = nonstandard(i,1); end molBool = ismember(mets,metList1); end +% for i=1:length(inchiStruct.standard) +% inchiStruct.standard = erase(inchiStruct.standard{i,1},''''); +% inchiStruct.standardWithStereo = erase(inchiStruct.standardWithStereo{i,1},''''); +% inchiStruct.standardWithStereoAndCharge = erase(inchiStruct.standardWithStereoAndCharge{i,1},''''); +% inchiStruct.nonstandard = erase(inchiStruct.nonstandard{i,1},''''); +% end + diff --git a/src/analysis/thermo/groupContribution/new/modelMetabolitesToSDF.m b/src/analysis/thermo/molFiles/new/modelMetabolitesToSDF.m similarity index 100% rename from src/analysis/thermo/groupContribution/new/modelMetabolitesToSDF.m rename to src/analysis/thermo/molFiles/new/modelMetabolitesToSDF.m diff --git a/src/analysis/thermo/groupContribution/old/modelMetabolitesToSDF.m b/src/analysis/thermo/molFiles/old/modelMetabolitesToSDF.m similarity index 100% rename from src/analysis/thermo/groupContribution/old/modelMetabolitesToSDF.m rename to src/analysis/thermo/molFiles/old/modelMetabolitesToSDF.m diff --git a/src/analysis/thermo/protons/new/estimate_pKa.m b/src/analysis/thermo/protons/new/estimate_pKa.m index c5847339ca..458fc08604 100644 --- a/src/analysis/thermo/protons/new/estimate_pKa.m +++ b/src/analysis/thermo/protons/new/estimate_pKa.m @@ -170,8 +170,7 @@ met = umets{n}; currentInchi = uinchi{n}; if printLevel>1 - disp(n) - disp(umets{n}) + fprintf('%u\t%s',n,umets{n}) end [formula, nH, charge] = getFormulaAndChargeFromInChI(currentInchi); diff --git a/src/analysis/thermo/componentContribution/Transform.m b/src/analysis/thermo/trainingModel/Transform.m similarity index 100% rename from src/analysis/thermo/componentContribution/Transform.m rename to src/analysis/thermo/trainingModel/Transform.m diff --git a/src/analysis/thermo/componentContribution/cache/kegg_inchies.mat b/src/analysis/thermo/trainingModel/cache/kegg_inchies.mat similarity index 100% rename from src/analysis/thermo/componentContribution/cache/kegg_inchies.mat rename to src/analysis/thermo/trainingModel/cache/kegg_inchies.mat diff --git a/src/analysis/thermo/componentContribution/cache/kegg_pkas.mat b/src/analysis/thermo/trainingModel/cache/kegg_pkas.mat similarity index 100% rename from src/analysis/thermo/componentContribution/cache/kegg_pkas.mat rename to src/analysis/thermo/trainingModel/cache/kegg_pkas.mat diff --git a/src/analysis/thermo/trainingModel/cache/trainingModel.mat b/src/analysis/thermo/trainingModel/cache/trainingModel.mat new file mode 100644 index 0000000000..b98d8be7d7 Binary files /dev/null and b/src/analysis/thermo/trainingModel/cache/trainingModel.mat differ diff --git a/src/analysis/thermo/componentContribution/data/TECRDB.tsv b/src/analysis/thermo/trainingModel/data/TECRDB.tsv similarity index 85% rename from src/analysis/thermo/componentContribution/data/TECRDB.tsv rename to src/analysis/thermo/trainingModel/data/TECRDB.tsv index d3d2e8f648..4f088a6d6a 100644 --- a/src/analysis/thermo/componentContribution/data/TECRDB.tsv +++ b/src/analysis/thermo/trainingModel/data/TECRDB.tsv @@ -1,4547 +1,4546 @@ -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=07LIN/ALG_1584 07LIN/ALG spectrophotometry A 1.1.1.87 homoisocitrate dehydrogenase C05662 + C00003 = C00322 + C00288 + C00004 (1R,2S)-1-hydroxybutane-1,2,4-tricarboxylate(aq) + NAD(ox) = 2-oxoadipate(aq) + carbon dioxide(aq) + NAD(red) 0.45 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63GRE_1058 63GRE spectrophotometry C 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 4.2 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 18 310.15 7.3 2.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 25 310.15 7.3 2.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 33 310.15 7.3 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 11 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 25 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 26 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 30 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 35 310.15 7.3 2.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 14 310.15 7.3 3.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 15 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 19 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 28 310.15 7.3 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 7.5 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 17 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 35 310.15 7.3 2.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 203 303.15 6.02 1.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 430 303.15 6 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 300 303.15 6.01 2.31 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 230 303.15 5.94 2.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 277 303.15 6.12 2.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 154 303.15 6.04 0.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 205 303.15 6.03 0.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 1310 303.15 7 0.81 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 139 303.15 5.99 0.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 88 303.15 5.7 0.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 245 303.15 6.03 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 193 303.15 6 1.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 222 303.15 6 0.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 249 303.15 6.02 2.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 286 303.15 6.34 0.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 172 303.15 5.94 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 304 303.15 6 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 123 303.15 6.01 1.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 618 303.15 6 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 186 303.15 6.03 1.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 222 303.15 5.94 2.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 222 303.15 5.94 2.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 294 303.15 6.07 2.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 540 303.15 6.67 0.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 214 303.15 6.03 0.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 184 303.15 6.04 1.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 356 303.15 6.08 2.31 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 303 303.15 6.07 2.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 260 303.15 6.03 0.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 299 303.15 6.07 2.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62ESP_704 62ESP radioactivity and spectrophotometry C 2.7.7.27 glucose-1-phosphate adenylyltransferase C00002 + C00103 = C00498 + C00013 ATP(aq) + D-glucose 1-phosphate(aq) = ADPglucose(aq) + pyrophosphate(aq) 1.1 310.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STE/COO_718 53STE/COO spectrophotometric C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.01 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_660 68SU/RUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00206 = C00360 + C00131 2 dADP(aq) = dAMP(aq) + dATP(aq) 0.83 303.15 7 2.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_660 68SU/RUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00206 = C00360 + C00131 2 dADP(aq) = dAMP(aq) + dATP(aq) 0.27 303.15 7 1.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_660 68SU/RUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00206 = C00360 + C00131 2 dADP(aq) = dAMP(aq) + dATP(aq) 0.306 303.15 7 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_660 68SU/RUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00206 = C00360 + C00131 2 dADP(aq) = dAMP(aq) + dATP(aq) 0.563 303.15 7 1.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FER/STR_1112 74FER/STR enzymatic assay and spectrophotometry B 4.1.2.- D-arabino-3-hexulose phosphate formaldehyde lyase C06019 = C00199 + C00067 D-arabino-3-hexulose 6-phosphate(aq) = D-ribulose 5-phosphate(aq) + formaldehyde(aq) 4.0e-05 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_286 80COO/BLA spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 1.4e-05 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65DAW/DIC_103 65DAW/DIC spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0024 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ROS/RAP_311 64ROS/RAP spectrophotometry C 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00003 = C00127 + C00004 2 reduced glutathione(aq) + NAD(aq) = oxidized glutathione(aq) + NADH(aq) 0.001 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60FEI/NEU_1270 60FEI/NEU electrophoresis and radioactivity B 5.1.3.6 UDPglucuronate 4-epimerase C00167 = C00617 UDP-D-glucuronate(aq) = UDP-D-galacturonate(aq) 1.1 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STA_394 52STA spectrophotometry C 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.017 301.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51BLI_35 51BLI spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00473 + C00003 = C00376 + C00004 vitamin A alcohol(aq) + NAD(aq) = vitamin A aldehyde(aq) + NADH(aq) 0.033 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51BLI_35 51BLI spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00473 + C00003 = C00376 + C00004 vitamin A alcohol(aq) + NAD(aq) = vitamin A aldehyde(aq) + NADH(aq) 0.33 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51BLI_35 51BLI spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00473 + C00003 = C00376 + C00004 vitamin A alcohol(aq) + NAD(aq) = vitamin A aldehyde(aq) + NADH(aq) 3.3 310.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_759 93LAR/TEW HPLC A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 189 298.15 8.86 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_110 56KAP/CIO spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C80057 = C00022 + C80058 (S)-lactate(aq) + AP-NAD(aq)= pyruvate(aq) + AP-NADH(aq) 0.27 303.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 480 310.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 480 310.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 918 310.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 391 310.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 991 310.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 470 310.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 388 310.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63SCO/DUN_313 63SCO/DUN spectrophotometry B 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.00644 283.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63SCO/DUN_313 63SCO/DUN spectrophotometry B 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.00595 313.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63SCO/DUN_313 63SCO/DUN spectrophotometry B 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.00644 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63SLY/STA_401 63SLY/STA spectrophotometric B 2.3.1.8 phosphate acetyltransferase C00798 + C00009 = C00010 + C02405 formyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + formyl phosphate(aq) 0.14 303.15 6.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87RAO/HAR_555 87RAO/HAR enzymatic assay and spectrophotometry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 150 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87RAO/HAR_555 87RAO/HAR enzymatic assay and spectrophotometry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 2900 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99HUT/OEH_1552 99HUT/OEH calorimetry B 3.2.1.26 -fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 4.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62HOR_1266 62HOR radioactivity C 5.1.3.4 L-ribulose-phosphate 4-epimerase C01101 = C00231 L-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1 310.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55YAN/GIL_83 55YAN/GIL spectrophotometry B 1.1.1.25 shikimate dehydrogenase C00493 + C00006 = C02652 + C00005 shikimate(aq) + NADP(aq) = 5-dehydroshikimate(aq) + NADPH(aq) 0.0361 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55YAN/GIL_83 55YAN/GIL spectrophotometry B 1.1.1.25 shikimate dehydrogenase C00493 + C00006 = C02652 + C00005 shikimate(aq) + NADP(aq) = 5-dehydroshikimate(aq) + NADPH(aq) 0.175 303.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SCH/GIF_69 91SCH/GIF spectrophotometry C 1.1.1.14 L-iditol dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.032 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71KAT_220 71KAT spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.043 298.15 7.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71KAT_220 71KAT spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.13 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71KAT_220 71KAT spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.021 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67EPP/DAW_595 67EPP/DAW spectrophotometry C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0054 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67EPP/DAW_595 67EPP/DAW spectrophotometry C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.084 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67EPP/DAW_595 67EPP/DAW spectrophotometry C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.041 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_829 92KIM/KIN enzymatic assay A 3.1.3.5 5'-nucleosidase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 176 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51THE/BON_12 51THE/BON spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00011 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51THE/BON_12 51THE/BON spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0105 293.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51THE/BON_12 51THE/BON spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.09 293.15 10 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51THE/BON_12 51THE/BON spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00071 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00032 273.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0064 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.019 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0011 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00075 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00047 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00055 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00029 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0012 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00037 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00051 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0011 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0014 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.002 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0025 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0056 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0082 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0014 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00014 273.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00014 273.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.015 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0056 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0015 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0046 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00064 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00031 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 7.1e-05 273.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1608 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1608 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 303.4 8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1608 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 311.5 8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1608 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.4 8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1608 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 293.4 8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1607 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.307 293.4 8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1607 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.395 298.4 8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43KAL_633 43KAL spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.3 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72KOR/HUR_199 72KOR/HUR spectrophotometry C 1.1.1.72 glycerol dehydrogenase (NADP+) C00116 + C00006 = C00577 + C00005 glycerol(aq) + NADP(aq) = (R)-glyceraldehyde(aq) + NADPH(aq) 1.67e-06 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TRI/VOG_1050 67TRI/VOG polarimetry B 3.5.3.4 allantoicase C00499 + C00001 = C00603 + C00086 allantoate(aq) + H2O(l) = (-)-ureidoglycolate(aq) + urea(aq) 0.21 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DIT/KUB2_54 84DIT/KUB2 spectrophotometry C 1.1.1.9 D-xylulose reductase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.00043 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65WAL/SAL_202 65WAL/SAL spectrophotometry C 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 0.0001 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74DAN/CAR_473 74DAN/CAR spectrophotometry C 2.4.2.6 nucleoside deoxyribosyltransferase C05512 + C00147 = C00559 + C00262 2'-deoxyinosine(aq) + adenine(aq) = 2'-deoxyadenosine(aq) + hypoxanthine(aq) 1.4 313.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOD_1351 53BOD spectrophotometry B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.67 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_464 92KIM/KIN HPLC and enzymatic assay A 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.0164 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_145 52STE/OCH spectrophotometry B 1.1.1.37&4.1.3.7 malate dehydrogenase and citrate (si)-synthase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 0.48 295.15 6.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_145 52STE/OCH spectrophotometry B 1.1.1.37&4.1.3.7 malate dehydrogenase and citrate (si)-synthase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 599 295.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_145 52STE/OCH spectrophotometry B 1.1.1.37&4.1.3.7 malate dehydrogenase and citrate (si)-synthase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 5610 295.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_145 52STE/OCH spectrophotometry B 1.1.1.37&4.1.3.7 malate dehydrogenase and citrate (si)-synthase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 10.8 295.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_145 52STE/OCH spectrophotometry B 1.1.1.37&4.1.3.7 malate dehydrogenase and citrate (si)-synthase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 101 295.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64KEL/ALL_1421 64KEL/ALL enzymatic assay B 5.4.99.2 methylmalonyl-CoA mutase C01213 = C00091 (R)-methylmalonyl-CoA(aq) = succinyl-CoA(aq) 23.1 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_830 76LAW/GUY enzymatic assay; spectrophotometry A 3.1.3.11 fructose-biphosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 174 310.15 0.25 6.99 3.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_126 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C05268 + C00003 = C05269 + C00004 (S)-3-hydroxyhexanoyl-CoA(aq) + NAD(aq) = 3-oxohexanoyl-CoA(aq) + NADH(aq) 0.00025 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_126 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C05268 + C00003 = C05269 + C00004 (S)-3-hydroxyhexanoyl-CoA(aq) + NAD(aq) = 3-oxohexanoyl-CoA(aq) + NADH(aq) 0.025 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_126 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C05268 + C00003 = C05269 + C00004 (S)-3-hydroxyhexanoyl-CoA(aq) + NAD(aq) = 3-oxohexanoyl-CoA(aq) + NADH(aq) 0.0025 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_126 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C05268 + C00003 = C05269 + C00004 (S)-3-hydroxyhexanoyl-CoA(aq) + NAD(aq) = 3-oxohexanoyl-CoA(aq) + NADH(aq) 0.25 298.15 10 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00FRA/KOS_1534 00FRA/KOS calorimetry A 4.1.1.39 ribulose-bisphosphate carboxylase C01182 + C00007 = C00197 D-ribulose 1,5-bisphosphate(aq) + O2(aq) = 3-phospho-D-glycerate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00FRA/KOS_1533 00FRA/KOS calorimetry A 4.1.1.39 ribulose-bisphosphate carboxylase C01182 + C00288 = 2 C00197 D-ribulose 1,5-bisphosphate(aq) + carbon dioxide(aq) = 2 3-phospho-D-glycerate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_123 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.00063 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_123 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.0063 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_123 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.063 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_123 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.63 298.15 10 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47BUC_578 47BUC spectrophotometry C 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.00031 298.15 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90BHA/VIN_1514 90BHA/VIN radioactivity B 2.4.2.10 orotate phosphoribosyltransferase C01103 + C00013 = C00295 + C00119 orotidine 5 '-phosphate(aq) + pyrophosphate(aq) = orotate(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 9.3 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66DOM/ZEC_1374 66DOM/ZEC spectrophotometry C 5.3.1.14 L-rhamnose isomerase C00507 = C00861 L-rhamnose(aq) = L-rhamnulose(aq) 0.75 310.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65PIN_799 65PIN calorimetry A 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/RAI_1286 69VEE/RAI spectrophotometry A 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 22 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60JON/LIP_576 60JON/LIP chemical analysis C 2.7.2.2 carbamate kinase C00002 + C01563 = C00008 + C00169 ATP(aq) + ammonium carbamate(aq) = ADP(aq) + carbamoyl phosphate(aq) 0.042 283.15 9.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73SUG_714 73SUG enzymatic assay and spectrophotometry C 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.0049 298.15 7.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38MEY/SCH_1387 38MEY/SCH polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.8 273.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38MEY/SCH_1387 38MEY/SCH polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 9.5 293.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38MEY/SCH_1387 38MEY/SCH polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 7.9 310.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38MEY/SCH_1387 38MEY/SCH polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 7.6 333.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1291 41UTT/WER chemical analysis B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.000435 278.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1291 41UTT/WER chemical analysis B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00637 313.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1291 41UTT/WER chemical analysis B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00182 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53LYN/OCH_717 53LYN/OCH spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.01 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81GON/CHE_1326 81GON/CHE chemical analysis C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.2 313.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60NIR/JAK_193 60NIR/JAK spectrophotometry C 1.1.1.61 4-hydroxybutyrate dehydrogenase C00989 + C00003 = C00232 + C00004 4-hydroxybutanoate(aq) + NAD(aq) = 4-oxobutanoate(aq) + NADH(aq) 3.9 298.15 7.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60NIR/JAK_193 60NIR/JAK spectrophotometry C 1.1.1.61 4-hydroxybutyrate dehydrogenase C00989 + C00003 = C00232 + C00004 4-hydroxybutanoate(aq) + NAD(aq) = 4-oxobutanoate(aq) + NADH(aq) 25 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55VAR/WEB_1440 55VAR/WEB chromatography and radioactivity C 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 1700 308.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58NOL/BRU_1346 58NOL/BRU spectrophotometry C 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 1.8 310.15 5.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72LEH/TAN_452 72LEH/TAN C 2.4.1.67 galactinol-raffinose galactosyltransferase C01235 + C00492 = C00137 + C01613 1--D-galactosyl-myo-inositol(aq) + raffinose(aq) = myo-inositol(aq) + stachyose(aq) 4 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HAY/GRE_1229 71HAY/GRE enzymatic assay B 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.065 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59STR/SMI_702 59STR/SMI chromatography and spectrophotometry C 2.7.7.23 UDP-N-acetylglucosamine pyrophosphorylase C00075 + C04256 = C00043 + C00013 UTP(aq) + N-acetyl--D-glucosamine 1-phosphate(aq) = UDP-N-acetyl-D-glucosamine(aq) + pyrophosphate(aq) 0.5 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70KRI/BUC_579 70KRI/BUC spectrophotometry C 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.0003 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91MOR/FRE_329 91MOR/FRE calorimetry A 1.9.3.1 cytochrome-c oxidase 4 C00126 + C00007 = 4 C00125 + 2 C00001 4 reduced cytochrome c(aq) + O2(aq) = 4 cytochrome c(aq) + 2 H2O(l) 299.4 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43DOU_415 43DOU C 2.4.1.7 sucrose phosphorylase C00089 + C00009 = C00103 + C00095 sucrose(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-fructose(aq) 11 303.15 5.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43DOU_415 43DOU C 2.4.1.7 sucrose phosphorylase C00089 + C00009 = C00103 + C00095 sucrose(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-fructose(aq) 20 303.15 6.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MAR/COH_577 66MAR/COH radioactivity B 2.7.2.2 carbamate kinase C00002 + C01563 = C00008 + C00169 ATP(aq) + ammonium carbamate(aq) = ADP(aq) + carbamoyl phosphate(aq) 0.027 298.15 8.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53HAR/KOR_147 53HAR/KOR enzymatic assay; spectrophotometry B 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.051 297 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65KAZ/GRO_1447 65KAZ/GRO spectrophotometry and enzymatic assay C 6.4.1.3 propanoyl-CoA carboxylase C00002 + C00100 + C00288 = C00008 + C00009 + C02557 ATP(aq) + propanoyl-CoA(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + methylmalonyl-CoA(aq) 5.7 301.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.407 303.15 8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.079 303.15 8 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.043 303.15 8 2.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.043 303.15 8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.4 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.196 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.096 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.083 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.071 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.05 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.05 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.271 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.059 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.053 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.136 303.15 8 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.05 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.186 303.15 8 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.284 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.06 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.054 303.15 8 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.039 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.039 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.043 303.15 8 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.379 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.105 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.154 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.091 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.3 303.15 8 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.209 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.043 303.15 8 2.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.039 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BUR/HOR_1264 58BUR/HOR enzymatic assay B 5.1.3.4 L-ribulose-phosphate 4-epimerase C01101 = C00231 L-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.2 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62SEG/BEA_509 62SEG/BEA spectrophotometry B 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.61 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1288 34MEY/LOH spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00018 266.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1288 34MEY/LOH spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0015 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1288 34MEY/LOH spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.013 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1288 34MEY/LOH spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.022 343.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1288 34MEY/LOH spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0003 273.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1083 66WOO/DAV spectrophotometry and enzymatic assay A 4.1.1.32 phosphoenolpyruvate carboxykinase (GTP) C00081 + C00036 + C00001 = C00104 + C00074 + C00288 ITP(aq) + oxaloacetate(aq) + H2O(l) = IDP(aq) + phosphoenolpyruvate(aq) + carbon dioxide(aq) 1.7 298.15 0.1 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1083 66WOO/DAV spectrophotometry and enzymatic assay A 4.1.1.32 phosphoenolpyruvate carboxykinase (GTP) C00081 + C00036 + C00001 = C00104 + C00074 + C00288 ITP(aq) + oxaloacetate(aq) + H2O(l) = IDP(aq) + phosphoenolpyruvate(aq) + carbon dioxide(aq) 0.5 298.15 0.1 7.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1083 66WOO/DAV spectrophotometry and enzymatic assay A 4.1.1.32 phosphoenolpyruvate carboxykinase (GTP) C00081 + C00036 + C00001 = C00104 + C00074 + C00288 ITP(aq) + oxaloacetate(aq) + H2O(l) = IDP(aq) + phosphoenolpyruvate(aq) + carbon dioxide(aq) 0.71 298.15 0.1 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03TEW/GOL_1627 03TEW/GOL chromatography and calorimetry A 1.6.4.2 glutathione reductase (NADPH) 2 C00051 + C00006 = C00127 + C00005 2 glutathoine(red)(aq) + NADP(ox)(aq) = glutathoine(ox)(aq) + NADP(red)(aq) 298.15 0.35 7.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1084 66WOO/DAV spectrophotometry and enzymatic assay A 4.1.1.38 phosphoenolpyruvate carboxykinase (diphosphate) C00013 + C00036 + C00001 = C00009 + C00074 + C00288 diphosphate(aq) + oxaloacetate(aq) + H2O(l) = phosphate(aq) + phosphoenolpyruvate(aq) + carbon dioxide(aq) 0.013 298.15 0.1 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52OHL/SHA_1061 52OHL/SHA calorimetry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 302.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 3 284.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 3 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 3 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 2.9 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 3.1 274.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 3.1 279.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/SCH_798 35MEY/SCH calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 293.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CHA_622 97CHA spectrophotometry B 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 17.5 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61YAM_485 61YAM spectrophotometry C 2.4.2.15 guanosine phosphorylase C00387 + C00009 = C00242 + C00620 guanosine(aq) + orthophosphate(aq) = guanine(aq) + D-ribose 1-phosphate(aq) 0.019 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89SCH/GIF_68 89SCH/GIF spectrophotometry C 1.1.1.14 L-iditol 2-dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.0058 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62SHU/DOU_119 62SHU/DOU spectrophotometry C 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.13 305.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86MEI/GAD_306 86MEI/GAD spectrophotometry C 1.5.1.17 alanopine dehydrogenase C03210 + C00003 + C00001 = C00041 + C00022 + C00004 2,2'-iminodipropanoate(aq) + NAD(aq) + H2O(l) = L-alanine(aq) + pyruvate(aq) + NADH(aq) 1.0e-06 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89SCH/GIF_63 89SCH/GIF spectrophotometry C 1.1.1.14 L-iditol 2-dehydrogenase C00392 + C00003 = C00095 + C00004 D-mannitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.045 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86MEI/GAD_302 86MEI/GAD spectrophotometry C 1.5.1.11 D-octopine dehydrogenase C04137 + C00003 + C00001 = C00062 + C00022 + C00004 N-2-(D-1-carboxyethyl)-L-arginine(aq) + NAD(aq) + H2O(l) = L-arginine(aq) + pyruvate(aq) + NADH(aq) 3.0e-06 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51WOO/GUN_1233 51WOO/GUN enzymatic assay and manometry B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1 310.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77APP/NAI_556 77APP/NAI enzymatic assay and chromatography B 2.7.1.23 NAD+ kinase C00002 + C00003 = C00008 + C00006 ATP(aq) + NAD(aq) = ADP(aq) + NADP(aq) 29.3 303.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62GHA/HEA_1107 62GHA/HEA spectrophotometry C 4.1.2.17 L-fuculose-phosphate aldolase C01099 = C00111 + C00424 L-fuculose 1-phosphate(aq) = glycerone phosphate(aq) + (S)-lactaldehyde(aq) 0.00046 310.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.609 298.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.417 298.15 8.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.193 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0772 298.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.052 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0194 298.15 7.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0146 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0335 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WIL/ROC_1115 71WIL/ROC spectrophotometry B 4.1.3.1 isocitrate lyase C00311 = C00042 + C00048 isocitrate(aq) = succinate(aq) + glyoxylate(aq) 0.0023 303.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53GRE/BRO_634 53GRE/BRO chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.45 300.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03RAN/VAN_1602 03RAN/VAN spectophotometry B 4.1.3.1 isocitrate lyase C00311 = C00042 + C00048 isocitrate(aq) = succinate(aq) + glyoxylate(aq) 0.001 295.65 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06POD/BEL_1598 06POD/BEL calorimetry B 4.1.1.23 orotidine-5 '-phosphate decarboxylase C01103 = C00105 + C00288 orotidine 5 '-phosphate(aq) = UMP(aq) + carbon dioxide(aq) 328.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54HAN/CRA_1261 54HAN/CRA paper chromatography C 5.1.3.2&2.7.7.12 UDPglucose 4-epimerase and UDPglucose-hexose 1-phosphate uridylyltransferase C03384 = C00103 -D-galactose 1-phosphate(aq) =-D-glucose 1-phosphate(aq) 3 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69WAN/BAR_1151 69WAN/BAR spectrophotometry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.2 298.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_782 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00044 + 3 C00001 = C00387 + 3 C00009 GTP(aq) + 3 H2O(l) = guanosine(aq) + 3 orthophosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_782 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00044 + 3 C00001 = C00387 + 3 C00009 GTP(aq) + 3 H2O(l) = guanosine(aq) + 3 orthophosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_782 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00044 + 3 C00001 = C00387 + 3 C00009 GTP(aq) + 3 H2O(l) = guanosine(aq) + 3 orthophosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_782 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00044 + 3 C00001 = C00387 + 3 C00009 GTP(aq) + 3 H2O(l) = guanosine(aq) + 3 orthophosphate(aq) 308.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_781 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00144 + C00001 = C00387 + C00009 GMP(aq) + H2O(l) = guanosine(aq) + orthophosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_781 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00144 + C00001 = C00387 + C00009 GMP(aq) + H2O(l) = guanosine(aq) + orthophosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95PEL/MAC_1595 95PEL/MAC spectrophotometry and enzymatic assay B 1.5.1.5 methylenetetrahydrofolate dehydrogenase (NADP+) C00143 + C00006 = C00234 + C00005 5,10-methylenetetrahydrofolate(aq) + NADP(ox)(aq) = 10-formyltetrahydrofolate(aq) + NADP(red)(aq) 16 303.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83WED/BLA_146 83WED/BLA spectrophotometry C 1.1.1.39 malate dehydrogenase (decarboxylating) C00149 + C00003 + C00001 = C00022 + C00004 + C00288 (S)-malate(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + carbon dioxide(aq) 0.0011 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51ROW/KOR_465 51ROW/KOR fluorimetry and spectrophotometry C 2.4.2.1 purine-nucleoside phosphorylase C00153 + C00620 = C03150 + C00009 nicotinamide(aq) + D-ribose 1-phosphate(aq) = nicotinamide riboside(aq) + orthophosphate(aq) 0.00036 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99HUT/OEH_944 99HUT/OEH calorimetry B 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 4.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GEO/TRA_756 69GEO/TRA calorimetry C 3.1.3.1 alkaline phosphatase C00008 + C00001 = C00020 + C00009 + C00080 ADP-3-(aq) + H2O(l) = AMP-2--(aq) + HPO4-2-(aq) + H+(aq) 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GEO/TRA_757 69GEO/TRA calorimetry C 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP-2--(aq) + H2O(l) = adenosine(aq) + HPO4-2-(aq) 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HAB/CAN_951 59HAB/CAN enzymatic assay B 3.3.1.1 adenosylhomocysteinase C00021 + C00001 = C00212 + C00155 S-adenosyl-L-homocysteine(aq) + H2O(l) = adenosine(aq) + L-homocysteine(aq) 1.4e-06 310.15 6.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WIL/BAN_66 54WIL/BAN spectrophotometry C 1.1.1.14 L-iditol dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.0205 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1103 41UTT/WER chemical analysis B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.000435 278.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1103 41UTT/WER chemical analysis B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00637 313.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1103 41UTT/WER chemical analysis B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00182 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86POL/MEN_1318 86POL/MEN polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.06 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86POL/MEN_1318 86POL/MEN polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.093 323.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86POL/MEN_1318 86POL/MEN polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.162 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86POL/MEN_1318 86POL/MEN polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.08 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85VAN/SCH_1687 85VAN/SCH chromatography and spectrophotometry C 2.6.1.19 4-aminobutyrate aminotransferase C00334 + C00026 = C00232 + C00025 4-aminobutanoate(aq) + 2-oxoglutarate(aq) = 4-oxobutanoate(aq) + L-glutamate(aq) 0.04 295.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57DUR/STU_339 57DUR/STU calorimetry B 2.1.1.3 thetin-homocysteine S-methyltransferase C03392 + C00155 = C03173 + C00073 dimethylacetothetin(aq) + L-homocysteine(aq) = S-methylthioglycolate(aq) + L-methionine(aq) 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WUR/HES_1276 72WUR/HES enzymatic assay and spectrophotometry C 5.1.3.15 glucose-6-phosphate 1-epimerase C00668 = C01172 alpha-D-Glucose 6-phosphate(aq) = beta-D-Glucose 6-phosphate(aq) 1.7 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAK/YOS_900 65TAK/YOS calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00713 + 2 C00001 = 3 C00031 panose(aq) + 2 H2O(l) = 3 D-glucose(aq) 298.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_275 56KAP/CIO spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.43e-06 303.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97HAN/KLE_208 97HAN/KLE spectrophotometry and HPLC B 1.1.1.108 carnitine dehydrogenase C15025 + C00003 = C02636 + C00004 D-carnitine(aq) + NAD(aq) = 3-dehydrocarnitine(aq) + NADH(aq) 0.0022 295.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97HAN/KLE_208 97HAN/KLE spectrophotometry and HPLC B 1.1.1.108 carnitine dehydrogenase C15025 + C00003 = C02636 + C00004 D-carnitine(aq) + NAD(aq) = 3-dehydrocarnitine(aq) + NADH(aq) 0.00022 295.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WIL/WAK_412 66WIL/WAK chromatography and radioactivity B 2.3.1.39 [acyl-carrier-protein] S-malonyltransferase C00083 + C00229 = C00010 + C01209 malonyl-CoA(aq) + acyl-carrier protein(aq) = CoA(aq) + malonyl-[acyl-carrier protein](aq) 2.33 311.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WIL/WAK_411 66WIL/WAK chromatography and radioactivity B 2.3.1.38 [acyl-carrier-protein] S-acetyltransferase C00024 + C00229 = C00010 + C03939 acetyl-CoA(aq) + acyl-carrier protein(aq) = CoA(aq) + acetyl-[acyl-carrier protein](aq) 2.09 311.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_278 56KAP/CIO spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C80057 + C00001 = C00026 + C80058 + C00014 L-glutamate(aq) + AP-NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + AP-NADH(aq) + ammonia(aq) 0.0022 303.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56SMI/STA_1113 56SMI/STA chemical analysis and enzymatic assay B 4.1.3.1 isocitrate lyase C00311 = C00042 + C00048 isocitrate(aq) = succinate(aq) + glyoxylate(aq) 0.029 300.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80PET/AMI_144 80PET/AMI spectrophotometry C 1.1.1.37&2.6.1.1 malate dehydrogenase and aspartate aminotransferase C00025 + C00149 + C00003 = C00049 + C00026 + C00004 L-glutamate(aq) + (S)-malate(aq) + NAD(aq) = L-aspartate(aq) + 2-oxoglutarate(aq) + NADH(aq) 4.1e-05 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56AME/HOR_519 56AME/HOR spectrophotometry B 2.6.1.9 histidinol-phosphate transaminase C01100 + C00026 = C01267 + C00025 L-histidinol phosphate(aq) + 2-oxoglutarate(aq) = 3-(imidazol-4-yl)-2-oxopropyl phosphate(aq) + L-glutamate(aq) 25 310.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.321 288.15 7.25 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.588 288.15 7.25 2.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.549 288.15 7.25 2.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.971 288.15 7.25 2.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.877 288.15 7.25 2.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.24 288.15 7.25 2.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.27 288.15 7.25 2.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.45 288.15 7.25 3.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.14 288.15 7.25 3.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.82 288.15 7.25 4.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.694 288.15 7.25 4.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.341 288.15 7.25 5.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.461 288.15 7.25 5.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.478 288.15 7.25 5.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.461 288.15 7.25 6.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 288.15 7.25 6.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.469 288.15 7.25 6.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 288.15 7.25 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.422 288.15 7.25 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.23 288.15 7.25 3.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.488 288.15 7.25 5.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.488 288.15 7.25 5.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.935 288.15 7.25 2.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.38 288.15 7.25 1.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.521 288.15 7.25 4.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 288.15 7.25 6.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.518 288.15 7.25 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.352 288.15 7.25 1.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.37 288.15 7.25 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.562 288.15 7.25 4.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.452 288.15 7.25 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.794 288.15 7.25 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.794 288.15 7.25 4.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.41 288.15 7.25 3.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.383 288.15 7.25 2.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.518 288.15 7.25 5.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.617 288.15 7.25 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.461 288.15 7.25 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.317 288.15 7.25 1.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.472 288.15 7.25 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.483 288.15 7.25 6.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ISH_997 60ISH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 313.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ISH_997 60ISH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 313.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00565 298.15 0.25 6.97 3.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0069 298.15 0.25 6.98 3.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00629 298.15 0.25 6.98 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00518 298.15 0.25 6.96 3.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.005 298.15 0.25 7.01 3.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00699 311.15 0.25 6.93 3.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0073 311.15 0.25 6.93 3.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00704 311.15 0.25 6.94 3.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00685 311.15 0.25 6.94 3.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00592 311.15 0.25 6.93 3.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00444 278.15 0.25 7.03 3.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00439 278.15 0.25 7.03 3.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00444 278.15 0.25 7.03 3.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00481 278.15 0.25 7.03 3.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00388 278.15 0.25 7.02 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00389 278.15 0.25 7.07 3.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.005 288.15 0.25 7 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00535 288.15 0.25 7 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0049 288.15 0.25 7 3.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00552 288.15 0.25 7 3.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00465 288.15 0.25 6.99 3.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00465 288.15 0.25 6.99 3.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0045 288.15 0.25 7.04 3.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00602 298.15 0.25 6.97 3.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00629 311.15 0.25 6.98 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00467 288.15 0.25 7.04 3.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00535 298.15 0.25 7.01 3.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00613 311.15 0.25 6.93 3.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00637 311.15 0.25 6.98 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00376 278.15 0.25 7.02 3.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00467 288.15 0.25 6.99 3.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0051 298.15 0.25 6.96 3.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00382 278.15 0.25 7.07 3.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56LEL/CAR_1366 56LEL/CAR B 5.3.1.10 glucosamine-6-phosphate isomerase C00352 + C00001 = C00085 + C00014 D-glucosamine 6-phosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + ammonia(aq) 0.15 310.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55CAR/COH_1223 55CAR/COH spectrophotometry C 4.3.2.2 adenylosuccinate lyase C03794 = C00122 + C00020 adenylosuccinate(aq) = fumarate(aq) + AMP(aq) 0.012 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KIR/TUR_663 59KIR/TUR paper chromatography and spectrophotometry B 2.7.4.4 nucleoside-phosphate kinase C00002 + C00015 = C00008 + C00075 ATP(aq) + UDP(aq) = ADP(aq) + UTP(aq) 0.91 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MOO/REI_318 64MOO/REI spectrophotometry C 1.6.4.5 thioredoxin reductase (NADPH) C00342 + C00006 = C00343 + C00005 reduced thioredoxin(aq) + NADP(aq) = oxidized thioredoxin(aq) + NADPH(aq) 2 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MOO/REI_318 64MOO/REI spectrophotometry C 1.6.4.5 thioredoxin reductase (NADPH) C00342 + C00006 = C00343 + C00005 reduced thioredoxin(aq) + NADP(aq) = oxidized thioredoxin(aq) + NADPH(aq) 0.27 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MOO/REI_318 64MOO/REI spectrophotometry C 1.6.4.5 thioredoxin reductase (NADPH) C00342 + C00006 = C00343 + C00005 reduced thioredoxin(aq) + NADP(aq) = oxidized thioredoxin(aq) + NADPH(aq) 0.036 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1100 34MEY/LOH spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0015 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1100 34MEY/LOH spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.013 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1100 34MEY/LOH spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.022 343.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1100 34MEY/LOH spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00018 266.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1100 34MEY/LOH spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0003 273.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71UNK/GOL_1197 71UNK/GOL spectrophotometry B 4.2.1.48 D-glutamate cyclase C00217 = C02237 + C00001 D-glutamate(aq) = 5-oxo-D-proline(aq) + H2O(l) 24.3 293.4 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71UNK/GOL_1197 71UNK/GOL spectrophotometry B 4.2.1.48 D-glutamate cyclase C00217 = C02237 + C00001 D-glutamate(aq) = 5-oxo-D-proline(aq) + H2O(l) 30.3 310.9 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71UNK/GOL_1197 71UNK/GOL spectrophotometry B 4.2.1.48 D-glutamate cyclase C00217 = C02237 + C00001 D-glutamate(aq) = 5-oxo-D-proline(aq) + H2O(l) 27 302.3 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71UNK/GOL_1197 71UNK/GOL spectrophotometry B 4.2.1.48 D-glutamate cyclase C00217 = C02237 + C00001 D-glutamate(aq) = 5-oxo-D-proline(aq) + H2O(l) 26.8 303.2 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/SCH_805 35MEY/SCH calorimetry C 3.1.3.1 alkaline phosphatase C00074 + C00001 = C00022 + C00009 phosphoenolpyruvate(aq) + H2O(l) = pyruvate(aq) + orthophosphate(aq) 293.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62HAL/FEN_1446 62HAL/FEN spectrophotometry B 6.4.1.3 propanoyl-CoA carboxylase C00002 + C00100 + C00288 = C00008 + C00009 + C02557 ATP(aq) + propanoyl-CoA(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + methylmalonyl-CoA(aq) 0.0081 310.15 8.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97LIA/WU_332 97LIA/WU calorimetry B 1.11.1.6 catalase C00027 = 0.5 C00007 + C00001 H2O2(aq) = 1/2 O2(aq) + H2O(l) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/LOH_1102 35MEY/LOH calorimetry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 313.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/LOH_1102 35MEY/LOH calorimetry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 293.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1339 88TEW/STE calorimetry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 298.15 8.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SCH/KRI_1000 76SCH/KRI calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 300.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SCH/KRI_1000 76SCH/KRI calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 300.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52NEI_99 52NEI C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.003 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52NEI_99 52NEI C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 2.3e-05 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52NEI_99 52NEI C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00033 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52NEI_99 52NEI C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.044 298.15 10 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=05TEW/GOL_1634 05TEW/GOL calorimetry A 3.5.5.1 nitrilase C02938 + 2 C00001 = C00954 + C00014 3-indoleacetonitrile(aq) + 2 H2O(l) = indole-3-acetic acid(aq) + ammonia(aq) 298.15 0.29 7.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88GAU_1536 88GAU spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 2.8 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.42 2.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 2.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 2.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 298.15 8.85 3.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 304.8 8.85 3.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.54 2.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 3.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.62 2.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 2.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 7.87 2.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.99 2.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 3.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 3.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_766 88TEW/STE2 enzymatic assay and chromatography A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 262 298.15 0.29 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83CRA/BOS_19 83CRA/BOS spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00037 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57SMI/GUN_1114 57SMI/GUN spectrophotometry B 4.1.3.1 isocitrate lyase C00311 = C00042 + C00048 isocitrate(aq) = succinate(aq) + glyoxylate(aq) 0.029 300.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AVI/ALR_212 68AVI/ALR spectrophotometry C 1.1.1.119 glucose dehydrogenase (NADP+) C00031 + C00006 = C00198 + C00005 D-glucose(aq) + NADP(aq) = D-glucono-1,5-lactone(aq) + NADPH(aq) 0.297 303.15 6.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AVI/ALR_212 68AVI/ALR spectrophotometry C 1.1.1.119 glucose dehydrogenase (NADP+) C00031 + C00006 = C00198 + C00005 D-glucose(aq) + NADP(aq) = D-glucono-1,5-lactone(aq) + NADPH(aq) 3.52 303.15 6.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AVI/ALR_212 68AVI/ALR spectrophotometry C 1.1.1.119 glucose dehydrogenase (NADP+) C00031 + C00006 = C00198 + C00005 D-glucose(aq) + NADP(aq) = D-glucono-1,5-lactone(aq) + NADPH(aq) 1.13 303.15 6.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAP/ISH_312 63MAP/ISH radioactivity and fluorimetry D 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 1.5e-05 293.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAP/ISH_312 63MAP/ISH radioactivity and fluorimetry D 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.00012 293.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAP/ISH_312 63MAP/ISH radioactivity and fluorimetry D 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.00032 293.15 9.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87FIE/JOH_1530 87FIE/JOH spectrophotometric B 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(ox)(aq) = 7,8-dihydrofolate(aq) + NADP(red)(aq) 0.049 298.15 9.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CHE/HED_567 80CHE/HED flow microcalorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CHE/HED_567 80CHE/HED flow microcalorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CHE/HED_567 80CHE/HED flow microcalorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CHE/HED_567 80CHE/HED flow microcalorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72COO/MEI_523 72COO/MEI spectrophotometry B 2.6.1.15 glutamine-pyruvate aminotransaminase C00064 + C00022 = C00940 + C00041 L-glutamine(aq) + pyruvate(aq) = 2-oxoglutaramate(aq) + L-alanine(aq) 340 310.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72COO/MEI_521 72COO/MEI spectrophotometry B 2.6.1.15 glutamine-pyruvate aminotransaminase C00064 + C00048 = C00940 + C00037 L-glutamine(aq) + glyoxylate(aq) = 2-oxoglutaramate(aq) + glycine(aq) 607 310.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 85.4 311.15 0.25 6.81 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 78 311.15 0.25 6.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 82.6 311.15 0.25 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 98.8 311.15 0.25 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 93.9 311.15 0.25 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 83.7 311.15 0.25 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 81.8 311.15 0.25 6.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 85 311.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 89.5 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 81.5 311.15 0.25 7.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 93 311.15 0.25 7.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 99.5 311.15 0.25 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.4 311.15 0.25 7.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 96.4 311.15 0.25 7.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 92.2 311.15 0.25 7.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 96.2 311.15 0.25 7.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 86.1 311.15 0.25 7.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 95.1 311.15 0.25 7 2.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 80.6 311.15 0.25 7 2.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 91.6 311.15 0.25 7 2.58 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.9 311.15 0.25 7 2.57 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.9 311.15 0.25 7 2.57 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 83.6 311.15 0.25 7 2.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 76.9 311.15 0.25 7 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 84.8 311.15 0.25 7 2.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 73.5 311.15 0.25 7 1.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 73 311.15 0.25 7 1.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 103 311.15 0.07 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 112 311.15 0.07 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 69.5 311.15 0.5 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 84.7 311.15 0.5 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 67.9 311.15 0.75 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 68 311.15 0.75 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.1 311.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 79.6 311.15 0.25 7 2.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 86.1 311.15 0.25 7 2.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 64 311.15 0.75 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 100 311.15 0.25 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 101 311.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 89.6 311.15 0.25 7.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.6 311.15 0.25 7.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.6 311.15 0.25 7 2.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.6 311.15 0.25 7 2.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 101 311.15 0.07 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 73.9 311.15 0.5 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 65.5 311.15 0.75 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 93.6 311.15 0.25 7.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 93.4 311.15 0.25 7 2.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 74.9 311.15 0.25 7 2.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 110 311.15 0.07 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 90.7 311.15 0.25 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 84.4 311.15 0.25 7.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 74.6 311.15 0.5 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 87.7 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_104 67WIL/LUN spectrophotometry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 9.36e-05 311.15 0.045 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_104 67WIL/LUN spectrophotometry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0001023 311.15 0.138 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_104 67WIL/LUN spectrophotometry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.000111 311.15 0.258 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_104 67WIL/LUN spectrophotometry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 9.67e-05 311.15 0.077 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_1152 80COO/BLA spectrophotometry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.25 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 6.01e-06 298.15 7.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 7.68e-06 298.15 7.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 1.96e-05 298.15 8.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.000115 298.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.000119 298.15 9.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.000268 298.15 9.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 5.32e-05 298.15 8.73 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 1.8e-05 298.15 8.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 5.26e-05 298.15 8.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.00016 298.15 9.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CAM/SGA_950 80CAM/SGA spectrophotometry B 3.2.2.7 adenosine nucleosidase C00212 + C00001 = C00147 + C00121 adenosine(aq) + H2O(l) = adenine(aq) + D-ribose(aq) 53 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_543 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00095 = C00008 + C00085 ATP(aq) + D-fructose(aq) = ADP(aq) + D-fructose 6-phosphate(aq) 301.66 8.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_543 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00095 = C00008 + C00085 ATP(aq) + D-fructose(aq) = ADP(aq) + D-fructose 6-phosphate(aq) 298.19 8.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_543 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00095 = C00008 + C00085 ATP(aq) + D-fructose(aq) = ADP(aq) + D-fructose 6-phosphate(aq) 298.19 8.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_543 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00095 = C00008 + C00085 ATP(aq) + D-fructose(aq) = ADP(aq) + D-fructose 6-phosphate(aq) 305.11 8.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74TUR/GIL_693 74TUR/GIL spectrophotometry C 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.16 305.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65BUL/HAN_510 65BUL/HAN spectrophotometry C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 2.2 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90SAN/SIN_1363 90SAN/SIN enzymatic assay + spectrophotometry C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.3 303.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88GUI/SNE_1547 88GUI/SNE spectrophotometry B 1.1.1.65 pyridoxine 4-dehydrogenase C00314 + C00006 = C00250 + C00005 pyridoxine(aq) + NADP(ox)(aq) = pyridoxal(aq) + NADP(red)(aq) 0.0071 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88GUI/SNE_1547 88GUI/SNE spectrophotometry B 1.1.1.65 pyridoxine 4-dehydrogenase C00314 + C00006 = C00250 + C00005 pyridoxine(aq) + NADP(ox)(aq) = pyridoxal(aq) + NADP(red)(aq) 3.9e-06 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58NOL/BRU_1353 58NOL/BRU spectrophotometry C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.67 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.0758 309.8 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.127 317.7 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.00898 278.3 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.034 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.0165 287.9 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.0641 309.8 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70MAN/HOL_708 70MAN/HOL B 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 8.5 303.15 7.36 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_458 92KIM/KIN HPLC and enzymatic assay A 2.4.2.1 purine-nucleoside phosphorylase C00387 + C00009 = C00242 + C00620 guanosine(aq) + orthophosphate(aq) = guanine(aq) + D-ribose 1-phosphate(aq) 0.00926 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_22 56KAP/CIO spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C80057 = C00084 + C80058 ethanol(aq) + AP-NAD(aq) = acetaldehyde(aq) + AP-NADH(aq) 0.03 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_22 56KAP/CIO spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C80057 = C00084 + C80058 ethanol(aq) + AP-NAD(aq) = acetaldehyde(aq) + AP-NADH(aq) 0.3 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70NAK/TSU_205 70NAK/TSU spectrophotometry C 1.1.1.96 diiodophenylpyruvate reductase C04367 + C00003 = C01244 + C00004 -(3,5-diiodo-4-hydroxyphenyl)lactate(aq) + NAD(aq) =-(3,5-diiodo-4-hydroxyphenyl)pyruvate(aq) + NADH(aq) 8.2e-07 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KIS/HOL_262 99KIS/HOL calorimetry A 1.3.1.12 prephenate dehydrogenase C00254 + C00003 = C01179 + C00004 + C00288 prephenate(aq) + NAD(aq) = 4-hydroxyphenylpyruvate(aq) + NADH(aq) + carbon dioxide(aq) 298.15 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 7.94 310.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.1 310.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.13 310.15 9.1 1.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.13 310.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.45 310.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.15 310.15 9.1 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.12 310.15 9.1 1.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.29 310.15 9.1 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.15 310.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.13 310.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.1 310.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.26 310.15 8.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.23 310.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.17 310.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.24 310.15 9.1 1.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.15 310.15 5.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.1 310.15 9.1 1.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0926 310.15 9.1 1.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.37 310.15 6.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56COW/PIZ_1389 56COW/PIZ polarimetry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5 310.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KIT/HEM_986 59KIT/HEM calorimetry A 3.5.1.1 asparaginase C00152 + C00001 = C00049 + C00014 L-asparagine(aq) + H2O(l) = L-aspartate(aq) + ammonia(aq) 295 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53SIE/POT_635 53SIE/POT spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1 303.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40COH_495 40COH C 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.25 311.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71KUN/STA_1422 71KUN/STA spectrophotometry B 5.4.99.4 2-methyleneglutarate mutase C02930 = C02295 2-methyleneglutarate(aq) = methylitaconate(aq) 0.23 307.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70NAK/FUJ_535 70NAK/FUJ spectrophotometry B 2.6.1.39 2-aminoadipate transaminase C00956 + C00026 = C00322 + C00025 L-2-aminoadipate(aq) + 2-oxoglutarate(aq) = 2-oxoadipate(aq) + L-glutamate(aq) 1.32 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37NEG/WUL_9 37NEG/WUL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000741 293.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WU/WIT_811 67WU/WIT calorimetry A 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 6.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WU/WIT_811 67WU/WIT calorimetry A 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 6.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WU/WIT_811 67WU/WIT calorimetry A 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 6.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WU/WIT_811 67WU/WIT calorimetry A 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 6.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66REI_1356 66REI spectrophotometry C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.32 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52OHL/SHA_1070 52OHL/SHA calorimetry B 3.6.1.9 nucleotide pyrophosphatase C00003 + C00001 = C00455 + C00020 NAD(aq) + H2O(l) =-nicotinamide mononucleotide(aq) + AMP(aq) 306.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04DAS/BOM_1522 04DAS/BOM calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04DAS/BOM_1522 04DAS/BOM calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JES_999 75JES calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JES_999 75JES calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JES_999 75JES calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JES_999 75JES calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JES_999 75JES calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82REH/YOU_232 82REH/YOU calorimetry B 1.1.3.6&1.11.1.6 cholesterol oxidase and catalase C00187 + 0.5 C00007 = C00599 + C00001 cholesterol(aq) + 1/2 O2(aq) = cholest-4-en-3-one(aq) + H2O(l) 303.15 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61BEN/SCH_1408 61BEN/SCH enzymatic assay B 5.4.2.6 _-phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 24 310.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.61 303.15 7.4 2.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.54 303.15 7.4 3.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.56 303.15 7.4 2.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.83 303.15 7.4 2.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.8 303.15 7.4 2.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.69 303.15 7.4 2.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.63 303.15 7.4 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.02 303.15 7.4 2.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.17 303.15 7.4 1.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.29 303.15 7.4 1.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.22 303.15 7.4 1.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.45 303.15 7.4 3.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.92 303.15 7.4 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.72 303.15 7.4 2.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.94 303.15 7.4 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.28 303.15 7.4 1.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.65 303.15 7.4 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.04 303.15 7.4 2.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1 303.15 7.4 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.57 303.15 7.4 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 2.13 303.15 7.4 2.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1.34 303.15 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1.62 303.15 7.4 2.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.54 303.15 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.73 303.15 7.4 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1.66 303.15 7.4 2.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1.35 303.15 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1.69 303.15 7.4 2.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.91 303.15 7.4 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.6 303.15 7.4 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.7 303.15 7.4 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.52 303.15 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.35 303.15 7.4 2.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 2 303.15 7.4 2.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.65 303.15 7.4 2.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.24 303.15 7.4 2.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 2.36 303.15 7.4 1.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.43 303.15 7.4 2.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.23 303.15 7.4 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.82 303.15 7.4 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.65 303.15 7.4 2.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.03 303.15 7.4 2.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 0.93 303.15 7.4 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.96 303.15 7.4 2.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.84 303.15 7.4 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 2.75 303.15 7.4 1.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.13 303.15 7.4 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 2.39 303.15 7.4 1.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.33 303.15 7.4 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 2.16 303.15 7.4 1.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.22 303.15 7.4 2.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.17 303.15 7.4 2.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 2.72 303.15 7.4 1.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 2.4 303.15 7.4 1.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.98 303.15 7.4 2.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.92 303.15 7.4 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.43 303.15 7.4 2.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.9 303.15 7.4 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 2.34 303.15 7.4 1.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.31 303.15 7.4 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.67 303.15 7.4 2.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.46 303.15 7.4 2.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.68 303.15 7.4 2.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 0.85 303.15 7.4 3.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.33 303.15 7.4 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 2.05 303.15 7.4 2.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.16 303.15 7.4 3.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 2.63 303.15 7.4 1.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.38 303.15 7.4 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.01 303.15 7.4 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.17 303.15 7.4 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 0.96 303.15 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 2.49 303.15 7.4 1.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.04 303.15 7.4 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 2.04 303.15 7.4 1.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.74 303.15 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.41 303.15 7.4 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 2.41 303.15 7.4 1.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.75 303.15 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 2.25 303.15 7.4 1.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.17 303.15 7.4 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 0.87 303.15 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 298.15 6.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 304.4 6.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 304.4 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 304.4 7.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 310.15 6.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 304.4 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 310.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.33 292.15 6.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.275 292.15 6.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.579 304.15 6.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.221 310.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.194 310.15 6.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.416 310.15 6.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.247 310.15 6.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.644 310.15 6.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.565 310.15 6.59 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.536 310.15 6.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 1.71 310.15 7.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 7.46 310.15 7.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 4.16 310.15 7.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.725 316.15 6.59 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 1.19 322.15 6.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.776 322.15 6.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.694 310.15 6.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.59 310.15 6.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.469 304.15 6.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.756 310.15 6.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 1.051 310.15 6.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 1.051 310.15 6.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.445 298.15 6.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.382 298.15 6.59 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.524 310.15 6.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.879 316.15 6.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 1.13 310.15 6.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DIT/KUB_80 84DIT/KUB spectrophotometry C 1.1.1.21 aldehyde reductase C00379 + C00006 = C00181 + C00005 xylitol(aq) + NADP(aq) = D-xylose(aq) + NADPH(aq) 0.0032 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STA/BUR_241 55STA/BUR C 1.2.1.10 acetaldehyde dehydrogenase (acetylating) C00084 + C00010 + C00003 = C00024 + C00004 acetaldehyde(aq) + CoA(aq) + NAD(aq) = acetyl-CoA(aq) + NADH(aq) 1200 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_280 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.6e-06 300.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_280 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.5e-06 300.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_280 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.6e-07 300.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_282 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 9.9e-07 300.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_282 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.1e-06 300.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_282 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.1e-07 300.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_98 50RAC spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.000139 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_98 50RAC spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00044 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_98 50RAC spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0044 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_98 50RAC spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00139 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_675 92KIM/KIN spectrophotometry and fluorimetry A 2.7.6.1 ribose-phosphate pyrophosphokinase C00002 + C00117 = C00020 + C00119 ATP(aq) + D-ribose 5-phosphate(aq) = AMP(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 64.8 311.15 0.25 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62RAV/WOL_130 62RAV/WOL spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000103 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66DED_421 66DED spectrophotometry D 2.4.1.10 levansucrase C00089 + C06215 = C00031 + C06215 sucrose(aq) + (2,6--D-fructosyl)n(aq) = D-glucose(aq) + (2,6--D-fructosyl)n+1(aq) 0.036 310.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65LEE/DOB_211 65LEE/DOB spectrophotometry C 1.1.1.119 glucose dehydrogenase (NADP+) C00031 + C00006 = C00198 + C00005 D-glucose(aq) + NADP(aq) = D-glucono-1,5-lactone(aq) + NADPH(aq) 3.4 298.15 6.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92ELL/SRI_936 92ELL/SRI HPLC A 3.2.1.23 _-galactosidase C07064 + C00001 = C00124 + C00095 lactulose(aq) + H2O(l) = D-galactose(aq) + D-fructose(aq) 40 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ZAN/BAC_1714 64ZAN/BAC spectrophotometry B 1.1.1.17 mannitol-1-phosphate 5-dehydrogenase C00644 + C00003 = C00085 + C00004 D-mannitol-1-phosphate(aq) + NAD(ox)(aq) = D-fructose 6-phosphate(aq) + NAD(red)(aq) 1 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ZAN/BAC_1714 64ZAN/BAC spectrophotometry B 1.1.1.17 mannitol-1-phosphate 5-dehydrogenase C00644 + C00003 = C00085 + C00004 D-mannitol-1-phosphate(aq) + NAD(ox)(aq) = D-fructose 6-phosphate(aq) + NAD(red)(aq) 1.1 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75DON/BAR_106 75DON/BAR calorimetry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71BRI/CLA_1517 71BRI/CLA radioactivity C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.9 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1183 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C00463 + C00065 = C00078 + C00001 indole(aq) + L-serine(aq) = L-tryptophan(aq) + H2O(l) 283.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1183 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C00463 + C00065 = C00078 + C00001 indole(aq) + L-serine(aq) = L-tryptophan(aq) + H2O(l) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1183 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C00463 + C00065 = C00078 + C00001 indole(aq) + L-serine(aq) = L-tryptophan(aq) + H2O(l) 308.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1183 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C00463 + C00065 = C00078 + C00001 indole(aq) + L-serine(aq) = L-tryptophan(aq) + H2O(l) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1180 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C00118 + C00463 = C03506 D-glyceraldehyde 3-phosphate(aq) + indole(aq) = 1-(indol-3-yl)glycerol 3-phosphate(aq) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1187 85WIE/HIN calorimetry A 4.2.1.20 tryptophan synthase C00065 = C00022 + C00014 L-serine(aq) = pyruvate(aq) + ammonia(aq) 308.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1185 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C03506 + C00065 = C00078 + C00118 + C00001 1-(indol-3-yl)glycerol 3-phosphate(aq) + L-serine(aq) = L-tryptophan(aq) + D-glyceraldehyde 3-phosphate(aq) + H2O(l) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61WIL/WIL_1209 61WIL/WIL chemical analysis B 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.022 312.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61WIL/WIL_1209 61WIL/WIL chemical analysis B 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.01 302.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53RAT/ANS_1222 53RAT/ANS chemical analysis B 4.3.2.1 arginosuccinate lyase C03406 = C00122 + C00062 N-(L-argino)succinate(aq) = fumarate(aq) + L-arginine(aq) 0.0114 311.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DEW/EMI_946 86DEW/EMI HPLC B 3.2.2.4 AMP nucleosidase C00020 + C00001 = C00147 + C00117 AMP(aq) + H2O(l) = adenine(aq) + D-ribose 5-phosphate(aq) 170 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82SAL/JOR_462 82SAL/JOR NMR C 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.038 310.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81RAM/PIC_652 81RAM/PIC radioactivity C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.09 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73WUR/HES_164 73WUR/HES spectrophotometry C 1.1.1.49 glucose-6-phosphate dehydrogenase C00092 + C00006 = C01236 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) = D-glucono-1,5-lactone 6-phosphate(aq) + NADPH(aq) 20 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 379 298.15 8.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 439 298.15 9.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 2430 298.15 10.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 1860 298.15 7.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 622 298.15 8.48 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 10300 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 318 298.15 9.31 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 0.0733 298.15 4.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 0.127 298.15 5.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 0.221 298.15 5.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 11 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 12.7 298.15 7.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 0.818 298.15 5.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/CRO_16 79COR/CRO spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000194 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MAT_1275 66MAT chromatography and radioactivity B 5.1.3.10 CDPabequose epimerase C03598 = C03599 CDP-3,6-dideoxy-D-glucose(aq) = CDP-3,6-dideoxy-D-mannose(aq) 1.3 310.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74WON/FRE_697 74WON/FRE enzymatic assay B 2.7.7.12 UDPglucose-hexose-1-phosphate uridylyltransferase C00029 + C03384 = C00103 + C00052 UDPglucose(aq) + D-galactose 1-phosphate(aq) =-D-glucose 1-phosphate(aq) + UDPgalactose(aq) 2.1 300.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SCH/KRI_107 76SCH/KRI calorimetry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57BUR/HOR_1263 57BUR/HOR enzymatic assay C 5.1.3.4 L-ribulose-phosphate 4-epimerase C01101 = C00231 L-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73ROT/KIS_300 73ROT/KIS calorimetry A 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60BLA_349 60BLA spectrophotometry B 2.1.2.1 glycine hydroxymethyltransferase C00143 + C00037 + C00001 = C00101 + C00065 5,10-methylenetetrahydrofolate(aq) + glycine(aq) + H2O(l) = tetrahydrofolate(aq) + L-serine(aq) 0.098 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55HOR/SMY_371 55HOR/SMY paper chromatography C 2.2.1.2 transaldolase C05382 + C00118 = C00279 + C00085 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phosphate(aq) + D-fructose 6-phosphate(aq) 0.82 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62DOU2_160 62DOU2 spectrophotometry C 1.1.1.48 galactose dehydrogenase C00124 + C00003 = C03383 + C00004 D-galactose(aq) + NAD(aq) = D-galactono-1,4-lactone(aq) + NADH(aq) 570 303.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55CAR/LEL_423 55CAR/LEL spectrophotometry C 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 5 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/GOL_1636 00TEW/GOL calorimetry and chromatography A 2.6.1.42 branched-chain-amino-acid transferase C00183 + C00026 = C06255 + C00025 L-valine(aq) + 2-oxoglutarate(aq) = 2-oxovalerate(aq) + L-glutamate(aq) 298.15 0.31 7.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/GOL_1637 00TEW/GOL calorimetry and chromatography A 2.6.1.42 branched-chain-amino-acid transferase C00123 + C00026 = C00233 + C00025 L-leucine(aq) + 2-oxoglutarate(aq) = 2-oxoisocaproate(aq) + L-glutamate(aq) 2.42 298.15 0.31 7.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/GOL_1635 00TEW/GOL calorimetry and chromatography A 2.6.1.42 branched-chain-amino-acid transferase C00183 + C00026 = C06255 + C00025 L-valine(aq) + 2-oxoglutarate(aq) = 2-oxovalerate(aq) + L-glutamate(aq) 1.67 298.15 0.31 7.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=01AND/LEV_1510 01AND/LEV chromatography B 2.4.1.216 trehalose-6-phosphate phosphorylase C00689 + C00009 = C00103 + C00092 ,-trehalose 6-phosphate(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-glucose 6-phosphate(aq) 0.032 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=01AND/LEV_1510 01AND/LEV chromatography B 2.4.1.216 trehalose-6-phosphate phosphorylase C00689 + C00009 = C00103 + C00092 ,-trehalose 6-phosphate(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-glucose 6-phosphate(aq) 0.026 308.15 6.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45OHL_817 45OHL calorimetry B 3.1.3.2 acid phosphatase C00002 + 3 C00001 = C00212 + 3 C00009 ATP(aq) + 3 H2O(l) = adenosine(aq) + 3 orthophosphate(aq) 297.45 3.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45OHL_816 45OHL calorimetry B 3.1.3.2 acid phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 297.45 3.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93WER/TWE_1192 93WER/TWE HPLC B 4.2.1.35 (R)-2-methylmalate dehydratase C02612 = C02226 + C00001 (R)-2-methylmalate(aq) = 2-methylmaleate(aq) + H2O(l) 0.00962 298.15 0.1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/GOL_1638 00TEW/GOL calorimetry and chromatography A 2.6.1.42 branched-chain-amino-acid transferase C00123 + C00026 = C00233 + C00025 L-leucine(aq) + 2-oxoglutarate(aq) = 2-oxoisocaproate(aq) + L-glutamate(aq) 298.15 0.31 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.00082 293.15 7.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.0113 293.15 8.31 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.000474 293.15 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.00299 293.15 7.79 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.00339 293.15 7.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.0128 293.15 8.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.0116 293.15 8.36 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.000723 293.15 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.000922 293.15 7.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.00337 293.15 7.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.000637 293.15 7.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67POE/GUT_319 67POE/GUT calorimetry B 1.6.99.3 NADH dehydrogenase 2 C00004 + C00007 = 2 C00003 + 2 C00001 2 NADH(aq) + O2(aq) = 2 NAD(aq) + 2 H2O(l) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_140 80COO/BLA spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00071 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HAU_265 56HAU spectrophotometry C 1.3.99.2 butyryl-CoA dehydrogenase C00136 + C01748 = C00877 + C01748 butanoyl-CoA(aq) + pyocyanine(aq) = 2-butenoyl-CoA(aq) + reduced pyocyanine(aq) 0.23 303.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70KNO/HAN_690 70KNO/HAN B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.155 303.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47KAL_1556 47KAL spectrophotometry B 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.019 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.48 298.15 0.0516 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.54 298.15 0.1014 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.52 298.15 0.01 6.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.44 298.15 0.01 6.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.33 298.15 0.0015 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.43 298.15 0.0216 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.38 298.15 0.0115 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.41 298.15 0.01 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.38 298.15 0.01 7.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.35 298.15 0.0061 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=05TEW/GOL_1629 05TEW/GOL calorimetry A 3.5.5.1 nitrilase C09814 + 2 C00001 = C00180 + C00014 benzonitrile(aq) + 2 H2O(aq) = benzoic acid(aq) + ammonia(aq) 298.15 0.29 7.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.68 2.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.8 3.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.8 2.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.83 3.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 298.15 8.9 3.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 304.8 8.9 3.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 9.15 2.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.58 2.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.8 2.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.8 2.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 298.15 8.9 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.53 2.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 7.87 2.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.83 3.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DAS/BRO_746 85DAS/BRO calorimetry C 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 310.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DAS/BRO_746 85DAS/BRO calorimetry C 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 310.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75SUN_700 75SUN radioactivity C 2.7.7.14 ethanolamine-phosphate cytidylyltransferase C00063 + C00346 = C00013 + C00570 CTP(aq) + O-phosphorylethanolamine(aq) = pyrophosphate(aq) + CDPethanolamine(aq) 0.46 310.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52OHL/SHA_792 52OHL/SHA calorimetry B 3.1.3.1 alkaline phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 302.15 9.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65EIC/CYN_214 65EIC/CYN spectrophotometry C 1.1.1.125 2-deoxy-D-gluconate dehydrogenase C02782 + C00003 = C03926 + C00004 2-deoxy-D-gluconate(aq) + NAD(aq) = 2-deoxy-3-dehydro-D-gluconate(aq) + NADH(aq) 0.0034 308.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34JAC_1142 34JAC polarimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 8.4 278.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34JAC_1142 34JAC polarimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.5 288.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34JAC_1142 34JAC polarimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.1 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34JAC_1142 34JAC polarimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.8 311.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34JAC_1142 34JAC polarimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 2.1 327.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64LOW/PAS_1093 64LOW/PAS fluorimetry A 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 9.3e-05 311.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43KUB/OTT_97 43KUB/OTT spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 6.0e-05 295.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65GHO/ROS_1274 65GHO/ROS spectrophotometry and radioactivity C 5.1.3.9 N-acylglucosamine-6-phosphate 2-epimerase C00357 = C04257 N-acetyl-D-glucosamine 6-phosphate(aq) = N-acetyl-D-mannosamine 6-phosphate(aq) 0.43 310.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ROS/ADA_1133 67ROS/ADA enzymatic assay, spectrophotometry, and chemical analysis B 4.1.3.16 4-hydroxy-2-oxoglutarate aldolase C01127 = C00022 + C00048 4-hydroxy-2-oxoglutarate(aq) = pyruvate(aq) + glyoxylate(aq) 0.01 310.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAT/HUE_297 63MAT/HUE spectrophotometry B 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 6.1e-05 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAT/HUE_297 63MAT/HUE spectrophotometry B 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 0.00056 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84KOL/EGG_1201 84KOL/EGG spectrophotometry B 4.2.1.85 dimethylmaleate hydratase C03652 = C00922 + C00001 (2R,3S)-2,3-dimethylmalate(aq) = dimethylmaleate(aq) + H2O(l) 0.43 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_821 49MEY/GRE chemical analysis C 3.1.3.2 acid phosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 5.3 311.15 5.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GER/WES_839 75GER/WES calorimetry A 3.1.4.- phosphohydrolase (unclassified) C00575 + C00001 = C01367 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = adenosine 3'-monophosphate(aq) 310.15 7.2 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GER/WES_839 75GER/WES calorimetry A 3.1.4.- phosphohydrolase (unclassified) C00575 + C00001 = C01367 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = adenosine 3'-monophosphate(aq) 298.15 7.3 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GER/WES_838 75GER/WES calorimetry A 3.1.4.17 3',5'-cyclic-nucleotide phosphodiesterase C00575 + C00001 = C00020 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = AMP(aq) 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GER/WES_838 75GER/WES calorimetry A 3.1.4.17 3',5'-cyclic-nucleotide phosphodiesterase C00575 + C00001 = C00020 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = AMP(aq) 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53NIS/BAR_499 53NIS/BAR spectrophotometry B 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.13 310.65 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92WAN/CHE_747 92WAN/CHE calorimetry B 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92WAN/CHE_747 92WAN/CHE calorimetry B 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KEN_1037 74KEN spectrophotometry C 3.5.2.3 dihydroorotase C00337 + C00001 = C00438 (S)-dihydroorotate(aq) + H2O(l) = N-carbamoyl-L-aspartate(aq) 5.9 310.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62MEN_672 62MEN chromatography and spectrophotometry C 2.7.4.14 cytidylate kinase C00002 + C00055 = C00008 + C00112 ATP(aq) + CMP(aq) = ADP(aq) + CDP(aq) 1 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK_1303 67TAK chemical analysis and polarimetry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.74 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK_1303 67TAK chemical analysis and polarimetry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.15 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK_1303 67TAK chemical analysis and polarimetry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.3 343.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK_1303 67TAK chemical analysis and polarimetry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.92 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70TSU/FRI_291 70TSU/FRI spectrophotometry C 1.4.1.12 2,4-diaminopentanoate dehydrogenase C03943 + C00003 + C00001 = C03341 + C00004 + C00014 2,4-diaminopentanoate(aq) + NAD(aq) + H2O(l) = 2-amino-4-oxopentanoate(aq) + NADH(aq) + ammonia(aq) 0.000324 301.15 8.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92ELL/SRI_933 92ELL/SRI HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 152 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KAP/COL_309 53KAP/COL spectrophotometry B 1.6.1.1 NAD(P)+ transhydrogenase C00003 + C00005 = C00004 + C00006 NAD(aq) + NADPH(aq) = NADH(aq) + NADP(aq) 1.48 310.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KAP/COL_309 53KAP/COL spectrophotometry B 1.6.1.1 NAD(P)+ transhydrogenase C00003 + C00005 = C00004 + C00006 NAD(aq) + NADPH(aq) = NADH(aq) + NADP(aq) 1.43 310.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KAP/COL_309 53KAP/COL spectrophotometry B 1.6.1.1 NAD(P)+ transhydrogenase C00003 + C00005 = C00004 + C00006 NAD(aq) + NADPH(aq) = NADH(aq) + NADP(aq) 1.41 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_13 56KAP/CIO spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0016 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_13 56KAP/CIO spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00016 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1292 43MEY/JUN chemical analysis and polarimetry B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0024 311.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1292 43MEY/JUN chemical analysis and polarimetry B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.002 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1292 43MEY/JUN chemical analysis and polarimetry B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.003 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1292 43MEY/JUN chemical analysis and polarimetry B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.011 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72DUF/NEL_1526 72DUF/NEL enzymatic assay B 2.6.1.19 4-aminobutyrate transaminase C00334 + C00026 = C00232 + C00025 4-aminobutanoate(aq) + 2-oxoglutarate(aq) = 4-oxobutanoate(aq) + L-glutamate(aq) 0.29 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66CHA/WIL_327 66CHA/WIL spectrophotometry and electrophoresis B 1.8.4.3 glutathione-CoA-glutathione transhydrogenase C00010 + C00127 = C00920 + C00051 CoA(aq) + oxidized glutathione(aq) = CoA-glutathione(aq) + reduced glutathione(aq) 1.25 298.15 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97KAS/TEW_1423 97KAS/TEW calorimetry A 5.4.99.5 chorismate mutase C00251 = C00254 chorismate(aq) = prephenate(aq) 298.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97KAS/TEW_1423 97KAS/TEW calorimetry A 5.4.99.5 chorismate mutase C00251 = C00254 chorismate(aq) = prephenate(aq) 298.15 6.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BOS/YAM_471 74BOS/YAM spectrophotometry C 2.4.2.3 uridine phosphorylase C00299 + C00009 = C00106 + C00620 uridine(aq) + orthophosphate(aq) = uracil(aq) + D-ribose 1-phosphate(aq) 0.078 310.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BOS/YAM_471 74BOS/YAM spectrophotometry C 2.4.2.3 uridine phosphorylase C00299 + C00009 = C00106 + C00620 uridine(aq) + orthophosphate(aq) = uracil(aq) + D-ribose 1-phosphate(aq) 0.031 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1071 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1071 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1071 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1071 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 292.4 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1071 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 291.6 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1077 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00081 + C00001 = C00104 + C00009 ITP(aq) + H2O(l) = IDP(aq) + orthophosphate(aq) 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77SRA/FRE_722 77SRA/FRE spectrophotometry C 2.8.3.8 acetate CoA-transferase C00024 + C00164 = C00332 + C00033 acetyl-CoA(aq) + acetoacetate(aq) = acetoacetyl-CoA(aq) + acetate(aq) 0.13 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KIT/HEM_991 59KIT/HEM calorimetry A 3.5.1.2 glutaminase C00064 + C00001 = C00025 + C00014 L-glutamine(aq) + H2O(l) = L-glutamate(aq) + ammonia(aq) 295 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70VEE/RAI_584 70VEE/RAI spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 59 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_1411 92KIM/KIN enzymatic assay A 5.4.2.7 phosphopentomutase C00620 = C00117 D-ribose 1-phosphate(aq) = D-ribose 5-phosphate(aq) 26 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_910 89TEW/GOL calorimetry A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_910 89TEW/GOL calorimetry A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 304.55 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_910 89TEW/GOL calorimetry A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 316.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_910 89TEW/GOL calorimetry A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 310.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_820 49MEY/GRE chemical analysis C 3.1.3.2 acid phosphatase C00354 + C00001 = C01094 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 1-phosphate(aq) + orthophosphate(aq) 8 311.15 5.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_912 89TEW/GOL calorimetry A 3.2.1.20 -glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_912 89TEW/GOL calorimetry A 3.2.1.20 -glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 304.55 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_916 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C00185 + C00001 = 2 C00031 cellobiose(aq) + H2O(l) = 2 D-glucose(aq) 310.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_916 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C00185 + C00001 = 2 C00031 cellobiose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_916 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C00185 + C00001 = 2 C00031 cellobiose(aq) + H2O(l) = 2 D-glucose(aq) 304.55 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 17.2 285.75 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 17.5 292.25 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 17.7 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 17.9 304.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 18.5 310.35 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 19.5 316.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_919 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_919 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 304.55 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_919 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 310.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAT/SLA_712 68HAT/SLA C 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.0002 295.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83HAA/KAR_1015 83HAA/KAR C 3.5.1.11 penicillin amidase C08126 + C00001 = C02954 + C02181 phenoxymethylpenicillin-(aq) + H2O(l) = 6-aminopenicillanate-(aq) + phenoxyacetate(aq) 0.00128 298.15 6.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83HAA/KAR_1013 83HAA/KAR C 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G-(aq) + H2O(l) = 6-aminopenicillanic acid-(aq) + phenylacetic acid(aq) 0.0003 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99MUN/LOP_1589 99MUN/LOP chromatography B 5.1.3.6 UDPglucuronate 4-epimerase C00167 = C00617 UDP-D-glucuronate(aq) = UDP-D-galacturonate(aq) 1.3 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.031 311.15 6.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0511 311.15 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0302 311.15 7.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.014 311.15 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.014 311.15 7.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.00829 311.15 7.79 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0197 311.15 7.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.024 311.15 7.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0222 311.15 6.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0221 311.15 6.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0301 311.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0344 311.15 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0229 311.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0328 311.15 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0465 311.15 6.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72DAH/AND_1108 72DAH/AND enzymatic assay and spectrophotometry B 4.1.2.18 2-dehydro-3-deoxy-L-pentonate aldolase C06159 = C00022 + C00424 2-dehydro-3-deoxy-D-fuconate(aq) = pyruvate(aq) + (S)-lactaldehyde(aq) 0.00012 301.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91WOH/DIE_304 91WOH/DIE spectrophotometry C 1.5.1.15 methylenetetrahydrofolate dehydrogenase (NAD+) C00143 + C00003 = C00445 + C00004 5,10-methylenetetrahydrofolate(aq) + NAD(aq) = 5,10-methenyltetrahydrofolate(aq) + NADH(aq) 0.0096 310.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91WOH/DIE_304 91WOH/DIE spectrophotometry C 1.5.1.15 methylenetetrahydrofolate dehydrogenase (NAD+) C00143 + C00003 = C00445 + C00004 5,10-methylenetetrahydrofolate(aq) + NAD(aq) = 5,10-methenyltetrahydrofolate(aq) + NADH(aq) 0.012 310.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91WOH/DIE_305 91WOH/DIE spectrophotometry C 1.5.1.15 methylenetetrahydrofolate dehydrogenase (NAD+) C00143 + C80057 = C00445 + C80058 5,10-methylenetetrahydrofolate(aq) + AP-NAD(aq) = 5,10-methenyltetrahydrofolate(aq) + AP-NADH(aq) 0.11 310.15 8.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91WOH/DIE_305 91WOH/DIE spectrophotometry C 1.5.1.15 methylenetetrahydrofolate dehydrogenase (NAD+) C00143 + C80057 = C00445 + C80058 5,10-methylenetetrahydrofolate(aq) + AP-NAD(aq) = 5,10-methenyltetrahydrofolate(aq) + AP-NADH(aq) 0.86 310.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66JEN/DAR_502 66JEN/DAR spectrophotometry C 2.6.1.1 aspartate transaminase C19838 + C00026 = C03459 + C00025 erythro-3-hydroxyaspartate(aq) + 2-oxoglutarate(aq) = 2-oxo-3-hydroxybutanedioic acid(aq) + L-glutamate(aq) 12 303.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66THO/NAN_1158 66THO/NAN spectrophotometry C 4.2.1.3 aconitate hydratase C00158 = C00417 + C00001 citrate(aq) = cis-aconitate(aq) + H2O(l) 0.046 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=42LEN/STR_505 42LEN/STR chemical analysis C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.7 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97XU/EAD_1712 97XU/EAD radioactivity B 2.4.2.8 hypoxanthine phosphoribosyltransferase C00130 + C00013 = C00262 + C00119 IMP(aq) + pyrophosphate(aq) = hypoxanthine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 3.3e-06 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97DEJ/ROC_428 97DEJ/ROC enzymatic assay and spectrophotometry B 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 6.7 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97DEJ/ROC_428 97DEJ/ROC enzymatic assay and spectrophotometry B 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 250 303.15 9.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56GRE/COH_1296 56GRE/COH chemical analysis B 5.3.1.3 arabinose isomerase C01019 = C01721 L-fucose(aq) = L-fuculose(aq) 0.12 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_1129 52STE/OCH spectrophotometry B 4.1.3.7&1.1.1.37 citrate (si)-synthase and malate dehydrogenase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 0.48 295.15 6.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_1129 52STE/OCH spectrophotometry B 4.1.3.7&1.1.1.37 citrate (si)-synthase and malate dehydrogenase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 10.8 295.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_1129 52STE/OCH spectrophotometry B 4.1.3.7&1.1.1.37 citrate (si)-synthase and malate dehydrogenase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 599 295.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_1129 52STE/OCH spectrophotometry B 4.1.3.7&1.1.1.37 citrate (si)-synthase and malate dehydrogenase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 5610 295.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_1129 52STE/OCH spectrophotometry B 4.1.3.7&1.1.1.37 citrate (si)-synthase and malate dehydrogenase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 101 295.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66SCH_385 66SCH spectrophotometry C 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 145 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66SCH_385 66SCH spectrophotometry C 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 5100 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50SLE_1345 50SLE spectrophotometry B 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 1.5 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.85 0.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.9 0.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.86 0.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.9 0.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.9 1.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.89 1.73 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.92 1.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.93 2.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.98 2.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.98 3.57 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.88 1.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.87 1.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.92 1.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.92 1.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.86 1.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.64 1.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73HER_1136 73HER B 4.1.3.24 malyl-CoA lyase C04348 = C00024 + C00048 (R,S)-malyl-CoA(aq) = acetyl-CoA(aq) + glyoxylate(aq) 0.0029 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_1338 86CAS/VEE2 enzymatic assay and spectrophotometry A 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.83 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00ZHE/BLA_1715 00ZHE/BLA spectrophotometry B 1.1.1.169 2-dehydropantoate 2-reductase C00522 + C00006 = C00966 + C00005 (R)-pantoate(aq) + NADP(ox) = 2-dehydropantoate(aq) + NADP(red)(aq) 0.00148 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HAK/GLA_100 56HAK/GLA spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 9.78e-06 289.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HAK/GLA_100 56HAK/GLA spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 3.24e-05 308.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HAK/GLA_100 56HAK/GLA spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 1.74e-05 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.2 303.15 5.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6 303.15 5.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.8 303.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.8 303.15 6.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6 303.15 4.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.6 303.15 5.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.3 303.15 5.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57MAX_1249 57MAX spectrophotometry C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.33 298.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_784 93LAR/TEW HPLC A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 158 298.15 8.55 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88LIM/RAI_1287 88LIM/RAI enzymatic assay and spectrophotometry; NMR B 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 22 303.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_773 76LAW/GUY enzymatic assay; spectrophotometry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 110 310.15 0.25 6.99 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35AKA_1170 35AKA C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.3 301.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=01TEW/KIS_1645 01TEW/KIS calorimetry A 4.1.2.15 2-dehydro-3-deoxyheptonate aldolase C00074 + C00279 + C00001 = C04691 + C00009 phosphoenolpyruvate(aq) + D-erythrose 4-phosphate(aq) + H2O(l) = 2-dehydro-3-deoxy-D-arabino-heptonate 7-phosphate(aq) + orthophosphate(aq) 298.15 0.09 8.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67UYE/RAB_301 67UYE/RAB spectrophotometry B 1.5.1.5 methylenetetrahydrofolate dehydrogenase (NADP+) C00143 + C00006 = C00445 + C00005 5,10-methylenetetrahydrofolate(aq) + NADP(aq) = 5,10-methenyltetrahydrofolate(aq) + NADPH(aq) 0.14 298.15 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/KIE2_1386 35MEY/KIE2 polarimetry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 4 301.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93BES/REB_352 93BES/REB radioactivity B 2.1.2.1 glycine hydroxymethyltransferase C04377 + C00037 + C00001 = C01217 + C00065 CH2-H4PteGlu4(aq) + glycine(aq) + H2O(l) = H4PteGlu4(aq) + L-serine(aq) 0.063 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93BES/REB_351 93BES/REB radioactivity B 2.1.2.1 glycine hydroxymethyltransferase C00143 + C00037 + C00001 = C00101 + C00065 5,10-methylenetetrahydrofolate(aq) + glycine(aq) + H2O(l) = tetrahydrofolate(aq) + L-serine(aq) 0.067 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54CHA_1086 54CHA radioactivity B 4.1.2.2 ketotetraose-phosphate aldolase C03394 = C00067 + C00111 erythrulose 1-phosphate(aq) = formaldehyde(aq) + glycerone phosphate(aq) 0.00043 301.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89RIZ/HAR_55 89RIZ/HAR spectrophotometry C 1.1.1.9 D-xylulose reductase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.00069 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_1248 86CAS/VEE2 enzymatic assay and spectrophotometry A 5.1.3.1 ribulose-phosphate 3-epimerase C00199 = C00231 D-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.82 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.29 311.15 0.25 7 3.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 11.6 298.15 0.25 7 3.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 11.4 298.15 0.25 7 3.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 13.7 298.15 0.25 6.99 3.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.81 298.15 0.25 7.07 3.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.66 311.15 0.25 7.03 3.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.15 311.15 0.25 7.03 3.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.85 311.15 0.25 7.03 3.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.82 311.15 0.25 7.03 3.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.7 311.15 0.25 7.03 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.68 311.15 0.25 7.03 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.88 311.15 0.25 7.03 3.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 10.4 311.15 0.25 7.06 4.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.7 311.15 0.25 7.07 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.99 311.15 0.25 7.05 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.9 311.15 0.25 7.1 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 15.5 311.15 0.25 6.89 2.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 15.2 311.15 0.25 6.89 2.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 14.4 311.15 0.25 7.4 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 14.9 311.15 0.25 7.41 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 19.4 311.15 0.25 7.53 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 19.4 311.15 0.25 7.53 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.74 311.15 0.25 7.03 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.82 311.15 0.25 7.06 2.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.45 311.15 0.25 7 3.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 10.7 298.15 0.25 7 3.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.54 311.15 0.25 7.03 3.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.66 311.15 0.25 7.04 3.59 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 18.8 311.15 0.25 7.53 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.34 311.15 0.25 7.03 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 11.5 311.15 0.25 6.97 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 11.1 298.15 0.25 7 3.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.68 311.15 0.25 7.03 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 15.7 311.15 0.25 7.39 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.46 311.15 0.25 7 3.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59BAR/SMY_1214 59BAR/SMY spectrophotometry B 4.3.1.2 methylaspartate ammonia-lyase C03618 = C01732 + C00014 L-threo-3-methylaspartate(aq) = 2-methylfumarate(aq) + ammonia(aq) 0.238 298.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59BAR/SMY_1214 59BAR/SMY spectrophotometry B 4.3.1.2 methylaspartate ammonia-lyase C03618 = C01732 + C00014 L-threo-3-methylaspartate(aq) = 2-methylfumarate(aq) + ammonia(aq) 0.306 298.15 9.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93BOH/HUT_226 93BOH/HUT calorimetry A 1.1.3.4 glucose oxidase C00031 + C00007 = C00198 + C00027 -D-glucose(aq) + O2(aq) = D-glucono-1,5-lactone(aq) + H2O2(aq) 298.15 6.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=07TEW/KIS_1653 07TEW/KIS chromatography A 3.5.2.2 dihydropyrimidinase C00429 + C00001 = C02642 5,6-dihydrouracil(aq) + H2O(l) = 3-ureidopropanoic acid(aq) 25.9 298.15 0.28 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=07TEW/KIS_1653 07TEW/KIS chromatography A 3.5.2.2 dihydropyrimidinase C00429 + C00001 = C02642 5,6-dihydrouracil(aq) + H2O(l) = 3-ureidopropanoic acid(aq) 160 298.15 0.32 7.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=07TEW/KIS_1653 07TEW/KIS chromatography A 3.5.2.2 dihydropyrimidinase C00429 + C00001 = C02642 5,6-dihydrouracil(aq) + H2O(l) = 3-ureidopropanoic acid(aq) 64.8 298.15 0.31 7.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=07TEW/KIS_1656 07TEW/KIS chromatography A 3.5.2.2 dihydropyrimidinase C00429 + C00001 = C02642 5,6-dihydrouracil(aq) + H2O(l) = 3-ureidopropanoic acid(aq) 298.15 0.34 7.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MAR/WAD_641 66MAR/WAD electrophoresis and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.81 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CON/DEL_1320 97CON/DEL HPLC C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.98 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CON/DEL_1320 97CON/DEL HPLC C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.03 338.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CON/DEL_1320 97CON/DEL HPLC C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.14 343.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CON/DEL_1320 97CON/DEL HPLC C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.22 348.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CON/DEL_1320 97CON/DEL HPLC C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.39 353.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63HIN/WOL_1355 63HIN/WOL spectrophotometry B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.32 303.15 0.1 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.45 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.48 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 6.98 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.075 7.27 3.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.075 7.6 3.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 6.87 3.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.27 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.27 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.37 3.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.35 3.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.51 3.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.075 7.61 3.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 1 7.22 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.19 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.3 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.18 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.27 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.64 3.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 1 7.22 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.15 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 6.87 3.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 6.87 3.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.49 3.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.88 3.59 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.36 3.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.47 3.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.16 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 1 7.28 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KOR/GLA_703 61KOR/GLA enzymatic assay B 2.7.7.24 glucose-1-phosphate thymidylyltransferase C00459 + C00103 = C00842 + C00013 dTTP(aq) + D-glucose 1-phosphate(aq) = dTDPglucose(aq) + pyrophosphate(aq) 0.67 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.138 298.15 0.1 8.4 3.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.123 298.15 0.1 8.4 3.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0986 298.15 0.1 8.4 3.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0739 298.15 0.1 8.4 3.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0218 298.15 0.1 8.4 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0159 298.15 0.1 8.4 2.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0178 298.15 0.1 8.4 2.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0251 298.15 0.1 8.4 2.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0592 298.15 0.1 8.4 3.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0243 298.15 0.1 8.4 2.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0184 298.15 0.1 8.4 1.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0293 298.15 0.1 8.4 2.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.064 298.15 0.1 8.4 3.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0457 298.15 0.1 8.4 2.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.043 298.15 0.1 8.4 2.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0176 298.15 0.1 8.4 2.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.118 298.15 0.1 8.4 3.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0667 298.15 0.1 8.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.036 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.049 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.029 298.15 6.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.065 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.116 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.27 298.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73HAV/PIT_1304 73HAV/PIT polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.06 343.15 6.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73HAV/PIT_1304 73HAV/PIT polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.1 352.65 6.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73HAV/PIT_1304 73HAV/PIT polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.02 333.15 6.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85BAD/WAL_1511 85BAD/WAL spectrophotometry B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 0.8 310.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93WER/TWE_1189 93WER/TWE HPLC B 4.2.1.31 maleate hydratase C00497 = C01384 + C00001 (R)-malate(aq) = maleate(aq) + H2O(l) 0.000488 298.15 0.1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_774 79LAW/VEE enzymatic assay; spectrophotometry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 109 310.15 0.25 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_774 79LAW/VEE enzymatic assay; spectrophotometry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 110 310.15 0.25 6.99 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KAH/SCH_189 92KAH/SCH spectrophotometry C 1.1.1.56 ribitol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.0033 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59TAB/WYN_355 59TAB/WYN spectrophotometry B 2.1.2.5 glutamate formiminotransferase C00664 + C00025 = C00439 + C00101 5-formiminotetrahydrofolate(aq) + L-glutamate(aq) = N-formimino-L-glutamate(aq) + tetrahydrofolate(aq) 1.3 298.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_876 91TEW/GOL HPLC A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 123 292.25 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_876 91TEW/GOL HPLC A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 115 310.25 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_876 91TEW/GOL HPLC A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 119 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_876 91TEW/GOL HPLC A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 122 286.45 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_876 91TEW/GOL HPLC A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 118 304.55 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.98 310.15 0.25 6.91 2.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.982 310.15 0.25 6.9 2.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.964 310.15 0.25 6.89 2.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.946 310.15 0.25 6.98 3.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.929 310.15 0.25 6.97 3.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.899 310.15 0.25 6.99 3.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.06 310.15 0.25 6.99 3.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.842 310.15 0.25 6.99 2.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.38 310.15 0.25 6.99 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.014 310.15 0.25 6.99 3.36 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.981 310.15 0.25 6.97 3.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.044 310.15 0.25 6.99 3.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.708 310.15 0.25 6.99 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.572 310.15 0.25 6.99 2.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.983 310.15 0.25 6.91 2.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.871 310.15 0.25 6.98 3.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_877 91TEW/GOL calorimetry A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1098 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 2.1e-06 282.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1098 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 2.8e-06 313.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1098 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 4.1e-06 296.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1098 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 6.2e-06 303.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68NIX/BLA_298 68NIX/BLA spectrophotometry C 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 0.00024 310.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68NIX/BLA_298 68NIX/BLA spectrophotometry C 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 0.0012 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1095 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 6.4e-05 282.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1095 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00039 296.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1095 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00052 313.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1095 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00061 303.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_156 80COO/BLA spectrophotometry B 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 1 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56CAR/COH_1224 56CAR/COH spectrophotometry B 4.3.2.2 adenylosuccinate lyase C03794 = C00122 + C00020 adenylosuccinate(aq) = fumarate(aq) + AMP(aq) 0.0063 308.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56CAR/COH_1224 56CAR/COH spectrophotometry B 4.3.2.2 adenylosuccinate lyase C03794 = C00122 + C00020 adenylosuccinate(aq) = fumarate(aq) + AMP(aq) 0.0074 308.15 6.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56CAR/COH_1224 56CAR/COH spectrophotometry B 4.3.2.2 adenylosuccinate lyase C03794 = C00122 + C00020 adenylosuccinate(aq) = fumarate(aq) + AMP(aq) 0.0068 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99ELS_1527 99ELS spectrophotometry and enzymatic assay C 4.1.2.a 2-oxo-3-deoxy-D-gluconate aldolase C00204 = C00022 + C00577 2-oxo-3-deoxy-D-gluconate(aq) = pyruvate(aq) + D-glyceraldehyde(aq) 0.00088 313.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GUP/ROB_186 60GUP/ROB spectrophotometry C 1.1.1.55 lactaldehyde reductase (NADPH) C00583 + C00006 = C00424 + C00005 1,2-propanediol(aq) + NADP(aq) = L-lactaldehyde(aq) + NADPH(aq) 6.0e-05 298.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GUP/ROB_186 60GUP/ROB spectrophotometry C 1.1.1.55 lactaldehyde reductase (NADPH) C00583 + C00006 = C00424 + C00005 1,2-propanediol(aq) + NADP(aq) = L-lactaldehyde(aq) + NADPH(aq) 0.00024 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GUP/ROB_186 60GUP/ROB spectrophotometry C 1.1.1.55 lactaldehyde reductase (NADPH) C00583 + C00006 = C00424 + C00005 1,2-propanediol(aq) + NADP(aq) = L-lactaldehyde(aq) + NADPH(aq) 0.000759 298.15 9.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GUP/ROB_186 60GUP/ROB spectrophotometry C 1.1.1.55 lactaldehyde reductase (NADPH) C00583 + C00006 = C00424 + C00005 1,2-propanediol(aq) + NADP(aq) = L-lactaldehyde(aq) + NADPH(aq) 0.0024 298.15 10 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.508 298.15 0.266 7.4 1.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.357 298.15 0.287 7.4 1.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.233 298.15 0.395 7.4 0.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.206 298.15 0.541 7.4 0.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.186 298.15 0.54 7.4 0.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.143 298.15 0.748 7.4 0.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.123 298.15 1.65 7.4 0.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.112 298.15 3.15 7.4 -0.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.417 298.15 0.216 8.4 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.465 298.15 0.208 8.4 2.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.49 298.15 0.296 6.4 2.81 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.515 298.15 0.311 6.4 2.81 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.763 298.15 0.283 6.4 1.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.671 298.15 0.288 6.4 1.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.709 298.15 0.287 6.4 1.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.429 298.15 0.343 6.4 1.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.459 298.15 0.343 6.4 1.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.292 298.15 0.483 6.4 0.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.2 298.15 0.777 6.4 0.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.541 298.15 0.286 7.4 2.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.662 298.15 0.276 7.4 2.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.662 298.15 0.276 7.4 2.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.741 298.15 0.272 7.4 1.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.725 298.15 0.274 7.4 1.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.758 298.15 0.268 7.4 1.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.465 298.15 0.214 8.4 2.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.568 298.15 0.193 8.4 2.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.769 298.15 0.179 8.4 1.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.274 298.15 0.216 8.4 1.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.167 298.15 0.654 8.4 0.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.633 298.15 0.283 7.4 2.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.538 298.15 0.281 7.4 2.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.735 298.15 0.255 7.4 1.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.334 298.15 0.282 7.4 1.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.474 298.15 0.16 7.4 2.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.488 298.15 0.11 7.4 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.261 298.15 0.163 7.4 1.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.293 298.15 0.172 7.4 1.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.54 298.15 0.013 7.4 3.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.41 298.15 0.013 7.4 2.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.61 298.15 0.012 7.4 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.25 298.15 0.012 7.4 2.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.25 298.15 0.012 7.4 2.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.833 298.15 0.093 7.4 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.667 298.15 0.093 7.4 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.781 298.15 0.093 7.4 2.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.562 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.559 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.483 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.51 298.15 0.594 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.49 298.15 0.592 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.667 298.15 0.454 7.4 1.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.645 298.15 0.461 7.4 1.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.322 298.15 0.474 7.4 0.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.182 298.15 0.704 7.4 0.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.287 298.15 0.723 7.4 0.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.595 298.15 0.288 6.4 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.22 298.15 0.777 6.4 0.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.505 298.15 0.268 7.4 1.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.121 298.15 1.65 7.4 0.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.56 298.15 0.013 7.4 2.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.606 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.313 298.15 0.472 7.4 0.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.313 298.15 0.472 7.4 0.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.508 298.15 1.67 7.4 0.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.259 298.15 0.482 6.4 0.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.145 298.15 0.748 7.4 0.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.87 298.15 0.258 7.4 1.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.72 298.15 0.013 7.4 3.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.775 298.15 0.093 7.4 2.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.348 298.15 0.286 7.4 1.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.109 298.15 3.15 7.4 -0.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.265 298.15 0.216 8.4 1.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 298.15 0.17 7.4 2.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.59 298.15 0.012 7.4 3.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.575 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.704 298.15 0.183 8.4 1.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.513 298.15 0.298 6.4 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.549 298.15 0.283 7.4 2.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.326 298.15 0.282 7.4 1.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.758 298.15 0.284 6.4 1.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.658 298.15 0.276 7.4 2.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.233 298.15 0.395 7.4 0.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.427 298.15 0.227 8.4 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.427 298.15 0.227 8.4 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.153 298.15 0.654 8.4 0.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.645 298.15 0.129 7.4 1.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.33 298.15 0.012 7.4 2.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.485 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.526 298.15 1.55 7.4 0.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.538 298.15 0.191 8.4 2.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.758 298.15 0.263 7.4 1.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MCG/BRO_230 78MCG/BRO calorimetry B 1.1.3.6 cholesterol oxidase C00187 + C00007 = C00599 + C00027 cholesterol(aq) + O2(aq) = cholest-4-en-3-one(aq) + H2O2(aq) 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66THO/NAN_1164 66THO/NAN spectrophotometry C 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 11.8 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69FAN/FEI_1269 69FAN/FEI gas-liquid chromatography B 5.1.3.5 UDParabinose 4-epimerase C00935 = C00190 UDP-L-arabinose(aq) = UDP-D-xylose(aq) 1.25 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66THO/NAN_1161 66THO/NAN spectrophotometry C 4.2.1.3 aconitate hydratase C00311 = C00417 + C00001 isocitrate(aq) = cis-aconitate(aq) + H2O(l) 0.55 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK2_86 68KOH/JAK2 spectrophotometry C 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 7.2e-05 298.15 8.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK2_86 68KOH/JAK2 spectrophotometry C 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.0007 298.15 8.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK2_86 68KOH/JAK2 spectrophotometry C 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.0012 298.15 9.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/RAI_1094 69VEE/RAI spectrophotometry A 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 9.9e-05 311.15 6.7 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/RAI_1094 69VEE/RAI spectrophotometry A 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 5.6e-05 311.15 6.7 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 6.55 298.15 7.4 2.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 10.2 298.15 8 2.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 0.59 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 6.8 298.15 7.4 2.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 2 298.15 7.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 1.4 298.15 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64LOW/PAS_1394 64LOW/PAS fluorimetry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 9.8 311.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63HUE_296 63HUE spectrophotometry C 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 1.78e-05 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65KAT/BUC_321 65KAT/BUC spectrophotometry B 1.7.99.5 5,10-methylenetetrahydrofolate reductase (FADH2) C00440 + C00016 = C00143 + C01352 5-methyltetrahydrofolate(aq) + flavin-adenine dinucleotide(aq) = 5,10-methylenetetrahydrofolate(aq) + reduced flavin-adenine dinucleotide(aq) 0.00042 310.15 6.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63HAR/COL_1125 63HAR/COL spectrophotometry C 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0637 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65YOS/FRE_271 65YOS/FRE spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 1.13e-05 298.15 8.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65YOS/FRE_271 65YOS/FRE spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 7.65e-05 298.15 8.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65YOS/FRE_271 65YOS/FRE spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.000825 298.15 10.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/OES_1172 49MEY/OES chemical analysis and radioactivity C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.9 297.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH_192 68KOH spectrophotometry C 1.1.1.60 2-hydroxy-3-oxopropionate reductase C00258 + C00003 = C01146 + C00004 (R)-glycerate(aq) + NAD(aq) = 2-hydroxy-3-oxopropanoate(aq) + NADH(aq) 5.3e-05 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_120 67WIL/LUN spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0526 311.15 0.134 7.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_120 67WIL/LUN spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0561 311.15 0.073 7.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_120 67WIL/LUN spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0482 311.15 0.042 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_120 67WIL/LUN spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0494 311.15 0.255 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50SLE_1350 50SLE spectrophotometry B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.45 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74UEB/BLA_161 74UEB/BLA gas-liquid chromatography C 1.1.1.48 galactose dehydrogenase C00124 + C00003 = C03383 + C00004 D-galactose(aq) + NAD(aq) = D-galactono-1,4-lactone(aq) + NADH(aq) 400 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74UEB/BLA_161 74UEB/BLA gas-liquid chromatography C 1.1.1.48 galactose dehydrogenase C00124 + C00003 = C03383 + C00004 D-galactose(aq) + NAD(aq) = D-galactono-1,4-lactone(aq) + NADH(aq) 25000 303.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74UEB/BLA_161 74UEB/BLA gas-liquid chromatography C 1.1.1.48 galactose dehydrogenase C00124 + C00003 = C03383 + C00004 D-galactose(aq) + NAD(aq) = D-galactono-1,4-lactone(aq) + NADH(aq) 390 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SAL/NOR_1268 68SAL/NOR chromatography and spectrophotometry C 5.1.3.5 UDParabinose 4-epimerase C00935 = C00190 UDP-L-arabinose(aq) = UDP-D-xylose(aq) 0.94 310.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_1282 47MEY/OES chemical analysis and polarimetry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 17 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.83 323.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.32 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.05 343.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.33 343.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.1 353.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.13 333.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64LOW/PAS_1174 64LOW/PAS fluorimetry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.6 311.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73SHE/GUL_155 73SHE/GUL spectrophotometry B 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.076 293.15 0.404 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73SHE/GUL_155 73SHE/GUL spectrophotometry B 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.81 293.15 0.404 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93VIN/GRU_1691 93VIN/GRU radioactivity C 2.4.2.11 nicotinate phosphoribosyltransferase C01185 + C00013 = C00253 + C00119 Nicotinate D-ribonucleotide(aq) + pyrophosphate(aq) = nicotinic acid(aq) + 5-Phospho-alpha-D-ribose 1-diphosphate(aq) 1.5 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58FRO_1443 58FRO spectrophotometry C 6.3.4.4 adenylosuccinate synthase C00044 + C00130 + C00049 = C00035 + C00009 + C03794 GTP(aq) + IMP(aq) + L-aspartate(aq) = GDP(aq) + phosphate(aq) + adenylosuccinate(aq) 2.9 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49HES_743 49HES spectrophotometry C 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 538 296.15 5.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 8.8e-05 298.15 6.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00019 298.15 7.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0003 298.15 7.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00051 298.15 7.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0022 298.15 8.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0008 298.15 7.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 2.6e-05 298.15 6.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58ROB/LIP_678 58ROB/LIP C 2.7.7.4 sulfate adenylyltransferase C00002 + C00059 = C00224 + C00013 ATP(aq) + sulfate(aq) = adenosine 5'-phosphosulfate(aq) + pyrophosphate(aq) 1.1e-08 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LIE/KOR_1039 54LIE/KOR spectrophotometry and radioactivity B 3.5.2.4 carboxymethylhydantoinase C03703 + C00001 = C00438 L-5-carboxymethylhydantoin(aq) + H2O(l) = N-carbamoyl-L-aspartate(aq) 0.53 307.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_478 92KIM/KIN spectrophotometry and fluorimetry A 2.4.2.8 hypoxanthine phosphoribosyltransferase C00242 + C00119 = C00144 + C00013 guanine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) = GMP(aq) + pyrophosphate(aq) 100000 311.15 0.25 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_479 92KIM/KIN spectrophotometry and fluorimetry A 2.4.2.8 hypoxanthine phosphoribosyltransferase C00262 + C00119 = C00130 + C00013 hypoxanthine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) = IMP(aq) + pyrophosphate(aq) 100000 311.15 0.25 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85REK/SLO_987 85REK/SLO calorimetry A 3.5.1.1 asparaginase C00152 + C00001 = C00049 + C00014 L-asparagine(aq) + H2O(l) = L-aspartate(aq) + ammonia(aq) 298.15 6.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_475 92KIM/KIN spectrophotometry and fluorimetry A 2.4.2.7 adenine phosphoribosyltransferase C00147 + C00119 = C00020 + C00013 adenine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) = AMP(aq) + pyrophosphate(aq) 2000 311.15 0.25 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LIE/KOR_1036 54LIE/KOR spectrophotometry and radioactivity B 3.5.2.3 dihydroorotase C00337 + C00001 = C00438 (S)-dihydroorotate(aq) + H2O(l) = N-carbamoyl-L-aspartate(aq) 1.9 303.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87MOS/FRE_1417 87MOS/FRE chromatography and radioactivity C 5.4.3.2 lysine 2,3-aminomutase C00047 = C01142 L-lysine(aq) = (3S)-3,6-diaminohexanoate(aq) 5.3 303.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 6.62e-05 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 0.000436 298.15 8 0.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 1.56e-05 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 6.17e-05 298.15 8 1.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 1.85e-05 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 1.48e-05 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ASH/HIC_1246 57ASH/HIC spectrophotometry C 5.1.3.1 ribulose-phosphate 3-epimerase C00199 = C00231 D-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.4 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70CHI/ZAP_1416 70CHI/ZAP radioactivity B 5.4.3.2 lysine 2,3-aminomutase C00047 = C01142 L-lysine(aq) = (3S)-3,6-diaminohexanoate(aq) 6.7 310.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00BYR/GOL_1518 00BYR/GOL calorimetry, spectrophotometry, and chromatography A 4.1.3.27 anthranilate synthase C00251 + C00014 = C00108 + C00022 + C00001 chorismate(aq) + ammonia(aq) = anthranilate(aq) + pyruvate(aq) + H2O(l) 298.15 0.56 7.79 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00BYR/GOL_1519 00BYR/GOL calorimetry, spectrophotometry, and chromatography A 4.1.3.27 anthranilate synthase C00251 + C00014 = C18054 + C00001 chorismate(aq) + ammonia(aq) = 2-amino-2-deoxyisochorismate(aq) + H2O(l) 8.44 298.15 0.14 7.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00BYR/GOL_1519 00BYR/GOL calorimetry, spectrophotometry, and chromatography A 4.1.3.27 anthranilate synthase C00251 + C00014 = C18054 + C00001 chorismate(aq) + ammonia(aq) = 2-amino-2-deoxyisochorismate(aq) + H2O(l) 9.5 288.15 0.15 8.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00BYR/GOL_1519 00BYR/GOL calorimetry, spectrophotometry, and chromatography A 4.1.3.27 anthranilate synthase C00251 + C00014 = C18054 + C00001 chorismate(aq) + ammonia(aq) = 2-amino-2-deoxyisochorismate(aq) + H2O(l) 7.51 302.75 0.14 7.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00BYR/GOL_1519 00BYR/GOL calorimetry, spectrophotometry, and chromatography A 4.1.3.27 anthranilate synthase C00251 + C00014 = C18054 + C00001 chorismate(aq) + ammonia(aq) = 2-amino-2-deoxyisochorismate(aq) + H2O(l) 9.02 293.15 0.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 15.8 286.35 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 17.2 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 18 304.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 19.7 316.35 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 19.4 310.25 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 16.2 292.45 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62DUR/RAW_338 62DUR/RAW calorimetry A 2.1.1.3 thetin-homocysteine S-methyltransferase C00719 + C00155 = C01026 + C00073 betaine(aq) + L-homocysteine(aq) = N,N-dimethylglycine(aq) + L-methionine(aq) 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98LAE/EIS_1204 98LAE/EIS HPLC + radioactivity B 4.2.1.- cyclohexa-1,5-diene-1-carboxyl-CoA (dienoyl-CoA) hydratase C06322 + C00001 = C06749 cyclohexa-1,5-diene-1-carboxyl-CoA(aq) + H2O(l) = 6-hydroxycyclohex-1-ene-carboxyl-CoA(aq) 1 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_888 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C02160 + 2 C00001 = 3 C00031 isomaltotriose(aq) + 2 H2O(l) = 3 D-glucose(aq) 298.15 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MAI/DEK_1132 64MAI/DEK spectrophotometry C 4.1.3.16 4-hydroxy-2-oxoglutarate aldolase C01127 = C00022 + C00048 4-hydroxy-2-oxoglutarate(aq) = pyruvate(aq) + glyoxylate(aq) 0.012 310.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40KRE/SMY_1143 40KRE/SMY manometry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.57 293.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40KRE/SMY_1143 40KRE/SMY manometry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.54 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40KRE/SMY_1143 40KRE/SMY manometry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.17 313.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40KRE/SMY_1143 40KRE/SMY manometry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 2.65 323.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82HSI/CHI_1327 82HSI/CHI liquid chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.31 334.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82HSI/CHI_1327 82HSI/CHI liquid chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.39 343.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82HSI/CHI_1327 82HSI/CHI liquid chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.41 345.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82HSI/CHI_1327 82HSI/CHI liquid chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.22 323.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82HSI/CHI_1327 82HSI/CHI liquid chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.18 313.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72DEL_427 72DEL chromatography and radioactivity B 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 6.7 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW2_943 89GOL/TEW2 calorimetry A 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW2_943 89GOL/TEW2 calorimetry A 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 310.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW2_943 89GOL/TEW2 calorimetry A 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 316.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW2_943 89GOL/TEW2 calorimetry A 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 304.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_884 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 -isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 81 318.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_885 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 -isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 65 318.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79KIM/PET_143 79KIM/PET spectrophotometry B 1.1.1.37 malate dehydrogenase C00552 + C00003 = C03459 + C00004 meso-tartrate(aq) + NAD(aq) = 2-oxo-3-hydroxysuccinate(aq) + NADH(aq) 1.25e-06 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71ROB_710 71ROB chromatography, electrophoresis, and radioactivity C 2.7.7.44 glucuronate-1-phosphate uridylyltransferase C05385 + C00075 = C00167 + C00013 1-phospho--D-glucuronate(aq) + UTP(aq) = UDP-D-glucuronate(aq) + pyrophosphate(aq) 0.34 303.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98LIA/WAN_1583 98LIA/WAN calorimetry A 1.1.3.22 xanthine oxidase C00385 + C00001 + C00007 = C00366 + C00027 xanthine(aq) + H2O(l) + O2(aq) = urate(aq) + H2O2(aq) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90LUN/APR_431 90LUN/APR enzymatic assay and spectrophotometry B 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 62 298.15 7.5 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90LUN/APR_431 90LUN/APR enzymatic assay and spectrophotometry B 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 5.3 298.15 7 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90LUN/APR_431 90LUN/APR enzymatic assay and spectrophotometry B 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 26 298.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90LUN/APR_431 90LUN/APR enzymatic assay and spectrophotometry B 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 10 298.15 7.5 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36EUL/ADL_7 36EUL/ADL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.3e-05 298.15 6.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36EUL/ADL_7 36EUL/ADL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 5.3e-05 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36EUL/ADL_7 36EUL/ADL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00013 298.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49SOR/DVO_615 49SOR/DVO C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.002 298.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49SOR/DVO_615 49SOR/DVO C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.17 298.15 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GRI/CAR_1396 75GRI/CAR polarimetry and spectrophotometry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.3 303.15 5.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GRI/CAR_1396 75GRI/CAR polarimetry and spectrophotometry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5 310.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GRI/CAR_1396 75GRI/CAR polarimetry and spectrophotometry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.1 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76BER/KLY_1009 76BER/KLY C 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.022 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76BER/KLY_1009 76BER/KLY C 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.003 298.15 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59GOL_322 59GOL spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.0055 295.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54AXE/JAN_1331 54AXE/JAN enzymatic assay and spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.264 298.65 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54AXE/JAN_1331 54AXE/JAN enzymatic assay and spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.323 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54AXE/JAN_1331 54AXE/JAN enzymatic assay and spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.164 273.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37ADL/SRE_8 37ADL/SRE spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 6.0e-06 298.15 6.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37ADL/SRE_8 37ADL/SRE spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 7.7e-05 298.15 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37ADL/SRE_8 37ADL/SRE spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.2e-05 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66HOR/HEN_1550 66HOR/HEN radioactivity C 2.4.2.7 adenine phosphoribosyltransferase C00020 + C00013 = C00147 + C00119 AMP(aq) + pyrophosphate(aq) = adenine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 0.0035 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57STE_125 57STE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.86 298.15 9.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53HOC/WAT_1323 53HOC/WAT chemical analysis and paper chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.19 300.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PRI/HOR_1087 60PRI/HOR enzymatic assay, chemical analysis, and spectrophotometry B 4.1.2.4 deoxyribose-phosphate aldolase C00673 = C00118 + C00084 2-deoxy-D-ribose 5-phosphate(aq) = D-glyceraldehyde 3-phosphate(aq) + acetaldehyde(aq) 0.000235 310.15 6.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92REK/TIS_826 92REK/TIS calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BEN/HEM_989 56BEN/HEM calorimetry B 3.5.1.2 glutaminase C00064 + C00001 = C00025 + C00014 L-glutamine(aq) + H2O(l) = L-glutamate(aq) + ammonia(aq) 850 298.15 5.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56DIC/WIL_1262 56DIC/WIL chromatography and spectrophotometry C 5.1.3.4 L-ribulose-phosphate 4-epimerase C01101 = C00231 L-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.2 310.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 5.04e-07 300.15 0.134 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 6.34e-07 303.15 0.134 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 9.03e-07 303.15 0.471 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 8.08e-07 303.15 0.471 6.79 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 1.1e-06 298.1 0.47 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 1.2e-06 300.1 0.47 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 2.0e-06 305.1 0.47 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.2e-06 309.8 0.47 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.6e-06 311.1 0.47 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 2.09e-07 300.15 0.026 6.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 2.91e-07 300.15 0.054 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.83e-07 303.15 0.067 6.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.67e-07 303.15 0.067 6.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 4.96e-07 303.15 0.091 6.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 5.22e-07 303.15 0.112 6.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 5.92e-07 300.15 0.134 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 1.16e-06 303.15 0.471 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 2.59e-07 300.15 0.054 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 5.55e-07 300.15 0.112 6.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80TER/RAB_994 80TER/RAB spectrophotometry B 3.5.1.5 urease C01563 + C00001 = C00014 + C00288 carbamate(aq) + H2O(l) = ammonia(aq) + carbon dioxide(aq) 1920 293.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80TER/RAB_994 80TER/RAB spectrophotometry B 3.5.1.5 urease C01563 + C00001 = C00014 + C00288 carbamate(aq) + H2O(l) = ammonia(aq) + carbon dioxide(aq) 1710 293.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80TER/RAB_994 80TER/RAB spectrophotometry B 3.5.1.5 urease C01563 + C00001 = C00014 + C00288 carbamate(aq) + H2O(l) = ammonia(aq) + carbon dioxide(aq) 1030 310.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80TER/RAB_994 80TER/RAB spectrophotometry B 3.5.1.5 urease C01563 + C00001 = C00014 + C00288 carbamate(aq) + H2O(l) = ammonia(aq) + carbon dioxide(aq) 1500 293.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80TER/RAB_994 80TER/RAB spectrophotometry B 3.5.1.5 urease C01563 + C00001 = C00014 + C00288 carbamate(aq) + H2O(l) = ammonia(aq) + carbon dioxide(aq) 1230 293.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75SCH/RIF_138 75SCH/RIF spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00117 298.15 9.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67KEP/TOV_1280 67KEP/TOV radioactivity B 5.2.1.5 linoleate isomerase C01595 = C04056 9-cis,12-cis-octadecadienoate(aq) = 9-cis,11-trans-octadecadienoate(aq) 61 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STU/HOR_1245 56STU/HOR spectrophotometry C 5.1.3.1 ribulose-phosphate 3-epimerase C00199 = C00231 D-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 0.83 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000128 283.75 7.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000119 283.75 7.673 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000187 290.5 7.658 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000174 290.5 7.646 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000213 293.4 7.635 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000542 307.75 7.605 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000734 315.95 7.568 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00068 315.95 7.545 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000144 283.75 7.691 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000438 307.75 7.571 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000487 307.75 7.584 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000663 315.95 7.528 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00032 273.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0015 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0064 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.019 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0011 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00075 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00047 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00055 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00029 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0012 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00031 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00051 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0011 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0014 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0014 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0046 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0056 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.015 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0025 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0025 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00014 273.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0082 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 7.1e-05 273.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.002 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0056 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00037 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00064 293.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HUB_1279 56HUB spectrophotometry C 5.2.1.3 retinal isomerase C00376 = C02110 all-trans-retinal(aq) = 11-cis-retinal(aq) 0.05 309.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 6.19e-05 298.15 7.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000101 298.15 7.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000129 298.15 8.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000162 298.15 8.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 7.67e-05 298.15 7.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.49e-05 298.15 7.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 4.74e-05 298.15 7.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.43e-05 298.15 7.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_920 91TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C05402 + C00001 = C00124 + C00031 -D-melibiose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56WOL/KAP_76 56WOL/KAP chemical analysis and spectrophotometry C 1.1.1.17 mannitol-1-phosphate dehydrogenase C00644 + C00003 = C00085 + C00004 D-mannitol 1-phosphate(aq) + NAD(aq) = D-fructose 6-phosphate(aq) + NADH(aq) 0.0049 296.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/WAR_87 68KOH/WAR spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.0004 298.15 8.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/WAR_87 68KOH/WAR spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.00023 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/WAR_87 68KOH/WAR spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 7.4e-05 298.15 8.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/WAR_87 68KOH/WAR spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.00023 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 6.6 323.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 5.73 311.15 0.06 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 5.47 311.15 1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 9.23 311.15 0.25 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 5.27 311.15 0.25 7 2.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 4.26 298.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 4.42 303.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 5.5 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56RAM/GIR_1352 56RAM/GIR chemical analysis C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.67 310.15 7.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.33 310.15 7.2 3.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.3 310.15 7.2 3.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.36 310.15 7.2 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.32 310.15 7.2 3.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.44 310.15 7.2 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.32 310.15 7.2 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.32 310.15 7.2 3.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.44 310.15 7.2 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79RAO/KAY_566 79RAO/KAY NMR B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.0003 288.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66NAT_1301 66NAT chromatography C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.82 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56SMI/STA_1124 56SMI/STA chemical analysis B 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.64 300.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48OCH_152 48OCH spectrophotometry C 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.76 295.15 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_418 89GOL/TEW HPLC A 2.4.1.7 sucrose phosphorylase C00089 + C00009 = C00103 + C00095 sucrose(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-fructose(aq) 31.5 298.15 8.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54SIS/STA_1427 54SIS/STA spectrophotometry B 5.5.1.1 muconate cycloisomerase C04105 = C02480 2,5-dihydro-5-oxofuran-2-acetate(aq) = cis-cis-hexadienedioate(aq) 0.078 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54SIS/STA_1427 54SIS/STA spectrophotometry B 5.5.1.1 muconate cycloisomerase C04105 = C02480 2,5-dihydro-5-oxofuran-2-acetate(aq) = cis-cis-hexadienedioate(aq) 0.29 303.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54SIS/STA_1427 54SIS/STA spectrophotometry B 5.5.1.1 muconate cycloisomerase C04105 = C02480 2,5-dihydro-5-oxofuran-2-acetate(aq) = cis-cis-hexadienedioate(aq) 0.041 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54SIS/STA_1427 54SIS/STA spectrophotometry B 5.5.1.1 muconate cycloisomerase C04105 = C02480 2,5-dihydro-5-oxofuran-2-acetate(aq) = cis-cis-hexadienedioate(aq) 0.011 303.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54SIS/STA_1427 54SIS/STA spectrophotometry B 5.5.1.1 muconate cycloisomerase C04105 = C02480 2,5-dihydro-5-oxofuran-2-acetate(aq) = cis-cis-hexadienedioate(aq) 0.01 303.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1348 88TEW/STE calorimetry A 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1348 88TEW/STE calorimetry A 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 304.74 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1347 88TEW/STE calorimetry A 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 1.03 304.75 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1347 88TEW/STE calorimetry A 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.99 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SAK/YOR2_454 67SAK/YOR2 electrophoresis C 2.4.2.1 purine-nucleoside phosphorylase C00212 + C00009 = C00147 + C00620 adenosine(aq) + orthophosphate(aq) = adenine(aq) + D-ribose 1-phosphate(aq) 0.063 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SAK/YOR2_454 67SAK/YOR2 electrophoresis C 2.4.2.1 purine-nucleoside phosphorylase C00212 + C00009 = C00147 + C00620 adenosine(aq) + orthophosphate(aq) = adenine(aq) + D-ribose 1-phosphate(aq) 0.12 310.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77TRA/JON_481 77TRA/JON TLC and radioactivity B 2.4.2.10 orotate phosphoribosyltransferase C01103 + C00013 = C00295 + C00119 orotidine 5'-phosphate(aq) + pyrophosphate(aq) = orotate(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 14 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ATK/JOH_772 61ATK/JOH enzymatic assay and spectrophotometry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 263 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.37 298.15 8 5.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.92 298.15 8 4.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.28 298.15 8 3.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.06 298.15 8 3.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.92 298.15 8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.34 298.15 8 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.3 298.15 8 2.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.52 298.15 8 4.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.14 298.15 8 3.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.67 298.15 8 2.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.46 298.15 8 2.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.32 298.15 8 2.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.34 298.15 8 5.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.49 298.15 8 5.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70WUR/HES_163 70WUR/HES spectrophotometry D 1.1.1.49 glucose-6-phosphate dehydrogenase C00092 + C00006 = C01236 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) = D-glucono-1,5-lactone 6-phosphate(aq) + NADPH(aq) 52 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70WUR/HES_163 70WUR/HES spectrophotometry D 1.1.1.49 glucose-6-phosphate dehydrogenase C00092 + C00006 = C01236 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) = D-glucono-1,5-lactone 6-phosphate(aq) + NADPH(aq) 1.3 298.15 6.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.209 318.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.282 331.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.347 341.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.176 311.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.4 348.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.246 325.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/DEL_1178 56STE/DEL spectrophotometry B 4.2.1.17 enoyl-CoA hydratase C05268 = C05271 + C00001 (3S)-3-hydroxyhexanoyl-CoA(aq) = trans-hex-2-enoyl-CoA(aq) + H2O(l) 0.66 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MIL/AVI_425 64MIL/AVI D 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 1.3 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GRE/RUD_836 69GRE/RUD calorimetry A 3.1.4.17 phosphodiesterase I C00575 + C00001 = C00020 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = AMP(aq) 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00053 298.15 8.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00036 298.15 8.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000637 298.15 8.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000517 298.15 8.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000523 298.15 8.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000523 298.15 8.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000466 298.15 8.81 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000435 298.15 8.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000446 298.15 8.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000106 298.15 8.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 8.18e-05 298.15 8.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.75e-05 298.15 7.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000531 298.15 8.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000504 298.15 8.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000692 298.15 8.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_831 79LAW/VEE enzymatic assay; spectrophotometry A 3.1.3.11 fructose-biphosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 227 310.15 0.25 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_831 79LAW/VEE enzymatic assay; spectrophotometry A 3.1.3.11 fructose-biphosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 174 310.15 0.25 6.99 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/DEL_1175 56STE/DEL spectrophotometry B 4.2.1.17 enoyl-CoA hydratase C03561 = C00877 + C00001 (3R)-3-hydroxybutanoyl-CoA(aq) = cis-but-2-enoyl-CoA(aq) + H2O(l) 0.18 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52BUR_29 52BUR B 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.073 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/DEL_1176 56STE/DEL spectrophotometry C 4.2.1.17 enoyl-CoA hydratase C01144 = C00877 + C00001 (3S)-3-hydroxybutanoyl-CoA(aq) = trans-but-2-enoyl-CoA(aq) + H2O(l) 0.29 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56ENG_1371 56ENG C 5.3.1.14 L-rhamnose isomerase C00507 = C00861 L-rhamnose(aq) = L-rhamnulose(aq) 1.5 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60OCO/HAL_269 60OCO/HAL spectrophotometry C 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.000136 298.15 10 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DOU/MER_117 61DOU/MER C 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.13 305.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65MAR/JEN_527 65MAR/JEN spectrophotometry B 2.6.1.21 D-alanine transaminase C00133 + C00026 = C00022 + C00217 D-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + D-glutamate(aq) 0.59 310.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/OES_1388 49MEY/OES polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6 297.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_61 96TEW/GOL calorimetry A 1.1.1.14 L-iditol 2-dehydrogenase C01507 + C00003 = C00247 + C00004 L-iditol(aq) + NAD(aq) = L-sorbose(aq) + NADH(aq) 298.15 7.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_60 96TEW/GOL HPLC and spectrophotometry A 1.1.1.14 L-iditol 2-dehydrogenase C01507 + C00003 = C00247 + C00004 L-iditol(aq) + NAD(aq) = L-sorbose(aq) + NADH(aq) 0.186 298.15 7.58 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68JEA/DEM_210 68JEA/DEM spectrophotometry C 1.1.1.110 indolelactate dehydrogenase C02043 + C00003 = C00331 + C00004 indole-3-lactate(aq) + NAD(aq) = indole-3-pyruvate(aq) + NADH(aq) 630 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.31 275.8 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.31 276.9 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.31 277 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.5 284 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.3 286.1 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.01 288.2 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.86 288.2 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.57 291.9 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.21 296.7 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.98 298.7 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.78 303 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.63 303 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.21 309.9 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.09 310.7 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.09 311.7 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.98 298.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.01 299.2 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.68 282.3 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.31 277.2 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.5 283.5 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.47 292.6 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.47 292.6 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.63 302.5 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.21 307.8 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.57 292.8 6.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SAL/NOR_1253 68SAL/NOR chromatography and spectrophotometry C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.35 310.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_134 67WIL/LUN spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.78e-05 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 3.9e-11 298.15 6.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.3e-09 298.15 7.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.6e-09 298.15 7.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.5e-08 298.15 7.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.7e-09 298.15 7.57 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 3.6e-08 298.15 8.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.0e-08 298.15 8.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.7e-08 298.15 7.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.1e-08 298.15 7.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.9e-09 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.0e-08 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.3e-09 298.15 6.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.4e-08 298.15 7.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 9.4e-09 298.15 7.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.5e-09 298.15 7.36 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36MEY/SCH_1096 36MEY/SCH calorimetry C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56REI_1407 56REI spectrophotometry C 5.4.2.3 phosphoacetylglucosamine mutase C04256 = C00357 N-acetyl-D-glucosamine 1-phosphate(aq) = N-acetyl-D-glucosamine 6-phosphate(aq) 6 310.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55LIE/KOR_480 55LIE/KOR spectrophotometry C 2.4.2.10 orotate phosphoribosyltransferase C01103 + C00013 = C00295 + C00119 orotidine 5'-phosphate(aq) + pyrophosphate(aq) = orotate(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 8.3 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66UHR/MAR_616 66UHR/MAR C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 2.1 303.15 8 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66UHR/MAR_616 66UHR/MAR C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 2.4 303.15 8 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66UHR/MAR_616 66UHR/MAR C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 1.2 303.15 8 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CAL/WEB_639 59CAL/WEB chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.42 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95KOZ/TOM_1426 95KOZ/TOM HPLC C 5.4.99.6 isochorismate synthase C00251 + C00014 = C18054 + C00001 chorismate(aq) + ammonia(aq) = 2-amino-2-deoxyisochorismate(aq) + H2O(l) 2.67 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95KOZ/TOM_1425 95KOZ/TOM HPLC C 5.4.99.6 isochorismate synthase C00251 = C00885 chorismate(aq) = isochorismate(aq) 0.55 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1218 93LAR/TEW calorimetry A 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 298.15 8.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1218 93LAR/TEW calorimetry A 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 310.15 8.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60VOL_1370 60VOL spectrophotometry B 5.3.1.13 arabinose-5-phosphate isomerase C01112 = C00199 D-arabinose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.295 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1217 93LAR/TEW HPLC A 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 3.01 298.25 8.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1217 93LAR/TEW HPLC A 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 2.35 298.25 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_776 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 55 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_776 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 56 308.15 7 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68ERI_27 68ERI spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00756 + C00003 = C01545 + C00004 1-octanol(aq) + NAD(aq) = octanal(aq) + NADH(aq) 0.0011 298.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68ERI_25 68ERI spectrophotometry B 1.1.1.1 alcohol dehydrogenase C08492 + C00003 = C16310 + C00004 cis-3-hexene-1-ol(aq) + NAD(aq) = cis-3-hexenal(aq) + NADH(aq) 0.00072 298.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BRE/AAS_393 69BRE/AAS spectrophotometry C 2.3.1.7 carnitine O-acetyltransferase C00100 + C00318 = C00010 + C03017 propionyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-propionylcarnitine(aq) 1.3 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BRE/AAS_390 69BRE/AAS spectrophotometry B 2.3.1.7 carnitine O-acetyltransferase C00024 + C00318 = C00010 + C02571 acetyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-acetylcarnitine(aq) 1.5 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AYL/SNE_532 68AYL/SNE spectrophotometry C 2.6.1.30 pyridoxamine-pyruvate transaminase C00534 + C00022 = C00250 + C00041 pyridoxamine(aq) + pyruvate(aq) = pyridoxal(aq) + L-alanine(aq) 1.21 298.15 8.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.062 338.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.131 348.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.209 358.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.039 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.103 343.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.182 353.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53JON_1432 53JON spectrophotometry and chemical analysis B 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 2.7 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KER/KER_1155 92KER/KER spectrophotometry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.3 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_554 82RED calorimetry A 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_554 82RED calorimetry A 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_554 82RED calorimetry A 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_554 82RED calorimetry A 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_558 82RED calorimetry A 2.7.1.30 glycerol kinase C00002 + C00116 = C00008 + C00093 ATP(aq) + glycerol(aq) = ADP(aq) + sn-glycerol 3-phosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_558 82RED calorimetry A 2.7.1.30 glycerol kinase C00002 + C00116 = C00008 + C00093 ATP(aq) + glycerol(aq) = ADP(aq) + sn-glycerol 3-phosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_558 82RED calorimetry A 2.7.1.30 glycerol kinase C00002 + C00116 = C00008 + C00093 ATP(aq) + glycerol(aq) = ADP(aq) + sn-glycerol 3-phosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_558 82RED calorimetry A 2.7.1.30 glycerol kinase C00002 + C00116 = C00008 + C00093 ATP(aq) + glycerol(aq) = ADP(aq) + sn-glycerol 3-phosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68POT/GLO_386 68POT/GLO spectrophotometry and electrophoresis C 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 522 311.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70VEE/RAI_257 70VEE/RAI spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phocphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 59 311.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60MEN_429 60MEN chromatography, radioactivity, and chemical analysis C 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 3250 311.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60MEN_429 60MEN chromatography, radioactivity, and chemical analysis C 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 53 311.15 5.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GEO/TRA_1075 69GEO/TRA calorimetry C 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 + C00080 ATP-4-(aq) + H2O(l) = ADP-3-(aq) + HPO4-2-(aq) + H+(aq) 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69TSU/FUK_689 69TSU/FUK fluorimetry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.26 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99BAS/MAR_1512 99BAS/MAR spectrophotometry C 2.6.1.52 phosphoserine transferase C01005 + C00026 = C03232 + C00025 O-phospho-L-serine(aq) + 2-oxoglutarate(aq) = 3-phosphonooxypyruvate(aq) + L-glutamate(aq) 0.025 305 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65AND/ALL_1375 65AND/ALL spectrophotometry B 5.3.1.15 D-lyxose ketol-isomerase C00476 = C00310 D-lyxose(aq) = D-xylulose(aq) 0.23 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_466 92KIM/KIN HPLC and enzymatic assay A 2.4.2.1 purine-nucleoside phosphorylase C01762 + C00009 = C00385 + C00620 xanthosine(aq) + orthophosphate(aq) = xanthine(aq) + D-ribose 1-phosphate(aq) 0.0156 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79BYE/SHE_253 79BYE/SHE spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.042 298.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TSU/SAT_1300 65TSU/SAT spectrophotometry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.08 333.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79VAN/DEB_1689 79VAN/DEB spectrophotometry and radioactivity B 2.6.1.19 4-aminobutyrate transaminase C00334 + C00026 = C00232 + C00025 4-aminobutanoate(aq) + 2-oxoglutarate(aq) = 4-oxobutanoate(aq) + L-glutamate(aq) 0.04 295.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02ISO/KOI_1553 02ISO/KOI spectrophotometry C 1.1.1.28 D-lactate dehydrogenase C00256 + C00003 = C00022 + C00004 (R)-lactate(aq) + NAD(ox)(aq) = pyruvate(aq) + NAD(red)(aq) 0.0037 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02ISO/KOI_1554 02ISO/KOI spectrophotometry C 1.1.1.28 D-lactate dehydrogenase C05984 + C00003 = C00109 + C00004 D-2-hydroxy-n-butanoate(aq) + NAD(ox)(aq) = 2-oxobutanoate(aq) + NAD(red)(aq) 0.0028 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BEN/FRI_1367 70BEN/FRI spectrophotometry B 5.3.1.10 glucosamine-6-phosphate isomerase C00352 + C00001 = C00085 + C00014 D-glucosamine 6-phosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + ammonia(aq) 0.15 310.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_890 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C01936 + 5 C00001 = 6 C00031 maltohexaose(aq) + 5 H2O(l) = 6 D-glucose(aq) 298.15 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_890 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C01936 + 5 C00001 = 6 C00031 maltohexaose(aq) + 5 H2O(l) = 6 D-glucose(aq) 304.65 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_890 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C01936 + 5 C00001 = 6 C00031 maltohexaose(aq) + 5 H2O(l) = 6 D-glucose(aq) 311.15 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_897 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C02052 + 3 C00001 = 4 C00031 maltotetraose(aq) + 3 H2O(l) = 4 D-glucose(aq) 298.15 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_896 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_899 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C01835 + 2 C00001 = 3 C00031 maltotriose(aq) + 2 H2O(l) = 3 D-glucose(aq) 298.15 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DAR_506 45DAR spectrophotometry C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.48 298.15 7.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DAR_506 45DAR spectrophotometry C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.48 308.15 7.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1322 86TEW/GOL HPLC B 5.3.1.5 xylose isomerase C06468 = C06464 D-psicose(aq) = D-altrose(aq) 0.3 333.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1321 86TEW/GOL HPLC A 5.3.1.5 xylose isomerase C06468 = C01487 D-psicose(aq) =-D-allose(aq) 2.15 317.25 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1321 86TEW/GOL HPLC A 5.3.1.5 xylose isomerase C06468 = C01487 D-psicose(aq) =-D-allose(aq) 2.32 325.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1321 86TEW/GOL HPLC A 5.3.1.5 xylose isomerase C06468 = C01487 D-psicose(aq) =-D-allose(aq) 2.77 341.55 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1321 86TEW/GOL HPLC A 5.3.1.5 xylose isomerase C06468 = C01487 D-psicose(aq) =-D-allose(aq) 3.01 349.25 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1321 86TEW/GOL HPLC A 5.3.1.5 xylose isomerase C06468 = C01487 D-psicose(aq) =-D-allose(aq) 2.55 333.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86REK/SKY_1025 86REK/SKY calorimetry C 3.5.1.14 aminoacylase C02712 + C00001 = C00033 + C00073 N-acetyl-L-methionine(aq) + H2O(l) = acetate(aq) + L-methionine(aq) 298.15 6.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_940 91GOL/BEL calorimetry A 3.2.1.26 _-fructofuranosidase C00492 + C00001 = C05402 + C00095 raffinose(aq) + H2O(l) =-D-melibiose(aq) + D-fructose(aq) 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04LI/LI_1581 04LI/LI calorimetry A 3.6.1.3 adenosinetriphosphatase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87ANT_796 87ANT calorimetry A 3.1.3.1 alkaline phosphatase C02734 + C00001 = C00146 + C00009 phenyl phosphate(aq) + H2O(l) = phenol(aq) + orthophosphate(aq) 298.15 10.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71KUN/STA_1384 71KUN/STA spectrophotometry B 5.3.3.6 methylitaconate ?-isomerase C02295 = C00922 methylitaconate(aq) = dimethylmaleate(aq) 3.4 307.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87ANT_793 87ANT calorimetry A 3.1.3.1 alkaline phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 10.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64TAK/SAW_1373 64TAK/SAW spectrophotometry B 5.3.1.14 L-rhamnose isomerase C00507 = C00861 L-rhamnose(aq) = L-rhamnulose(aq) 1.5 310.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 9.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 6.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 6.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 305.11 8.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 9.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 301.66 8.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 6.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.126 278.15 0.25 7.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.162 298.15 0.25 7.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0353 298.15 0.25 6.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.026 298.15 0.25 6.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00344 298.15 0.25 5.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0656 288.15 0.25 7.31 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00673 278.15 0.25 6.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0646 313.15 0.25 6.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00925 298.15 0.25 6.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.328 313.15 0.25 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.155 278.15 0.25 7.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00239 288.15 0.25 5.79 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.393 308.15 0.25 7.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.292 298.15 0.25 7.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0558 308.15 0.25 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00145 308.15 0.25 6.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00533 313.15 0.25 5.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.357 278.15 0.25 8.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0132 298.15 0.25 6.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0701 298.15 0.25 7.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0701 298.15 0.25 7.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.191 313.15 0.25 7.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0169 288.15 0.25 6.73 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.104 288.15 0.25 7.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.113 308.15 0.25 7.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.435 313.15 0.25 7.59 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0967 298.15 0.25 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.551 298.15 0.25 8.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00938 308.15 0.25 5.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00145 313.15 0.25 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.579 313.15 0.25 7.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0277 278.15 0.25 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.381 288.15 0.25 8.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.477 308.15 0.25 7.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.251 308.15 0.25 7.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0519 313.15 0.25 6.58 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0706 278.15 0.25 7.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.882 308.15 0.25 7.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0459 278.15 0.25 7.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.144 308.15 0.25 7.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00973 288.15 0.25 6.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00973 288.15 0.25 6.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00449 288.15 0.25 5.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0233 313.15 0.25 6.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.236 298.15 0.25 7.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.188 288.15 0.25 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00531 308.15 0.25 5.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0103 313.15 0.25 5.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.131 313.15 0.25 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00413 278.15 0.25 6.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 1.08 313.15 0.25 7.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0183 278.15 0.25 6.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0236 288.15 0.25 6.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0208 308.15 0.25 6.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00145 278.15 0.25 5.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0111 278.15 0.25 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0037 278.15 0.25 6.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00636 298.15 0.25 5.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00651 288.15 0.25 6.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.15 288.15 0.25 7.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0425 308.15 0.25 6.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0428 288.15 0.25 7.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0428 288.15 0.25 7.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95LIA/WAN2_1048 95LIA/WAN2 calorimetry B 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 9.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_549 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00159 = C00008 + C00275 ATP(aq) + D-mannose(aq) = ADP(aq) + D-mannose 6-phosphate(aq) 298.19 8.57 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_549 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00159 = C00008 + C00275 ATP(aq) + D-mannose(aq) = ADP(aq) + D-mannose 6-phosphate(aq) 301.66 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_549 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00159 = C00008 + C00275 ATP(aq) + D-mannose(aq) = ADP(aq) + D-mannose 6-phosphate(aq) 305.11 8.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_549 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00159 = C00008 + C00275 ATP(aq) + D-mannose(aq) = ADP(aq) + D-mannose 6-phosphate(aq) 298.19 8.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STA_375 54STA spectrophotometry B 2.3.1.2&2.3.1.8 imidazole N-acetyltransferase and phosphate acetyltransferase C00227 + C01589 = C02560 + C00009 acetyl phosphate(aq) + imidazole(aq) = N-acetylimidazole(aq) + orthophosphate(aq) 0.006 299.15 6.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STA_375 54STA spectrophotometry B 2.3.1.2&2.3.1.8 imidazole N-acetyltransferase and phosphate acetyltransferase C00227 + C01589 = C02560 + C00009 acetyl phosphate(aq) + imidazole(aq) = N-acetylimidazole(aq) + orthophosphate(aq) 0.0073 299.15 6.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STA_375 54STA spectrophotometry B 2.3.1.2&2.3.1.8 imidazole N-acetyltransferase and phosphate acetyltransferase C00227 + C01589 = C02560 + C00009 acetyl phosphate(aq) + imidazole(aq) = N-acetylimidazole(aq) + orthophosphate(aq) 0.011 299.15 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STA_375 54STA spectrophotometry B 2.3.1.2&2.3.1.8 imidazole N-acetyltransferase and phosphate acetyltransferase C00227 + C01589 = C02560 + C00009 acetyl phosphate(aq) + imidazole(aq) = N-acetylimidazole(aq) + orthophosphate(aq) 0.0092 299.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STA_375 54STA spectrophotometry B 2.3.1.2&2.3.1.8 imidazole N-acetyltransferase and phosphate acetyltransferase C00227 + C01589 = C02560 + C00009 acetyl phosphate(aq) + imidazole(aq) = N-acetylimidazole(aq) + orthophosphate(aq) 0.0099 299.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85BAR_430 85BAR electrophoresis and radioactivity C 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 5 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61RAC2_372 61RAC2 enzymatic assay B 2.2.1.2 transaldolase C05382 + C00118 = C00279 + C00085 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phosphate(aq) + D-fructose 6-phosphate(aq) 1.05 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/TOU_56 57HOL/TOU spectrophotometry B 1.1.1.10 L-xylulose reductase C00379 + C00006 = C00312 + C00005 xylitol(aq) + NADP(aq) = L-xylulose(aq) + NADPH(aq) 0.000858 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/TOU_56 57HOL/TOU spectrophotometry B 1.1.1.10 L-xylulose reductase C00379 + C00006 = C00312 + C00005 xylitol(aq) + NADP(aq) = L-xylulose(aq) + NADPH(aq) 0.00858 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.37 298.15 0.01 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.59 298.15 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 9.49 298.15 0.05 4.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.66 298.15 0.05 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.66 298.15 0.05 5.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.47 298.15 0.05 6.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.35 298.15 0.05 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.43 298.15 0.05 9.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.11 313 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.01 307.7 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4 307.5 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.93 307.5 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.97 307.3 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.68 304.1 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.74 304.1 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.69 303.6 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.04 293.3 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.54 291.2 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.68 290.8 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.61 290.8 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.22 277.8 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.22 277.8 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.37 277.8 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.88 292.6 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.01 290.8 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.2 290.8 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.51 290.6 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.08 290.8 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.34 295.2 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.28 298.15 0.0011 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.13 313 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.55 298.15 0.05 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.72 308.3 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.82 294.1 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.36 290.6 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.87 298.15 0.25 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.31 298.15 0.05 7.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.97 307.6 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.7 291.2 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 8.14 277.9 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.85 303.6 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.94 307.5 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.94 307.5 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.42 298.15 0.05 6.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.88 294.1 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.44 298.15 0.049 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.99 293.4 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.69 292.6 0.1 4.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.81 308.3 0.1 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HUR/HOR_1244 56HUR/HOR enzymatic assay and spectrophotometry B 5.1.3.1 ribulose-phosphate 3-epimerase C00199 = C00231 D-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.5 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69PAS/LOW_1400 69PAS/LOW fluorimetry B 5.4.2.2 phosphoglucomutase C00085 + C01231 = C00092 + C00354 D-fructose 6-phosphate(aq) + D-glucose 1,6-diphosphate(aq) =-D-glucose 6-phosphate(aq) + D-fructose 1,6-bisphosphate(aq) 12 311.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92WED/LEY_1701 92WED/LEY spectrophotometry and radioactivity B 1.1.1.3 homoserine dehydrogenase C00263 + C00006 = C00441 + C00005 L-homoserine(aq) + NADP(ox)(aq) = L-aspartate 4-semialdehyde(aq) + NADP(red)(aq) 0.01 310.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73HAN/RUD_553 73HAN/RUD enzymatic assay; spectrophotometry A 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 2290 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.22e-07 300.15 0.0245 6.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 5.81e-07 300.15 0.0445 6.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.37e-07 300.15 0.055 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 5.62e-07 300.15 0.055 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 8.64e-07 300.15 0.055 7.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.04e-07 300.15 0.067 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.13e-07 300.15 0.067 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.31e-07 300.15 0.067 6.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 8.66e-07 300.15 0.089 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 8.8e-07 300.15 0.089 6.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.79e-07 300.15 0.089 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.51e-07 300.15 0.101 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 9.86e-07 300.15 0.111 6.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.01e-06 300.15 0.111 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 9.13e-07 300.15 0.111 6.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.08e-06 300.15 0.135 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.04e-06 300.15 0.135 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.3e-06 300.15 0.233 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.24e-06 300.15 0.233 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.39e-06 300.15 0.233 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.52e-06 300.15 0.471 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.52e-06 300.15 0.471 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.49e-06 300.15 0.471 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.51e-06 300.15 0.471 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.12e-06 300.15 0.471 6.79 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.84e-06 300.15 0.471 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.83e-06 300.15 0.471 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.56e-06 303.15 0.709 6.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.4e-06 298.1 0.47 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.8e-06 300.1 0.47 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.8e-06 305.1 0.47 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.3e-06 309.8 0.47 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.14e-07 300.15 0.0245 6.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 5.3e-06 311.1 0.47 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 5.73e-07 300.15 0.0445 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.79e-07 300.15 0.067 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.16e-06 300.15 0.101 7.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.05e-06 300.15 0.135 6.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.78e-06 300.15 0.471 7.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.18e-06 303.15 0.709 7.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70JEN/TAY_536 70JEN/TAY spectrophotometry C 2.6.1.42 branched-chain-amino-acid transaminase C00123 + C00026 = C00233 + C00025 L-leucine(aq) + 2-oxoglutarate(aq) = 4-methyl-2-oxopentanooate(aq) + L-glutamate(aq) 1.75 310.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_785 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 298.15 8.15 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_785 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 298.15 9.14 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_785 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 304.55 7.92 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_785 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 310.15 7.81 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_785 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 298.15 8.55 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_141 85ANS/PRI D 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.4e-05 311.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_141 85ANS/PRI D 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.6e-05 311.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_141 85ANS/PRI D 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 6.4e-05 311.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78OKA/GEN_893 78OKA/GEN paper chromatography C 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 322 303.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97STA/SUA_1365 97STA/SUA spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.33 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97STA/SUA_1365 97STA/SUA spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.3 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72STU_745 72STU calorimetry A 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93HUT/BOH_227 93HUT/BOH calorimetry A 1.1.3.4 glucose oxidase C00031 + C00007 = C00198 + C00027 -D-glucose(aq) + O2(aq) = D-glucono-1,5-lactone(aq) + H2O2(aq) 298.15 6.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70TSA/HOL_1255 70TSA/HOL spectrophotometry A 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.3 298.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06XU/WES_1713 06XU/WES spectrophotometry A 1.5.1.7 saccharopine dehydrogenase (NAD+, L-lysine-forming) C00449 + C00003 + C00001 = C00047 + C00026 + C00004 N6-(L-1,3-dicarboxypropyl)-L-lysine + NAD(ox) + H2O(l) = L-lysine(aq) + 2-oxoglutarate(aq) + NAD(red) 3.9e-07 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55LEH/SIC_1097 55LEH/SIC C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 2.8e-06 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55LEH/SIC_1092 55LEH/SIC C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.000118 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 1.03e-07 298.15 7.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 2.92e-07 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 2.33e-07 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 3.3e-07 298.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 9.29e-08 298.15 7.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 1.2e-07 298.15 7.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 3.05e-07 298.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 8.9e-05 287.45 7.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000154 292.15 7.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000235 298.15 7.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.00024 298.15 7.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000277 298.15 7.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000212 298.15 7.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000222 298.15 7.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000259 298.15 8.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000223 298.15 8.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000424 304.25 7.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000359 304.25 7.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000598 310.15 7.81 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 8.3e-05 287.45 7.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000571 310.15 7.81 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000228 298.15 7.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000261 298.15 7.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000959 316.15 7.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000265 298.15 7.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.00101 316.15 7.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000137 292.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84BLA/COC_295 84BLA/COC spectrophotometry and HPLC C 1.5.1.3 dihydrofolate reductase 2 C00415 = C00504 + C00101 2 7,8-dihydrofolate(aq) = folate(aq) + 5,6,7,8-tetrahydrofolate(aq) 19.4 295.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAR/BAR_196 63MAR/BAR spectrophotometry C 1.1.1.67 mannitol dehydrogenase C00392 + C00003 = C00095 + C00004 D-mannitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.084 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 5.6e-05 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.000481 298.15 9.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 1.31e-05 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.000255 298.15 8.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.24e-05 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.71e-06 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80SVE/MAR_1008 80SVE/MAR spectrophotometry B 3.5.1.11 penicillin amidase C07761 + C00001 = C02595 + C07756 cephalothin(aq) + H2O(l) = 2-thienylacetic acid(aq) + 7-aminocephalosporanic acid(aq) 0.007 298.15 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69DAH/AND_1109 69DAH/AND enzymatic assay and spectrophotometry B 4.1.2.18 2-dehydro-3-deoxy-L-pentonate aldolase C00684 = C00022 + C00266 2-dehydro-3-deoxy-L-pentonate(aq) = pyruvate(aq) + glycolaldehyde(aq) 0.00037 301.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_921 91TEW/GOL HPLC A 3.2.1.21 _-glucosidase C05402 + C00001 = C00124 + C00031 -D-melibiose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 123 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELL_588 89ELL NMR and enzymatic assay C 2.7.3.1 guanidinoacetate kinase C00002 + C00581 = C00008 + C03166 ATP(aq) + guanidinoacetate(aq) = ADP(aq) + phosphoguanidinoacetate(aq) 29 308.15 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SHO/PRI_216 59SHO/PRI C 1.1.1.140 sorbitol-6-phosphate dehydrogenase C01096 + C00003 = C00085 + C00004 D-sorbitol 6-phosphate(aq) + NAD(aq) = D-fructose 6-phosphate(aq) + NADH(aq) 2.2 298.15 9.31 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BUR_39 55BUR spectrophotometry C 1.1.1.6 glycerol dehydrogenase C00116 + C00003 = C00184 + C00004 glycerol(aq) + NAD(aq) = dihydroxyacetone(aq) + NADH(aq) 6.4e-05 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_70 96TEW/GOL HPLC and spectrophotometry A 1.1.1.14 L-iditol 2-dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.094 298.15 7.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_71 96TEW/GOL calorimetry A 1.1.1.14 L-iditol 2-dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 298.15 7.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69SHE/ALE_446 69SHE/ALE enzymatic assay C 2.4.1.20 cellobiose phosphorylase C06219 + C00009 = C00185 + C00103 cellotriose(aq) + orthophosphate(aq) = cellobiose(aq) + D-glucose 1-phosphate(aq) 0.4 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_73 96TEW/GOL HPLC and spectrophotometry A 1.1.1.14 L-iditol 2-dehydrogenase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.00122 298.15 7.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_74 96TEW/GOL calorimetry A 1.1.1.14 L-iditol 2-dehydrogenase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 298.15 7.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76WEI/KIR_1179 76WEI/KIR spectrophotometry C 4.2.1.20 tryptophan synthase C00118 + C00463 = C03506 D-glyceraldehyde 3-phosphate(aq) + indole(aq) = 1-(indol-3-yl)glycerol 3-phosphate(aq) 2300 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 8.65 303.15 0.065 5.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.5 303.15 0.065 6.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.59 303.15 0.065 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.65 303.15 0.065 7.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 9.81 293.15 0.065 6.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.28 293.15 0.065 7.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.74 293.15 0.065 8.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.3 303.15 0.046 7.4 1.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.31 303.15 0.032 7.4 1.48 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.64 303.15 0.059 7.4 1.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.45 303.15 0.3 7.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.36 303.15 0.038 7.4 1.48 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.02 303.15 0.065 6.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.4 303.15 0.065 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.72 303.15 0.065 6.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.14 303.15 0.3 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.11 303.15 0.085 7.4 1.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.43 303.15 0.3 7.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.47 303.15 0.3 8.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.84 303.15 0.3 7.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.1 303.15 0.3 7.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.1 303.15 0.3 7.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.06 303.15 0.3 6.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DOU_416 61DOU D 2.4.1.7 sucrose phosphorylase C00089 + C00009 = C00103 + C00095 sucrose(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-fructose(aq) 20 303.15 6.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00KIS/TEW_1574 00KIS/TEW calorimetry and chromatography A 3.5.1.2 glutaminase C00064 + C00001 = C00025 + C00014 L-glutamine(aq) + H2O(l) = L-glutamate(aq) + ammonia(aq) 298.15 0.11 5.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00KIS/TEW_1575 00KIS/TEW calorimetry and chromatography A 3.5.1.1 asparaginase C00152 + C00001 = C00049 + C00014 L-asparagine(aq) + H2O(l) = L-aspartate(aq) + ammonia(aq) 298.15 0.11 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65GAU/WOL_1226 65GAU/WOL chemical analysis C 4.3.2.3 ureidoglycolate lyase C00603 = C00048 + C00086 (-)-ureidoglycolate(aq) = glyoxylate(aq) + urea(aq) 0.15 303.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65GAU/WOL_1226 65GAU/WOL chemical analysis C 4.3.2.3 ureidoglycolate lyase C00603 = C00048 + C00086 (-)-ureidoglycolate(aq) = glyoxylate(aq) + urea(aq) 0.14 303.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_568 82RED calorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_568 82RED calorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_568 82RED calorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_568 82RED calorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95LIU/ZEN_1049 95LIU/ZEN calorimetry B 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 9.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66ALL_234 66ALL enzymatic assay and spectrophotometry B 1.1.99.7 lactate-malate transhydrogenase C00186 + C00036 = C00149 + C00022 (S)-lactate(aq) + oxaloacetate(aq) = (S)-malate(aq) + pyruvate(aq) 1.8 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71TAN/JOH_402 71TAN/JOH chromatography and spectrophotometry C 2.3.1.8&2.3.1.54 phosphate acetyltransferase and formate C-acetyltransferase C00022 + C00009 = C00227 + C00058 pyruvate(aq) + orthophosphate(aq) = acetyl phosphate(aq) + formate(aq) 23 310.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70GEO/WIT_806 70GEO/WIT calorimetry C 3.1.3.1 alkaline phosphatase C00074 + C00001 = C00022 + C00009 phosphoenolpyruvate3-(aq) + H2O(l) = pyruvate-(aq) + HPO4-2-(aq) 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 57.4 278.5 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 28.8 283.2 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 21.8 288 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 12.3 303.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 23.6 303.15 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 38.2 303.15 7.4 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 48.2 303.15 7.57 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 18.5 309.5 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 19.6 298.2 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 17.8 303 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 5 303.15 6.73 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 12.8 303.15 7.03 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 12.9 303.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79SCH/HIN_108 79SCH/HIN calorimetry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79SCH/HIN_108 79SCH/HIN calorimetry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79SCH/HIN_108 79SCH/HIN calorimetry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 283.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_786 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C00275 + C00001 = C00159 + C00009 D-mannose 6-phosphate(aq) + H2O(l) = D-mannose(aq) + orthophosphate(aq) 39 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KRA/GYG_1120 91KRA/GYG HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.012 283.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KRA/GYG_1120 91KRA/GYG HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.0348 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92XIA/XUE_1414 92XIA/XUE spectrophotometry C 5.4.2.8 phosphomannomutase C00636 = C00275 D-mannose 1-phosphate(aq) = D-mannose 6-phosphate(aq) 16.2 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52ASK_592 52ASK C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.04 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52ASK_592 52ASK C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.2 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54UTT/KUR_1082 54UTT/KUR chromatography and enzymatic assay C 4.1.1.32 phosphoenolpyruvate carboxykinase (GTP) C00081 + C00036 + C00001 = C00104 + C00074 + C00288 ITP(aq) + oxaloacetate(aq) + H2O(l) = IDP(aq) + phosphoenolpyruvate(aq) + carbon dioxide(aq) 12 303.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.252 311.15 0.25 7.01 3.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.171 311.15 0.25 7.01 2.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.395 311.15 0.25 7.01 3.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.695 311.15 0.25 7.01 4.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.164 311.15 0.25 7.01 2.57 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.989 311.15 0.25 7.01 5.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79REK/EGO_238 79REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 7.48 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79REK/EGO_238 79REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 8.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79REK/EGO_238 79REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 6.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79REK/EGO_238 79REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 6.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 7.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 7.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 7.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 8.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 8.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 8.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 304.65 7.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 7.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 8.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 310.15 7.79 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85SRI/FIS_293 85SRI/FIS spectrophotometry B 1.5.1.1 pyrroline-2-carboxylate reductase C00148 + C00006 = C03564 + C00005 (S)-proline(aq) + NADP(aq) =D-1-pyrroline-2-carboxylate(aq) + NADPH(aq) 0.0036 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85SRI/FIS_293 85SRI/FIS spectrophotometry B 1.5.1.1 pyrroline-2-carboxylate reductase C00148 + C00006 = C03564 + C00005 (S)-proline(aq) + NADP(aq) =D-1-pyrroline-2-carboxylate(aq) + NADPH(aq) 0.0036 298.15 9.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85SRI/FIS_293 85SRI/FIS spectrophotometry B 1.5.1.1 pyrroline-2-carboxylate reductase C00148 + C00006 = C03564 + C00005 (S)-proline(aq) + NADP(aq) =D-1-pyrroline-2-carboxylate(aq) + NADPH(aq) 0.0036 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85SRI/FIS_293 85SRI/FIS spectrophotometry B 1.5.1.1 pyrroline-2-carboxylate reductase C00148 + C00006 = C03564 + C00005 (S)-proline(aq) + NADP(aq) =D-1-pyrroline-2-carboxylate(aq) + NADPH(aq) 0.0036 298.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_32 80COO/BLA spectrophotometry B 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.53 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.343 298.15 8.31 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.352 292.15 8.46 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.357 304.15 8.16 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.351 304.15 8.34 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.381 298.15 8.34 2.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.378 298.15 8.54 2.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.634 298.15 8.33 1.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.603 298.15 8.53 1.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.484 298.15 8.5 2.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.302 298.15 8.32 1.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.268 298.15 8.5 1.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.361 298.15 8.54 3.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.462 298.15 8.68 3.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.458 298.15 8.87 3.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.366 298.15 7.79 3.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.366 298.15 6.04 3.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.377 298.15 6.67 3.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.364 298.15 6.77 3.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.365 298.15 7.41 3.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.366 298.15 7.45 3.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.346 298.15 8.54 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.346 298.15 8.54 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.861 298.15 8.28 1.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.412 298.15 8.67 3.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.934 311.15 6.83 1.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.351 310.25 7.98 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 298.15 8.73 3.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.348 310.25 8.13 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.349 298.15 8.4 3.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.355 286.05 8.68 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.258 298.15 8.56 0.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.45 298.15 8.57 3.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.475 298.15 8.3 2.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.364 298.15 7.93 3.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.26 298.15 8.4 0.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.365 298.15 6.88 3.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.349 292.15 8.67 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.854 298.15 8.51 1.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.408 298.15 8.49 3.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.928 311.15 7.04 1.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.356 286.05 8.85 3.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_656 91TEW/GOL2 calorimetry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 304.55 8.2 3.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_656 91TEW/GOL2 calorimetry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 310.25 8.1 3.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_656 91TEW/GOL2 calorimetry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 298.15 8.37 3.58 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69DOL_235 69DOL enzymatic assay and spectrophotometry B 1.1.99.7 lactate-malate transhydrogenase C00186 + C00036 = C00149 + C00022 (S)-lactate(aq) + oxaloacetate(aq) = (S)-malate(aq) + pyruvate(aq) 4.3 297.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.8 297.15 6.1 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.55 297.15 8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.7 297.15 8 2.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.84 297.15 8 2.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.4 297.15 8 2.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.25 297.15 8 2.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.99 297.15 8 2.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.64 297.15 8 2.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.52 297.15 8 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.67 297.15 8 2.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.27 297.15 8 2.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.57 297.15 9 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.42 297.15 10.1 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.57 297.15 8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.6 297.15 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.24 297.15 8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.46 297.15 8 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54MAR/WIL_1234 54MAR/WIL enzymatic assay B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1 307.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72NAG/JAE_299 72NAG/JAE spectrophotometry C 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 0.0005 298.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66GOL/MAR_447 66GOL/MAR chromatography B 2.4.1.31 laminaribiose phosphorylase C02048 + C00009 = C00031 + C00103 laminaribiose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.3 310.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00LIA/HUA_1580 00LIA/HUA calorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71NOJ/TAN_399 71NOJ/TAN spectrophotometry B 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0075 300.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STR/HAR_38 54STR/HAR spectrophotometry B 1.1.1.4 (R,R)-butanediol dehydrogenase C03044 + C00003 = C00810 + C00004 (R,R)-2,3-butanediol(aq) + NAD(aq) = (R)-acetoin(aq) + NADH(aq) 0.0668 300.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STR/HAR_38 54STR/HAR spectrophotometry B 1.1.1.4 (R,R)-butanediol dehydrogenase C03044 + C00003 = C00810 + C00004 (R,R)-2,3-butanediol(aq) + NAD(aq) = (R)-acetoin(aq) + NADH(aq) 0.00723 300.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE2_498 53KRE2 manometry A 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.148 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 6.67 298.15 5.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 4.83 298.15 5.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 8.06 298.15 5.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 20.4 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 2.09 298.15 5.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 15 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 1.85 298.15 5.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96KIM/DUN_1571 96KIM/DUN spectrophotometry B 5.4.2.9 phosphoenolpyruvate mutase C00074 = C02798 phosphoenolpyruvate(aq) = 3-phosphonopyruvate(aq) 0.0008 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.8 298.15 8.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.84 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.19 298.15 7.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.63 298.15 6.03 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.83 298.15 6.04 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.45 298.15 6.08 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.76 298.15 6.08 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.21 298.15 6.23 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.27 298.15 6.23 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.17 298.15 6.29 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.54 288 7.5 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.55 299.5 7.5 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.5 298.15 6.5 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.29 298.15 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.68 298.15 7.5 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.15 298.15 8.5 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.4 298.15 6.5 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.92 298.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.41 298.15 8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.52 298.15 8.5 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.35 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.35 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.48 298.15 6.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.2 298.15 8.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.91 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.51 298.15 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.48 298.15 7.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.21 298.15 6.29 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.1 298.15 6.34 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.21 298.15 6.34 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.63 298.15 6.49 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.68 298.15 6.49 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.84 298.15 6.55 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.09 298.15 6.74 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.37 298.15 6.74 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.26 298.15 6.78 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.26 298.15 6.84 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.38 298.15 7 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.52 298.15 7 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.68 298.15 7 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.4 298.15 7.12 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.8 298.15 7.12 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.8 298.15 7.12 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.56 298.15 7.38 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.64 298.15 7.38 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5 298.15 7.38 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.68 298.15 7.46 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.82 298.15 7.46 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.86 298.15 7.46 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.06 298.15 7.88 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.1 298.15 7.88 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.92 298.15 7.88 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.15 298.15 7.94 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.08 298.15 8.25 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.19 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.36 298.15 6.34 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4 298.15 6.84 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.71 298.15 7.85 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.97 298.15 8.25 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5 298.15 8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.29 298.15 7.5 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.12 298.15 5.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.32 298.15 6.23 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.32 298.15 6.23 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.61 298.15 6.55 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.43 298.15 7 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.7 298.15 7.38 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.25 298.15 7.88 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.8 298.15 7.16 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.25 298.15 8.25 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.28 307.5 7.5 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.05 298.15 8.25 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.78 298.15 6.43 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.24 298.15 6.84 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.97 298.15 7.16 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.25 298.15 7.85 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.76 298.15 6.13 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.27 298.15 8.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.65 298.15 6 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.89 298.15 7.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.16 298.15 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.55 298.15 6.13 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.32 298.15 5.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.5 298.15 6 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.5 298.15 6 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.25 298.15 7.94 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=31BOR/SCH_1141 31BOR/SCH electrochemistry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.1 298.15 6.81 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=31BOR/SCH_1141 31BOR/SCH electrochemistry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.3 298.15 7.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BRO_1399 53BRO enzymatic assay C 5.4.2.2 phosphoglucomutase C00352 = C06156 D-glucosamine 6-phosphate(aq) = D-glucosamine 1-phosphate(aq) 0.28 303.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BRO_1399 53BRO enzymatic assay C 5.4.2.2 phosphoglucomutase C00352 = C06156 D-glucosamine 6-phosphate(aq) = D-glucosamine 1-phosphate(aq) 0.24 303.15 7.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BRO_1399 53BRO enzymatic assay C 5.4.2.2 phosphoglucomutase C00352 = C06156 D-glucosamine 6-phosphate(aq) = D-glucosamine 1-phosphate(aq) 0.28 303.15 7.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KIT/HOR_1085 56KIT/HOR microcalorimetry C 4.1.1.39 ribulose-biphosphate carboxylase C01182 + C00288 = 2 C00197 D-ribulose 1,5-biphosphate(aq) + carbon dioxide(aq) = 2 3-phospho-D-glycerate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KIT/HOR_1085 56KIT/HOR microcalorimetry C 4.1.1.39 ribulose-biphosphate carboxylase C01182 + C00288 = 2 C00197 D-ribulose 1,5-biphosphate(aq) + carbon dioxide(aq) = 2 3-phospho-D-glycerate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54ROS/GRU_573 54ROS/GRU spectrophotometry B 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.0087 302.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94REK/SCH_1601 94REK/SCH calorimetry A 3.2.1.26 -fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 4.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/OES_563 49MEY/OES spectrophotometry, chemical analysis, and radioactivity C 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000556 303.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 7.9 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.9 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.4 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.4 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.6 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.7 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.2 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.1 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 7.4 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.5 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.2 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 8 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.3 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.9 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.7 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 4.7 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.2 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65UYE/RAB_354 65UYE/RAB spectrophotometry B 2.1.2.4 glycine formiminotransferase C00664 + C00037 = C02718 + C00101 5-formiminotetrahydrofolate(aq) + glycine(aq) = N-formiminoglycine(aq) + tetrahydrofolate(aq) 3.1 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73ROT/KIS_346 73ROT/KIS calorimetry A 2.1.1.45 thymidylate synthase C00143 + C00365 = C00415 + C00364 5,10-methylenetetrahydrofolate(aq) + dUMP(aq) = dihydrofolate(aq) + dTMP(aq) 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAK/YOS_883 65TAK/YOS calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73BEE/STE_998 73BEE/STE calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03WAT/YAM_1700 03WAT/YAM chromatography A 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1.1 310.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAH/LOW_1354 60KAH/LOW enzymatic assay; fluorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.298 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAH/LOW_1354 60KAH/LOW enzymatic assay; fluorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.26 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAH/LOW_1354 60KAH/LOW enzymatic assay; fluorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.327 311.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.89 311.15 7.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.92 311.15 7.07 5.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 11 311.15 7.07 4.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 16.1 311.15 7.07 3.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 28.8 311.15 7.07 2.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 47 311.15 7.07 2.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.51 311.15 6.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 10.3 311.15 6.64 4.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 29.5 311.15 6.64 2.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 46 311.15 6.64 2.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 13.9 311.15 7.07 3.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 52.3 311.15 7.07 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 14.8 311.15 7.45 3.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 15.8 311.15 6.64 3.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 27.6 311.15 7.45 2.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 46 311.15 7.07 2.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.48 311.15 7.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 17.1 311.15 7.07 3.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 10.6 311.15 7.07 4.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 18 311.15 7.07 3.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 10 311.15 7.07 4.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 10 311.15 7.07 4.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 47.5 311.15 7.07 2.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 57.9 311.15 7.07 1.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 12.2 311.15 7.07 3.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.83 311.15 7.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.95 311.15 7.45 4.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 46.6 311.15 7.45 2.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 43.6 311.15 7.07 2.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 37.2 311.15 7.07 2.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80BEY/ROE_894 80BEY/ROE HPLC C 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 197 328 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 0.081 295.15 6.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 0.18 295.15 6.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 0.65 295.15 7.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 1 295.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 3.6 295.15 8.59 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 0.36 295.15 7.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 4.8 295.15 9.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 2.6 295.15 8.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 0.28 295.15 7.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 1.5 295.15 8.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_324 59SAN/LAN spectrophotometry C 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.13 295.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BRU/NOL_1334 58BRU/NOL spectrophotometry C 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.28 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BRU/NOL_1334 58BRU/NOL spectrophotometry C 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.31 273.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MCG/JOR_547 75MCG/JOR calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MCG/JOR_547 75MCG/JOR calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MCG/JOR_547 75MCG/JOR calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MCG/JOR_547 75MCG/JOR calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.293 298.15 8.7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.299 298.15 8.7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.302 298.15 8.7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.31 304.95 8.7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.329 310.15 8.7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.357 316.15 8.7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.308 298.15 8.7 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.287 298.15 8.7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 316.15 8.7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 310.15 8.7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 304.95 8.7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.7 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KIS/HOL_1199 99KIS/HOL calorimetry A 4.2.1.51 prephenate dehydratase C00254 = C00166 + C00001 + C00288 prephenate(aq) = phenylpyruvate(aq) + H2o(l) + carbon dioxide(aq) 298.15 7.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BEN_1149 69BEN calorimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.45 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80SVE/MAR_1010 80SVE/MAR spectrophotometry B 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.004 298.15 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80SVE/MAR_1010 80SVE/MAR spectrophotometry B 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.02 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79VIC/GRE_482 79VIC/GRE spectrophotometry C 2.4.2.10 orotate phosphoribosyltransferase C01103 + C00013 = C00295 + C00119 orotidine 5'-phosphate(aq) + pyrophosphate(aq) = orotate(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 2 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83PIL/HAN_1596 83PIL/HAN radioactivity C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.38 310.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57VLA/VLA_545 57VLA/VLA radioactivity C 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 340 310.15 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_935 91TEW/GOL calorimetry A 3.2.1.23 _-galactosidase C07064 + C00001 = C00124 + C00095 lactulose(aq) + H2O(l) = D-galactose(aq) + D-fructose(aq) 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_934 91TEW/GOL HPLC A 3.2.1.23 _-galactosidase C07064 + C00001 = C00124 + C00095 lactulose(aq) + H2O(l) = D-galactose(aq) + D-fructose(aq) 128 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 294 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 336 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 319 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 310 311.15 0.25 7 2.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 294 311.15 0.25 7 2.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 338 311.15 0.25 6.95 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 301 311.15 0.25 6.92 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 260 311.15 0.25 6.89 2.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 297 311.15 0.25 6.93 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 307 311.15 0.25 6.73 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 269 311.15 0.25 7 2.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 298 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 247 311.15 0.25 6.87 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 290 311.15 0.25 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 303 311.15 0.25 7 2.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 255 311.15 0.25 6.9 2.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 332 311.15 0.25 7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 270 311.15 0.25 6.88 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 384 311.15 0.25 6.96 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 341 311.15 0.25 6.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 288 311.15 0.25 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 288 311.15 0.25 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 306 311.15 0.25 6.72 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72MAR/BEL_450 72MAR/BEL enzymatic assay and spectrophotometry C 2.4.1.64 ,-trehalose phosphorylase C01083 + C00009 = C00031 + C00103 ,-trehalose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.059 310.15 6.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72MAR/BEL_450 72MAR/BEL enzymatic assay and spectrophotometry C 2.4.1.64 ,-trehalose phosphorylase C01083 + C00009 = C00031 + C00103 ,-trehalose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.24 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91AND/KAT_1232 91AND/KAT HPLC B 4.- 4-aminobenzoate synthase C00251 + C00014 = C11355 + C00001 chorismate(aq) + ammonia(aq) = 4-amino-4-deoxychorismate(aq) + H2O(l) 6.1 310.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99BRA/FIS_1516 99BRA/FIS spectrophotometry and NMR B 3.5.4.16 GTP cyclohydrolase I C00044 + C00001 = C05922 GTP(aq) + H2O(l) = ((2R,3S,4R,5R)-5-(2-amino-5-formamido-6-oxo-3,6-dihydropyrimidin-4-ylamino)-3,4-dihydroxytetrahydrofuran-2-yl)methyl tetrahydrogen triphosphate(aq) 0.1 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63SLY/STA_397 63SLY/STA spectrophotometric B 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0142 303.15 6.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69FAN/FEI_1254 69FAN/FEI radioactivity and spectrophotometry B 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.32 303.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96LI/ZHA_668 96LI/ZHA NMR and radioactivity A 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 1.5 298.15 7.5 2.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96LI/ZHA_668 96LI/ZHA NMR and radioactivity A 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 3.1 298.15 7.5 1.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96LI/ZHA_668 96LI/ZHA NMR and radioactivity A 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 5.2 298.15 7.5 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96LI/ZHA_668 96LI/ZHA NMR and radioactivity A 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 5.3 298.15 7.5 1.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96LI/ZHA_668 96LI/ZHA NMR and radioactivity A 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 2.1 298.15 7.7 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59NOR/FRO_188 59NOR/FRO spectrophotometry B 1.1.1.56 ribitol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.00717 301.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62WIL/SNE_358 62WIL/SNE chromatography and spectrophotometry B 2.1.2.7 D-alanine 2-hydroxymethyltransferase C03059 = C00740 + C00067 2-hydroxymethylserine(aq) = D-serine(aq) + formaldehyde(aq) 0.00027 311.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03GOL/TEW_1546 03GOL/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00074 + C00001 = C00022 + C00009 phosphoenolpyruvate(aq) + H2O(l) = pyruvate(aq) + orthophosphate(aq) 298.15 0.33 7.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOR/ESF_316 75GOR/ESF spectrophotometry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.0373 298.15 7.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOR/ESF_316 75GOR/ESF spectrophotometry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.0054 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOR/ESF_316 75GOR/ESF spectrophotometry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.049 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOR/ESF_316 75GOR/ESF spectrophotometry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.138 298.15 8.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45OHL_1144 45OHL calorimetry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 297.45 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.3e-05 298.15 7.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.5e-05 298.15 7.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00011 298.15 7.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.0002 298.15 8.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.0005 298.15 8.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00063 298.15 8.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 5.0e-05 298.15 7.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.895 310.6 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.12 345.2 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.083 341.6 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.037 333.2 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.992 326.5 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.936 318.2 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85COO/PRA_1203 85COO/PRA spectrophotometry and HPLC C 4.2.1.- 3-hydroxybutyryl-CoA dehyratase C01144 = C00877 + C00001 DL-3-hydroxybutanoyl-CoA(aq) = trans-but-2-enoyl-CoA(aq) + H2O(l) 0.28 308.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/EGG_149 69VEE/EGG spectrophotometry A 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.0344 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45GRE/LEL_497 45GRE/LEL spectrophotometry C 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.3 311.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52BAU/GEM_942 52BAU/GEM calorimetry B 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 303.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60MAX/ROB_1250 60MAX/ROB spectrophotometry C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.33 298.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98URB/BRA_1684 98URB/BRA spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(ox)(aq) = oxaloacetate(aq) + NAD(red)(aq) 6.65e-05 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80LER/COH_599 80LER/COH NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.053 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_44 53BUR/WIL spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.000174 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_44 53BUR/WIL spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.00055 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_44 53BUR/WIL spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.00174 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_44 53BUR/WIL spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.0055 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BRO_511 68BRO spectrophotometry A 2.6.1.2 alanine aminotransferase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.68 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65YOS_132 65YOS spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00367 298.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65YOS_132 65YOS spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000976 298.15 8.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55LIE/KOR2_664 55LIE/KOR2 chromatography B 2.7.4.4 nucleoside-phosphate kinase C00075 + C00105 = 2 C00015 UTP(aq) + UMP(aq) = 2 UDP(aq) 0.94 309.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06MCC/ARA_1585 06MCC/ARA spectrophotometry and enzymatic assay B 2.7.7 ADP-glucose phosphorylase C00008 + C00103 = C00498 + C00009 ADP(aq) + D-glucose 1-phosphate(aq) = ADPglucose(aq) + orthophosphate(aq) 0.2 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06MCC/ARA_1585 06MCC/ARA spectrophotometry and enzymatic assay B 2.7.7 ADP-glucose phosphorylase C00008 + C00103 = C00498 + C00009 ADP(aq) + D-glucose 1-phosphate(aq) = ADPglucose(aq) + orthophosphate(aq) 0.025 298.15 7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.64 311.15 0.25 7.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.62 311.15 0.25 7.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.45 311.15 0.25 6.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.44 311.15 0.25 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.17 311.15 0.25 6.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.42 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.43 311.15 0.25 6.91 3.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.44 311.15 0.25 6.91 2.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.205 311.15 0.04 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.433 311.15 0.18 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.487 311.15 0.21 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.616 311.15 0.25 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 1.015 311.15 0.6 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.42 311.15 0.25 6.91 3.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.58 311.15 0.25 7.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.43 311.15 0.25 6.91 2.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.337 311.15 0.1 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.789 311.15 0.4 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.43 311.15 0.25 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.62 311.15 0.25 7.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.41 311.15 0.25 6.91 3.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.41 311.15 0.25 6.91 3.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.41 311.15 0.25 6.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77SCH/CLE_151 77SCH/CLE spectrophotometry C 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.029 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_259 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 2170 311.15 7 2.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56ALE/GRE_348 56ALE/GRE spectrophotometry B 2.1.2.1 glycine hydroxymethyltransferase C00037 + C00067 = C00065 glycine(aq) + formaldehyde(aq) = L-serine(aq) 2760 310.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65MAY/GIN_705 65MAY/GIN radioactivity and spectrophotometry B 2.7.7.33 glucose-1-phosphate cytidylyltransferase C00063 + C00103 = C00501 + C00013 CTP(aq) + D-glucose 1-phosphate(aq) = CDPglucose(aq) + pyrophosphate(aq) 1 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80SVE/MAR_1017 80SVE/MAR spectrophotometry B 3.5.1.11 penicillin amidase C05598 + C00001 = C07086 + C00037 phenylacetylglycine(aq) + H2O(l) = phenylacetic acid(aq) + glycine(aq) 1.2 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62DUR/RAW_340 62DUR/RAW calorimetry A 2.1.1.3 thetin-homocysteine S-methyltransferase C03392 + C00155 = C03173 + C00073 dimethylacetothetin(aq) + L-homocysteine(aq) = S-methylthioglycolate(aq) + L-methionine(aq) 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MUR/TSU_461 75MUR/TSU spectrophotometry B 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.048 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43KRE/EGG_1162 43KRE/EGG polarimetry and manometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 14.4 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90LIU_1424 90LIU NMR and spectrophotometry A 5.4.99.6 isochorismate synthase C00251 = C00885 chorismate(aq) = isochorismate(aq) 0.66 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_1076 81HIN/POL calorimetry A 3.6.1.32 myosin ATPase C00044 + C00001 = C00035 + C00009 GTP(aq) + H2O(l) = GDP(aq) + orthophosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_1076 81HIN/POL calorimetry A 3.6.1.32 myosin ATPase C00044 + C00001 = C00035 + C00009 GTP(aq) + H2O(l) = GDP(aq) + orthophosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81KIS/NIE_1572 81KIS/NIE spectrophotometry B 1.1.1.17 mannitol-1-phosphate 5-dehydrogenase C00644 + C00003 = C00085 + C00004 D-mannitol-1-phosphate(aq) + NAD(ox)(aq) = D-fructose 6-phosphate(aq) + NAD(red)(aq) 0.79 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91LIU/FRO_832 91LIU/FRO NMR C 3.1.3.11 fructose-biphosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 47 288.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41WAR/CHR_1171 41WAR/CHR spectrophotometry C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 1.43 293.15 7.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87MIL/EST_1588 87MIL/EST spectrophotometry C 1.1.1.274 2,5-diketo-D-gluconate reductase C15673 + C00006 = C02780 + C00005 2-keto-L-gulonate(aq) + NADP(ox)(aq) = 2,5-diketo-D-gluconate(aq) + NADP(red)(aq) 0.00089 298.15 9.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87MIL/EST_1588 87MIL/EST spectrophotometry C 1.1.1.274 2,5-diketo-D-gluconate reductase C15673 + C00006 = C02780 + C00005 2-keto-L-gulonate(aq) + NADP(ox)(aq) = 2,5-diketo-D-gluconate(aq) + NADP(red)(aq) 0.0022 298.15 9.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ASP/JAK_215 64ASP/JAK spectrophotometry C 1.1.1.129 L-threonate dehydrogenase C01620 + C00003 = C03064 + C00004 L-threonate(aq) + NAD(aq) = 3-oxo-L-threonate(aq) + NADH(aq) 0.00553 298.15 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ASP/JAK_215 64ASP/JAK spectrophotometry C 1.1.1.129 L-threonate dehydrogenase C01620 + C00003 = C03064 + C00004 L-threonate(aq) + NAD(aq) = 3-oxo-L-threonate(aq) + NADH(aq) 0.000342 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ASP/JAK_215 64ASP/JAK spectrophotometry C 1.1.1.129 L-threonate dehydrogenase C01620 + C00003 = C03064 + C00004 L-threonate(aq) + NAD(aq) = 3-oxo-L-threonate(aq) + NADH(aq) 0.00125 298.15 7.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76RUS/MUL_237 76RUS/MUL spectrophotometry D 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 420 298.15 6.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 6.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 7.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 7.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 310.15 6.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 304.65 6.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1044 94KIS/TEW HPLC A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 2.9 298.15 6.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GAR/CLE_662 69GAR/CLE radioactivity and chromatography B 2.7.4.4 nucleoside-phosphate kinase C00002 + C00015 = C00008 + C00075 ATP(aq) + UDP(aq) = ADP(aq) + UTP(aq) 1.28 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_6 80COO/BLA spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00854 + C00003 = C00414 + C00004 cyclohexanol(aq) + NAD(aq) = cyclohexanone(aq) + NADH(aq) 0.2 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_2 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.0031 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_2 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.0098 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_2 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.098 298.15 9.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_2 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.00098 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_2 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.031 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81SUG/VEI_53 81SUG/VEI spectrophotometry C 1.1.1.9 D-xylulose reductase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.06 298.15 9.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65ONO/HIR_892 65ONO/HIR calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65ONO/HIR_892 65ONO/HIR calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 308.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SIL/VOE_417 67SIL/VOE spectrophotometry C 2.4.1.7 sucrose phosphorylase C00089 + C00009 = C00103 + C00095 sucrose(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-fructose(aq) 16 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65BES/HER_671 65BES/HER radioactivity and spectrophotometry C 2.7.4.13 (deoxy)nucleoside-phosphate kinase C00002 + C00364 = C00008 + C00363 ATP(aq) + dTMP(aq) = ADP(aq) + dTDP(aq) 1.4 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 8.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 304.55 7.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 310.15 7.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 8.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58WOL/SIM_1265 58WOL/SIM enzymatic assay B 5.1.3.4 L-ribulose-phosphate 4-epimerase C01101 = C00231 L-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.86 297.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JUN/JUN_1555 89JUN/JUN radioactivity A 4.2.1.89 carnitine dehydratase C00318 = C04114 + C00001 L-carnitine(aq) = 4-(trimethylammonio)but-2-enoate(aq) + H2O(l) 1.5 310.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK_135 68KOH/JAK spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000209 298.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK_135 68KOH/JAK spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00487 298.15 9.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK_135 68KOH/JAK spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00204 298.15 9.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MEI/BUK_1196 63MEI/BUK chromatography and radioactivity B 4.2.1.48 D-glutamate cyclase C00217 = C02237 + C00001 D-glutamate(aq) = 5-oxo-D-proline(aq) + H2O(l) 16 310.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63ALL/KEL_1278 63ALL/KEL spectrophotometry B 5.1.99.1 methylmalonyl-CoA epimerase C01213 = C00683 (R)-methylmalonyl-CoA(aq) = (S)-methylmalonyl-CoA(aq) 1 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KAU/ALI_1438 55KAU/ALI spectrophotometry B 6.2.1.5 succinate-CoA ligase (ADP forming) C00002 + C00042 + C00010 = C00008 + C00009 + C00091 ATP(aq) + succinate(aq) + CoA(aq) = ADP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.27 293.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WOL_800 72WOL calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WOL_800 72WOL calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 7.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WOL_800 72WOL calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 8.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WOL_800 72WOL calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 8.73 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WOL_800 72WOL calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94LEU/COO_409 94LEU/COO spectrophotometry A 2.3.1.30 serine acetyltransferase C00024 + C00065 = C00010 + C00979 acetyl-CoA(aq) + L-serine(aq) = CoA(aq) + O-acetyl-L-serine(aq) 15 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81GRI/CLE_272 81GRI/CLE spectrophotometry C 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 4.3e-06 298.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SEM/CLE_1364 91SEM/CLE NMR and spectrophotometry B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.214 278.85 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SEM/CLE_1364 91SEM/CLE NMR and spectrophotometry B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.264 295.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MCQ/UTT_565 59MCQ/UTT enzymatic assay and spectrophotometry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000155 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MCQ/UTT_565 59MCQ/UTT enzymatic assay and spectrophotometry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000451 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MCQ/UTT_565 59MCQ/UTT enzymatic assay and spectrophotometry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.0011 303.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MCQ/UTT_565 59MCQ/UTT enzymatic assay and spectrophotometry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00272 303.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76RAO/BUT_618 76RAO/BUT NMR B 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.1 285.15 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55MUN_683 55MUN spectrophotometry C 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 1.5 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BOM/PRA_643 68BOM/PRA chromatography and radioactivity D 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.5 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SCO/JAK_526 59SCO/JAK spectrophotometry C 2.6.1.19 4-aminobutyrate transaminase C00334 + C00026 = C00232 + C00025 4-aminobutanoate(aq) + 2-oxoglutarate(aq) = 4-oxobutanoate(aq) + L-glutamate(aq) 0.14 311.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KRI_1285 75KRI spectrophotometry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 19 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59BEN/KIT_990 59BEN/KIT calorimetry B 3.5.1.2 glutaminase C00064 + C00001 = C00025 + C00014 L-glutamine(aq) + H2O(l) = L-glutamate(aq) + ammonia(aq) 896 298.15 5.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63BEC/LEV_472 63BEC/LEV enzymatic assay B 2.4.2.6 nucleoside deoxyribosyltransferase C00214 + C00147 = C00559 + C00178 thymidine(aq) + adenine(aq) = 2'-deoxyadenosine(aq) + thymine(aq) 15.1 310.15 5.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_224 87BUC/MIL spectrophotometry A 1.1.1.- (R)-2-hydroxyglutarate dehydrogenase C01087 + C00003 = C00026 + C00004 (R)-2-hydroxyglutarate(aq) + NAD(aq) = 2-oxoglutarate(aq) + NADH(aq) 1.83e-05 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_224 87BUC/MIL spectrophotometry A 1.1.1.- (R)-2-hydroxyglutarate dehydrogenase C01087 + C00003 = C00026 + C00004 (R)-2-hydroxyglutarate(aq) + NAD(aq) = 2-oxoglutarate(aq) + NADH(aq) 1.47e-05 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ATK/BUR_640 61ATK/BUR electrophoresis and enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.48 298.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ATK/BUR_640 61ATK/BUR electrophoresis and enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.28 298.15 7 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00ROD/BAR_1603 00ROD/BAR spectophotometry and chromatography C 3.1.4 ADPglucose phosphodiesterase C00498 + C00001 = C00103 + C00020 ADPglucose(aq) + H2O(l) =-D-glucose 1-phosphate(aq) + AMP(aq) 110 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_268 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C80057 = C00295 + C80058 (S)-dihydroorotate(aq) + AP-NAD(aq) = orotate(aq) + AP-NADH(aq) 0.035 293.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_268 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C80057 = C00295 + C80058 (S)-dihydroorotate(aq) + AP-NAD(aq) = orotate(aq) + AP-NADH(aq) 0.093 293.15 6.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_268 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C80057 = C00295 + C80058 (S)-dihydroorotate(aq) + AP-NAD(aq) = orotate(aq) + AP-NADH(aq) 0.189 293.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_266 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C00003 = C00295 + C00004 (S)-dihydroorotate(aq) + NAD(aq) = orotate(aq) + NADH(aq) 0.00106 293.15 6.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_266 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C00003 = C00295 + C00004 (S)-dihydroorotate(aq) + NAD(aq) = orotate(aq) + NADH(aq) 0.00224 293.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_266 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C00003 = C00295 + C00004 (S)-dihydroorotate(aq) + NAD(aq) = orotate(aq) + NADH(aq) 0.00619 293.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_266 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C00003 = C00295 + C00004 (S)-dihydroorotate(aq) + NAD(aq) = orotate(aq) + NADH(aq) 0.00042 293.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59FRI_283 59FRI spectrophotometry D 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 4.5e-06 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_1135 87BUC/MIL enzymatic assay and spectrophotometry A 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 0.212 298.15 0.648 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_1135 87BUC/MIL enzymatic assay and spectrophotometry A 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 0.188 298.15 0.399 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_1135 87BUC/MIL enzymatic assay and spectrophotometry A 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 0.207 298.15 0.306 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_1135 87BUC/MIL enzymatic assay and spectrophotometry A 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 0.211 298.15 0.212 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_1135 87BUC/MIL enzymatic assay and spectrophotometry A 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 0.151 298.15 0.845 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95KAM/JUR_657 95KAM/JUR enzymatic analysis C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.36 285.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80BEY/ROE_886 80BEY/ROE HPLC C 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 34 328 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BEN_1150 69BEN calorimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_995 95HUT/BOH calorimetry B 3.5.1.5 urease C01563 + C00001 = 2 C00014 + C00288 ammonium carbamate(aq) + H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_995 95HUT/BOH calorimetry B 3.5.1.5 urease C01563 + C00001 = 2 C00014 + C00288 ammonium carbamate(aq) + H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_995 95HUT/BOH calorimetry B 3.5.1.5 urease C01563 + C00001 = 2 C00014 + C00288 ammonium carbamate(aq) + H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_995 95HUT/BOH calorimetry B 3.5.1.5 urease C01563 + C00001 = 2 C00014 + C00288 ammonium carbamate(aq) + H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62DOU/SHU_1105 62DOU/SHU C 4.1.2.14 2-dehydro-3-deoxyphosphogluconate aldolase C04442 = C00022 + C00118 6-phospho-2-dehydro-3-deoxy-D-gluconate(aq) = pyruvate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.0016 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69PET/MCK_337 69PET/MCK calorimetry B 1.14.15.1 camphor 5-monooxygenase C00808 + C00004 + C00007 = C03448 + C00003 + C00001 (+)-camphor(aq) + NADH(aq) + O2(aq) = (+)-5-exo-hydroxycamphor(aq) + NAD(aq) + H2O(l) 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1378 85TEW/GOL2 calorimetry A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 331.65 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1378 85TEW/GOL2 calorimetry A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 325.35 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1378 85TEW/GOL2 calorimetry A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 320.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1378 85TEW/GOL2 calorimetry A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 338.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68LON/DAL_153 68LON/DAL spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.93 298.15 0.017 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68LON/DAL_153 68LON/DAL spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.9 298.15 0.054 6.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68LON/DAL_153 68LON/DAL spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.62 298.15 0.404 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68LON/DAL_153 68LON/DAL spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.86 298.15 0.104 7.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68LON/DAL_153 68LON/DAL spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.72 298.15 0.254 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.446 320.25 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.484 325.25 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.521 331.95 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.591 343.75 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.391 313.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.563 338.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.489 328.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90OCO/BUT_752 90OCO/BUT spectrophotometry C 3.1.1.21 retinyl-palmitate esterase C02588 + C00001 = C00473 + C00249 retinyl palmitate(aq) + H2O(l) = retinol(aq) + palmitate(aq) 0.0028 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BEL/MAR_1409 74BEL/MAR spectrophotometry B 5.4.2.6 _-phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 28.6 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0305 310.15 7.04 6.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0322 310.15 7.04 6.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0288 310.15 7.01 6.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0322 310.15 6.99 5.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0305 310.15 7.01 5.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0311 310.15 7.02 5.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00787 310.15 7.07 3.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00781 310.15 7.1 3.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00769 310.15 7.08 3.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00847 310.15 7.11 3.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00781 310.15 7.12 3.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00649 310.15 7.16 2.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00617 310.15 7.16 2.48 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00758 310.15 7.34 1.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0182 310.15 7 4.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00676 310.15 7.33 1.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0347 310.15 7.14 4.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00714 310.15 7.37 1.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0362 310.15 7.07 2.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0346 310.15 7.12 5.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00813 310.15 7.12 3.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00813 310.15 7.12 3.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0061 310.15 7.38 1.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.018 310.15 7.01 4.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00602 310.15 7.09 2.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0061 310.15 7.12 2.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00578 310.15 7.11 2.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0297 310.15 6.99 5.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0351 310.15 7.11 5.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00649 310.15 7.19 2.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0254 310.15 7 5.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00649 310.15 7.33 1.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0358 310.15 7.11 5.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00667 310.15 7.14 2.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.026 310.15 7 5.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0338 310.15 7.15 4.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00769 310.15 7.1 3.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0172 310.15 7.01 4.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00606 310.15 7.11 2.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0339 310.15 7.14 4.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0217 310.15 7.01 5.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00752 310.15 7.39 1.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00752 310.15 7.39 1.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00641 310.15 7.32 1.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00806 310.15 7.09 3.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0069 310.15 7.35 1.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 8333 298.15 6.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 1175 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 255 298.15 8.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 302 298.15 9.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 908 298.15 10.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 267 298.15 9.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 242 298.15 9.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 2231 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 1321 298.15 9.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 352 298.15 9.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 212 298.15 8.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 191 298.15 9.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 345 298.15 9.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 587 298.15 8.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 318 298.15 9.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62WIL/SNE_360 62WIL/SNE chromatography and spectrophotometry B 2.1.2.7 D-alanine 2-hydroxymethyltransferase C02115 = C00133 + C00067 2-methylserine(aq) = D-alanine(aq) + formaldehyde(aq) 0.00027 311.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_666 78LYN/GUY fluorimetry and spectrophotometry A 2.7.4.6 nucleoside-diphosphate kinase C00002 + C00035 = C00008 + C00044 ATP(aq) + GDP(aq) = ADP(aq) + GTP(aq) 1.04 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84WAS/DAU_1699 84WAS/DAU spectrophotometry C 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1.01 310.15 9.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63KUR/FUK_1131 63KUR/FUK spectrophotometry C 4.1.3.16 4-hydroxy-2-oxoglutarate aldolase C01127 = C00022 + C00048 4-hydroxy-2-oxoglutarate(aq) = pyruvate(aq) + glyoxylate(aq) 0.0037 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50HES_744 50HES spectrophotometry B 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 510 296.15 5.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50HES_744 50HES spectrophotometry B 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 2175 296.15 5.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36LEH_589 36LEH chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.13 293.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36LEH_589 36LEH chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.48 293.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40HER/GOR_1090 40HER/GOR C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.000119 311.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40HER/GOR_1090 40HER/GOR C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 6.0e-05 301.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40HER/GOR_1090 40HER/GOR C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.000234 321.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40HER/GOR_1090 40HER/GOR C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.000122 311.15 7.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TRI/VOG_1227 67TRI/VOG polarimetry B 4.3.2.3 ureidoglycolate lyase C00603 = C00048 + C00086 (-)-ureidoglycolate(aq) = glyoxylate(aq) + urea(aq) 0.14 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_932 89GOL/TEW calorimetry A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 304.65 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_932 89GOL/TEW calorimetry A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 310.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_932 89GOL/TEW calorimetry A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 316.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_932 89GOL/TEW calorimetry A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_931 89GOL/TEW HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 34 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_931 89GOL/TEW HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 34.8 310.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_931 89GOL/TEW HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 32.2 292.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_931 89GOL/TEW HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 32.4 304.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_931 89GOL/TEW HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 35.2 286.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LEV/MEI_1439 54LEV/MEI chemical analysis and enzymatic assay A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 1800 295.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LEV/MEI_1439 54LEV/MEI chemical analysis and enzymatic assay A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 400 310.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LEV/MEI_1439 54LEV/MEI chemical analysis and enzymatic assay A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 1233 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LEV/MEI_1439 54LEV/MEI chemical analysis and enzymatic assay A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 3000 310.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89REK/SIK_1026 89REK/SIK calorimetry B 3.5.1.14 aminoacylase C02712 + C00001 = C00033 + C00073 N-acetyl-L-methionine(aq) + H2O(l) = acetate(aq) + L-methionine(aq) 298.15 6.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55LYN/WIE_124 55LYN/WIE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.012 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 303 308.15 6 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 520 308.15 6 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 949 308.15 6 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 79 308.15 7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 687 308.15 7 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 126 293.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 235 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 320 293.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 466 303.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 572 308.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 865 313.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 125 308.15 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2660 308.15 6 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 156 299.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2060 308.15 7 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 231 308.15 7 1.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 187 303.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 294 313.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 12400 308.15 7 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 372 299.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55GLA/BRO_162 55GLA/BRO spectrophotometry B 1.1.1.49 glucose-6-phosphate dehydrogenase C00092 + C00006 = C01236 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) = D-glucono-1,5-lactone 6-phosphate(aq) + NADPH(aq) 1.5 301.15 6.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70KOH/WAR_91 70KOH/WAR spectrophotometry C 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 9.3e-07 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70KOH/WAR_91 70KOH/WAR spectrophotometry C 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 1.8e-06 298.15 8.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70KOH/WAR_91 70KOH/WAR spectrophotometry C 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 7.3e-07 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/STA_240 53BUR/STA spectrophotometry B 1.2.1.10 acetaldehyde dehydrogenase (acetylating) C00084 + C00010 + C00003 = C00024 + C00004 acetaldehyde(aq) + CoA(aq) + NAD(aq) = acetyl-CoA(aq) + NADH(aq) 2000 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/STA_240 53BUR/STA spectrophotometry B 1.2.1.10 acetaldehyde dehydrogenase (acetylating) C00084 + C00010 + C00003 = C00024 + C00004 acetaldehyde(aq) + CoA(aq) + NAD(aq) = acetyl-CoA(aq) + NADH(aq) 7200 298.15 7.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/STA_240 53BUR/STA spectrophotometry B 1.2.1.10 acetaldehyde dehydrogenase (acetylating) C00084 + C00010 + C00003 = C00024 + C00004 acetaldehyde(aq) + CoA(aq) + NAD(aq) = acetyl-CoA(aq) + NADH(aq) 8200 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59BON/PON_370 59BON/PON enzymatic assay C 2.2.1.2 transaldolase C00095 + C00118 = C00085 + C00577 D-fructose(aq) + D-glyceraldehyde-3-phosphate(aq) = D-fructose 6-phosphate(aq) + D-glyceraldehyde(aq) 0.27 303.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW2_541 98KIS/TEW2 HPLC A 2.6.2.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.133 283.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW2_541 98KIS/TEW2 HPLC A 2.6.2.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.133 292.65 7.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW2_541 98KIS/TEW2 HPLC A 2.6.2.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.143 298.15 7.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW2_541 98KIS/TEW2 HPLC A 2.6.2.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.145 303.15 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW2_541 98KIS/TEW2 HPLC A 2.6.2.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.144 288.15 7.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58WIL/BAN_681 58WIL/BAN chemical analysis and radioactivity C 2.7.7.4&3.6.1.1 sulfate adenylyltransferase and inorganic pyrophosphatase C00002 + C00059 + C00001 = 2 C00009 + C00224 ATP(aq) + sulfate(aq) + H2O(l) = 2 orthophosphate(aq) + adenosine 5'-phosphosulfate(aq) 6.0e-07 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78INF/KIN_701 78INF/KIN paper chromatography B 2.7.7.15 choline-phosphate cytidylyltransferase C00063 + C00588 = C00013 + C00307 CTP(aq) + phosphorylcholine(aq) = pyrophosphate(aq) + CDPcholine(aq) 0.2 310.15 0.15 7.5 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BRI_159 53BRI spectrophotometry C 1.1.1.47 glucose dehydrogenase C00031 + C00003 = C00198 + C00004 -D-glucose(aq) + NAD(aq) = D-glucono-1,5-lactone(aq) + NADH(aq) 3.1 294.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84WAS/DAU_1236 84WAS/DAU enzymatic assay and spectrophotometry B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1 310.15 9.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JEN/NYG_460 75JEN/NYG chromatography and radioactivity C 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.0175 310.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.04e-05 298.15 0.25 7.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.2e-05 298.15 0.25 7.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.08e-05 298.15 0.25 7.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.23e-05 298.15 0.25 7.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.27e-05 298.15 0.25 7.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.96e-05 311.15 0.25 7.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.79e-05 311.15 0.25 7.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.78e-05 311.15 0.25 7.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.76e-05 311.15 0.25 7.09 2.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.94e-05 311.15 0.25 7.11 2.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.45e-05 311.15 0.25 7.05 2.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.59e-05 311.15 0.25 7.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.39e-05 311.15 0.25 7.06 2.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 8.98e-06 311.15 0.25 7.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.13e-05 298.15 0.25 7.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.29e-05 311.15 0.25 7.09 2.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.19e-05 311.15 0.25 7.07 2.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.41e-05 311.15 0.25 7.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_154 68VEE spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.91 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52EGG/HEM_658 52EGG/HEM paper chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51BLA_65 51BLA spectrophotometry and chemical analysis B 1.1.1.14 L-iditol dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.24 293.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=01TIS/IHL_1683 01TIS/IHL C 4.1.2.4 deoxyribose-phosphate aldolase C00673 = C00118 + C00084 2-deoxy-D-ribose 5-phosphate(aq) = D-glyceraldehyde 3-phosphate(aq) + acetaldehyde(aq) 0.00024 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=01TIS/IHL_1682 01TIS/IHL C 4.1.2.13 fructose-bisphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.0001 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_52 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.000418 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_52 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.00418 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_50 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.00419 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_50 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.0419 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_57 59HOL spectrophotometry B 1.1.1.10 L-xylulose reductase C00379 + C00006 = C00312 + C00005 xylitol(aq) + NADP(aq) = L-xylulose(aq) + NADPH(aq) 0.00516 298.15 8.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_57 59HOL spectrophotometry B 1.1.1.10 L-xylulose reductase C00379 + C00006 = C00312 + C00005 xylitol(aq) + NADP(aq) = L-xylulose(aq) + NADPH(aq) 0.00297 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_57 59HOL spectrophotometry B 1.1.1.10 L-xylulose reductase C00379 + C00006 = C00312 + C00005 xylitol(aq) + NADP(aq) = L-xylulose(aq) + NADPH(aq) 0.000297 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92REK/TIS_794 92REK/TIS calorimetry A 3.1.3.1 alkaline phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60COM/ROS_1117 60COM/ROS spectrophotometry C 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.064 310.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74SCH/STU_310 74SCH/STU calorimetry C 1.6.1.1 NAD(P)+ transhydrogenase C00003 + C00005 = C00004 + C00006 NAD(aq) + NADPH(aq) = NADH(aq) + NADP(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62BRU/JOU_1122 62BRU/JOU radioactivity and spectrophotometry A 4.1.3.3 N-acetylneuraminate lyase C03410 = C03521 + C00022 N-glycolylneuraminate(aq) = N-glycolyl-D-mannosamine(aq) + pyruvate(aq) 0.09 310.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45GRE/LEL_507 45GRE/LEL spectrophotometry C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 1 311.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69POP_628 69POP spectrophotometry C 2.7.4.2 phosphomevalonate kinase C00002 + C01107 = C00008 + C01143 ATP(aq) + (R)-5-phosphomevalonate(aq) = ADP(aq) + (R)-5-diphosphomevalonate(aq) 1 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_251 47MEY/OES spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.55 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_251 47MEY/OES spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 1.4 298.15 7.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_251 47MEY/OES spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 17 298.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_251 47MEY/OES spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.69 298.15 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_251 47MEY/OES spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.71 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85FAG/DEW_1080 85FAG/DEW spectrophotometry C 3.6.1.38 Ca2+-transporting ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 40000 295.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63DOB/DEM_1337 63DOB/DEM spectrophotometry C 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.3 310.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52NAR/WOO_1237 52NAR/WOO enzymatic assay B 5.1.1.3 glutamate racemase C00025 = C00217 L-glutamate(aq) = D-glutamate(aq) 1 310.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34LOH/MEY_1169 34LOH/MEY chemical analysis C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 0.39 293.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34LOH/MEY_1169 34LOH/MEY chemical analysis C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 0.7 333.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34LOH/MEY_1169 34LOH/MEY chemical analysis C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 0.33 273.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34LOH/MEY_1169 34LOH/MEY chemical analysis C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 0.54 313.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65SEK/SUN_1210 65SEK/SUN C 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.02 310.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95BIS/KRA_1027 95BIS/KRA C 3.5.1.14 aminoacylase C02712 + C00001 = C00073 + C00033 N-acetyl-L-methionine(aq) + H2O(l) = L-methionine(aq) + acetate(aq) 2.7 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STE/COO_405 53STE/COO spectrophotometric C 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 2.0e-05 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK_142 68KOH/JAK spectrophotometry C 1.1.1.37 malate dehydrogenase C00552 + C00003 = C00975 + C00004 meso-tartrate(aq) + NAD(aq) = (E)-dihydroxyfumarate(aq) + NADH(aq) 0.00034 298.15 8.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK_142 68KOH/JAK spectrophotometry C 1.1.1.37 malate dehydrogenase C00552 + C00003 = C00975 + C00004 meso-tartrate(aq) + NAD(aq) = (E)-dihydroxyfumarate(aq) + NADH(aq) 5.3e-05 298.15 7.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54BER/JOK_665 54BER/JOK radioactive labelling and spectrophotometry C 2.7.4.6 nucleoside-diphosphate kinase C00002 + C00104 = C00008 + C00081 ATP(aq) + inosine 5'-diphosphate(aq) = ADP(aq) + inosine 5'-triphosphate(aq) 1 310.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71GLO/POT_387 71GLO/POT spectrophotometry B 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 41 310.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82SAL/GIA_477 82SAL/GIA spectrophotometry C 2.4.2.8 hypoxanthine phosphoribosyltransferase C00144 + C00262 = C00130 + C00242 GMP(aq) + hypoxanthine(aq) = IMP(aq) + guanine(aq) 0.38 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62RAV/WOL2_131 62RAV/WOL2 spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000104 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62SIL_356 62SIL C 2.1.2.5 glutamate formiminotransferase C00664 + C00025 = C00439 + C00101 5-formiminotetrahydrofolate(aq) + L-glutamate(aq) = N-formimino-L-glutamate(aq) + tetrahydrofolate(aq) 0.09 310.15 6.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/DAV_1625 00TEW/DAV chromatography A 5.4.99.6 isochorismate synthase C00251 = C00885 chorismate(aq) = isochorismate(aq) 0.84 298.15 0.31 7.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/DAV_1626 00TEW/DAV calorimetry and chromatography A 5.4.99.6 isochorismate synthase C00251 = C00885 chorismate(aq) = isochorismate(aq) 298.15 0.23 6.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0028 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.004 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0048 303.15 8.1 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0055 303.15 9.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0049 303.15 7.5 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0039 303.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.003 303.15 9.2 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0046 303.15 7 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83YAM/SAI_261 83YAM/SAI spectrophotometry C 1.2.1.43 formate dehydrogenase (NADP+) C00058 + C00006 + C00001 = C00288 + C00005 formate(aq) + NADP(aq) + H2O(l) = carbon dioxide(aq) + NADPH(aq) 650 328.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SUG/PIZ_203 68SUG/PIZ spectrophotometry and fluorimetry B 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 0.0019 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SUG/PIZ_203 68SUG/PIZ spectrophotometry and fluorimetry B 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 0.0022 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54BOW/KER_636 54BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.38 274.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54BOW/KER_636 54BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.39 293.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54BOW/KER_636 54BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.31 293.15 6 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54BOW/KER_636 54BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.48 313.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58HEA/HOR_1297 58HEA/HOR polarimetry C 5.3.1.4 L-arabinose isomerase C00259 = C00508 L-arabinose(aq) = L-ribulose(aq) 0.16 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58HEA/HOR_1297 58HEA/HOR polarimetry C 5.3.1.4 L-arabinose isomerase C00259 = C00508 L-arabinose(aq) = L-ribulose(aq) 0.19 326.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58HEA/HOR_1297 58HEA/HOR polarimetry C 5.3.1.4 L-arabinose isomerase C00259 = C00508 L-arabinose(aq) = L-ribulose(aq) 0.11 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92DEM/ATT_1319 92DEM/ATT C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.08 333.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99SAK/UTS_1605 99SAK/UTS enzymatic assay C 2.7.9.2 pyruvate, water dikinase C00002 + C00022 + C00001 = C00020 + C00074 + C00009 ATP(aq) + pyruvate(aq) + H2O(l) = AMP(aq) + phosphoenolpyruvate(aq) + orthophosphate(aq) 52 323.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BLA/WRI_587 55BLA/WRI chromatography C 2.7.2.4 aspartate kinase C00002 + C00049 = C00008 + C03082 ATP(aq) + L-aspartate(aq) = ADP(aq) + 4-phospho-L-aspartate(aq) 0.00035 288.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_1405 89GOL/TEW HPLC A 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 17.1 298.15 8.48 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KLE_685 61KLE D 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 1 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88MAC/FEW_201 88MAC/FEW spectrophotometry C 1.1.1.90 aryl-alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.097 300.15 9.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.04 303.15 7.6 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.14 303.15 7.6 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.265 303.15 7.6 1.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.272 303.15 7.6 1.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.23 303.15 7.9 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.704 303.15 7.5 2.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.09 303.15 7 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.752 303.15 7 2.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.23 303.15 6.06 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.662 303.15 5 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.862 303.15 5 2.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.787 303.15 4.9 2.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.09 303.15 7.6 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.28 303.15 7.5 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.826 303.15 5.57 2.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.534 303.15 7.6 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.909 303.15 6.06 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.14 303.15 7.5 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.87 303.15 6.04 2.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.694 303.15 6.5 2.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.699 303.15 7 2.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.699 303.15 7 2.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.84 303.15 5.49 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.01 303.15 7.6 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.709 303.15 5.6 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.279 303.15 7.6 1.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.11 303.15 6.56 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.23 303.15 8.2 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.25 303.15 7.9 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.15 303.15 7.5 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.03 303.15 7.6 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOH_102 57HOH spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0173 298.15 9.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1310 310.15 7 3.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1130 310.15 7 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 975 310.15 7 3.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 670 310.15 7 3.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 412 310.15 7 4.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 306 310.15 7 5.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 622 310.15 7 3.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1540 310.15 7 2.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1930 310.15 7 2.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 288 310.15 7 4.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 490 310.15 7 4.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 288 310.15 7 5.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 817 310.15 7 3.48 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 353 310.15 7 4.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 586 310.15 7 3.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_904 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 -isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 65 318.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE_374 86CAS/VEE enzymatic assay and spectrophotometry A 2.2.1.2 transaldolase C05382 + C00118 = C00279 + C00085 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phosphate(aq) + D-fructose 6-phosphate(aq) 0.37 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65STR_520 65STR spectrophotometry C 2.6.1.13 ornithine-oxo-acid transaminase C00077 + C00026 = C03912 + C00025 L-ornithine(aq) + 2-oxoglutarate(aq) = DL-D-1-pyrroline-5-carboxylate(aq) + L-glutamate(aq) 71 310.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/SCH_802 35MEY/SCH calorimetry C 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 293.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62HIM/RAB_1442 62HIM/RAB spectrophotometry B 6.3.4.3 formate-tetrahydrofolate ligase C00002 + C00058 + C00101 = C00008 + C00009 + C00234 ATP(aq) + formate(aq) + tetrahydrofolate(aq) = ADP(aq) + phosphate(aq) + 10-formyltetrahydrofolate(aq) 41 310.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79PIR/LIL_1137 79PIR/LIL gas chromatography and spectrophotometry B 4.1.3.32 2,3-dimethylmalate lyase C03652 = C00163 + C00022 2,3-dimethylmalate(aq) = propanoate(aq) + pyruvate(aq) 0.5 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56TAL/MAR_179 56TAL/MAR spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 0.026 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56TAL/MAR_179 56TAL/MAR spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 2.6 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56TAL/MAR_179 56TAL/MAR spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 26 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56TAL/MAR_179 56TAL/MAR spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 0.26 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_911 91TEW/GOL calorimetry A 3.2.1.10 oligo-1,6-glucosidase C01742 + C00001 = C00031 + C00095 palatinose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 4.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_913 91TEW/GOL calorimetry A 3.2.1.20 -glucosidase C19636 + C00001 = C00031 + C00095 D-turanose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 5.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93WER/TWE_1202 93WER/TWE HPLC B 4.2.1.85 dimethylmaleate hydratase C03652 = C00922 + C00001 (2R,3S)-2,3-dimethylmalate(aq) = dimethylmaleate(aq) + H2O(l) 0.089 298.15 0.1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GRA/ELL_620 86GRA/ELL NMR B 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.0186 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53LYN/OCH_404 53LYN/OCH spectrophotometry C 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 2.0e-05 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53LYN/OCH_404 53LYN/OCH spectrophotometry C 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 0.0001 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ADA/NOR_1240 64ADA/NOR ion exchange chromatography B 5.1.1.8 4-hydroxyproline epimerase C01157 = C03440 trans-4-hydroxy-L-proline(aq) = cis-4-hydroxy-D-proline(aq) 0.99 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DOU_420 61DOU D 2.4.1.8 maltose phosphorylase C00208 + C00009 = C00031 + C00103 maltose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.23 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00WU/FEN_1711 00WU/FEN NMR A 4.2.1.17 enoyl-CoA hydratase C01144 = C00877 + C00001 (3S)-hydroxybutanoyl-coenzyme A(aq) = trans-but-2-enoyl-coenzyme A + H2O(l) 0.13 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 2.46 323.3 7.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.48 292.8 7.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.31 308.1 7.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.13 313.4 7.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 2.79 318.3 7.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.07 298.5 7.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.86 288.3 7.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.64 303 7.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73LAN_1305 73LAN C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.21 343.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73LAN_1305 73LAN C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.08 333.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73LAN_1305 73LAN C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1 323.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73LAN_1305 73LAN C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.14 338.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELL_625 89ELL NMR and enzymatic assay C 2.7.3.4 taurocyamine kinase C00002 + C01959 = C00008 + C03149 ATP(aq) + taurocyamine(aq) = ADP(aq) + N-w-phosphotaurocyamine(aq) 29 308.15 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELL_627 89ELL NMR and enzymatic assay C 2.7.3.5 lombricine kinase C00002 + C14177 = C00008 + C14178 ATP(aq) + lombricine(aq) = ADP(aq) + N-w-phospholombricine(aq) 32 308.15 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELL_621 89ELL NMR and enzymatic assay C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 13 308.15 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KAT/UED_1557 99KAT/UED radioactivity B 3.5.1.a anandamide amidohydrolase C11695 + C00001 = C00189 + C00219 anandamide(aq) + H2O(l) = ethanolamine(aq) + arachidonic acid(aq) 0.004 310.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KAT/UED_1557 99KAT/UED radioactivity B 3.5.1.a anandamide amidohydrolase C11695 + C00001 = C00189 + C00219 anandamide(aq) + H2O(l) = ethanolamine(aq) + arachidonic acid(aq) 0.008 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KAT/UED_1557 99KAT/UED radioactivity B 3.5.1.a anandamide amidohydrolase C11695 + C00001 = C00189 + C00219 anandamide(aq) + H2O(l) = ethanolamine(aq) + arachidonic acid(aq) 0.03 310.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_148 68VEE spectrophotometry A 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.0344 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_148 68VEE spectrophotometry A 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.0558 311.15 0.03 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59TAL/LEV_181 59TAL/LEV spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 3.78 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59TAL/LEV_181 59TAL/LEV spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 378 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59TAL/LEV_181 59TAL/LEV spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 0.378 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KAT/UED_1558 99KAT/UED radioactivity B 3.5.1.a anandamide amidohydrolase C16512 + C00001 = C00189 + C00249 palmitoylethanolamide(aq) + H2O(l) = ethanolamine(aq) + palmitic acid(aq) 0.0004 310.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59ALE_443 59ALE enzymatic assay B 2.4.1.20 cellobiose phosphorylase C00185 + C00009 = C00031 + C00103 cellobiose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.23 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 5.55e-06 295.15 6.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000208 295.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 6.94e-05 295.15 7.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.33e-05 295.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00676 295.15 9.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.34e-06 295.15 6.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.58 298.15 0.25 7.15 2.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.66 298.15 0.25 7.14 2.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.25 298.15 0.25 6.83 2.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.54 298.15 0.25 6.85 2.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.7 298.15 0.25 6.82 2.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.63 311.15 0.25 7.17 2.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.74 311.15 0.25 7.09 2.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.82 311.15 0.25 7.03 2.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.54 311.15 0.25 7.27 2.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.5 311.15 0.25 7.3 2.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.56 311.15 0.25 7.27 2.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.04 311.15 0.25 6.75 2.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.53 311.15 0.25 7.11 2.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.82 311.15 0.25 6.93 2.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.61 311.15 0.25 7.1 2.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.77 311.15 0.25 7.1 2.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.72 311.15 0.25 7.08 2.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.72 311.15 0.25 6.75 2.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.79 311.15 0.25 7.05 2.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.73 311.15 0.25 7.01 1.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.68 298.15 0.25 7.15 2.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.68 298.15 0.25 7.15 2.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.52 311.15 0.25 7.17 2.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.03 311.15 0.25 6.75 2.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1 311.15 0.25 7.12 3.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.53 311.15 0.25 6.82 2.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.63 311.15 0.25 6.96 1.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.72 298.15 0.25 7.19 2.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.82 298.15 0.25 7.15 2.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.72 311.15 0.25 7.08 2.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.54 311.15 0.25 7.12 2.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.79 311.15 0.25 7.12 2.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.65 311.15 0.25 7.11 2.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.79 311.15 0.25 6.8 2.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.87 311.15 0.25 6.83 2.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.6 311.15 0.25 6.94 1.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.75 311.15 0.25 7.04 2.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.68 311.15 0.25 7.02 1.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48KOR_676 48KOR spectrophotometry B 2.7.7.1 nicotinamide-nucleotide adenylyltransferase C00002 + C00455 = C00003 + C00013 ATP + beta-Nicotinamide mononucleotide = NAD + pyrophosphate 0.4 311.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83HON/HAR_695 83HON/HAR spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.48 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03MER/WOO_1587 03MER/WOO NMR B 5.3.1.13 arabinose-5-phosphate isomerase C01112 = C00199 D-arabinose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.5 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MUR/SUG_426 66MUR/SUG chromatography and radioactivity B 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 3.3 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MUR/SUG_422 66MUR/SUG chromatography and radioactivity B 2.4.1.13 sucrose synthase C00498 + C00095 = C00008 + C00089 ADPglucose(aq) + D-fructose(aq) = ADP(aq) + sucrose(aq) 1.6 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=42COL/SUT_1401 42COL/SUT C 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 19.8 293.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=42COL/SUT_1401 42COL/SUT C 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 16.2 313.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=42COL/SUT_1401 42COL/SUT C 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 17.2 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE_1147 53KRE polarimetry and manometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.43 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_586 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 2170 311.15 7 2.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000529 311.15 0.25 7 0.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000548 311.15 0.25 7 0.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000392 311.15 0.25 7 0.36 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000349 311.15 0.25 7 0.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000318 311.15 0.25 7 0.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000318 311.15 0.25 7 -0.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000242 311.15 0.25 7 -0.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000278 311.15 0.25 7 -0.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.0004 311.15 0.25 7 0.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000272 311.15 0.25 7 -0.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000241 311.15 0.25 7 -0.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.00102 311.15 0.25 7 1.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000274 311.15 0.25 7 -0.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000251 311.15 0.25 7 -0.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000278 311.15 0.25 7 -0.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000549 311.15 0.25 7 0.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000225 311.15 0.25 7 -0.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.00143 311.15 0.25 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89BER/MUD_947 89BER/MUD calorimetry B 3.2.2.5 NAD+ nucleosidase C00003 + C00001 = C00153 + C01882 NAD(aq) + H2O(l) = nicotinamide(aq) + ADPribose(aq) 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.333 298.15 7.5 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.567 298.15 7.5 3.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.226 298.15 7.5 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.9 298.15 7.5 2.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.833 298.15 7.5 3.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.167 298.15 7.5 2.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.6 298.15 7.5 2.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1 298.15 7.5 2.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.543 298.15 7.5 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.433 298.15 7.5 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.342 298.15 7.5 2.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.637 298.15 7.5 3.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.367 298.15 7.5 2.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.847 298.15 7.5 3.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.153 298.15 7.5 3.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84ADA/UED_895 84ADA/UED HPLC and enzymatic assay C 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 200 313 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84BER/COO_1513 84BER/COO spectrophotometry and NMR B 2.7.1.90 pyrophosphate-fructose-6-phosphate 1-phosphotransferase C00013 + C00085 = C00009 + C00354 pyrophosphate(aq) + D-fructose 6-phosphate(aq) = orthophosphate(aq) + D-fructose 1,6-bisphosphate(aq) 0.006 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_49 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.000175 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_49 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.00175 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=05TEW/GOL_1630 05TEW/GOL calorimetry A 3.5.5.1 nitrilase C16074 + 2 C00001 = C07086 + C00014 benzyl cyanide(aq) + 2 H2O(aq) = phenylacetic acid(aq) + ammonia(aq) 298.15 0.29 7.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86MEI/GAD_111 86MEI/GAD spectrophotometry C 1.1.1.28 D-lactate dehydrogenase C00256 + C00003 = C00022 + C00004 (R)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 1.4e-05 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1329 85TEW/STE calorimetry A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 313.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1329 85TEW/STE calorimetry A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 320.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1329 85TEW/STE calorimetry A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 338.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1329 85TEW/STE calorimetry A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 331.65 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1329 85TEW/STE calorimetry A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 325.35 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.172 298.35 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.237 313.25 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.224 314.05 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.424 342.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.315 328.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.272 320.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.374 335.05 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.204 306.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62PET_524 62PET spectrophotometry C 2.6.1.17 succinyldiaminopimelate transaminase C04462 + C00025 = C04421 + C00026 N-succinyl-2-L-amino-6-oxoheptanedioate(aq) + L-glutamate(aq) = N-succinyl-L-2,6-diaminoheptanedioate(aq) + 2-oxoglutarate(aq) 1.2 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LEE/OSU_629 85LEE/OSU NMR and radioassay B 2.7.4.2 phosphomevalonate kinase C00002 + C01107 = C00008 + C01143 ATP(aq) + (R)-5-phosphomevalonate(aq) = ADP(aq) + (R)-5-diphosphomevalonate(aq) 1.7 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA/FRA_1381 69BLA/FRA spectrophotometry C 5.3.2.1 phenylpyruvate tautomerase C00166 = C02763 keto-phenylpyruvate(aq) = enol-phenylpyruvate(aq) 0.1 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64BAR/ROO_1419 64BAR/ROO spectrophotometry C 5.4.99.1 methylaspartate mutase C03618 = C00025 L-threo-3-methylaspartate(aq) = L-glutamate(aq) 10.7 303.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIT/SAS_445 92KIT/SAS enzymatic assay C 2.4.1.20 cellobiose phosphorylase C00185 + C00009 = C00031 + C00103 cellobiose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.32 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW_1181 98KIS/TEW HPLC A 4.2.1.20 tryptophan synthase C00463 + C00118 = C03506 indole(aq) + D-glyceraldehyde 3-phosphate(aq) = 1-(indol-3-yl)glycerol 3-phosphate(aq) 298.15 7.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW_1182 98KIS/TEW calorimetry A 4.2.1.20 tryptophan synthase C00118 + C00463 = C03506 D-glyceraldehyde 3-phosphate(aq) + indole(aq) = 1-(indol-3-yl)glycerol 3-phosphate(aq) 298.15 7.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW_1184 98KIS/TEW calorimetry A 4.2.1.20 tryptophan synthase C00463 + C00065 = C00078 + C00001 indole(aq) + L-serine(aq) = L-tryptophan(aq) + H2O(l) 298.15 7.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW_1186 98KIS/TEW calorimetry A 4.2.1.20 tryptophan synthase C03506 + C00065 = C00078 + C00118 + C00001 1-(indol-3-yl)glycerol 3-phosphate(aq) + L-serine(aq) = L-tryptophan(aq) + D-glyceraldehyde 3-phosphate(aq) + H2O(l) 298.15 7.57 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW_1188 98KIS/TEW calorimetry A 4.2.1.20 tryptophan synthase C00065 = C00022 + C00014 L-serine(aq) = pyruvate(aq) + ammonia(aq) 308.15 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66HAN/ALB_688 66HAN/ALB spectrophotometry C 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.31 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64NOR_408 64NOR spectrophotometry and radioactivity B 2.3.1.21 carnitine O-palmitoyltransferase C00154 + C00318 = C00010 + C02990 palmitoyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-palmitoylcarnitine(aq) 0.5 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68ERI_3 68ERI spectrophotometry B 1.1.1.1 alcohol dehydrogenase C06142 + C00003 = C01412 + C00004 1-butanol(aq) + NAD(aq) = butanal(aq) + NADH(aq) 0.0018 298.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66AVI/ENG_213 66AVI/ENG spectrophotometry C 1.1.1.124 fructose 5-dehydrogenase (NADP+) C00095 + C00006 = C00273 + C00005 D-fructose(aq) + NADP(aq) = 5-dehydro-D-fructose(aq) + NADPH(aq) 0.000652 303.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66AVI/ENG_213 66AVI/ENG spectrophotometry C 1.1.1.124 fructose 5-dehydrogenase (NADP+) C00095 + C00006 = C00273 + C00005 D-fructose(aq) + NADP(aq) = 5-dehydro-D-fructose(aq) + NADPH(aq) 8.56e-05 303.15 6.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66AVI/ENG_213 66AVI/ENG spectrophotometry C 1.1.1.124 fructose 5-dehydrogenase (NADP+) C00095 + C00006 = C00273 + C00005 D-fructose(aq) + NADP(aq) = 5-dehydro-D-fructose(aq) + NADPH(aq) 0.000303 303.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66AVI/ENG_213 66AVI/ENG spectrophotometry C 1.1.1.124 fructose 5-dehydrogenase (NADP+) C00095 + C00006 = C00273 + C00005 D-fructose(aq) + NADP(aq) = 5-dehydro-D-fructose(aq) + NADPH(aq) 0.000177 303.15 6.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00LIA/HUA_1579 00LIA/HUA calorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.335 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN_771 54GIN radioactivity B 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 55 310.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SPR/LIM_1310 76SPR/LIM enzymatic assay and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.957 318.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SPR/LIM_1310 76SPR/LIM enzymatic assay and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.283 343.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SPR/LIM_1310 76SPR/LIM enzymatic assay and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.141 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SPR/LIM_1310 76SPR/LIM enzymatic assay and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.381 353.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SPR/LIM_1310 76SPR/LIM enzymatic assay and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.828 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88BEL/BAE_569 88BEL/BAE chromatography and radioactivity B 2.7.1.67 1-phosphatidylinositol kinase C00002 + C01194 = C00008 + C01277 ATP(aq) + 1-phosphatidyl-1D-myo-inositol(aq) = ADP(aq) + 1-phosphatidyl-1D-myo-inositol 4-phosphate(aq) 0.003 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89LOP/COH_603 89LOP/COH NMR C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00581 309.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55THO/GOM_1235 55THO/GOM manometry and enzymatic assay B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69KLO_398 69KLO spectrophotometry C 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0068 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_17 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0029 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70HEY/ELB_1343 70HEY/ELB spectrophotometry and chemical analysis C 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 1.9 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78OKA/GEN_875 78OKA/GEN paper chromatography C 3.2.1.2 _-amylase C02052 + C00001 = 2 C00208 maltotetraose(aq) + H2O(l) = 2 maltose(aq) 335 303.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62AKA/CAM_680 62AKA/CAM radioactivity B 2.7.7.4 sulfate adenylyltransferase C00002 + C00059 = C00224 + C00013 ATP(aq) + sulfate(aq) = adenosine 5'-phosphosulfate(aq) + pyrophosphate(aq) 6.2e-09 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62AKA/CAM_680 62AKA/CAM radioactivity B 2.7.7.4 sulfate adenylyltransferase C00002 + C00059 = C00224 + C00013 ATP(aq) + sulfate(aq) = adenosine 5'-phosphosulfate(aq) + pyrophosphate(aq) 1.8e-08 303.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/LOH_1290 35MEY/LOH calorimetry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 293.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/LOH_1290 35MEY/LOH calorimetry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 313.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE_366 86CAS/VEE enzymatic assay and spectrophotometry A 2.2.1.1 transketolase C00085 + C00118 = C00279 + C00231 D-fructose 6-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phospahte(aq) + D-xylulose 5-phosphate(aq) 0.0373 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50FRI_456 50FRI spectrophotometry C 2.4.2.1 purine-nucleoside phosphorylase C05512 + C00009 = C00262 + C00672 2'-deoxyinosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + 2-deoxy--D-ribose 1-phosphate(aq) 0.019 297.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93AND/BUL_1509 93AND/BUL radioactivity B 2.3.1.129 UDP-N-acetylglucosamine acyltransferase C04688 + C00043 = C03688 + C04738 (R)-3-hydroxytetradecanoyl-[acyl-carrier-protein](aq) + UDP-N-acetyl-D-glucosamine(aq) = acyl-carrier-protein(aq) + UDP-3-O-(3-hydroxytetradecanoyl)-N-acetyl-D-glucosamine(aq) 0.007 296.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93AND/BUL_1509 93AND/BUL radioactivity B 2.3.1.129 UDP-N-acetylglucosamine acyltransferase C04688 + C00043 = C03688 + C04738 (R)-3-hydroxytetradecanoyl-[acyl-carrier-protein](aq) + UDP-N-acetyl-D-glucosamine(aq) = acyl-carrier-protein(aq) + UDP-3-O-(3-hydroxytetradecanoyl)-N-acetyl-D-glucosamine(aq) 0.004 296.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93AND/BUL_1509 93AND/BUL radioactivity B 2.3.1.129 UDP-N-acetylglucosamine acyltransferase C04688 + C00043 = C03688 + C04738 (R)-3-hydroxytetradecanoyl-[acyl-carrier-protein](aq) + UDP-N-acetyl-D-glucosamine(aq) = acyl-carrier-protein(aq) + UDP-3-O-(3-hydroxytetradecanoyl)-N-acetyl-D-glucosamine(aq) 0.002 296.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93AND/BUL_1509 93AND/BUL radioactivity B 2.3.1.129 UDP-N-acetylglucosamine acyltransferase C04688 + C00043 = C03688 + C04738 (R)-3-hydroxytetradecanoyl-[acyl-carrier-protein](aq) + UDP-N-acetyl-D-glucosamine(aq) = acyl-carrier-protein(aq) + UDP-3-O-(3-hydroxytetradecanoyl)-N-acetyl-D-glucosamine(aq) 0.0095 296.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE_369 86CAS/VEE enzymatic assay and spectrophotometry A 2.2.1.1 transketolase C05382 + C00118 = C00117 + C00231 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-ribose 5-phosphate(aq) + D-xylulose 5-phosphate(aq) 0.48 311.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74JEB/TY_647 74JEB/TY enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.55 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75PIE/GUY_391 75PIE/GUY spectrophotometry A 2.3.1.7 carnitine O-acetyltransferase C00024 + C00318 = C00010 + C02571 acetyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-acetylcarnitine(aq) 1.73 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75PIE/GUY_391 75PIE/GUY spectrophotometry A 2.3.1.7 carnitine O-acetyltransferase C00024 + C00318 = C00010 + C02571 acetyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-acetylcarnitine(aq) 1.6 298.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=29WOO_1206 29WOO chemical analysis and polarimetry B 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.01 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KUR/SUG_696 60KUR/SUG spectrophotometry and enzymatic assay C 2.7.7.12 UDPglucose-hexose-1-phosphate uridylyltransferase C00029 + C03384 = C00103 + C00052 UDPglucose(aq) + D-galactose 1-phosphate(aq) =-D-glucose 1-phosphate(aq) + UDPgalactose(aq) 1.1 303.15 8.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62HAY/NIS_525 62HAY/NIS spectrophotometry C 2.6.1.18 _-alanine-pyruvate transaminase C00041 + C00222 = C00099 + C00022 L-alanine + 3-oxopropanoate = beta-alanine + pyruvate 0.2 308.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00084 293.15 0.1 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00807 293.15 0.1 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0795 293.15 0.1 10 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 7.36e-05 293.15 0.05 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 8.07e-05 293.15 0.096 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 9.25e-05 293.15 0.259 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 9.97e-05 293.15 0.376 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0001047 293.15 0.423 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0001184 293.15 0.749 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 6.46e-05 288.15 0.1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 9.77e-05 298.15 0.1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0001202 303.15 0.1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0001445 308.15 0.1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000642 288.15 0.1 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000795 293.15 0.1 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.001175 303.15 0.1 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.001413 308.15 0.1 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00635 288.15 0.1 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00794 293.15 0.1 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00972 298.15 0.1 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.01454 308.15 0.1 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.01454 308.15 0.1 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 9.27e-05 293.15 0.189 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 8.0e-05 293.15 0.1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000966 298.15 0.1 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.012 303.15 0.1 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 7.95e-05 293.15 0.1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 40.1 311.15 0.25 6.95 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 34.1 311.15 0.25 7.23 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 32.4 311.15 0.25 7.08 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 31.6 311.15 0.25 7.08 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 26.7 311.15 0.25 7.22 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 24.1 311.15 0.25 7.92 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 25.5 311.15 0.25 7.92 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 44.6 311.15 0.25 6.9 2.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 37.4 311.15 0.25 6.95 1.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 40 311.15 0.25 6.85 1.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 43.3 311.15 0.25 6.9 2.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 45 311.15 0.25 6.9 2.59 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 44.7 311.15 0.25 6.88 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 33.6 311.15 0.25 7.35 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.5 311.15 0.25 6.94 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 49.6 311.15 0.25 6.9 2.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 49 311.15 0.25 6.9 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 34.4 311.15 0.25 6.9 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 34.6 311.15 0.25 6.95 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 39 311.15 0.25 6.94 2.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.8 311.15 0.25 6.92 2.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.8 311.15 0.25 6.92 2.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 49.9 311.15 0.25 6.9 2.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 43.1 311.15 0.25 6.88 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.9 311.15 0.25 7.15 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 33.5 311.15 0.25 7.32 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 34.4 311.15 0.25 7.32 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 39.9 311.15 0.25 6.95 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 29.9 311.15 0.25 6.91 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 28.2 311.15 0.25 7.09 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 37.3 311.15 0.25 6.9 2.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 39.4 311.15 0.25 6.95 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 38.3 311.15 0.25 6.9 1.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 44.5 311.15 0.25 6.88 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 35.7 311.15 0.25 6.87 2.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 37.6 311.15 0.25 6.94 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 38.9 311.15 0.25 6.88 1.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 30.4 311.15 0.25 7.09 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 46.9 311.15 0.25 6.9 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 41.3 311.15 0.25 6.88 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 51.4 311.15 0.25 6.9 2.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 31.3 311.15 0.25 7.23 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 31.3 311.15 0.25 7.23 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.1 311.15 0.25 6.94 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 34 311.15 0.25 7.16 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 21.6 311.15 0.25 7.99 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 39.3 311.15 0.25 6.86 1.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 35.9 311.15 0.25 7.15 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 28.9 311.15 0.25 7.99 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 39.9 311.15 0.25 6.89 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.8 311.15 0.25 7.35 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74SCA/SHI_1308 74SCA/SHI C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.04 340.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74SCA/SHI_1308 74SCA/SHI C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.16 360.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74SCA/SHI_1308 74SCA/SHI C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.09 350.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77SCH/TAT_350 77SCH/TAT spectrophotometry and radioactivity A 2.1.2.1 glycine hydroxymethyltransferase C00143 + C00037 + C00001 = C00101 + C00065 5,10-methylenetetrahydrofolate(aq) + glycine(aq) + H2O(l) = tetrahydrofolate(aq) + L-serine(aq) 0.083 308.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77SCH/TAT_350 77SCH/TAT spectrophotometry and radioactivity A 2.1.2.1 glycine hydroxymethyltransferase C00143 + C00037 + C00001 = C00101 + C00065 5,10-methylenetetrahydrofolate(aq) + glycine(aq) + H2O(l) = tetrahydrofolate(aq) + L-serine(aq) 0.125 303.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95JUS/KOT_1002 95JUS/KOT calorimetry C 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 0.07 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_277 85ANS/PRI D 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.8e-07 311.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_277 85ANS/PRI D 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 8.0e-08 311.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_277 85ANS/PRI D 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 3.1e-06 311.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80SVE/GAL_1023 80SVE/GAL B 3.5.1.14 aminoacylase C02712 + C00001 = C00033 + C00073 N-acetyl-L-methionine(aq) + H2O(l) = acetate(aq) + L-methionine(aq) 3.6 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57TAL_180 57TAL spectrophotometry C 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 0.37 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.021 298.15 7.4 2.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00625 298.15 7.4 1.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00465 298.15 7.4 1.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00549 298.15 7.4 1.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00408 298.15 7.4 1.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.0027 298.15 7.4 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00268 298.15 7.4 1.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00282 298.15 7.4 1.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00279 298.15 7.4 1.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00288 298.15 7.4 0.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00251 298.15 7.4 0.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00292 298.15 7.4 0.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00787 298.15 7.4 2.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.0036 298.15 7.4 1.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00276 298.15 7.4 0.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.0207 298.15 7.4 2.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00855 298.15 7.4 2.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00565 298.15 7.4 1.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00255 298.15 7.4 1.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LLO/KHA_1309 76LLO/KHA polarimetry and HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.869 303.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LLO/KHA_1309 76LLO/KHA polarimetry and HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.931 318.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LLO/KHA_1309 76LLO/KHA polarimetry and HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.996 333.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LLO/KHA_1309 76LLO/KHA polarimetry and HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.101 343.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70GEO/WIT_755 70GEO/WIT calorimetry C 3.1.3.1 alkaline phosphatase C00227 + C00001 = C00033 + C00009 acetyl phosphate-2-(aq) + H2O(l) = acetate-(aq) + HPO4-2-(aq) 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TUR/TUR_684 58TUR/TUR chromatography and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.119 303.15 7.9 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TUR/TUR_684 58TUR/TUR chromatography and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.286 303.15 7 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TUR/TUR_684 58TUR/TUR chromatography and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.139 303.15 7.9 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TUR/TUR_684 58TUR/TUR chromatography and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.263 303.15 7.9 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78SUB_284 78SUB calorimetry A 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78SUB_284 78SUB calorimetry A 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 308.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_136 68VEE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.0002 311.15 0.25 8.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_136 68VEE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.9e-05 311.15 0.25 7.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_136 68VEE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000257 311.15 0.25 8.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70GEO/WIT_758 70GEO/WIT chromatography and enzymatic assay C 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP-2--(aq) + H2O(l) = adenosine(aq) + HPO4-2-(aq) 48 298.15 0 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69SMI/MOR_617 69SMI/MOR B 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.8 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68TAN/KAN_451 68TAN/KAN paper chromatography and radioactivity C 2.4.1.67 galactinol-raffinose galactosyltransferase C01235 + C00492 = C00137 + C01613 1--D-galactosyl-myo-inositol(aq) + raffinose(aq) = myo-inositol(aq) + stachyose(aq) 4 305.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.7e-06 296.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 8.57e-06 296.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 9.34e-05 296.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.000163 296.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.000465 296.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.49e-05 296.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.00071 296.15 9.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.73e-05 296.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83SEL/MAN_1228 83SEL/MAN spectrophotometry C 4.4.1.5 lactoylglutathione lyase C03451 = C00051 + C00546 (R)-S-lactoylglutathione(aq) = glutathione (reduced)(aq) + methylglyoxal(aq) 9.0e-05 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73RAD/HOC_400 73RAD/HOC spectrophotometry C 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0065 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 6.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.59 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.57 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 309.95 8.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 7.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 7.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 304.15 8.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 7.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEN/ROB_190 59DEN/ROB chromatography and spectrophotometry B 1.1.1.59 3-hydroxypropionate dehydrogenase C01013 + C00003 = C00222 + C00004 3-hydroxypropanoate(aq) + NAD(aq) = 3-oxopropanoate(aq) + NADH(aq) 0.009 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_814 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00199 + C00001 = C00309 + C00009 D-ribulose 5-phosphate(aq) + H2O(l) = D-ribulose(aq) + orthophosphate(aq) 304.65 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_814 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00199 + C00001 = C00309 + C00009 D-ribulose 5-phosphate(aq) + H2O(l) = D-ribulose(aq) + orthophosphate(aq) 310.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_814 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00199 + C00001 = C00309 + C00009 D-ribulose 5-phosphate(aq) + H2O(l) = D-ribulose(aq) + orthophosphate(aq) 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_813 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00117 + C00001 = C00121 + C00009 D-ribose 5-phosphate(aq) + H2O(l) = D-ribose(aq) + orthophosphate(aq) 298.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_813 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00117 + C00001 = C00121 + C00009 D-ribose 5-phosphate(aq) + H2O(l) = D-ribose(aq) + orthophosphate(aq) 310.15 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_813 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00117 + C00001 = C00121 + C00009 D-ribose 5-phosphate(aq) + H2O(l) = D-ribose(aq) + orthophosphate(aq) 304.65 8.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL2_42 37EUL/ADL2 spectrophotometry C 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 1.6e-05 298.15 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL2_42 37EUL/ADL2 spectrophotometry C 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.00059 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL2_42 37EUL/ADL2 spectrophotometry C 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.0003 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52BAU/GEM_996 52BAU/GEM calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 303.15 7.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 15700 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2500 298.15 7.4 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2630 298.15 7.4 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1180 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 493 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 115 298.15 7.4 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 101 298.15 7.4 1.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 7000 298.15 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 556 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 862 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1350 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1350 298.15 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 387 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 136 298.15 7.4 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 6310 277.9 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 5830 283.1 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3120 303 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2460 312.7 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3530 298.15 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 469 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3770 298.15 7.4 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3770 298.15 7.4 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 111 298.15 7.4 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 17000 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 215 298.15 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1850 298.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 12000 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3930 292.9 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE_1157 53KRE polarimetry and manometry A 4.2.1.3 aconitate hydratase C00158 = C00417 + C00001 citrate(aq) = cis-aconitate(aq) + H2O(l) 0.032 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57SAN/SEA_323 57SAN/SEA spectrophotometry C 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.21 295.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1104 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.002 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1104 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.003 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1104 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.011 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1104 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0024 311.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GEU/MAY_1542 85GEU/MAY radioactivity B 2.7.1.117 myosin-light-chain kinase C00002 + C01003 = C00008 + C03875 ATP(aq) + myosin light chain(aq) = ADP(aq) + myosin light chain phosphate(aq) 59 303.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_11 50RAC spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000364 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_11 50RAC spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0115 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_11 50RAC spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0364 298.15 9.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_11 50RAC spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00364 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_11 50RAC spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00115 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BAL/DEN_84 70BAL/DEN spectrophotometry C 1.1.1.25 shikimate dehydrogenase C00493 + C00006 = C02652 + C00005 shikimate(aq) + NADP(aq) = 5-dehydroshikimate(aq) + NADPH(aq) 0.097 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_787 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00275 + C00001 = C00159 + C00009 D-mannose 6-phosphate(aq) + H2O(l) = D-mannose(aq) + orthophosphate(aq) 298.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_787 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00275 + C00001 = C00159 + C00009 D-mannose 6-phosphate(aq) + H2O(l) = D-mannose(aq) + orthophosphate(aq) 304.65 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_787 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00275 + C00001 = C00159 + C00009 D-mannose 6-phosphate(aq) + H2O(l) = D-mannose(aq) + orthophosphate(aq) 310.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84ADA/UED_887 84ADA/UED HPLC and enzymatic assay C 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 18 313 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72ROS/SLA_1441 72ROS/SLA enzymatic assay and chemical analysis A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 270 310.15 0.3 7 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72ROS/SLA_1441 72ROS/SLA enzymatic assay and chemical analysis A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 831 310.15 0.17 7.58 2.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72ROS/SLA_1441 72ROS/SLA enzymatic assay and chemical analysis A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 668 310.15 0.21 7.5 1.31 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72ROS/SLA_1441 72ROS/SLA enzymatic assay and chemical analysis A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 162 310.15 0.2 6.6 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72ROS/SLA_1441 72ROS/SLA enzymatic assay and chemical analysis A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 280 310.15 0.22 7.1 1.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_764 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C01094 + C00001 = C00095 + C00009 D-fructose 1-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 53 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_765 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 124 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_762 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C00354 + C00001 = C01094 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 1-phosphate(aq) + orthophosphate(aq) 14 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_763 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 6.3 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69WHI/LEJ_1239 69WHI/LEJ manometry and spectrophotometry B 5.1.1.7 diaminopimelate epimerase C00666 = C00680 L,L-2,6-diaminoheptanedioate(aq) = meso-diaminoheptanedioate(aq) 1.9 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_768 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C01113 + C00001 = C00124 + C00009 D-galactose 6-phosphate(aq) + H2O(l) = D-galactose(aq) + orthophosphate(aq) 87 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64HEN/CLE_500 64HEN/CLE spectrophotometry B 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.165 310.15 0.13 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56FEU/WOL_557 56FEU/WOL chromatography C 2.7.1.24 dephospho-CoA kinase C00002 + C00882 = C00008 + C00010 ATP(aq) + 3'-dephospho-CoA(aq) = ADP(aq) + CoA(aq) 1.6 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_165 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 1500 311.15 6.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_165 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 8900 311.15 6.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_165 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 83000 311.15 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DAT/RAC_368 61DAT/RAC enzymatic assay and spectrophotometry B 2.2.1.1 transketolase C05382 + C00118 = C00117 + C00231 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-ribose 5-phosphate(aq) + D-xylulose 5-phosphate(aq) 0.9 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GOL_406 54GOL spectrophotometry C 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 6.0e-05 289.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GOL_406 54GOL spectrophotometry C 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 8.7e-05 289.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DAT/RAC_367 61DAT/RAC enzymatic assay and spectrophotometry B 2.2.1.1 transketolase C00085 + C00266 = C02045 + C00279 D-fructose 6-phosphate(aq) + glycolaldehyde(aq) = L-erythrulose(aq) + D-erythrose 4-phosphate(aq) 0.015 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DAT/RAC_365 61DAT/RAC enzymatic assay and spectrophotometry B 2.2.1.1 transketolase C00085 + C00118 = C00279 + C00231 D-fructose 6-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phosphate(aq) + D-xylulose 5-phosphate(aq) 0.084 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63DEV/GOU_459 63DEV/GOU radioactivity and spectrophotometry C 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.025 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63QUA_260 63QUA spectrophotometry B 1.2.1.17 glyoxylate dehydrogenase (acylating) C00048 + C00010 + C00006 = C00313 + C00005 glyoxylate(aq) + CoA(aq) + NADP(aq) = oxalyl-CoA(aq) + NADPH(aq) 44.7 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63QUA_260 63QUA spectrophotometry B 1.2.1.17 glyoxylate dehydrogenase (acylating) C00048 + C00010 + C00006 = C00313 + C00005 glyoxylate(aq) + CoA(aq) + NADP(aq) = oxalyl-CoA(aq) + NADPH(aq) 38.5 298.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63QUA_260 63QUA spectrophotometry B 1.2.1.17 glyoxylate dehydrogenase (acylating) C00048 + C00010 + C00006 = C00313 + C00005 glyoxylate(aq) + CoA(aq) + NADP(aq) = oxalyl-CoA(aq) + NADPH(aq) 73.4 298.15 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63QUA_260 63QUA spectrophotometry B 1.2.1.17 glyoxylate dehydrogenase (acylating) C00048 + C00010 + C00006 = C00313 + C00005 glyoxylate(aq) + CoA(aq) + NADP(aq) = oxalyl-CoA(aq) + NADPH(aq) 24.3 298.15 6.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63QUA_260 63QUA spectrophotometry B 1.2.1.17 glyoxylate dehydrogenase (acylating) C00048 + C00010 + C00006 = C00313 + C00005 glyoxylate(aq) + CoA(aq) + NADP(aq) = oxalyl-CoA(aq) + NADPH(aq) 51.8 298.15 6.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 46.8 311.15 0.25 7.73 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49.4 311.15 0.25 8.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 48.3 311.15 0.25 8.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49.9 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47.8 311.15 0.25 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49.8 311.15 0.25 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 50 311.15 0.25 7 1.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 50 311.15 0.25 7 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 51.1 311.15 0.25 7 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 50.6 311.15 0.12 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 58.9 311.15 0.41 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 57.5 311.15 0.56 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 125 311.15 0.25 5.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 122.3 311.15 0.25 5.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 76.8 311.15 0.25 6.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 70.4 311.15 0.25 6.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 74.2 311.15 0.25 6.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 55.1 311.15 0.25 6.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 58.4 311.15 0.25 6.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 59.8 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 59.4 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 59.4 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 59.8 311.15 0.25 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 52.8 311.15 0.25 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 54.9 311.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49.8 311.15 0.25 7.36 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 45 311.15 0.25 7.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 55.8 311.15 0.71 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 55.8 311.15 1 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 58.9 311.15 1 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56.5 311.15 0.25 6.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 46.1 311.15 0.25 7.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49.8 311.15 0.25 7 1.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 68.6 311.15 0.25 6.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 57.2 311.15 0.25 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 58.2 311.15 0.71 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 57.7 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 51 311.15 0.25 8.16 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56.1 311.15 0.41 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47.4 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47 311.15 0.25 8.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47.8 311.15 0.25 7 2.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47.8 311.15 0.25 7 2.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 53.9 311.15 0.56 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 54.8 311.15 0.12 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47.4 311.15 0.25 7 2.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60SCH/RAT_1444 60SCH/RAT spectrophotometry A 6.3.4.5 arginosuccinate synthase C00002 + C00327 + C00049 = C00020 + C00013 + C03406 ATP(aq) + L-citrulline(aq) + L-aspartate(aq) = AMP(aq) + diphosphate(aq) + L-arginosuccinate(aq) 2.14 311.15 6.91 2.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60SCH/RAT_1444 60SCH/RAT spectrophotometry A 6.3.4.5 arginosuccinate synthase C00002 + C00327 + C00049 = C00020 + C00013 + C03406 ATP(aq) + L-citrulline(aq) + L-aspartate(aq) = AMP(aq) + diphosphate(aq) + L-arginosuccinate(aq) 69.5 311.15 7.79 2.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60SCH/RAT_1444 60SCH/RAT spectrophotometry A 6.3.4.5 arginosuccinate synthase C00002 + C00327 + C00049 = C00020 + C00013 + C03406 ATP(aq) + L-citrulline(aq) + L-aspartate(aq) = AMP(aq) + diphosphate(aq) + L-arginosuccinate(aq) 38.3 311.15 7.7 2.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60SCH/RAT_1444 60SCH/RAT spectrophotometry A 6.3.4.5 arginosuccinate synthase C00002 + C00327 + C00049 = C00020 + C00013 + C03406 ATP(aq) + L-citrulline(aq) + L-aspartate(aq) = AMP(aq) + diphosphate(aq) + L-arginosuccinate(aq) 0.14 311.15 5.9 2.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62DOU/SHU_1111 62DOU/SHU spectrophotometry C 4.1.2.21 2-dehydro-3-deoxy-6-phosphogalactonate aldolase C01286 = C00022 + C00118 2-dehydro-3-deoxy-D-galactonate 6-phosphate(aq) = pyruvate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.0037 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63DEV/GOU_457 63DEV/GOU radioactivity and spectrophotometry C 2.4.2.1 purine-nucleoside phosphorylase C05512 + C00009 = C00262 + C00672 2'-deoxyinosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + 2-deoxy--D-ribose 1-phosphate(aq) 0.03 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84UCH/TSU_1119 84UCH/TSU B 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.08 310.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK/HIZ_1357 67TAK/HIZ spectrophotometry C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.54 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64IMA/MOR_1251 64IMA/MOR spectrophotometry A 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.29 298.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50FRI_1535 50FRI spectrophotometry B 2.4.2.1 purine-nucleoside phosphorylase C05512 + C00009 = C00262 + C00672 2 '-deoxyinosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + 2-deoxy--D-ribose 1-phosphate(aq) 0.019 297.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FER/STR_1380 74FER/STR enzymatic assay and spectrophotometry B 5.3.1.- phospho-3-hexuloisomerase C06019 = C00085 D-arabino-3-hexulose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 188 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65MOR/JAM_594 65MOR/JAM spectrophotometry C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.036 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75COH/LYN_1198 75COH/LYN spectrophotometry A 4.2.1.49 urocanate hydratase C00785 + C00001 = C03680 urocanate(aq) + H2O(l) = 4,5-dihydro-4-oxo-5-imidazolepropanoate(aq) 35.5 277.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75COH/LYN_1198 75COH/LYN spectrophotometry A 4.2.1.49 urocanate hydratase C00785 + C00001 = C03680 urocanate(aq) + H2O(l) = 4,5-dihydro-4-oxo-5-imidazolepropanoate(aq) 49.1 288.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75COH/LYN_1198 75COH/LYN spectrophotometry A 4.2.1.49 urocanate hydratase C00785 + C00001 = C03680 urocanate(aq) + H2O(l) = 4,5-dihydro-4-oxo-5-imidazolepropanoate(aq) 58.2 293.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75COH/LYN_1198 75COH/LYN spectrophotometry A 4.2.1.49 urocanate hydratase C00785 + C00001 = C03680 urocanate(aq) + H2O(l) = 4,5-dihydro-4-oxo-5-imidazolepropanoate(aq) 69.8 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75COH/LYN_1198 75COH/LYN spectrophotometry A 4.2.1.49 urocanate hydratase C00785 + C00001 = C03680 urocanate(aq) + H2O(l) = 4,5-dihydro-4-oxo-5-imidazolepropanoate(aq) 91.2 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KAT_112 55KAT calorimetry B 1.1.1.28 D-lactate dehydrogenase C00256 + C00003 = C00022 + C00004 (R)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73SUZ/IWA_1060 73SUZ/IWA spectrophotometry C 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 50 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MEY/SHA_1069 53MEY/SHA calorimetry B 3.6.1.2 trimetaphosphatase C02466 + C00001 = C00536 trimetaphosphate(aq) + H2O(l) = triphosphate(aq) 306.15 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62UEH_1293 62UEH chemical analysis C 5.3.1.2 erythrose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 2.3 308.15 5.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69SWI_674 69SWI enzymatic assay and spectrophotometry A 2.7.6.1 ribose-phosphate pyrophosphokinase C00002 + C00117 = C00020 + C00119 ATP(aq) + D-ribose 5-phosphate(aq) = AMP(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 28.6 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93MOC/STR_453 93MOC/STR HPLC C 2.4.1.120 sinapate 1-glucosyltransferase C00029 + C00482 = C00015 + C01175 UDPglucose(aq) + sinapate(aq) = UDP(aq) + 1-sinapoyl-D-glucose(aq) 0.21 303.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE2_508 53KRE2 manometry A 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.658 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83PIL/HAN_1597 83PIL/HAN radioactivity C 5.1.3.2 UDPglucose 4-epimerase C00043 = C00203 UDP-N-acetyl-D-glucosamine(aq) = UDP-N-acetyl-D-galactosamine(aq) 0.38 310.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67PLO/CLE_1130 67PLO/CLE radioactivity and paper chromatography C 4.1.3.8 ATP citrate(pro-3S)-lyase C00002 + C00158 + C00010 = C00008 + C00009 + C00024 + C00036 ATP(aq) + citrate(aq) + CoA(aq) = ADP(aq) + phosphate(aq) + acetyl-CoA(aq) + oxaloacetate(aq) 1.2 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83BRA_4 83BRA calorimetry A 1.1.1.1 alcohol dehydrogenase C06142 + C00003 = C01412 + C00004 1-butanol(aq) + NAD(aq) = butanal(aq) + NADH(aq) 298.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76HIL/ATT_1397 76HIL/ATT enzymatic assay and spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.3 303.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ALE_444 61ALE enzymatic assay B 2.4.1.20 cellobiose phosphorylase C00185 + C00009 = C00031 + C00103 cellobiose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.23 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52MEY/SHA_815 52MEY/SHA calorimetry B 3.1.3.2 acid phosphatase C00227 + C00001 = C00033 + C00009 acetyl phosphate(aq) + H2O(l) = acetate(aq) + orthophosphate(aq) 306.15 5.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55WOL/KAP_75 55WOL/KAP spectrophotometry C 1.1.1.17 mannitol-1-phosphate dehydrogenase C00644 + C00003 = C00085 + C00004 D-mannitol 1-phosphate(aq) + NAD(aq) = D-fructose 6-phosphate(aq) + NADH(aq) 0.005 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83BRA_28 83BRA calorimetry A 1.1.1.1 alcohol dehydrogenase C05979 + C00003 = C00479 + C00004 1-propanol(aq) + NAD(aq) = propanal(aq) + NADH(aq) 298.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61WOO/STJ_361 61WOO/STJ enzymatic assay and spectrophotometry B 2.1.3.1 methylmalonyl-CoA carboxyltransferase C00036 + C00100 = C00022 + C02557 oxaloacetate(aq) + propanoyl-CoA(aq) = pyruvate(aq) + methylmalonyl-CoA(aq) 1.9 303.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50COR/VEL_252 50COR/VEL enzymatic assay and spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.0984 298.15 7.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50COR/VEL_252 50COR/VEL enzymatic assay and spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.193 298.15 7.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50COR/VEL_252 50COR/VEL enzymatic assay and spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.187 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50COR/VEL_252 50COR/VEL enzymatic assay and spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.156 298.15 7.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.169 328.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.199 331.95 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.246 343.75 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.146 320.25 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.226 338.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.17 325.25 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MAT/STR_533 66MAT/STR spectrophotometry B 2.6.1.33 dTDP-4-amino-4,6-dideoxy-D-glucose transaminase C04268 + C00026 = C11907 + C00025 dTDP-4-amino-4,6-dideoxy-D-glucose(aq) + 2-oxoglutarate(aq) = dTDP-4-dehydro-6-deoxy-D-glucose(aq) + L-glutamate(aq) 2 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.79e-06 298.15 0.25 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.36e-06 298.15 0.25 6.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 6.91e-06 298.15 0.25 7.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.17e-05 298.15 0.25 7.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.28e-05 298.15 0.25 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 1.15e-06 298.15 0.25 6.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 9.49e-07 298.15 0.25 6.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.54e-06 298.15 0.25 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.36e-06 298.15 0.25 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 6.1e-05 298.15 0.25 8.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.11e-06 298.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.82e-06 298.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.84e-06 298.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.72e-06 298.15 0.25 6.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.77e-06 298.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.13e-06 298.15 0.25 6.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.52e-06 311.15 0.5 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 5.4e-06 311.15 1 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.36e-06 311.15 0.25 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.64e-06 303.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 1.98e-06 298.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 1.98e-06 298.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 5.53e-06 298.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.22e-06 298.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.19e-06 311.15 0.25 7 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.22e-05 298.15 0.25 7.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 5.44e-06 298.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.8e-06 311.15 0.0595 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 1.09e-06 298.15 0.25 6.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.19e-06 298.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 8.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 8.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 313.15 7.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 313.15 8.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 320.15 8.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 320.15 8.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 8.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 320.15 8.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 313.15 7.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 7.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1140 94TEW/GOL calorimetry A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 298.15 7.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75IZU/REE_1376 75IZU/REE B 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.39 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87HSU/WED_1551 87HSU/WED radioactivity A 2.1.3.2 aspartate carbamoyl-transferase C00169 + C00049 = C00009 + C00438 carbamoyl phosphate(aq) + L-aspartate(aq) = orthophosphate(aq) + N-carbamoyl-L-aspartate(aq) 5900 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62WIL/SNE_357 62WIL/SNE spectrophotometry B 2.1.2.7 D-alanine 2-hydroxymethyltransferase C03059 + C00101 = C00143 + C00740 + C00001 2-hydroxymethylserine(aq) + tetrahydrofolate(aq) = 5,10-methylenetetrahydrofolate(aq) + D-serine(aq) + H2O(1) 8 311.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58MAL/OCH_673 58MAL/OCH spectrophotometry B 2.7.4.14 cytidylate kinase C00002 + C00239 = C00008 + C00705 ATP(aq) + dCMP(aq) = ADP(aq) + dCDP(aq) 1.49 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75PIE/GUY_388 75PIE/GUY spectrophotometry A 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 12.3 311.15 0.25 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75PIE/GUY_388 75PIE/GUY spectrophotometry A 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 11.7 298.15 0.25 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1315 84TEW/GOL microcalorimetry A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 344.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1315 84TEW/GOL microcalorimetry A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 331.85 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1315 84TEW/GOL microcalorimetry A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1315 84TEW/GOL microcalorimetry A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 313.25 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.892 306.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.004 331.85 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.094 344.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.199 358.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.157 353.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.964 322.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.866 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.936 313.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MEL/WOO_1106 64MEL/WOO spectrophotometry and radioactivity C 4.1.2.14 2-dehydro-3-deoxyphosphogluconate aldolase C04442 = C00022 + C00118 6-phospho-2-dehydro-3-deoxy-D-gluconate(aq) = pyruvate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.0012 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82SUE/KAT_221 82SUE/KAT spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.045 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1540 310.15 7 2.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1130 310.15 7 3.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 817 310.15 7 3.48 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 586 310.15 7 3.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 490 310.15 7 4.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 288 310.15 7 4.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 306 310.15 7 5.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 670 310.15 7 3.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 622 310.15 7 3.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 288 310.15 7 5.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 412 310.15 7 4.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 353 310.15 7 4.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1930 310.15 7 2.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1310 310.15 7 3.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 975 310.15 7 3.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66STA/DEN_410 66STA/DEN spectrophotometry, chromatography, and radioactivity B 2.3.1.35 glutamate N-acetyltransferase C00437 + C00025 = C00077 + C00624 N-2-acetyl-L-ornithine(aq) + L-glutamate(aq) = L-ornithine(aq) + N-acetyl-L-glutamate(aq) 0.47 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DRA/MEY_250 45DRA/MEY spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 1.3 296.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DRA/MEY_250 45DRA/MEY spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.92 296.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DRA/MEY_250 45DRA/MEY spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.36 296.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80REK/EGO_335 80REK/EGO calorimetry B 1.12.1.2 hydrogen dehydrogenase C00282 + C00003 = C00004 H2(aq) + NAD(aq) = NADH(aq) 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57CAL_638 57CAL chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.69 303.15 6.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57CAL_638 57CAL chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.47 303.15 6.81 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57CAL_638 57CAL chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.46 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57CAL_638 57CAL chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.4 303.15 7.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66KIM/SUZ_706 66KIM/SUZ spectrophotometry and enzymatic assay B 2.7.7.33 glucose-1-phosphate cytidylyltransferase C00063 + C00103 = C00501 + C00013 CTP(aq) + D-glucose 1-phosphate(aq) = CDPglucose(aq) + pyrophosphate(aq) 0.57 310.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56DIC/WIL_1333 56DIC/WIL chromatography and spectrophotometry C 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.67 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GAL/SVE_1024 82GAL/SVE spectrophotometry C 3.5.1.14 aminoacylase C02712 + C00001 = C00033 + C00073 N-acetyl-L-methionine(aq) + H2O(l) = acetate(aq) + L-methionine(aq) 3.7 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.31 298.15 0.1 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 10.8 310.15 0.1 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 36.1 298.15 0.1 7.5 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 46.1 298.15 0.1 7.5 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 64.8 298.15 0.1 7.5 2.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 48.3 298.15 0.044 7.5 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 77.7 298.15 0.044 7.5 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 37.9 298.15 0.07 7.5 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 67.3 298.15 0.07 7.5 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 21.5 298.15 0.15 7.5 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 31.2 298.15 0.15 7.5 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 12.7 298.15 0.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 59.7 298.15 0.15 7.5 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 21.3 298.15 0.1 7.5 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 46.8 298.15 0.15 7.5 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 11.4 298.15 0.044 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 66.8 298.15 0.044 7.5 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 52.5 298.15 0.1 7.5 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 12.2 298.15 0.1 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 23.3 298.15 0.07 7.5 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 16.4 298.15 0.07 7.5 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 16.4 298.15 0.07 7.5 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 11.6 298.15 0.07 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 54.5 298.15 0.07 7.5 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 69 298.15 0.1 7.5 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 27.6 298.15 0.044 7.5 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 63.8 298.15 0.07 7.5 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76MUR_1413 76MUR enzymatic assay and spectrophotometry B 5.4.2.8 phosphomannomutase C00636 = C00275 D-mannose 1-phosphate(aq) = D-mannose 6-phosphate(aq) 8.5 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AUR/KLE_209 68AUR/KLE spectrophotometry B 1.1.1.108 carnitine dehydrogenase C00318 + C00003 = C02636 + C00004 L-carnitine(aq) + NAD(aq) = 3-dehydrocarnitine(aq) + NADH(aq) 0.00013 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AUR/KLE_209 68AUR/KLE spectrophotometry B 1.1.1.108 carnitine dehydrogenase C00318 + C00003 = C02636 + C00004 L-carnitine(aq) + NAD(aq) = 3-dehydrocarnitine(aq) + NADH(aq) 0.0013 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AUR/KLE_209 68AUR/KLE spectrophotometry B 1.1.1.108 carnitine dehydrogenase C00318 + C00003 = C02636 + C00004 L-carnitine(aq) + NAD(aq) = 3-dehydrocarnitine(aq) + NADH(aq) 0.013 303.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/KIE_1385 35MEY/KIE polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 7.3 273.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/KIE_1385 35MEY/KIE polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 3.45 311.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/KIE_1385 35MEY/KIE polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 2.3 333.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/KIE_1385 35MEY/KIE polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 3.85 301.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61BER/BER_1431 61BER/BER radioactivity and spectrophotometry A 6.1.1.9 valine-tRNA ligase C00002 + C00183 + C01653 = C00020 + C00013 + C02554 ATP + L-valine + tRNA(Val) = AMP + diphosphate + L-Valyl-tRNA(Val) 0.32 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 4000 308.15 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 170 308.15 7 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 66 308.15 7 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1500 308.15 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 650 308.15 7.8 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 370 308.15 7.8 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 180 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 74 308.15 7.8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 920 308.15 6.2 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 510 308.15 6.2 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 370 308.15 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 500 308.15 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3000 308.15 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 61 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 61 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 430 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 310 308.15 7.8 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 450 308.15 7.8 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 400 308.15 7.8 1.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1200 308.15 6.15 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 180 308.15 7.82 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2600 308.15 6.2 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1200 308.15 6.2 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 420 308.15 6.2 1.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 140 308.15 6.2 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 310 308.15 6.2 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1200 308.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 400 308.15 7 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 440 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 180 308.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 110 308.15 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 74 308.15 7.8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 830 313.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 830 313.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 420 299.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 320 313.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 230 308.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 210 302.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 160 299.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 130 293.15 7.8 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 140 302.15 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 82 293.15 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 160 308.15 7.8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 110 302.15 7.8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 100 299.15 7.8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 81 293.15 7.8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 270 308.15 7.8 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 970 308.15 7.8 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 71 308.15 7.8 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 72 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 170 308.15 7.8 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 110 308.15 7.8 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 97 308.15 7.8 1.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 82 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 372 308.15 7.8 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 270 308.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 280 308.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 82 308.15 7.8 1.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 89 308.15 7 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 170 308.15 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 130 308.15 8.93 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 98 308.15 7 1.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2600 308.15 6.2 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1000 308.15 7.8 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 280 293.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 280 293.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 130 308.15 7.8 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 350 308.15 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 72 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 570 308.15 6.42 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 690 308.15 7 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 110 308.15 7.8 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 190 308.15 7 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 660 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 230 313.15 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 540 308.15 7.8 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=8.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 900 308.15 7.8 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=8.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 490 302.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=8.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 110 299.15 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=8.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 400 308.15 7.8 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=8.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 530 308.15 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76FAR/CRY_1529 76FAR/CRY radioactivity B 2.7.7.4 sulfate adenylyltransferase C00002 + C00059 = C00013 + C00224 ATP(aq) + sulfate(aq) = pyrophosphate(aq) + adenylylsulfate(aq) 2.5e-09 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_48 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C01507 + C00003 = C00247 + C00004 L-iditol(aq) + NAD(aq) = L-sorbose(aq) + NADH(aq) 0.00423 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_48 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C01507 + C00003 = C00247 + C00004 L-iditol(aq) + NAD(aq) = L-sorbose(aq) + NADH(aq) 0.0423 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KIS/TEW_992 99KIS/TEW calorimetry A 3.5.1.2 glutaminase C00064 + C00001 = C00025 + C00014 L-glutamine(aq) + H2O(l) = L-glutamate(aq) + ammonia(aq) 298.15 5.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_314 68VEE fluorimetry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.0242 298.15 0.25 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_314 68VEE fluorimetry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.0156 311.15 0.25 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FRA/LEE_1306 74FRA/LEE C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.03 323.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ASH/WAH_1368 60ASH/WAH enzymatic assay and spectrophotometry C 5.3.1.12 glucuronate isomerase C00333 = C00558 D-galacturonate(aq) = D-tagaturonate(aq) 0.25 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ASH/WAH_1368 60ASH/WAH enzymatic assay and spectrophotometry C 5.3.1.12 glucuronate isomerase C00333 = C00558 D-galacturonate(aq) = D-tagaturonate(aq) 1.4 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ASH/WAH_1369 60ASH/WAH enzymatic assay and spectrophotometry B 5.3.1.12 glucuronate isomerase C00191 = C00905 D-glucuronate(aq) = D-fructuronate(aq) 0.82 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62BLA_243 62BLA spectrophotometry D 1.2.1.11 aspartate-semialdehyde dehydrogenase C00441 + C00006 + C00009 = C03082 + C00005 L-aspartate-4-semialdehyde(aq) + NADP(aq) + orthophosphate(aq) = L-4-aspartyl phosphate(aq) + NADPH(aq) 33 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53LYN/OCH_116 53LYN/OCH D 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0019 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/EGG_315 69VEE/EGG fluorimetry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.0156 311.15 0.25 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06TAN/SUR_1609 06TAN/SUR chromatography C 2.3.1.169 CO-methylating acetyl-CoA synthase C00024 + C06021 = C00237 + C06020 + C00010 acetyl-CoA(aq) + corrinoid protein(aq) = carbon monoxide(aq) + methylcorrinoid protein(aq) + CoA(aq) 5.0e-05 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57KAR/GRE_347 57KAR/GRE spectrophotometry B 2.1.2.1 glycine hydroxymethyltransferase C00037 + C00084 = C00188 glycine(aq) + acetaldehyde(aq) = L-threonine(aq) 56 310.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_908 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C05402 + C00001 = C00124 + C00031 -D-melibiose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 40 318.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_907 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C05402 + C00001 = C00124 + C00031 -D-melibiose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 53 318.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KAT/SUE_222 83KAT/SUE spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.045 298.15 7.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KAT/SUE_222 83KAT/SUE spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.037 298.15 7.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KAT/SUE_222 83KAT/SUE spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.046 298.15 8.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KAT/SUE_222 83KAT/SUE spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.038 298.15 8.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KAT/SUE_222 83KAT/SUE spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.039 298.15 7.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_903 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 -isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 81 318.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62BRU/JOU_1118 62BRU/JOU radioactivity and spectrophotometry A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.096 310.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_753 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 8900 311.15 6.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_753 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 83000 311.15 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_753 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 1500 311.15 6.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 28 311.15 0.25 6.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 41 311.15 0.25 6.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 45 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 61 311.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 58 311.15 0.25 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 59 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 71 311.15 0.25 7.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 35 311.15 0.25 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 68 311.15 0.25 6.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 41 311.15 0.25 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 78 311.15 0.25 7.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 7.1e-06 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00029 298.15 8.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00015 298.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 5.0e-05 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00033 298.15 8.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0002 298.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 3.1e-05 298.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 9.6e-06 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00029 298.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 980 303.15 7.3 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1280 303.15 8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 300 303.15 8 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 152 303.15 8 1.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 650 303.15 8 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 330 303.15 8 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 158 303.15 8 1.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 126 303.15 8 1.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 184 303.15 8 1.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2820 303.15 8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1050 303.15 8 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 330 303.15 8 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 228 303.15 8 1.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 116 303.15 8 1.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 195 303.15 8 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2230 303.15 8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 495 303.15 8 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3300 303.15 7.3 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 144 303.15 8 1.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1870 303.15 8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 536 303.15 8 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 536 303.15 8 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 420 303.15 8 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 772 303.15 8 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 215 303.15 8 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 255 303.15 8 2.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1500 303.15 7.3 2.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 167 303.15 8 1.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_770 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 62 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1281 43MEY/JUN chemical analysis and polarimetry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 24 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1281 43MEY/JUN chemical analysis and polarimetry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 25 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1281 43MEY/JUN chemical analysis and polarimetry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 21 312.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86KIM/LEE_601 86KIM/LEE C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.011 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE_1163 53KRE polarimetry and manometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 14.7 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MCN/DAM_1429 64MCN/DAM radioactivity C 5.5.1.3 tetrahydroxypteridine cycloisomerase C03178 = C03314 tetrahydroxypteridine(aq) = xanthine-8-carboxylate(aq) 620 296.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE_1160 53KRE polarimetry and manometry A 4.2.1.3 aconitate hydratase C00311 = C00417 + C00001 isocitrate(aq) = cis-aconitate(aq) + H2O(l) 0.47 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/VEL_692 74GUY/VEL enzymatic assay and spectrophotometry A 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.22 311.15 0.25 7.07 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89SAN/SIN_1362 89SAN/SIN enzymatic assay + spectrophotometry C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.37 303.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71RUD/JOH_833 71RUD/JOH calorimetry B 3.1.4.1 phosphodiesterase I C00968 + C00001 = C00360 2'-deoxyadenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = 2'-deoxyadenosine 5'-monophosphate(aq) 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71RUD/JOH_834 71RUD/JOH calorimetry B 3.1.4.1 phosphodiesterase I C00943 + C00001 = C00130 inosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = IMP(aq) 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STA_395 55STA spectrophotometry C 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0135 301.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55WIL/MCI_1208 55WIL/MCI chemical analysis C 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.023 310.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62CHA/VEI_72 62CHA/VEI spectrophotometry B 1.1.1.14 L-iditol dehydrogenase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.021 296.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61LED_488 61LED fluorescence and chemical analysis C 2.5.1.3 thiamin-phosphate pyrophosphorylase C04752 + C04327 = C00013 + C01081 2-methyl-4-amino-5-hydroxymethylpyrimidine diphosphate(aq) + 4-methyl-5-(2-phosphonoxyethyl)-thiazole(aq) = pyrophosphate(aq) + thiamine monophosphate(aq) 6 310.15 9.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73SOM/COS_1418 73SOM/COS chromatography and radioactivity C 5.4.3.5 D-ornithine 4,5-aminomutase C00515 = C03943 D-ornithine(aq) = D-threo-2,4-diaminopentanoate(aq) 0.9 310.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78RAO/COH_650 78RAO/COH NMR B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 2.6 277.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54MIT/DAV_1168 54MIT/DAV spectrophotometry C 4.2.1.10 3-dehydroquinate dehydratase C00944 = C02637 + C00001 3-dehydroquinate(aq) = 3-dehydroshikimate(aq) + H2O(l) 15 302.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93WIL/TOO_1708 93WIL/TOO calorimetry A 3.5.1.14 aminoacylase C03519 + C00001 = C00033 + C00079 N-acetyl-L-phenylalanine(aq) + H2O(l) = acetate(aq) + L-phenylalanine(aq) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93WIL/TOO_1702 93WIL/TOO calorimetry A 3.5.1.14 aminoacylase C02712 + C00001 = C00033 + C00073 N-acetyl-L-methionine(aq) + H2O(l) = acetate(aq) + L-methionine(aq) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00471 298.25 7.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00559 304.25 7.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00507 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00669 310.25 7.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00763 316.25 7.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00854 310.15 7.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00331 286.15 7.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00374 292.15 7.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 298.15 7.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 304.15 7.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 310.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 310.15 7.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 310.15 7.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 310.15 7.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86KUP/FER_661 86KUP/FER NMR C 2.7.4.3 adenylate kinase C00002 + C00008 = C03483 + C00020 ATP(aq) + ADP(aq) = adenosine 5'-tetraphosphate(aq) + AMP(aq) 0.1 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02TEW/HAW_1643 02TEW/HAW calorimetry A 4.2.1.10 3-dehydroquinate dehydratase C00944 = C02637 + C00001 3-dehydroquinate(aq) = 3-dehydroshikimate(aq) + H2O(l) 298.15 0.069 7.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02TEW/HAW_1642 02TEW/HAW calorimetry A 4.6.1.3 3-dehydroquinate synthase C04691 = C00944 + C00009 2-dehydro-3-deoxy-D-arabino-heptonate 7-phosphate(aq) = 3-dehydroquinate(aq) + orthophosphate(aq) 298.15 0.07 7.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02TEW/HAW_1641 02TEW/HAW chromatography A 4.6.1.3 3-dehydroquinate synthase C00944 = C02637 + C00001 3-dehydroquinate(aq) = 3-dehydroshikimate(aq) + H2O(l) 4.6 298.15 0.065 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_513 98TEW/KIS HPLC A 2.6.1.2 alanine aminotransferase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.72 298.15 6.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_513 98TEW/KIS HPLC A 2.6.1.2 alanine aminotransferase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.78 298.15 7.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_517 98TEW/KIS HPLC A 2.6.1.5 tyrosine aminotransferase C00082 + C00026 = C01179 + C00025 L-tyrosine(aq) + 2-oxoglutarate(aq) = 4-hydroxyphenylpyruvate(aq) + L-glutamate(aq) 0.876 298.15 7.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_517 98TEW/KIS HPLC A 2.6.1.5 tyrosine aminotransferase C00082 + C00026 = C01179 + C00025 L-tyrosine(aq) + 2-oxoglutarate(aq) = 4-hydroxyphenylpyruvate(aq) + L-glutamate(aq) 0.88 298.15 7.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_516 98TEW/KIS calorimetry A 2.6.1.5 tyrosine aminotransferase C00079 + C00026 = C00166 + C00025 L-phenylalanine(aq) + 2-oxoglutarate(aq) = phenylpyruvate(aq) + L-glutamate(aq) 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_515 98TEW/KIS HPLC A 2.6.1.5 tyrosine aminotransferase C00079 + C00026 = C00166 + C00025 L-phenylalanine(aq) + 2-oxoglutarate(aq) = phenylpyruvate(aq) + L-glutamate(aq) 1.069 298.15 7.57 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_515 98TEW/KIS HPLC A 2.6.1.5 tyrosine aminotransferase C00079 + C00026 = C00166 + C00025 L-phenylalanine(aq) + 2-oxoglutarate(aq) = phenylpyruvate(aq) + L-glutamate(aq) 1.024 298.15 7.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_514 98TEW/KIS calorimetry A 2.6.1.2 alanine aminotransferase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 298.15 7.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_518 98TEW/KIS calorimetry A 2.6.1.5 tyrosine aminotransferase C00082 + C00026 = C01179 + C00025 L-tyrosine(aq) + 2-oxoglutarate(aq) = 4-hydroxyphenylpyruvate(aq) + L-glutamate(aq) 298.15 7.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02KIM/BAK_1570 02KIM/BAK spectrophotometry B 2.6.1.37 (2-aminoethyl)phosphonate-pyruvate transferase C03557 + C00022 = C03167 + C00041 (2-aminoethyl)phosphonate(aq) + pyruvate(aq) = 2-phosphonoacetaldehyde(aq) + L-alanine(aq) 0.5 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64AVI_424 64AVI spectrophotometry B 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 1.6 303.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53COH_1294 53COH spectrophotometry C 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.18 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1153 85GAJ/GOL gas chromatography A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.16 298.15 7.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1153 85GAJ/GOL gas chromatography A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 2.66 320.05 7.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1153 85GAJ/GOL gas chromatography A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.25 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1153 85GAJ/GOL gas chromatography A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.28 309.41 7.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1153 85GAJ/GOL gas chromatography A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.14 298.15 7.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64SAT/TSU_1298 64SAT/TSU polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1 323.15 7.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70ALB_670 70ALB enzymatic assay B 2.7.4.10 nucleoside-triphosphate-adenylate kinase C00044 + C00020 = C00008 + C00035 GTP(aq) + AMP(aq) = ADP(aq) + GDP(aq) 0.82 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1078 56POD/MOR calorimetry B 3.6.1.32 myosin ATPase C00081 + C00001 = C00104 + C00009 ITP(aq) + H2O(l) = IDP(aq) + orthophosphate(aq) 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 292.2 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67GRO_1088 67GRO spectrophotometry B 4.1.2.4 deoxyribose-phosphate aldolase C00673 = C00118 + C00084 2-deoxy-D-ribose 5-phosphate(aq) = D-glyceraldehyde 3-phosphate(aq) + acetaldehyde(aq) 0.00025 295.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.64 303.15 7.4 2.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 2.19 303.15 7.4 1.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.05 303.15 7.4 3.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 2 303.15 7.4 1.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.28 303.15 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.14 303.15 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.26 303.15 7.4 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.41 303.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.84 303.15 7.4 2.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 2.14 303.15 7.4 1.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.43 303.15 7.4 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.4 303.15 7.4 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.66 303.15 7.4 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.53 303.15 7.4 2.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.92 303.15 7.4 1.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.17 303.15 7.4 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.76 303.15 7.4 2.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 0.97 303.15 7.4 3.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67HIR/GRE_538 67HIR/GRE spectrophotometry and radioactivity D 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 0.15 298.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68MIZ/WEE_1200 68MIZ/WEE enzymatic assay and spectrophotometry C 4.2.1.58 crotonoyl-[acyl-carrier-protein] hydratase C04618 = C04246 + C00001 (3R)-3-hydroxybutanoyl-[acyl-carrier protein](aq) = cis-but-2-enoyl-[acyl-carrier protein](aq) + H2O(l) 0.32 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83BRA_33 83BRA calorimetry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 298.15 8.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_901 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00713 + 2 C00001 = 3 C00031 panose(aq) + 2 H2O(l) = 3 D-glucose(aq) 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ICH/FUR_1238 60ICH/FUR B 5.1.1.5 lysine racemase C00047 = C00739 L-lysine(aq) = D-lysine(aq) 1 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TAV/LEE_483 87TAV/LEE NMR B 2.4.2.10 orotate phosphoribosyltransferase C01103 + C00013 = C00295 + C00119 orotidine 5'-phosphate(aq) + pyrophosphate(aq) = orotate(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 1.4 301.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79VAN_1688 79VAN radioactivity C 3.6.1.a inosine triphosphate pyrophosphohydrolase C00081 + C00001 = C00130 + C00013 ITP(aq) + H2O(l) = IMP(aq) + pyrophosphate(aq) 38000 303.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75SCH/GRE_218 75SCH/GRE spectrophotometry C 1.1.1.141 15-hydroxyprostaglandin dehydrogenase (NAD+) C00584 + C00003 = C04707 + C00004 prostaglandin E2(aq) + NAD(aq) = 15-oxo-prostaglandin E2(aq) + NADH(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75SCH/GRE_218 75SCH/GRE spectrophotometry C 1.1.1.141 15-hydroxyprostaglandin dehydrogenase (NAD+) C00584 + C00003 = C04707 + C00004 prostaglandin E2(aq) + NAD(aq) = 15-oxo-prostaglandin E2(aq) + NADH(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82BAR/HEB_1277 82BAR/HEB C 5.1.3.18 GDP-D-mannose 3,5-epimerase C00096 = C02280 GDPmannose(aq) = GDP-L-galactose(aq) 0.52 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0023 311.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0925 311.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.191 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.138 311.15 9.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.365 311.15 9.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0061 311.15 9.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0049 311.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0239 311.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.039 311.15 8.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69WAN/BAR_1191 69WAN/BAR spectrophotometry C 4.2.1.34 (S)-2-methylmalate dehydratase C02614 = C01732 + C00001 (S)-2-methylmalate(aq) = 2-methylfumarate(aq) + H2O(l) 0.17 298.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61PRA_624 61PRA C 2.7.3.4 taurocyamine kinase C00002 + C01959 = C00008 + C03149 ATP(aq) + taurocyamine(aq) = ADP(aq) + N-w-phosphotaurocyamine(aq) 0.53 303.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80PET/AMI_503 80PET/AMI spectrophotometry C 1.1.1.37&2.6.1.1 malate dehydrogenase and aspartate transaminase C00025 + C00149 + C00003 = C00049 + C00026 + C00004 L-glutamate(aq) + (S)-malate(aq) + NAD(aq) = L-aspartate(aq) + 2-oxoglutarate(aq) + NADH(aq) 4.1e-05 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BRA/JAR_217 75BRA/JAR spectrophotometry B 1.1.1.141 15-hydroxyprostaglandin dehydrogenase (NAD+) C04741 + C00003 = C04654 + C00004 prostaglandin E1(aq) + NAD(aq) = 15-oxo-prostaglandin E1(aq) + NADH(aq) 0.065 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BRA/JAR_217 75BRA/JAR spectrophotometry B 1.1.1.141 15-hydroxyprostaglandin dehydrogenase (NAD+) C04741 + C00003 = C04654 + C00004 prostaglandin E1(aq) + NAD(aq) = 15-oxo-prostaglandin E1(aq) + NADH(aq) 0.65 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BRA/JAR_217 75BRA/JAR spectrophotometry B 1.1.1.141 15-hydroxyprostaglandin dehydrogenase (NAD+) C04741 + C00003 = C04654 + C00004 prostaglandin E1(aq) + NAD(aq) = 15-oxo-prostaglandin E1(aq) + NADH(aq) 6.5 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DAV/GIL_82 55DAV/GIL enzymatic assay and spectrophotometry C 1.1.1.25 shikimate dehydrogenase C00493 + C00006 = C02652 + C00005 shikimate(aq) + NADP(aq) = 5-dehydroshikimate(aq) + NADPH(aq) 0.18 303.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DAV/GIL_82 55DAV/GIL enzymatic assay and spectrophotometry C 1.1.1.25 shikimate dehydrogenase C00493 + C00006 = C02652 + C00005 shikimate(aq) + NADP(aq) = 5-dehydroshikimate(aq) + NADPH(aq) 0.036 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DAV/GIL_81 55DAV/GIL spectrophotometry D 1.1.1.24 quinate dehydrogenase C00296 + C00003 = C00944 + C00004 quinate(aq) + NAD(aq) = 5-dehydroquinate(aq) + NADH(aq) 0.00461 305.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK2_90 68KOH/JAK2 spectrophotometry C 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 2.4e-07 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 320 308.15 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 214 308.15 5 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 100 308.15 6 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 120 308.15 6.1 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 100 308.15 6.1 1.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 96 308.15 6.1 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 74 308.15 6.1 0.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 63 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 2.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 61 308.15 7 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 63 308.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 61 308.15 7 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 0.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 21 308.15 7 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 58 308.15 7.2 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 29 308.15 7.2 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 45 308.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47 308.15 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 45 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 53 308.15 8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 53 308.15 8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 12 308.15 8 3.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47 308.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47 308.15 10 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 490 298.2 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 500 303.5 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 490 308.2 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 400 313.4 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 490 313.4 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 140 308.15 6.1 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47 308.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 530 311 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49 308.15 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 550 308.2 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 83 308.15 6.1 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 530 303.5 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 140 308.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 440 311 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 156 308.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 156 308.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 42 308.15 8 3.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 45 308.15 7.8 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 110 308.15 6.1 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 39 308.15 7 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7.2 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 620 298.2 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 120 308.15 6.1 2.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 2.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 46 308.15 7 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97YOR/ISH_540 97YOR/ISH spectrophotometry B 2.6.1.- polyamine aminotransferase C00041 + C05665 = C00022 + C00986 L-alanine(aq) + 3-aminopropionaldehyde(aq) = pyruvate(aq) + 1,3-diaminopropane(aq) 2.9 303.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67BAR_1134 67BAR spectrophotometry C 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 8.3 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64WIL/HOG_1252 64WIL/HOG spectrophotometry B 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.289 300.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64WIL/HOG_1252 64WIL/HOG spectrophotometry B 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.278 300.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63EDM/WRI_195 63EDM/WRI spectrophotometry B 1.1.1.67 mannitol dehydrogenase C00392 + C00003 = C00095 + C00004 D-mannitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.056 310.15 8.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SCH/GIF_59 91SCH/GIF spectrophotometry C 1.1.1.14 L-iditol dehydrogenase C01697 + C00003 = C00795 + C00004 galactitol(aq) + NAD(aq) = D-tagatose(aq) + NADH(aq) 0.013 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78ROS/DUB_1604 78ROS/DUB radioactivity C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 12.7 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95SCH/TRA_581 95SCH/TRA radioactivity C 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.00015 277.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BAR_40 69BAR spectrophotometry C 1.1.1.6 glycerol dehydrogenase C00116 + C00003 = C00184 + C00004 glycerol(aq) + NAD(aq) = dihydroxyacetone(aq) + NADH(aq) 0.014 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50OES/MEY_1283 50OES/MEY spectrophotometry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 22 311.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 4.23 298.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.73 298.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.27 298.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.73 308.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.6 308.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.08 308.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.22 308.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 2.54 298.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.98 308.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.81 308.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.84 298.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.33 298.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MAN/LAN_336 75MAN/LAN calorimetry C 1.14.14.3 alkanal monooxygenase (FMN-linked) C02278 + C01847 + C00007 = C02679 + C00061 + C00001 dodecanal(aq) + FMN(reduced) + O2(aq) = dodecanoic acid(aq) + FMN(oxidized) + H2O(l) 280.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MAN/LAN_336 75MAN/LAN calorimetry C 1.14.14.3 alkanal monooxygenase (FMN-linked) C02278 + C01847 + C00007 = C02679 + C00061 + C00001 dodecanal(aq) + FMN(reduced) + O2(aq) = dodecanoic acid(aq) + FMN(oxidized) + H2O(l) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91PAR/HOR_1594 91PAR/HOR chromatography B 3.2.2.2 inosine nucleosidase C00294 + C00001 = C00262 + C00121 inosine(aq) + H2O(l) = hypoxanthine(aq) + D-ribose(aq) 106 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 290000 311.15 0.25 6.39 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 409000 311.15 0.25 6.52 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 697000 311.15 0.25 6.75 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 595000 311.15 0.25 6.79 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1230000 311.15 0.25 7.2 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1730000 311.15 0.25 7.28 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1030000 311.15 0.25 7.1 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1090000 311.15 0.25 7.1 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 6750000 311.15 0.25 6.94 1.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 2260000 311.15 0.25 7.11 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 773000 311.15 0.25 6.82 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 733000 311.15 0.25 6.91 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 5400000 311.15 0.25 7 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 3110000 311.15 0.25 7.06 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1340000 311.15 0.25 6.82 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1290000 311.15 0.25 7.09 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1530000 311.15 0.25 7.08 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1140000 311.15 0.25 7.05 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 2420000 311.15 0.25 7.35 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1800000 311.15 0.25 7.22 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 992000 311.15 0.25 6.36 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 992000 311.15 0.25 6.36 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1310000 311.15 0.25 6.81 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 418000 311.15 0.25 6.42 2.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1127 73GUY/GEL spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.168 311.15 0.25 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1127 73GUY/GEL spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.314 311.15 0.25 7 2.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1127 73GUY/GEL spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.877 311.15 0.25 7 3.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1127 73GUY/GEL spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.592 311.15 0.25 7 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1127 73GUY/GEL spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.909 311.15 0.25 7 2.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52LEL/CAR_1260 52LEL/CAR paper chromatography and chemical analysis C 5.1.3.2&2.7.7.12 UDPglucose 4-epimerase and UDPglucose-hexose 1-phosphate uridylyltransferase C03384 = C00103 -D-galactose 1-phosphate(aq) =-D-glucose 1-phosphate(aq) 3 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61VEN/RAC_373 61VEN/RAC enzymatic assay B 2.2.1.2 transaldolase C05382 + C00118 = C00279 + C00085 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phosphate(aq) + D-fructose 6-phosphate(aq) 1.05 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1273 92KRA A 5.1.3.8 N-acylglucosamine 2-epimerase C00140 = C00645 N-acetyl-D-glucosamine(aq) = N-acetyl-D-mannosamine(aq) 0.201 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KIS/TEW_988 99KIS/TEW calorimetry A 3.5.1.1 asparaginase C00152 + C00001 = C00049 + C00014 L-asparagine(aq) + H2O(l) = L-aspartate(aq) + ammonia(aq) 298.15 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36LEH_614 36LEH chemical analysis C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.323 293.15 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.09e-06 303.65 6.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.06e-06 303.65 7.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.17e-06 303.65 7.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.08e-06 303.65 7.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.3e-06 303.65 7.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.44e-06 303.65 7.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.88e-05 303.65 8.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 9.67e-05 303.65 8.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 9.95e-06 303.65 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 3.47e-07 303.65 6.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.2e-05 303.65 8.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.21e-05 303.65 8.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.47e-06 303.65 7.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96OES/SCH_1410 96OES/SCH enzymatic assay and spectrophotometry B 5.4.2.6 _-phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 3.7 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00049 303.15 7.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000386 303.15 7.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000179 303.15 8.31 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00413 303.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000429 303.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00152 303.15 8.31 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000735 303.15 7.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000685 303.15 7.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00208 303.15 8.31 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00045 303.15 7.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00495 303.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000552 303.15 7.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96OES/SCH_1415 96OES/SCH enzymatic assay and spectrophotometry B 5.4.2.8 phosphomannomutase C00636 = C00275 D-mannose 1-phosphate(aq) = D-mannose 6-phosphate(aq) 1 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GAU/MAI_1271 74GAU/MAI radioactivity B 5.1.3.6 UDPglucuronate 4-epimerase C00167 = C00617 UDP-D-glucuronate(aq) = UDP-D-galacturonate(aq) 2.6 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65CHI/FEI_1110 65CHI/FEI spectrophotometry C 4.1.2.19 rhamnulose-1-phosphate aldolase C01131 = C00111 + C00424 L-rhamnulose 1-phosphate(aq) = glycerone phosphate(aq) + (S)-lactaldehyde(aq) 0.083 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80LER/COH_619 80LER/COH NMR B 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.17 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81RAO/COH_600 81RAO/COH NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.08 277.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63VIL/LAR_686 63VIL/LAR spectrophotometry C 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 1 303.15 7.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62GRI_1393 62GRI spectrophotometry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.1 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MIT/LAM_1324 53MIT/LAM chromatography and spectrophotometry C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.16 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65SHA/CLE_1383 65SHA/CLE radioactivity C 5.3.3.2 isopentenyl-diphosphate-isomerase C00129 = C00235 isopentenyl diphosphate(aq) = dimethylallyl diphosphate(aq) 6.7 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58WIL/BAN_1068 58WIL/BAN chemical analysis and radioactivity C 2.7.7.4&3.6.1.1 sulfate adenylyltransferase and inorganic pyrophosphatase C00002 + C00059 + C00001 = C00224 + 2 C00009 ATP(aq) + sulfate(aq) + H2O(l) = adenylyl sulfate(aq) + 2 orthophosphate(aq) 6.0e-07 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62CHA/VEI_62 62CHA/VEI spectrophotometry B 1.1.1.14 L-iditol dehydrogenase C00392 + C00003 = C00095 + C00004 D-mannitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 1.43 296.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62CHA/VEI_67 62CHA/VEI spectrophotometry B 1.1.1.14 L-iditol dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.454 296.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62CHA/VEI_64 62CHA/VEI spectrophotometry B 1.1.1.14 L-iditol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.0179 296.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67HER/JEN_721 67HER/JEN spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.067 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0103 298.15 0.25 6.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.465 298.15 0.25 8.2 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0221 278.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0307 298.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0277 298.15 0.25 7.13 2.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0445 298.15 0.25 7 3.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0725 298.15 0.25 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0334 313.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0321 298.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0606 298.15 0.25 7 3.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.174 298.15 0.25 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0282 298.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0903 298.15 0.25 7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0252 288.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0252 298.15 0.25 7 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0173 298.15 0.25 6.7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0299 306.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0215 298.15 0.25 7 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35JAC/TAP_1207 35JAC/TAP polarimetry and chemical analysis C 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0024 278.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35JAC/TAP_1207 35JAC/TAP polarimetry and chemical analysis C 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0076 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70WUR/SCH_1359 70WUR/SCH enzymatic assay B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.28 298.15 6.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/HIR_1215 67WIL/HIR spectrophotometry C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 3 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49BAR_43 49BAR spectrophotometry C 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 7.1e-05 295.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65CAN/FOC_1420 65CAN/FOC enzymatic assay and spectrophotometry B 5.4.99.2 methylmalonyl-CoA mutase C01213 = C00091 (R)-methylmalonyl-CoA(aq) = succinyl-CoA(aq) 18.6 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96PRO/GRO_1258 96PRO/GRO spectrophotometry C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.29 298.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.418 303.15 6 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.413 303.15 7 1.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.245 303.15 7 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.197 303.15 10 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.205 303.15 9 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.303 280.3 7 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.269 303.15 7 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.245 322.6 7 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.272 300.4 7 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.216 303.15 7 1.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.496 303.15 5 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.64 303.15 7 2.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.236 303.15 8 1.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.0411 287.75 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.0664 292.35 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.0655 295.65 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.079 298.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.0383 284.95 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.0764 299.25 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79MCK/TAV_1311 79MCK/TAV polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.06 343.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79MCK/TAV_1311 79MCK/TAV polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.12 353.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79MCK/TAV_1311 79MCK/TAV polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.84 323.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79MCK/TAV_1311 79MCK/TAV polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.33 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 2.09 292.15 7.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 2.47 298.05 7.69 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.11 304.45 7.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 4.48 316.45 7.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.58 309.95 7.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.7 309.95 7.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.61 309.95 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.46 309.95 7.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 1.54 285.65 7.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.74 309.95 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BUR/WAL_1284 68BUR/WAL enzymatic assay C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 22 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=44LIP_572 44LIP chemical analysis C 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.0056 310.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60AGO/ARA_1336 60AGO/ARA spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.179 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60AGO/ARA_1336 60AGO/ARA spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.312 311.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60AGO/ARA_1336 60AGO/ARA spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.227 304.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 5.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 5.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 6.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 6.55 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 5.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 304.65 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 7.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 310.15 6.13 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TAB/SRE_1335 58TAB/SRE enzymatic assay and spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.32 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71JOS/WAK_413 71JOS/WAK B 2.3.1.39 [acyl-carrier-protein] S-malonyltransferase C00083 + C00229 = C00010 + C01209 malonyl-CoA(aq) + acyl-carrier protein(aq) = CoA(aq) + malonyl-[acyl-carrier protein](aq) 0.018 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MUD/KLE_341 66MUD/KLE calorimetry A 2.1.1.3 thetin-homocysteine S-methyltransferase C03392 + C00155 = C03173 + C00073 dimethylacetothetin(aq) + L-homocysteine(aq) = S-methylthioglycolate(aq) + L-methionine(aq) 297.15 7.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 9.62e-05 282.95 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 5.8e-05 297.65 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 5.59e-05 298.28 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 3.07e-05 309.7 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 7.15e-05 294.58 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 5.34e-05 301.06 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 6.64e-05 295.26 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MUD/KLE_344 66MUD/KLE calorimetry A 2.1.1.3 thetin-homocysteine S-methyltransferase C01008 + C00155 = C00580 + C00073 trimethylsulfonium(aq) + L-homocysteine(aq) = dimethylsulfide(aq) + L-methionine(aq) 297.15 7.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MUD/KLE_345 66MUD/KLE calorimetry A 2.1.1.10 homocysteine S-methyltransferase C00019 + C00155 = C00021 + C00073 S-adenosyl-L-methionine(aq) + L-homocysteine(aq) = S-adenosyl-L-homocysteine(aq) + L-methionine(aq) 297.15 7.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TAB/SRE_1247 58TAB/SRE enzymatic assay and spectrophotometry B 5.1.3.1 ribulose-phosphate 3-epimerase C00199 = C00231 D-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 3 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71SHI/SUG_669 71SHI/SUG spectrophotometry C 2.7.4.8 guanylate kinase C00002 + C00362 = C00008 + C00361 ATP(aq) + dGMP(aq) = ADP(aq) + dGDP(aq) 0.28 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71SHI/SUG_667 71SHI/SUG spectrophotometry C 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 0.24 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84RAG/LJU_303 84RAG/LJU spectrophotometry D 1.5.1.15 methylenetetrahydrofolate dehydrogenase (NAD+) C00143 + C00003 = C00445 + C00004 5,10-methylenetetrahydrofolate(aq) + NAD(aq) = 5,10-methenyltetrahydrofolate(aq) + NADH(aq) 2 298.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65ANN/KOS_1382 65ANN/KOS NMR D 5.3.2.2 oxaloacetate tautomerase C00036 = C03981 keto-oxaloacetate(aq) = enol-oxaloacetate(aq) 0.1 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84PAU_317 84PAU calorimetry B 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56RAT/ROC_364 56RAT/ROC spectrophotometry B 2.1.4.1 glycine amidinotransferase C00062 + C00037 = C00077 + C00581 L-arginine(aq) + glycine(aq) = L-ornithine(aq) + guanidinoacetate(aq) 1.1 311.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53TAL/DOB_178 53TAL/DOB spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 0.032 298.65 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53TAL/DOB_178 53TAL/DOB spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 1.4 298.65 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53TAL/DOB_178 53TAL/DOB spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 89 298.65 9.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53TAL/DOB_178 53TAL/DOB spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 4 298.65 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66SCH/HOR_79 66SCH/HOR spectrophotometry B 1.1.1.21 aldehyde reductase C00379 + C00006 = C00181 + C00005 xylitol(aq) + NADP(aq) = D-xylose(aq) + NADPH(aq) 0.021 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1698 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00121 D-arabinose(aq) = D-ribose(aq) 0.22 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1698 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00121 D-arabinose(aq) = D-ribose(aq) 0.37 333.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1698 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00121 D-arabinose(aq) = D-ribose(aq) 0.4 343.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1698 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00121 D-arabinose(aq) = D-ribose(aq) 0.32 323.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1698 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00121 D-arabinose(aq) = D-ribose(aq) 0.3 313.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1693 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.03 333.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1696 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C06463 D-erythrose(aq) = D-threose(aq) 0.76 343.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1696 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C06463 D-erythrose(aq) = D-threose(aq) 1.1 333.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1696 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C06463 D-erythrose(aq) = D-threose(aq) 1.04 313.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1696 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C06463 D-erythrose(aq) = D-threose(aq) 0.82 323.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1696 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C06463 D-erythrose(aq) = D-threose(aq) 0.96 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1697 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.038 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1697 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.14 343.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1697 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.085 323.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1697 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.067 313.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1697 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.12 333.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1694 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00031 = C00159 D-glucose(aq) = D-mannose(aq) 0.48 333.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1695 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 2.67 333.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1695 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 2.73 323.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1695 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 2.04 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1695 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 2.3 313.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1695 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 3 343.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MCG/BRO_231 78MCG/BRO calorimetry B 1.1.3.6&1.11.1.6 cholesterol oxidase and catalase C00187 + 0.5 C00007 = C00599 + C00001 cholesterol(aq) + 1/2 O2(aq) = cholest-4-en-3-one(aq) + H2O(l) 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81PAH/JAG_294 81PAH/JAG spectrophotometry C 1.5.1.2 pyrroline-5-carboxylate reductase C00148 + C00006 = C03912 + C00005 (S)-proline(aq) + NADP(aq) =D-1-pyrroline-5-carboxylate(aq) + NADPH(aq) 4.3e-05 298.15 9.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEY_1257 84DEY spectrophotometry C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.31 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69LAN/DEK_93 69LAN/DEK chromatography and spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C05984 + C00003 = C00109 + C00004 2-hydroxybutanoate(aq) + NAD(aq) = 2-oxobutanoate(aq) + NADH(aq) 0.003 298.65 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69LAN/DEK_93 69LAN/DEK chromatography and spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C05984 + C00003 = C00109 + C00004 2-hydroxybutanoate(aq) + NAD(aq) = 2-oxobutanoate(aq) + NADH(aq) 0.03 298.65 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1340 308.15 6 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 15000 308.15 6.1 2.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1300 308.15 6.1 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 420 308.15 6.1 1.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 130 308.15 6.1 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 838 308.15 6.53 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 301 308.15 6.97 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 290 308.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 160 308.15 7 1.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 100 308.15 7 1.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 14 308.15 7.2 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1400 308.15 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 330 308.15 7.8 2.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 83 308.15 7.8 1.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 112 308.15 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 346 308.15 8 3.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 218 293.2 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 158 299.9 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 128 302.3 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 256 308.15 7.2 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 73 308.15 6.1 0.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 73 308.15 6.1 0.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 590 308.15 7.8 2.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 0.9 308.15 7 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3100 308.15 6.1 2.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1600 308.15 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 458 302.3 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 127 308.15 8.83 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3700 308.15 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 180 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 313 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 20000 308.15 7 3.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 357 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 867 293.2 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 0.2 308.15 8 3.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 549 299.9 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 58 308.15 7 1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3900 308.15 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 82 313.2 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 490 308.15 7 2.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 184 308.15 7.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 100 308.15 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 100 308.15 7.8 1.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75SCH/RIF_150 75SCH/RIF spectrophotometry B 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.03 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75WYR/GRI_223 75WYR/GRI spectrophotometry C 1.1.1.194 coniferyl-alcohol dehydrogenase C00590 + C00006 = C02666 + C00005 coniferyl alcohol(aq) + NADP(aq) = coniferyl aldehyde(aq) + NADPH(aq) 0.28 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75WYR/GRI_223 75WYR/GRI spectrophotometry C 1.1.1.194 coniferyl-alcohol dehydrogenase C00590 + C00006 = C02666 + C00005 coniferyl alcohol(aq) + NADP(aq) = coniferyl aldehyde(aq) + NADPH(aq) 0.18 303.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75WYR/GRI_223 75WYR/GRI spectrophotometry C 1.1.1.194 coniferyl-alcohol dehydrogenase C00590 + C00006 = C02666 + C00005 coniferyl alcohol(aq) + NADP(aq) = coniferyl aldehyde(aq) + NADPH(aq) 1.8 303.15 8.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_109 80COO/BLA spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00045 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_819 49MEY/GRE chemical analysis C 3.1.3.2 acid phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 260 311.15 5.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 2900 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 800 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 1000 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 2700 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 4800 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 2800 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 303.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71TAK/KUR_1230 71TAK/KUR chromatography, fluorimetry, and radioactivity C 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.255 303.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAK/HIR_898 65TAK/HIR calorimetry A 3.2.1.3 glucan 1,4--glucosidase C01835 + 2 C00001 = 3 C00031 maltotriose(aq) + 2 H2O(l) = 3 D-glucose(aq) 298.15 4.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43KRE/EGG_1156 43KRE/EGG polarimetry and manometry B 4.2.1.3 aconitate hydratase C00158 = C00417 + C00001 citrate(aq) = cis-aconitate(aq) + H2O(l) 0.048 298.15 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.3 293.15 9.02 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.35 293.15 9.02 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.01 303.15 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.01 303.15 7.4 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.037 303.15 8 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.038 303.15 8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.078 303.15 8 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.22 303.15 8.9 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.78 303.15 8.9 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 1.3 303.15 9.8 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 2.7 303.15 9.8 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.12 303.15 8.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.17 303.15 8.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.18 303.15 8.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.88 303.15 8.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.52 311.15 8.82 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0096 303.15 7.4 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.19 311.15 8.82 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.032 303.15 7.4 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.29 303.15 8.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 1.4 303.15 9.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 1.4 303.15 9.8 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.18 311.15 8.82 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.61 303.15 8.9 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.044 303.15 8 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.22 311.15 8.82 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.78 293.15 9.02 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 1.7 303.15 9.8 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.24 303.15 8.9 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.31 293.15 9.02 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.29 303.15 8.9 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BED/TES_20 87BED/TES spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00024 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MIL/LUK_1225 59MIL/LUK spectrophotometry, chromatography, and radioactivity C 4.3.2.2 adenylosuccinate lyase C04823 = C00122 + C04677 1-(5'-Phosphoribosyl)-5-amino-4-(N-succinocarboxamide)-imidazole = Fumarate + 1-(5'-Phosphoribosyl)-5-amino-4-imidazolecarboxamide 0.0023 310.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.37 293.15 6 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.36 293.15 6 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.96 293.15 6 3.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.24 293.15 6 3.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.09 293.15 6 3.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.47 293.15 6 2.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.76 293.15 6 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.52 293.15 6 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.68 293.15 6 2.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06ONO/YAN_1593 06ONO/YAN chromatography B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1 310.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58FRO2_187 58FRO2 spectrophotometry B 1.1.1.56 ribitol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.0096 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58FRO2_187 58FRO2 spectrophotometry B 1.1.1.56 ribitol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.07 310.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58FRO2_187 58FRO2 spectrophotometry B 1.1.1.56 ribitol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.0031 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67POE/GUT_263 67POE/GUT calorimetry B 1.3.99.1 succinate dehydrogenase 2 C00042 + C00007 = 2 C00122 + 2 C00001 2 succinate(aq) + O2(aq) = 2 fumarate(aq) + 2 H2O(l) 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.000877 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.000826 298.15 7.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.00119 298.15 7.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.00145 298.15 7.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.5 298.15 8.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.01 298.15 7.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.00555 298.15 7.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.000175 298.15 6.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.000935 298.15 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.17 298.15 8.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.071 298.15 7.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73MCC/KOL_1216 73MCC/KOL spectrophotometry and thin layer chromatography C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 0.025 305.3 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73MCC/KOL_1216 73MCC/KOL spectrophotometry and thin layer chromatography C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 0.028 308.2 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73MCC/KOL_1216 73MCC/KOL spectrophotometry and thin layer chromatography C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 0.04 311.3 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73MCC/KOL_1216 73MCC/KOL spectrophotometry and thin layer chromatography C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 0.1 316.4 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73MCC/KOL_1216 73MCC/KOL spectrophotometry and thin layer chromatography C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 0.016 303.2 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89HAG/ROS_1548 89HAG/ROS calorimetry A 3.1.4.35 3 ', 5 '-cyclic-GMP phosphodiesterase C00942 + C00001 = C00144 guanosine 3 ',5 '-cyclic phosphate(aq) + H2O(l) = guanosine 5 '-phosphate(aq) 298.15 7.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56PAL/DOU_1340 56PAL/DOU chemical analysis and spectrophotometry C 5.3.1.7 mannose isomerase C00476 = C00310 D-lyxose(aq) = D-xylulose(aq) 0.39 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56PAL/DOU_1341 56PAL/DOU chemical analysis and spectrophotometry C 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 2.45 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CHE/PAT_837 74CHE/PAT calorimetry B 3.1.4.17 3',5'-cyclic-nucleotide phosphodiesterase C00575 + C00001 = C00020 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = AMP(aq) 298.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65ICH/HIR_1299 65ICH/HIR spectrophotometry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.08 343.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72FOR/GAU_206 72FOR/GAU spectrophotometry C 1.1.1.97 3-hydroxybenzyl-alcohol dehydrogenase C03351 + C00006 = C03067 + C00005 3-hydroxybenzyl alcohol(aq) + NADP(aq) = 3-hydroxybenzaldehyde(aq) + NADPH(aq) 0.18 303.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/EGG_501 69VEE/EGG C 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.151 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CHI/SUG_1391 59CHI/SUG polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.3 298.15 5.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CHI/SUG_1391 59CHI/SUG polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.1 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CHI/SUG_1391 59CHI/SUG polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.25 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CHI/SUG_1391 59CHI/SUG polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 4.9 298.15 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CHI/SUG_1391 59CHI/SUG polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.35 298.15 5.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MER/TOM_5 59MER/TOM spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00854 + C00003 = C00414 + C00004 cyclohexanol(aq) + NAD(aq) = cyclohexanone(aq) + NADH(aq) 0.09 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MER/TOM_5 59MER/TOM spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00854 + C00003 = C00414 + C00004 cyclohexanol(aq) + NAD(aq) = cyclohexanone(aq) + NADH(aq) 0.158 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MER/TOM_5 59MER/TOM spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00854 + C00003 = C00414 + C00004 cyclohexanol(aq) + NAD(aq) = cyclohexanone(aq) + NADH(aq) 19 298.15 9.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79GRI/TAN_1043 79GRI/TAN calorimetry B 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63BER/HOL_396 63BER/HOL spectrophotometry C 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0068 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65PIN_809 65PIN calorimetry A 3.1.3.1 alkaline phosphatase C03149 + C00001 = C01959 + C00009 phosphotaurocyamine(aq) + H2O(l) = taurocyamine(aq) + orthophosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76JES_139 76JES calorimetry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 298.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65PIN_804 65PIN calorimetry A 3.1.3.1 alkaline phosphatase C03166 + C00001 = C00581 + C00009 phosphoguanidinoacetate(aq) + H2O(l) = guanidinoacetate(aq) + orthophosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 2.91 303.15 7.4 1.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 2.46 303.15 7.4 1.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.07 303.15 7.4 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.91 303.15 7.4 3.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.98 303.15 7.4 3.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 2.69 303.15 7.4 1.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.21 303.15 7.4 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.96 303.15 7.4 3.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.31 303.15 7.4 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.09 303.15 7.4 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.56 303.15 7.4 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.96 303.15 7.4 2.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.8 303.15 7.4 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.35 303.15 7.4 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.09 303.15 7.4 2.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.21 303.15 7.4 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.99 303.15 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 2.16 303.15 7.4 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.95 303.15 7.4 3.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.95 303.15 7.4 3.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69LAN/DEK_105 69LAN/DEK spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00048 298.65 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69LAN/DEK_105 69LAN/DEK spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0048 298.65 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86KON/POL_121 86KON/POL spectrophotometry C 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 1.66 298.15 9.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIR_225 81HIR C 1.1.1.- sorbitol-6-phosphate dehydrogenase (NADP+) C01096 + C00006 = C00092 + C00005 D-sorbitol 6-phosphate(aq) + NADP(aq) = D-glucose 6-phosphate(aq) + NADPH(aq) 0.234 303.15 8.66 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66ALB/BAS_687 66ALB/BAS spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.32 303.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79REK/EGO_334 79REK/EGO calorimetry B 1.12.1.2 hydrogen dehydrogenase C00282 + C00003 = C00004 H2(aq) + NAD(aq) = NADH(aq) 298.15 7.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/COO_122 57ROB/COO spectrophotometry B 1.1.1.31 3-hydroxyisobutyrate dehydrogenase C01188 + C00003 = C00349 + C00004 3-hydroxy-2-methylpropanoate(aq) + NAD(aq) = 2-methyl-3-oxopropanoate(aq) + NADH(aq) 0.12 298.15 10 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/COO_122 57ROB/COO spectrophotometry B 1.1.1.31 3-hydroxyisobutyrate dehydrogenase C01188 + C00003 = C00349 + C00004 3-hydroxy-2-methylpropanoate(aq) + NAD(aq) = 2-methyl-3-oxopropanoate(aq) + NADH(aq) 0.036 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/COO_122 57ROB/COO spectrophotometry B 1.1.1.31 3-hydroxyisobutyrate dehydrogenase C01188 + C00003 = C00349 + C00004 3-hydroxy-2-methylpropanoate(aq) + NAD(aq) = 2-methyl-3-oxopropanoate(aq) + NADH(aq) 0.0031 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CAM/SGA_455 80CAM/SGA spectrophotometry B 2.4.2.1 purine-nucleoside phosphorylase C00212 + C00009 = C00147 + C00620 adenosine(aq) + orthophosphate(aq) = adenine(aq) + D-ribose 1-phosphate(aq) 0.00541 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61SAN/ZIN_288 61SAN/ZIN spectrophotometry B 1.4.1.9 leucine dehydrogenase C00123 + C00003 + C00001 = C00233 + C00004 + C00014 L-leucine(aq) + NAD(aq) + H2O(l) = 4-methyl-2-oxopentanoate(aq) + NADH(aq) + ammonia(aq) 0.0111 298.15 11.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KNA/BLA_414 74KNA/BLA spectrophotometry C 2.3.1.54 formate C-acetyltransferase C00024 + C00058 = C00010 + C00022 acetyl-CoA(aq) + formate(aq) = CoA(aq) + pyruvate(aq) 0.00133 303.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55POD/STU_1072 55POD/STU calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BEE/DEL_236 68BEE/DEL spectrophotometry C 1.1.99.13 glucoside 3-dehydrogenase C00243 + 2 C00125 = C05403 + 2 C00126 lactose(aq) + 2 cytochrome c(aq) = 3-oxolactose(aq) + 2 reduced cytochrome c(aq) 6.3 298.15 5.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BLA/WRI3_36 55BLA/WRI3 spectrophotometry C 1.1.1.3 homoserine dehydrogenase C00263 + C00003 = C00441 + C00004 L-homoserine(aq) + NAD(aq) = L-aspartate 4-semialdehyde(aq) + NADH(aq) 0.0088 298.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BLA/WRI3_37 55BLA/WRI3 spectrophotometry C 1.1.1.3 homoserine dehydrogenase C00263 + C00006 = C00441 + C00005 L-homoserine(aq) + NADP(aq) = L-aspartate 4-semialdehyde(aq) + NADPH(aq) 0.00063 298.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52KOR_574 52KOR D 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.013 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63FRI/SCH_389 63FRI/SCH spectrophotometry B 2.3.1.7 carnitine O-acetyltransferase C00024 + C00318 = C00010 + C02571 acetyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-acetylcarnitine(aq) 1.6 308.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60LEA/GLA_1578 60LEA/GLA radioactivity B 6.1.1.3 threonin-tRNA ligase C00002 + C00188 + C01651 = C00020 + C00013 + C02992 ATP(aq) + L-threonine(aq) + tRNA-Thr(aq) = AMP(aq) + pyrophosphate(aq) + L-threonyl-tRNA-Thr(aq) 0.37 310.16 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DAR_496 45DAR spectrophotometry C 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.18 298.15 7.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77REH/JAN_320 77REH/JAN calorimetry B 1.7.3.3&1.11.1.6 urate oxidase and catalase C00366 + 0.5 C00007 + 2 C00001 = C01551 + C00288 urate(aq) + 1/2 O2(aq) + 2 H2O(l) = allantoin(aq) + carbon dioxide(aq) 303.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67LOM/GRE_1059 67LOM/GRE spectrophotometry C 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 1.84 298.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.6 311.15 0.25 6.86 3.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.3 311.15 0.25 6.83 3.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.5 311.15 0.25 6.66 2.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.6 311.15 0.25 6.65 2.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.3 311.15 0.25 6.79 2.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.8 311.15 0.25 6.57 2.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.8 311.15 0.25 6.68 2.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.4 311.15 0.25 6.72 2.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11 311.15 0.25 6.7 2.04 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.8 311.15 0.25 6.48 1.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.9 311.15 0.25 6.65 1.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.3 311.15 0.25 6.63 1.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.7 311.15 0.25 6.76 3.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.7 311.15 0.25 6.78 3.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.3 311.15 0.25 6.76 2.33 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11 311.15 0.25 6.48 1.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72NEL/KIE_330 72NEL/KIE calorimetry A 1.11.1.6 catalase C00027 = 0.5 C00007 + C00001 H2O2(aq) = 1/2 O2(aq) + H2O(l) 298.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 6.55 311.15 0.25 8.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.138 298.15 0.25 6.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.13 298.15 0.25 6.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.267 298.15 0.25 7.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.27 298.15 0.25 7.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.579 298.15 0.25 7.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.36 298.15 0.1 7.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.349 298.15 0.35 7.21 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.334 298.15 0.6 7.14 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.16 298.15 1.1 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.264 298.15 1.1 7.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.051 311.15 0.25 6.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.141 311.15 0.25 6.73 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.129 311.15 0.25 6.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.15 311.15 0.25 6.84 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.139 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.197 311.15 0.25 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.26 311.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.116 311.15 0.25 7.05 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.266 311.15 0.25 7.06 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.34 311.15 0.25 7.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.34 311.15 0.25 7.07 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.257 311.15 0.25 7.16 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.268 311.15 0.25 7.17 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.309 311.15 0.25 7.25 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.385 311.15 0.25 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.498 311.15 0.25 7.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.634 311.15 0.25 7.58 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 3.55 311.15 0.25 8.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 3.55 311.15 0.25 8.39 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.271 311.15 0.25 7.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.321 311.15 0.25 7.24 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 2.37 311.15 0.25 8.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.329 298.15 0.25 7.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 2.04 311.15 0.25 8.12 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.1 298.15 0.12 6.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.067 311.15 0.25 6.41 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.187 311.15 0.25 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 3.86 311.15 0.25 8.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.294 298.15 0.25 7.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.287 298.15 0.35 7.19 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.088 311.15 0.25 6.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.088 311.15 0.25 6.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.253 298.15 0.6 7.11 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.143 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.105 311.15 0.25 7.07 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 2.75 311.15 0.25 8.29 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.445 298.15 0.25 7.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.338 298.15 0.35 7.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.141 311.15 0.25 6.75 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.271 311.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.351 311.15 0.25 7.23 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.328 311.15 0.25 7.09 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.62 311.15 0.25 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.138 311.15 0.25 6.79 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66HOR/HEN_474 66HOR/HEN C 2.4.2.7 adenine phosphoribosyltransferase C00147 + C00119 = C00020 + C00013 adenine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) = AMP(aq) + pyrophosphate(aq) 290 303.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 7.46 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 7.79 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 7.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 7.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 8.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 7.67 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 310.25 7.86 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 6.47 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 304.65 7.87 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83BRA_18 83BRA calorimetry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 298.15 8.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61GOT/KOR_191 61GOT/KOR spectrophotometry B 1.1.1.60 2-hydroxy-3-oxopropionate reductase C00258 + C00003 = C01146 + C00004 (R)-glycerate(aq) + NAD(aq) = 2-hydroxy-3-oxopropanoate(aq) + NADH(aq) 1.9e-06 296.15 7.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61GOT/KOR_191 61GOT/KOR spectrophotometry B 1.1.1.60 2-hydroxy-3-oxopropionate reductase C00258 + C00003 = C01146 + C00004 (R)-glycerate(aq) + NAD(aq) = 2-hydroxy-3-oxopropanoate(aq) + NADH(aq) 1.6e-05 296.15 8.49 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.871 310.15 0.25 6.98 3.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.899 310.15 0.25 6.99 3.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.06 310.15 0.25 6.99 3.08 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.842 310.15 0.25 6.99 2.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.044 310.15 0.25 6.99 3.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.98 310.15 0.25 6.91 2.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.014 310.15 0.25 6.99 3.36 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.964 310.15 0.25 6.89 2.96 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.708 310.15 0.25 6.99 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.983 310.15 0.25 6.91 2.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.929 310.15 0.25 6.97 3.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.981 310.15 0.25 6.97 3.42 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.38 310.15 0.25 6.99 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.946 310.15 0.25 6.98 3.43 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.572 310.15 0.25 6.99 2.35 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.982 310.15 0.25 6.9 2.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/VEL_1404 74GUY/VEL enzymatic assay and spectrophotometry A 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 17.4 311.15 0.25 7.04 3.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GEL/STU_613 60GEL/STU calorimetry A 2.7.3.2&3.6.1.32 creatine kinase and myosin ATPase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59ITO/GRI_1392 59ITO/GRI D 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 8 303.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58LAN/ENG_194 58LAN/ENG spectrophotometry C 1.1.1.62 estradiol 17_-dehydrogenase C00951 + C00003 = C00468 + C00004 estradiol-17(aq) + NAD(aq) = estrone(aq) + NADH(aq) 0.18 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58LAN/ENG_194 58LAN/ENG spectrophotometry C 1.1.1.62 estradiol 17_-dehydrogenase C00951 + C00003 = C00468 + C00004 estradiol-17(aq) + NAD(aq) = estrone(aq) + NADH(aq) 18 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58LAN/ENG_194 58LAN/ENG spectrophotometry C 1.1.1.62 estradiol 17_-dehydrogenase C00951 + C00003 = C00468 + C00004 estradiol-17(aq) + NAD(aq) = estrone(aq) + NADH(aq) 1.8 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58LAN/ENG_194 58LAN/ENG spectrophotometry C 1.1.1.62 estradiol 17_-dehydrogenase C00951 + C00003 = C00468 + C00004 estradiol-17(aq) + NAD(aq) = estrone(aq) + NADH(aq) 180 298.15 10 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87WOL/REI_801 87WOL/REI calorimetry B 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 273.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87WOL/REI_801 87WOL/REI calorimetry B 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 310.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87WOL/REI_801 87WOL/REI calorimetry B 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.012 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.003 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.002 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.004 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0025 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.015 303.15 7 3.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.004 303.15 7 2.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.005 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.01 303.15 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.003 303.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.009 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.005 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.025 303.15 7 4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65DAW/DIC_114 65DAW/DIC spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 6.1e-05 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98CON/DEL_1520 98CON/DEL chromatography B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.21 348.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98CON/DEL_1520 98CON/DEL chromatography B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.39 353.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98CON/DEL_1520 98CON/DEL chromatography B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.99 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98CON/DEL_1520 98CON/DEL chromatography B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.02 338.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98CON/DEL_1520 98CON/DEL chromatography B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.14 343.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_769 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00035 + 2 C00001 = C00387 + 2 C00009 GDP(aq) + 2 H2O(l) = guanosine(aq) + 2 orthophosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_769 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00035 + 2 C00001 = C00387 + 2 C00009 GDP(aq) + 2 H2O(l) = guanosine(aq) + 2 orthophosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_769 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00035 + 2 C00001 = C00387 + 2 C00009 GDP(aq) + 2 H2O(l) = guanosine(aq) + 2 orthophosphate(aq) 298.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ATK/BUR_550 61ATK/BUR electrophoresis and enzymatic assay A 2.7.1.6 galactokinase C00002 + C00124 = C00008 + C03384 ATP(aq) + D-galactose(aq) = ADP(aq) + D-galactose 1-phosphate(aq) 24 298.15 7 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ATK/BUR_550 61ATK/BUR electrophoresis and enzymatic assay A 2.7.1.6 galactokinase C00002 + C00124 = C00008 + C03384 ATP(aq) + D-galactose(aq) = ADP(aq) + D-galactose 1-phosphate(aq) 26 298.15 7 1.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60FEI/NEU_1267 60FEI/NEU electrophoresis and radioactivity B 5.1.3.5 UDParabinose 4-epimerase C00935 = C00190 UDP-L-arabinose(aq) = UDP-D-xylose(aq) 1 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 329 303.15 6.2 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 133 303.15 6.2 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 100 303.15 6.2 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 619 303.15 7.2 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 224 303.15 7.2 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 79 303.15 7.2 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 584 303.15 8 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 413 303.15 8 2.15 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 136 303.15 7.2 2.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 406 303.15 7.2 2.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 345.6 303.15 8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 400 303.15 8 2.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 85.5 303.15 7.2 2.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78SUB_285 78SUB spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 2.91e-06 298.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78SUB_285 78SUB spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 6.37e-06 308.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.046 5.85 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.04 5.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.025 4.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.05 3.72 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.0025 3.62 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.039 5.27 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.005 3.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.014 4.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.025 4.74 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62WIL/SNE_359 62WIL/SNE spectrophotometry B 2.1.2.7 D-alanine 2-hydroxymethyltransferase C02115 + C00101 = C00143 + C00133 + C00001 2-methylserine(aq) + tetrahydrofolate(aq) = 5,10-methylenetetrahydrofolate(aq) + D-alanine(aq) + H2O(l) 3 311.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_101 56KAP/CIO spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0012 303.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.131 282.45 7.65 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.128 282.55 7.621 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.131 282.65 7.621 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.157 285.55 7.653 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.162 285.65 7.653 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.171 286.1 7.663 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.498 309.95 7.548 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.516 310.35 7.547 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.591 313.75 7.516 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.713 314.85 7.565 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.318 298.75 7.581 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.556 311.35 7.546 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.549 310.15 7.552 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.158 285.85 7.653 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66VER/ROD_707 66VER/ROD enzymatic assay and spectrophotometry C 2.7.7.34 glucose-1-phosphate guanylyltransferase C00044 + C00103 = C00394 + C00013 GTP(aq) + D-glucose 1-phosphate(aq) = GDPglucose(aq) + pyrophosphate(aq) 0.25 303.15 7.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_760 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 298.15 8.42 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_760 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 298.15 8.85 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_760 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 304.55 7.78 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_760 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 310.15 7.62 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_760 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 298.15 8.02 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98LIA/QU_1582 98LIA/QU calorimetry B 1.15.1.1 superoxide dismutase 2 C00704 + 2 C00080 = C00007 + C00027 2 O2- + 2 H+ = O2 + H2O2 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64PRE/WOO_699 64PRE/WOO paper chromatography and chemical analysis B 2.7.7.13 mannose-1-phosphate guanylyltransferase C00044 + C00636 = C00096 + C00013 GTP(aq) + D-mannose 1-phosphate(aq) = GDPmannose(aq) + pyrophosphate(aq) 2.5 310.15 8.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1004 98DIE/STR HPLC A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-4-hydroxyphenylglycine(aq) 7.04 298.15 5.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1004 98DIE/STR HPLC A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-4-hydroxyphenylglycine(aq) 17.7 298.15 6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1004 98DIE/STR HPLC A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-4-hydroxyphenylglycine(aq) 2.86 298.15 5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80REK/EGO_239 80REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 6.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80REK/EGO_239 80REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 7.48 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80REK/EGO_239 80REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 8.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80REK/EGO_239 80REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 6.44 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65STI/DIA_810 65STI/DIA paper chromatography and radioactivity D 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 69000 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 41 311.15 0.25 6.89 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 41 311.15 0.25 6.94 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 71 311.15 0.25 7.01 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 78 311.15 0.25 7.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 35 311.15 0.25 6.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 58 311.15 0.25 6.99 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 68 311.15 0.25 6.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 45 311.15 0.25 6.91 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 28 311.15 0.25 6.88 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 59 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 61 311.15 0.25 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=26QUA/WOO_1205 26QUA/WOO chemical analysis C 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.04 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.99 323.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.07 338.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.05 333.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.14 338.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.11 333.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.01 328.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GRE/RUD_840 69GRE/RUD calorimetry A 3.1.4.17 phosphodiesterase I C00942 + C00001 = C00144 guanosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = GMP(aq) 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85HEA/CHU_1549 85HEA/CHU spectrophotometry C 1.2.1.a succinate-semialdehyde reductase C00232 + C00005 = C00989 + C00006 4-oxobutanoate(aq) + NADP(red)(aq) = 4-hydroxybutanoate(aq) + NADP(ox)(aq) 3.7 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65GHO/ROS2_1272 65GHO/ROS2 radioactivity C 5.1.3.8 N-acylglucosamine 2-epimerase C00140 = C00645 N-acetyl-D-glucosamine(aq) = N-acetyl-D-mannosamine(aq) 0.26 310.15 7.6 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.238 298.15 7.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.263 298.15 7.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.282 298.15 7.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.328 298.15 7.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.291 298.15 7.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.27 298.15 7.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.225 298.15 7.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.23 298.15 7.52 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.337 298.15 7.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.136 298.15 7.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.134 298.15 7.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.129 298.15 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 4.36 298.15 8.78 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 4.71 298.15 8.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 5.91 298.15 8.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.223 298.15 7.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.268 298.15 7.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.361 298.15 7.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 5.32 298.15 8.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.308 298.15 7.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 5.76 298.15 8.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 5.76 298.15 8.71 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.251 298.15 7.63 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.0758 298.15 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.109 298.15 7.18 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.33 298.15 7.68 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SOD/OSU_1241 67SOD/OSU manometry and enzymatic assay B 5.1.1.10 amino-acid racemase C00123 = C01570 L-leucine(aq) = D-leucine(aq) 1 310.15 8.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SAK/YOR_470 67SAK/YOR electrophoresis C 2.4.2.2 pyrimidine-nucleoside phosphorylase C00299 + C00009 = C00106 + C00620 uridine(aq) + orthophosphate(aq) = uracil(aq) + D-ribose 1-phosphate(aq) 0.44 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SAK/YOR_470 67SAK/YOR electrophoresis C 2.4.2.2 pyrimidine-nucleoside phosphorylase C00299 + C00009 = C00106 + C00620 uridine(aq) + orthophosphate(aq) = uracil(aq) + D-ribose 1-phosphate(aq) 1 310.15 9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86RAG/CAR_1600 86RAG/CAR chromatography and radioactivity B 2.4.2.28 5 '-methylthioadenosine phosphorylase C00170 + C00009 = C00147 + C04188 5 '-methylthioadenosine(aq) + orthophosphate(aq) = adenine(aq) + 5-methylthio-D-ribose 1-phosphate(aq) 0.0139 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94NOE/COL_197 94NOE/COL HPLC and spectrophotometry B 1.1.1.67 mannitol dehydrogenase C00392 + C00006 = C00095 + C00005 D-mannitol(aq) + NADP(aq) = D-fructose(aq) + NADPH(aq) 0.0917 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELD/DEG_602 89ELD/DEG NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0406 295.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELD/DEG_602 89ELD/DEG NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.033 286.65 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELD/DEG_602 89ELD/DEG NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0417 303.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELD/DEG_602 89ELD/DEG NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0453 308.15 8.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0042 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0043 303.15 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0088 303.15 8.1 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0086 303.15 9.2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0028 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.015 303.15 9.2 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0049 303.15 7 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0059 303.15 7.5 2.28 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.26 310.15 8.5 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.63 310.15 8.5 2 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.2 310.15 8.5 3.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.33 310.15 8.5 2.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.17 310.15 8.5 3.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.13 310.15 8.5 3.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=39COH_504 39COH C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 1 313.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54HEL_1435 54HEL enzymatic assay C 6.2.1.1 acetate-CoA ligase C00002 + C00163 + C00010 = C00020 + C00013 + C00100 ATP(aq) + propanoate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + propanonyl-CoA(aq) 1.15 311.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54HEL_1433 54HEL enzymatic assay C 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 0.86 311.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54HEL_1433 54HEL enzymatic assay C 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 0.86 311.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54HEL_1433 54HEL enzymatic assay C 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 0.86 311.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87OWU/TRE_1003 87OWU/TRE calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87OWU/TRE_1003 87OWU/TRE calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96OES/SCH_1412 96OES/SCH enzymatic assay and spectrophotometry B 5.4.2.8 phosphomannomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 1.4 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83VIT/HUA_1692 83VIT/HUA spectrophotometry B 2.4.2.3 uridine phosphorylase C00299 + C00009 = C00106 + C00620 uridine(aq) + orthophosphate(aq) = uracil(aq) + D-ribose 1-phosphate(aq) 0.58 303.15 7.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GEL/STU_1079 60GEL/STU calorimetry A 2.7.3.2&3.6.1.32 creatine kinase and myosin ATPase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00215 278.05 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00307 288.45 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00511 300.55 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0071 309.45 5.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0091 309.45 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00673 309.45 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0064 309.45 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0067 309.45 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0067 309.45 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0098 309.45 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0098 309.45 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57REI_362 57REI radioactivity C 2.1.3.3 ornithine carbamoyltransferase C00169 + C00077 = C00327 + C00009 carbamoyl phosphate(aq) + L-ornithine(aq) = L-citrulline(aq) + orthophosphate(aq) 100000 310.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61VLA/KOM_827 61VLA/KOM chromatography and radioactivity B 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 673 308.15 7.05 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61VLA/KOM_827 61VLA/KOM chromatography and radioactivity B 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 287 308.15 9.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80FUK/OBO_1256 80FUK/OBO spectrophotometry B 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.29 298.15 8.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.00775 291.1 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.00585 297.6 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.0103 281.2 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.00719 285.3 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.00526 305 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.0111 277.8 9.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56RAB/PRI_353 56RAB/PRI spectrophotometry C 2.1.2.4 glycine formiminotransferase C00664 + C00037 = C02718 + C00101 5-formiminotetrahydrofolate(aq) + glycine(aq) = N-formiminoglycine(aq) + tetrahydrofolate(aq) 5 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MCC/NAJ_1403 59MCC/NAJ enzymatic assay C 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 17.2 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DIC/WIL_1332 55DIC/WIL chromatography and spectrophotometry C 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.59 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02NES/ZHO_1591 02NES/ZHO chromatography and radioactivituy C 5.3.3.5 cholestenol -isomerase C05439 = C05437 (3,5)-cholesta-7,24-diene-3-ol(aq) = (3,5)-cholesta-8,24-diene-3-ol(aq) 14 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63DOM/ZEC_1372 63DOM/ZEC spectrophotometry C 5.3.1.14 L-rhamnose isomerase C00507 = C00861 L-rhamnose(aq) = L-rhamnulose(aq) 0.75 310.15 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.53e-06 311.15 0.25 6.76 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.64e-06 311.15 0.25 6.77 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 3.1e-06 311.15 0.25 7.02 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.28e-05 311.15 0.25 7.34 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.09e-05 311.15 0.25 7.56 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.46e-05 311.15 0.25 7.64 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.86e-05 311.15 0.25 7.92 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 3.28e-05 311.15 0.25 8.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 3.77e-06 311.15 0.75 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.45e-06 298.15 0.25 7.32 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.28e-06 298.15 0.25 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.61e-06 311.15 0.25 7.12 1.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 3.14e-06 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.83e-06 311.15 0.25 7.12 2.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.23e-05 311.15 0.25 7.54 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 3.14e-06 311.15 0.25 7.03 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.12e-05 311.15 0.25 7.53 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.57e-06 311.15 0.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_818 49MEY/GRE chemical analysis C 3.1.3.2 acid phosphatase C01094 + C00001 = C00095 + C00009 D-fructose 1-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 168 311.15 5.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86HUB/HUR_930 86HUB/HUR gas-liquid chromatography C 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 86 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 8.3e-05 298.15 7.61 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0014 298.15 8.51 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0025 298.15 8.83 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 7.7e-05 298.15 7.58 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0011 298.15 8.38 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.002 298.15 8.82 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.074 298.15 0.036 6.45 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.079 298.15 0.048 7.3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.074 298.15 0.12 7.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.076 298.15 0.25 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.075 298.15 0.35 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.083 298.15 0.084 6.8 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.081 298.15 0.096 6.9 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.069 298.15 0.45 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.08 298.15 0.12 6.95 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66GIB/MOR_534 66GIB/MOR D 2.6.1.35 glycine-oxaloacetate transaminase C00037 + C00036 = C00048 + C00049 glycine(aq) + oxaloacetate(aq) = glyoxylate(aq) + L-aspartate(aq) 0.016 298.15 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43KRE/EGG_1159 43KRE/EGG polarimetry B 4.2.1.3 aconitate hydratase C00311 = C00417 + C00001 isocitrate(aq) = cis-aconitate(aq) + H2O(l) 0.69 311.15 7.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1091 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 8.0e-05 303.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1091 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00011 313.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1091 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00045 333.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1091 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00015 311.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.19 273.3 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.19 274.9 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.2 278.2 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.22 283.4 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.25 289.9 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.26 293.3 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.27 299 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.3 303.6 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.31 303.6 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.33 308.8 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.36 313.3 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.38 317.5 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.34 313.7 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.41 322.8 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.24 288.4 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.38 318.7 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.2 279.3 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.29 298.2 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.26 294.3 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.41 322 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.22 284.7 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.22 284.7 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.33 308.2 0.12 8.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95LIA/WAN_331 95LIA/WAN calorimetry C 1.11.1.6 catalase C00027 = 0.5 C00007 + C00001 H2O2(aq) = 1/2 O2(aq) + H2O(l) 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58CAB/LEL_432 58CAB/LEL enzymatic assay and spectrophotometry C 2.4.1.15 ,-trehalose-phosphate synthase (UDP-forming) C00029 + C00092 = C00015 + C00689 UDP-glucose + D-glucose 6-phosphate = UDP + alpha,alpha'-trehalose 6-phosphate 40 310.15 6.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.84e-05 318.14 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.82e-05 298.15 6.94 3.26 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.25e-05 278.43 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.78e-05 298.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 3.01e-05 298.15 6.98 3.22 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 1.03e-05 298.15 0.25 7.8 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.65e-05 298.15 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 6.98e-05 298.15 0.25 6.7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.46e-05 280.13 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 0.000111 298.15 0.25 6.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.74e-05 307.93 0.25 7 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 1.58e-05 298.15 0.25 7.4 3 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59ATK/JOH_1402 59ATK/JOH enzymatic assay and spectrophotometry B 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 17 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/CHE_1138 98TEW/CHE calorimetry A 4.1.3.- chorismate lyase C00251 = C00156 + C00022 chorismate(aq) = 4-hydroxybenzoate(aq) + pyruvate(aq) 298.15 6.98 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BLA/WRI2_242 55BLA/WRI2 enzymatic assay B 1.2.1.11 aspartate-semialdehyde dehydrogenase C00441 + C00006 + C00009 = C03082 + C00005 L-aspartate 4-semialdehyde(aq) + NADP(aq) + orthophosphate(aq) = L-4-aspartyl phosphate(aq) + NADPH(aq) 200 298.15 5.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BLA/WRI2_242 55BLA/WRI2 enzymatic assay B 1.2.1.11 aspartate-semialdehyde dehydrogenase C00441 + C00006 + C00009 = C03082 + C00005 L-aspartate 4-semialdehyde(aq) + NADP(aq) + orthophosphate(aq) = L-4-aspartyl phosphate(aq) + NADPH(aq) 7.4 298.15 4.4 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STR/KOR_158 52STR/KOR spectrophotometry C 1.1.1.47 glucose dehydrogenase C00031 + C00003 = C00198 + C00004 -D-glucose(aq) + NAD(aq) = D-glucono-1,5-lactone(aq) + NADH(aq) 15 303.15 6.7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BRO/KRE_512 70BRO/KRE spectrophotometry A 2.6.1.2 alanine aminotransferase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.68 311.15 0.25 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55SLE_1325 55SLE spectrophotometry B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.19 303.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52FIT/DOU_419 52FIT/DOU chromatography C 2.4.1.8 maltose phosphorylase C00208 + C00009 = C00031 + C00103 maltose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.23 310.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.11 343.35 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.107 343.35 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.114 343.35 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.104 343.35 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.105 343.35 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.109 343.35 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.104 343.35 7.1 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89SCH/GIF_58 89SCH/GIF spectrophotometry C 1.1.1.14 L-iditol 2-dehydrogenase C01904 + C00003 = C00309 + C00004 D-arabitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.0008 298.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 0.0038 299.15 6.93 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 0.0053 299.15 7.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 5.0e-05 299.15 7.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 0.0062 299.15 7.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 0.0041 299.15 6.97 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 0.004 299.15 7 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 8.3e-05 299.15 7.37 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78CHR/MAT_1038 78CHR/MAT chromatography and radioactivity C 3.5.2.3 dihydroorotase C00337 + C00001 = C00438 (S)-dihydroorotate(aq) + H2O(l) = N-carbamoyl-L-aspartate(aq) 10.8 310.15 7.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67DAN/YOS_1302 67DAN/YOS spectrophotometry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1 333.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67DAN/YOS_1302 67DAN/YOS spectrophotometry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1 343.15 6.5 -http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52LEL/CAR_698 52LEL/CAR paper chromatography and chemical analysis C 2.7.7.12&5.1.3.2 UDPglucose-hexose 1-phosphate uridylyltransferase and UDPglucose 4-epimerase C03384 = C00103 -D-galactose 1-phosphate(aq) =-D-glucose 1-phosphate(aq) 3 310.15 7.4 - 85LIE A 1.1.-.- glycine cleavage system C00037 + C00003 + C00101 = C00143 + C00004 + C00014 + C00288 glycine(aq) + NAD+(aq) + THF(aq) = 5,10-CH2-THF(aq) + NADH(aq) + NH3(aq) + CO2(aq) 0.00156 311.15 0.25 7 - 85LIE A 4.3.-.- formaldehyde condensation with THF C00101 + C00067 = C00143 THF(aq) + formaldehyde(aq) = 5,10-CH2-THF(aq) 30000 311.15 0.25 7 - +66KAL/JEN E 4.3.-.- formaldehyde condensation with THF C00101 + C00067 = C00143 THF(aq) + formaldehyde(aq) = 5,10-CH2-THF(aq) 32000 298.15 1 7 - +92MEY E 4.1.1.21 phosphoribosylaminoimidazole carboxylase C03373 + C00288 = C04751 + C00001 Aminoimidazole ribotide + CO2 = 1-(5-Phospho-D-ribosyl)-5-amino-4-imidazolecarboxylate 1.8 310.15 7.8 - +00WAL E 2.1.2.3 phosphoribosylaminoimidazolecarboxamide formyltransferase C00234 + C04677 = C00101 + C04734 10-Formyltetrahydrofolate + 1-(5'-Phosphoribosyl)-5-amino-4-imidazolecarboxamide = Tetrahydrofolate + 1-(5'-Phosphoribosyl)-5-formamido-4-imidazolecarboxamide 0.024 298.15 7.5 - +59BLA E 4.3.-.- formaldehyde condensation with THF C00101 + C00067 = C00143 THF(aq) + formaldehyde(aq) = 5,10-CH2-THF(aq) 7700 293.15 7.2 - +74FER E 4.1.2.43 3-Hexulose-6-Phosphate synthase C00199 + C00067 = C06019 D-Ribulose 5-phosphate + Formaldehyde = D-arabino-Hex-3-ulose 6-phosphate 25000 303.15 7 - +74FER E 5.3.1.27 3-Hexulose-6-Phosphate Isomerase C06019 = C00085 D-arabino-Hex-3-ulose 6-phosphate = D-Fructose 6-phosphate 188 303.15 7 - +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=07LIN/ALG_1584 07LIN/ALG spectrophotometry A 1.1.1.87 homoisocitrate dehydrogenase C05662 + C00003 = C00322 + C00288 + C00004 (1R,2S)-1-hydroxybutane-1,2,4-tricarboxylate(aq) + NAD(ox) = 2-oxoadipate(aq) + carbon dioxide(aq) + NAD(red) 0.45 298.15 7.5 1 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63GRE_1058 63GRE spectrophotometry C 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 4.2 298.15 6.5 2 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 18 310.15 7.3 2.96 3 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 25 310.15 7.3 2.8 4 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 33 310.15 7.3 2.3 5 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 11 310.15 7.3 6 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 25 310.15 7.3 7 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 26 310.15 7.3 8 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 30 310.15 7.3 9 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 35 310.15 7.3 2.68 10 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 14 310.15 7.3 3.19 11 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 15 310.15 7.3 12 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 19 310.15 7.3 13 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 28 310.15 7.3 1.3 14 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 7.5 310.15 7.3 15 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 17 310.15 7.3 16 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DEN_1165 67ENG/DEN spectrophotometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 35 310.15 7.3 2.51 17 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 203 303.15 6.02 1.96 18 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 430 303.15 6 2.6 19 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 300 303.15 6.01 2.31 20 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 230 303.15 5.94 2.66 21 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 277 303.15 6.12 2.69 22 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 154 303.15 6.04 0.92 23 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 205 303.15 6.03 0.75 24 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 1310 303.15 7 0.81 25 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 139 303.15 5.99 0.83 26 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 88 303.15 5.7 0.84 27 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 245 303.15 6.03 2.12 28 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 193 303.15 6 1.07 29 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 222 303.15 6 0.98 30 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 249 303.15 6.02 2.67 31 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 286 303.15 6.34 0.82 32 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 172 303.15 5.94 1 33 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 304 303.15 6 2.4 34 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 123 303.15 6.01 1.1 35 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 618 303.15 6 2.6 36 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 186 303.15 6.03 1.85 37 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 222 303.15 5.94 2.66 38 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 222 303.15 5.94 2.66 39 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 294 303.15 6.07 2.67 40 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 540 303.15 6.67 0.82 41 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 214 303.15 6.03 0.75 42 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 184 303.15 6.04 1.04 43 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 356 303.15 6.08 2.31 44 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 303 303.15 6.07 2.67 45 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 260 303.15 6.03 0.93 46 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57ROB/BOY_544 57ROB/BOY radioactivity A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 299 303.15 6.07 2.67 47 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62ESP_704 62ESP radioactivity and spectrophotometry C 2.7.7.27 glucose-1-phosphate adenylyltransferase C00002 + C00103 = C00498 + C00013 ATP(aq) + D-glucose 1-phosphate(aq) = ADPglucose(aq) + pyrophosphate(aq) 1.1 310.15 7.9 48 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STE/COO_718 53STE/COO spectrophotometric C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.01 298.15 8.1 49 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_660 68SU/RUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00206 = C00360 + C00131 2 dADP(aq) = dAMP(aq) + dATP(aq) 0.83 303.15 7 2.09 50 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_660 68SU/RUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00206 = C00360 + C00131 2 dADP(aq) = dAMP(aq) + dATP(aq) 0.27 303.15 7 1.19 51 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_660 68SU/RUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00206 = C00360 + C00131 2 dADP(aq) = dAMP(aq) + dATP(aq) 0.306 303.15 7 1.49 52 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_660 68SU/RUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00206 = C00360 + C00131 2 dADP(aq) = dAMP(aq) + dATP(aq) 0.563 303.15 7 1.8 53 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FER/STR_1112 74FER/STR enzymatic assay and spectrophotometry B 4.1.2.- D-arabino-3-hexulose phosphate formaldehyde lyase C06019 = C00199 + C00067 D-arabino-3-hexulose 6-phosphate(aq) = D-ribulose 5-phosphate(aq) + formaldehyde(aq) 4E-05 303.15 7 54 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_286 80COO/BLA spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 1.4E-05 298.15 8.5 55 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65DAW/DIC_103 65DAW/DIC spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0024 298.15 9 56 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ROS/RAP_311 64ROS/RAP spectrophotometry C 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00003 = C00127 + C00004 2 reduced glutathione(aq) + NAD(aq) = oxidized glutathione(aq) + NADH(aq) 0.001 313.15 7 57 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60FEI/NEU_1270 60FEI/NEU electrophoresis and radioactivity B 5.1.3.6 UDPglucuronate 4-epimerase C00167 = C00617 UDP-D-glucuronate(aq) = UDP-D-galacturonate(aq) 1.1 310.15 7.5 58 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STA_394 52STA spectrophotometry C 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.017 301.15 8.1 59 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51BLI_35 51BLI spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00473 + C00003 = C00376 + C00004 vitamin A alcohol(aq) + NAD(aq) = vitamin A aldehyde(aq) + NADH(aq) 0.033 310.15 7 60 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51BLI_35 51BLI spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00473 + C00003 = C00376 + C00004 vitamin A alcohol(aq) + NAD(aq) = vitamin A aldehyde(aq) + NADH(aq) 0.33 310.15 8 61 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51BLI_35 51BLI spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00473 + C00003 = C00376 + C00004 vitamin A alcohol(aq) + NAD(aq) = vitamin A aldehyde(aq) + NADH(aq) 3.3 310.15 9 62 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_759 93LAR/TEW HPLC A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 189 298.15 8.86 4.5 63 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_110 56KAP/CIO spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C80057 = C00022 + C80058 (S)-lactate(aq) + AP-NAD(aq)= pyruvate(aq) + AP-NADH(aq) 0.27 303.15 9 64 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 480 310.15 6.7 65 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 480 310.15 6.7 66 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 918 310.15 7.7 67 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 391 310.15 6.7 68 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 991 310.15 7.7 69 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 470 310.15 6.7 70 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72CAG/FRI_570 72CAG/FRI spectrophotometry C 2.7.1.80 pyrophosphate-serine phosphotransferase C00013 + C00065 = C00009 + C01005 pyrophosphate(aq) + L-serine(aq) = orthophosphate(aq) + O-phospho-L-serine(aq) 388 310.15 6.7 71 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63SCO/DUN_313 63SCO/DUN spectrophotometry B 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.00644 283.15 6.8 72 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63SCO/DUN_313 63SCO/DUN spectrophotometry B 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.00595 313.15 6.8 73 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63SCO/DUN_313 63SCO/DUN spectrophotometry B 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.00644 298.15 6.8 74 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63SLY/STA_401 63SLY/STA spectrophotometric B 2.3.1.8 phosphate acetyltransferase C00798 + C00009 = C00010 + C02405 formyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + formyl phosphate(aq) 0.14 303.15 6.85 75 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87RAO/HAR_555 87RAO/HAR enzymatic assay and spectrophotometry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 150 303.15 6.8 76 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87RAO/HAR_555 87RAO/HAR enzymatic assay and spectrophotometry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 2900 303.15 8 77 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99HUT/OEH_1552 99HUT/OEH calorimetry B 3.2.1.26 -fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 4.6 78 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62HOR_1266 62HOR radioactivity C 5.1.3.4 L-ribulose-phosphate 4-epimerase C01101 = C00231 L-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1 310.15 6 79 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55YAN/GIL_83 55YAN/GIL spectrophotometry B 1.1.1.25 shikimate dehydrogenase C00493 + C00006 = C02652 + C00005 shikimate(aq) + NADP(aq) = 5-dehydroshikimate(aq) + NADPH(aq) 0.0361 303.15 7 80 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55YAN/GIL_83 55YAN/GIL spectrophotometry B 1.1.1.25 shikimate dehydrogenase C00493 + C00006 = C02652 + C00005 shikimate(aq) + NADP(aq) = 5-dehydroshikimate(aq) + NADPH(aq) 0.175 303.15 7.9 81 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SCH/GIF_69 91SCH/GIF spectrophotometry C 1.1.1.14 L-iditol dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.032 298.15 7 82 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71KAT_220 71KAT spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.043 298.15 7.65 83 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71KAT_220 71KAT spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.13 298.15 7.6 84 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71KAT_220 71KAT spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.021 298.15 7.8 85 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67EPP/DAW_595 67EPP/DAW spectrophotometry C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0054 310.15 7 86 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67EPP/DAW_595 67EPP/DAW spectrophotometry C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.084 310.15 8 87 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67EPP/DAW_595 67EPP/DAW spectrophotometry C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.041 310.15 7.5 88 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_829 92KIM/KIN enzymatic assay A 3.1.3.5 5'-nucleosidase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 176 311.15 0.25 7 3 89 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51THE/BON_12 51THE/BON spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00011 293.15 7 90 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51THE/BON_12 51THE/BON spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0105 293.15 9 91 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51THE/BON_12 51THE/BON spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.09 293.15 10 92 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51THE/BON_12 51THE/BON spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00071 293.15 8 93 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00032 273.15 7 94 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0064 313.15 7 95 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.019 333.15 7 96 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0011 293.15 7 97 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00075 293.15 7 98 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00047 293.15 7 99 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00055 293.15 7 100 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 101 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 102 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00029 293.15 7 103 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0012 333.15 7 104 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00037 293.15 7 105 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00051 293.15 7 106 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0011 293.15 7 107 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0014 293.15 7 108 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.002 313.15 7 109 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0025 313.15 7 110 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0056 333.15 7 111 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0082 333.15 7 112 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0014 313.15 7 113 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00014 273.15 7 114 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00014 273.15 7 115 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.015 333.15 7 116 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0056 313.15 7 117 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0015 293.15 7 118 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 119 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0046 333.15 7 120 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00064 293.15 7 121 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00031 293.15 7 122 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1101 35MEY spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 7.1E-05 273.15 7 123 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1608 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8 1 124 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1608 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 303.4 8 1 125 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1608 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 311.5 8 1 126 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1608 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.4 8 1 127 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1608 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 293.4 8 1 128 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1607 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.307 293.4 8 1 129 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04STO/SCH_1607 04STO/SCH calorimetriy A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.395 298.4 8 1 130 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43KAL_633 43KAL spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.3 303.15 7.5 131 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72KOR/HUR_199 72KOR/HUR spectrophotometry C 1.1.1.72 glycerol dehydrogenase (NADP+) C00116 + C00006 = C00577 + C00005 glycerol(aq) + NADP(aq) = (R)-glyceraldehyde(aq) + NADPH(aq) 1.67E-06 310.15 7 132 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TRI/VOG_1050 67TRI/VOG polarimetry B 3.5.3.4 allantoicase C00499 + C00001 = C00603 + C00086 allantoate(aq) + H2O(l) = (-)-ureidoglycolate(aq) + urea(aq) 0.21 303.15 7.5 133 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DIT/KUB2_54 84DIT/KUB2 spectrophotometry C 1.1.1.9 D-xylulose reductase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.00043 298.15 7 134 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65WAL/SAL_202 65WAL/SAL spectrophotometry C 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 0.0001 298.15 8 135 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74DAN/CAR_473 74DAN/CAR spectrophotometry C 2.4.2.6 nucleoside deoxyribosyltransferase C05512 + C00147 = C00559 + C00262 2'-deoxyinosine(aq) + adenine(aq) = 2'-deoxyadenosine(aq) + hypoxanthine(aq) 1.4 313.15 6 136 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOD_1351 53BOD spectrophotometry B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.67 310.15 7.4 137 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_464 92KIM/KIN HPLC and enzymatic assay A 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.0164 311.15 0.25 7 3 138 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_145 52STE/OCH spectrophotometry B 1.1.1.37&4.1.3.7 malate dehydrogenase and citrate (si)-synthase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 0.48 295.15 6.25 139 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_145 52STE/OCH spectrophotometry B 1.1.1.37&4.1.3.7 malate dehydrogenase and citrate (si)-synthase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 599 295.15 8.2 140 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_145 52STE/OCH spectrophotometry B 1.1.1.37&4.1.3.7 malate dehydrogenase and citrate (si)-synthase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 5610 295.15 8.7 141 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_145 52STE/OCH spectrophotometry B 1.1.1.37&4.1.3.7 malate dehydrogenase and citrate (si)-synthase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 10.8 295.15 7.2 142 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_145 52STE/OCH spectrophotometry B 1.1.1.37&4.1.3.7 malate dehydrogenase and citrate (si)-synthase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 101 295.15 7.6 143 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64KEL/ALL_1421 64KEL/ALL enzymatic assay B 5.4.99.2 methylmalonyl-CoA mutase C01213 = C00091 (R)-methylmalonyl-CoA(aq) = succinyl-CoA(aq) 23.1 298.15 7.4 144 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_830 76LAW/GUY enzymatic assay; spectrophotometry A 3.1.3.11 fructose-biphosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 174 310.15 0.25 6.99 3.05 145 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_126 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C05268 + C00003 = C05269 + C00004 (S)-3-hydroxyhexanoyl-CoA(aq) + NAD(aq) = 3-oxohexanoyl-CoA(aq) + NADH(aq) 0.00025 298.15 7 146 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_126 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C05268 + C00003 = C05269 + C00004 (S)-3-hydroxyhexanoyl-CoA(aq) + NAD(aq) = 3-oxohexanoyl-CoA(aq) + NADH(aq) 0.025 298.15 9 147 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_126 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C05268 + C00003 = C05269 + C00004 (S)-3-hydroxyhexanoyl-CoA(aq) + NAD(aq) = 3-oxohexanoyl-CoA(aq) + NADH(aq) 0.0025 298.15 8 148 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_126 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C05268 + C00003 = C05269 + C00004 (S)-3-hydroxyhexanoyl-CoA(aq) + NAD(aq) = 3-oxohexanoyl-CoA(aq) + NADH(aq) 0.25 298.15 10 149 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00FRA/KOS_1534 00FRA/KOS calorimetry A 4.1.1.39 ribulose-bisphosphate carboxylase C01182 + C00007 = C00197 D-ribulose 1,5-bisphosphate(aq) + O2(aq) = 3-phospho-D-glycerate(aq) 298.15 8 150 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00FRA/KOS_1533 00FRA/KOS calorimetry A 4.1.1.39 ribulose-bisphosphate carboxylase C01182 + C00288 = 2 C00197 D-ribulose 1,5-bisphosphate(aq) + carbon dioxide(aq) = 2 3-phospho-D-glycerate(aq) 298.15 8 151 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_123 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.00063 298.15 7 152 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_123 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.0063 298.15 8 153 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_123 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.063 298.15 9 154 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WAK/GRE_123 54WAK/GRE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.63 298.15 10 155 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47BUC_578 47BUC spectrophotometry C 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.00031 298.15 6.9 156 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90BHA/VIN_1514 90BHA/VIN radioactivity B 2.4.2.10 orotate phosphoribosyltransferase C01103 + C00013 = C00295 + C00119 orotidine 5 '-phosphate(aq) + pyrophosphate(aq) = orotate(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 9.3 303.15 8 157 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66DOM/ZEC_1374 66DOM/ZEC spectrophotometry C 5.3.1.14 L-rhamnose isomerase C00507 = C00861 L-rhamnose(aq) = L-rhamnulose(aq) 0.75 310.15 8.5 158 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65PIN_799 65PIN calorimetry A 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 9 159 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/RAI_1286 69VEE/RAI spectrophotometry A 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 22 311.15 0.25 7 160 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60JON/LIP_576 60JON/LIP chemical analysis C 2.7.2.2 carbamate kinase C00002 + C01563 = C00008 + C00169 ATP(aq) + ammonium carbamate(aq) = ADP(aq) + carbamoyl phosphate(aq) 0.042 283.15 9.4 161 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73SUG_714 73SUG enzymatic assay and spectrophotometry C 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.0049 298.15 7.24 162 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38MEY/SCH_1387 38MEY/SCH polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.8 273.15 163 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38MEY/SCH_1387 38MEY/SCH polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 9.5 293.15 164 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38MEY/SCH_1387 38MEY/SCH polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 7.9 310.15 165 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38MEY/SCH_1387 38MEY/SCH polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 7.6 333.15 166 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1291 41UTT/WER chemical analysis B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.000435 278.15 9 167 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1291 41UTT/WER chemical analysis B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00637 313.15 9 168 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1291 41UTT/WER chemical analysis B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00182 298.15 9 169 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53LYN/OCH_717 53LYN/OCH spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.01 298.15 8.1 170 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81GON/CHE_1326 81GON/CHE chemical analysis C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.2 313.15 6 171 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60NIR/JAK_193 60NIR/JAK spectrophotometry C 1.1.1.61 4-hydroxybutyrate dehydrogenase C00989 + C00003 = C00232 + C00004 4-hydroxybutanoate(aq) + NAD(aq) = 4-oxobutanoate(aq) + NADH(aq) 3.9 298.15 7.14 172 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60NIR/JAK_193 60NIR/JAK spectrophotometry C 1.1.1.61 4-hydroxybutyrate dehydrogenase C00989 + C00003 = C00232 + C00004 4-hydroxybutanoate(aq) + NAD(aq) = 4-oxobutanoate(aq) + NADH(aq) 25 298.15 8 173 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55VAR/WEB_1440 55VAR/WEB chromatography and radioactivity C 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 1700 308.15 7.4 174 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58NOL/BRU_1346 58NOL/BRU spectrophotometry C 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 1.8 310.15 5.9 175 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72LEH/TAN_452 72LEH/TAN C 2.4.1.67 galactinol-raffinose galactosyltransferase C01235 + C00492 = C00137 + C01613 1--D-galactosyl-myo-inositol(aq) + raffinose(aq) = myo-inositol(aq) + stachyose(aq) 4 298.15 6.5 176 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HAY/GRE_1229 71HAY/GRE enzymatic assay B 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.065 298.15 7.3 177 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59STR/SMI_702 59STR/SMI chromatography and spectrophotometry C 2.7.7.23 UDP-N-acetylglucosamine pyrophosphorylase C00075 + C04256 = C00043 + C00013 UTP(aq) + N-acetyl--D-glucosamine 1-phosphate(aq) = UDP-N-acetyl-D-glucosamine(aq) + pyrophosphate(aq) 0.5 310.15 7.4 178 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70KRI/BUC_579 70KRI/BUC spectrophotometry C 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.0003 298.15 7.6 179 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91MOR/FRE_329 91MOR/FRE calorimetry A 1.9.3.1 cytochrome-c oxidase 4 C00126 + C00007 = 4 C00125 + 2 C00001 4 reduced cytochrome c(aq) + O2(aq) = 4 cytochrome c(aq) + 2 H2O(l) 299.4 7.4 180 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43DOU_415 43DOU C 2.4.1.7 sucrose phosphorylase C00089 + C00009 = C00103 + C00095 sucrose(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-fructose(aq) 11 303.15 5.8 181 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43DOU_415 43DOU C 2.4.1.7 sucrose phosphorylase C00089 + C00009 = C00103 + C00095 sucrose(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-fructose(aq) 20 303.15 6.6 182 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MAR/COH_577 66MAR/COH radioactivity B 2.7.2.2 carbamate kinase C00002 + C01563 = C00008 + C00169 ATP(aq) + ammonium carbamate(aq) = ADP(aq) + carbamoyl phosphate(aq) 0.027 298.15 8.14 183 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53HAR/KOR_147 53HAR/KOR enzymatic assay; spectrophotometry B 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.051 297 7.4 184 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65KAZ/GRO_1447 65KAZ/GRO spectrophotometry and enzymatic assay C 6.4.1.3 propanoyl-CoA carboxylase C00002 + C00100 + C00288 = C00008 + C00009 + C02557 ATP(aq) + propanoyl-CoA(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + methylmalonyl-CoA(aq) 5.7 301.15 8.1 185 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.407 303.15 8 3 186 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.079 303.15 8 2.3 187 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.043 303.15 8 2.15 188 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.043 303.15 8 2 189 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.4 303.15 8 190 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.196 303.15 8 191 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.096 303.15 8 192 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.083 303.15 8 193 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.071 303.15 8 194 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.05 303.15 8 195 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.05 303.15 8 196 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.271 303.15 8 197 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.059 303.15 8 198 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.053 303.15 8 199 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.136 303.15 8 2.4 200 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.05 303.15 8 201 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.186 303.15 8 2.52 202 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.284 303.15 8 203 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.06 303.15 8 204 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.054 303.15 8 2.22 205 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.039 303.15 8 206 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.039 303.15 8 207 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.043 303.15 8 2.1 208 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.379 303.15 8 209 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.105 303.15 8 210 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.154 303.15 8 211 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.091 303.15 8 212 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.3 303.15 8 2.7 213 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.209 303.15 8 214 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.043 303.15 8 2.05 215 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67MOR/WHI_596 67MOR/WHI chromatography B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.039 303.15 8 216 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BUR/HOR_1264 58BUR/HOR enzymatic assay B 5.1.3.4 L-ribulose-phosphate 4-epimerase C01101 = C00231 L-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.2 310.15 7 217 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62SEG/BEA_509 62SEG/BEA spectrophotometry B 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.61 310.15 7.3 218 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1288 34MEY/LOH spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00018 266.15 7 219 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1288 34MEY/LOH spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0015 293.15 7 220 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1288 34MEY/LOH spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.013 333.15 7 221 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1288 34MEY/LOH spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.022 343.15 7 222 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1288 34MEY/LOH spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0003 273.15 7 223 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1083 66WOO/DAV spectrophotometry and enzymatic assay A 4.1.1.32 phosphoenolpyruvate carboxykinase (GTP) C00081 + C00036 + C00001 = C00104 + C00074 + C00288 ITP(aq) + oxaloacetate(aq) + H2O(l) = IDP(aq) + phosphoenolpyruvate(aq) + carbon dioxide(aq) 1.7 298.15 0.1 7.8 224 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1083 66WOO/DAV spectrophotometry and enzymatic assay A 4.1.1.32 phosphoenolpyruvate carboxykinase (GTP) C00081 + C00036 + C00001 = C00104 + C00074 + C00288 ITP(aq) + oxaloacetate(aq) + H2O(l) = IDP(aq) + phosphoenolpyruvate(aq) + carbon dioxide(aq) 0.5 298.15 0.1 7.06 225 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1083 66WOO/DAV spectrophotometry and enzymatic assay A 4.1.1.32 phosphoenolpyruvate carboxykinase (GTP) C00081 + C00036 + C00001 = C00104 + C00074 + C00288 ITP(aq) + oxaloacetate(aq) + H2O(l) = IDP(aq) + phosphoenolpyruvate(aq) + carbon dioxide(aq) 0.71 298.15 0.1 7.03 226 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03TEW/GOL_1627 03TEW/GOL chromatography and calorimetry A 1.6.4.2 glutathione reductase (NADPH) 2 C00051 + C00006 = C00127 + C00005 2 glutathoine(red)(aq) + NADP(ox)(aq) = glutathoine(ox)(aq) + NADP(red)(aq) 298.15 0.35 7.41 227 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1084 66WOO/DAV spectrophotometry and enzymatic assay A 4.1.1.38 phosphoenolpyruvate carboxykinase (diphosphate) C00013 + C00036 + C00001 = C00009 + C00074 + C00288 diphosphate(aq) + oxaloacetate(aq) + H2O(l) = phosphate(aq) + phosphoenolpyruvate(aq) + carbon dioxide(aq) 0.013 298.15 0.1 6.5 228 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52OHL/SHA_1061 52OHL/SHA calorimetry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 302.15 7.2 229 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 3 284.15 7 230 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 3 298.15 7 231 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 3 313.15 7 232 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 2.9 308.15 7 233 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 3.1 274.15 7 234 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK2_1342 67TAK2 chemical analysis and polarimetry B 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 3.1 279.15 7 235 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/SCH_798 35MEY/SCH calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 293.15 236 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CHA_622 97CHA spectrophotometry B 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 17.5 298.15 7.2 237 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61YAM_485 61YAM spectrophotometry C 2.4.2.15 guanosine phosphorylase C00387 + C00009 = C00242 + C00620 guanosine(aq) + orthophosphate(aq) = guanine(aq) + D-ribose 1-phosphate(aq) 0.019 310.15 7 238 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89SCH/GIF_68 89SCH/GIF spectrophotometry C 1.1.1.14 L-iditol 2-dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.0058 298.15 7 239 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62SHU/DOU_119 62SHU/DOU spectrophotometry C 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.13 305.15 8 240 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86MEI/GAD_306 86MEI/GAD spectrophotometry C 1.5.1.17 alanopine dehydrogenase C03210 + C00003 + C00001 = C00041 + C00022 + C00004 2,2'-iminodipropanoate(aq) + NAD(aq) + H2O(l) = L-alanine(aq) + pyruvate(aq) + NADH(aq) 1E-06 298.15 7 241 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89SCH/GIF_63 89SCH/GIF spectrophotometry C 1.1.1.14 L-iditol 2-dehydrogenase C00392 + C00003 = C00095 + C00004 D-mannitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.045 298.15 7 242 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86MEI/GAD_302 86MEI/GAD spectrophotometry C 1.5.1.11 D-octopine dehydrogenase C04137 + C00003 + C00001 = C00062 + C00022 + C00004 N-2-(D-1-carboxyethyl)-L-arginine(aq) + NAD(aq) + H2O(l) = L-arginine(aq) + pyruvate(aq) + NADH(aq) 3E-06 298.15 7 243 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51WOO/GUN_1233 51WOO/GUN enzymatic assay and manometry B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1 310.15 8.1 244 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77APP/NAI_556 77APP/NAI enzymatic assay and chromatography B 2.7.1.23 NAD+ kinase C00002 + C00003 = C00008 + C00006 ATP(aq) + NAD(aq) = ADP(aq) + NADP(aq) 29.3 303.15 6.1 245 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62GHA/HEA_1107 62GHA/HEA spectrophotometry C 4.1.2.17 L-fuculose-phosphate aldolase C01099 = C00111 + C00424 L-fuculose 1-phosphate(aq) = glycerone phosphate(aq) + (S)-lactaldehyde(aq) 0.00046 310.15 7.2 246 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.609 298.15 8.7 247 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.417 298.15 8.55 248 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.193 298.15 8.1 249 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0772 298.15 7.7 250 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.052 298.15 7.6 251 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0194 298.15 7.05 252 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0146 298.15 7 253 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62KRE/MEL_118 62KRE/MEL spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0335 298.15 7.4 254 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WIL/ROC_1115 71WIL/ROC spectrophotometry B 4.1.3.1 isocitrate lyase C00311 = C00042 + C00048 isocitrate(aq) = succinate(aq) + glyoxylate(aq) 0.0023 303.15 7.7 255 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53GRE/BRO_634 53GRE/BRO chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.45 300.15 6.7 256 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03RAN/VAN_1602 03RAN/VAN spectophotometry B 4.1.3.1 isocitrate lyase C00311 = C00042 + C00048 isocitrate(aq) = succinate(aq) + glyoxylate(aq) 0.001 295.65 7 257 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06POD/BEL_1598 06POD/BEL calorimetry B 4.1.1.23 orotidine-5 '-phosphate decarboxylase C01103 = C00105 + C00288 orotidine 5 '-phosphate(aq) = UMP(aq) + carbon dioxide(aq) 328.15 7.5 258 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54HAN/CRA_1261 54HAN/CRA paper chromatography C 5.1.3.2&2.7.7.12 UDPglucose 4-epimerase and UDPglucose-hexose 1-phosphate uridylyltransferase C03384 = C00103 -D-galactose 1-phosphate(aq) =-D-glucose 1-phosphate(aq) 3 298.15 7.1 259 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69WAN/BAR_1151 69WAN/BAR spectrophotometry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.2 298.15 8.2 260 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_782 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00044 + 3 C00001 = C00387 + 3 C00009 GTP(aq) + 3 H2O(l) = guanosine(aq) + 3 orthophosphate(aq) 298.15 8 261 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_782 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00044 + 3 C00001 = C00387 + 3 C00009 GTP(aq) + 3 H2O(l) = guanosine(aq) + 3 orthophosphate(aq) 298.15 9 262 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_782 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00044 + 3 C00001 = C00387 + 3 C00009 GTP(aq) + 3 H2O(l) = guanosine(aq) + 3 orthophosphate(aq) 298.15 9 263 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_782 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00044 + 3 C00001 = C00387 + 3 C00009 GTP(aq) + 3 H2O(l) = guanosine(aq) + 3 orthophosphate(aq) 308.15 9 264 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_781 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00144 + C00001 = C00387 + C00009 GMP(aq) + H2O(l) = guanosine(aq) + orthophosphate(aq) 298.15 9 265 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_781 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00144 + C00001 = C00387 + C00009 GMP(aq) + H2O(l) = guanosine(aq) + orthophosphate(aq) 298.15 9 266 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95PEL/MAC_1595 95PEL/MAC spectrophotometry and enzymatic assay B 1.5.1.5 methylenetetrahydrofolate dehydrogenase (NADP+) C00143 + C00006 = C00234 + C00005 5,10-methylenetetrahydrofolate(aq) + NADP(ox)(aq) = 10-formyltetrahydrofolate(aq) + NADP(red)(aq) 16 303.15 7.3 267 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83WED/BLA_146 83WED/BLA spectrophotometry C 1.1.1.39 malate dehydrogenase (decarboxylating) C00149 + C00003 + C00001 = C00022 + C00004 + C00288 (S)-malate(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + carbon dioxide(aq) 0.0011 298.15 6.5 268 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51ROW/KOR_465 51ROW/KOR fluorimetry and spectrophotometry C 2.4.2.1 purine-nucleoside phosphorylase C00153 + C00620 = C03150 + C00009 nicotinamide(aq) + D-ribose 1-phosphate(aq) = nicotinamide riboside(aq) + orthophosphate(aq) 0.00036 298.15 7.4 269 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99HUT/OEH_944 99HUT/OEH calorimetry B 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 4.6 270 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GEO/TRA_756 69GEO/TRA calorimetry C 3.1.3.1 alkaline phosphatase C00008 + C00001 = C00020 + C00009 + C00080 ADP-3-(aq) + H2O(l) = AMP-2--(aq) + HPO4-2-(aq) + H+(aq) 298.15 8.5 271 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GEO/TRA_757 69GEO/TRA calorimetry C 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP-2--(aq) + H2O(l) = adenosine(aq) + HPO4-2-(aq) 298.15 8.5 272 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HAB/CAN_951 59HAB/CAN enzymatic assay B 3.3.1.1 adenosylhomocysteinase C00021 + C00001 = C00212 + C00155 S-adenosyl-L-homocysteine(aq) + H2O(l) = adenosine(aq) + L-homocysteine(aq) 1.4E-06 310.15 6.3 273 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54WIL/BAN_66 54WIL/BAN spectrophotometry C 1.1.1.14 L-iditol dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.0205 298.15 7 274 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1103 41UTT/WER chemical analysis B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.000435 278.15 9 275 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1103 41UTT/WER chemical analysis B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00637 313.15 9 276 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41UTT/WER_1103 41UTT/WER chemical analysis B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00182 298.15 9 277 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86POL/MEN_1318 86POL/MEN polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.06 303.15 7 278 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86POL/MEN_1318 86POL/MEN polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.093 323.15 7 279 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86POL/MEN_1318 86POL/MEN polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.162 333.15 7 280 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86POL/MEN_1318 86POL/MEN polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.08 313.15 7 281 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85VAN/SCH_1687 85VAN/SCH chromatography and spectrophotometry C 2.6.1.19 4-aminobutyrate aminotransferase C00334 + C00026 = C00232 + C00025 4-aminobutanoate(aq) + 2-oxoglutarate(aq) = 4-oxobutanoate(aq) + L-glutamate(aq) 0.04 295.15 8.5 282 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57DUR/STU_339 57DUR/STU calorimetry B 2.1.1.3 thetin-homocysteine S-methyltransferase C03392 + C00155 = C03173 + C00073 dimethylacetothetin(aq) + L-homocysteine(aq) = S-methylthioglycolate(aq) + L-methionine(aq) 298.15 7.1 283 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WUR/HES_1276 72WUR/HES enzymatic assay and spectrophotometry C 5.1.3.15 glucose-6-phosphate 1-epimerase C00668 = C01172 alpha-D-Glucose 6-phosphate(aq) = beta-D-Glucose 6-phosphate(aq) 1.7 298.15 7.6 284 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAK/YOS_900 65TAK/YOS calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00713 + 2 C00001 = 3 C00031 panose(aq) + 2 H2O(l) = 3 D-glucose(aq) 298.15 4.5 285 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_275 56KAP/CIO spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.43E-06 303.15 7.6 286 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97HAN/KLE_208 97HAN/KLE spectrophotometry and HPLC B 1.1.1.108 carnitine dehydrogenase C15025 + C00003 = C02636 + C00004 D-carnitine(aq) + NAD(aq) = 3-dehydrocarnitine(aq) + NADH(aq) 0.0022 295.15 9 287 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97HAN/KLE_208 97HAN/KLE spectrophotometry and HPLC B 1.1.1.108 carnitine dehydrogenase C15025 + C00003 = C02636 + C00004 D-carnitine(aq) + NAD(aq) = 3-dehydrocarnitine(aq) + NADH(aq) 0.00022 295.15 8 288 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WIL/WAK_412 66WIL/WAK chromatography and radioactivity B 2.3.1.39 [acyl-carrier-protein] S-malonyltransferase C00083 + C00229 = C00010 + C01209 malonyl-CoA(aq) + acyl-carrier protein(aq) = CoA(aq) + malonyl-[acyl-carrier protein](aq) 2.33 311.15 6.5 289 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WIL/WAK_411 66WIL/WAK chromatography and radioactivity B 2.3.1.38 [acyl-carrier-protein] S-acetyltransferase C00024 + C00229 = C00010 + C03939 acetyl-CoA(aq) + acyl-carrier protein(aq) = CoA(aq) + acetyl-[acyl-carrier protein](aq) 2.09 311.15 6.5 290 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_278 56KAP/CIO spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C80057 + C00001 = C00026 + C80058 + C00014 L-glutamate(aq) + AP-NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + AP-NADH(aq) + ammonia(aq) 0.0022 303.15 7.6 291 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56SMI/STA_1113 56SMI/STA chemical analysis and enzymatic assay B 4.1.3.1 isocitrate lyase C00311 = C00042 + C00048 isocitrate(aq) = succinate(aq) + glyoxylate(aq) 0.029 300.15 7.6 292 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80PET/AMI_144 80PET/AMI spectrophotometry C 1.1.1.37&2.6.1.1 malate dehydrogenase and aspartate aminotransferase C00025 + C00149 + C00003 = C00049 + C00026 + C00004 L-glutamate(aq) + (S)-malate(aq) + NAD(aq) = L-aspartate(aq) + 2-oxoglutarate(aq) + NADH(aq) 4.1E-05 298.15 7.4 293 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56AME/HOR_519 56AME/HOR spectrophotometry B 2.6.1.9 histidinol-phosphate transaminase C01100 + C00026 = C01267 + C00025 L-histidinol phosphate(aq) + 2-oxoglutarate(aq) = 3-(imidazol-4-yl)-2-oxopropyl phosphate(aq) + L-glutamate(aq) 25 310.15 8.1 294 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.321 288.15 7.25 1.7 295 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.588 288.15 7.25 2.15 296 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.549 288.15 7.25 2.2 297 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.971 288.15 7.25 2.67 298 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.877 288.15 7.25 2.8 299 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.24 288.15 7.25 2.8 300 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.27 288.15 7.25 2.93 301 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.45 288.15 7.25 3.5 302 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.14 288.15 7.25 3.78 303 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.82 288.15 7.25 4.1 304 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.694 288.15 7.25 4.35 305 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.341 288.15 7.25 5.15 306 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.461 288.15 7.25 5.28 307 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.478 288.15 7.25 5.45 308 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.461 288.15 7.25 6.25 309 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 288.15 7.25 6.4 310 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.469 288.15 7.25 6.75 311 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 288.15 7.25 6.8 312 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.422 288.15 7.25 7.25 313 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.23 288.15 7.25 3.5 314 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.488 288.15 7.25 5.4 315 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.488 288.15 7.25 5.4 316 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.935 288.15 7.25 2.68 317 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.38 288.15 7.25 1.9 318 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.521 288.15 7.25 4.9 319 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 288.15 7.25 6.45 320 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.518 288.15 7.25 6.7 321 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.352 288.15 7.25 1.85 322 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.37 288.15 7.25 3.3 323 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.562 288.15 7.25 4.8 324 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.452 288.15 7.25 7.4 325 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.794 288.15 7.25 4 326 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.794 288.15 7.25 4.15 327 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.41 288.15 7.25 3.12 328 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.383 288.15 7.25 2.25 329 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.518 288.15 7.25 5.3 330 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.617 288.15 7.25 2.3 331 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.461 288.15 7.25 6.35 332 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.317 288.15 7.25 1.65 333 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.472 288.15 7.25 5 334 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73DEW/LOW_646 73DEW/LOW spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.483 288.15 7.25 6.6 335 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ISH_997 60ISH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 313.15 336 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ISH_997 60ISH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 313.15 6.7 337 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00565 298.15 0.25 6.97 3.18 338 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0069 298.15 0.25 6.98 3.28 339 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00629 298.15 0.25 6.98 3.29 340 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00518 298.15 0.25 6.96 3.2 341 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.005 298.15 0.25 7.01 3.26 342 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00699 311.15 0.25 6.93 3.21 343 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0073 311.15 0.25 6.93 3.21 344 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00704 311.15 0.25 6.94 3.34 345 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00685 311.15 0.25 6.94 3.34 346 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00592 311.15 0.25 6.93 3.24 347 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00444 278.15 0.25 7.03 3.1 348 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00439 278.15 0.25 7.03 3.1 349 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00444 278.15 0.25 7.03 3.2 350 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00481 278.15 0.25 7.03 3.21 351 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00388 278.15 0.25 7.02 3.13 352 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00389 278.15 0.25 7.07 3.16 353 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.005 288.15 0.25 7 3.13 354 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00535 288.15 0.25 7 3.13 355 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0049 288.15 0.25 7 3.25 356 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00552 288.15 0.25 7 3.24 357 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00465 288.15 0.25 6.99 3.15 358 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00465 288.15 0.25 6.99 3.15 359 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0045 288.15 0.25 7.04 3.2 360 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00602 298.15 0.25 6.97 3.16 361 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00629 311.15 0.25 6.98 3.29 362 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00467 288.15 0.25 7.04 3.2 363 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00535 298.15 0.25 7.01 3.25 364 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00613 311.15 0.25 6.93 3.24 365 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00637 311.15 0.25 6.98 3.29 366 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00376 278.15 0.25 7.02 3.12 367 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00467 288.15 0.25 6.99 3.16 368 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0051 298.15 0.25 6.96 3.2 369 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=92TEA/DOB_604 92TEA/DOB spectrophotometry and fluorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00382 278.15 0.25 7.07 3.16 370 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56LEL/CAR_1366 56LEL/CAR B 5.3.1.10 glucosamine-6-phosphate isomerase C00352 + C00001 = C00085 + C00014 D-glucosamine 6-phosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + ammonia(aq) 0.15 310.15 8.4 371 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55CAR/COH_1223 55CAR/COH spectrophotometry C 4.3.2.2 adenylosuccinate lyase C03794 = C00122 + C00020 adenylosuccinate(aq) = fumarate(aq) + AMP(aq) 0.012 298.15 7 372 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KIR/TUR_663 59KIR/TUR paper chromatography and spectrophotometry B 2.7.4.4 nucleoside-phosphate kinase C00002 + C00015 = C00008 + C00075 ATP(aq) + UDP(aq) = ADP(aq) + UTP(aq) 0.91 303.15 8 373 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MOO/REI_318 64MOO/REI spectrophotometry C 1.6.4.5 thioredoxin reductase (NADPH) C00342 + C00006 = C00343 + C00005 reduced thioredoxin(aq) + NADP(aq) = oxidized thioredoxin(aq) + NADPH(aq) 2 298.15 9 374 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MOO/REI_318 64MOO/REI spectrophotometry C 1.6.4.5 thioredoxin reductase (NADPH) C00342 + C00006 = C00343 + C00005 reduced thioredoxin(aq) + NADP(aq) = oxidized thioredoxin(aq) + NADPH(aq) 0.27 298.15 8 375 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MOO/REI_318 64MOO/REI spectrophotometry C 1.6.4.5 thioredoxin reductase (NADPH) C00342 + C00006 = C00343 + C00005 reduced thioredoxin(aq) + NADP(aq) = oxidized thioredoxin(aq) + NADPH(aq) 0.036 298.15 7 376 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1100 34MEY/LOH spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0015 293.15 7 377 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1100 34MEY/LOH spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.013 333.15 7 378 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1100 34MEY/LOH spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.022 343.15 7 379 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1100 34MEY/LOH spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00018 266.15 7 380 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34MEY/LOH_1100 34MEY/LOH spectrophotometry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0003 273.15 7 381 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71UNK/GOL_1197 71UNK/GOL spectrophotometry B 4.2.1.48 D-glutamate cyclase C00217 = C02237 + C00001 D-glutamate(aq) = 5-oxo-D-proline(aq) + H2O(l) 24.3 293.4 7.9 382 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71UNK/GOL_1197 71UNK/GOL spectrophotometry B 4.2.1.48 D-glutamate cyclase C00217 = C02237 + C00001 D-glutamate(aq) = 5-oxo-D-proline(aq) + H2O(l) 30.3 310.9 7.9 383 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71UNK/GOL_1197 71UNK/GOL spectrophotometry B 4.2.1.48 D-glutamate cyclase C00217 = C02237 + C00001 D-glutamate(aq) = 5-oxo-D-proline(aq) + H2O(l) 27 302.3 7.9 384 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71UNK/GOL_1197 71UNK/GOL spectrophotometry B 4.2.1.48 D-glutamate cyclase C00217 = C02237 + C00001 D-glutamate(aq) = 5-oxo-D-proline(aq) + H2O(l) 26.8 303.2 7.9 385 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/SCH_805 35MEY/SCH calorimetry C 3.1.3.1 alkaline phosphatase C00074 + C00001 = C00022 + C00009 phosphoenolpyruvate(aq) + H2O(l) = pyruvate(aq) + orthophosphate(aq) 293.15 386 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62HAL/FEN_1446 62HAL/FEN spectrophotometry B 6.4.1.3 propanoyl-CoA carboxylase C00002 + C00100 + C00288 = C00008 + C00009 + C02557 ATP(aq) + propanoyl-CoA(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + methylmalonyl-CoA(aq) 0.0081 310.15 8.15 387 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97LIA/WU_332 97LIA/WU calorimetry B 1.11.1.6 catalase C00027 = 0.5 C00007 + C00001 H2O2(aq) = 1/2 O2(aq) + H2O(l) 298.15 7 388 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/LOH_1102 35MEY/LOH calorimetry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 313.15 389 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/LOH_1102 35MEY/LOH calorimetry C 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 293.15 390 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1339 88TEW/STE calorimetry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 298.15 8.52 391 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SCH/KRI_1000 76SCH/KRI calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 300.15 7 392 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SCH/KRI_1000 76SCH/KRI calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 300.15 8 393 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52NEI_99 52NEI C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.003 298.15 9 394 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52NEI_99 52NEI C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 2.3E-05 298.15 7 395 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52NEI_99 52NEI C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00033 298.15 8 396 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52NEI_99 52NEI C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.044 298.15 10 397 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=05TEW/GOL_1634 05TEW/GOL calorimetry A 3.5.5.1 nitrilase C02938 + 2 C00001 = C00954 + C00014 3-indoleacetonitrile(aq) + 2 H2O(l) = indole-3-acetic acid(aq) + ammonia(aq) 298.15 0.29 7.51 398 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88GAU_1536 88GAU spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 2.8 298.15 7.4 399 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.42 2.21 400 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 2.96 401 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 2.49 402 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 298.15 8.85 3.27 403 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 304.8 8.85 3.27 404 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.54 2.21 405 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 3.11 406 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.62 2.21 407 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 2.25 408 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 7.87 2.21 409 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.99 2.21 410 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 3.27 411 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_767 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 311.15 8.8 3.11 412 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_766 88TEW/STE2 enzymatic assay and chromatography A 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 262 298.15 0.29 8.4 413 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83CRA/BOS_19 83CRA/BOS spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00037 310.15 7.3 414 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57SMI/GUN_1114 57SMI/GUN spectrophotometry B 4.1.3.1 isocitrate lyase C00311 = C00042 + C00048 isocitrate(aq) = succinate(aq) + glyoxylate(aq) 0.029 300.15 7.6 415 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AVI/ALR_212 68AVI/ALR spectrophotometry C 1.1.1.119 glucose dehydrogenase (NADP+) C00031 + C00006 = C00198 + C00005 D-glucose(aq) + NADP(aq) = D-glucono-1,5-lactone(aq) + NADPH(aq) 0.297 303.15 6.13 416 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AVI/ALR_212 68AVI/ALR spectrophotometry C 1.1.1.119 glucose dehydrogenase (NADP+) C00031 + C00006 = C00198 + C00005 D-glucose(aq) + NADP(aq) = D-glucono-1,5-lactone(aq) + NADPH(aq) 3.52 303.15 6.93 417 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AVI/ALR_212 68AVI/ALR spectrophotometry C 1.1.1.119 glucose dehydrogenase (NADP+) C00031 + C00006 = C00198 + C00005 D-glucose(aq) + NADP(aq) = D-glucono-1,5-lactone(aq) + NADPH(aq) 1.13 303.15 6.55 418 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAP/ISH_312 63MAP/ISH radioactivity and fluorimetry D 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 1.5E-05 293.15 7.4 419 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAP/ISH_312 63MAP/ISH radioactivity and fluorimetry D 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.00012 293.15 8.3 420 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAP/ISH_312 63MAP/ISH radioactivity and fluorimetry D 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.00032 293.15 9.3 421 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87FIE/JOH_1530 87FIE/JOH spectrophotometric B 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(ox)(aq) = 7,8-dihydrofolate(aq) + NADP(red)(aq) 0.049 298.15 9.8 422 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CHE/HED_567 80CHE/HED flow microcalorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.02 423 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CHE/HED_567 80CHE/HED flow microcalorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.54 424 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CHE/HED_567 80CHE/HED flow microcalorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.06 425 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CHE/HED_567 80CHE/HED flow microcalorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8 426 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72COO/MEI_523 72COO/MEI spectrophotometry B 2.6.1.15 glutamine-pyruvate aminotransaminase C00064 + C00022 = C00940 + C00041 L-glutamine(aq) + pyruvate(aq) = 2-oxoglutaramate(aq) + L-alanine(aq) 340 310.15 8.4 427 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72COO/MEI_521 72COO/MEI spectrophotometry B 2.6.1.15 glutamine-pyruvate aminotransaminase C00064 + C00048 = C00940 + C00037 L-glutamine(aq) + glyoxylate(aq) = 2-oxoglutaramate(aq) + glycine(aq) 607 310.15 8.4 428 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 85.4 311.15 0.25 6.81 429 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 78 311.15 0.25 6.83 430 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 82.6 311.15 0.25 6.92 431 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 98.8 311.15 0.25 6.94 432 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 93.9 311.15 0.25 6.94 433 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 83.7 311.15 0.25 6.94 434 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 81.8 311.15 0.25 6.96 435 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 85 311.15 0.25 6.98 436 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 89.5 311.15 0.25 7 437 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 81.5 311.15 0.25 7.01 438 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 93 311.15 0.25 7.02 439 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 99.5 311.15 0.25 7.03 440 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.4 311.15 0.25 7.15 441 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 96.4 311.15 0.25 7.19 442 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 92.2 311.15 0.25 7.22 443 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 96.2 311.15 0.25 7.23 444 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 86.1 311.15 0.25 7.51 445 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 95.1 311.15 0.25 7 2.88 446 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 80.6 311.15 0.25 7 2.69 447 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 91.6 311.15 0.25 7 2.58 448 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.9 311.15 0.25 7 2.57 449 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.9 311.15 0.25 7 2.57 450 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 83.6 311.15 0.25 7 2.39 451 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 76.9 311.15 0.25 7 2.28 452 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 84.8 311.15 0.25 7 2.25 453 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 73.5 311.15 0.25 7 1.95 454 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 73 311.15 0.25 7 1.96 455 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 103 311.15 0.07 7 456 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 112 311.15 0.07 7 457 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 69.5 311.15 0.5 7 458 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 84.7 311.15 0.5 7 459 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 67.9 311.15 0.75 7 460 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 68 311.15 0.75 7 461 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.1 311.15 0.25 6.98 462 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 79.6 311.15 0.25 7 2.69 463 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 86.1 311.15 0.25 7 2.26 464 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 64 311.15 0.75 7 465 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 100 311.15 0.25 6.92 466 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 101 311.15 0.25 6.98 467 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 89.6 311.15 0.25 7.15 468 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.6 311.15 0.25 7.53 469 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.6 311.15 0.25 7 2.39 470 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 88.6 311.15 0.25 7 2.39 471 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 101 311.15 0.07 7 472 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 73.9 311.15 0.5 7 473 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 65.5 311.15 0.75 7 474 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 93.6 311.15 0.25 7.17 475 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 93.4 311.15 0.25 7 2.88 476 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 74.9 311.15 0.25 7 2.27 477 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 110 311.15 0.07 7 478 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 90.7 311.15 0.25 6.94 479 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 84.4 311.15 0.25 7.01 480 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 74.6 311.15 0.5 7 481 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=81MER/MCA_539 81MER/MCA enzymatic assay and spectrophotometry A 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 87.7 311.15 0.25 6.91 482 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_104 67WIL/LUN spectrophotometry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 9.36E-05 311.15 0.045 7 483 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_104 67WIL/LUN spectrophotometry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0001023 311.15 0.138 7 484 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_104 67WIL/LUN spectrophotometry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.000111 311.15 0.258 7 485 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_104 67WIL/LUN spectrophotometry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 9.67E-05 311.15 0.077 7 486 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_1152 80COO/BLA spectrophotometry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.25 298.15 8 487 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 6.01E-06 298.15 7.97 488 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 7.68E-06 298.15 7.98 489 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 1.96E-05 298.15 8.35 490 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.000115 298.15 9.1 491 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.000119 298.15 9.14 492 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.000268 298.15 9.41 493 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 5.32E-05 298.15 8.73 494 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 1.8E-05 298.15 8.32 495 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 5.26E-05 298.15 8.77 496 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PIE/WIA_270 60PIE/WIA spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.00016 298.15 9.22 497 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CAM/SGA_950 80CAM/SGA spectrophotometry B 3.2.2.7 adenosine nucleosidase C00212 + C00001 = C00147 + C00121 adenosine(aq) + H2O(l) = adenine(aq) + D-ribose(aq) 53 298.15 7 498 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_543 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00095 = C00008 + C00085 ATP(aq) + D-fructose(aq) = ADP(aq) + D-fructose 6-phosphate(aq) 301.66 8.63 499 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_543 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00095 = C00008 + C00085 ATP(aq) + D-fructose(aq) = ADP(aq) + D-fructose 6-phosphate(aq) 298.19 8.61 500 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_543 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00095 = C00008 + C00085 ATP(aq) + D-fructose(aq) = ADP(aq) + D-fructose 6-phosphate(aq) 298.19 8.63 501 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_543 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00095 = C00008 + C00085 ATP(aq) + D-fructose(aq) = ADP(aq) + D-fructose 6-phosphate(aq) 305.11 8.61 502 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74TUR/GIL_693 74TUR/GIL spectrophotometry C 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.16 305.15 7.8 503 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65BUL/HAN_510 65BUL/HAN spectrophotometry C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 2.2 298.15 8 504 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90SAN/SIN_1363 90SAN/SIN enzymatic assay + spectrophotometry C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.3 303.15 8.6 505 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88GUI/SNE_1547 88GUI/SNE spectrophotometry B 1.1.1.65 pyridoxine 4-dehydrogenase C00314 + C00006 = C00250 + C00005 pyridoxine(aq) + NADP(ox)(aq) = pyridoxal(aq) + NADP(red)(aq) 0.0071 298.15 9 506 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88GUI/SNE_1547 88GUI/SNE spectrophotometry B 1.1.1.65 pyridoxine 4-dehydrogenase C00314 + C00006 = C00250 + C00005 pyridoxine(aq) + NADP(ox)(aq) = pyridoxal(aq) + NADP(red)(aq) 3.9E-06 298.15 6 507 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58NOL/BRU_1353 58NOL/BRU spectrophotometry C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.67 310.15 7.5 508 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.0758 309.8 7.5 509 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.127 317.7 7.5 510 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.00898 278.3 7.5 511 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.034 298.15 7.5 512 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.0165 287.9 7.5 513 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1121 92KRA HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.0641 309.8 7.5 514 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70MAN/HOL_708 70MAN/HOL B 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 8.5 303.15 7.36 515 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_458 92KIM/KIN HPLC and enzymatic assay A 2.4.2.1 purine-nucleoside phosphorylase C00387 + C00009 = C00242 + C00620 guanosine(aq) + orthophosphate(aq) = guanine(aq) + D-ribose 1-phosphate(aq) 0.00926 311.15 0.25 7 3 516 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_22 56KAP/CIO spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C80057 = C00084 + C80058 ethanol(aq) + AP-NAD(aq) = acetaldehyde(aq) + AP-NADH(aq) 0.03 303.15 7 517 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_22 56KAP/CIO spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C80057 = C00084 + C80058 ethanol(aq) + AP-NAD(aq) = acetaldehyde(aq) + AP-NADH(aq) 0.3 303.15 8 518 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70NAK/TSU_205 70NAK/TSU spectrophotometry C 1.1.1.96 diiodophenylpyruvate reductase C04367 + C00003 = C01244 + C00004 -(3,5-diiodo-4-hydroxyphenyl)lactate(aq) + NAD(aq) =-(3,5-diiodo-4-hydroxyphenyl)pyruvate(aq) + NADH(aq) 8.2E-07 298.15 6.5 519 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KIS/HOL_262 99KIS/HOL calorimetry A 1.3.1.12 prephenate dehydrogenase C00254 + C00003 = C01179 + C00004 + C00288 prephenate(aq) + NAD(aq) = 4-hydroxyphenylpyruvate(aq) + NADH(aq) + carbon dioxide(aq) 298.15 6.98 520 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 7.94 310.15 9.1 521 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.1 310.15 9.1 522 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.13 310.15 9.1 1.38 523 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.13 310.15 9.1 524 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.45 310.15 9.1 525 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.15 310.15 9.1 2.28 526 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.12 310.15 9.1 1.98 527 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.29 310.15 9.1 2.28 528 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.15 310.15 9.1 529 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.13 310.15 9.1 530 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.1 310.15 9.1 531 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.26 310.15 8.72 532 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.23 310.15 9.1 533 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.17 310.15 9.1 534 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.24 310.15 9.1 1.43 535 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.15 310.15 5.98 536 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.1 310.15 9.1 1.98 537 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0926 310.15 9.1 1.13 538 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SOR/DEG_591 48SOR/DEG chemical analysis and spectrophotometry B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.37 310.15 6.02 539 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56COW/PIZ_1389 56COW/PIZ polarimetry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5 310.15 6.8 540 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KIT/HEM_986 59KIT/HEM calorimetry A 3.5.1.1 asparaginase C00152 + C00001 = C00049 + C00014 L-asparagine(aq) + H2O(l) = L-aspartate(aq) + ammonia(aq) 295 8.5 541 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53SIE/POT_635 53SIE/POT spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1 303.15 542 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40COH_495 40COH C 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.25 311.15 7.4 543 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71KUN/STA_1422 71KUN/STA spectrophotometry B 5.4.99.4 2-methyleneglutarate mutase C02930 = C02295 2-methyleneglutarate(aq) = methylitaconate(aq) 0.23 307.15 7.9 544 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70NAK/FUJ_535 70NAK/FUJ spectrophotometry B 2.6.1.39 2-aminoadipate transaminase C00956 + C00026 = C00322 + C00025 L-2-aminoadipate(aq) + 2-oxoglutarate(aq) = 2-oxoadipate(aq) + L-glutamate(aq) 1.32 310.15 7.5 545 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37NEG/WUL_9 37NEG/WUL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000741 293.15 7.9 546 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WU/WIT_811 67WU/WIT calorimetry A 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 6.76 547 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WU/WIT_811 67WU/WIT calorimetry A 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 6.88 548 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WU/WIT_811 67WU/WIT calorimetry A 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 6.93 549 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WU/WIT_811 67WU/WIT calorimetry A 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 6.89 550 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66REI_1356 66REI spectrophotometry C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.32 303.15 8 551 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52OHL/SHA_1070 52OHL/SHA calorimetry B 3.6.1.9 nucleotide pyrophosphatase C00003 + C00001 = C00455 + C00020 NAD(aq) + H2O(l) =-nicotinamide mononucleotide(aq) + AMP(aq) 306.15 7 552 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04DAS/BOM_1522 04DAS/BOM calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 303.15 7.5 553 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04DAS/BOM_1522 04DAS/BOM calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 303.15 7.5 554 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JES_999 75JES calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.7 555 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JES_999 75JES calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.7 556 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JES_999 75JES calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.7 557 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JES_999 75JES calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7.5 558 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JES_999 75JES calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7.5 559 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82REH/YOU_232 82REH/YOU calorimetry B 1.1.3.6&1.11.1.6 cholesterol oxidase and catalase C00187 + 0.5 C00007 = C00599 + C00001 cholesterol(aq) + 1/2 O2(aq) = cholest-4-en-3-one(aq) + H2O(l) 303.15 6.9 560 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61BEN/SCH_1408 61BEN/SCH enzymatic assay B 5.4.2.6 _-phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 24 310.15 6.5 561 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.61 303.15 7.4 2.82 562 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.54 303.15 7.4 3.22 563 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.56 303.15 7.4 2.82 564 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.83 303.15 7.4 2.26 565 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.8 303.15 7.4 2.26 566 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.69 303.15 7.4 2.46 567 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.63 303.15 7.4 2.6 568 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.02 303.15 7.4 2.02 569 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.17 303.15 7.4 1.87 570 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.29 303.15 7.4 1.76 571 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.22 303.15 7.4 1.87 572 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.45 303.15 7.4 3.22 573 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.92 303.15 7.4 2.12 574 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.72 303.15 7.4 2.46 575 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.94 303.15 7.4 2.12 576 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.28 303.15 7.4 1.76 577 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 0.65 303.15 7.4 2.6 578 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1504 06AIR2 radioactivity A 6.1.1.5 isoleucine-tRNA ligase C00002 + C00407 + C01644 = C00020 + C00013 + C03127 ATP(aq) + L-isoleusine(aq) + tRNA-Ile(aq) = AMP(aq) + pyrophosphate(aq) + L-isoleucyl-tRNA-Ile(aq) 1.04 303.15 7.4 2.02 579 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1 303.15 7.4 2.22 580 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.57 303.15 7.4 2.7 581 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 2.13 303.15 7.4 2.74 582 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1.34 303.15 7.4 3 583 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1.62 303.15 7.4 2.85 584 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.54 303.15 7.4 3 585 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.73 303.15 7.4 2.52 586 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1.66 303.15 7.4 2.74 587 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1.35 303.15 7.4 3 588 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 1.69 303.15 7.4 2.85 589 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.91 303.15 7.4 2.22 590 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.6 303.15 7.4 2.7 591 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.7 303.15 7.4 2.52 592 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1505 06AIR2 radioactivity A 6.1.1.11 serine-tRNA ligase C00002 + C00065 + C01650 = C00020 + C00013 + C02553 ATP(aq) + L-serine(aq) + tRNA-Ser(aq) = AMP(aq) + pyrophosphate(aq) + L-seryl-tRNA-Ser(aq) 0.52 303.15 7.4 3 593 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.35 303.15 7.4 2.46 594 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 2 303.15 7.4 2.02 595 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.65 303.15 7.4 2.26 596 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.24 303.15 7.4 2.82 597 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 2.36 303.15 7.4 1.76 598 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.43 303.15 7.4 2.46 599 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.23 303.15 7.4 3.3 600 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.82 303.15 7.4 2.12 601 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.65 303.15 7.4 2.26 602 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.03 303.15 7.4 2.82 603 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 0.93 303.15 7.4 3.3 604 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.96 303.15 7.4 2.02 605 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.84 303.15 7.4 2.12 606 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 2.75 303.15 7.4 1.76 607 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.13 303.15 7.4 2.6 608 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 2.39 303.15 7.4 1.87 609 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 1.33 303.15 7.4 2.6 610 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1506 06AIR2 radioactivity A 6.1.1.21 histidine t-RNA ligase C00002 + C00135 + C01643 = C00020 + C00013 + C02988 ATP(aq) + L-histidine(aq) + tRNA-His(aq) = AMP(aq) + pyrophosphate(aq) + L-histidyl-tRNA-His(aq) 2.16 303.15 7.4 1.87 611 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.22 303.15 7.4 2.82 612 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.17 303.15 7.4 2.82 613 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 2.72 303.15 7.4 1.76 614 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 2.4 303.15 7.4 1.87 615 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.98 303.15 7.4 2.02 616 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.92 303.15 7.4 2.12 617 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.43 303.15 7.4 2.46 618 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.9 303.15 7.4 2.12 619 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 2.34 303.15 7.4 1.87 620 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.31 303.15 7.4 2.6 621 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.67 303.15 7.4 2.26 622 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.46 303.15 7.4 2.46 623 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.68 303.15 7.4 2.26 624 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 0.85 303.15 7.4 3.22 625 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.33 303.15 7.4 2.6 626 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 2.05 303.15 7.4 2.02 627 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 1.16 303.15 7.4 3.22 628 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1507 06AIR2 radioactivity A 6.1.1.6 lysine-tRNA ligase C00002 + C00047 + C01646 = C00020 + C00013 + C01931 ATP(aq) + L-lysine(aq) + tRNA-Lys(aq) = AMP(aq) + pyrophosphate(aq) + L-lysyl-tRNA-Lys(aq) 2.63 303.15 7.4 1.76 629 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.38 303.15 7.4 2.22 630 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.01 303.15 7.4 2.7 631 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.17 303.15 7.4 2.52 632 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 0.96 303.15 7.4 3 633 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 2.49 303.15 7.4 1.74 634 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.04 303.15 7.4 2.7 635 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 2.04 303.15 7.4 1.85 636 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.74 303.15 7.4 2 637 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.41 303.15 7.4 2.22 638 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 2.41 303.15 7.4 1.74 639 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.75 303.15 7.4 2 640 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 2.25 303.15 7.4 1.85 641 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 1.17 303.15 7.4 2.52 642 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1508 06AIR2 radioactivity A 6.1.1.20 phenylalanine-tRNA ligase C00002 + C00079 + C01648 = C00020 + C00013 + C03511 ATP(aq) + L-phenylalanine(aq) + tRNA-Phe(aq) = AMP(aq) + pyrophosphate(aq) + L-phenylalanyl-tRNA-Phe(aq) 0.87 303.15 7.4 3 643 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 298.15 6.54 644 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 304.4 6.54 645 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 304.4 7 646 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 310.15 7 647 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 304.4 7.44 648 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 310.15 6.54 649 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 304.4 6 650 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 310.15 6 651 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 298.15 7 652 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1012 88TEW/GOL calorimetry A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 298.15 6 653 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.33 292.15 6.67 654 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.275 292.15 6.68 655 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.579 304.15 6.68 656 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.221 310.15 6.1 657 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.194 310.15 6.02 658 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.416 310.15 6.3 659 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.247 310.15 6.07 660 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.644 310.15 6.68 661 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.565 310.15 6.59 662 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.536 310.15 6.46 663 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 1.71 310.15 7.05 664 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 7.46 310.15 7.55 665 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 4.16 310.15 7.32 666 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.725 316.15 6.59 667 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 1.19 322.15 6.75 668 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.776 322.15 6.53 669 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.694 310.15 6.54 670 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.59 310.15 6.43 671 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.469 304.15 6.54 672 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.756 310.15 6.61 673 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 1.051 310.15 6.74 674 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 1.051 310.15 6.74 675 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.445 298.15 6.71 676 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.382 298.15 6.59 677 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.524 310.15 6.39 678 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.879 316.15 6.65 679 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=88TEW/GOL_1011 88TEW/GOL HPLC A 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 1.13 310.15 6.85 680 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DIT/KUB_80 84DIT/KUB spectrophotometry C 1.1.1.21 aldehyde reductase C00379 + C00006 = C00181 + C00005 xylitol(aq) + NADP(aq) = D-xylose(aq) + NADPH(aq) 0.0032 298.15 7.5 681 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STA/BUR_241 55STA/BUR C 1.2.1.10 acetaldehyde dehydrogenase (acetylating) C00084 + C00010 + C00003 = C00024 + C00004 acetaldehyde(aq) + CoA(aq) + NAD(aq) = acetyl-CoA(aq) + NADH(aq) 1200 298.15 7 682 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_280 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.6E-06 300.15 7.5 683 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_280 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.5E-06 300.15 7 684 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_280 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.6E-07 300.15 6.5 685 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_282 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 9.9E-07 300.15 7 686 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_282 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.1E-06 300.15 7.5 687 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53OLS/ANF_282 53OLS/ANF spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.1E-07 300.15 6.5 688 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_98 50RAC spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.000139 298.15 7.5 689 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_98 50RAC spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00044 298.15 8 690 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_98 50RAC spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0044 298.15 9 691 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_98 50RAC spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00139 298.15 8.5 692 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_675 92KIM/KIN spectrophotometry and fluorimetry A 2.7.6.1 ribose-phosphate pyrophosphokinase C00002 + C00117 = C00020 + C00119 ATP(aq) + D-ribose 5-phosphate(aq) = AMP(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 64.8 311.15 0.25 7.4 3 693 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62RAV/WOL_130 62RAV/WOL spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000103 298.15 8 694 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66DED_421 66DED spectrophotometry D 2.4.1.10 levansucrase C00089 + C06215 = C00031 + C06215 sucrose(aq) + (2,6--D-fructosyl)n(aq) = D-glucose(aq) + (2,6--D-fructosyl)n+1(aq) 0.036 310.15 6 695 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65LEE/DOB_211 65LEE/DOB spectrophotometry C 1.1.1.119 glucose dehydrogenase (NADP+) C00031 + C00006 = C00198 + C00005 D-glucose(aq) + NADP(aq) = D-glucono-1,5-lactone(aq) + NADPH(aq) 3.4 298.15 6.4 696 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92ELL/SRI_936 92ELL/SRI HPLC A 3.2.1.23 _-galactosidase C07064 + C00001 = C00124 + C00095 lactulose(aq) + H2O(l) = D-galactose(aq) + D-fructose(aq) 40 310.15 7 697 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ZAN/BAC_1714 64ZAN/BAC spectrophotometry B 1.1.1.17 mannitol-1-phosphate 5-dehydrogenase C00644 + C00003 = C00085 + C00004 D-mannitol-1-phosphate(aq) + NAD(ox)(aq) = D-fructose 6-phosphate(aq) + NAD(red)(aq) 1 298.15 8 698 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ZAN/BAC_1714 64ZAN/BAC spectrophotometry B 1.1.1.17 mannitol-1-phosphate 5-dehydrogenase C00644 + C00003 = C00085 + C00004 D-mannitol-1-phosphate(aq) + NAD(ox)(aq) = D-fructose 6-phosphate(aq) + NAD(red)(aq) 1.1 298.15 7.4 699 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75DON/BAR_106 75DON/BAR calorimetry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 298.15 7.5 700 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71BRI/CLA_1517 71BRI/CLA radioactivity C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.9 298.15 7.4 701 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1183 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C00463 + C00065 = C00078 + C00001 indole(aq) + L-serine(aq) = L-tryptophan(aq) + H2O(l) 283.15 7.5 702 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1183 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C00463 + C00065 = C00078 + C00001 indole(aq) + L-serine(aq) = L-tryptophan(aq) + H2O(l) 298.15 7.5 703 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1183 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C00463 + C00065 = C00078 + C00001 indole(aq) + L-serine(aq) = L-tryptophan(aq) + H2O(l) 308.15 7.5 704 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1183 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C00463 + C00065 = C00078 + C00001 indole(aq) + L-serine(aq) = L-tryptophan(aq) + H2O(l) 298.15 7.5 705 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1180 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C00118 + C00463 = C03506 D-glyceraldehyde 3-phosphate(aq) + indole(aq) = 1-(indol-3-yl)glycerol 3-phosphate(aq) 298.15 7.5 706 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1187 85WIE/HIN calorimetry A 4.2.1.20 tryptophan synthase C00065 = C00022 + C00014 L-serine(aq) = pyruvate(aq) + ammonia(aq) 308.15 7.5 707 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85WIE/HIN_1185 85WIE/HIN calorimetry and spectrophotometry A 4.2.1.20 tryptophan synthase C03506 + C00065 = C00078 + C00118 + C00001 1-(indol-3-yl)glycerol 3-phosphate(aq) + L-serine(aq) = L-tryptophan(aq) + D-glyceraldehyde 3-phosphate(aq) + H2O(l) 298.15 7.5 708 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61WIL/WIL_1209 61WIL/WIL chemical analysis B 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.022 312.15 7 709 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61WIL/WIL_1209 61WIL/WIL chemical analysis B 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.01 302.15 7 710 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53RAT/ANS_1222 53RAT/ANS chemical analysis B 4.3.2.1 arginosuccinate lyase C03406 = C00122 + C00062 N-(L-argino)succinate(aq) = fumarate(aq) + L-arginine(aq) 0.0114 311.15 7.5 711 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DEW/EMI_946 86DEW/EMI HPLC B 3.2.2.4 AMP nucleosidase C00020 + C00001 = C00147 + C00117 AMP(aq) + H2O(l) = adenine(aq) + D-ribose 5-phosphate(aq) 170 303.15 8 712 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82SAL/JOR_462 82SAL/JOR NMR C 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.038 310.15 7.1 713 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81RAM/PIC_652 81RAM/PIC radioactivity C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.09 303.15 7.4 714 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73WUR/HES_164 73WUR/HES spectrophotometry C 1.1.1.49 glucose-6-phosphate dehydrogenase C00092 + C00006 = C01236 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) = D-glucono-1,5-lactone 6-phosphate(aq) + NADPH(aq) 20 298.15 7.6 715 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 379 298.15 8.84 716 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 439 298.15 9.77 717 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 2430 298.15 10.69 718 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 1860 298.15 7.92 719 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 622 298.15 8.48 720 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 10300 298.15 7 721 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71COH/WOL_1054 71COH/WOL spectrophotometry C 3.5.4.5 cytidine deaminase C00475 + C00001 = C00299 + C00014 cytidine(aq) + H2O(l) = uridine(aq) + ammonia(aq) 318 298.15 9.31 722 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 0.0733 298.15 4.74 723 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 0.127 298.15 5.2 724 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 0.221 298.15 5.2 725 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 11 298.15 7 726 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 12.7 298.15 7.13 727 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAY/OSB_1057 60KAY/OSB spectrophotometry B 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 0.818 298.15 5.7 728 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/CRO_16 79COR/CRO spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000194 311.15 0.25 7 729 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MAT_1275 66MAT chromatography and radioactivity B 5.1.3.10 CDPabequose epimerase C03598 = C03599 CDP-3,6-dideoxy-D-glucose(aq) = CDP-3,6-dideoxy-D-mannose(aq) 1.3 310.15 8.4 730 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74WON/FRE_697 74WON/FRE enzymatic assay B 2.7.7.12 UDPglucose-hexose-1-phosphate uridylyltransferase C00029 + C03384 = C00103 + C00052 UDPglucose(aq) + D-galactose 1-phosphate(aq) =-D-glucose 1-phosphate(aq) + UDPgalactose(aq) 2.1 300.15 8.5 731 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SCH/KRI_107 76SCH/KRI calorimetry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 298.15 7.5 732 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57BUR/HOR_1263 57BUR/HOR enzymatic assay C 5.1.3.4 L-ribulose-phosphate 4-epimerase C01101 = C00231 L-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1 308.15 7 733 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73ROT/KIS_300 73ROT/KIS calorimetry A 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 298.15 7.4 734 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60BLA_349 60BLA spectrophotometry B 2.1.2.1 glycine hydroxymethyltransferase C00143 + C00037 + C00001 = C00101 + C00065 5,10-methylenetetrahydrofolate(aq) + glycine(aq) + H2O(l) = tetrahydrofolate(aq) + L-serine(aq) 0.098 298.15 7.4 735 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55HOR/SMY_371 55HOR/SMY paper chromatography C 2.2.1.2 transaldolase C05382 + C00118 = C00279 + C00085 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phosphate(aq) + D-fructose 6-phosphate(aq) 0.82 298.15 7.6 736 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62DOU2_160 62DOU2 spectrophotometry C 1.1.1.48 galactose dehydrogenase C00124 + C00003 = C03383 + C00004 D-galactose(aq) + NAD(aq) = D-galactono-1,4-lactone(aq) + NADH(aq) 570 303.15 6.7 737 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55CAR/LEL_423 55CAR/LEL spectrophotometry C 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 5 310.15 7.4 738 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/GOL_1636 00TEW/GOL calorimetry and chromatography A 2.6.1.42 branched-chain-amino-acid transferase C00183 + C00026 = C06255 + C00025 L-valine(aq) + 2-oxoglutarate(aq) = 2-oxovalerate(aq) + L-glutamate(aq) 298.15 0.31 7.21 739 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/GOL_1637 00TEW/GOL calorimetry and chromatography A 2.6.1.42 branched-chain-amino-acid transferase C00123 + C00026 = C00233 + C00025 L-leucine(aq) + 2-oxoglutarate(aq) = 2-oxoisocaproate(aq) + L-glutamate(aq) 2.42 298.15 0.31 7.19 740 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/GOL_1635 00TEW/GOL calorimetry and chromatography A 2.6.1.42 branched-chain-amino-acid transferase C00183 + C00026 = C06255 + C00025 L-valine(aq) + 2-oxoglutarate(aq) = 2-oxovalerate(aq) + L-glutamate(aq) 1.67 298.15 0.31 7.21 741 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=01AND/LEV_1510 01AND/LEV chromatography B 2.4.1.216 trehalose-6-phosphate phosphorylase C00689 + C00009 = C00103 + C00092 ,-trehalose 6-phosphate(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-glucose 6-phosphate(aq) 0.032 308.15 7 742 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=01AND/LEV_1510 01AND/LEV chromatography B 2.4.1.216 trehalose-6-phosphate phosphorylase C00689 + C00009 = C00103 + C00092 ,-trehalose 6-phosphate(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-glucose 6-phosphate(aq) 0.026 308.15 6.3 743 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45OHL_817 45OHL calorimetry B 3.1.3.2 acid phosphatase C00002 + 3 C00001 = C00212 + 3 C00009 ATP(aq) + 3 H2O(l) = adenosine(aq) + 3 orthophosphate(aq) 297.45 3.7 744 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45OHL_816 45OHL calorimetry B 3.1.3.2 acid phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 297.45 3.7 745 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93WER/TWE_1192 93WER/TWE HPLC B 4.2.1.35 (R)-2-methylmalate dehydratase C02612 = C02226 + C00001 (R)-2-methylmalate(aq) = 2-methylmaleate(aq) + H2O(l) 0.00962 298.15 0.1 7 746 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/GOL_1638 00TEW/GOL calorimetry and chromatography A 2.6.1.42 branched-chain-amino-acid transferase C00123 + C00026 = C00233 + C00025 L-leucine(aq) + 2-oxoglutarate(aq) = 2-oxoisocaproate(aq) + L-glutamate(aq) 298.15 0.31 7.2 747 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.00082 293.15 7.12 748 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.0113 293.15 8.31 749 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.000474 293.15 6.98 750 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.00299 293.15 7.79 751 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.00339 293.15 7.89 752 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.0128 293.15 8.25 753 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.0116 293.15 8.36 754 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.000723 293.15 7.03 755 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.000922 293.15 7.39 756 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.00337 293.15 7.86 757 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEL/DEF_233 59DEL/DEF spectrophotometry B 1.1.99.3 gluconate 2-dehydrogenase C00257 + C00006 = C06473 + C00005 D-gluconate(aq) + NADP(aq) = 2-oxo-D-gluconate(aq) + NADPH(aq) 0.000637 293.15 7.24 758 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67POE/GUT_319 67POE/GUT calorimetry B 1.6.99.3 NADH dehydrogenase 2 C00004 + C00007 = 2 C00003 + 2 C00001 2 NADH(aq) + O2(aq) = 2 NAD(aq) + 2 H2O(l) 298.15 7 759 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_140 80COO/BLA spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00071 298.15 9 760 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HAU_265 56HAU spectrophotometry C 1.3.99.2 butyryl-CoA dehydrogenase C00136 + C01748 = C00877 + C01748 butanoyl-CoA(aq) + pyocyanine(aq) = 2-butenoyl-CoA(aq) + reduced pyocyanine(aq) 0.23 303.15 7.2 761 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70KNO/HAN_690 70KNO/HAN B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.155 303.15 7.8 762 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47KAL_1556 47KAL spectrophotometry B 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.019 303.15 7.5 763 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.48 298.15 0.0516 7.6 764 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.54 298.15 0.1014 7.6 765 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.52 298.15 0.01 6.11 766 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.44 298.15 0.01 6.53 767 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.33 298.15 0.0015 7.6 768 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.43 298.15 0.0216 7.6 769 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.38 298.15 0.0115 7.6 770 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.41 298.15 0.01 6.99 771 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.38 298.15 0.01 7.45 772 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77VEE/KRU_1690 77VEE/KRU spectrophotometry A 1.6.1.1 NAD(P)+ transhydrogenase (B-specific) C00004 + C00006 = C00003 + C00005 NAD(red)(aq) + NADP(ox)(aq) = NAD(ox)(aq) + NADP(red)(aq) 0.35 298.15 0.0061 7.6 773 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=05TEW/GOL_1629 05TEW/GOL calorimetry A 3.5.5.1 nitrilase C09814 + 2 C00001 = C00180 + C00014 benzonitrile(aq) + 2 H2O(aq) = benzoic acid(aq) + ammonia(aq) 298.15 0.29 7.51 774 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.68 2.2 775 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.8 3.27 776 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.8 2.2 777 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.83 3.18 778 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 298.15 8.9 3.27 779 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 304.8 8.9 3.27 780 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 9.15 2.2 781 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.58 2.2 782 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.8 2.97 783 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.8 2.49 784 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 298.15 8.9 3 785 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.53 2.2 786 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 7.87 2.2 787 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_775 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 311.15 8.83 3.18 788 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DAS/BRO_746 85DAS/BRO calorimetry C 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 310.15 7.2 789 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DAS/BRO_746 85DAS/BRO calorimetry C 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 310.15 790 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75SUN_700 75SUN radioactivity C 2.7.7.14 ethanolamine-phosphate cytidylyltransferase C00063 + C00346 = C00013 + C00570 CTP(aq) + O-phosphorylethanolamine(aq) = pyrophosphate(aq) + CDPethanolamine(aq) 0.46 310.15 7.8 791 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52OHL/SHA_792 52OHL/SHA calorimetry B 3.1.3.1 alkaline phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 302.15 9.6 792 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65EIC/CYN_214 65EIC/CYN spectrophotometry C 1.1.1.125 2-deoxy-D-gluconate dehydrogenase C02782 + C00003 = C03926 + C00004 2-deoxy-D-gluconate(aq) + NAD(aq) = 2-deoxy-3-dehydro-D-gluconate(aq) + NADH(aq) 0.0034 308.15 9 793 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34JAC_1142 34JAC polarimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 8.4 278.15 6.8 794 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34JAC_1142 34JAC polarimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.5 288.15 6.8 795 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34JAC_1142 34JAC polarimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.1 298.15 6.8 796 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34JAC_1142 34JAC polarimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.8 311.15 6.8 797 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34JAC_1142 34JAC polarimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 2.1 327.15 6.8 798 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64LOW/PAS_1093 64LOW/PAS fluorimetry A 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 9.3E-05 311.15 7.1 799 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43KUB/OTT_97 43KUB/OTT spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 6E-05 295.15 7.4 800 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65GHO/ROS_1274 65GHO/ROS spectrophotometry and radioactivity C 5.1.3.9 N-acylglucosamine-6-phosphate 2-epimerase C00357 = C04257 N-acetyl-D-glucosamine 6-phosphate(aq) = N-acetyl-D-mannosamine 6-phosphate(aq) 0.43 310.15 7.6 801 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ROS/ADA_1133 67ROS/ADA enzymatic assay, spectrophotometry, and chemical analysis B 4.1.3.16 4-hydroxy-2-oxoglutarate aldolase C01127 = C00022 + C00048 4-hydroxy-2-oxoglutarate(aq) = pyruvate(aq) + glyoxylate(aq) 0.01 310.15 8.4 802 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAT/HUE_297 63MAT/HUE spectrophotometry B 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 6.1E-05 298.15 7.5 803 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAT/HUE_297 63MAT/HUE spectrophotometry B 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 0.00056 298.15 8.5 804 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84KOL/EGG_1201 84KOL/EGG spectrophotometry B 4.2.1.85 dimethylmaleate hydratase C03652 = C00922 + C00001 (2R,3S)-2,3-dimethylmalate(aq) = dimethylmaleate(aq) + H2O(l) 0.43 308.15 7 805 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_821 49MEY/GRE chemical analysis C 3.1.3.2 acid phosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 5.3 311.15 5.8 806 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GER/WES_839 75GER/WES calorimetry A 3.1.4.- phosphohydrolase (unclassified) C00575 + C00001 = C01367 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = adenosine 3'-monophosphate(aq) 310.15 7.2 3 807 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GER/WES_839 75GER/WES calorimetry A 3.1.4.- phosphohydrolase (unclassified) C00575 + C00001 = C01367 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = adenosine 3'-monophosphate(aq) 298.15 7.3 3 808 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GER/WES_838 75GER/WES calorimetry A 3.1.4.17 3',5'-cyclic-nucleotide phosphodiesterase C00575 + C00001 = C00020 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = AMP(aq) 298.15 7.2 809 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GER/WES_838 75GER/WES calorimetry A 3.1.4.17 3',5'-cyclic-nucleotide phosphodiesterase C00575 + C00001 = C00020 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = AMP(aq) 310.15 7.3 810 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53NIS/BAR_499 53NIS/BAR spectrophotometry B 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.13 310.65 7.4 811 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92WAN/CHE_747 92WAN/CHE calorimetry B 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 298.15 7 812 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92WAN/CHE_747 92WAN/CHE calorimetry B 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 298.15 7 813 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KEN_1037 74KEN spectrophotometry C 3.5.2.3 dihydroorotase C00337 + C00001 = C00438 (S)-dihydroorotate(aq) + H2O(l) = N-carbamoyl-L-aspartate(aq) 5.9 310.15 6.5 814 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62MEN_672 62MEN chromatography and spectrophotometry C 2.7.4.14 cytidylate kinase C00002 + C00055 = C00008 + C00112 ATP(aq) + CMP(aq) = ADP(aq) + CDP(aq) 1 310.15 7.5 815 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK_1303 67TAK chemical analysis and polarimetry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.74 298.15 7 816 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK_1303 67TAK chemical analysis and polarimetry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.15 333.15 7 817 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK_1303 67TAK chemical analysis and polarimetry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.3 343.15 7 818 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK_1303 67TAK chemical analysis and polarimetry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.92 313.15 7 819 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70TSU/FRI_291 70TSU/FRI spectrophotometry C 1.4.1.12 2,4-diaminopentanoate dehydrogenase C03943 + C00003 + C00001 = C03341 + C00004 + C00014 2,4-diaminopentanoate(aq) + NAD(aq) + H2O(l) = 2-amino-4-oxopentanoate(aq) + NADH(aq) + ammonia(aq) 0.000324 301.15 8.75 820 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92ELL/SRI_933 92ELL/SRI HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 152 310.15 7 821 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KAP/COL_309 53KAP/COL spectrophotometry B 1.6.1.1 NAD(P)+ transhydrogenase C00003 + C00005 = C00004 + C00006 NAD(aq) + NADPH(aq) = NADH(aq) + NADP(aq) 1.48 310.15 6 822 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KAP/COL_309 53KAP/COL spectrophotometry B 1.6.1.1 NAD(P)+ transhydrogenase C00003 + C00005 = C00004 + C00006 NAD(aq) + NADPH(aq) = NADH(aq) + NADP(aq) 1.43 310.15 6.5 823 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KAP/COL_309 53KAP/COL spectrophotometry B 1.6.1.1 NAD(P)+ transhydrogenase C00003 + C00005 = C00004 + C00006 NAD(aq) + NADPH(aq) = NADH(aq) + NADP(aq) 1.41 310.15 7.5 824 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_13 56KAP/CIO spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0016 303.15 8 825 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_13 56KAP/CIO spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00016 303.15 7 826 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1292 43MEY/JUN chemical analysis and polarimetry B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0024 311.15 7 827 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1292 43MEY/JUN chemical analysis and polarimetry B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.002 303.15 7 828 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1292 43MEY/JUN chemical analysis and polarimetry B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.003 313.15 7 829 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1292 43MEY/JUN chemical analysis and polarimetry B 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.011 333.15 7 830 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72DUF/NEL_1526 72DUF/NEL enzymatic assay B 2.6.1.19 4-aminobutyrate transaminase C00334 + C00026 = C00232 + C00025 4-aminobutanoate(aq) + 2-oxoglutarate(aq) = 4-oxobutanoate(aq) + L-glutamate(aq) 0.29 298.15 8.5 831 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66CHA/WIL_327 66CHA/WIL spectrophotometry and electrophoresis B 1.8.4.3 glutathione-CoA-glutathione transhydrogenase C00010 + C00127 = C00920 + C00051 CoA(aq) + oxidized glutathione(aq) = CoA-glutathione(aq) + reduced glutathione(aq) 1.25 298.15 6.9 832 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97KAS/TEW_1423 97KAS/TEW calorimetry A 5.4.99.5 chorismate mutase C00251 = C00254 chorismate(aq) = prephenate(aq) 298.15 7.7 833 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97KAS/TEW_1423 97KAS/TEW calorimetry A 5.4.99.5 chorismate mutase C00251 = C00254 chorismate(aq) = prephenate(aq) 298.15 6.93 834 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BOS/YAM_471 74BOS/YAM spectrophotometry C 2.4.2.3 uridine phosphorylase C00299 + C00009 = C00106 + C00620 uridine(aq) + orthophosphate(aq) = uracil(aq) + D-ribose 1-phosphate(aq) 0.078 310.15 8.2 835 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BOS/YAM_471 74BOS/YAM spectrophotometry C 2.4.2.3 uridine phosphorylase C00299 + C00009 = C00106 + C00620 uridine(aq) + orthophosphate(aq) = uracil(aq) + D-ribose 1-phosphate(aq) 0.031 310.15 7.4 836 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1071 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 837 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1071 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 838 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1071 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 839 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1071 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 292.4 8 840 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1071 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 291.6 8 841 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KIT/BEN_1077 55KIT/BEN calorimetry A 3.6.1.32 myosin ATPase C00081 + C00001 = C00104 + C00009 ITP(aq) + H2O(l) = IDP(aq) + orthophosphate(aq) 293.15 8 842 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77SRA/FRE_722 77SRA/FRE spectrophotometry C 2.8.3.8 acetate CoA-transferase C00024 + C00164 = C00332 + C00033 acetyl-CoA(aq) + acetoacetate(aq) = acetoacetyl-CoA(aq) + acetate(aq) 0.13 298.15 8.1 843 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KIT/HEM_991 59KIT/HEM calorimetry A 3.5.1.2 glutaminase C00064 + C00001 = C00025 + C00014 L-glutamine(aq) + H2O(l) = L-glutamate(aq) + ammonia(aq) 295 4.5 844 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70VEE/RAI_584 70VEE/RAI spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 59 311.15 0.25 7 845 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_1411 92KIM/KIN enzymatic assay A 5.4.2.7 phosphopentomutase C00620 = C00117 D-ribose 1-phosphate(aq) = D-ribose 5-phosphate(aq) 26 311.15 0.25 7 3 846 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_910 89TEW/GOL calorimetry A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 5.65 847 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_910 89TEW/GOL calorimetry A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 304.55 5.65 848 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_910 89TEW/GOL calorimetry A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 316.15 5.65 849 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_910 89TEW/GOL calorimetry A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 310.15 5.65 850 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_820 49MEY/GRE chemical analysis C 3.1.3.2 acid phosphatase C00354 + C00001 = C01094 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 1-phosphate(aq) + orthophosphate(aq) 8 311.15 5.8 851 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_912 89TEW/GOL calorimetry A 3.2.1.20 -glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 5.65 852 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_912 89TEW/GOL calorimetry A 3.2.1.20 -glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 304.55 5.65 853 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_916 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C00185 + C00001 = 2 C00031 cellobiose(aq) + H2O(l) = 2 D-glucose(aq) 310.15 5.65 854 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_916 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C00185 + C00001 = 2 C00031 cellobiose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 5.65 855 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_916 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C00185 + C00001 = 2 C00031 cellobiose(aq) + H2O(l) = 2 D-glucose(aq) 304.55 5.65 856 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 17.2 285.75 5.65 857 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 17.5 292.25 5.65 858 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 17.7 298.15 5.65 859 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 17.9 304.15 5.65 860 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 18.5 310.35 5.65 861 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_918 89TEW/GOL HPLC A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 19.5 316.15 5.65 862 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_919 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 5.65 863 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_919 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 304.55 5.65 864 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_919 89TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C08240 + C00001 = 2 C00031 -gentiobiose(aq) + H2O(l) = 2 D-glucose(aq) 310.15 5.65 865 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAT/SLA_712 68HAT/SLA C 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.0002 295.15 8.3 866 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83HAA/KAR_1015 83HAA/KAR C 3.5.1.11 penicillin amidase C08126 + C00001 = C02954 + C02181 phenoxymethylpenicillin-(aq) + H2O(l) = 6-aminopenicillanate-(aq) + phenoxyacetate(aq) 0.00128 298.15 6.37 867 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83HAA/KAR_1013 83HAA/KAR C 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G-(aq) + H2O(l) = 6-aminopenicillanic acid-(aq) + phenylacetic acid(aq) 0.0003 298.15 6.5 868 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99MUN/LOP_1589 99MUN/LOP chromatography B 5.1.3.6 UDPglucuronate 4-epimerase C00167 = C00617 UDP-D-glucuronate(aq) = UDP-D-galacturonate(aq) 1.3 310.15 7.5 869 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.031 311.15 6.39 870 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0511 311.15 6.99 871 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0302 311.15 7.01 872 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.014 311.15 7.03 873 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.014 311.15 7.04 874 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.00829 311.15 7.79 875 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0197 311.15 7.18 876 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.024 311.15 7.17 877 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0222 311.15 6.39 878 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0221 311.15 6.62 879 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0301 311.15 6.8 880 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0344 311.15 6.99 881 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0229 311.15 7.2 882 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0328 311.15 6.99 883 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_292 85LIE spectrophotometry and enzymatic assay A 1.4.4.2 glycine dehydrogenase (decarboxylating) C00037 + C00725 = C80069 + C00288 glycine(aq) + lipoate(aq) = S-aminomethyldihydro--lipoate(aq) + carbon dioxide(aq) 0.0465 311.15 6.83 884 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72DAH/AND_1108 72DAH/AND enzymatic assay and spectrophotometry B 4.1.2.18 2-dehydro-3-deoxy-L-pentonate aldolase C06159 = C00022 + C00424 2-dehydro-3-deoxy-D-fuconate(aq) = pyruvate(aq) + (S)-lactaldehyde(aq) 0.00012 301.15 7.5 885 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91WOH/DIE_304 91WOH/DIE spectrophotometry C 1.5.1.15 methylenetetrahydrofolate dehydrogenase (NAD+) C00143 + C00003 = C00445 + C00004 5,10-methylenetetrahydrofolate(aq) + NAD(aq) = 5,10-methenyltetrahydrofolate(aq) + NADH(aq) 0.0096 310.15 7.9 886 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91WOH/DIE_304 91WOH/DIE spectrophotometry C 1.5.1.15 methylenetetrahydrofolate dehydrogenase (NAD+) C00143 + C00003 = C00445 + C00004 5,10-methylenetetrahydrofolate(aq) + NAD(aq) = 5,10-methenyltetrahydrofolate(aq) + NADH(aq) 0.012 310.15 7.8 887 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91WOH/DIE_305 91WOH/DIE spectrophotometry C 1.5.1.15 methylenetetrahydrofolate dehydrogenase (NAD+) C00143 + C80057 = C00445 + C80058 5,10-methylenetetrahydrofolate(aq) + AP-NAD(aq) = 5,10-methenyltetrahydrofolate(aq) + AP-NADH(aq) 0.11 310.15 8.25 888 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91WOH/DIE_305 91WOH/DIE spectrophotometry C 1.5.1.15 methylenetetrahydrofolate dehydrogenase (NAD+) C00143 + C80057 = C00445 + C80058 5,10-methylenetetrahydrofolate(aq) + AP-NAD(aq) = 5,10-methenyltetrahydrofolate(aq) + AP-NADH(aq) 0.86 310.15 7.2 889 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66JEN/DAR_502 66JEN/DAR spectrophotometry C 2.6.1.1 aspartate transaminase C19838 + C00026 = C03459 + C00025 erythro-3-hydroxyaspartate(aq) + 2-oxoglutarate(aq) = 2-oxo-3-hydroxybutanedioic acid(aq) + L-glutamate(aq) 12 303.15 7.9 890 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66THO/NAN_1158 66THO/NAN spectrophotometry C 4.2.1.3 aconitate hydratase C00158 = C00417 + C00001 citrate(aq) = cis-aconitate(aq) + H2O(l) 0.046 298.15 7.4 891 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=42LEN/STR_505 42LEN/STR chemical analysis C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.7 310.15 7.3 892 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97XU/EAD_1712 97XU/EAD radioactivity B 2.4.2.8 hypoxanthine phosphoribosyltransferase C00130 + C00013 = C00262 + C00119 IMP(aq) + pyrophosphate(aq) = hypoxanthine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 3.3E-06 303.15 7.4 893 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97DEJ/ROC_428 97DEJ/ROC enzymatic assay and spectrophotometry B 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 6.7 303.15 7 894 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97DEJ/ROC_428 97DEJ/ROC enzymatic assay and spectrophotometry B 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 250 303.15 9.4 895 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56GRE/COH_1296 56GRE/COH chemical analysis B 5.3.1.3 arabinose isomerase C01019 = C01721 L-fucose(aq) = L-fuculose(aq) 0.12 310.15 8 896 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_1129 52STE/OCH spectrophotometry B 4.1.3.7&1.1.1.37 citrate (si)-synthase and malate dehydrogenase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 0.48 295.15 6.25 897 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_1129 52STE/OCH spectrophotometry B 4.1.3.7&1.1.1.37 citrate (si)-synthase and malate dehydrogenase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 10.8 295.15 7.2 898 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_1129 52STE/OCH spectrophotometry B 4.1.3.7&1.1.1.37 citrate (si)-synthase and malate dehydrogenase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 599 295.15 8.2 899 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_1129 52STE/OCH spectrophotometry B 4.1.3.7&1.1.1.37 citrate (si)-synthase and malate dehydrogenase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 5610 295.15 8.7 900 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_1129 52STE/OCH spectrophotometry B 4.1.3.7&1.1.1.37 citrate (si)-synthase and malate dehydrogenase C00149 + C00024 + C00003 + C00001 = C00158 + C00010 + C00004 (S)-malate(aq) + acetyl-CoA(aq) + NAD(aq) + H2O(l) = citrate(aq) + CoA(aq) + NADH(aq) 101 295.15 7.6 901 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66SCH_385 66SCH spectrophotometry C 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 145 310.15 7 902 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66SCH_385 66SCH spectrophotometry C 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 5100 310.15 7 903 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50SLE_1345 50SLE spectrophotometry B 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 1.5 303.15 7.4 904 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.85 0.2 905 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.9 0.3 906 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.86 0.55 907 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.9 0.78 908 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.9 1.71 909 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.89 1.73 910 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.92 1.97 911 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.93 2.34 912 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.98 2.89 913 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.98 3.57 914 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.88 1.65 915 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.87 1.5 916 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.92 1.17 917 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.92 1.85 918 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.86 1.41 919 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GOL_548 76GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.16 8.64 1.8 920 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73HER_1136 73HER B 4.1.3.24 malyl-CoA lyase C04348 = C00024 + C00048 (R,S)-malyl-CoA(aq) = acetyl-CoA(aq) + glyoxylate(aq) 0.0029 303.15 7.4 921 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_1338 86CAS/VEE2 enzymatic assay and spectrophotometry A 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.83 311.15 0.25 7 3 922 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00ZHE/BLA_1715 00ZHE/BLA spectrophotometry B 1.1.1.169 2-dehydropantoate 2-reductase C00522 + C00006 = C00966 + C00005 (R)-pantoate(aq) + NADP(ox) = 2-dehydropantoate(aq) + NADP(red)(aq) 0.00148 298.15 7.5 923 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HAK/GLA_100 56HAK/GLA spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 9.78E-06 289.15 6.8 924 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HAK/GLA_100 56HAK/GLA spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 3.24E-05 308.15 6.8 925 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HAK/GLA_100 56HAK/GLA spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 1.74E-05 298.15 6.8 926 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.2 303.15 5.15 927 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6 303.15 5.43 928 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.8 303.15 6.1 929 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.8 303.15 6.65 930 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6 303.15 4.6 931 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.6 303.15 5.01 932 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROD/TOW_1390 57ROD/TOW spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.3 303.15 5.7 933 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57MAX_1249 57MAX spectrophotometry C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.33 298.15 8.7 934 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_784 93LAR/TEW HPLC A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 158 298.15 8.55 4.44 935 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88LIM/RAI_1287 88LIM/RAI enzymatic assay and spectrophotometry; NMR B 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 22 303.15 7.6 936 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_773 76LAW/GUY enzymatic assay; spectrophotometry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 110 310.15 0.25 6.99 3 937 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35AKA_1170 35AKA C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.3 301.15 938 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=01TEW/KIS_1645 01TEW/KIS calorimetry A 4.1.2.15 2-dehydro-3-deoxyheptonate aldolase C00074 + C00279 + C00001 = C04691 + C00009 phosphoenolpyruvate(aq) + D-erythrose 4-phosphate(aq) + H2O(l) = 2-dehydro-3-deoxy-D-arabino-heptonate 7-phosphate(aq) + orthophosphate(aq) 298.15 0.09 8.18 939 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67UYE/RAB_301 67UYE/RAB spectrophotometry B 1.5.1.5 methylenetetrahydrofolate dehydrogenase (NADP+) C00143 + C00006 = C00445 + C00005 5,10-methylenetetrahydrofolate(aq) + NADP(aq) = 5,10-methenyltetrahydrofolate(aq) + NADPH(aq) 0.14 298.15 6.9 940 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/KIE2_1386 35MEY/KIE2 polarimetry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 4 301.15 941 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93BES/REB_352 93BES/REB radioactivity B 2.1.2.1 glycine hydroxymethyltransferase C04377 + C00037 + C00001 = C01217 + C00065 CH2-H4PteGlu4(aq) + glycine(aq) + H2O(l) = H4PteGlu4(aq) + L-serine(aq) 0.063 310.15 7.4 942 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93BES/REB_351 93BES/REB radioactivity B 2.1.2.1 glycine hydroxymethyltransferase C00143 + C00037 + C00001 = C00101 + C00065 5,10-methylenetetrahydrofolate(aq) + glycine(aq) + H2O(l) = tetrahydrofolate(aq) + L-serine(aq) 0.067 310.15 7.4 943 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54CHA_1086 54CHA radioactivity B 4.1.2.2 ketotetraose-phosphate aldolase C03394 = C00067 + C00111 erythrulose 1-phosphate(aq) = formaldehyde(aq) + glycerone phosphate(aq) 0.00043 301.15 7.4 944 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89RIZ/HAR_55 89RIZ/HAR spectrophotometry C 1.1.1.9 D-xylulose reductase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.00069 298.15 7 945 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_1248 86CAS/VEE2 enzymatic assay and spectrophotometry A 5.1.3.1 ribulose-phosphate 3-epimerase C00199 = C00231 D-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.82 311.15 0.25 7 3 946 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.29 311.15 0.25 7 3.1 947 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 11.6 298.15 0.25 7 3.02 948 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 11.4 298.15 0.25 7 3.11 949 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 13.7 298.15 0.25 6.99 3.11 950 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.81 298.15 0.25 7.07 3.14 951 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.66 311.15 0.25 7.03 3.19 952 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.15 311.15 0.25 7.03 3.19 953 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.85 311.15 0.25 7.03 3.19 954 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.82 311.15 0.25 7.03 3.19 955 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.7 311.15 0.25 7.03 3.13 956 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.68 311.15 0.25 7.03 3.13 957 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.88 311.15 0.25 7.03 3.12 958 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 10.4 311.15 0.25 7.06 4.6 959 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.7 311.15 0.25 7.07 4.44 960 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.99 311.15 0.25 7.05 4.44 961 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.9 311.15 0.25 7.1 4.44 962 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 15.5 311.15 0.25 6.89 2.2 963 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 15.2 311.15 0.25 6.89 2.2 964 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 14.4 311.15 0.25 7.4 2.28 965 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 14.9 311.15 0.25 7.41 2.28 966 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 19.4 311.15 0.25 7.53 2.3 967 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 19.4 311.15 0.25 7.53 2.3 968 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.74 311.15 0.25 7.03 3.13 969 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.82 311.15 0.25 7.06 2.55 970 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.45 311.15 0.25 7 3.08 971 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 10.7 298.15 0.25 7 3.11 972 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.54 311.15 0.25 7.03 3.19 973 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.66 311.15 0.25 7.04 3.59 974 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 18.8 311.15 0.25 7.53 2.3 975 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.34 311.15 0.25 7.03 3.13 976 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 11.5 311.15 0.25 6.97 2.6 977 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 11.1 298.15 0.25 7 3.11 978 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 9.68 311.15 0.25 7.03 3.13 979 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 15.7 311.15 0.25 7.39 2.28 980 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74GUY/WEB_1434 74GUY/WEB spectrophotometry and enzymatic assay A 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 8.46 311.15 0.25 7 3.09 981 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59BAR/SMY_1214 59BAR/SMY spectrophotometry B 4.3.1.2 methylaspartate ammonia-lyase C03618 = C01732 + C00014 L-threo-3-methylaspartate(aq) = 2-methylfumarate(aq) + ammonia(aq) 0.238 298.15 7.9 982 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59BAR/SMY_1214 59BAR/SMY spectrophotometry B 4.3.1.2 methylaspartate ammonia-lyase C03618 = C01732 + C00014 L-threo-3-methylaspartate(aq) = 2-methylfumarate(aq) + ammonia(aq) 0.306 298.15 9.7 983 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93BOH/HUT_226 93BOH/HUT calorimetry A 1.1.3.4 glucose oxidase C00031 + C00007 = C00198 + C00027 -D-glucose(aq) + O2(aq) = D-glucono-1,5-lactone(aq) + H2O2(aq) 298.15 6.86 984 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=07TEW/KIS_1653 07TEW/KIS chromatography A 3.5.2.2 dihydropyrimidinase C00429 + C00001 = C02642 5,6-dihydrouracil(aq) + H2O(l) = 3-ureidopropanoic acid(aq) 25.9 298.15 0.28 6.8 985 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=07TEW/KIS_1653 07TEW/KIS chromatography A 3.5.2.2 dihydropyrimidinase C00429 + C00001 = C02642 5,6-dihydrouracil(aq) + H2O(l) = 3-ureidopropanoic acid(aq) 160 298.15 0.32 7.84 986 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=07TEW/KIS_1653 07TEW/KIS chromatography A 3.5.2.2 dihydropyrimidinase C00429 + C00001 = C02642 5,6-dihydrouracil(aq) + H2O(l) = 3-ureidopropanoic acid(aq) 64.8 298.15 0.31 7.38 987 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=07TEW/KIS_1656 07TEW/KIS chromatography A 3.5.2.2 dihydropyrimidinase C00429 + C00001 = C02642 5,6-dihydrouracil(aq) + H2O(l) = 3-ureidopropanoic acid(aq) 298.15 0.34 7.44 988 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MAR/WAD_641 66MAR/WAD electrophoresis and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.81 303.15 7.4 989 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CON/DEL_1320 97CON/DEL HPLC C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.98 333.15 7 990 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CON/DEL_1320 97CON/DEL HPLC C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.03 338.15 7 991 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CON/DEL_1320 97CON/DEL HPLC C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.14 343.15 7 992 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CON/DEL_1320 97CON/DEL HPLC C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.22 348.15 7 993 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97CON/DEL_1320 97CON/DEL HPLC C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.39 353.15 7 994 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63HIN/WOL_1355 63HIN/WOL spectrophotometry B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.32 303.15 0.1 8 995 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.45 3.3 996 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.48 3.3 997 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 6.98 3.52 998 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.075 7.27 3.65 999 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.075 7.6 3.65 1000 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 6.87 3.6 1001 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.27 3.52 1002 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.27 3.52 1003 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.37 3.51 1004 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.35 3.43 1005 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.51 3.6 1006 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.075 7.61 3.65 1007 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 1 7.22 3.29 1008 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.19 3.52 1009 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.3 3.52 1010 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.18 3.52 1011 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.27 3.52 1012 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.64 3.43 1013 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 1 7.22 3.29 1014 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.15 3.52 1015 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 6.87 3.6 1016 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 6.87 3.6 1017 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.49 3.6 1018 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.88 3.59 1019 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.36 3.68 1020 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.1 7.47 3.6 1021 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 0.6 7.16 3.52 1022 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54GIN/STU_1062 54GIN/STU calorimetry A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 298.15 1 7.28 3.29 1023 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KOR/GLA_703 61KOR/GLA enzymatic assay B 2.7.7.24 glucose-1-phosphate thymidylyltransferase C00459 + C00103 = C00842 + C00013 dTTP(aq) + D-glucose 1-phosphate(aq) = dTDPglucose(aq) + pyrophosphate(aq) 0.67 298.15 8 1024 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.138 298.15 0.1 8.4 3.49 1025 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.123 298.15 0.1 8.4 3.21 1026 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0986 298.15 0.1 8.4 3.2 1027 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0739 298.15 0.1 8.4 3.2 1028 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0218 298.15 0.1 8.4 2.22 1029 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0159 298.15 0.1 8.4 2.07 1030 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0178 298.15 0.1 8.4 2.07 1031 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0251 298.15 0.1 8.4 2.02 1032 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0592 298.15 0.1 8.4 3.21 1033 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0243 298.15 0.1 8.4 2.03 1034 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0184 298.15 0.1 8.4 1.96 1035 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0293 298.15 0.1 8.4 2.42 1036 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.064 298.15 0.1 8.4 3.16 1037 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0457 298.15 0.1 8.4 2.78 1038 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.043 298.15 0.1 8.4 2.87 1039 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0176 298.15 0.1 8.4 2.05 1040 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.118 298.15 0.1 8.4 3.51 1041 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAT/DAT_1126 65TAT/DAT chemical analysis and spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0667 298.15 0.1 8.4 3 1042 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.036 298.15 6.5 1043 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.049 298.15 6.8 1044 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.029 298.15 6.2 1045 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.065 298.15 7 1046 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.116 298.15 7.3 1047 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KUR/TAK_1231 74KUR/TAK fluorimetry, spectrophotometry, and radioactivity A 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.27 298.15 7.7 1048 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73HAV/PIT_1304 73HAV/PIT polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.06 343.15 6.85 1049 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73HAV/PIT_1304 73HAV/PIT polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.1 352.65 6.85 1050 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73HAV/PIT_1304 73HAV/PIT polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.02 333.15 6.85 1051 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85BAD/WAL_1511 85BAD/WAL spectrophotometry B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 0.8 310.15 9 1052 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93WER/TWE_1189 93WER/TWE HPLC B 4.2.1.31 maleate hydratase C00497 = C01384 + C00001 (R)-malate(aq) = maleate(aq) + H2O(l) 0.000488 298.15 0.1 7 1053 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_774 79LAW/VEE enzymatic assay; spectrophotometry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 109 310.15 0.25 6.99 1054 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_774 79LAW/VEE enzymatic assay; spectrophotometry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 110 310.15 0.25 6.99 2.22 1055 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KAH/SCH_189 92KAH/SCH spectrophotometry C 1.1.1.56 ribitol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.0033 298.15 7 1056 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59TAB/WYN_355 59TAB/WYN spectrophotometry B 2.1.2.5 glutamate formiminotransferase C00664 + C00025 = C00439 + C00101 5-formiminotetrahydrofolate(aq) + L-glutamate(aq) = N-formimino-L-glutamate(aq) + tetrahydrofolate(aq) 1.3 298.15 6.7 1057 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_876 91TEW/GOL HPLC A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 123 292.25 5.65 1058 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_876 91TEW/GOL HPLC A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 115 310.25 5.65 1059 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_876 91TEW/GOL HPLC A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 119 298.15 5.65 1060 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_876 91TEW/GOL HPLC A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 122 286.45 5.65 1061 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_876 91TEW/GOL HPLC A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 118 304.55 5.65 1062 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.98 310.15 0.25 6.91 2.97 1063 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.982 310.15 0.25 6.9 2.97 1064 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.964 310.15 0.25 6.89 2.96 1065 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.946 310.15 0.25 6.98 3.43 1066 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.929 310.15 0.25 6.97 3.42 1067 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.899 310.15 0.25 6.99 3.6 1068 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.06 310.15 0.25 6.99 3.08 1069 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.842 310.15 0.25 6.99 2.71 1070 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.38 310.15 0.25 6.99 2 1071 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.014 310.15 0.25 6.99 3.36 1072 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.981 310.15 0.25 6.97 3.42 1073 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.044 310.15 0.25 6.99 3.18 1074 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.708 310.15 0.25 6.99 4 1075 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.572 310.15 0.25 6.99 2.35 1076 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.983 310.15 0.25 6.91 2.97 1077 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_651 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.871 310.15 0.25 6.98 3.44 1078 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_877 91TEW/GOL calorimetry A 3.2.1.2 _-amylase C01083 + C00001 = 2 C00031 ,-trehalose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 5.65 1079 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1098 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 2.1E-06 282.15 8.8 1080 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1098 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 2.8E-06 313.15 8.8 1081 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1098 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 4.1E-06 296.15 8.8 1082 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1098 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 6.2E-06 303.15 8.8 1083 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68NIX/BLA_298 68NIX/BLA spectrophotometry C 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 0.00024 310.15 6.7 1084 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68NIX/BLA_298 68NIX/BLA spectrophotometry C 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 0.0012 310.15 8 1085 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1095 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 6.4E-05 282.15 8.8 1086 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1095 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00039 296.15 8.8 1087 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1095 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00052 313.15 8.8 1088 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KUR/KON_1095 75KUR/KON C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00061 303.15 8.8 1089 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_156 80COO/BLA spectrophotometry B 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 1 298.15 8 1090 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56CAR/COH_1224 56CAR/COH spectrophotometry B 4.3.2.2 adenylosuccinate lyase C03794 = C00122 + C00020 adenylosuccinate(aq) = fumarate(aq) + AMP(aq) 0.0063 308.15 6 1091 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56CAR/COH_1224 56CAR/COH spectrophotometry B 4.3.2.2 adenylosuccinate lyase C03794 = C00122 + C00020 adenylosuccinate(aq) = fumarate(aq) + AMP(aq) 0.0074 308.15 6.75 1092 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56CAR/COH_1224 56CAR/COH spectrophotometry B 4.3.2.2 adenylosuccinate lyase C03794 = C00122 + C00020 adenylosuccinate(aq) = fumarate(aq) + AMP(aq) 0.0068 308.15 7 1093 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99ELS_1527 99ELS spectrophotometry and enzymatic assay C 4.1.2.a 2-oxo-3-deoxy-D-gluconate aldolase C00204 = C00022 + C00577 2-oxo-3-deoxy-D-gluconate(aq) = pyruvate(aq) + D-glyceraldehyde(aq) 0.00088 313.15 8 1094 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GUP/ROB_186 60GUP/ROB spectrophotometry C 1.1.1.55 lactaldehyde reductase (NADPH) C00583 + C00006 = C00424 + C00005 1,2-propanediol(aq) + NADP(aq) = L-lactaldehyde(aq) + NADPH(aq) 6E-05 298.15 8.4 1095 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GUP/ROB_186 60GUP/ROB spectrophotometry C 1.1.1.55 lactaldehyde reductase (NADPH) C00583 + C00006 = C00424 + C00005 1,2-propanediol(aq) + NADP(aq) = L-lactaldehyde(aq) + NADPH(aq) 0.00024 298.15 9 1096 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GUP/ROB_186 60GUP/ROB spectrophotometry C 1.1.1.55 lactaldehyde reductase (NADPH) C00583 + C00006 = C00424 + C00005 1,2-propanediol(aq) + NADP(aq) = L-lactaldehyde(aq) + NADPH(aq) 0.000759 298.15 9.5 1097 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GUP/ROB_186 60GUP/ROB spectrophotometry C 1.1.1.55 lactaldehyde reductase (NADPH) C00583 + C00006 = C00424 + C00005 1,2-propanediol(aq) + NADP(aq) = L-lactaldehyde(aq) + NADPH(aq) 0.0024 298.15 10 1098 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.508 298.15 0.266 7.4 1.41 1099 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.357 298.15 0.287 7.4 1.24 1100 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.233 298.15 0.395 7.4 0.88 1101 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.206 298.15 0.541 7.4 0.63 1102 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.186 298.15 0.54 7.4 0.64 1103 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.143 298.15 0.748 7.4 0.43 1104 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.123 298.15 1.65 7.4 0.01 1105 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.112 298.15 3.15 7.4 -0.03 1106 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.417 298.15 0.216 8.4 3.3 1107 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.465 298.15 0.208 8.4 2.69 1108 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.49 298.15 0.296 6.4 2.81 1109 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.515 298.15 0.311 6.4 2.81 1110 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.763 298.15 0.283 6.4 1.96 1111 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.671 298.15 0.288 6.4 1.97 1112 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.709 298.15 0.287 6.4 1.63 1113 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.429 298.15 0.343 6.4 1.12 1114 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.459 298.15 0.343 6.4 1.12 1115 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.292 298.15 0.483 6.4 0.76 1116 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.2 298.15 0.777 6.4 0.43 1117 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.541 298.15 0.286 7.4 2.29 1118 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.662 298.15 0.276 7.4 2.11 1119 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.662 298.15 0.276 7.4 2.11 1120 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.741 298.15 0.272 7.4 1.98 1121 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.725 298.15 0.274 7.4 1.99 1122 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.758 298.15 0.268 7.4 1.88 1123 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.465 298.15 0.214 8.4 2.69 1124 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.568 298.15 0.193 8.4 2.29 1125 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.769 298.15 0.179 8.4 1.99 1126 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.274 298.15 0.216 8.4 1.13 1127 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.167 298.15 0.654 8.4 0.43 1128 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.633 298.15 0.283 7.4 2.29 1129 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.538 298.15 0.281 7.4 2.29 1130 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.735 298.15 0.255 7.4 1.88 1131 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.334 298.15 0.282 7.4 1.25 1132 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.474 298.15 0.16 7.4 2.69 1133 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.488 298.15 0.11 7.4 1.49 1134 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.261 298.15 0.163 7.4 1.1 1135 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.293 298.15 0.172 7.4 1.13 1136 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.54 298.15 0.013 7.4 3.14 1137 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.41 298.15 0.013 7.4 2.91 1138 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.61 298.15 0.012 7.4 3.13 1139 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.25 298.15 0.012 7.4 2.91 1140 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.25 298.15 0.012 7.4 2.91 1141 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.833 298.15 0.093 7.4 3.13 1142 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.667 298.15 0.093 7.4 3.13 1143 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.781 298.15 0.093 7.4 2.9 1144 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.562 298.15 7.4 2.3 1145 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.559 298.15 7.4 2.3 1146 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.483 298.15 7.4 2.3 1147 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.51 298.15 0.594 7.4 2 1148 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.49 298.15 0.592 7.4 2 1149 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.667 298.15 0.454 7.4 1.29 1150 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.645 298.15 0.461 7.4 1.29 1151 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.322 298.15 0.474 7.4 0.86 1152 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.182 298.15 0.704 7.4 0.52 1153 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.287 298.15 0.723 7.4 0.64 1154 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.595 298.15 0.288 6.4 2.28 1155 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.22 298.15 0.777 6.4 0.43 1156 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.505 298.15 0.268 7.4 1.42 1157 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.121 298.15 1.65 7.4 0.01 1158 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.56 298.15 0.013 7.4 2.91 1159 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.606 298.15 7.4 2.3 1160 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.313 298.15 0.472 7.4 0.86 1161 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.313 298.15 0.472 7.4 0.86 1162 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.508 298.15 1.67 7.4 0.7 1163 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.259 298.15 0.482 6.4 0.76 1164 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.145 298.15 0.748 7.4 0.43 1165 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.87 298.15 0.258 7.4 1.88 1166 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.72 298.15 0.013 7.4 3.14 1167 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.775 298.15 0.093 7.4 2.9 1168 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.348 298.15 0.286 7.4 1.23 1169 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.109 298.15 3.15 7.4 -0.03 1170 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.265 298.15 0.216 8.4 1.13 1171 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 298.15 0.17 7.4 2.69 1172 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.59 298.15 0.012 7.4 3.14 1173 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.575 298.15 7.4 2.3 1174 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.704 298.15 0.183 8.4 1.99 1175 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.513 298.15 0.298 6.4 2.28 1176 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.549 298.15 0.283 7.4 2.29 1177 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.326 298.15 0.282 7.4 1.25 1178 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.758 298.15 0.284 6.4 1.63 1179 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.658 298.15 0.276 7.4 2.11 1180 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.233 298.15 0.395 7.4 0.88 1181 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.427 298.15 0.227 8.4 3.3 1182 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.427 298.15 0.227 8.4 3.3 1183 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.153 298.15 0.654 8.4 0.43 1184 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.645 298.15 0.129 7.4 1.53 1185 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.33 298.15 0.012 7.4 2.9 1186 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.485 298.15 7.4 2.3 1187 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.526 298.15 1.55 7.4 0.7 1188 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.538 298.15 0.191 8.4 2.29 1189 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=74LAN_648 74LAN enzymatic assay and spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.758 298.15 0.263 7.4 1.88 1190 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MCG/BRO_230 78MCG/BRO calorimetry B 1.1.3.6 cholesterol oxidase C00187 + C00007 = C00599 + C00027 cholesterol(aq) + O2(aq) = cholest-4-en-3-one(aq) + H2O2(aq) 303.15 7 1191 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66THO/NAN_1164 66THO/NAN spectrophotometry C 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 11.8 298.15 7.4 1192 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69FAN/FEI_1269 69FAN/FEI gas-liquid chromatography B 5.1.3.5 UDParabinose 4-epimerase C00935 = C00190 UDP-L-arabinose(aq) = UDP-D-xylose(aq) 1.25 303.15 8 1193 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66THO/NAN_1161 66THO/NAN spectrophotometry C 4.2.1.3 aconitate hydratase C00311 = C00417 + C00001 isocitrate(aq) = cis-aconitate(aq) + H2O(l) 0.55 298.15 7.4 1194 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK2_86 68KOH/JAK2 spectrophotometry C 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 7.2E-05 298.15 8.03 1195 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK2_86 68KOH/JAK2 spectrophotometry C 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.0007 298.15 8.85 1196 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK2_86 68KOH/JAK2 spectrophotometry C 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.0012 298.15 9.08 1197 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/RAI_1094 69VEE/RAI spectrophotometry A 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 9.9E-05 311.15 6.7 2.3 1198 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/RAI_1094 69VEE/RAI spectrophotometry A 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 5.6E-05 311.15 6.7 1.3 1199 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 6.55 298.15 7.4 2.35 1200 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 10.2 298.15 8 2.35 1201 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 0.59 298.15 7.8 1202 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 6.8 298.15 7.4 2.05 1203 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 2 298.15 7.06 1204 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66WOO/DAV_1445 66WOO/DAV spectrophotometry and enzymatic assay A 6.4.1.1 pyruvate carboxylase C00002 + C00022 + C00288 = C00008 + C00009 + C00036 ATP(aq) + pyruvate(aq) + carbon dioxide(aq) = ADP(aq) + phosphate(aq) + oxaloacetate(aq) 1.4 298.15 7.03 1205 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64LOW/PAS_1394 64LOW/PAS fluorimetry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 9.8 311.15 7 1206 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63HUE_296 63HUE spectrophotometry C 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 1.78E-05 298.15 7 1207 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65KAT/BUC_321 65KAT/BUC spectrophotometry B 1.7.99.5 5,10-methylenetetrahydrofolate reductase (FADH2) C00440 + C00016 = C00143 + C01352 5-methyltetrahydrofolate(aq) + flavin-adenine dinucleotide(aq) = 5,10-methylenetetrahydrofolate(aq) + reduced flavin-adenine dinucleotide(aq) 0.00042 310.15 6.3 1208 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63HAR/COL_1125 63HAR/COL spectrophotometry C 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.0637 303.15 7 1209 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65YOS/FRE_271 65YOS/FRE spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 1.13E-05 298.15 8.21 1210 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65YOS/FRE_271 65YOS/FRE spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 7.65E-05 298.15 8.98 1211 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65YOS/FRE_271 65YOS/FRE spectrophotometry B 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.000825 298.15 10.05 1212 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/OES_1172 49MEY/OES chemical analysis and radioactivity C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.9 297.15 1213 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH_192 68KOH spectrophotometry C 1.1.1.60 2-hydroxy-3-oxopropionate reductase C00258 + C00003 = C01146 + C00004 (R)-glycerate(aq) + NAD(aq) = 2-hydroxy-3-oxopropanoate(aq) + NADH(aq) 5.3E-05 298.15 7.5 1214 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_120 67WIL/LUN spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0526 311.15 0.134 7.04 1215 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_120 67WIL/LUN spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0561 311.15 0.073 7.09 1216 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_120 67WIL/LUN spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0482 311.15 0.042 7.1 1217 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_120 67WIL/LUN spectrophotometry A 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0494 311.15 0.255 7 1218 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50SLE_1350 50SLE spectrophotometry B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.45 303.15 7.4 1219 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74UEB/BLA_161 74UEB/BLA gas-liquid chromatography C 1.1.1.48 galactose dehydrogenase C00124 + C00003 = C03383 + C00004 D-galactose(aq) + NAD(aq) = D-galactono-1,4-lactone(aq) + NADH(aq) 400 303.15 6.8 1220 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74UEB/BLA_161 74UEB/BLA gas-liquid chromatography C 1.1.1.48 galactose dehydrogenase C00124 + C00003 = C03383 + C00004 D-galactose(aq) + NAD(aq) = D-galactono-1,4-lactone(aq) + NADH(aq) 25000 303.15 8.6 1221 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74UEB/BLA_161 74UEB/BLA gas-liquid chromatography C 1.1.1.48 galactose dehydrogenase C00124 + C00003 = C03383 + C00004 D-galactose(aq) + NAD(aq) = D-galactono-1,4-lactone(aq) + NADH(aq) 390 298.15 6.8 1222 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SAL/NOR_1268 68SAL/NOR chromatography and spectrophotometry C 5.1.3.5 UDParabinose 4-epimerase C00935 = C00190 UDP-L-arabinose(aq) = UDP-D-xylose(aq) 0.94 310.15 8.7 1223 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_1282 47MEY/OES chemical analysis and polarimetry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 17 298.15 8 1224 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.83 323.15 7 1225 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.32 333.15 7 1226 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.05 343.15 7 1227 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.33 343.15 7.2 1228 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.1 353.15 7 1229 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74MCK_1307 74MCK polarimetry and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.13 333.15 7.2 1230 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64LOW/PAS_1174 64LOW/PAS fluorimetry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.6 311.15 7.1 1231 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73SHE/GUL_155 73SHE/GUL spectrophotometry B 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.076 293.15 0.404 7.4 1232 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73SHE/GUL_155 73SHE/GUL spectrophotometry B 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.81 293.15 0.404 7.4 1233 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93VIN/GRU_1691 93VIN/GRU radioactivity C 2.4.2.11 nicotinate phosphoribosyltransferase C01185 + C00013 = C00253 + C00119 Nicotinate D-ribonucleotide(aq) + pyrophosphate(aq) = nicotinic acid(aq) + 5-Phospho-alpha-D-ribose 1-diphosphate(aq) 1.5 303.15 8 1234 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58FRO_1443 58FRO spectrophotometry C 6.3.4.4 adenylosuccinate synthase C00044 + C00130 + C00049 = C00035 + C00009 + C03794 GTP(aq) + IMP(aq) + L-aspartate(aq) = GDP(aq) + phosphate(aq) + adenylosuccinate(aq) 2.9 310.15 8 1235 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49HES_743 49HES spectrophotometry C 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 538 296.15 5.1 1236 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 8.8E-05 298.15 6.85 1237 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00019 298.15 7.15 1238 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0003 298.15 7.34 1239 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00051 298.15 7.61 1240 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0022 298.15 8.17 1241 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0008 298.15 7.77 1242 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38SCH/HEL_10 38SCH/HEL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 2.6E-05 298.15 6.3 1243 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58ROB/LIP_678 58ROB/LIP C 2.7.7.4 sulfate adenylyltransferase C00002 + C00059 = C00224 + C00013 ATP(aq) + sulfate(aq) = adenosine 5'-phosphosulfate(aq) + pyrophosphate(aq) 1.1E-08 310.15 8 1244 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LIE/KOR_1039 54LIE/KOR spectrophotometry and radioactivity B 3.5.2.4 carboxymethylhydantoinase C03703 + C00001 = C00438 L-5-carboxymethylhydantoin(aq) + H2O(l) = N-carbamoyl-L-aspartate(aq) 0.53 307.15 6.1 1245 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_478 92KIM/KIN spectrophotometry and fluorimetry A 2.4.2.8 hypoxanthine phosphoribosyltransferase C00242 + C00119 = C00144 + C00013 guanine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) = GMP(aq) + pyrophosphate(aq) 100000 311.15 0.25 7.4 3 1246 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_479 92KIM/KIN spectrophotometry and fluorimetry A 2.4.2.8 hypoxanthine phosphoribosyltransferase C00262 + C00119 = C00130 + C00013 hypoxanthine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) = IMP(aq) + pyrophosphate(aq) 100000 311.15 0.25 7.4 3 1247 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85REK/SLO_987 85REK/SLO calorimetry A 3.5.1.1 asparaginase C00152 + C00001 = C00049 + C00014 L-asparagine(aq) + H2O(l) = L-aspartate(aq) + ammonia(aq) 298.15 6.86 1248 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_475 92KIM/KIN spectrophotometry and fluorimetry A 2.4.2.7 adenine phosphoribosyltransferase C00147 + C00119 = C00020 + C00013 adenine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) = AMP(aq) + pyrophosphate(aq) 2000 311.15 0.25 7.4 3 1249 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LIE/KOR_1036 54LIE/KOR spectrophotometry and radioactivity B 3.5.2.3 dihydroorotase C00337 + C00001 = C00438 (S)-dihydroorotate(aq) + H2O(l) = N-carbamoyl-L-aspartate(aq) 1.9 303.15 6.1 1250 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87MOS/FRE_1417 87MOS/FRE chromatography and radioactivity C 5.4.3.2 lysine 2,3-aminomutase C00047 = C01142 L-lysine(aq) = (3S)-3,6-diaminohexanoate(aq) 5.3 303.15 7.7 1251 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 6.62E-05 298.15 9 1252 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 0.000436 298.15 8 0.7 1253 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 1.56E-05 298.15 7 1254 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 6.17E-05 298.15 8 1.89 1255 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 1.85E-05 298.15 8 1256 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DEC_407 55DEC spectrophotometry B 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 1.48E-05 298.15 6 1257 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ASH/HIC_1246 57ASH/HIC spectrophotometry C 5.1.3.1 ribulose-phosphate 3-epimerase C00199 = C00231 D-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.4 310.15 7.5 1258 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70CHI/ZAP_1416 70CHI/ZAP radioactivity B 5.4.3.2 lysine 2,3-aminomutase C00047 = C01142 L-lysine(aq) = (3S)-3,6-diaminohexanoate(aq) 6.7 310.15 7.8 1259 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00BYR/GOL_1518 00BYR/GOL calorimetry, spectrophotometry, and chromatography A 4.1.3.27 anthranilate synthase C00251 + C00014 = C00108 + C00022 + C00001 chorismate(aq) + ammonia(aq) = anthranilate(aq) + pyruvate(aq) + H2O(l) 298.15 0.56 7.79 1260 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00BYR/GOL_1519 00BYR/GOL calorimetry, spectrophotometry, and chromatography A 4.1.3.27 anthranilate synthase C00251 + C00014 = C18054 + C00001 chorismate(aq) + ammonia(aq) = 2-amino-2-deoxyisochorismate(aq) + H2O(l) 8.44 298.15 0.14 7.86 1261 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00BYR/GOL_1519 00BYR/GOL calorimetry, spectrophotometry, and chromatography A 4.1.3.27 anthranilate synthase C00251 + C00014 = C18054 + C00001 chorismate(aq) + ammonia(aq) = 2-amino-2-deoxyisochorismate(aq) + H2O(l) 9.5 288.15 0.15 8.08 1262 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00BYR/GOL_1519 00BYR/GOL calorimetry, spectrophotometry, and chromatography A 4.1.3.27 anthranilate synthase C00251 + C00014 = C18054 + C00001 chorismate(aq) + ammonia(aq) = 2-amino-2-deoxyisochorismate(aq) + H2O(l) 7.51 302.75 0.14 7.76 1263 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00BYR/GOL_1519 00BYR/GOL calorimetry, spectrophotometry, and chromatography A 4.1.3.27 anthranilate synthase C00251 + C00014 = C18054 + C00001 chorismate(aq) + ammonia(aq) = 2-amino-2-deoxyisochorismate(aq) + H2O(l) 9.02 293.15 0.15 8 1264 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 15.8 286.35 5.65 1265 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 17.2 298.15 5.65 1266 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 18 304.15 5.65 1267 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 19.7 316.35 5.65 1268 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 19.4 310.25 5.65 1269 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89TEW/GOL_909 89TEW/GOL HPLC A 3.2.1.10 oligo-1,6-glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 16.2 292.45 5.65 1270 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62DUR/RAW_338 62DUR/RAW calorimetry A 2.1.1.3 thetin-homocysteine S-methyltransferase C00719 + C00155 = C01026 + C00073 betaine(aq) + L-homocysteine(aq) = N,N-dimethylglycine(aq) + L-methionine(aq) 298.15 7.1 1271 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98LAE/EIS_1204 98LAE/EIS HPLC + radioactivity B 4.2.1.- cyclohexa-1,5-diene-1-carboxyl-CoA (dienoyl-CoA) hydratase C06322 + C00001 = C06749 cyclohexa-1,5-diene-1-carboxyl-CoA(aq) + H2O(l) = 6-hydroxycyclohex-1-ene-carboxyl-CoA(aq) 1 310.15 7.4 1272 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_888 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C02160 + 2 C00001 = 3 C00031 isomaltotriose(aq) + 2 H2O(l) = 3 D-glucose(aq) 298.15 4.44 1273 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MAI/DEK_1132 64MAI/DEK spectrophotometry C 4.1.3.16 4-hydroxy-2-oxoglutarate aldolase C01127 = C00022 + C00048 4-hydroxy-2-oxoglutarate(aq) = pyruvate(aq) + glyoxylate(aq) 0.012 310.15 8.4 1274 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40KRE/SMY_1143 40KRE/SMY manometry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.57 293.15 7.4 1275 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40KRE/SMY_1143 40KRE/SMY manometry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.54 303.15 7.4 1276 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40KRE/SMY_1143 40KRE/SMY manometry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.17 313.15 7.4 1277 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40KRE/SMY_1143 40KRE/SMY manometry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 2.65 323.15 7.4 1278 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82HSI/CHI_1327 82HSI/CHI liquid chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.31 334.15 7.5 1279 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82HSI/CHI_1327 82HSI/CHI liquid chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.39 343.15 7.5 1280 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82HSI/CHI_1327 82HSI/CHI liquid chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.41 345.15 7.5 1281 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82HSI/CHI_1327 82HSI/CHI liquid chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.22 323.15 7.5 1282 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82HSI/CHI_1327 82HSI/CHI liquid chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.18 313.15 7.5 1283 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72DEL_427 72DEL chromatography and radioactivity B 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 6.7 298.15 7.5 1284 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW2_943 89GOL/TEW2 calorimetry A 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 5.65 1285 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW2_943 89GOL/TEW2 calorimetry A 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 310.15 5.65 1286 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW2_943 89GOL/TEW2 calorimetry A 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 316.15 5.65 1287 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW2_943 89GOL/TEW2 calorimetry A 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 304.15 5.65 1288 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_884 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 -isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 81 318.15 4.5 1289 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_885 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 -isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 65 318.15 4.5 1290 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79KIM/PET_143 79KIM/PET spectrophotometry B 1.1.1.37 malate dehydrogenase C00552 + C00003 = C03459 + C00004 meso-tartrate(aq) + NAD(aq) = 2-oxo-3-hydroxysuccinate(aq) + NADH(aq) 1.25E-06 298.15 8 1291 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71ROB_710 71ROB chromatography, electrophoresis, and radioactivity C 2.7.7.44 glucuronate-1-phosphate uridylyltransferase C05385 + C00075 = C00167 + C00013 1-phospho--D-glucuronate(aq) + UTP(aq) = UDP-D-glucuronate(aq) + pyrophosphate(aq) 0.34 303.15 8.2 1292 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98LIA/WAN_1583 98LIA/WAN calorimetry A 1.1.3.22 xanthine oxidase C00385 + C00001 + C00007 = C00366 + C00027 xanthine(aq) + H2O(l) + O2(aq) = urate(aq) + H2O2(aq) 298.15 7.5 1293 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90LUN/APR_431 90LUN/APR enzymatic assay and spectrophotometry B 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 62 298.15 7.5 2 1294 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90LUN/APR_431 90LUN/APR enzymatic assay and spectrophotometry B 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 5.3 298.15 7 2.6 1295 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90LUN/APR_431 90LUN/APR enzymatic assay and spectrophotometry B 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 26 298.15 7 2 1296 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90LUN/APR_431 90LUN/APR enzymatic assay and spectrophotometry B 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 10 298.15 7.5 2.6 1297 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36EUL/ADL_7 36EUL/ADL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.3E-05 298.15 6.4 1298 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36EUL/ADL_7 36EUL/ADL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 5.3E-05 298.15 7 1299 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36EUL/ADL_7 36EUL/ADL spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00013 298.15 7.7 1300 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49SOR/DVO_615 49SOR/DVO C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.002 298.15 6.1 1301 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49SOR/DVO_615 49SOR/DVO C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.17 298.15 9.1 1302 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GRI/CAR_1396 75GRI/CAR polarimetry and spectrophotometry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.3 303.15 5.6 1303 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GRI/CAR_1396 75GRI/CAR polarimetry and spectrophotometry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5 310.15 6.8 1304 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GRI/CAR_1396 75GRI/CAR polarimetry and spectrophotometry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.1 298.15 6 1305 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76BER/KLY_1009 76BER/KLY C 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.022 298.15 6 1306 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76BER/KLY_1009 76BER/KLY C 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.003 298.15 5 1307 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59GOL_322 59GOL spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.0055 295.15 6 1308 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54AXE/JAN_1331 54AXE/JAN enzymatic assay and spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.264 298.65 7 1309 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54AXE/JAN_1331 54AXE/JAN enzymatic assay and spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.323 310.15 7 1310 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54AXE/JAN_1331 54AXE/JAN enzymatic assay and spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.164 273.15 7 1311 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37ADL/SRE_8 37ADL/SRE spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 6E-06 298.15 6.05 1312 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37ADL/SRE_8 37ADL/SRE spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 7.7E-05 298.15 7.25 1313 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37ADL/SRE_8 37ADL/SRE spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.2E-05 298.15 8 1314 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66HOR/HEN_1550 66HOR/HEN radioactivity C 2.4.2.7 adenine phosphoribosyltransferase C00020 + C00013 = C00147 + C00119 AMP(aq) + pyrophosphate(aq) = adenine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 0.0035 303.15 7.4 1315 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57STE_125 57STE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.86 298.15 9.6 1316 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53HOC/WAT_1323 53HOC/WAT chemical analysis and paper chromatography C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.19 300.15 7.5 1317 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60PRI/HOR_1087 60PRI/HOR enzymatic assay, chemical analysis, and spectrophotometry B 4.1.2.4 deoxyribose-phosphate aldolase C00673 = C00118 + C00084 2-deoxy-D-ribose 5-phosphate(aq) = D-glyceraldehyde 3-phosphate(aq) + acetaldehyde(aq) 0.000235 310.15 6.3 1318 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92REK/TIS_826 92REK/TIS calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 3 1319 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BEN/HEM_989 56BEN/HEM calorimetry B 3.5.1.2 glutaminase C00064 + C00001 = C00025 + C00014 L-glutamine(aq) + H2O(l) = L-glutamate(aq) + ammonia(aq) 850 298.15 5.5 1320 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56DIC/WIL_1262 56DIC/WIL chromatography and spectrophotometry C 5.1.3.4 L-ribulose-phosphate 4-epimerase C01101 = C00231 L-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.2 310.15 7.6 1321 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 5.04E-07 300.15 0.134 6.92 1322 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 6.34E-07 303.15 0.134 6.95 1323 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 9.03E-07 303.15 0.471 6.91 1324 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 8.08E-07 303.15 0.471 6.79 1325 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 1.1E-06 298.1 0.47 7 1326 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 1.2E-06 300.1 0.47 7 1327 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 2E-06 305.1 0.47 7 1328 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.2E-06 309.8 0.47 7 1329 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.6E-06 311.1 0.47 7 1330 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 2.09E-07 300.15 0.026 6.93 1331 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 2.91E-07 300.15 0.054 6.94 1332 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.83E-07 303.15 0.067 6.96 1333 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 3.67E-07 303.15 0.067 6.93 1334 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 4.96E-07 303.15 0.091 6.97 1335 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 5.22E-07 303.15 0.112 6.96 1336 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 5.92E-07 300.15 0.134 6.92 1337 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 1.16E-06 303.15 0.471 6.99 1338 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 2.59E-07 300.15 0.054 6.9 1339 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_287 67ENG/DAL spectrophotometry A 1.4.1.4 glutamate dehydrogenase (NADP+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 5.55E-07 300.15 0.112 6.97 1340 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80TER/RAB_994 80TER/RAB spectrophotometry B 3.5.1.5 urease C01563 + C00001 = C00014 + C00288 carbamate(aq) + H2O(l) = ammonia(aq) + carbon dioxide(aq) 1920 293.15 6.5 1341 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80TER/RAB_994 80TER/RAB spectrophotometry B 3.5.1.5 urease C01563 + C00001 = C00014 + C00288 carbamate(aq) + H2O(l) = ammonia(aq) + carbon dioxide(aq) 1710 293.15 6.5 1342 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80TER/RAB_994 80TER/RAB spectrophotometry B 3.5.1.5 urease C01563 + C00001 = C00014 + C00288 carbamate(aq) + H2O(l) = ammonia(aq) + carbon dioxide(aq) 1030 310.15 6.5 1343 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80TER/RAB_994 80TER/RAB spectrophotometry B 3.5.1.5 urease C01563 + C00001 = C00014 + C00288 carbamate(aq) + H2O(l) = ammonia(aq) + carbon dioxide(aq) 1500 293.15 6.5 1344 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80TER/RAB_994 80TER/RAB spectrophotometry B 3.5.1.5 urease C01563 + C00001 = C00014 + C00288 carbamate(aq) + H2O(l) = ammonia(aq) + carbon dioxide(aq) 1230 293.15 6.5 1345 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75SCH/RIF_138 75SCH/RIF spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00117 298.15 9.3 1346 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67KEP/TOV_1280 67KEP/TOV radioactivity B 5.2.1.5 linoleate isomerase C01595 = C04056 9-cis,12-cis-octadecadienoate(aq) = 9-cis,11-trans-octadecadienoate(aq) 61 308.15 7 1347 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STU/HOR_1245 56STU/HOR spectrophotometry C 5.1.3.1 ribulose-phosphate 3-epimerase C00199 = C00231 D-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 0.83 310.15 7.5 1348 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000128 283.75 7.68 1349 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000119 283.75 7.673 1350 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000187 290.5 7.658 1351 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000174 290.5 7.646 1352 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000213 293.4 7.635 1353 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000542 307.75 7.605 1354 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000734 315.95 7.568 1355 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00068 315.95 7.545 1356 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000144 283.75 7.691 1357 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000438 307.75 7.571 1358 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000487 307.75 7.584 1359 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_15 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000663 315.95 7.528 1360 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00032 273.15 7 1361 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0015 293.15 7 1362 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0064 313.15 7 1363 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.019 333.15 7 1364 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0011 293.15 7 1365 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00075 293.15 7 1366 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00047 293.15 7 1367 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00055 293.15 7 1368 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 1369 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 1370 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00029 293.15 7 1371 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0012 333.15 7 1372 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00031 293.15 7 1373 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00051 293.15 7 1374 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0011 293.15 7 1375 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0014 293.15 7 1376 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0014 313.15 7 1377 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0046 333.15 7 1378 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0056 333.15 7 1379 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.015 333.15 7 1380 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0025 313.15 7 1381 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0025 313.15 7 1382 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00014 273.15 7 1383 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0082 333.15 7 1384 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 7.1E-05 273.15 7 1385 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.002 313.15 7 1386 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00035 293.15 7 1387 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0056 313.15 7 1388 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00037 293.15 7 1389 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=35MEY_1289 35MEY spectrophotometry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.00064 293.15 7 1390 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HUB_1279 56HUB spectrophotometry C 5.2.1.3 retinal isomerase C00376 = C02110 all-trans-retinal(aq) = 11-cis-retinal(aq) 0.05 309.15 7 1391 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 6.19E-05 298.15 7.76 1392 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000101 298.15 7.99 1393 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000129 298.15 8.09 1394 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000162 298.15 8.19 1395 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 7.67E-05 298.15 7.87 1396 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.49E-05 298.15 7.54 1397 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 4.74E-05 298.15 7.68 1398 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66BER/MOE_133 66BER/MOE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.43E-05 298.15 7.37 1399 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_920 91TEW/GOL calorimetry A 3.2.1.21 _-glucosidase C05402 + C00001 = C00124 + C00031 -D-melibiose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 298.15 5.65 1400 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56WOL/KAP_76 56WOL/KAP chemical analysis and spectrophotometry C 1.1.1.17 mannitol-1-phosphate dehydrogenase C00644 + C00003 = C00085 + C00004 D-mannitol 1-phosphate(aq) + NAD(aq) = D-fructose 6-phosphate(aq) + NADH(aq) 0.0049 296.15 7 1401 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/WAR_87 68KOH/WAR spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.0004 298.15 8.83 1402 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/WAR_87 68KOH/WAR spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.00023 298.15 8.5 1403 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/WAR_87 68KOH/WAR spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 7.4E-05 298.15 8.15 1404 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/WAR_87 68KOH/WAR spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.00023 298.15 8.5 1405 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 6.6 323.15 0.25 7 1406 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 5.73 311.15 0.06 7 1407 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 5.47 311.15 1 7 1408 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 9.23 311.15 0.25 9 1409 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 5.27 311.15 0.25 7 2.08 1410 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 4.26 298.15 0.25 7 1411 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 4.42 303.15 0.25 7 1412 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_537 82GUY spectrophotometry A 2.6.1.51 serine-pyruvate transaminase C00041 + C00168 = C00065 + C00022 L-alanine(aq) + hydroxypyruvate(aq) = L-serine(aq) + pyruvate(aq) 5.5 311.15 0.25 7 1413 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56RAM/GIR_1352 56RAM/GIR chemical analysis C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.67 310.15 7.65 1414 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.33 310.15 7.2 3.7 1415 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.3 310.15 7.2 3.1 1416 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.36 310.15 7.2 2.7 1417 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.32 310.15 7.2 3.4 1418 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.44 310.15 7.2 2 1419 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.32 310.15 7.2 3 1420 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.32 310.15 7.2 3.22 1421 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HSI/SU_694 81HSI/SU enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.44 310.15 7.2 2.4 1422 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79RAO/KAY_566 79RAO/KAY NMR B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.0003 288.15 8 1423 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66NAT_1301 66NAT chromatography C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.82 313.15 7 1424 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56SMI/STA_1124 56SMI/STA chemical analysis B 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.64 300.15 7.6 1425 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48OCH_152 48OCH spectrophotometry C 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.76 295.15 6.95 1426 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_418 89GOL/TEW HPLC A 2.4.1.7 sucrose phosphorylase C00089 + C00009 = C00103 + C00095 sucrose(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-fructose(aq) 31.5 298.15 8.25 1427 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54SIS/STA_1427 54SIS/STA spectrophotometry B 5.5.1.1 muconate cycloisomerase C04105 = C02480 2,5-dihydro-5-oxofuran-2-acetate(aq) = cis-cis-hexadienedioate(aq) 0.078 303.15 8 1428 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54SIS/STA_1427 54SIS/STA spectrophotometry B 5.5.1.1 muconate cycloisomerase C04105 = C02480 2,5-dihydro-5-oxofuran-2-acetate(aq) = cis-cis-hexadienedioate(aq) 0.29 303.15 9 1429 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54SIS/STA_1427 54SIS/STA spectrophotometry B 5.5.1.1 muconate cycloisomerase C04105 = C02480 2,5-dihydro-5-oxofuran-2-acetate(aq) = cis-cis-hexadienedioate(aq) 0.041 303.15 7.5 1430 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54SIS/STA_1427 54SIS/STA spectrophotometry B 5.5.1.1 muconate cycloisomerase C04105 = C02480 2,5-dihydro-5-oxofuran-2-acetate(aq) = cis-cis-hexadienedioate(aq) 0.011 303.15 6.5 1431 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54SIS/STA_1427 54SIS/STA spectrophotometry B 5.5.1.1 muconate cycloisomerase C04105 = C02480 2,5-dihydro-5-oxofuran-2-acetate(aq) = cis-cis-hexadienedioate(aq) 0.01 303.15 6 1432 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1348 88TEW/STE calorimetry A 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.5 1433 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1348 88TEW/STE calorimetry A 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 304.74 8.5 1434 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1347 88TEW/STE calorimetry A 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 1.03 304.75 8.5 1435 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1347 88TEW/STE calorimetry A 5.3.1.8 mannose-6-phosphate isomerase C00275 = C00085 D-mannose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.99 298.15 8.5 1436 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SAK/YOR2_454 67SAK/YOR2 electrophoresis C 2.4.2.1 purine-nucleoside phosphorylase C00212 + C00009 = C00147 + C00620 adenosine(aq) + orthophosphate(aq) = adenine(aq) + D-ribose 1-phosphate(aq) 0.063 310.15 7 1437 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SAK/YOR2_454 67SAK/YOR2 electrophoresis C 2.4.2.1 purine-nucleoside phosphorylase C00212 + C00009 = C00147 + C00620 adenosine(aq) + orthophosphate(aq) = adenine(aq) + D-ribose 1-phosphate(aq) 0.12 310.15 9 1438 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77TRA/JON_481 77TRA/JON TLC and radioactivity B 2.4.2.10 orotate phosphoribosyltransferase C01103 + C00013 = C00295 + C00119 orotidine 5'-phosphate(aq) + pyrophosphate(aq) = orotate(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 14 310.15 7.4 1439 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ATK/JOH_772 61ATK/JOH enzymatic assay and spectrophotometry A 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 263 298.15 7 1440 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.37 298.15 8 5.53 1441 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.92 298.15 8 4.37 1442 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.28 298.15 8 3.84 1443 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.06 298.15 8 3.04 1444 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.92 298.15 8 3 1445 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.34 298.15 8 2.28 1446 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.3 298.15 8 2.08 1447 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.52 298.15 8 4.88 1448 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.14 298.15 8 3.2 1449 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.67 298.15 8 2.68 1450 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.46 298.15 8 2.49 1451 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.32 298.15 8 2.17 1452 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.34 298.15 8 5.83 1453 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KLE/RAN_654 91KLE/RAN enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.49 298.15 8 5.37 1454 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70WUR/HES_163 70WUR/HES spectrophotometry D 1.1.1.49 glucose-6-phosphate dehydrogenase C00092 + C00006 = C01236 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) = D-glucono-1,5-lactone 6-phosphate(aq) + NADPH(aq) 52 298.15 7.6 1455 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70WUR/HES_163 70WUR/HES spectrophotometry D 1.1.1.49 glucose-6-phosphate dehydrogenase C00092 + C00006 = C01236 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) = D-glucono-1,5-lactone 6-phosphate(aq) + NADPH(aq) 1.3 298.15 6.4 1456 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.209 318.15 7 1457 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.282 331.15 7 1458 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.347 341.15 7 1459 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.176 311.15 7 1460 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.4 348.15 7 1461 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1330 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.246 325.15 7 1462 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/DEL_1178 56STE/DEL spectrophotometry B 4.2.1.17 enoyl-CoA hydratase C05268 = C05271 + C00001 (3S)-3-hydroxyhexanoyl-CoA(aq) = trans-hex-2-enoyl-CoA(aq) + H2O(l) 0.66 298.15 7.5 1463 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MIL/AVI_425 64MIL/AVI D 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 1.3 298.15 7.2 1464 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GRE/RUD_836 69GRE/RUD calorimetry A 3.1.4.17 phosphodiesterase I C00575 + C00001 = C00020 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = AMP(aq) 298.15 7.3 1465 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00053 298.15 8.87 1466 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00036 298.15 8.63 1467 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000637 298.15 8.85 1468 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000517 298.15 8.87 1469 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000523 298.15 8.89 1470 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000523 298.15 8.86 1471 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000466 298.15 8.81 1472 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000435 298.15 8.78 1473 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000446 298.15 8.75 1474 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000106 298.15 8.19 1475 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 8.18E-05 298.15 8.08 1476 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.75E-05 298.15 7.55 1477 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000531 298.15 8.83 1478 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000504 298.15 8.83 1479 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_129 53BUR/WIL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000692 298.15 8.95 1480 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_831 79LAW/VEE enzymatic assay; spectrophotometry A 3.1.3.11 fructose-biphosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 227 310.15 0.25 6.99 1481 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_831 79LAW/VEE enzymatic assay; spectrophotometry A 3.1.3.11 fructose-biphosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 174 310.15 0.25 6.99 2.22 1482 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/DEL_1175 56STE/DEL spectrophotometry B 4.2.1.17 enoyl-CoA hydratase C03561 = C00877 + C00001 (3R)-3-hydroxybutanoyl-CoA(aq) = cis-but-2-enoyl-CoA(aq) + H2O(l) 0.18 298.15 7.5 1483 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52BUR_29 52BUR B 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.073 298.15 7 1484 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/DEL_1176 56STE/DEL spectrophotometry C 4.2.1.17 enoyl-CoA hydratase C01144 = C00877 + C00001 (3S)-3-hydroxybutanoyl-CoA(aq) = trans-but-2-enoyl-CoA(aq) + H2O(l) 0.29 298.15 7.5 1485 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56ENG_1371 56ENG C 5.3.1.14 L-rhamnose isomerase C00507 = C00861 L-rhamnose(aq) = L-rhamnulose(aq) 1.5 298.15 1486 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60OCO/HAL_269 60OCO/HAL spectrophotometry C 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 0.000136 298.15 10 1487 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DOU/MER_117 61DOU/MER C 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.13 305.15 8 1488 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65MAR/JEN_527 65MAR/JEN spectrophotometry B 2.6.1.21 D-alanine transaminase C00133 + C00026 = C00022 + C00217 D-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + D-glutamate(aq) 0.59 310.15 8.3 1489 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/OES_1388 49MEY/OES polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6 297.15 1490 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_61 96TEW/GOL calorimetry A 1.1.1.14 L-iditol 2-dehydrogenase C01507 + C00003 = C00247 + C00004 L-iditol(aq) + NAD(aq) = L-sorbose(aq) + NADH(aq) 298.15 7.39 1491 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_60 96TEW/GOL HPLC and spectrophotometry A 1.1.1.14 L-iditol 2-dehydrogenase C01507 + C00003 = C00247 + C00004 L-iditol(aq) + NAD(aq) = L-sorbose(aq) + NADH(aq) 0.186 298.15 7.58 1492 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68JEA/DEM_210 68JEA/DEM spectrophotometry C 1.1.1.110 indolelactate dehydrogenase C02043 + C00003 = C00331 + C00004 indole-3-lactate(aq) + NAD(aq) = indole-3-pyruvate(aq) + NADH(aq) 630 310.15 7 1493 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.31 275.8 7.3 1494 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.31 276.9 6.35 1495 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.31 277 6.35 1496 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.5 284 6.35 1497 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.3 286.1 6.35 1498 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.01 288.2 6.35 1499 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.86 288.2 7.3 1500 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.57 291.9 6.35 1501 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.21 296.7 6.35 1502 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.98 298.7 6.35 1503 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.78 303 6.35 1504 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.63 303 6.35 1505 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.21 309.9 6.35 1506 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.09 310.7 6.35 1507 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.09 311.7 6.35 1508 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.98 298.1 7.3 1509 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.01 299.2 6.35 1510 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.68 282.3 6.35 1511 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.31 277.2 6.35 1512 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.5 283.5 7.3 1513 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.47 292.6 7.3 1514 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.47 292.6 7.3 1515 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.63 302.5 7.3 1516 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.21 307.8 7.3 1517 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53MAS_1148 53MAS spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.57 292.8 6.35 1518 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SAL/NOR_1253 68SAL/NOR chromatography and spectrophotometry C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.35 310.15 8.7 1519 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/LUN_134 67WIL/LUN spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.78E-05 311.15 0.25 7 1520 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 3.9E-11 298.15 6.05 1521 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.3E-09 298.15 7.01 1522 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.6E-09 298.15 7.26 1523 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.5E-08 298.15 7.43 1524 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.7E-09 298.15 7.57 1525 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 3.6E-08 298.15 8.01 1526 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7E-08 298.15 8.05 1527 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.7E-08 298.15 7.45 1528 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.1E-08 298.15 7.66 1529 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.9E-09 298.15 7.4 1530 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2E-08 298.15 7.6 1531 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.3E-09 298.15 6.63 1532 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.4E-08 298.15 7.82 1533 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 9.4E-09 298.15 7.39 1534 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=38EUL/ADL_273 38EUL/ADL spectrophotometry C 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.5E-09 298.15 7.36 1535 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36MEY/SCH_1096 36MEY/SCH calorimetry C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 298.15 1536 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56REI_1407 56REI spectrophotometry C 5.4.2.3 phosphoacetylglucosamine mutase C04256 = C00357 N-acetyl-D-glucosamine 1-phosphate(aq) = N-acetyl-D-glucosamine 6-phosphate(aq) 6 310.15 7.7 1537 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55LIE/KOR_480 55LIE/KOR spectrophotometry C 2.4.2.10 orotate phosphoribosyltransferase C01103 + C00013 = C00295 + C00119 orotidine 5'-phosphate(aq) + pyrophosphate(aq) = orotate(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 8.3 303.15 8 1538 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66UHR/MAR_616 66UHR/MAR C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 2.1 303.15 8 2.22 1539 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66UHR/MAR_616 66UHR/MAR C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 2.4 303.15 8 2.1 1540 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66UHR/MAR_616 66UHR/MAR C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 1.2 303.15 8 2.4 1541 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CAL/WEB_639 59CAL/WEB chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.42 303.15 7.5 1542 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95KOZ/TOM_1426 95KOZ/TOM HPLC C 5.4.99.6 isochorismate synthase C00251 + C00014 = C18054 + C00001 chorismate(aq) + ammonia(aq) = 2-amino-2-deoxyisochorismate(aq) + H2O(l) 2.67 298.15 8 1543 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95KOZ/TOM_1425 95KOZ/TOM HPLC C 5.4.99.6 isochorismate synthase C00251 = C00885 chorismate(aq) = isochorismate(aq) 0.55 298.15 8 1544 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1218 93LAR/TEW calorimetry A 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 298.15 8.15 1545 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1218 93LAR/TEW calorimetry A 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 310.15 8.15 1546 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60VOL_1370 60VOL spectrophotometry B 5.3.1.13 arabinose-5-phosphate isomerase C01112 = C00199 D-arabinose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.295 310.15 8 1547 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1217 93LAR/TEW HPLC A 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 3.01 298.25 8.41 1548 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1217 93LAR/TEW HPLC A 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 2.35 298.25 8.7 1549 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_776 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 55 308.15 7 1550 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_776 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 56 308.15 7 1 1551 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68ERI_27 68ERI spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00756 + C00003 = C01545 + C00004 1-octanol(aq) + NAD(aq) = octanal(aq) + NADH(aq) 0.0011 298.15 8.3 1552 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68ERI_25 68ERI spectrophotometry B 1.1.1.1 alcohol dehydrogenase C08492 + C00003 = C16310 + C00004 cis-3-hexene-1-ol(aq) + NAD(aq) = cis-3-hexenal(aq) + NADH(aq) 0.00072 298.15 8.3 1553 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BRE/AAS_393 69BRE/AAS spectrophotometry C 2.3.1.7 carnitine O-acetyltransferase C00100 + C00318 = C00010 + C03017 propionyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-propionylcarnitine(aq) 1.3 298.15 7.5 1554 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BRE/AAS_390 69BRE/AAS spectrophotometry B 2.3.1.7 carnitine O-acetyltransferase C00024 + C00318 = C00010 + C02571 acetyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-acetylcarnitine(aq) 1.5 298.15 7.5 1555 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AYL/SNE_532 68AYL/SNE spectrophotometry C 2.6.1.30 pyridoxamine-pyruvate transaminase C00534 + C00022 = C00250 + C00041 pyridoxamine(aq) + pyruvate(aq) = pyridoxal(aq) + L-alanine(aq) 1.21 298.15 8.85 1556 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.062 338.15 7 1557 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.131 348.15 7 1558 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.209 358.15 7 1559 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.039 333.15 7 1560 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.103 343.15 7 1561 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84LLO/CHA_1313 84LLO/CHA HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.182 353.15 7 1562 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53JON_1432 53JON spectrophotometry and chemical analysis B 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 2.7 310.15 7.5 1563 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KER/KER_1155 92KER/KER spectrophotometry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.3 298.15 7.6 1564 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_554 82RED calorimetry A 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 9 1565 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_554 82RED calorimetry A 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 9 1566 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_554 82RED calorimetry A 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 9 1567 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_554 82RED calorimetry A 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 9 1568 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_558 82RED calorimetry A 2.7.1.30 glycerol kinase C00002 + C00116 = C00008 + C00093 ATP(aq) + glycerol(aq) = ADP(aq) + sn-glycerol 3-phosphate(aq) 298.15 9 1569 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_558 82RED calorimetry A 2.7.1.30 glycerol kinase C00002 + C00116 = C00008 + C00093 ATP(aq) + glycerol(aq) = ADP(aq) + sn-glycerol 3-phosphate(aq) 298.15 9 1570 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_558 82RED calorimetry A 2.7.1.30 glycerol kinase C00002 + C00116 = C00008 + C00093 ATP(aq) + glycerol(aq) = ADP(aq) + sn-glycerol 3-phosphate(aq) 298.15 9 1571 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_558 82RED calorimetry A 2.7.1.30 glycerol kinase C00002 + C00116 = C00008 + C00093 ATP(aq) + glycerol(aq) = ADP(aq) + sn-glycerol 3-phosphate(aq) 298.15 9 1572 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68POT/GLO_386 68POT/GLO spectrophotometry and electrophoresis C 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 522 311.15 7 1573 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70VEE/RAI_257 70VEE/RAI spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phocphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 59 311.15 7 1574 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60MEN_429 60MEN chromatography, radioactivity, and chemical analysis C 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 3250 311.15 7.5 1575 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60MEN_429 60MEN chromatography, radioactivity, and chemical analysis C 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 53 311.15 5.5 1576 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GEO/TRA_1075 69GEO/TRA calorimetry C 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 + C00080 ATP-4-(aq) + H2O(l) = ADP-3-(aq) + HPO4-2-(aq) + H+(aq) 298.15 8.5 1577 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69TSU/FUK_689 69TSU/FUK fluorimetry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.26 303.15 8.5 1578 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99BAS/MAR_1512 99BAS/MAR spectrophotometry C 2.6.1.52 phosphoserine transferase C01005 + C00026 = C03232 + C00025 O-phospho-L-serine(aq) + 2-oxoglutarate(aq) = 3-phosphonooxypyruvate(aq) + L-glutamate(aq) 0.025 305 7.8 1579 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65AND/ALL_1375 65AND/ALL spectrophotometry B 5.3.1.15 D-lyxose ketol-isomerase C00476 = C00310 D-lyxose(aq) = D-xylulose(aq) 0.23 298.15 7 1580 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIM/KIN_466 92KIM/KIN HPLC and enzymatic assay A 2.4.2.1 purine-nucleoside phosphorylase C01762 + C00009 = C00385 + C00620 xanthosine(aq) + orthophosphate(aq) = xanthine(aq) + D-ribose 1-phosphate(aq) 0.0156 311.15 0.25 7 3 1581 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79BYE/SHE_253 79BYE/SHE spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.042 298.15 8.4 1582 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TSU/SAT_1300 65TSU/SAT spectrophotometry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.08 333.15 9 1583 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79VAN/DEB_1689 79VAN/DEB spectrophotometry and radioactivity B 2.6.1.19 4-aminobutyrate transaminase C00334 + C00026 = C00232 + C00025 4-aminobutanoate(aq) + 2-oxoglutarate(aq) = 4-oxobutanoate(aq) + L-glutamate(aq) 0.04 295.15 8.5 1584 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02ISO/KOI_1553 02ISO/KOI spectrophotometry C 1.1.1.28 D-lactate dehydrogenase C00256 + C00003 = C00022 + C00004 (R)-lactate(aq) + NAD(ox)(aq) = pyruvate(aq) + NAD(red)(aq) 0.0037 298.15 8 1585 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02ISO/KOI_1554 02ISO/KOI spectrophotometry C 1.1.1.28 D-lactate dehydrogenase C05984 + C00003 = C00109 + C00004 D-2-hydroxy-n-butanoate(aq) + NAD(ox)(aq) = 2-oxobutanoate(aq) + NAD(red)(aq) 0.0028 298.15 8 1586 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BEN/FRI_1367 70BEN/FRI spectrophotometry B 5.3.1.10 glucosamine-6-phosphate isomerase C00352 + C00001 = C00085 + C00014 D-glucosamine 6-phosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + ammonia(aq) 0.15 310.15 8.5 1587 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_890 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C01936 + 5 C00001 = 6 C00031 maltohexaose(aq) + 5 H2O(l) = 6 D-glucose(aq) 298.15 4.44 1588 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_890 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C01936 + 5 C00001 = 6 C00031 maltohexaose(aq) + 5 H2O(l) = 6 D-glucose(aq) 304.65 4.44 1589 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_890 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C01936 + 5 C00001 = 6 C00031 maltohexaose(aq) + 5 H2O(l) = 6 D-glucose(aq) 311.15 4.44 1590 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_897 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C02052 + 3 C00001 = 4 C00031 maltotetraose(aq) + 3 H2O(l) = 4 D-glucose(aq) 298.15 4.44 1591 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_896 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 4.44 1592 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_899 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C01835 + 2 C00001 = 3 C00031 maltotriose(aq) + 2 H2O(l) = 3 D-glucose(aq) 298.15 4.44 1593 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DAR_506 45DAR spectrophotometry C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.48 298.15 7.15 1594 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DAR_506 45DAR spectrophotometry C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.48 308.15 7.15 1595 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1322 86TEW/GOL HPLC B 5.3.1.5 xylose isomerase C06468 = C06464 D-psicose(aq) = D-altrose(aq) 0.3 333.15 7.4 1596 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1321 86TEW/GOL HPLC A 5.3.1.5 xylose isomerase C06468 = C01487 D-psicose(aq) =-D-allose(aq) 2.15 317.25 7.4 1597 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1321 86TEW/GOL HPLC A 5.3.1.5 xylose isomerase C06468 = C01487 D-psicose(aq) =-D-allose(aq) 2.32 325.15 7.4 1598 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1321 86TEW/GOL HPLC A 5.3.1.5 xylose isomerase C06468 = C01487 D-psicose(aq) =-D-allose(aq) 2.77 341.55 7.4 1599 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1321 86TEW/GOL HPLC A 5.3.1.5 xylose isomerase C06468 = C01487 D-psicose(aq) =-D-allose(aq) 3.01 349.25 7.4 1600 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86TEW/GOL_1321 86TEW/GOL HPLC A 5.3.1.5 xylose isomerase C06468 = C01487 D-psicose(aq) =-D-allose(aq) 2.55 333.15 7.4 1601 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86REK/SKY_1025 86REK/SKY calorimetry C 3.5.1.14 aminoacylase C02712 + C00001 = C00033 + C00073 N-acetyl-L-methionine(aq) + H2O(l) = acetate(aq) + L-methionine(aq) 298.15 6.86 1602 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_940 91GOL/BEL calorimetry A 3.2.1.26 _-fructofuranosidase C00492 + C00001 = C05402 + C00095 raffinose(aq) + H2O(l) =-D-melibiose(aq) + D-fructose(aq) 298.15 6 1603 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=04LI/LI_1581 04LI/LI calorimetry A 3.6.1.3 adenosinetriphosphatase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 310.15 7.4 1604 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87ANT_796 87ANT calorimetry A 3.1.3.1 alkaline phosphatase C02734 + C00001 = C00146 + C00009 phenyl phosphate(aq) + H2O(l) = phenol(aq) + orthophosphate(aq) 298.15 10.4 1605 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71KUN/STA_1384 71KUN/STA spectrophotometry B 5.3.3.6 methylitaconate ?-isomerase C02295 = C00922 methylitaconate(aq) = dimethylmaleate(aq) 3.4 307.15 7.9 1606 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87ANT_793 87ANT calorimetry A 3.1.3.1 alkaline phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 10.4 1607 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64TAK/SAW_1373 64TAK/SAW spectrophotometry B 5.3.1.14 L-rhamnose isomerase C00507 = C00861 L-rhamnose(aq) = L-rhamnulose(aq) 1.5 310.15 7.6 1608 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.66 1609 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.69 1610 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.71 1611 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 9.01 1612 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.66 1613 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.65 1614 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.67 1615 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 6.71 1616 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 6.75 1617 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.06 1618 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.25 1619 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.45 1620 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.46 1621 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.99 1622 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.09 1623 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.2 1624 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.42 1625 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.44 1626 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.56 1627 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.84 1628 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.66 1629 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.66 1630 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.72 1631 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.64 1632 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 305.11 8.65 1633 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.64 1634 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 7.67 1635 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.66 1636 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.68 1637 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.68 1638 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.41 1639 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8 1640 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.67 1641 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.54 1642 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.41 1643 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 9.01 1644 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 301.66 8.63 1645 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 8.71 1646 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=75GOL_546 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.19 6.69 1647 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.126 278.15 0.25 7.82 1648 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.162 298.15 0.25 7.49 1649 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0353 298.15 0.25 6.75 1650 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.026 298.15 0.25 6.67 1651 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00344 298.15 0.25 5.71 1652 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0656 288.15 0.25 7.31 1653 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00673 278.15 0.25 6.43 1654 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0646 313.15 0.25 6.69 1655 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00925 298.15 0.25 6.19 1656 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.328 313.15 0.25 7.4 1657 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.155 278.15 0.25 7.87 1658 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00239 288.15 0.25 5.79 1659 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.393 308.15 0.25 7.62 1660 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.292 298.15 0.25 7.72 1661 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0558 308.15 0.25 6.7 1662 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00145 308.15 0.25 6.13 1663 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00533 313.15 0.25 5.63 1664 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.357 278.15 0.25 8.19 1665 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0132 298.15 0.25 6.3 1666 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0701 298.15 0.25 7.11 1667 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0701 298.15 0.25 7.11 1668 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.191 313.15 0.25 7.18 1669 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0169 288.15 0.25 6.73 1670 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.104 288.15 0.25 7.55 1671 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.113 308.15 0.25 7.06 1672 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.435 313.15 0.25 7.59 1673 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0967 298.15 0.25 7.25 1674 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.551 298.15 0.25 8.02 1675 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00938 308.15 0.25 5.87 1676 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00145 313.15 0.25 6.1 1677 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.579 313.15 0.25 7.65 1678 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0277 278.15 0.25 7.25 1679 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.381 288.15 0.25 8.11 1680 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.477 308.15 0.25 7.66 1681 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.251 308.15 0.25 7.43 1682 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0519 313.15 0.25 6.58 1683 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0706 278.15 0.25 7.62 1684 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.882 308.15 0.25 7.96 1685 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0459 278.15 0.25 7.38 1686 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.144 308.15 0.25 7.19 1687 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00973 288.15 0.25 6.37 1688 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00973 288.15 0.25 6.37 1689 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00449 288.15 0.25 5.99 1690 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0233 313.15 0.25 6.23 1691 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.236 298.15 0.25 7.68 1692 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.188 288.15 0.25 7.8 1693 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00531 308.15 0.25 5.67 1694 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0103 313.15 0.25 5.85 1695 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.131 313.15 0.25 7.03 1696 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00413 278.15 0.25 6.06 1697 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 1.08 313.15 0.25 7.93 1698 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0183 278.15 0.25 6.88 1699 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0236 288.15 0.25 6.82 1700 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0208 308.15 0.25 6.25 1701 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00145 278.15 0.25 5.88 1702 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0111 278.15 0.25 6.8 1703 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0037 278.15 0.25 6.32 1704 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00636 298.15 0.25 5.92 1705 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.00651 288.15 0.25 6.25 1706 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.15 288.15 0.25 7.74 1707 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0425 308.15 0.25 6.61 1708 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0428 288.15 0.25 7.18 1709 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=03KIN_1573 03KIN spectrophotometry coupled with enzymatic assay A 1.1.1.2 alcohol dehydrogenase C01845 + C00006 = C00207 + C00005 2-propanol(aq) + NADP(ox)(aq) = acetone(aq) + NADP(red)(aq) 0.0428 288.15 0.25 7.18 1710 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95LIA/WAN2_1048 95LIA/WAN2 calorimetry B 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 9.4 1711 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_549 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00159 = C00008 + C00275 ATP(aq) + D-mannose(aq) = ADP(aq) + D-mannose 6-phosphate(aq) 298.19 8.57 1712 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_549 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00159 = C00008 + C00275 ATP(aq) + D-mannose(aq) = ADP(aq) + D-mannose 6-phosphate(aq) 301.66 8.6 1713 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_549 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00159 = C00008 + C00275 ATP(aq) + D-mannose(aq) = ADP(aq) + D-mannose 6-phosphate(aq) 305.11 8.63 1714 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOL_549 75GOL calorimetry A 2.7.1.1 hexokinase C00002 + C00159 = C00008 + C00275 ATP(aq) + D-mannose(aq) = ADP(aq) + D-mannose 6-phosphate(aq) 298.19 8.62 1715 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STA_375 54STA spectrophotometry B 2.3.1.2&2.3.1.8 imidazole N-acetyltransferase and phosphate acetyltransferase C00227 + C01589 = C02560 + C00009 acetyl phosphate(aq) + imidazole(aq) = N-acetylimidazole(aq) + orthophosphate(aq) 0.006 299.15 6.15 1716 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STA_375 54STA spectrophotometry B 2.3.1.2&2.3.1.8 imidazole N-acetyltransferase and phosphate acetyltransferase C00227 + C01589 = C02560 + C00009 acetyl phosphate(aq) + imidazole(aq) = N-acetylimidazole(aq) + orthophosphate(aq) 0.0073 299.15 6.45 1717 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STA_375 54STA spectrophotometry B 2.3.1.2&2.3.1.8 imidazole N-acetyltransferase and phosphate acetyltransferase C00227 + C01589 = C02560 + C00009 acetyl phosphate(aq) + imidazole(aq) = N-acetylimidazole(aq) + orthophosphate(aq) 0.011 299.15 6.95 1718 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STA_375 54STA spectrophotometry B 2.3.1.2&2.3.1.8 imidazole N-acetyltransferase and phosphate acetyltransferase C00227 + C01589 = C02560 + C00009 acetyl phosphate(aq) + imidazole(aq) = N-acetylimidazole(aq) + orthophosphate(aq) 0.0092 299.15 7.3 1719 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STA_375 54STA spectrophotometry B 2.3.1.2&2.3.1.8 imidazole N-acetyltransferase and phosphate acetyltransferase C00227 + C01589 = C02560 + C00009 acetyl phosphate(aq) + imidazole(aq) = N-acetylimidazole(aq) + orthophosphate(aq) 0.0099 299.15 7.2 1720 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85BAR_430 85BAR electrophoresis and radioactivity C 2.4.1.14 sucrose-phosphate synthase C00029 + C00085 = C00015 + C16688 UDPglucose(aq) + D-fructose 6-phosphate(aq) = UDP(aq) + sucrose 6-phosphate(aq) 5 310.15 7.5 1721 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61RAC2_372 61RAC2 enzymatic assay B 2.2.1.2 transaldolase C05382 + C00118 = C00279 + C00085 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phosphate(aq) + D-fructose 6-phosphate(aq) 1.05 310.15 7.4 1722 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/TOU_56 57HOL/TOU spectrophotometry B 1.1.1.10 L-xylulose reductase C00379 + C00006 = C00312 + C00005 xylitol(aq) + NADP(aq) = L-xylulose(aq) + NADPH(aq) 0.000858 298.15 7 1723 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/TOU_56 57HOL/TOU spectrophotometry B 1.1.1.10 L-xylulose reductase C00379 + C00006 = C00312 + C00005 xylitol(aq) + NADP(aq) = L-xylulose(aq) + NADPH(aq) 0.00858 298.15 8 1724 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.37 298.15 0.01 7.3 1725 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.59 298.15 0.1 7.3 1726 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 9.49 298.15 0.05 4.06 1727 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.66 298.15 0.05 5 1728 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.66 298.15 0.05 5.05 1729 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.47 298.15 0.05 6.06 1730 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.35 298.15 0.05 8 1731 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.43 298.15 0.05 9.01 1732 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.11 313 0.1 7.3 1733 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.01 307.7 0.1 7.3 1734 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4 307.5 0.1 7.3 1735 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.93 307.5 0.1 7.3 1736 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.97 307.3 0.1 7.3 1737 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.68 304.1 0.1 7.3 1738 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.74 304.1 0.1 7.3 1739 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.69 303.6 0.1 7.3 1740 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.04 293.3 0.1 7.3 1741 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.54 291.2 0.1 7.3 1742 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.68 290.8 0.1 7.3 1743 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.61 290.8 0.1 7.3 1744 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.22 277.8 0.1 7.3 1745 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.22 277.8 0.1 7.3 1746 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.37 277.8 0.1 7.3 1747 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.88 292.6 0.1 4.91 1748 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.01 290.8 0.1 4.91 1749 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.2 290.8 0.1 4.91 1750 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.51 290.6 0.1 4.91 1751 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.08 290.8 0.1 4.91 1752 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.34 295.2 0.1 4.91 1753 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.28 298.15 0.0011 7.3 1754 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.13 313 0.1 7.3 1755 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.55 298.15 0.05 6 1756 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.72 308.3 0.1 7.3 1757 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.82 294.1 0.1 7.3 1758 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 7.36 290.6 0.1 4.91 1759 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.87 298.15 0.25 7.3 1760 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.31 298.15 0.05 7.99 1761 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.97 307.6 0.1 7.3 1762 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.7 291.2 0.1 7.3 1763 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 8.14 277.9 0.1 4.91 1764 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.85 303.6 0.1 7.3 1765 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.94 307.5 0.1 4.91 1766 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 5.94 307.5 0.1 4.91 1767 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.42 298.15 0.05 6.01 1768 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.88 294.1 0.1 7.3 1769 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.44 298.15 0.049 7.3 1770 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.99 293.4 0.1 7.3 1771 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 6.69 292.6 0.1 4.91 1772 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=53BOC/ALB_1146 53BOC/ALB spectrophotometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.81 308.3 0.1 7.3 1773 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56HUR/HOR_1244 56HUR/HOR enzymatic assay and spectrophotometry B 5.1.3.1 ribulose-phosphate 3-epimerase C00199 = C00231 D-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.5 298.15 7.5 1774 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69PAS/LOW_1400 69PAS/LOW fluorimetry B 5.4.2.2 phosphoglucomutase C00085 + C01231 = C00092 + C00354 D-fructose 6-phosphate(aq) + D-glucose 1,6-diphosphate(aq) =-D-glucose 6-phosphate(aq) + D-fructose 1,6-bisphosphate(aq) 12 311.15 7 1775 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92WED/LEY_1701 92WED/LEY spectrophotometry and radioactivity B 1.1.1.3 homoserine dehydrogenase C00263 + C00006 = C00441 + C00005 L-homoserine(aq) + NADP(ox)(aq) = L-aspartate 4-semialdehyde(aq) + NADP(red)(aq) 0.01 310.15 9 1776 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73HAN/RUD_553 73HAN/RUD enzymatic assay; spectrophotometry A 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 2290 303.15 8 1777 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.22E-07 300.15 0.0245 6.83 1778 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 5.81E-07 300.15 0.0445 6.82 1779 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.37E-07 300.15 0.055 6.9 1780 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 5.62E-07 300.15 0.055 6.9 1781 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 8.64E-07 300.15 0.055 7.07 1782 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.04E-07 300.15 0.067 6.92 1783 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.13E-07 300.15 0.067 6.92 1784 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.31E-07 300.15 0.067 6.89 1785 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 8.66E-07 300.15 0.089 6.98 1786 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 8.8E-07 300.15 0.089 6.93 1787 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.79E-07 300.15 0.089 6.95 1788 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.51E-07 300.15 0.101 6.9 1789 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 9.86E-07 300.15 0.111 6.97 1790 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.01E-06 300.15 0.111 6.98 1791 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 9.13E-07 300.15 0.111 6.96 1792 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.08E-06 300.15 0.135 6.98 1793 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.04E-06 300.15 0.135 6.95 1794 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.3E-06 300.15 0.233 6.95 1795 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.24E-06 300.15 0.233 6.9 1796 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.39E-06 300.15 0.233 6.99 1797 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.52E-06 300.15 0.471 6.9 1798 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.52E-06 300.15 0.471 6.9 1799 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.49E-06 300.15 0.471 6.9 1800 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.51E-06 300.15 0.471 6.9 1801 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.12E-06 300.15 0.471 6.79 1802 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.84E-06 300.15 0.471 6.99 1803 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.83E-06 300.15 0.471 6.99 1804 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.56E-06 303.15 0.709 6.89 1805 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.4E-06 298.1 0.47 7 1806 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.8E-06 300.1 0.47 7 1807 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.8E-06 305.1 0.47 7 1808 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.3E-06 309.8 0.47 7 1809 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.14E-07 300.15 0.0245 6.93 1810 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 5.3E-06 311.1 0.47 7 1811 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 5.73E-07 300.15 0.0445 6.94 1812 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.79E-07 300.15 0.067 6.94 1813 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.16E-06 300.15 0.101 7.06 1814 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.05E-06 300.15 0.135 6.97 1815 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.78E-06 300.15 0.471 7.17 1816 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=67ENG/DAL_276 67ENG/DAL spectrophotometry A 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.18E-06 303.15 0.709 7.02 1817 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70JEN/TAY_536 70JEN/TAY spectrophotometry C 2.6.1.42 branched-chain-amino-acid transaminase C00123 + C00026 = C00233 + C00025 L-leucine(aq) + 2-oxoglutarate(aq) = 4-methyl-2-oxopentanooate(aq) + L-glutamate(aq) 1.75 310.15 8.3 1818 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_785 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 298.15 8.15 3 1819 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_785 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 298.15 9.14 3 1820 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_785 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 304.55 7.92 3 1821 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_785 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 310.15 7.81 3 1822 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_785 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00130 + C00001 = C00294 + C00009 IMP(aq) + H2O(l) = inosine(aq) + orthophosphate(aq) 298.15 8.55 3 1823 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_141 85ANS/PRI D 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.4E-05 311.15 7.6 1824 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_141 85ANS/PRI D 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.6E-05 311.15 7.6 1825 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_141 85ANS/PRI D 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 6.4E-05 311.15 7.6 1826 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78OKA/GEN_893 78OKA/GEN paper chromatography C 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 322 303.15 1827 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97STA/SUA_1365 97STA/SUA spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.33 310.15 7 1828 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97STA/SUA_1365 97STA/SUA spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.3 310.15 8 1829 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72STU_745 72STU calorimetry A 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 298.15 7.1 1830 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93HUT/BOH_227 93HUT/BOH calorimetry A 1.1.3.4 glucose oxidase C00031 + C00007 = C00198 + C00027 -D-glucose(aq) + O2(aq) = D-glucono-1,5-lactone(aq) + H2O2(aq) 298.15 6.86 1831 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70TSA/HOL_1255 70TSA/HOL spectrophotometry A 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.3 298.15 8.7 1832 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06XU/WES_1713 06XU/WES spectrophotometry A 1.5.1.7 saccharopine dehydrogenase (NAD+, L-lysine-forming) C00449 + C00003 + C00001 = C00047 + C00026 + C00004 N6-(L-1,3-dicarboxypropyl)-L-lysine + NAD(ox) + H2O(l) = L-lysine(aq) + 2-oxoglutarate(aq) + NAD(red) 3.9E-07 298.15 7 1833 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55LEH/SIC_1097 55LEH/SIC C 4.1.2.13 fructose-biphosphate aldolase C01094 = C00577 + C00111 D-fructose 1-phosphate(aq) = D-glyceraldehyde(aq) + glycerone phosphate(aq) 2.8E-06 310.15 7 1834 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55LEH/SIC_1092 55LEH/SIC C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.000118 310.15 7 1835 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 1.03E-07 298.15 7.82 1836 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 2.92E-07 298.15 8 1837 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 2.33E-07 298.15 8.1 1838 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 3.3E-07 298.15 8.3 1839 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 9.29E-08 298.15 7.83 1840 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 1.2E-07 298.15 7.85 1841 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_88 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 3.05E-07 298.15 8.4 1842 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 8.9E-05 287.45 7.98 1843 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000154 292.15 7.91 1844 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000235 298.15 7.76 1845 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.00024 298.15 7.84 1846 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000277 298.15 7.85 1847 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000212 298.15 7.89 1848 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000222 298.15 7.97 1849 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000259 298.15 8.85 1850 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000223 298.15 8.85 1851 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000424 304.25 7.71 1852 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000359 304.25 7.71 1853 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000598 310.15 7.81 1854 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 8.3E-05 287.45 7.98 1855 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000571 310.15 7.81 1856 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000228 298.15 7.77 1857 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000261 298.15 7.93 1858 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000959 316.15 7.94 1859 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000265 298.15 7.93 1860 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.00101 316.15 7.92 1861 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1139 94TEW/GOL HPLC A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 0.000137 292.15 7.9 1862 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84BLA/COC_295 84BLA/COC spectrophotometry and HPLC C 1.5.1.3 dihydrofolate reductase 2 C00415 = C00504 + C00101 2 7,8-dihydrofolate(aq) = folate(aq) + 5,6,7,8-tetrahydrofolate(aq) 19.4 295.15 7 1863 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MAR/BAR_196 63MAR/BAR spectrophotometry C 1.1.1.67 mannitol dehydrogenase C00392 + C00003 = C00095 + C00004 D-mannitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.084 298.15 7.2 1864 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 5.6E-05 298.15 8.1 1865 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.000481 298.15 9.2 1866 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 1.31E-05 298.15 7.5 1867 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.000255 298.15 8.85 1868 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.24E-05 298.15 8 1869 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55ZEL_85 55ZEL spectrophotometry B 1.1.1.26 glyoxylate reductase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.71E-06 298.15 7 1870 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80SVE/MAR_1008 80SVE/MAR spectrophotometry B 3.5.1.11 penicillin amidase C07761 + C00001 = C02595 + C07756 cephalothin(aq) + H2O(l) = 2-thienylacetic acid(aq) + 7-aminocephalosporanic acid(aq) 0.007 298.15 5 1871 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69DAH/AND_1109 69DAH/AND enzymatic assay and spectrophotometry B 4.1.2.18 2-dehydro-3-deoxy-L-pentonate aldolase C00684 = C00022 + C00266 2-dehydro-3-deoxy-L-pentonate(aq) = pyruvate(aq) + glycolaldehyde(aq) 0.00037 301.15 7.4 1872 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_921 91TEW/GOL HPLC A 3.2.1.21 _-glucosidase C05402 + C00001 = C00124 + C00031 -D-melibiose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 123 298.15 5.65 1873 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELL_588 89ELL NMR and enzymatic assay C 2.7.3.1 guanidinoacetate kinase C00002 + C00581 = C00008 + C03166 ATP(aq) + guanidinoacetate(aq) = ADP(aq) + phosphoguanidinoacetate(aq) 29 308.15 7.25 1874 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SHO/PRI_216 59SHO/PRI C 1.1.1.140 sorbitol-6-phosphate dehydrogenase C01096 + C00003 = C00085 + C00004 D-sorbitol 6-phosphate(aq) + NAD(aq) = D-fructose 6-phosphate(aq) + NADH(aq) 2.2 298.15 9.31 1875 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BUR_39 55BUR spectrophotometry C 1.1.1.6 glycerol dehydrogenase C00116 + C00003 = C00184 + C00004 glycerol(aq) + NAD(aq) = dihydroxyacetone(aq) + NADH(aq) 6.4E-05 298.15 7.1 1876 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_70 96TEW/GOL HPLC and spectrophotometry A 1.1.1.14 L-iditol 2-dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.094 298.15 7.63 1877 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_71 96TEW/GOL calorimetry A 1.1.1.14 L-iditol 2-dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 298.15 7.55 1878 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69SHE/ALE_446 69SHE/ALE enzymatic assay C 2.4.1.20 cellobiose phosphorylase C06219 + C00009 = C00185 + C00103 cellotriose(aq) + orthophosphate(aq) = cellobiose(aq) + D-glucose 1-phosphate(aq) 0.4 310.15 7.5 1879 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_73 96TEW/GOL HPLC and spectrophotometry A 1.1.1.14 L-iditol 2-dehydrogenase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.00122 298.15 7.51 1880 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96TEW/GOL_74 96TEW/GOL calorimetry A 1.1.1.14 L-iditol 2-dehydrogenase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 298.15 7.43 1881 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76WEI/KIR_1179 76WEI/KIR spectrophotometry C 4.2.1.20 tryptophan synthase C00118 + C00463 = C03506 D-glyceraldehyde 3-phosphate(aq) + indole(aq) = 1-(indol-3-yl)glycerol 3-phosphate(aq) 2300 298.15 7.8 1882 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 8.65 303.15 0.065 5.42 1883 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.5 303.15 0.065 6.45 1884 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.59 303.15 0.065 7.5 1885 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.65 303.15 0.065 7.89 1886 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 9.81 293.15 0.065 6.22 1887 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.28 293.15 0.065 7.24 1888 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.74 293.15 0.065 8.06 1889 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.3 303.15 0.046 7.4 1.34 1890 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.31 303.15 0.032 7.4 1.48 1891 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.64 303.15 0.059 7.4 1.34 1892 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.45 303.15 0.3 7.45 1893 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.36 303.15 0.038 7.4 1.48 1894 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.02 303.15 0.065 6.2 1895 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.4 303.15 0.065 7.1 1896 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.72 303.15 0.065 6.66 1897 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.14 303.15 0.3 7.8 1898 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.11 303.15 0.085 7.4 1.34 1899 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.43 303.15 0.3 7.01 1900 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.47 303.15 0.3 8.12 1901 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.84 303.15 0.3 7.55 1902 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.1 303.15 0.3 7.89 1903 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.1 303.15 0.3 7.89 1904 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74CLA/BIR_1395 74CLA/BIR spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.06 303.15 0.3 6.97 1905 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DOU_416 61DOU D 2.4.1.7 sucrose phosphorylase C00089 + C00009 = C00103 + C00095 sucrose(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-fructose(aq) 20 303.15 6.6 1906 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00KIS/TEW_1574 00KIS/TEW calorimetry and chromatography A 3.5.1.2 glutaminase C00064 + C00001 = C00025 + C00014 L-glutamine(aq) + H2O(l) = L-glutamate(aq) + ammonia(aq) 298.15 0.11 5.14 1907 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00KIS/TEW_1575 00KIS/TEW calorimetry and chromatography A 3.5.1.1 asparaginase C00152 + C00001 = C00049 + C00014 L-asparagine(aq) + H2O(l) = L-aspartate(aq) + ammonia(aq) 298.15 0.11 7.03 1908 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65GAU/WOL_1226 65GAU/WOL chemical analysis C 4.3.2.3 ureidoglycolate lyase C00603 = C00048 + C00086 (-)-ureidoglycolate(aq) = glyoxylate(aq) + urea(aq) 0.15 303.15 8.4 1909 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65GAU/WOL_1226 65GAU/WOL chemical analysis C 4.3.2.3 ureidoglycolate lyase C00603 = C00048 + C00086 (-)-ureidoglycolate(aq) = glyoxylate(aq) + urea(aq) 0.14 303.15 8.8 1910 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_568 82RED calorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.5 1911 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_568 82RED calorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.5 1912 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_568 82RED calorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.5 1913 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82RED_568 82RED calorimetry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 298.15 8.5 1914 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95LIU/ZEN_1049 95LIU/ZEN calorimetry B 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 9.5 1915 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66ALL_234 66ALL enzymatic assay and spectrophotometry B 1.1.99.7 lactate-malate transhydrogenase C00186 + C00036 = C00149 + C00022 (S)-lactate(aq) + oxaloacetate(aq) = (S)-malate(aq) + pyruvate(aq) 1.8 303.15 7.5 1916 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71TAN/JOH_402 71TAN/JOH chromatography and spectrophotometry C 2.3.1.8&2.3.1.54 phosphate acetyltransferase and formate C-acetyltransferase C00022 + C00009 = C00227 + C00058 pyruvate(aq) + orthophosphate(aq) = acetyl phosphate(aq) + formate(aq) 23 310.15 7.2 1917 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70GEO/WIT_806 70GEO/WIT calorimetry C 3.1.3.1 alkaline phosphatase C00074 + C00001 = C00022 + C00009 phosphoenolpyruvate3-(aq) + H2O(l) = pyruvate-(aq) + HPO4-2-(aq) 298.15 1918 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 57.4 278.5 7.4 2 1919 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 28.8 283.2 7.4 2 1920 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 21.8 288 7.4 2 1921 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 12.3 303.15 7.4 2.3 1922 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 23.6 303.15 7.4 2 1923 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 38.2 303.15 7.4 1.7 1924 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 48.2 303.15 7.57 2 1925 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 18.5 309.5 7.4 2 1926 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 19.6 298.2 7.4 2 1927 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 17.8 303 7.4 2 1928 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 5 303.15 6.73 2 1929 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 12.8 303.15 7.03 2 1930 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71WOH_709 71WOH enzymatic assay A 2.7.7.42 [glutamate-ammonia-ligase] adenylyltransferase C00002 + C01281 = C00013 + C01299 ATP(aq) + [L-glutamate:ammonia ligase(ADP-forming)](aq) = pyrophosphate(aq) + adenylyl-[L-glutamate:ammonia ligase(ADP-forming)](aq) 12.9 303.15 7 2 1931 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79SCH/HIN_108 79SCH/HIN calorimetry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 298.15 7 1932 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79SCH/HIN_108 79SCH/HIN calorimetry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 308.15 7 1933 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79SCH/HIN_108 79SCH/HIN calorimetry A 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 283.15 7 1934 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_786 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C00275 + C00001 = C00159 + C00009 D-mannose 6-phosphate(aq) + H2O(l) = D-mannose(aq) + orthophosphate(aq) 39 311.15 8.5 1935 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KRA/GYG_1120 91KRA/GYG HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.012 283.15 7.5 1936 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91KRA/GYG_1120 91KRA/GYG HPLC A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.0348 298.15 7.5 1937 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92XIA/XUE_1414 92XIA/XUE spectrophotometry C 5.4.2.8 phosphomannomutase C00636 = C00275 D-mannose 1-phosphate(aq) = D-mannose 6-phosphate(aq) 16.2 303.15 7.5 1938 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52ASK_592 52ASK C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.04 311.15 8.5 1939 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52ASK_592 52ASK C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.2 311.15 8.5 1940 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54UTT/KUR_1082 54UTT/KUR chromatography and enzymatic assay C 4.1.1.32 phosphoenolpyruvate carboxykinase (GTP) C00081 + C00036 + C00001 = C00104 + C00074 + C00288 ITP(aq) + oxaloacetate(aq) + H2O(l) = IDP(aq) + phosphoenolpyruvate(aq) + carbon dioxide(aq) 12 303.15 7.6 1941 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.252 311.15 0.25 7.01 3.16 1942 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.171 311.15 0.25 7.01 2.39 1943 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.395 311.15 0.25 7.01 3.54 1944 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.695 311.15 0.25 7.01 4.32 1945 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.164 311.15 0.25 7.01 2.57 1946 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/VEE_403 73GUY/VEE spectrophotometry and enzymatic assay A 2.3.1.8&2.7.2.1 phosphate acetyltransferase and acetate kinase C00010 + C00033 + C00002 = C00024 + C00008 + C00009 CoA(aq) + acetate(aq) + ATP(aq) = acetyl-CoA(aq) + ADP(aq) + orthophospate(aq) 0.989 311.15 0.25 7.01 5.6 1947 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79REK/EGO_238 79REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 7.48 1948 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79REK/EGO_238 79REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 8.01 1949 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79REK/EGO_238 79REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 6.44 1950 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79REK/EGO_238 79REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 6.02 1951 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 7.34 1952 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 7.63 1953 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 7.93 1954 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 8.02 1955 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 8.2 1956 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 8.23 1957 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 8.38 1958 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 304.65 7.91 1959 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 7.08 1960 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 298.15 8.96 1961 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1056 93LAR/TEW calorimetry A 3.5.4.6 AMP deaminase C00020 + C00001 = C00130 + C00014 AMP(aq) + H2O(l) = IMP(aq) + ammonia(aq) 310.15 7.79 1962 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85SRI/FIS_293 85SRI/FIS spectrophotometry B 1.5.1.1 pyrroline-2-carboxylate reductase C00148 + C00006 = C03564 + C00005 (S)-proline(aq) + NADP(aq) =D-1-pyrroline-2-carboxylate(aq) + NADPH(aq) 0.0036 298.15 9 1963 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85SRI/FIS_293 85SRI/FIS spectrophotometry B 1.5.1.1 pyrroline-2-carboxylate reductase C00148 + C00006 = C03564 + C00005 (S)-proline(aq) + NADP(aq) =D-1-pyrroline-2-carboxylate(aq) + NADPH(aq) 0.0036 298.15 9.2 1964 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85SRI/FIS_293 85SRI/FIS spectrophotometry B 1.5.1.1 pyrroline-2-carboxylate reductase C00148 + C00006 = C03564 + C00005 (S)-proline(aq) + NADP(aq) =D-1-pyrroline-2-carboxylate(aq) + NADPH(aq) 0.0036 298.15 8.5 1965 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85SRI/FIS_293 85SRI/FIS spectrophotometry B 1.5.1.1 pyrroline-2-carboxylate reductase C00148 + C00006 = C03564 + C00005 (S)-proline(aq) + NADP(aq) =D-1-pyrroline-2-carboxylate(aq) + NADPH(aq) 0.0036 298.15 7.9 1966 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_32 80COO/BLA spectrophotometry B 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.53 298.15 8 1967 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.343 298.15 8.31 3.29 1968 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.352 292.15 8.46 3.29 1969 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.357 304.15 8.16 3.29 1970 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.351 304.15 8.34 3.29 1971 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.381 298.15 8.34 2.62 1972 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.378 298.15 8.54 2.62 1973 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.634 298.15 8.33 1.11 1974 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.603 298.15 8.53 1.11 1975 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.484 298.15 8.5 2.13 1976 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.302 298.15 8.32 1.4 1977 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.268 298.15 8.5 1.4 1978 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.361 298.15 8.54 3.71 1979 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.462 298.15 8.68 3.71 1980 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.458 298.15 8.87 3.72 1981 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.366 298.15 7.79 3.67 1982 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.366 298.15 6.04 3.67 1983 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.377 298.15 6.67 3.67 1984 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.364 298.15 6.77 3.77 1985 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.365 298.15 7.41 3.77 1986 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.366 298.15 7.45 3.77 1987 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.346 298.15 8.54 3.29 1988 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.346 298.15 8.54 3.29 1989 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.861 298.15 8.28 1.61 1990 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.412 298.15 8.67 3.71 1991 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.934 311.15 6.83 1.61 1992 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.351 310.25 7.98 3.29 1993 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 298.15 8.73 3.71 1994 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.348 310.25 8.13 3.29 1995 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.349 298.15 8.4 3.71 1996 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.355 286.05 8.68 3.29 1997 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.258 298.15 8.56 0.62 1998 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.45 298.15 8.57 3.71 1999 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.475 298.15 8.3 2.13 2000 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.364 298.15 7.93 3.67 2001 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.26 298.15 8.4 0.61 2002 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.365 298.15 6.88 3.77 2003 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.349 292.15 8.67 3.29 2004 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.854 298.15 8.51 1.61 2005 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.408 298.15 8.49 3.71 2006 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.928 311.15 7.04 1.61 2007 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=91TEW/GOL2_655 91TEW/GOL2 high-pressure liquid-chromatography A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.356 286.05 8.85 3.29 2008 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_656 91TEW/GOL2 calorimetry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 304.55 8.2 3.53 2009 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_656 91TEW/GOL2 calorimetry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 310.25 8.1 3.55 2010 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL2_656 91TEW/GOL2 calorimetry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 298.15 8.37 3.58 2011 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69DOL_235 69DOL enzymatic assay and spectrophotometry B 1.1.99.7 lactate-malate transhydrogenase C00186 + C00036 = C00149 + C00022 (S)-lactate(aq) + oxaloacetate(aq) = (S)-malate(aq) + pyruvate(aq) 4.3 297.15 7.8 2012 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.8 297.15 6.1 3 2013 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.55 297.15 8 3 2014 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.7 297.15 8 2.77 2015 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.84 297.15 8 2.51 2016 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.4 297.15 8 2.26 2017 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.25 297.15 8 2.05 2018 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.99 297.15 8 2.64 2019 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.64 297.15 8 2.34 2020 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.52 297.15 8 3.52 2021 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.67 297.15 8 2.43 2022 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.27 297.15 8 2.21 2023 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.57 297.15 9 3 2024 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.42 297.15 10.1 3 2025 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.57 297.15 8 3 2026 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.6 297.15 7 3 2027 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.24 297.15 8 2 2028 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KHO/KAR_653 83KHO/KAR paper chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.46 297.15 8 2.28 2029 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54MAR/WIL_1234 54MAR/WIL enzymatic assay B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1 307.15 8 2030 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72NAG/JAE_299 72NAG/JAE spectrophotometry C 1.5.1.3 dihydrofolate reductase C00101 + C00006 = C00415 + C00005 5,6,7,8-tetrahydrofolate(aq) + NADP(aq) = 7,8-dihydrofolate(aq) + NADPH(aq) 0.0005 298.15 8.2 2031 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66GOL/MAR_447 66GOL/MAR chromatography B 2.4.1.31 laminaribiose phosphorylase C02048 + C00009 = C00031 + C00103 laminaribiose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.3 310.15 6.5 2032 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00LIA/HUA_1580 00LIA/HUA calorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 298.15 9 2033 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71NOJ/TAN_399 71NOJ/TAN spectrophotometry B 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0075 300.15 7.6 2034 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STR/HAR_38 54STR/HAR spectrophotometry B 1.1.1.4 (R,R)-butanediol dehydrogenase C03044 + C00003 = C00810 + C00004 (R,R)-2,3-butanediol(aq) + NAD(aq) = (R)-acetoin(aq) + NADH(aq) 0.0668 300.15 8.4 2035 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54STR/HAR_38 54STR/HAR spectrophotometry B 1.1.1.4 (R,R)-butanediol dehydrogenase C03044 + C00003 = C00810 + C00004 (R,R)-2,3-butanediol(aq) + NAD(aq) = (R)-acetoin(aq) + NADH(aq) 0.00723 300.15 7.4 2036 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE2_498 53KRE2 manometry A 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.148 298.15 7.4 2037 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 6.67 298.15 5.6 2038 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 4.83 298.15 5.6 2039 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 8.06 298.15 5.6 2040 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 20.4 298.15 6 2041 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 2.09 298.15 5.1 2042 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 15 298.15 6 2043 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1524 98DIE/STR chromatography A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-(4-hydroxyphenyl)glycine(aq) 1.85 298.15 5.1 2044 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96KIM/DUN_1571 96KIM/DUN spectrophotometry B 5.4.2.9 phosphoenolpyruvate mutase C00074 = C02798 phosphoenolpyruvate(aq) = 3-phosphonopyruvate(aq) 0.0008 298.15 7.5 2045 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.8 298.15 8.08 2046 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.84 298.15 6.5 2047 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.19 298.15 7.28 2048 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.63 298.15 6.03 2.1 2049 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.83 298.15 6.04 2.1 2050 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.45 298.15 6.08 2.1 2051 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.76 298.15 6.08 2.1 2052 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.21 298.15 6.23 2.1 2053 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.27 298.15 6.23 2.1 2054 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.17 298.15 6.29 2.1 2055 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.54 288 7.5 2.1 2056 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.55 299.5 7.5 2.1 2057 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.5 298.15 6.5 3 2058 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.29 298.15 7 3 2059 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.68 298.15 7.5 3 2060 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.15 298.15 8.5 3 2061 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.4 298.15 6.5 2 2062 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.92 298.15 7 2 2063 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.41 298.15 8 2 2064 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.52 298.15 8.5 2 2065 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.35 298.15 6 2066 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.35 298.15 6 2067 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.48 298.15 6.88 2068 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.2 298.15 8.08 2069 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.91 298.15 6.5 2070 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.51 298.15 6.9 2071 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.48 298.15 7.28 2072 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.21 298.15 6.29 2.1 2073 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.1 298.15 6.34 2.1 2074 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.21 298.15 6.34 2.1 2075 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.63 298.15 6.49 2.1 2076 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.68 298.15 6.49 2.1 2077 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.84 298.15 6.55 2.1 2078 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.09 298.15 6.74 2.1 2079 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.37 298.15 6.74 2.1 2080 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.26 298.15 6.78 2.1 2081 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.26 298.15 6.84 2.1 2082 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.38 298.15 7 2.1 2083 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.52 298.15 7 2.1 2084 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.68 298.15 7 2.1 2085 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.4 298.15 7.12 2.1 2086 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.8 298.15 7.12 2.1 2087 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.8 298.15 7.12 2.1 2088 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.56 298.15 7.38 2.1 2089 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.64 298.15 7.38 2.1 2090 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5 298.15 7.38 2.1 2091 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.68 298.15 7.46 2.1 2092 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.82 298.15 7.46 2.1 2093 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.86 298.15 7.46 2.1 2094 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.06 298.15 7.88 2.1 2095 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.1 298.15 7.88 2.1 2096 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.92 298.15 7.88 2.1 2097 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.15 298.15 7.94 2.1 2098 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.08 298.15 8.25 2.1 2099 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.19 298.15 6.5 2100 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.36 298.15 6.34 2.1 2101 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4 298.15 6.84 2.1 2102 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.71 298.15 7.85 2.1 2103 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.97 298.15 8.25 2.1 2104 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5 298.15 8 3 2105 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.29 298.15 7.5 2 2106 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.12 298.15 5.92 2107 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.32 298.15 6.23 2.1 2108 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.32 298.15 6.23 2.1 2109 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.61 298.15 6.55 2.1 2110 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.43 298.15 7 2.1 2111 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.7 298.15 7.38 2.1 2112 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.25 298.15 7.88 2.1 2113 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.8 298.15 7.16 2.1 2114 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.25 298.15 8.25 2.1 2115 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.28 307.5 7.5 2.1 2116 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.05 298.15 8.25 2.1 2117 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.78 298.15 6.43 2.1 2118 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.24 298.15 6.84 2.1 2119 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 4.97 298.15 7.16 2.1 2120 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.25 298.15 7.85 2.1 2121 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.76 298.15 6.13 2.1 2122 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.27 298.15 8.08 2123 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.65 298.15 6 2 2124 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.89 298.15 7.28 2125 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 3.16 298.15 6.9 2126 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.55 298.15 6.13 2.1 2127 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.32 298.15 5.92 2128 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.5 298.15 6 3 2129 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 2.5 298.15 6 3 2130 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=57WOL/BAL_1173 57WOL/BAL spectrophotometry A 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 5.25 298.15 7.94 2.1 2131 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=31BOR/SCH_1141 31BOR/SCH electrochemistry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.1 298.15 6.81 2132 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=31BOR/SCH_1141 31BOR/SCH electrochemistry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.3 298.15 7.12 2133 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BRO_1399 53BRO enzymatic assay C 5.4.2.2 phosphoglucomutase C00352 = C06156 D-glucosamine 6-phosphate(aq) = D-glucosamine 1-phosphate(aq) 0.28 303.15 7.8 2134 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BRO_1399 53BRO enzymatic assay C 5.4.2.2 phosphoglucomutase C00352 = C06156 D-glucosamine 6-phosphate(aq) = D-glucosamine 1-phosphate(aq) 0.24 303.15 7.53 2135 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BRO_1399 53BRO enzymatic assay C 5.4.2.2 phosphoglucomutase C00352 = C06156 D-glucosamine 6-phosphate(aq) = D-glucosamine 1-phosphate(aq) 0.28 303.15 7.11 2136 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KIT/HOR_1085 56KIT/HOR microcalorimetry C 4.1.1.39 ribulose-biphosphate carboxylase C01182 + C00288 = 2 C00197 D-ribulose 1,5-biphosphate(aq) + carbon dioxide(aq) = 2 3-phospho-D-glycerate(aq) 298.15 8 2137 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KIT/HOR_1085 56KIT/HOR microcalorimetry C 4.1.1.39 ribulose-biphosphate carboxylase C01182 + C00288 = 2 C00197 D-ribulose 1,5-biphosphate(aq) + carbon dioxide(aq) = 2 3-phospho-D-glycerate(aq) 298.15 8 2138 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54ROS/GRU_573 54ROS/GRU spectrophotometry B 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.0087 302.15 7.3 2139 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94REK/SCH_1601 94REK/SCH calorimetry A 3.2.1.26 -fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 4.94 2140 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/OES_563 49MEY/OES spectrophotometry, chemical analysis, and radioactivity C 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000556 303.15 2141 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 7.9 303.15 6.8 2142 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.9 303.15 8.5 2143 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.4 303.15 8.5 2144 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.4 303.15 8.5 2145 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.6 303.15 8.5 2146 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.7 303.15 8.5 2147 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6 303.15 6.8 2148 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.2 303.15 6.8 2149 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.1 303.15 6.8 2150 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 7.4 303.15 6.8 2151 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.5 303.15 8.5 2152 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.2 303.15 8.5 2153 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 8 303.15 6.8 2154 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.3 303.15 8.5 2155 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.9 303.15 6.8 2156 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 5.7 303.15 6.8 2157 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 4.7 303.15 6.8 2158 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68HAV/HAN_1219 68HAV/HAN chromatography B 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 6.2 303.15 8.5 2159 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65UYE/RAB_354 65UYE/RAB spectrophotometry B 2.1.2.4 glycine formiminotransferase C00664 + C00037 = C02718 + C00101 5-formiminotetrahydrofolate(aq) + glycine(aq) = N-formiminoglycine(aq) + tetrahydrofolate(aq) 3.1 298.15 7 2160 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73ROT/KIS_346 73ROT/KIS calorimetry A 2.1.1.45 thymidylate synthase C00143 + C00365 = C00415 + C00364 5,10-methylenetetrahydrofolate(aq) + dUMP(aq) = dihydrofolate(aq) + dTMP(aq) 298.15 7.4 2161 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAK/YOS_883 65TAK/YOS calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 4.5 2162 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73BEE/STE_998 73BEE/STE calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.95 2163 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03WAT/YAM_1700 03WAT/YAM chromatography A 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1.1 310.15 9 2164 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAH/LOW_1354 60KAH/LOW enzymatic assay; fluorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.298 303.15 8 2165 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAH/LOW_1354 60KAH/LOW enzymatic assay; fluorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.26 293.15 8 2166 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KAH/LOW_1354 60KAH/LOW enzymatic assay; fluorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.327 311.15 8 2167 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.89 311.15 7.07 2168 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.92 311.15 7.07 5.05 2169 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 11 311.15 7.07 4.03 2170 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 16.1 311.15 7.07 3.15 2171 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 28.8 311.15 7.07 2.64 2172 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 47 311.15 7.07 2.16 2173 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.51 311.15 6.64 2174 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 10.3 311.15 6.64 4.33 2175 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 29.5 311.15 6.64 2.64 2176 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 46 311.15 6.64 2.16 2177 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 13.9 311.15 7.07 3.33 2178 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 52.3 311.15 7.07 2 2179 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 14.8 311.15 7.45 3.15 2180 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 15.8 311.15 6.64 3.15 2181 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 27.6 311.15 7.45 2.64 2182 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 46 311.15 7.07 2.07 2183 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.48 311.15 7.45 2184 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 17.1 311.15 7.07 3.15 2185 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 10.6 311.15 7.07 4.33 2186 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 18 311.15 7.07 3.03 2187 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 10 311.15 7.07 4.33 2188 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 10 311.15 7.07 4.33 2189 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 47.5 311.15 7.07 2.16 2190 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 57.9 311.15 7.07 1.91 2191 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 12.2 311.15 7.07 3.64 2192 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.83 311.15 7.07 2193 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.95 311.15 7.45 4.33 2194 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 46.6 311.15 7.45 2.16 2195 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 43.6 311.15 7.07 2.35 2196 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73VEL/GUY_1167 73VEL/GUY enzymatic assay and fluorimetry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 37.2 311.15 7.07 2.44 2197 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80BEY/ROE_894 80BEY/ROE HPLC C 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 197 328 2198 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 0.081 295.15 6.23 2199 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 0.18 295.15 6.86 2200 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 0.65 295.15 7.74 2201 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 1 295.15 7.9 2202 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 3.6 295.15 8.59 2203 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 0.36 295.15 7.53 2204 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 4.8 295.15 9.08 2205 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 2.6 295.15 8.42 2206 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 0.28 295.15 7.19 2207 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_326 59SAN/LAN spectrophotometry B 1.8.1.4 dihydrolipoamide dehydrogenase C00579 + C00003 = C00248 + C00004 dihydrolipoamide(aq) + NAD(aq) = lipoamide(aq) + NADH(aq) 1.5 295.15 8.23 2208 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SAN/LAN_324 59SAN/LAN spectrophotometry C 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.13 295.15 7.1 2209 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BRU/NOL_1334 58BRU/NOL spectrophotometry C 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.28 310.15 7.5 2210 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BRU/NOL_1334 58BRU/NOL spectrophotometry C 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.31 273.15 7.5 2211 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MCG/JOR_547 75MCG/JOR calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 8 2212 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MCG/JOR_547 75MCG/JOR calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 8 2213 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MCG/JOR_547 75MCG/JOR calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 8 2214 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MCG/JOR_547 75MCG/JOR calorimetry A 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 8 2215 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.293 298.15 8.7 3 2216 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.299 298.15 8.7 3 2217 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.302 298.15 8.7 3 2218 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.31 304.95 8.7 4 2219 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.329 310.15 8.7 4 2220 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.357 316.15 8.7 4 2221 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.308 298.15 8.7 2.6 2222 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1360 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.287 298.15 8.7 4 2223 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.7 3 2224 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 316.15 8.7 4 2225 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 310.15 8.7 4 2226 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.7 3 2227 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 304.95 8.7 4 2228 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.7 3 2229 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.7 2.6 2230 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE_1361 88TEW/STE calorimetry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 298.15 8.7 4 2231 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KIS/HOL_1199 99KIS/HOL calorimetry A 4.2.1.51 prephenate dehydratase C00254 = C00166 + C00001 + C00288 prephenate(aq) = phenylpyruvate(aq) + H2o(l) + carbon dioxide(aq) 298.15 7.17 2232 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BEN_1149 69BEN calorimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.45 298.15 2233 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80SVE/MAR_1010 80SVE/MAR spectrophotometry B 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.004 298.15 5 2234 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80SVE/MAR_1010 80SVE/MAR spectrophotometry B 3.5.1.11 penicillin amidase C05551 + C00001 = C02954 + C07086 penicillin G(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + phenylacetic acid(aq) 0.02 298.15 6 2235 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79VIC/GRE_482 79VIC/GRE spectrophotometry C 2.4.2.10 orotate phosphoribosyltransferase C01103 + C00013 = C00295 + C00119 orotidine 5'-phosphate(aq) + pyrophosphate(aq) = orotate(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 2 298.15 8 2236 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83PIL/HAN_1596 83PIL/HAN radioactivity C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.38 310.15 2237 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57VLA/VLA_545 57VLA/VLA radioactivity C 2.7.1.1 hexokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 340 310.15 7.25 2238 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_935 91TEW/GOL calorimetry A 3.2.1.23 _-galactosidase C07064 + C00001 = C00124 + C00095 lactulose(aq) + H2O(l) = D-galactose(aq) + D-fructose(aq) 298.15 5.65 2239 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_934 91TEW/GOL HPLC A 3.2.1.23 _-galactosidase C07064 + C00001 = C00124 + C00095 lactulose(aq) + H2O(l) = D-galactose(aq) + D-fructose(aq) 128 298.15 5.65 2240 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 294 311.15 0.25 7 3 2241 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 336 311.15 0.25 7 3 2242 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 319 311.15 0.25 7 3 2243 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 310 311.15 0.25 7 2.32 2244 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 294 311.15 0.25 7 2.04 2245 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 338 311.15 0.25 6.95 3 2246 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 301 311.15 0.25 6.92 2.4 2247 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 260 311.15 0.25 6.89 2.15 2248 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 297 311.15 0.25 6.93 2.4 2249 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 307 311.15 0.25 6.73 3 2250 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 269 311.15 0.25 7 2.32 2251 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 298 311.15 0.25 6.91 2252 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 247 311.15 0.25 6.87 2 2253 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 290 311.15 0.25 6.92 2254 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 303 311.15 0.25 7 2.04 2255 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 255 311.15 0.25 6.9 2.15 2256 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 332 311.15 0.25 7 4 2257 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 270 311.15 0.25 6.88 2 2258 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 384 311.15 0.25 6.96 3 2259 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 341 311.15 0.25 6.86 2260 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 288 311.15 0.25 6.95 2261 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 288 311.15 0.25 6.95 2262 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_803 82GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 306 311.15 0.25 6.72 3 2263 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72MAR/BEL_450 72MAR/BEL enzymatic assay and spectrophotometry C 2.4.1.64 ,-trehalose phosphorylase C01083 + C00009 = C00031 + C00103 ,-trehalose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.059 310.15 6.3 2264 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72MAR/BEL_450 72MAR/BEL enzymatic assay and spectrophotometry C 2.4.1.64 ,-trehalose phosphorylase C01083 + C00009 = C00031 + C00103 ,-trehalose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.24 310.15 7 2265 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91AND/KAT_1232 91AND/KAT HPLC B 4.- 4-aminobenzoate synthase C00251 + C00014 = C11355 + C00001 chorismate(aq) + ammonia(aq) = 4-amino-4-deoxychorismate(aq) + H2O(l) 6.1 310.15 8.6 2266 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99BRA/FIS_1516 99BRA/FIS spectrophotometry and NMR B 3.5.4.16 GTP cyclohydrolase I C00044 + C00001 = C05922 GTP(aq) + H2O(l) = ((2R,3S,4R,5R)-5-(2-amino-5-formamido-6-oxo-3,6-dihydropyrimidin-4-ylamino)-3,4-dihydroxytetrahydrofuran-2-yl)methyl tetrahydrogen triphosphate(aq) 0.1 303.15 7 2267 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63SLY/STA_397 63SLY/STA spectrophotometric B 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0142 303.15 6.85 2268 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69FAN/FEI_1254 69FAN/FEI radioactivity and spectrophotometry B 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.32 303.15 9 2269 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96LI/ZHA_668 96LI/ZHA NMR and radioactivity A 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 1.5 298.15 7.5 2.25 2270 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96LI/ZHA_668 96LI/ZHA NMR and radioactivity A 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 3.1 298.15 7.5 1.89 2271 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96LI/ZHA_668 96LI/ZHA NMR and radioactivity A 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 5.2 298.15 7.5 1.7 2272 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96LI/ZHA_668 96LI/ZHA NMR and radioactivity A 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 5.3 298.15 7.5 1.35 2273 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96LI/ZHA_668 96LI/ZHA NMR and radioactivity A 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 2.1 298.15 7.7 2.3 2274 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59NOR/FRO_188 59NOR/FRO spectrophotometry B 1.1.1.56 ribitol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.00717 301.15 8 2275 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62WIL/SNE_358 62WIL/SNE chromatography and spectrophotometry B 2.1.2.7 D-alanine 2-hydroxymethyltransferase C03059 = C00740 + C00067 2-hydroxymethylserine(aq) = D-serine(aq) + formaldehyde(aq) 0.00027 311.15 7.5 2276 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03GOL/TEW_1546 03GOL/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00074 + C00001 = C00022 + C00009 phosphoenolpyruvate(aq) + H2O(l) = pyruvate(aq) + orthophosphate(aq) 298.15 0.33 7.62 2277 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOR/ESF_316 75GOR/ESF spectrophotometry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.0373 298.15 7.82 2278 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOR/ESF_316 75GOR/ESF spectrophotometry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.0054 298.15 7 2279 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOR/ESF_316 75GOR/ESF spectrophotometry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.049 298.15 8 2280 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75GOR/ESF_316 75GOR/ESF spectrophotometry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.138 298.15 8.47 2281 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45OHL_1144 45OHL calorimetry B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 297.45 6.8 2282 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.3E-05 298.15 7.46 2283 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.5E-05 298.15 7.54 2284 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00011 298.15 7.85 2285 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.0002 298.15 8.33 2286 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.0005 298.15 8.44 2287 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00063 298.15 8.49 2288 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_127 37EUL/ADL spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 5E-05 298.15 7.71 2289 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.895 310.6 7 2290 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.12 345.2 7 2291 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.083 341.6 7 2292 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.037 333.2 7 2293 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.992 326.5 7 2294 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86OLI/TOI_1317 86OLI/TOI HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.936 318.2 7 2295 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85COO/PRA_1203 85COO/PRA spectrophotometry and HPLC C 4.2.1.- 3-hydroxybutyryl-CoA dehyratase C01144 = C00877 + C00001 DL-3-hydroxybutanoyl-CoA(aq) = trans-but-2-enoyl-CoA(aq) + H2O(l) 0.28 308.15 7.4 2296 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/EGG_149 69VEE/EGG spectrophotometry A 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.0344 311.15 0.25 7 2297 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45GRE/LEL_497 45GRE/LEL spectrophotometry C 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.3 311.15 7.3 2298 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52BAU/GEM_942 52BAU/GEM calorimetry B 3.2.1.26 _-fructofuranosidase C00089 + C00001 = C00031 + C00095 sucrose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 303.15 4.5 2299 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60MAX/ROB_1250 60MAX/ROB spectrophotometry C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.33 298.15 8.7 2300 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98URB/BRA_1684 98URB/BRA spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(ox)(aq) = oxaloacetate(aq) + NAD(red)(aq) 6.65E-05 298.15 8 2301 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80LER/COH_599 80LER/COH NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.053 303.15 8 2302 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_44 53BUR/WIL spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.000174 298.15 7.5 2303 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_44 53BUR/WIL spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.00055 298.15 8 2304 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_44 53BUR/WIL spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.00174 298.15 8.5 2305 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_44 53BUR/WIL spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.0055 298.15 9 2306 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BRO_511 68BRO spectrophotometry A 2.6.1.2 alanine aminotransferase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.68 311.15 0.25 7 2307 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65YOS_132 65YOS spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00367 298.15 8.7 2308 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65YOS_132 65YOS spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000976 298.15 8.06 2309 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55LIE/KOR2_664 55LIE/KOR2 chromatography B 2.7.4.4 nucleoside-phosphate kinase C00075 + C00105 = 2 C00015 UTP(aq) + UMP(aq) = 2 UDP(aq) 0.94 309.15 7.5 2310 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06MCC/ARA_1585 06MCC/ARA spectrophotometry and enzymatic assay B 2.7.7 ADP-glucose phosphorylase C00008 + C00103 = C00498 + C00009 ADP(aq) + D-glucose 1-phosphate(aq) = ADPglucose(aq) + orthophosphate(aq) 0.2 298.15 7 2311 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06MCC/ARA_1585 06MCC/ARA spectrophotometry and enzymatic assay B 2.7.7 ADP-glucose phosphorylase C00008 + C00103 = C00498 + C00009 ADP(aq) + D-glucose 1-phosphate(aq) = ADPglucose(aq) + orthophosphate(aq) 0.025 298.15 7 4 2312 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.64 311.15 0.25 7.15 2313 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.62 311.15 0.25 7.09 2314 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.45 311.15 0.25 6.93 2315 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.44 311.15 0.25 6.92 2316 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.17 311.15 0.25 6.52 2317 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.42 311.15 0.25 6.91 2318 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.43 311.15 0.25 6.91 3.51 2319 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.44 311.15 0.25 6.91 2.9 2320 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.205 311.15 0.04 7.1 2321 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.433 311.15 0.18 7.1 2322 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.487 311.15 0.21 7.1 2323 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.616 311.15 0.25 7.1 2324 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 1.015 311.15 0.6 7.1 2325 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.42 311.15 0.25 6.91 3.04 2326 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.58 311.15 0.25 7.05 2327 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.43 311.15 0.25 6.91 2.82 2328 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.337 311.15 0.1 7.1 2329 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.789 311.15 0.4 7.1 2330 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.43 311.15 0.25 6.92 2331 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.62 311.15 0.25 7.11 2332 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.41 311.15 0.25 6.91 3.19 2333 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.41 311.15 0.25 6.91 3.19 2334 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79COR/LEA_254 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.41 311.15 0.25 6.87 2335 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77SCH/CLE_151 77SCH/CLE spectrophotometry C 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.029 298.15 7.1 2336 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_259 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 2170 311.15 7 2.92 2337 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56ALE/GRE_348 56ALE/GRE spectrophotometry B 2.1.2.1 glycine hydroxymethyltransferase C00037 + C00067 = C00065 glycine(aq) + formaldehyde(aq) = L-serine(aq) 2760 310.15 7.2 2338 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65MAY/GIN_705 65MAY/GIN radioactivity and spectrophotometry B 2.7.7.33 glucose-1-phosphate cytidylyltransferase C00063 + C00103 = C00501 + C00013 CTP(aq) + D-glucose 1-phosphate(aq) = CDPglucose(aq) + pyrophosphate(aq) 1 310.15 8 2339 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80SVE/MAR_1017 80SVE/MAR spectrophotometry B 3.5.1.11 penicillin amidase C05598 + C00001 = C07086 + C00037 phenylacetylglycine(aq) + H2O(l) = phenylacetic acid(aq) + glycine(aq) 1.2 298.15 7 2340 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62DUR/RAW_340 62DUR/RAW calorimetry A 2.1.1.3 thetin-homocysteine S-methyltransferase C03392 + C00155 = C03173 + C00073 dimethylacetothetin(aq) + L-homocysteine(aq) = S-methylthioglycolate(aq) + L-methionine(aq) 298.15 7.1 2341 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MUR/TSU_461 75MUR/TSU spectrophotometry B 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.048 310.15 7.5 2342 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43KRE/EGG_1162 43KRE/EGG polarimetry and manometry B 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 14.4 298.15 6.8 2343 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90LIU_1424 90LIU NMR and spectrophotometry A 5.4.99.6 isochorismate synthase C00251 = C00885 chorismate(aq) = isochorismate(aq) 0.66 298.15 7.5 2344 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_1076 81HIN/POL calorimetry A 3.6.1.32 myosin ATPase C00044 + C00001 = C00035 + C00009 GTP(aq) + H2O(l) = GDP(aq) + orthophosphate(aq) 298.15 8 2345 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_1076 81HIN/POL calorimetry A 3.6.1.32 myosin ATPase C00044 + C00001 = C00035 + C00009 GTP(aq) + H2O(l) = GDP(aq) + orthophosphate(aq) 298.15 9 2346 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81KIS/NIE_1572 81KIS/NIE spectrophotometry B 1.1.1.17 mannitol-1-phosphate 5-dehydrogenase C00644 + C00003 = C00085 + C00004 D-mannitol-1-phosphate(aq) + NAD(ox)(aq) = D-fructose 6-phosphate(aq) + NAD(red)(aq) 0.79 298.15 9 2347 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91LIU/FRO_832 91LIU/FRO NMR C 3.1.3.11 fructose-biphosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 47 288.15 7.5 2348 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=41WAR/CHR_1171 41WAR/CHR spectrophotometry C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 1.43 293.15 7.34 2349 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87MIL/EST_1588 87MIL/EST spectrophotometry C 1.1.1.274 2,5-diketo-D-gluconate reductase C15673 + C00006 = C02780 + C00005 2-keto-L-gulonate(aq) + NADP(ox)(aq) = 2,5-diketo-D-gluconate(aq) + NADP(red)(aq) 0.00089 298.15 9.2 2350 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87MIL/EST_1588 87MIL/EST spectrophotometry C 1.1.1.274 2,5-diketo-D-gluconate reductase C15673 + C00006 = C02780 + C00005 2-keto-L-gulonate(aq) + NADP(ox)(aq) = 2,5-diketo-D-gluconate(aq) + NADP(red)(aq) 0.0022 298.15 9.6 2351 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ASP/JAK_215 64ASP/JAK spectrophotometry C 1.1.1.129 L-threonate dehydrogenase C01620 + C00003 = C03064 + C00004 L-threonate(aq) + NAD(aq) = 3-oxo-L-threonate(aq) + NADH(aq) 0.00553 298.15 6.9 2352 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ASP/JAK_215 64ASP/JAK spectrophotometry C 1.1.1.129 L-threonate dehydrogenase C01620 + C00003 = C03064 + C00004 L-threonate(aq) + NAD(aq) = 3-oxo-L-threonate(aq) + NADH(aq) 0.000342 298.15 7 2353 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ASP/JAK_215 64ASP/JAK spectrophotometry C 1.1.1.129 L-threonate dehydrogenase C01620 + C00003 = C03064 + C00004 L-threonate(aq) + NAD(aq) = 3-oxo-L-threonate(aq) + NADH(aq) 0.00125 298.15 7.75 2354 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76RUS/MUL_237 76RUS/MUL spectrophotometry D 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 420 298.15 6.2 2355 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 6.01 2356 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 6.98 2357 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 7.01 2358 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 7.51 2359 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 310.15 6.53 2360 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 7 2361 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1045 94KIS/TEW calorimetry A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 304.65 6.53 2362 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94KIS/TEW_1044 94KIS/TEW HPLC A 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 2.9 298.15 6.01 2363 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GAR/CLE_662 69GAR/CLE radioactivity and chromatography B 2.7.4.4 nucleoside-phosphate kinase C00002 + C00015 = C00008 + C00075 ATP(aq) + UDP(aq) = ADP(aq) + UTP(aq) 1.28 303.15 8 2364 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_6 80COO/BLA spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00854 + C00003 = C00414 + C00004 cyclohexanol(aq) + NAD(aq) = cyclohexanone(aq) + NADH(aq) 0.2 298.15 8 2365 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_2 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.0031 298.15 8 2366 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_2 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.0098 298.15 8.5 2367 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_2 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.098 298.15 9.5 2368 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_2 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.00098 298.15 7.5 2369 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_2 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.031 298.15 9 2370 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81SUG/VEI_53 81SUG/VEI spectrophotometry C 1.1.1.9 D-xylulose reductase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.06 298.15 9.5 2371 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65ONO/HIR_892 65ONO/HIR calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 298.15 4.5 2372 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65ONO/HIR_892 65ONO/HIR calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 308.15 4.5 2373 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SIL/VOE_417 67SIL/VOE spectrophotometry C 2.4.1.7 sucrose phosphorylase C00089 + C00009 = C00103 + C00095 sucrose(aq) + orthophosphate(aq) =-D-glucose 1-phosphate(aq) + D-fructose(aq) 16 303.15 7 2374 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65BES/HER_671 65BES/HER radioactivity and spectrophotometry C 2.7.4.13 (deoxy)nucleoside-phosphate kinase C00002 + C00364 = C00008 + C00363 ATP(aq) + dTMP(aq) = ADP(aq) + dTDP(aq) 1.4 310.15 7.4 2375 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.19 2376 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.38 2377 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 8.83 2378 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.86 2379 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.09 2380 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 304.55 7.97 2381 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.47 2382 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 310.15 7.84 2383 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 8.17 2384 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_1053 93LAR/TEW calorimetry A 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 298.15 7.49 2385 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58WOL/SIM_1265 58WOL/SIM enzymatic assay B 5.1.3.4 L-ribulose-phosphate 4-epimerase C01101 = C00231 L-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 1.86 297.15 8.4 2386 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JUN/JUN_1555 89JUN/JUN radioactivity A 4.2.1.89 carnitine dehydratase C00318 = C04114 + C00001 L-carnitine(aq) = 4-(trimethylammonio)but-2-enoate(aq) + H2O(l) 1.5 310.15 7.8 2387 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK_135 68KOH/JAK spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000209 298.15 8.2 2388 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK_135 68KOH/JAK spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00487 298.15 9.6 2389 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK_135 68KOH/JAK spectrophotometry C 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00204 298.15 9.2 2390 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63MEI/BUK_1196 63MEI/BUK chromatography and radioactivity B 4.2.1.48 D-glutamate cyclase C00217 = C02237 + C00001 D-glutamate(aq) = 5-oxo-D-proline(aq) + H2O(l) 16 310.15 8.3 2391 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63ALL/KEL_1278 63ALL/KEL spectrophotometry B 5.1.99.1 methylmalonyl-CoA epimerase C01213 = C00683 (R)-methylmalonyl-CoA(aq) = (S)-methylmalonyl-CoA(aq) 1 303.15 7.4 2392 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KAU/ALI_1438 55KAU/ALI spectrophotometry B 6.2.1.5 succinate-CoA ligase (ADP forming) C00002 + C00042 + C00010 = C00008 + C00009 + C00091 ATP(aq) + succinate(aq) + CoA(aq) = ADP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.27 293.15 7.4 2393 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WOL_800 72WOL calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 6.1 2394 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WOL_800 72WOL calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 7.78 2395 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WOL_800 72WOL calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 8.33 2396 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WOL_800 72WOL calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 8.73 2397 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72WOL_800 72WOL calorimetry C 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 7.1 2398 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94LEU/COO_409 94LEU/COO spectrophotometry A 2.3.1.30 serine acetyltransferase C00024 + C00065 = C00010 + C00979 acetyl-CoA(aq) + L-serine(aq) = CoA(aq) + O-acetyl-L-serine(aq) 15 298.15 6 2399 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81GRI/CLE_272 81GRI/CLE spectrophotometry C 1.4.1.1 alanine dehydrogenase C00041 + C00003 + C00001 = C00022 + C00004 + C00014 L-alanine(aq) + NAD(aq) + H2O(l) = pyruvate(aq) + NADH(aq) + ammonia(aq) 4.3E-06 298.15 7.9 2400 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SEM/CLE_1364 91SEM/CLE NMR and spectrophotometry B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.214 278.85 8.7 2401 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SEM/CLE_1364 91SEM/CLE NMR and spectrophotometry B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.264 295.15 8.7 2402 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MCQ/UTT_565 59MCQ/UTT enzymatic assay and spectrophotometry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000155 303.15 7.4 2403 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MCQ/UTT_565 59MCQ/UTT enzymatic assay and spectrophotometry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000451 303.15 8 2404 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MCQ/UTT_565 59MCQ/UTT enzymatic assay and spectrophotometry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.0011 303.15 8.4 2405 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MCQ/UTT_565 59MCQ/UTT enzymatic assay and spectrophotometry A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00272 303.15 9 2406 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76RAO/BUT_618 76RAO/BUT NMR B 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.1 285.15 7.25 2407 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55MUN_683 55MUN spectrophotometry C 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 1.5 310.15 7.4 2408 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BOM/PRA_643 68BOM/PRA chromatography and radioactivity D 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.5 298.15 2409 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59SCO/JAK_526 59SCO/JAK spectrophotometry C 2.6.1.19 4-aminobutyrate transaminase C00334 + C00026 = C00232 + C00025 4-aminobutanoate(aq) + 2-oxoglutarate(aq) = 4-oxobutanoate(aq) + L-glutamate(aq) 0.14 311.15 8.1 2410 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75KRI_1285 75KRI spectrophotometry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 19 298.15 7.5 2411 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59BEN/KIT_990 59BEN/KIT calorimetry B 3.5.1.2 glutaminase C00064 + C00001 = C00025 + C00014 L-glutamine(aq) + H2O(l) = L-glutamate(aq) + ammonia(aq) 896 298.15 5.5 2412 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63BEC/LEV_472 63BEC/LEV enzymatic assay B 2.4.2.6 nucleoside deoxyribosyltransferase C00214 + C00147 = C00559 + C00178 thymidine(aq) + adenine(aq) = 2'-deoxyadenosine(aq) + thymine(aq) 15.1 310.15 5.8 2413 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_224 87BUC/MIL spectrophotometry A 1.1.1.- (R)-2-hydroxyglutarate dehydrogenase C01087 + C00003 = C00026 + C00004 (R)-2-hydroxyglutarate(aq) + NAD(aq) = 2-oxoglutarate(aq) + NADH(aq) 1.83E-05 298.15 7 2414 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_224 87BUC/MIL spectrophotometry A 1.1.1.- (R)-2-hydroxyglutarate dehydrogenase C01087 + C00003 = C00026 + C00004 (R)-2-hydroxyglutarate(aq) + NAD(aq) = 2-oxoglutarate(aq) + NADH(aq) 1.47E-05 298.15 7 2415 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ATK/BUR_640 61ATK/BUR electrophoresis and enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.48 298.15 7 2 2416 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ATK/BUR_640 61ATK/BUR electrophoresis and enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.28 298.15 7 1.6 2417 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00ROD/BAR_1603 00ROD/BAR spectophotometry and chromatography C 3.1.4 ADPglucose phosphodiesterase C00498 + C00001 = C00103 + C00020 ADPglucose(aq) + H2O(l) =-D-glucose 1-phosphate(aq) + AMP(aq) 110 298.15 7 2418 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_268 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C80057 = C00295 + C80058 (S)-dihydroorotate(aq) + AP-NAD(aq) = orotate(aq) + AP-NADH(aq) 0.035 293.15 6.1 2419 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_268 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C80057 = C00295 + C80058 (S)-dihydroorotate(aq) + AP-NAD(aq) = orotate(aq) + AP-NADH(aq) 0.093 293.15 6.4 2420 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_268 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C80057 = C00295 + C80058 (S)-dihydroorotate(aq) + AP-NAD(aq) = orotate(aq) + AP-NADH(aq) 0.189 293.15 6.7 2421 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_266 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C00003 = C00295 + C00004 (S)-dihydroorotate(aq) + NAD(aq) = orotate(aq) + NADH(aq) 0.00106 293.15 6.4 2422 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_266 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C00003 = C00295 + C00004 (S)-dihydroorotate(aq) + NAD(aq) = orotate(aq) + NADH(aq) 0.00224 293.15 6.7 2423 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_266 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C00003 = C00295 + C00004 (S)-dihydroorotate(aq) + NAD(aq) = orotate(aq) + NADH(aq) 0.00619 293.15 7.2 2424 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KRA/VEN_266 61KRA/VEN spectrophotometry B 1.3.99.11 dihydroorotate dehydrogenase C00337 + C00003 = C00295 + C00004 (S)-dihydroorotate(aq) + NAD(aq) = orotate(aq) + NADH(aq) 0.00042 293.15 6.1 2425 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59FRI_283 59FRI spectrophotometry D 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 4.5E-06 298.15 8 2426 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_1135 87BUC/MIL enzymatic assay and spectrophotometry A 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 0.212 298.15 0.648 7.4 2427 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_1135 87BUC/MIL enzymatic assay and spectrophotometry A 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 0.188 298.15 0.399 7.4 2428 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_1135 87BUC/MIL enzymatic assay and spectrophotometry A 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 0.207 298.15 0.306 7.4 2429 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_1135 87BUC/MIL enzymatic assay and spectrophotometry A 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 0.211 298.15 0.212 7.4 2430 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BUC/MIL_1135 87BUC/MIL enzymatic assay and spectrophotometry A 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 0.151 298.15 0.845 7.4 2431 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95KAM/JUR_657 95KAM/JUR enzymatic analysis C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.36 285.15 7.3 2432 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80BEY/ROE_886 80BEY/ROE HPLC C 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 34 328 2433 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BEN_1150 69BEN calorimetry C 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 2434 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_995 95HUT/BOH calorimetry B 3.5.1.5 urease C01563 + C00001 = 2 C00014 + C00288 ammonium carbamate(aq) + H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.86 2435 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_995 95HUT/BOH calorimetry B 3.5.1.5 urease C01563 + C00001 = 2 C00014 + C00288 ammonium carbamate(aq) + H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7 2436 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_995 95HUT/BOH calorimetry B 3.5.1.5 urease C01563 + C00001 = 2 C00014 + C00288 ammonium carbamate(aq) + H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 8 2437 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_995 95HUT/BOH calorimetry B 3.5.1.5 urease C01563 + C00001 = 2 C00014 + C00288 ammonium carbamate(aq) + H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.3 2438 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62DOU/SHU_1105 62DOU/SHU C 4.1.2.14 2-dehydro-3-deoxyphosphogluconate aldolase C04442 = C00022 + C00118 6-phospho-2-dehydro-3-deoxy-D-gluconate(aq) = pyruvate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.0016 298.15 6.8 2439 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69PET/MCK_337 69PET/MCK calorimetry B 1.14.15.1 camphor 5-monooxygenase C00808 + C00004 + C00007 = C03448 + C00003 + C00001 (+)-camphor(aq) + NADH(aq) + O2(aq) = (+)-5-exo-hydroxycamphor(aq) + NAD(aq) + H2O(l) 298.15 7.4 2440 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1378 85TEW/GOL2 calorimetry A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 331.65 7.1 2441 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1378 85TEW/GOL2 calorimetry A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 325.35 7.1 2442 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1378 85TEW/GOL2 calorimetry A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 320.15 7.1 2443 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1378 85TEW/GOL2 calorimetry A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 338.15 7.1 2444 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68LON/DAL_153 68LON/DAL spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.93 298.15 0.017 7.2 2445 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68LON/DAL_153 68LON/DAL spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.9 298.15 0.054 6.6 2446 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68LON/DAL_153 68LON/DAL spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.62 298.15 0.404 6.9 2447 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68LON/DAL_153 68LON/DAL spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.86 298.15 0.104 7.05 2448 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68LON/DAL_153 68LON/DAL spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.72 298.15 0.254 6.9 2449 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.446 320.25 7.4 2450 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.484 325.25 7.4 2451 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.521 331.95 7.4 2452 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.591 343.75 7.4 2453 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.391 313.15 7.4 2454 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.563 338.15 7.4 2455 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1377 85TEW/GOL2 HPLC A 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.489 328.15 7.4 2456 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=90OCO/BUT_752 90OCO/BUT spectrophotometry C 3.1.1.21 retinyl-palmitate esterase C02588 + C00001 = C00473 + C00249 retinyl palmitate(aq) + H2O(l) = retinol(aq) + palmitate(aq) 0.0028 310.15 7.5 2457 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BEL/MAR_1409 74BEL/MAR spectrophotometry B 5.4.2.6 _-phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 28.6 310.15 7 2458 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0305 310.15 7.04 6.05 2459 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0322 310.15 7.04 6.29 2460 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0288 310.15 7.01 6.19 2461 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0322 310.15 6.99 5.72 2462 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0305 310.15 7.01 5.82 2463 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0311 310.15 7.02 5.72 2464 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00787 310.15 7.07 3.09 2465 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00781 310.15 7.1 3.06 2466 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00769 310.15 7.08 3.08 2467 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00847 310.15 7.11 3.07 2468 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00781 310.15 7.12 3.06 2469 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00649 310.15 7.16 2.46 2470 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00617 310.15 7.16 2.48 2471 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00758 310.15 7.34 1.93 2472 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0182 310.15 7 4.14 2473 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00676 310.15 7.33 1.92 2474 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0347 310.15 7.14 4.33 2475 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00714 310.15 7.37 1.92 2476 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0362 310.15 7.07 2.25 2477 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0346 310.15 7.12 5.47 2478 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00813 310.15 7.12 3.08 2479 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00813 310.15 7.12 3.08 2480 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0061 310.15 7.38 1.93 2481 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.018 310.15 7.01 4.15 2482 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00602 310.15 7.09 2.47 2483 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0061 310.15 7.12 2.47 2484 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00578 310.15 7.11 2.47 2485 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0297 310.15 6.99 5.74 2486 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0351 310.15 7.11 5.46 2487 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00649 310.15 7.19 2.47 2488 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0254 310.15 7 5.26 2489 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00649 310.15 7.33 1.92 2490 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0358 310.15 7.11 5.46 2491 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00667 310.15 7.14 2.45 2492 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.026 310.15 7 5.25 2493 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0338 310.15 7.15 4.34 2494 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00769 310.15 7.1 3.06 2495 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0172 310.15 7.01 4.14 2496 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00606 310.15 7.11 2.45 2497 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0339 310.15 7.14 4.32 2498 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0217 310.15 7.01 5.27 2499 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00752 310.15 7.39 1.93 2500 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00752 310.15 7.39 1.93 2501 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00641 310.15 7.32 1.92 2502 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00806 310.15 7.09 3.05 2503 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=79LAW/VEE_598 79LAW/VEE enzymatic assay; spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0069 310.15 7.35 1.92 2504 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 8333 298.15 6.53 2505 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 1175 298.15 7.5 2506 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 255 298.15 8.52 2507 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 302 298.15 9.71 2508 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 908 298.15 10.18 2509 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 267 298.15 9.16 2510 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 242 298.15 9.16 2511 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 2231 298.15 6.5 2512 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 1321 298.15 9.32 2513 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 352 298.15 9.13 2514 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 212 298.15 8.88 2515 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 191 298.15 9.23 2516 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 345 298.15 9.16 2517 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 587 298.15 8.12 2518 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WOL_1052 67WOL radioactivity B 3.5.4.4 adenosine deaminase C00212 + C00001 = C00294 + C00014 adenosine(aq) + H2O(l) = inosine(aq) + ammonia(aq) 318 298.15 9.16 2519 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62WIL/SNE_360 62WIL/SNE chromatography and spectrophotometry B 2.1.2.7 D-alanine 2-hydroxymethyltransferase C02115 = C00133 + C00067 2-methylserine(aq) = D-alanine(aq) + formaldehyde(aq) 0.00027 311.15 7.5 2520 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_666 78LYN/GUY fluorimetry and spectrophotometry A 2.7.4.6 nucleoside-diphosphate kinase C00002 + C00035 = C00008 + C00044 ATP(aq) + GDP(aq) = ADP(aq) + GTP(aq) 1.04 311.15 0.25 7 2521 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84WAS/DAU_1699 84WAS/DAU spectrophotometry C 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1.01 310.15 9.2 2522 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63KUR/FUK_1131 63KUR/FUK spectrophotometry C 4.1.3.16 4-hydroxy-2-oxoglutarate aldolase C01127 = C00022 + C00048 4-hydroxy-2-oxoglutarate(aq) = pyruvate(aq) + glyoxylate(aq) 0.0037 310.15 7.5 2523 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50HES_744 50HES spectrophotometry B 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 510 296.15 5.1 2524 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50HES_744 50HES spectrophotometry B 3.1.1.7 acetylcholinesterase C01996 + C00001 = C00033 + C00114 acetylcholine(aq) + H2O(l) = acetate(aq) + choline(aq) 2175 296.15 5.9 2525 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36LEH_589 36LEH chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.13 293.15 7.7 2526 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36LEH_589 36LEH chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.48 293.15 8.8 2527 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40HER/GOR_1090 40HER/GOR C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.000119 311.15 7.2 2528 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40HER/GOR_1090 40HER/GOR C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 6E-05 301.15 7.2 2529 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40HER/GOR_1090 40HER/GOR C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.000234 321.15 7.2 2530 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=40HER/GOR_1090 40HER/GOR C 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.000122 311.15 7.33 2531 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TRI/VOG_1227 67TRI/VOG polarimetry B 4.3.2.3 ureidoglycolate lyase C00603 = C00048 + C00086 (-)-ureidoglycolate(aq) = glyoxylate(aq) + urea(aq) 0.14 303.15 7.5 2532 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_932 89GOL/TEW calorimetry A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 304.65 5.65 2533 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_932 89GOL/TEW calorimetry A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 310.15 5.65 2534 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_932 89GOL/TEW calorimetry A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 316.15 5.65 2535 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_932 89GOL/TEW calorimetry A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 298.15 5.65 2536 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_931 89GOL/TEW HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 34 298.15 5.65 2537 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_931 89GOL/TEW HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 34.8 310.15 5.65 2538 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_931 89GOL/TEW HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 32.2 292.15 5.65 2539 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_931 89GOL/TEW HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 32.4 304.15 5.65 2540 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_931 89GOL/TEW HPLC A 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 35.2 286.15 5.65 2541 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LEV/MEI_1439 54LEV/MEI chemical analysis and enzymatic assay A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 1800 295.15 7 2542 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LEV/MEI_1439 54LEV/MEI chemical analysis and enzymatic assay A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 400 310.15 6 2543 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LEV/MEI_1439 54LEV/MEI chemical analysis and enzymatic assay A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 1233 310.15 7 2544 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54LEV/MEI_1439 54LEV/MEI chemical analysis and enzymatic assay A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 3000 310.15 7.9 2545 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89REK/SIK_1026 89REK/SIK calorimetry B 3.5.1.14 aminoacylase C02712 + C00001 = C00033 + C00073 N-acetyl-L-methionine(aq) + H2O(l) = acetate(aq) + L-methionine(aq) 298.15 6.86 2546 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55LYN/WIE_124 55LYN/WIE spectrophotometry C 1.1.1.35 3-hydroxyacyl-CoA dehydrogenase C01144 + C00003 = C00332 + C00004 (S)-3-hydroxybutanoyl-CoA(aq) + NAD(aq) = 3-oxobutanoyl-CoA(aq) + NADH(aq) 0.012 298.15 7.8 2547 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 303 308.15 6 2 2548 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 520 308.15 6 1.6 2549 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 949 308.15 6 1.3 2550 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 79 308.15 7 4 2551 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 687 308.15 7 1.6 2552 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 126 293.15 7.8 2 2553 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 235 308.15 7.8 2 2554 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 320 293.15 7.8 1.6 2555 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 466 303.15 7.8 1.6 2556 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 572 308.15 7.8 1.6 2557 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 865 313.15 7.8 1.6 2558 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 125 308.15 7 3 2559 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2660 308.15 6 1 2560 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 156 299.15 7.8 2 2561 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2060 308.15 7 1.3 2562 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 231 308.15 7 1.2 2563 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 187 303.15 7.8 2 2564 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 294 313.15 7.8 2 2565 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 12400 308.15 7 1 2566 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82DEM_1064 82DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 372 299.15 7.8 1.6 2567 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55GLA/BRO_162 55GLA/BRO spectrophotometry B 1.1.1.49 glucose-6-phosphate dehydrogenase C00092 + C00006 = C01236 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) = D-glucono-1,5-lactone 6-phosphate(aq) + NADPH(aq) 1.5 301.15 6.4 2568 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70KOH/WAR_91 70KOH/WAR spectrophotometry C 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 9.3E-07 298.15 8.5 2569 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70KOH/WAR_91 70KOH/WAR spectrophotometry C 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 1.8E-06 298.15 8.83 2570 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70KOH/WAR_91 70KOH/WAR spectrophotometry C 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 7.3E-07 298.15 8.5 2571 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/STA_240 53BUR/STA spectrophotometry B 1.2.1.10 acetaldehyde dehydrogenase (acetylating) C00084 + C00010 + C00003 = C00024 + C00004 acetaldehyde(aq) + CoA(aq) + NAD(aq) = acetyl-CoA(aq) + NADH(aq) 2000 298.15 7.3 2572 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/STA_240 53BUR/STA spectrophotometry B 1.2.1.10 acetaldehyde dehydrogenase (acetylating) C00084 + C00010 + C00003 = C00024 + C00004 acetaldehyde(aq) + CoA(aq) + NAD(aq) = acetyl-CoA(aq) + NADH(aq) 7200 298.15 7.89 2573 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/STA_240 53BUR/STA spectrophotometry B 1.2.1.10 acetaldehyde dehydrogenase (acetylating) C00084 + C00010 + C00003 = C00024 + C00004 acetaldehyde(aq) + CoA(aq) + NAD(aq) = acetyl-CoA(aq) + NADH(aq) 8200 298.15 7.8 2574 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59BON/PON_370 59BON/PON enzymatic assay C 2.2.1.2 transaldolase C00095 + C00118 = C00085 + C00577 D-fructose(aq) + D-glyceraldehyde-3-phosphate(aq) = D-fructose 6-phosphate(aq) + D-glyceraldehyde(aq) 0.27 303.15 7.6 2575 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW2_541 98KIS/TEW2 HPLC A 2.6.2.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.133 283.15 7 2576 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW2_541 98KIS/TEW2 HPLC A 2.6.2.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.133 292.65 7.07 2577 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW2_541 98KIS/TEW2 HPLC A 2.6.2.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.143 298.15 7.13 2578 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW2_541 98KIS/TEW2 HPLC A 2.6.2.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.145 303.15 6.94 2579 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW2_541 98KIS/TEW2 HPLC A 2.6.2.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.144 288.15 7.12 2580 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58WIL/BAN_681 58WIL/BAN chemical analysis and radioactivity C 2.7.7.4&3.6.1.1 sulfate adenylyltransferase and inorganic pyrophosphatase C00002 + C00059 + C00001 = 2 C00009 + C00224 ATP(aq) + sulfate(aq) + H2O(l) = 2 orthophosphate(aq) + adenosine 5'-phosphosulfate(aq) 6E-07 303.15 7.5 2581 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78INF/KIN_701 78INF/KIN paper chromatography B 2.7.7.15 choline-phosphate cytidylyltransferase C00063 + C00588 = C00013 + C00307 CTP(aq) + phosphorylcholine(aq) = pyrophosphate(aq) + CDPcholine(aq) 0.2 310.15 0.15 7.5 3 2582 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BRI_159 53BRI spectrophotometry C 1.1.1.47 glucose dehydrogenase C00031 + C00003 = C00198 + C00004 -D-glucose(aq) + NAD(aq) = D-glucono-1,5-lactone(aq) + NADH(aq) 3.1 294.15 7 2583 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84WAS/DAU_1236 84WAS/DAU enzymatic assay and spectrophotometry B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1 310.15 9.2 2584 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75JEN/NYG_460 75JEN/NYG chromatography and radioactivity C 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.0175 310.15 7.1 2585 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.04E-05 298.15 0.25 7.08 2586 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.2E-05 298.15 0.25 7.06 2587 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.08E-05 298.15 0.25 7.08 2588 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.23E-05 298.15 0.25 7.11 2589 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.27E-05 298.15 0.25 7.08 2590 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.96E-05 311.15 0.25 7.14 2591 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.79E-05 311.15 0.25 7.17 2592 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.78E-05 311.15 0.25 7.13 2593 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.76E-05 311.15 0.25 7.09 2.95 2594 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.94E-05 311.15 0.25 7.11 2.95 2595 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.45E-05 311.15 0.25 7.05 2.95 2596 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.59E-05 311.15 0.25 7.08 2597 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.39E-05 311.15 0.25 7.06 2.95 2598 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 8.98E-06 311.15 0.25 7.11 2599 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.13E-05 298.15 0.25 7.06 2600 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.29E-05 311.15 0.25 7.09 2.95 2601 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.19E-05 311.15 0.25 7.07 2.95 2602 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_137 73GUY/GEL spectrophotometry A 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.41E-05 311.15 0.25 7.07 2603 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_154 68VEE spectrophotometry A 1.1.1.42 isocitrate dehydrogenase (NADP+) C00311 + C00006 + C00001 = C00026 + C00005 + C00288 isocitrate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + carbon dioxide(aq) 0.91 311.15 0.25 7 2604 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52EGG/HEM_658 52EGG/HEM paper chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.444 298.15 7.4 2605 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=51BLA_65 51BLA spectrophotometry and chemical analysis B 1.1.1.14 L-iditol dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.24 293.15 8.6 2606 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=01TIS/IHL_1683 01TIS/IHL C 4.1.2.4 deoxyribose-phosphate aldolase C00673 = C00118 + C00084 2-deoxy-D-ribose 5-phosphate(aq) = D-glyceraldehyde 3-phosphate(aq) + acetaldehyde(aq) 0.00024 298.15 7 2607 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=01TIS/IHL_1682 01TIS/IHL C 4.1.2.13 fructose-bisphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.0001 298.15 2608 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_52 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.000418 298.15 7 2609 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_52 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.00418 298.15 8 2610 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_50 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.00419 298.15 7 2611 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_50 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.0419 298.15 8 2612 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_57 59HOL spectrophotometry B 1.1.1.10 L-xylulose reductase C00379 + C00006 = C00312 + C00005 xylitol(aq) + NADP(aq) = L-xylulose(aq) + NADPH(aq) 0.00516 298.15 8.24 2613 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_57 59HOL spectrophotometry B 1.1.1.10 L-xylulose reductase C00379 + C00006 = C00312 + C00005 xylitol(aq) + NADP(aq) = L-xylulose(aq) + NADPH(aq) 0.00297 298.15 8 2614 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_57 59HOL spectrophotometry B 1.1.1.10 L-xylulose reductase C00379 + C00006 = C00312 + C00005 xylitol(aq) + NADP(aq) = L-xylulose(aq) + NADPH(aq) 0.000297 298.15 7 2615 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92REK/TIS_794 92REK/TIS calorimetry A 3.1.3.1 alkaline phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 8.5 2616 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60COM/ROS_1117 60COM/ROS spectrophotometry C 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.064 310.15 7.1 2617 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74SCH/STU_310 74SCH/STU calorimetry C 1.6.1.1 NAD(P)+ transhydrogenase C00003 + C00005 = C00004 + C00006 NAD(aq) + NADPH(aq) = NADH(aq) + NADP(aq) 298.15 7 2618 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62BRU/JOU_1122 62BRU/JOU radioactivity and spectrophotometry A 4.1.3.3 N-acetylneuraminate lyase C03410 = C03521 + C00022 N-glycolylneuraminate(aq) = N-glycolyl-D-mannosamine(aq) + pyruvate(aq) 0.09 310.15 7.2 2619 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45GRE/LEL_507 45GRE/LEL spectrophotometry C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 1 311.15 7.3 2620 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69POP_628 69POP spectrophotometry C 2.7.4.2 phosphomevalonate kinase C00002 + C01107 = C00008 + C01143 ATP(aq) + (R)-5-phosphomevalonate(aq) = ADP(aq) + (R)-5-diphosphomevalonate(aq) 1 310.15 7.3 2621 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_251 47MEY/OES spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.55 298.15 7 2622 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_251 47MEY/OES spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 1.4 298.15 7.15 2623 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_251 47MEY/OES spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 17 298.15 8.2 2624 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_251 47MEY/OES spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.69 298.15 6.95 2625 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=47MEY/OES_251 47MEY/OES spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.71 298.15 6 2626 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85FAG/DEW_1080 85FAG/DEW spectrophotometry C 3.6.1.38 Ca2+-transporting ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 40000 295.15 7 2627 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63DOB/DEM_1337 63DOB/DEM spectrophotometry C 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.3 310.15 7.6 2628 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52NAR/WOO_1237 52NAR/WOO enzymatic assay B 5.1.1.3 glutamate racemase C00025 = C00217 L-glutamate(aq) = D-glutamate(aq) 1 310.15 6.8 2629 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34LOH/MEY_1169 34LOH/MEY chemical analysis C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 0.39 293.15 2630 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34LOH/MEY_1169 34LOH/MEY chemical analysis C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 0.7 333.15 2631 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34LOH/MEY_1169 34LOH/MEY chemical analysis C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 0.33 273.15 2632 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=34LOH/MEY_1169 34LOH/MEY chemical analysis C 4.2.1.11 phosphopyruvate hydratase C00631 = C00074 + C00001 2-phospho-D-glycerate(aq) = phosphoenolpyruvate(aq) + H2O(l) 0.54 313.15 2633 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65SEK/SUN_1210 65SEK/SUN C 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.02 310.15 2634 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95BIS/KRA_1027 95BIS/KRA C 3.5.1.14 aminoacylase C02712 + C00001 = C00073 + C00033 N-acetyl-L-methionine(aq) + H2O(l) = L-methionine(aq) + acetate(aq) 2.7 310.15 7 2635 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STE/COO_405 53STE/COO spectrophotometric C 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 2E-05 298.15 8.1 2636 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK_142 68KOH/JAK spectrophotometry C 1.1.1.37 malate dehydrogenase C00552 + C00003 = C00975 + C00004 meso-tartrate(aq) + NAD(aq) = (E)-dihydroxyfumarate(aq) + NADH(aq) 0.00034 298.15 8.13 2637 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK_142 68KOH/JAK spectrophotometry C 1.1.1.37 malate dehydrogenase C00552 + C00003 = C00975 + C00004 meso-tartrate(aq) + NAD(aq) = (E)-dihydroxyfumarate(aq) + NADH(aq) 5.3E-05 298.15 7.54 2638 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54BER/JOK_665 54BER/JOK radioactive labelling and spectrophotometry C 2.7.4.6 nucleoside-diphosphate kinase C00002 + C00104 = C00008 + C00081 ATP(aq) + inosine 5'-diphosphate(aq) = ADP(aq) + inosine 5'-triphosphate(aq) 1 310.15 6 2639 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71GLO/POT_387 71GLO/POT spectrophotometry B 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 41 310.15 7.2 2640 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82SAL/GIA_477 82SAL/GIA spectrophotometry C 2.4.2.8 hypoxanthine phosphoribosyltransferase C00144 + C00262 = C00130 + C00242 GMP(aq) + hypoxanthine(aq) = IMP(aq) + guanine(aq) 0.38 310.15 7.4 2641 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62RAV/WOL2_131 62RAV/WOL2 spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000104 298.15 8 2642 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62SIL_356 62SIL C 2.1.2.5 glutamate formiminotransferase C00664 + C00025 = C00439 + C00101 5-formiminotetrahydrofolate(aq) + L-glutamate(aq) = N-formimino-L-glutamate(aq) + tetrahydrofolate(aq) 0.09 310.15 6.6 2643 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/DAV_1625 00TEW/DAV chromatography A 5.4.99.6 isochorismate synthase C00251 = C00885 chorismate(aq) = isochorismate(aq) 0.84 298.15 0.31 7.34 2644 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00TEW/DAV_1626 00TEW/DAV calorimetry and chromatography A 5.4.99.6 isochorismate synthase C00251 = C00885 chorismate(aq) = isochorismate(aq) 298.15 0.23 6.93 2645 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0028 303.15 7 2646 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.004 303.15 7.5 2647 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0048 303.15 8.1 2.28 2648 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0055 303.15 9.2 2649 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0049 303.15 7.5 2.28 2650 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0039 303.15 8.1 2651 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.003 303.15 9.2 2.28 2652 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE_720 56STE spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0046 303.15 7 2.28 2653 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83YAM/SAI_261 83YAM/SAI spectrophotometry C 1.2.1.43 formate dehydrogenase (NADP+) C00058 + C00006 + C00001 = C00288 + C00005 formate(aq) + NADP(aq) + H2O(l) = carbon dioxide(aq) + NADPH(aq) 650 328.15 7.5 2654 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SUG/PIZ_203 68SUG/PIZ spectrophotometry and fluorimetry B 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 0.0019 298.15 7.5 2655 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SUG/PIZ_203 68SUG/PIZ spectrophotometry and fluorimetry B 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 0.0022 310.15 7.5 2656 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54BOW/KER_636 54BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.38 274.15 6 2657 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54BOW/KER_636 54BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.39 293.15 6 2658 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54BOW/KER_636 54BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.31 293.15 6 3 2659 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54BOW/KER_636 54BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.48 313.15 6 2660 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58HEA/HOR_1297 58HEA/HOR polarimetry C 5.3.1.4 L-arabinose isomerase C00259 = C00508 L-arabinose(aq) = L-ribulose(aq) 0.16 310.15 7 2661 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58HEA/HOR_1297 58HEA/HOR polarimetry C 5.3.1.4 L-arabinose isomerase C00259 = C00508 L-arabinose(aq) = L-ribulose(aq) 0.19 326.15 7 2662 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58HEA/HOR_1297 58HEA/HOR polarimetry C 5.3.1.4 L-arabinose isomerase C00259 = C00508 L-arabinose(aq) = L-ribulose(aq) 0.11 298.15 7 2663 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92DEM/ATT_1319 92DEM/ATT C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.08 333.15 7.5 2664 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99SAK/UTS_1605 99SAK/UTS enzymatic assay C 2.7.9.2 pyruvate, water dikinase C00002 + C00022 + C00001 = C00020 + C00074 + C00009 ATP(aq) + pyruvate(aq) + H2O(l) = AMP(aq) + phosphoenolpyruvate(aq) + orthophosphate(aq) 52 323.15 6.5 2665 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BLA/WRI_587 55BLA/WRI chromatography C 2.7.2.4 aspartate kinase C00002 + C00049 = C00008 + C03082 ATP(aq) + L-aspartate(aq) = ADP(aq) + 4-phospho-L-aspartate(aq) 0.00035 288.15 7 2666 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89GOL/TEW_1405 89GOL/TEW HPLC A 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 17.1 298.15 8.48 2667 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61KLE_685 61KLE D 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 1 298.15 2668 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88MAC/FEW_201 88MAC/FEW spectrophotometry C 1.1.1.90 aryl-alcohol dehydrogenase C00556 + C00003 = C00261 + C00004 benzyl alcohol(aq) + NAD(aq) = benzaldehyde(aq) + NADH(aq) 0.097 300.15 9.5 2669 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.04 303.15 7.6 2.4 2670 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.14 303.15 7.6 2.4 2671 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.265 303.15 7.6 1.4 2672 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.272 303.15 7.6 1.4 2673 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.23 303.15 7.9 2.61 2674 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.704 303.15 7.5 2.27 2675 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.09 303.15 7 2.61 2676 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.752 303.15 7 2.27 2677 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.23 303.15 6.06 2.61 2678 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.662 303.15 5 2.61 2679 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.862 303.15 5 2.27 2680 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.787 303.15 4.9 2.27 2681 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.09 303.15 7.6 2.4 2682 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.28 303.15 7.5 2.61 2683 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.826 303.15 5.57 2.27 2684 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.534 303.15 7.6 2.3 2685 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.909 303.15 6.06 2.61 2686 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.14 303.15 7.5 2.61 2687 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.87 303.15 6.04 2.27 2688 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.694 303.15 6.5 2.27 2689 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.699 303.15 7 2.27 2690 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.699 303.15 7 2.27 2691 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.84 303.15 5.49 2.61 2692 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.01 303.15 7.6 2.7 2693 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.709 303.15 5.6 2.61 2694 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.279 303.15 7.6 1.4 2695 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.11 303.15 6.56 2.61 2696 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.23 303.15 8.2 2.61 2697 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.25 303.15 7.9 2.61 2698 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.15 303.15 7.5 2.61 2699 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=71HOR/HUS_645 71HOR/HUS paper chromatography and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.03 303.15 7.6 2.52 2700 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOH_102 57HOH spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0173 298.15 9.5 2701 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1310 310.15 7 3.05 2702 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1130 310.15 7 3.13 2703 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 975 310.15 7 3.42 2704 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 670 310.15 7 3.78 2705 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 412 310.15 7 4.21 2706 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 306 310.15 7 5.52 2707 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 622 310.15 7 3.68 2708 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1540 310.15 7 2.66 2709 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1930 310.15 7 2.63 2710 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 288 310.15 7 4.75 2711 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 490 310.15 7 4.08 2712 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 288 310.15 7 5.7 2713 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 817 310.15 7 3.48 2714 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 353 310.15 7 4.63 2715 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_585 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 586 310.15 7 3.83 2716 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_904 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 -isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 65 318.15 4.5 2717 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE_374 86CAS/VEE enzymatic assay and spectrophotometry A 2.2.1.2 transaldolase C05382 + C00118 = C00279 + C00085 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phosphate(aq) + D-fructose 6-phosphate(aq) 0.37 311.15 0.25 7 3 2718 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65STR_520 65STR spectrophotometry C 2.6.1.13 ornithine-oxo-acid transaminase C00077 + C00026 = C03912 + C00025 L-ornithine(aq) + 2-oxoglutarate(aq) = DL-D-1-pyrroline-5-carboxylate(aq) + L-glutamate(aq) 71 310.15 7.1 2719 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/SCH_802 35MEY/SCH calorimetry C 3.1.3.1 alkaline phosphatase C00197 + C00001 = C00258 + C00009 (R)-3-phosphoglycerate(aq) + H2O(l) = (R)-glycerate(aq) + orthophosphate(aq) 293.15 2720 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62HIM/RAB_1442 62HIM/RAB spectrophotometry B 6.3.4.3 formate-tetrahydrofolate ligase C00002 + C00058 + C00101 = C00008 + C00009 + C00234 ATP(aq) + formate(aq) + tetrahydrofolate(aq) = ADP(aq) + phosphate(aq) + 10-formyltetrahydrofolate(aq) 41 310.15 7.7 2721 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79PIR/LIL_1137 79PIR/LIL gas chromatography and spectrophotometry B 4.1.3.32 2,3-dimethylmalate lyase C03652 = C00163 + C00022 2,3-dimethylmalate(aq) = propanoate(aq) + pyruvate(aq) 0.5 298.15 8 2722 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56TAL/MAR_179 56TAL/MAR spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 0.026 298.15 6 2723 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56TAL/MAR_179 56TAL/MAR spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 2.6 298.15 8 2724 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56TAL/MAR_179 56TAL/MAR spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 26 298.15 9 2725 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56TAL/MAR_179 56TAL/MAR spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 0.26 298.15 7 2726 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_911 91TEW/GOL calorimetry A 3.2.1.10 oligo-1,6-glucosidase C01742 + C00001 = C00031 + C00095 palatinose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 4.44 2727 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91TEW/GOL_913 91TEW/GOL calorimetry A 3.2.1.20 -glucosidase C19636 + C00001 = C00031 + C00095 D-turanose(aq) + H2O(l) = D-glucose(aq) + D-fructose(aq) 298.15 5.65 2728 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93WER/TWE_1202 93WER/TWE HPLC B 4.2.1.85 dimethylmaleate hydratase C03652 = C00922 + C00001 (2R,3S)-2,3-dimethylmalate(aq) = dimethylmaleate(aq) + H2O(l) 0.089 298.15 0.1 7 2729 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GRA/ELL_620 86GRA/ELL NMR B 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.0186 298.15 7.1 2730 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53LYN/OCH_404 53LYN/OCH spectrophotometry C 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 2E-05 298.15 8.1 2731 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53LYN/OCH_404 53LYN/OCH spectrophotometry C 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 0.0001 298.15 9 2732 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64ADA/NOR_1240 64ADA/NOR ion exchange chromatography B 5.1.1.8 4-hydroxyproline epimerase C01157 = C03440 trans-4-hydroxy-L-proline(aq) = cis-4-hydroxy-D-proline(aq) 0.99 298.15 8.1 2733 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DOU_420 61DOU D 2.4.1.8 maltose phosphorylase C00208 + C00009 = C00031 + C00103 maltose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.23 310.15 7 2734 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00WU/FEN_1711 00WU/FEN NMR A 4.2.1.17 enoyl-CoA hydratase C01144 = C00877 + C00001 (3S)-hydroxybutanoyl-coenzyme A(aq) = trans-but-2-enoyl-coenzyme A + H2O(l) 0.13 298.15 7.4 2735 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 2.46 323.3 7.29 2736 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.48 292.8 7.29 2737 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.31 308.1 7.29 2738 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.13 313.4 7.29 2739 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 2.79 318.3 7.29 2740 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.07 298.5 7.29 2741 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.86 288.3 7.29 2742 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48SCO/POW_1145 48SCO/POW chemical analysis B 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.64 303 7.29 2743 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73LAN_1305 73LAN C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.21 343.15 7.8 2744 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73LAN_1305 73LAN C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.08 333.15 7.8 2745 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73LAN_1305 73LAN C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1 323.15 7.8 2746 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73LAN_1305 73LAN C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.14 338.15 7.8 2747 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELL_625 89ELL NMR and enzymatic assay C 2.7.3.4 taurocyamine kinase C00002 + C01959 = C00008 + C03149 ATP(aq) + taurocyamine(aq) = ADP(aq) + N-w-phosphotaurocyamine(aq) 29 308.15 7.25 2748 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELL_627 89ELL NMR and enzymatic assay C 2.7.3.5 lombricine kinase C00002 + C14177 = C00008 + C14178 ATP(aq) + lombricine(aq) = ADP(aq) + N-w-phospholombricine(aq) 32 308.15 7.25 2749 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELL_621 89ELL NMR and enzymatic assay C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 13 308.15 7.25 2750 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KAT/UED_1557 99KAT/UED radioactivity B 3.5.1.a anandamide amidohydrolase C11695 + C00001 = C00189 + C00219 anandamide(aq) + H2O(l) = ethanolamine(aq) + arachidonic acid(aq) 0.004 310.15 9 2751 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KAT/UED_1557 99KAT/UED radioactivity B 3.5.1.a anandamide amidohydrolase C11695 + C00001 = C00189 + C00219 anandamide(aq) + H2O(l) = ethanolamine(aq) + arachidonic acid(aq) 0.008 310.15 7.4 2752 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KAT/UED_1557 99KAT/UED radioactivity B 3.5.1.a anandamide amidohydrolase C11695 + C00001 = C00189 + C00219 anandamide(aq) + H2O(l) = ethanolamine(aq) + arachidonic acid(aq) 0.03 310.15 6 2753 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_148 68VEE spectrophotometry A 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.0344 311.15 0.25 7 2754 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_148 68VEE spectrophotometry A 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.0558 311.15 0.03 7 2755 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59TAL/LEV_181 59TAL/LEV spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 3.78 298.15 8 2756 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59TAL/LEV_181 59TAL/LEV spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 378 298.15 9 2757 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59TAL/LEV_181 59TAL/LEV spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 0.378 298.15 7 2758 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KAT/UED_1558 99KAT/UED radioactivity B 3.5.1.a anandamide amidohydrolase C16512 + C00001 = C00189 + C00249 palmitoylethanolamide(aq) + H2O(l) = ethanolamine(aq) + palmitic acid(aq) 0.0004 310.15 9 2759 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59ALE_443 59ALE enzymatic assay B 2.4.1.20 cellobiose phosphorylase C00185 + C00009 = C00031 + C00103 cellobiose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.23 310.15 7 2760 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 5.55E-06 295.15 6.55 2761 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000208 295.15 8.3 2762 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 6.94E-05 295.15 7.75 2763 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 2.33E-05 295.15 7.2 2764 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.00676 295.15 9.95 2765 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STE/OCH_128 52STE/OCH spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 1.34E-06 295.15 6.05 2766 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.58 298.15 0.25 7.15 2.9 2767 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.66 298.15 0.25 7.14 2.89 2768 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.25 298.15 0.25 6.83 2.84 2769 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.54 298.15 0.25 6.85 2.84 2770 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.7 298.15 0.25 6.82 2.84 2771 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.63 311.15 0.25 7.17 2.94 2772 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.74 311.15 0.25 7.09 2.89 2773 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.82 311.15 0.25 7.03 2.88 2774 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.54 311.15 0.25 7.27 2.89 2775 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.5 311.15 0.25 7.3 2.9 2776 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.56 311.15 0.25 7.27 2.89 2777 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.04 311.15 0.25 6.75 2.88 2778 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.53 311.15 0.25 7.11 2.89 2779 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.82 311.15 0.25 6.93 2.88 2780 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.61 311.15 0.25 7.1 2.88 2781 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.77 311.15 0.25 7.1 2.88 2782 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.72 311.15 0.25 7.08 2.87 2783 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.72 311.15 0.25 6.75 2.85 2784 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.79 311.15 0.25 7.05 2.18 2785 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.73 311.15 0.25 7.01 1.86 2786 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.68 298.15 0.25 7.15 2.91 2787 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.68 298.15 0.25 7.15 2.91 2788 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.52 311.15 0.25 7.17 2.94 2789 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.03 311.15 0.25 6.75 2.88 2790 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1 311.15 0.25 7.12 3.96 2791 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.53 311.15 0.25 6.82 2.86 2792 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.63 311.15 0.25 6.96 1.72 2793 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.72 298.15 0.25 7.19 2.9 2794 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 1.82 298.15 0.25 7.15 2.9 2795 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.72 311.15 0.25 7.08 2.89 2796 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.54 311.15 0.25 7.12 2.88 2797 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.79 311.15 0.25 7.12 2.9 2798 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.65 311.15 0.25 7.11 2.89 2799 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.79 311.15 0.25 6.8 2.84 2800 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.87 311.15 0.25 6.83 2.85 2801 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.6 311.15 0.25 6.94 1.72 2802 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.75 311.15 0.25 7.04 2.18 2803 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=78LYN/GUY_1437 78LYN/GUY fluorimetry and spectrophotometry A 6.2.1.4 succinate-CoA ligase (GDP-forming) C00044 + C00042 + C00010 = C00035 + C00009 + C00091 GTP(aq) + succinate(aq) + CoA(aq) = GDP(aq) + phosphate(aq) + succinyl-CoA(aq) 0.68 311.15 0.25 7.02 1.86 2804 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=48KOR_676 48KOR spectrophotometry B 2.7.7.1 nicotinamide-nucleotide adenylyltransferase C00002 + C00455 = C00003 + C00013 ATP + beta-Nicotinamide mononucleotide = NAD + pyrophosphate 0.4 311.15 7.4 2805 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83HON/HAR_695 83HON/HAR spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.48 310.15 8 2806 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03MER/WOO_1587 03MER/WOO NMR B 5.3.1.13 arabinose-5-phosphate isomerase C01112 = C00199 D-arabinose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.5 310.15 7.5 2807 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MUR/SUG_426 66MUR/SUG chromatography and radioactivity B 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 3.3 310.15 7.4 2808 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MUR/SUG_422 66MUR/SUG chromatography and radioactivity B 2.4.1.13 sucrose synthase C00498 + C00095 = C00008 + C00089 ADPglucose(aq) + D-fructose(aq) = ADP(aq) + sucrose(aq) 1.6 310.15 7.4 2809 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=42COL/SUT_1401 42COL/SUT C 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 19.8 293.15 7.5 2810 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=42COL/SUT_1401 42COL/SUT C 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 16.2 313.15 7.5 2811 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=42COL/SUT_1401 42COL/SUT C 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 17.2 303.15 7.5 2812 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE_1147 53KRE polarimetry and manometry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.43 298.15 7.4 2813 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_586 79COR/LEA enzymatic assay and spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 2170 311.15 7 2.92 2814 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000529 311.15 0.25 7 0.66 2815 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000548 311.15 0.25 7 0.52 2816 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000392 311.15 0.25 7 0.36 2817 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000349 311.15 0.25 7 0.34 2818 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000318 311.15 0.25 7 0.1 2819 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000318 311.15 0.25 7 -0.04 2820 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000242 311.15 0.25 7 -0.11 2821 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000278 311.15 0.25 7 -0.09 2822 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.0004 311.15 0.25 7 0.38 2823 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000272 311.15 0.25 7 -0.01 2824 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000241 311.15 0.25 7 -0.15 2825 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.00102 311.15 0.25 7 1.23 2826 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000274 311.15 0.25 7 -0.13 2827 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000251 311.15 0.25 7 -0.16 2828 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000278 311.15 0.25 7 -0.02 2829 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000549 311.15 0.25 7 0.62 2830 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.000225 311.15 0.25 7 -0.14 2831 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79COR/LEA_580 79COR/LEA enzymatic assay and spectrophotometry A 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.00143 311.15 0.25 7 2 2832 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89BER/MUD_947 89BER/MUD calorimetry B 3.2.2.5 NAD+ nucleosidase C00003 + C00001 = C00153 + C01882 NAD(aq) + H2O(l) = nicotinamide(aq) + ADPribose(aq) 298.15 7.4 2833 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.333 298.15 7.5 5 2834 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.567 298.15 7.5 3.7 2835 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.226 298.15 7.5 3.13 2836 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.9 298.15 7.5 2.67 2837 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.833 298.15 7.5 3.4 2838 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.167 298.15 7.5 2.8 2839 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.6 298.15 7.5 2.41 2840 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1 298.15 7.5 2.67 2841 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.543 298.15 7.5 2.4 2842 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.433 298.15 7.5 5 2843 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.342 298.15 7.5 2.93 2844 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.637 298.15 7.5 3.68 2845 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.367 298.15 7.5 2.97 2846 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.847 298.15 7.5 3.37 2847 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BLA_644 70BLA anion exchange chromatography B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.153 298.15 7.5 3.2 2848 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84ADA/UED_895 84ADA/UED HPLC and enzymatic assay C 3.2.1.3 glucan 1,4--glucosidase C00208 + C00001 = 2 C00031 maltose(aq) + H2O(l) = 2 D-glucose(aq) 200 313 5 2849 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84BER/COO_1513 84BER/COO spectrophotometry and NMR B 2.7.1.90 pyrophosphate-fructose-6-phosphate 1-phosphotransferase C00013 + C00085 = C00009 + C00354 pyrophosphate(aq) + D-fructose 6-phosphate(aq) = orthophosphate(aq) + D-fructose 1,6-bisphosphate(aq) 0.006 298.15 8 2850 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_49 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.000175 298.15 7 2851 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_49 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.00175 298.15 8 2852 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=05TEW/GOL_1630 05TEW/GOL calorimetry A 3.5.5.1 nitrilase C16074 + 2 C00001 = C07086 + C00014 benzyl cyanide(aq) + 2 H2O(aq) = phenylacetic acid(aq) + ammonia(aq) 298.15 0.29 7.51 2853 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86MEI/GAD_111 86MEI/GAD spectrophotometry C 1.1.1.28 D-lactate dehydrogenase C00256 + C00003 = C00022 + C00004 (R)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 1.4E-05 298.15 7 2854 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1329 85TEW/STE calorimetry A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 313.15 7.4 2855 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1329 85TEW/STE calorimetry A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 320.15 7.4 2856 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1329 85TEW/STE calorimetry A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 338.15 7.4 2857 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1329 85TEW/STE calorimetry A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 331.65 7.4 2858 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1329 85TEW/STE calorimetry A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 325.35 7.4 2859 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.172 298.35 8.7 2860 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.237 313.25 8.7 2861 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.224 314.05 8.7 2862 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.424 342.15 8.7 2863 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.315 328.15 8.7 2864 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.272 320.15 8.7 2865 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.374 335.05 8.7 2866 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/STE_1328 85TEW/STE HPLC A 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.204 306.15 8.7 2867 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62PET_524 62PET spectrophotometry C 2.6.1.17 succinyldiaminopimelate transaminase C04462 + C00025 = C04421 + C00026 N-succinyl-2-L-amino-6-oxoheptanedioate(aq) + L-glutamate(aq) = N-succinyl-L-2,6-diaminoheptanedioate(aq) + 2-oxoglutarate(aq) 1.2 310.15 8 2868 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LEE/OSU_629 85LEE/OSU NMR and radioassay B 2.7.4.2 phosphomevalonate kinase C00002 + C01107 = C00008 + C01143 ATP(aq) + (R)-5-phosphomevalonate(aq) = ADP(aq) + (R)-5-diphosphomevalonate(aq) 1.7 303.15 8 2869 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA/FRA_1381 69BLA/FRA spectrophotometry C 5.3.2.1 phenylpyruvate tautomerase C00166 = C02763 keto-phenylpyruvate(aq) = enol-phenylpyruvate(aq) 0.1 298.15 7.8 2870 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64BAR/ROO_1419 64BAR/ROO spectrophotometry C 5.4.99.1 methylaspartate mutase C03618 = C00025 L-threo-3-methylaspartate(aq) = L-glutamate(aq) 10.7 303.15 8.2 2871 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KIT/SAS_445 92KIT/SAS enzymatic assay C 2.4.1.20 cellobiose phosphorylase C00185 + C00009 = C00031 + C00103 cellobiose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.32 310.15 7 2872 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW_1181 98KIS/TEW HPLC A 4.2.1.20 tryptophan synthase C00463 + C00118 = C03506 indole(aq) + D-glyceraldehyde 3-phosphate(aq) = 1-(indol-3-yl)glycerol 3-phosphate(aq) 298.15 7.54 2873 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW_1182 98KIS/TEW calorimetry A 4.2.1.20 tryptophan synthase C00118 + C00463 = C03506 D-glyceraldehyde 3-phosphate(aq) + indole(aq) = 1-(indol-3-yl)glycerol 3-phosphate(aq) 298.15 7.26 2874 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW_1184 98KIS/TEW calorimetry A 4.2.1.20 tryptophan synthase C00463 + C00065 = C00078 + C00001 indole(aq) + L-serine(aq) = L-tryptophan(aq) + H2O(l) 298.15 7.01 2875 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW_1186 98KIS/TEW calorimetry A 4.2.1.20 tryptophan synthase C03506 + C00065 = C00078 + C00118 + C00001 1-(indol-3-yl)glycerol 3-phosphate(aq) + L-serine(aq) = L-tryptophan(aq) + D-glyceraldehyde 3-phosphate(aq) + H2O(l) 298.15 7.57 2876 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98KIS/TEW_1188 98KIS/TEW calorimetry A 4.2.1.20 tryptophan synthase C00065 = C00022 + C00014 L-serine(aq) = pyruvate(aq) + ammonia(aq) 308.15 6.9 2877 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66HAN/ALB_688 66HAN/ALB spectrophotometry C 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.31 298.15 7.8 2878 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64NOR_408 64NOR spectrophotometry and radioactivity B 2.3.1.21 carnitine O-palmitoyltransferase C00154 + C00318 = C00010 + C02990 palmitoyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-palmitoylcarnitine(aq) 0.5 310.15 7.5 2879 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68ERI_3 68ERI spectrophotometry B 1.1.1.1 alcohol dehydrogenase C06142 + C00003 = C01412 + C00004 1-butanol(aq) + NAD(aq) = butanal(aq) + NADH(aq) 0.0018 298.15 8.3 2880 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66AVI/ENG_213 66AVI/ENG spectrophotometry C 1.1.1.124 fructose 5-dehydrogenase (NADP+) C00095 + C00006 = C00273 + C00005 D-fructose(aq) + NADP(aq) = 5-dehydro-D-fructose(aq) + NADPH(aq) 0.000652 303.15 7.1 2881 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66AVI/ENG_213 66AVI/ENG spectrophotometry C 1.1.1.124 fructose 5-dehydrogenase (NADP+) C00095 + C00006 = C00273 + C00005 D-fructose(aq) + NADP(aq) = 5-dehydro-D-fructose(aq) + NADPH(aq) 8.56E-05 303.15 6.2 2882 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66AVI/ENG_213 66AVI/ENG spectrophotometry C 1.1.1.124 fructose 5-dehydrogenase (NADP+) C00095 + C00006 = C00273 + C00005 D-fructose(aq) + NADP(aq) = 5-dehydro-D-fructose(aq) + NADPH(aq) 0.000303 303.15 6.8 2883 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66AVI/ENG_213 66AVI/ENG spectrophotometry C 1.1.1.124 fructose 5-dehydrogenase (NADP+) C00095 + C00006 = C00273 + C00005 D-fructose(aq) + NADP(aq) = 5-dehydro-D-fructose(aq) + NADPH(aq) 0.000177 303.15 6.55 2884 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=00LIA/HUA_1579 00LIA/HUA calorimetry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.335 298.15 9 2885 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GIN_771 54GIN radioactivity B 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 55 310.15 8.2 2886 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SPR/LIM_1310 76SPR/LIM enzymatic assay and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.957 318.15 7 2887 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SPR/LIM_1310 76SPR/LIM enzymatic assay and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.283 343.15 7 2888 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SPR/LIM_1310 76SPR/LIM enzymatic assay and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.141 333.15 7 2889 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SPR/LIM_1310 76SPR/LIM enzymatic assay and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.381 353.15 7 2890 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76SPR/LIM_1310 76SPR/LIM enzymatic assay and chemical analysis B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.828 303.15 7 2891 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88BEL/BAE_569 88BEL/BAE chromatography and radioactivity B 2.7.1.67 1-phosphatidylinositol kinase C00002 + C01194 = C00008 + C01277 ATP(aq) + 1-phosphatidyl-1D-myo-inositol(aq) = ADP(aq) + 1-phosphatidyl-1D-myo-inositol 4-phosphate(aq) 0.003 303.15 8 2892 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89LOP/COH_603 89LOP/COH NMR C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.00581 309.15 7 2893 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55THO/GOM_1235 55THO/GOM manometry and enzymatic assay B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1 310.15 7.4 2894 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69KLO_398 69KLO spectrophotometry C 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0068 298.15 7.4 2895 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_17 80COO/BLA spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0029 298.15 9 2896 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70HEY/ELB_1343 70HEY/ELB spectrophotometry and chemical analysis C 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 1.9 310.15 7.5 2897 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78OKA/GEN_875 78OKA/GEN paper chromatography C 3.2.1.2 _-amylase C02052 + C00001 = 2 C00208 maltotetraose(aq) + H2O(l) = 2 maltose(aq) 335 303.15 2898 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62AKA/CAM_680 62AKA/CAM radioactivity B 2.7.7.4 sulfate adenylyltransferase C00002 + C00059 = C00224 + C00013 ATP(aq) + sulfate(aq) = adenosine 5'-phosphosulfate(aq) + pyrophosphate(aq) 6.2E-09 303.15 8 2899 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62AKA/CAM_680 62AKA/CAM radioactivity B 2.7.7.4 sulfate adenylyltransferase C00002 + C00059 = C00224 + C00013 ATP(aq) + sulfate(aq) = adenosine 5'-phosphosulfate(aq) + pyrophosphate(aq) 1.8E-08 303.15 7.2 2900 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/LOH_1290 35MEY/LOH calorimetry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 293.15 2901 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/LOH_1290 35MEY/LOH calorimetry C 5.3.1.1&4.1.2.13 triose-phosphate isomerase and fructose-bisphosphate aldolase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 313.15 2902 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE_366 86CAS/VEE enzymatic assay and spectrophotometry A 2.2.1.1 transketolase C00085 + C00118 = C00279 + C00231 D-fructose 6-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phospahte(aq) + D-xylulose 5-phosphate(aq) 0.0373 311.15 0.25 7 3 2903 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50FRI_456 50FRI spectrophotometry C 2.4.2.1 purine-nucleoside phosphorylase C05512 + C00009 = C00262 + C00672 2'-deoxyinosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + 2-deoxy--D-ribose 1-phosphate(aq) 0.019 297.15 7.4 2904 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93AND/BUL_1509 93AND/BUL radioactivity B 2.3.1.129 UDP-N-acetylglucosamine acyltransferase C04688 + C00043 = C03688 + C04738 (R)-3-hydroxytetradecanoyl-[acyl-carrier-protein](aq) + UDP-N-acetyl-D-glucosamine(aq) = acyl-carrier-protein(aq) + UDP-3-O-(3-hydroxytetradecanoyl)-N-acetyl-D-glucosamine(aq) 0.007 296.15 7.4 2905 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93AND/BUL_1509 93AND/BUL radioactivity B 2.3.1.129 UDP-N-acetylglucosamine acyltransferase C04688 + C00043 = C03688 + C04738 (R)-3-hydroxytetradecanoyl-[acyl-carrier-protein](aq) + UDP-N-acetyl-D-glucosamine(aq) = acyl-carrier-protein(aq) + UDP-3-O-(3-hydroxytetradecanoyl)-N-acetyl-D-glucosamine(aq) 0.004 296.15 8.5 2906 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93AND/BUL_1509 93AND/BUL radioactivity B 2.3.1.129 UDP-N-acetylglucosamine acyltransferase C04688 + C00043 = C03688 + C04738 (R)-3-hydroxytetradecanoyl-[acyl-carrier-protein](aq) + UDP-N-acetyl-D-glucosamine(aq) = acyl-carrier-protein(aq) + UDP-3-O-(3-hydroxytetradecanoyl)-N-acetyl-D-glucosamine(aq) 0.002 296.15 9 2907 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93AND/BUL_1509 93AND/BUL radioactivity B 2.3.1.129 UDP-N-acetylglucosamine acyltransferase C04688 + C00043 = C03688 + C04738 (R)-3-hydroxytetradecanoyl-[acyl-carrier-protein](aq) + UDP-N-acetyl-D-glucosamine(aq) = acyl-carrier-protein(aq) + UDP-3-O-(3-hydroxytetradecanoyl)-N-acetyl-D-glucosamine(aq) 0.0095 296.15 8 2908 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE_369 86CAS/VEE enzymatic assay and spectrophotometry A 2.2.1.1 transketolase C05382 + C00118 = C00117 + C00231 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-ribose 5-phosphate(aq) + D-xylulose 5-phosphate(aq) 0.48 311.15 0.25 7 3 2909 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74JEB/TY_647 74JEB/TY enzymatic assay and spectrophotometry B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.55 298.15 7.4 2.3 2910 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75PIE/GUY_391 75PIE/GUY spectrophotometry A 2.3.1.7 carnitine O-acetyltransferase C00024 + C00318 = C00010 + C02571 acetyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-acetylcarnitine(aq) 1.73 311.15 0.25 7 2911 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75PIE/GUY_391 75PIE/GUY spectrophotometry A 2.3.1.7 carnitine O-acetyltransferase C00024 + C00318 = C00010 + C02571 acetyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-acetylcarnitine(aq) 1.6 298.15 0.25 7 2912 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=29WOO_1206 29WOO chemical analysis and polarimetry B 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.01 310.15 7.4 2913 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60KUR/SUG_696 60KUR/SUG spectrophotometry and enzymatic assay C 2.7.7.12 UDPglucose-hexose-1-phosphate uridylyltransferase C00029 + C03384 = C00103 + C00052 UDPglucose(aq) + D-galactose 1-phosphate(aq) =-D-glucose 1-phosphate(aq) + UDPgalactose(aq) 1.1 303.15 8.75 2914 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62HAY/NIS_525 62HAY/NIS spectrophotometry C 2.6.1.18 _-alanine-pyruvate transaminase C00041 + C00222 = C00099 + C00022 L-alanine + 3-oxopropanoate = beta-alanine + pyruvate 0.2 308.15 8 2915 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00084 293.15 0.1 8 2916 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00807 293.15 0.1 9 2917 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0795 293.15 0.1 10 2918 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 7.36E-05 293.15 0.05 7 2919 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 8.07E-05 293.15 0.096 7 2920 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 9.25E-05 293.15 0.259 7 2921 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 9.97E-05 293.15 0.376 7 2922 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0001047 293.15 0.423 7 2923 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0001184 293.15 0.749 7 2924 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 6.46E-05 288.15 0.1 7 2925 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 9.77E-05 298.15 0.1 7 2926 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0001202 303.15 0.1 7 2927 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0001445 308.15 0.1 7 2928 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000642 288.15 0.1 8 2929 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000795 293.15 0.1 8 2930 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.001175 303.15 0.1 8 2931 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.001413 308.15 0.1 8 2932 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00635 288.15 0.1 9 2933 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00794 293.15 0.1 9 2934 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00972 298.15 0.1 9 2935 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.01454 308.15 0.1 9 2936 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.01454 308.15 0.1 9 2937 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 9.27E-05 293.15 0.189 7 2938 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 8E-05 293.15 0.1 7 2939 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000966 298.15 0.1 8 2940 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.012 303.15 0.1 9 2941 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=58BAC_14 58BAC spectrophotometry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 7.95E-05 293.15 0.1 7 2942 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 40.1 311.15 0.25 6.95 3.3 2943 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 34.1 311.15 0.25 7.23 3.3 2944 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 32.4 311.15 0.25 7.08 3.3 2945 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 31.6 311.15 0.25 7.08 3.3 2946 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 26.7 311.15 0.25 7.22 3.3 2947 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 24.1 311.15 0.25 7.92 3.3 2948 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 25.5 311.15 0.25 7.92 3.3 2949 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 44.6 311.15 0.25 6.9 2.77 2950 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 37.4 311.15 0.25 6.95 1.92 2951 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 40 311.15 0.25 6.85 1.82 2952 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 43.3 311.15 0.25 6.9 2.25 2953 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 45 311.15 0.25 6.9 2.59 2954 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 44.7 311.15 0.25 6.88 2.3 2955 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 33.6 311.15 0.25 7.35 2.3 2956 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.5 311.15 0.25 6.94 3.3 2957 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 49.6 311.15 0.25 6.9 2.85 2958 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 49 311.15 0.25 6.9 3.3 2959 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 34.4 311.15 0.25 6.9 2.3 2960 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 34.6 311.15 0.25 6.95 3.3 2961 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 39 311.15 0.25 6.94 2.72 2962 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.8 311.15 0.25 6.92 2.33 2963 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.8 311.15 0.25 6.92 2.33 2964 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 49.9 311.15 0.25 6.9 2.54 2965 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 43.1 311.15 0.25 6.88 2.3 2966 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.9 311.15 0.25 7.15 2.3 2967 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 33.5 311.15 0.25 7.32 2.3 2968 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 34.4 311.15 0.25 7.32 2.3 2969 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 39.9 311.15 0.25 6.95 3.3 2970 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 29.9 311.15 0.25 6.91 3.3 2971 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 28.2 311.15 0.25 7.09 3.3 2972 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 37.3 311.15 0.25 6.9 2.09 2973 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 39.4 311.15 0.25 6.95 3.3 2974 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 38.3 311.15 0.25 6.9 1.92 2975 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 44.5 311.15 0.25 6.88 2.3 2976 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 35.7 311.15 0.25 6.87 2.06 2977 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 37.6 311.15 0.25 6.94 3.3 2978 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 38.9 311.15 0.25 6.88 1.94 2979 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 30.4 311.15 0.25 7.09 3.3 2980 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 46.9 311.15 0.25 6.9 3.3 2981 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 41.3 311.15 0.25 6.88 2.3 2982 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 51.4 311.15 0.25 6.9 2.19 2983 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 31.3 311.15 0.25 7.23 3.3 2984 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 31.3 311.15 0.25 7.23 3.3 2985 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.1 311.15 0.25 6.94 3.3 2986 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 34 311.15 0.25 7.16 2.3 2987 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 21.6 311.15 0.25 7.99 3.3 2988 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 39.3 311.15 0.25 6.86 1.85 2989 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 35.9 311.15 0.25 7.15 2.3 2990 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 28.9 311.15 0.25 7.99 3.3 2991 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 39.9 311.15 0.25 6.89 2.3 2992 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=76GUY_807 76GUY spectrophotometry A 3.1.3.1 alkaline phosphatase C00588 + C00001 = C00114 + C00009 phosphorylcholine(aq) + H2O(l) = choline(aq) + orthophosphate(aq) 36.8 311.15 0.25 7.35 2.3 2993 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74SCA/SHI_1308 74SCA/SHI C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.04 340.15 7.1 2994 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74SCA/SHI_1308 74SCA/SHI C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.16 360.15 7.1 2995 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74SCA/SHI_1308 74SCA/SHI C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.09 350.15 7.1 2996 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77SCH/TAT_350 77SCH/TAT spectrophotometry and radioactivity A 2.1.2.1 glycine hydroxymethyltransferase C00143 + C00037 + C00001 = C00101 + C00065 5,10-methylenetetrahydrofolate(aq) + glycine(aq) + H2O(l) = tetrahydrofolate(aq) + L-serine(aq) 0.083 308.15 7.5 2997 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77SCH/TAT_350 77SCH/TAT spectrophotometry and radioactivity A 2.1.2.1 glycine hydroxymethyltransferase C00143 + C00037 + C00001 = C00101 + C00065 5,10-methylenetetrahydrofolate(aq) + glycine(aq) + H2O(l) = tetrahydrofolate(aq) + L-serine(aq) 0.125 303.15 7.3 2998 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95JUS/KOT_1002 95JUS/KOT calorimetry C 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 0.07 7 2999 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_277 85ANS/PRI D 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.8E-07 311.15 7.6 3000 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_277 85ANS/PRI D 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 8E-08 311.15 7.6 3001 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85ANS/PRI_277 85ANS/PRI D 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 3.1E-06 311.15 7.6 3002 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80SVE/GAL_1023 80SVE/GAL B 3.5.1.14 aminoacylase C02712 + C00001 = C00033 + C00073 N-acetyl-L-methionine(aq) + H2O(l) = acetate(aq) + L-methionine(aq) 3.6 298.15 7.5 3003 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57TAL_180 57TAL spectrophotometry C 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 0.37 298.15 7 3004 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.021 298.15 7.4 2.69 3005 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00625 298.15 7.4 1.99 3006 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00465 298.15 7.4 1.78 3007 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00549 298.15 7.4 1.78 3008 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00408 298.15 7.4 1.75 3009 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.0027 298.15 7.4 1.6 3010 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00268 298.15 7.4 1.62 3011 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00282 298.15 7.4 1.22 3012 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00279 298.15 7.4 1.21 3013 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00288 298.15 7.4 0.86 3014 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00251 298.15 7.4 0.43 3015 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00292 298.15 7.4 0.43 3016 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00787 298.15 7.4 2.29 3017 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.0036 298.15 7.4 1.75 3018 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00276 298.15 7.4 0.86 3019 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.0207 298.15 7.4 2.69 3020 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00855 298.15 7.4 2.29 3021 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00565 298.15 7.4 1.98 3022 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74LAN_575 74LAN enzymatic assay and spectrophotometry A 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.00255 298.15 7.4 1.37 3023 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LLO/KHA_1309 76LLO/KHA polarimetry and HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.869 303.15 7.3 3024 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LLO/KHA_1309 76LLO/KHA polarimetry and HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.931 318.15 7.3 3025 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LLO/KHA_1309 76LLO/KHA polarimetry and HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.996 333.15 7.3 3026 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LLO/KHA_1309 76LLO/KHA polarimetry and HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.101 343.15 7.3 3027 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70GEO/WIT_755 70GEO/WIT calorimetry C 3.1.3.1 alkaline phosphatase C00227 + C00001 = C00033 + C00009 acetyl phosphate-2-(aq) + H2O(l) = acetate-(aq) + HPO4-2-(aq) 298.15 3028 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TUR/TUR_684 58TUR/TUR chromatography and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.119 303.15 7.9 2.6 3029 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TUR/TUR_684 58TUR/TUR chromatography and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.286 303.15 7 2.6 3030 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TUR/TUR_684 58TUR/TUR chromatography and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.139 303.15 7.9 2.3 3031 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TUR/TUR_684 58TUR/TUR chromatography and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.263 303.15 7.9 2 3032 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78SUB_284 78SUB calorimetry A 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 298.15 7.6 3033 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78SUB_284 78SUB calorimetry A 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 308.15 7.6 3034 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_136 68VEE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.0002 311.15 0.25 8.15 3035 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_136 68VEE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 3.9E-05 311.15 0.25 7.15 3036 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_136 68VEE spectrophotometry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 0.000257 311.15 0.25 8.02 3037 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70GEO/WIT_758 70GEO/WIT chromatography and enzymatic assay C 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP-2--(aq) + H2O(l) = adenosine(aq) + HPO4-2-(aq) 48 298.15 0 3038 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69SMI/MOR_617 69SMI/MOR B 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.8 303.15 8 3039 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68TAN/KAN_451 68TAN/KAN paper chromatography and radioactivity C 2.4.1.67 galactinol-raffinose galactosyltransferase C01235 + C00492 = C00137 + C01613 1--D-galactosyl-myo-inositol(aq) + raffinose(aq) = myo-inositol(aq) + stachyose(aq) 4 305.15 7 3040 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.7E-06 296.15 7 3041 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 8.57E-06 296.15 7.4 3042 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 9.34E-05 296.15 8.4 3043 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.000163 296.15 8.8 3044 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.000465 296.15 9 3045 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.49E-05 296.15 7.8 3046 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 0.00071 296.15 9.4 3047 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57HOL/HOL_113 57HOL/HOL spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.73E-05 296.15 8 3048 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83SEL/MAN_1228 83SEL/MAN spectrophotometry C 4.4.1.5 lactoylglutathione lyase C03451 = C00051 + C00546 (R)-S-lactoylglutathione(aq) = glutathione (reduced)(aq) + methylglyoxal(aq) 9E-05 303.15 7 3049 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73RAD/HOC_400 73RAD/HOC spectrophotometry C 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0065 298.15 7.6 3050 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 6.42 3051 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 7.9 3052 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.59 3053 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.57 3054 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.53 3055 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.55 3056 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.14 3057 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 309.95 8.42 3058 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.8 3059 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.45 3060 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 7.16 3061 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.63 3062 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.41 3063 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.19 3064 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8.32 3065 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 7.55 3066 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 304.15 8.42 3067 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GAJ/STE_1074 86GAJ/STE calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 7.86 3068 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59DEN/ROB_190 59DEN/ROB chromatography and spectrophotometry B 1.1.1.59 3-hydroxypropionate dehydrogenase C01013 + C00003 = C00222 + C00004 3-hydroxypropanoate(aq) + NAD(aq) = 3-oxopropanoate(aq) + NADH(aq) 0.009 298.15 9 3069 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_814 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00199 + C00001 = C00309 + C00009 D-ribulose 5-phosphate(aq) + H2O(l) = D-ribulose(aq) + orthophosphate(aq) 304.65 8.5 3070 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_814 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00199 + C00001 = C00309 + C00009 D-ribulose 5-phosphate(aq) + H2O(l) = D-ribulose(aq) + orthophosphate(aq) 310.15 8.5 3071 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_814 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00199 + C00001 = C00309 + C00009 D-ribulose 5-phosphate(aq) + H2O(l) = D-ribulose(aq) + orthophosphate(aq) 298.15 8.5 3072 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_813 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00117 + C00001 = C00121 + C00009 D-ribose 5-phosphate(aq) + H2O(l) = D-ribose(aq) + orthophosphate(aq) 298.15 8.4 3073 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_813 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00117 + C00001 = C00121 + C00009 D-ribose 5-phosphate(aq) + H2O(l) = D-ribose(aq) + orthophosphate(aq) 310.15 8.4 3074 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_813 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00117 + C00001 = C00121 + C00009 D-ribose 5-phosphate(aq) + H2O(l) = D-ribose(aq) + orthophosphate(aq) 304.65 8.4 3075 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL2_42 37EUL/ADL2 spectrophotometry C 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 1.6E-05 298.15 6.9 3076 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL2_42 37EUL/ADL2 spectrophotometry C 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.00059 298.15 8.1 3077 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL2_42 37EUL/ADL2 spectrophotometry C 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 0.0003 298.15 7.6 3078 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52BAU/GEM_996 52BAU/GEM calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 303.15 7.14 3079 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 15700 298.15 7.4 3080 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2500 298.15 7.4 4 3081 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2630 298.15 7.4 4 3082 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1180 298.15 7.4 2.3 3083 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 493 298.15 7.4 2.3 3084 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 115 298.15 7.4 1.7 3085 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 101 298.15 7.4 1.4 3086 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 7000 298.15 7.4 3 3087 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 556 298.15 7.4 2.3 3088 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 862 298.15 7.4 2.3 3089 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1350 298.15 7.4 2.3 3090 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1350 298.15 7.4 2 3091 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 387 298.15 7.4 2.3 3092 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 136 298.15 7.4 1.7 3093 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 6310 277.9 7.4 3 3094 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 5830 283.1 7.4 3 3095 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3120 303 7.4 3 3096 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2460 312.7 7.4 3 3097 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3530 298.15 7.4 3 3098 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 469 298.15 7.4 2.3 3099 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3770 298.15 7.4 3.3 3100 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3770 298.15 7.4 3.3 3101 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 111 298.15 7.4 1.7 3102 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 17000 298.15 7.4 3103 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 215 298.15 7.4 2 3104 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1850 298.15 7.4 2.3 3105 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 12000 298.15 7.4 3106 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=74FLO/FLE_1063 74FLO/FLE radioactivity A 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3930 292.9 7.4 3 3107 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE_1157 53KRE polarimetry and manometry A 4.2.1.3 aconitate hydratase C00158 = C00417 + C00001 citrate(aq) = cis-aconitate(aq) + H2O(l) 0.032 298.15 7.4 3108 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57SAN/SEA_323 57SAN/SEA spectrophotometry C 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.21 295.15 7.1 3109 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1104 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.002 303.15 7 3110 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1104 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.003 313.15 7 3111 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1104 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.011 333.15 7 3112 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1104 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13&5.3.1.1 fructose-biphosphate aldolase and triose-phosphate isomerase C00354 = 2 C00111 D-fructose 1,6-bisphosphate(aq) = 2 glycerone phosphate(aq) 0.0024 311.15 7 3113 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GEU/MAY_1542 85GEU/MAY radioactivity B 2.7.1.117 myosin-light-chain kinase C00002 + C01003 = C00008 + C03875 ATP(aq) + myosin light chain(aq) = ADP(aq) + myosin light chain phosphate(aq) 59 303.15 7.2 3114 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_11 50RAC spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.000364 298.15 7.5 3115 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_11 50RAC spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0115 298.15 9 3116 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_11 50RAC spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.0364 298.15 9.5 3117 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_11 50RAC spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00364 298.15 8.5 3118 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50RAC_11 50RAC spectrophotometry B 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00115 298.15 8 3119 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BAL/DEN_84 70BAL/DEN spectrophotometry C 1.1.1.25 shikimate dehydrogenase C00493 + C00006 = C02652 + C00005 shikimate(aq) + NADP(aq) = 5-dehydroshikimate(aq) + NADPH(aq) 0.097 298.15 7.6 3120 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_787 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00275 + C00001 = C00159 + C00009 D-mannose 6-phosphate(aq) + H2O(l) = D-mannose(aq) + orthophosphate(aq) 298.15 8.6 3121 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_787 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00275 + C00001 = C00159 + C00009 D-mannose 6-phosphate(aq) + H2O(l) = D-mannose(aq) + orthophosphate(aq) 304.65 8.6 3122 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=88TEW/STE2_787 88TEW/STE2 calorimetry A 3.1.3.1 alkaline phosphatase C00275 + C00001 = C00159 + C00009 D-mannose 6-phosphate(aq) + H2O(l) = D-mannose(aq) + orthophosphate(aq) 310.15 8.6 3123 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84ADA/UED_887 84ADA/UED HPLC and enzymatic assay C 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 18 313 5 3124 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72ROS/SLA_1441 72ROS/SLA enzymatic assay and chemical analysis A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 270 310.15 0.3 7 1.3 3125 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72ROS/SLA_1441 72ROS/SLA enzymatic assay and chemical analysis A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 831 310.15 0.17 7.58 2.01 3126 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72ROS/SLA_1441 72ROS/SLA enzymatic assay and chemical analysis A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 668 310.15 0.21 7.5 1.31 3127 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72ROS/SLA_1441 72ROS/SLA enzymatic assay and chemical analysis A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 162 310.15 0.2 6.6 1.3 3128 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72ROS/SLA_1441 72ROS/SLA enzymatic assay and chemical analysis A 6.3.1.2 glutamate-ammonia ligase C00002 + C00025 + C00014 = C00008 + C00009 + C00064 ATP(aq) + L-glutamate(aq) + ammonia(aq) = ADP(aq) + phosphate(aq) + L-glutamine(aq) 280 310.15 0.22 7.1 1.97 3129 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_764 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C01094 + C00001 = C00095 + C00009 D-fructose 1-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 53 311.15 8.5 3130 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_765 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 124 311.15 8.5 3131 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_762 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C00354 + C00001 = C01094 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 1-phosphate(aq) + orthophosphate(aq) 14 311.15 8.5 3132 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_763 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C00354 + C00001 = C00085 + C00009 D-fructose 1,6-bisphosphate(aq) + H2O(l) = D-fructose 6-phosphate(aq) + orthophosphate(aq) 6.3 311.15 8.5 3133 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69WHI/LEJ_1239 69WHI/LEJ manometry and spectrophotometry B 5.1.1.7 diaminopimelate epimerase C00666 = C00680 L,L-2,6-diaminoheptanedioate(aq) = meso-diaminoheptanedioate(aq) 1.9 310.15 7 3134 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_768 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C01113 + C00001 = C00124 + C00009 D-galactose 6-phosphate(aq) + H2O(l) = D-galactose(aq) + orthophosphate(aq) 87 311.15 8.5 3135 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64HEN/CLE_500 64HEN/CLE spectrophotometry B 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.165 310.15 0.13 7.4 3136 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56FEU/WOL_557 56FEU/WOL chromatography C 2.7.1.24 dephospho-CoA kinase C00002 + C00882 = C00008 + C00010 ATP(aq) + 3'-dephospho-CoA(aq) = ADP(aq) + CoA(aq) 1.6 310.15 7.3 3137 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_165 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 1500 311.15 6.03 3138 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_165 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 8900 311.15 6.47 3139 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_165 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 83000 311.15 7.03 3140 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DAT/RAC_368 61DAT/RAC enzymatic assay and spectrophotometry B 2.2.1.1 transketolase C05382 + C00118 = C00117 + C00231 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-ribose 5-phosphate(aq) + D-xylulose 5-phosphate(aq) 0.9 298.15 7.6 3141 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GOL_406 54GOL spectrophotometry C 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 6E-05 289.15 8.5 3142 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54GOL_406 54GOL spectrophotometry C 2.3.1.9 acetyl-CoA C-acetyltransferase 2 C00024 = C00010 + C00332 2 acetyl-CoA(aq) = CoA(aq) + acetoacetyl-CoA(aq) 8.7E-05 289.15 8.8 3143 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DAT/RAC_367 61DAT/RAC enzymatic assay and spectrophotometry B 2.2.1.1 transketolase C00085 + C00266 = C02045 + C00279 D-fructose 6-phosphate(aq) + glycolaldehyde(aq) = L-erythrulose(aq) + D-erythrose 4-phosphate(aq) 0.015 298.15 7.6 3144 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61DAT/RAC_365 61DAT/RAC enzymatic assay and spectrophotometry B 2.2.1.1 transketolase C00085 + C00118 = C00279 + C00231 D-fructose 6-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phosphate(aq) + D-xylulose 5-phosphate(aq) 0.084 298.15 7.6 3145 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63DEV/GOU_459 63DEV/GOU radioactivity and spectrophotometry C 2.4.2.1 purine-nucleoside phosphorylase C00294 + C00009 = C00262 + C00620 inosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + D-ribose 1-phosphate(aq) 0.025 310.15 7 3146 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63QUA_260 63QUA spectrophotometry B 1.2.1.17 glyoxylate dehydrogenase (acylating) C00048 + C00010 + C00006 = C00313 + C00005 glyoxylate(aq) + CoA(aq) + NADP(aq) = oxalyl-CoA(aq) + NADPH(aq) 44.7 298.15 6.8 3147 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63QUA_260 63QUA spectrophotometry B 1.2.1.17 glyoxylate dehydrogenase (acylating) C00048 + C00010 + C00006 = C00313 + C00005 glyoxylate(aq) + CoA(aq) + NADP(aq) = oxalyl-CoA(aq) + NADPH(aq) 38.5 298.15 6.7 3148 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63QUA_260 63QUA spectrophotometry B 1.2.1.17 glyoxylate dehydrogenase (acylating) C00048 + C00010 + C00006 = C00313 + C00005 glyoxylate(aq) + CoA(aq) + NADP(aq) = oxalyl-CoA(aq) + NADPH(aq) 73.4 298.15 6.98 3149 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63QUA_260 63QUA spectrophotometry B 1.2.1.17 glyoxylate dehydrogenase (acylating) C00048 + C00010 + C00006 = C00313 + C00005 glyoxylate(aq) + CoA(aq) + NADP(aq) = oxalyl-CoA(aq) + NADPH(aq) 24.3 298.15 6.6 3150 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63QUA_260 63QUA spectrophotometry B 1.2.1.17 glyoxylate dehydrogenase (acylating) C00048 + C00010 + C00006 = C00313 + C00005 glyoxylate(aq) + CoA(aq) + NADP(aq) = oxalyl-CoA(aq) + NADPH(aq) 51.8 298.15 6.85 3151 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 46.8 311.15 0.25 7.73 3152 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49.4 311.15 0.25 8.13 3153 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 48.3 311.15 0.25 8.12 3154 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49.9 311.15 0.25 7 3155 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47.8 311.15 0.25 7 2 3156 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49.8 311.15 0.25 7 2 3157 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 50 311.15 0.25 7 1.88 3158 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 50 311.15 0.25 7 1.7 3159 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 51.1 311.15 0.25 7 1.7 3160 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 50.6 311.15 0.12 6.98 3161 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 58.9 311.15 0.41 6.98 3162 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 57.5 311.15 0.56 6.98 3163 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 125 311.15 0.25 5.9 3164 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 122.3 311.15 0.25 5.99 3165 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 76.8 311.15 0.25 6.47 3166 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 70.4 311.15 0.25 6.52 3167 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 74.2 311.15 0.25 6.53 3168 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 55.1 311.15 0.25 6.89 3169 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 58.4 311.15 0.25 6.89 3170 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 59.8 311.15 0.25 6.91 3171 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 59.4 311.15 0.25 6.91 3172 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 59.4 311.15 0.25 6.91 3173 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 59.8 311.15 0.25 6.92 3174 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 52.8 311.15 0.25 6.95 3175 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 54.9 311.15 0.25 6.98 3176 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49.8 311.15 0.25 7.36 3177 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 45 311.15 0.25 7.66 3178 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 55.8 311.15 0.71 6.98 3179 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 55.8 311.15 1 6.98 3180 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 58.9 311.15 1 6.98 3181 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56.5 311.15 0.25 6.89 3182 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 46.1 311.15 0.25 7.43 3183 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49.8 311.15 0.25 7 1.88 3184 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 68.6 311.15 0.25 6.49 3185 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 57.2 311.15 0.25 6.95 3186 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 58.2 311.15 0.71 6.98 3187 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 57.7 311.15 0.25 6.91 3188 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 51 311.15 0.25 8.16 3189 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56.1 311.15 0.41 6.98 3190 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47.4 311.15 0.25 7 3191 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47 311.15 0.25 8.02 3192 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47.8 311.15 0.25 7 2.17 3193 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47.8 311.15 0.25 7 2.17 3194 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 53.9 311.15 0.56 6.98 3195 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 54.8 311.15 0.12 6.98 3196 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=82GUY/THA_828 82GUY/THA spectrophotometry A 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47.4 311.15 0.25 7 2.17 3197 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60SCH/RAT_1444 60SCH/RAT spectrophotometry A 6.3.4.5 arginosuccinate synthase C00002 + C00327 + C00049 = C00020 + C00013 + C03406 ATP(aq) + L-citrulline(aq) + L-aspartate(aq) = AMP(aq) + diphosphate(aq) + L-arginosuccinate(aq) 2.14 311.15 6.91 2.18 3198 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60SCH/RAT_1444 60SCH/RAT spectrophotometry A 6.3.4.5 arginosuccinate synthase C00002 + C00327 + C00049 = C00020 + C00013 + C03406 ATP(aq) + L-citrulline(aq) + L-aspartate(aq) = AMP(aq) + diphosphate(aq) + L-arginosuccinate(aq) 69.5 311.15 7.79 2.18 3199 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60SCH/RAT_1444 60SCH/RAT spectrophotometry A 6.3.4.5 arginosuccinate synthase C00002 + C00327 + C00049 = C00020 + C00013 + C03406 ATP(aq) + L-citrulline(aq) + L-aspartate(aq) = AMP(aq) + diphosphate(aq) + L-arginosuccinate(aq) 38.3 311.15 7.7 2.18 3200 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60SCH/RAT_1444 60SCH/RAT spectrophotometry A 6.3.4.5 arginosuccinate synthase C00002 + C00327 + C00049 = C00020 + C00013 + C03406 ATP(aq) + L-citrulline(aq) + L-aspartate(aq) = AMP(aq) + diphosphate(aq) + L-arginosuccinate(aq) 0.14 311.15 5.9 2.18 3201 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62DOU/SHU_1111 62DOU/SHU spectrophotometry C 4.1.2.21 2-dehydro-3-deoxy-6-phosphogalactonate aldolase C01286 = C00022 + C00118 2-dehydro-3-deoxy-D-galactonate 6-phosphate(aq) = pyruvate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.0037 298.15 6.8 3202 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63DEV/GOU_457 63DEV/GOU radioactivity and spectrophotometry C 2.4.2.1 purine-nucleoside phosphorylase C05512 + C00009 = C00262 + C00672 2'-deoxyinosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + 2-deoxy--D-ribose 1-phosphate(aq) 0.03 310.15 7 3203 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84UCH/TSU_1119 84UCH/TSU B 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.08 310.15 7.7 3204 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67TAK/HIZ_1357 67TAK/HIZ spectrophotometry C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.54 310.15 7.5 3205 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64IMA/MOR_1251 64IMA/MOR spectrophotometry A 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.29 298.15 8.7 3206 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50FRI_1535 50FRI spectrophotometry B 2.4.2.1 purine-nucleoside phosphorylase C05512 + C00009 = C00262 + C00672 2 '-deoxyinosine(aq) + orthophosphate(aq) = hypoxanthine(aq) + 2-deoxy--D-ribose 1-phosphate(aq) 0.019 297.15 7.4 3207 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FER/STR_1380 74FER/STR enzymatic assay and spectrophotometry B 5.3.1.- phospho-3-hexuloisomerase C06019 = C00085 D-arabino-3-hexulose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 188 303.15 7 3208 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65MOR/JAM_594 65MOR/JAM spectrophotometry C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.036 303.15 8 3209 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75COH/LYN_1198 75COH/LYN spectrophotometry A 4.2.1.49 urocanate hydratase C00785 + C00001 = C03680 urocanate(aq) + H2O(l) = 4,5-dihydro-4-oxo-5-imidazolepropanoate(aq) 35.5 277.15 7.5 3210 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75COH/LYN_1198 75COH/LYN spectrophotometry A 4.2.1.49 urocanate hydratase C00785 + C00001 = C03680 urocanate(aq) + H2O(l) = 4,5-dihydro-4-oxo-5-imidazolepropanoate(aq) 49.1 288.15 7.5 3211 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75COH/LYN_1198 75COH/LYN spectrophotometry A 4.2.1.49 urocanate hydratase C00785 + C00001 = C03680 urocanate(aq) + H2O(l) = 4,5-dihydro-4-oxo-5-imidazolepropanoate(aq) 58.2 293.15 7.5 3212 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75COH/LYN_1198 75COH/LYN spectrophotometry A 4.2.1.49 urocanate hydratase C00785 + C00001 = C03680 urocanate(aq) + H2O(l) = 4,5-dihydro-4-oxo-5-imidazolepropanoate(aq) 69.8 298.15 7.5 3213 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75COH/LYN_1198 75COH/LYN spectrophotometry A 4.2.1.49 urocanate hydratase C00785 + C00001 = C03680 urocanate(aq) + H2O(l) = 4,5-dihydro-4-oxo-5-imidazolepropanoate(aq) 91.2 310.15 7.5 3214 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55KAT_112 55KAT calorimetry B 1.1.1.28 D-lactate dehydrogenase C00256 + C00003 = C00022 + C00004 (R)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 298.15 7.3 3215 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73SUZ/IWA_1060 73SUZ/IWA spectrophotometry C 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 50 298.15 7 3216 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3217 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3218 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3219 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3220 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3221 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3222 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3223 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3224 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3225 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3226 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3227 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3228 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3229 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3230 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3231 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3232 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3233 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3234 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3235 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3236 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3237 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3238 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3239 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3240 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3241 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3242 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3243 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3244 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=03BIA_1515 03BIA calorimetry B 2.7.1.2 glucokinase C00002 + C00031 = C00008 + C00092 ATP(aq) + D-glucose(aq) = ADP(aq) + D-glucose 6-phosphate(aq) 298.15 7.6 3245 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MEY/SHA_1069 53MEY/SHA calorimetry B 3.6.1.2 trimetaphosphatase C02466 + C00001 = C00536 trimetaphosphate(aq) + H2O(l) = triphosphate(aq) 306.15 6.95 3246 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62UEH_1293 62UEH chemical analysis C 5.3.1.2 erythrose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 2.3 308.15 5.8 3247 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69SWI_674 69SWI enzymatic assay and spectrophotometry A 2.7.6.1 ribose-phosphate pyrophosphokinase C00002 + C00117 = C00020 + C00119 ATP(aq) + D-ribose 5-phosphate(aq) = AMP(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 28.6 310.15 7.5 3248 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93MOC/STR_453 93MOC/STR HPLC C 2.4.1.120 sinapate 1-glucosyltransferase C00029 + C00482 = C00015 + C01175 UDPglucose(aq) + sinapate(aq) = UDP(aq) + 1-sinapoyl-D-glucose(aq) 0.21 303.15 6 3249 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE2_508 53KRE2 manometry A 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.658 298.15 7.4 3250 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83PIL/HAN_1597 83PIL/HAN radioactivity C 5.1.3.2 UDPglucose 4-epimerase C00043 = C00203 UDP-N-acetyl-D-glucosamine(aq) = UDP-N-acetyl-D-galactosamine(aq) 0.38 310.15 3251 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67PLO/CLE_1130 67PLO/CLE radioactivity and paper chromatography C 4.1.3.8 ATP citrate(pro-3S)-lyase C00002 + C00158 + C00010 = C00008 + C00009 + C00024 + C00036 ATP(aq) + citrate(aq) + CoA(aq) = ADP(aq) + phosphate(aq) + acetyl-CoA(aq) + oxaloacetate(aq) 1.2 298.15 8.1 3252 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83BRA_4 83BRA calorimetry A 1.1.1.1 alcohol dehydrogenase C06142 + C00003 = C01412 + C00004 1-butanol(aq) + NAD(aq) = butanal(aq) + NADH(aq) 298.15 8.8 3253 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76HIL/ATT_1397 76HIL/ATT enzymatic assay and spectrophotometry B 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.3 303.15 7.3 3254 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ALE_444 61ALE enzymatic assay B 2.4.1.20 cellobiose phosphorylase C00185 + C00009 = C00031 + C00103 cellobiose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.23 310.15 7 3255 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52MEY/SHA_815 52MEY/SHA calorimetry B 3.1.3.2 acid phosphatase C00227 + C00001 = C00033 + C00009 acetyl phosphate(aq) + H2O(l) = acetate(aq) + orthophosphate(aq) 306.15 5.6 3256 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55WOL/KAP_75 55WOL/KAP spectrophotometry C 1.1.1.17 mannitol-1-phosphate dehydrogenase C00644 + C00003 = C00085 + C00004 D-mannitol 1-phosphate(aq) + NAD(aq) = D-fructose 6-phosphate(aq) + NADH(aq) 0.005 298.15 7 3257 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83BRA_28 83BRA calorimetry A 1.1.1.1 alcohol dehydrogenase C05979 + C00003 = C00479 + C00004 1-propanol(aq) + NAD(aq) = propanal(aq) + NADH(aq) 298.15 8.8 3258 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61WOO/STJ_361 61WOO/STJ enzymatic assay and spectrophotometry B 2.1.3.1 methylmalonyl-CoA carboxyltransferase C00036 + C00100 = C00022 + C02557 oxaloacetate(aq) + propanoyl-CoA(aq) = pyruvate(aq) + methylmalonyl-CoA(aq) 1.9 303.15 6.5 3259 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50COR/VEL_252 50COR/VEL enzymatic assay and spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.0984 298.15 7.09 3260 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50COR/VEL_252 50COR/VEL enzymatic assay and spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.193 298.15 7.85 3261 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50COR/VEL_252 50COR/VEL enzymatic assay and spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.187 298.15 8.1 3262 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50COR/VEL_252 50COR/VEL enzymatic assay and spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.156 298.15 7.08 3263 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.169 328.15 7.4 3264 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.199 331.95 7.4 3265 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.246 343.75 7.4 3266 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.146 320.25 7.4 3267 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.226 338.15 7.4 3268 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85TEW/GOL2_1295 85TEW/GOL2 HPLC A 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.17 325.25 7.4 3269 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MAT/STR_533 66MAT/STR spectrophotometry B 2.6.1.33 dTDP-4-amino-4,6-dideoxy-D-glucose transaminase C04268 + C00026 = C11907 + C00025 dTDP-4-amino-4,6-dideoxy-D-glucose(aq) + 2-oxoglutarate(aq) = dTDP-4-dehydro-6-deoxy-D-glucose(aq) + L-glutamate(aq) 2 310.15 7 3270 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.79E-06 298.15 0.25 6.99 3271 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.36E-06 298.15 0.25 6.96 3272 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 6.91E-06 298.15 0.25 7.22 3273 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.17E-05 298.15 0.25 7.72 3274 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.28E-05 298.15 0.25 7.8 3275 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 1.15E-06 298.15 0.25 6.41 3276 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 9.49E-07 298.15 0.25 6.49 3277 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.54E-06 298.15 0.25 7.03 3278 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.36E-06 298.15 0.25 7.03 3279 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 6.1E-05 298.15 0.25 8.05 3280 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.11E-06 298.15 0.25 6.98 3281 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.82E-06 298.15 0.25 6.98 3282 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.84E-06 298.15 0.25 6.98 3283 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.72E-06 298.15 0.25 6.96 3284 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.77E-06 298.15 0.25 6.98 3285 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.13E-06 298.15 0.25 6.97 3286 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.52E-06 311.15 0.5 7 3287 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 5.4E-06 311.15 1 7 3288 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.36E-06 311.15 0.25 7 2 3289 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.64E-06 303.15 0.25 7 3290 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 1.98E-06 298.15 0.25 7 3291 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 1.98E-06 298.15 0.25 7 3292 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 5.53E-06 298.15 0.25 6.98 3293 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.22E-06 298.15 0.25 6.98 3294 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.19E-06 311.15 0.25 7 2.52 3295 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 2.22E-05 298.15 0.25 7.72 3296 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 5.44E-06 298.15 0.25 6.98 3297 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 3.8E-06 311.15 0.0595 7 3298 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 1.09E-06 298.15 0.25 6.41 3299 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=82GUY_115 82GUY spectrophotometry A 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 4.19E-06 298.15 0.25 6.98 3300 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 8.24 3301 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 8.11 3302 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 313.15 7.98 3303 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 313.15 8.03 3304 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 320.15 8.06 3305 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 320.15 8.14 3306 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 8.04 3307 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 320.15 8.11 3308 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 313.15 7.99 3309 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 7.8 3310 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1154 85GAJ/GOL calorimetry A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 298.15 7.92 3311 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94TEW/GOL_1140 94TEW/GOL calorimetry A 4.1.99.1 tryptophanase C00078 + C00001 = C00463 + C00022 + C00014 L-tryptophan(aq) + H2O(l) = indole(aq) + pyruvate(aq) + ammonia(aq) 298.15 7.82 3312 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75IZU/REE_1376 75IZU/REE B 5.3.1.20 ribose isomerase C00121 = C00309 D-ribose(aq) = D-ribulose(aq) 0.39 310.15 7.5 3313 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87HSU/WED_1551 87HSU/WED radioactivity A 2.1.3.2 aspartate carbamoyl-transferase C00169 + C00049 = C00009 + C00438 carbamoyl phosphate(aq) + L-aspartate(aq) = orthophosphate(aq) + N-carbamoyl-L-aspartate(aq) 5900 303.15 7 3314 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62WIL/SNE_357 62WIL/SNE spectrophotometry B 2.1.2.7 D-alanine 2-hydroxymethyltransferase C03059 + C00101 = C00143 + C00740 + C00001 2-hydroxymethylserine(aq) + tetrahydrofolate(aq) = 5,10-methylenetetrahydrofolate(aq) + D-serine(aq) + H2O(1) 8 311.15 7.5 3315 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58MAL/OCH_673 58MAL/OCH spectrophotometry B 2.7.4.14 cytidylate kinase C00002 + C00239 = C00008 + C00705 ATP(aq) + dCMP(aq) = ADP(aq) + dCDP(aq) 1.49 303.15 7.5 3316 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75PIE/GUY_388 75PIE/GUY spectrophotometry A 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 12.3 311.15 0.25 7.03 3317 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75PIE/GUY_388 75PIE/GUY spectrophotometry A 2.3.1.6 choline O-acetyltransferase C00024 + C00114 = C00010 + C01996 acetyl-CoA(aq) + choline(aq) = CoA(aq) + O-acetylcholine(aq) 11.7 298.15 0.25 7.03 3318 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1315 84TEW/GOL microcalorimetry A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 344.15 7.4 3319 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1315 84TEW/GOL microcalorimetry A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 331.85 7.4 3320 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1315 84TEW/GOL microcalorimetry A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 298.15 7.4 3321 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1315 84TEW/GOL microcalorimetry A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 313.25 7.4 3322 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.892 306.15 7.5 3323 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.004 331.85 7.5 3324 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.094 344.15 7.5 3325 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.199 358.15 7.5 3326 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.157 353.15 7.5 3327 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.964 322.15 7.5 3328 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.866 298.15 7.5 3329 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84TEW/GOL_1314 84TEW/GOL HPLC A 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.936 313.15 7.5 3330 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MEL/WOO_1106 64MEL/WOO spectrophotometry and radioactivity C 4.1.2.14 2-dehydro-3-deoxyphosphogluconate aldolase C04442 = C00022 + C00118 6-phospho-2-dehydro-3-deoxy-D-gluconate(aq) = pyruvate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.0012 298.15 8 3331 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82SUE/KAT_221 82SUE/KAT spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.045 298.15 8 3332 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1540 310.15 7 2.66 3333 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1130 310.15 7 3.13 3334 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 817 310.15 7 3.48 3335 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 586 310.15 7 3.83 3336 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 490 310.15 7 4.08 3337 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 288 310.15 7 4.75 3338 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 306 310.15 7 5.52 3339 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 670 310.15 7 3.78 3340 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 622 310.15 7 3.68 3341 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 288 310.15 7 5.7 3342 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 412 310.15 7 4.21 3343 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 353 310.15 7 4.63 3344 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1930 310.15 7 2.63 3345 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 1310 310.15 7 3.05 3346 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MEE/AKE_258 78MEE/AKE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 975 310.15 7 3.42 3347 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66STA/DEN_410 66STA/DEN spectrophotometry, chromatography, and radioactivity B 2.3.1.35 glutamate N-acetyltransferase C00437 + C00025 = C00077 + C00624 N-2-acetyl-L-ornithine(aq) + L-glutamate(aq) = L-ornithine(aq) + N-acetyl-L-glutamate(aq) 0.47 310.15 7.5 3348 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DRA/MEY_250 45DRA/MEY spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 1.3 296.15 8 3349 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DRA/MEY_250 45DRA/MEY spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.92 296.15 8.3 3350 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DRA/MEY_250 45DRA/MEY spectrophotometry C 1.2.1.12 glyceraldehyde-3-phosphate dehydrogenase C00118 + C00009 + C00003 = C00236 + C00004 D-glyceraldehyde 3-phosphate(aq) + orthophosphate(aq) + NAD(aq) = 3-phospho-D-glyceroyl phosphate(aq) + NADH(aq) 0.36 296.15 7.2 3351 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80REK/EGO_335 80REK/EGO calorimetry B 1.12.1.2 hydrogen dehydrogenase C00282 + C00003 = C00004 H2(aq) + NAD(aq) = NADH(aq) 298.15 7.2 3352 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57CAL_638 57CAL chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.69 303.15 6.12 3353 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57CAL_638 57CAL chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.47 303.15 6.81 3354 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57CAL_638 57CAL chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.46 303.15 7.5 3355 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57CAL_638 57CAL chromatography C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.4 303.15 7.88 3356 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66KIM/SUZ_706 66KIM/SUZ spectrophotometry and enzymatic assay B 2.7.7.33 glucose-1-phosphate cytidylyltransferase C00063 + C00103 = C00501 + C00013 CTP(aq) + D-glucose 1-phosphate(aq) = CDPglucose(aq) + pyrophosphate(aq) 0.57 310.15 8.5 3357 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56DIC/WIL_1333 56DIC/WIL chromatography and spectrophotometry C 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.67 310.15 7.4 3358 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GAL/SVE_1024 82GAL/SVE spectrophotometry C 3.5.1.14 aminoacylase C02712 + C00001 = C00033 + C00073 N-acetyl-L-methionine(aq) + H2O(l) = acetate(aq) + L-methionine(aq) 3.7 298.15 7.5 3359 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 9.31 298.15 0.1 7.5 3360 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 10.8 310.15 0.1 7.5 3361 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 36.1 298.15 0.1 7.5 2.7 3362 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 46.1 298.15 0.1 7.5 2.52 3363 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 64.8 298.15 0.1 7.5 2.15 3364 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 48.3 298.15 0.044 7.5 2.7 3365 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 77.7 298.15 0.044 7.5 2.1 3366 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 37.9 298.15 0.07 7.5 2.7 3367 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 67.3 298.15 0.07 7.5 2.1 3368 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 21.5 298.15 0.15 7.5 3 3369 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 31.2 298.15 0.15 7.5 2.7 3370 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 12.7 298.15 0.15 7.5 3371 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 59.7 298.15 0.15 7.5 2.1 3372 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 21.3 298.15 0.1 7.5 3 3373 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 46.8 298.15 0.15 7.5 2.4 3374 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 11.4 298.15 0.044 7.5 3375 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 66.8 298.15 0.044 7.5 2.4 3376 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 52.5 298.15 0.1 7.5 2.4 3377 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 12.2 298.15 0.1 7.5 3378 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 23.3 298.15 0.07 7.5 3 3379 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 16.4 298.15 0.07 7.5 3.3 3380 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 16.4 298.15 0.07 7.5 3.3 3381 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 11.6 298.15 0.07 7.5 3382 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 54.5 298.15 0.07 7.5 2.4 3383 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 69 298.15 0.1 7.5 2 3384 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 27.6 298.15 0.044 7.5 3 3385 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=69BLA_1166 69BLA spectrophotometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 63.8 298.15 0.07 7.5 2.22 3386 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76MUR_1413 76MUR enzymatic assay and spectrophotometry B 5.4.2.8 phosphomannomutase C00636 = C00275 D-mannose 1-phosphate(aq) = D-mannose 6-phosphate(aq) 8.5 303.15 7 3387 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AUR/KLE_209 68AUR/KLE spectrophotometry B 1.1.1.108 carnitine dehydrogenase C00318 + C00003 = C02636 + C00004 L-carnitine(aq) + NAD(aq) = 3-dehydrocarnitine(aq) + NADH(aq) 0.00013 303.15 7 3388 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AUR/KLE_209 68AUR/KLE spectrophotometry B 1.1.1.108 carnitine dehydrogenase C00318 + C00003 = C02636 + C00004 L-carnitine(aq) + NAD(aq) = 3-dehydrocarnitine(aq) + NADH(aq) 0.0013 303.15 8 3389 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68AUR/KLE_209 68AUR/KLE spectrophotometry B 1.1.1.108 carnitine dehydrogenase C00318 + C00003 = C02636 + C00004 L-carnitine(aq) + NAD(aq) = 3-dehydrocarnitine(aq) + NADH(aq) 0.013 303.15 9 3390 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/KIE_1385 35MEY/KIE polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 7.3 273.15 3391 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/KIE_1385 35MEY/KIE polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 3.45 311.15 3392 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/KIE_1385 35MEY/KIE polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 2.3 333.15 3393 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35MEY/KIE_1385 35MEY/KIE polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 3.85 301.15 3394 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61BER/BER_1431 61BER/BER radioactivity and spectrophotometry A 6.1.1.9 valine-tRNA ligase C00002 + C00183 + C01653 = C00020 + C00013 + C02554 ATP + L-valine + tRNA(Val) = AMP + diphosphate + L-Valyl-tRNA(Val) 0.32 310.15 7 3395 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 4000 308.15 7 3 3396 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 170 308.15 7 1.7 3397 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 66 308.15 7 1 3398 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1500 308.15 7.8 3 3399 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 650 308.15 7.8 2.7 3400 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 370 308.15 7.8 2.4 3401 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 180 308.15 7.8 2 3402 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 74 308.15 7.8 1 3403 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 920 308.15 6.2 1.6 3404 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 510 308.15 6.2 1.3 3405 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 370 308.15 7.8 3 3406 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 500 308.15 7.8 3 3407 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3000 308.15 7.8 3 3408 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 61 308.15 7.8 2 3409 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 61 308.15 7.8 2 3410 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 430 308.15 7.8 2 3411 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 310 308.15 7.8 2.7 3412 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 450 308.15 7.8 2.3 3413 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 400 308.15 7.8 1.92 3414 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1200 308.15 6.15 2 3415 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 180 308.15 7.82 2 3416 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2600 308.15 6.2 2.4 3417 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1200 308.15 6.2 2 3418 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 420 308.15 6.2 1.4 3419 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 140 308.15 6.2 1 3420 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 310 308.15 6.2 1 3421 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1200 308.15 7 2 3422 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 400 308.15 7 1.6 3423 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 440 308.15 7.8 2 3424 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 180 308.15 7.8 1.6 3425 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 110 308.15 7.8 1.3 3426 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 74 308.15 7.8 1 3427 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 830 313.15 7.8 2 3428 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 830 313.15 7.8 2 3429 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 420 299.15 7.8 2 3430 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 320 313.15 7.8 1.6 3431 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 230 308.15 7.8 1.6 3432 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 210 302.15 7.8 1.6 3433 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 160 299.15 7.8 1.6 3434 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 130 293.15 7.8 1.6 3435 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 140 302.15 7.8 1.3 3436 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 82 293.15 7.8 1.3 3437 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 160 308.15 7.8 1 3438 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 110 302.15 7.8 1 3439 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 100 299.15 7.8 1 3440 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 81 293.15 7.8 1 3441 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 270 308.15 7.8 2.7 3442 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 970 308.15 7.8 2.22 3443 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 71 308.15 7.8 2.1 3444 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 72 308.15 7.8 2 3445 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 170 308.15 7.8 2.4 3446 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 110 308.15 7.8 2.22 3447 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 97 308.15 7.8 1.1 3448 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 82 308.15 7.8 2 3449 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=5.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 372 308.15 7.8 2.4 3450 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 270 308.15 7 2 3451 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 280 308.15 7 2 3452 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 82 308.15 7.8 1.4 3453 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 89 308.15 7 1 3454 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 170 308.15 7.8 1.3 3455 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 130 308.15 8.93 2 3456 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 98 308.15 7 1.4 3457 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2600 308.15 6.2 2 3458 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1000 308.15 7.8 2.4 3459 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=6.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 280 293.15 7.8 2 3460 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 280 293.15 7.8 2 3461 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 130 308.15 7.8 2.4 3462 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 350 308.15 7.8 3 3463 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 72 308.15 7.8 2 3464 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 570 308.15 6.42 2 3465 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 690 308.15 7 2.4 3466 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 110 308.15 7.8 1.7 3467 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 190 308.15 7 1.3 3468 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 660 308.15 7.8 2 3469 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 230 313.15 7.8 1.3 3470 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=7.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 540 308.15 7.8 3.3 3471 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=8.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 900 308.15 7.8 3.3 3472 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=8.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 490 302.15 7.8 2 3473 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=8.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 110 299.15 7.8 1.3 3474 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=8.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 400 308.15 7.8 2.4 3475 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=8.&T1=84DEM_1065 84DEM radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 530 308.15 7.8 3 3476 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76FAR/CRY_1529 76FAR/CRY radioactivity B 2.7.7.4 sulfate adenylyltransferase C00002 + C00059 = C00013 + C00224 ATP(aq) + sulfate(aq) = pyrophosphate(aq) + adenylylsulfate(aq) 2.5E-09 303.15 8 3477 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_48 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C01507 + C00003 = C00247 + C00004 L-iditol(aq) + NAD(aq) = L-sorbose(aq) + NADH(aq) 0.00423 298.15 7 3478 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59HOL_48 59HOL spectrophotometry B 1.1.1.9 D-xylulose reductase C01507 + C00003 = C00247 + C00004 L-iditol(aq) + NAD(aq) = L-sorbose(aq) + NADH(aq) 0.0423 298.15 8 3479 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KIS/TEW_992 99KIS/TEW calorimetry A 3.5.1.2 glutaminase C00064 + C00001 = C00025 + C00014 L-glutamine(aq) + H2O(l) = L-glutamate(aq) + ammonia(aq) 298.15 5.14 3480 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_314 68VEE fluorimetry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.0242 298.15 0.25 6.9 3481 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_314 68VEE fluorimetry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.0156 311.15 0.25 6.9 3482 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74FRA/LEE_1306 74FRA/LEE C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.03 323.15 7 3483 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ASH/WAH_1368 60ASH/WAH enzymatic assay and spectrophotometry C 5.3.1.12 glucuronate isomerase C00333 = C00558 D-galacturonate(aq) = D-tagaturonate(aq) 0.25 310.15 8 3484 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ASH/WAH_1368 60ASH/WAH enzymatic assay and spectrophotometry C 5.3.1.12 glucuronate isomerase C00333 = C00558 D-galacturonate(aq) = D-tagaturonate(aq) 1.4 310.15 8 3485 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ASH/WAH_1369 60ASH/WAH enzymatic assay and spectrophotometry B 5.3.1.12 glucuronate isomerase C00191 = C00905 D-glucuronate(aq) = D-fructuronate(aq) 0.82 310.15 8 3486 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62BLA_243 62BLA spectrophotometry D 1.2.1.11 aspartate-semialdehyde dehydrogenase C00441 + C00006 + C00009 = C03082 + C00005 L-aspartate-4-semialdehyde(aq) + NADP(aq) + orthophosphate(aq) = L-4-aspartyl phosphate(aq) + NADPH(aq) 33 298.15 8 3487 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53LYN/OCH_116 53LYN/OCH D 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 0.0019 298.15 7 3488 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/EGG_315 69VEE/EGG fluorimetry A 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 0.0156 311.15 0.25 6.9 3489 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06TAN/SUR_1609 06TAN/SUR chromatography C 2.3.1.169 CO-methylating acetyl-CoA synthase C00024 + C06021 = C00237 + C06020 + C00010 acetyl-CoA(aq) + corrinoid protein(aq) = carbon monoxide(aq) + methylcorrinoid protein(aq) + CoA(aq) 5E-05 298.15 8 3490 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57KAR/GRE_347 57KAR/GRE spectrophotometry B 2.1.2.1 glycine hydroxymethyltransferase C00037 + C00084 = C00188 glycine(aq) + acetaldehyde(aq) = L-threonine(aq) 56 310.15 7.6 3491 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_908 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C05402 + C00001 = C00124 + C00031 -D-melibiose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 40 318.15 4.5 3492 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_907 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C05402 + C00001 = C00124 + C00031 -D-melibiose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 53 318.15 4.5 3493 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KAT/SUE_222 83KAT/SUE spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.045 298.15 7.88 3494 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KAT/SUE_222 83KAT/SUE spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.037 298.15 7.93 3495 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KAT/SUE_222 83KAT/SUE spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.046 298.15 8.02 3496 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KAT/SUE_222 83KAT/SUE spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.038 298.15 8.06 3497 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83KAT/SUE_222 83KAT/SUE spectrophotometry B 1.1.1.153 sepiapterin reductase C02953 + C00006 = C00835 + C00005 7,8-dihydrobiopterin(aq) + NADP(aq) = sepiapterin(aq) + NADPH(aq) 0.039 298.15 7.95 3498 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97PES/PRI_903 97PES/PRI GC + MS B 3.2.1.3 glucan 1,4--glucosidase C00252 + C00001 = 2 C00031 -isomaltose(aq) + H2O(l) = 2 D-glucose(aq) 81 318.15 4.5 3499 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62BRU/JOU_1118 62BRU/JOU radioactivity and spectrophotometry A 4.1.3.3 N-acetylneuraminate lyase C00270 = C00645 + C00022 N-acetylneuraminate(aq) = N-acetyl-D-mannosamine(aq) + pyruvate(aq) 0.096 310.15 7.2 3500 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_753 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 8900 311.15 6.47 3501 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_753 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 83000 311.15 7.03 3502 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86CAS/VEE2_753 86CAS/VEE2 enzymatic assay and spectrophotometry B 1.1.1.49&3.1.1.31 glucose-6-phosphate dehydrogenase and 6-phosphogluconolactonase C00092 + C00006 + C00001 = C00345 + C00005 D-glucose 6-phosphate(aq) + NADP(aq) + H2O(l) = 6-phospho-D-gluconate(aq) + NADPH(aq) 1500 311.15 6.03 3503 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 28 311.15 0.25 6.88 3504 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 41 311.15 0.25 6.89 3505 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 45 311.15 0.25 6.91 3506 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 61 311.15 0.25 6.98 3507 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 58 311.15 0.25 6.99 3508 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 59 311.15 0.25 7 3509 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 71 311.15 0.25 7.01 3510 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 35 311.15 0.25 6.92 3511 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 68 311.15 0.25 6.97 3512 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 41 311.15 0.25 6.94 3513 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_583 68VEE spectrophotometry B 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 78 311.15 0.25 7.02 3514 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 7.1E-06 298.15 7.4 3515 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00029 298.15 8.35 3516 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00015 298.15 8.7 3517 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 5E-05 298.15 8.1 3518 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00033 298.15 8.9 3519 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0002 298.15 8.2 3520 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 3.1E-05 298.15 7.9 3521 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 9.6E-06 298.15 7.4 3522 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL3_96 37EUL/ADL3 spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00029 298.15 8.3 3523 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 980 303.15 7.3 2.3 3524 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1280 303.15 8 3 3525 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 300 303.15 8 2.3 3526 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 152 303.15 8 1.96 3527 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 650 303.15 8 2.6 3528 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 330 303.15 8 2.3 3529 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 158 303.15 8 1.96 3530 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 126 303.15 8 1.82 3531 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 184 303.15 8 1.96 3532 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2820 303.15 8 3 3533 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1050 303.15 8 2.6 3534 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 330 303.15 8 2.12 3535 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 228 303.15 8 1.96 3536 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 116 303.15 8 1.82 3537 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 195 303.15 8 2.12 3538 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 2230 303.15 8 3 3539 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 495 303.15 8 2.6 3540 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3300 303.15 7.3 3 3541 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 144 303.15 8 1.82 3542 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1870 303.15 8 3 3543 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 536 303.15 8 2.3 3544 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 536 303.15 8 2.3 3545 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 420 303.15 8 2.3 3546 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 772 303.15 8 2.6 3547 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 215 303.15 8 2.12 3548 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 255 303.15 8 2.12 3549 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1500 303.15 7.3 2.6 3550 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=86DAL/REN_1067 86DAL/REN spectrophotometry B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 167 303.15 8 1.82 3551 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_770 49MEY/GRE chemical analysis C 3.1.3.1 alkaline phosphatase C00092 + C00001 = C00031 + C00009 D-glucose 6-phosphate(aq) + H2O(l) = D-glucose(aq) + orthophosphate(aq) 62 311.15 8.5 3552 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1281 43MEY/JUN chemical analysis and polarimetry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 24 303.15 7 3553 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1281 43MEY/JUN chemical analysis and polarimetry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 25 333.15 7 3554 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1281 43MEY/JUN chemical analysis and polarimetry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 21 312.15 7 3555 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86KIM/LEE_601 86KIM/LEE C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.011 303.15 7.4 3556 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE_1163 53KRE polarimetry and manometry A 4.2.1.3 aconitate hydratase C00311 = C00158 isocitrate(aq) = citrate(aq) 14.7 298.15 7.4 3557 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64MCN/DAM_1429 64MCN/DAM radioactivity C 5.5.1.3 tetrahydroxypteridine cycloisomerase C03178 = C03314 tetrahydroxypteridine(aq) = xanthine-8-carboxylate(aq) 620 296.15 7.5 3558 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53KRE_1160 53KRE polarimetry and manometry A 4.2.1.3 aconitate hydratase C00311 = C00417 + C00001 isocitrate(aq) = cis-aconitate(aq) + H2O(l) 0.47 298.15 7.4 3559 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/VEL_692 74GUY/VEL enzymatic assay and spectrophotometry A 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.22 311.15 0.25 7.07 3 3560 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89SAN/SIN_1362 89SAN/SIN enzymatic assay + spectrophotometry C 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.37 303.15 8.1 3561 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71RUD/JOH_833 71RUD/JOH calorimetry B 3.1.4.1 phosphodiesterase I C00968 + C00001 = C00360 2'-deoxyadenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = 2'-deoxyadenosine 5'-monophosphate(aq) 298.15 7.3 3562 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71RUD/JOH_834 71RUD/JOH calorimetry B 3.1.4.1 phosphodiesterase I C00943 + C00001 = C00130 inosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = IMP(aq) 298.15 7.3 3563 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STA_395 55STA spectrophotometry C 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0135 301.15 8 3564 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55WIL/MCI_1208 55WIL/MCI chemical analysis C 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.023 310.15 6.8 3565 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62CHA/VEI_72 62CHA/VEI spectrophotometry B 1.1.1.14 L-iditol dehydrogenase C00379 + C00003 = C00310 + C00004 xylitol(aq) + NAD(aq) = D-xylulose(aq) + NADH(aq) 0.021 296.15 8.6 3566 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61LED_488 61LED fluorescence and chemical analysis C 2.5.1.3 thiamin-phosphate pyrophosphorylase C04752 + C04327 = C00013 + C01081 2-methyl-4-amino-5-hydroxymethylpyrimidine diphosphate(aq) + 4-methyl-5-(2-phosphonoxyethyl)-thiazole(aq) = pyrophosphate(aq) + thiamine monophosphate(aq) 6 310.15 9.2 3567 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73SOM/COS_1418 73SOM/COS chromatography and radioactivity C 5.4.3.5 D-ornithine 4,5-aminomutase C00515 = C03943 D-ornithine(aq) = D-threo-2,4-diaminopentanoate(aq) 0.9 310.15 9 3568 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78RAO/COH_650 78RAO/COH NMR B 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 2.6 277.15 7 3569 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54MIT/DAV_1168 54MIT/DAV spectrophotometry C 4.2.1.10 3-dehydroquinate dehydratase C00944 = C02637 + C00001 3-dehydroquinate(aq) = 3-dehydroshikimate(aq) + H2O(l) 15 302.15 7.4 3570 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93WIL/TOO_1708 93WIL/TOO calorimetry A 3.5.1.14 aminoacylase C03519 + C00001 = C00033 + C00079 N-acetyl-L-phenylalanine(aq) + H2O(l) = acetate(aq) + L-phenylalanine(aq) 298.15 7.5 3571 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93WIL/TOO_1702 93WIL/TOO calorimetry A 3.5.1.14 aminoacylase C02712 + C00001 = C00033 + C00073 N-acetyl-L-methionine(aq) + H2O(l) = acetate(aq) + L-methionine(aq) 298.15 7.5 3572 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00471 298.25 7.37 3573 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00559 304.25 7.33 3574 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00507 310.15 7.3 3575 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00669 310.25 7.29 3576 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00763 316.25 7.35 3577 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00854 310.15 7.24 3578 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00331 286.15 7.43 3579 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1212 86GOL/GAJ HPLC A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00374 292.15 7.39 3580 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 298.15 7.27 3581 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 304.15 7.28 3582 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 310.15 7.3 3583 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 310.15 7.32 3584 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 310.15 7.28 3585 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86GOL/GAJ_1213 86GOL/GAJ calorimetry A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 310.15 7.27 3586 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86KUP/FER_661 86KUP/FER NMR C 2.7.4.3 adenylate kinase C00002 + C00008 = C03483 + C00020 ATP(aq) + ADP(aq) = adenosine 5'-tetraphosphate(aq) + AMP(aq) 0.1 303.15 8 3587 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02TEW/HAW_1643 02TEW/HAW calorimetry A 4.2.1.10 3-dehydroquinate dehydratase C00944 = C02637 + C00001 3-dehydroquinate(aq) = 3-dehydroshikimate(aq) + H2O(l) 298.15 0.069 7.42 3588 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02TEW/HAW_1642 02TEW/HAW calorimetry A 4.6.1.3 3-dehydroquinate synthase C04691 = C00944 + C00009 2-dehydro-3-deoxy-D-arabino-heptonate 7-phosphate(aq) = 3-dehydroquinate(aq) + orthophosphate(aq) 298.15 0.07 7.46 3589 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02TEW/HAW_1641 02TEW/HAW chromatography A 4.6.1.3 3-dehydroquinate synthase C00944 = C02637 + C00001 3-dehydroquinate(aq) = 3-dehydroshikimate(aq) + H2O(l) 4.6 298.15 0.065 7.5 3590 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_513 98TEW/KIS HPLC A 2.6.1.2 alanine aminotransferase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.72 298.15 6.6 3591 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_513 98TEW/KIS HPLC A 2.6.1.2 alanine aminotransferase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.78 298.15 7.23 3592 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_517 98TEW/KIS HPLC A 2.6.1.5 tyrosine aminotransferase C00082 + C00026 = C01179 + C00025 L-tyrosine(aq) + 2-oxoglutarate(aq) = 4-hydroxyphenylpyruvate(aq) + L-glutamate(aq) 0.876 298.15 7.74 3593 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_517 98TEW/KIS HPLC A 2.6.1.5 tyrosine aminotransferase C00082 + C00026 = C01179 + C00025 L-tyrosine(aq) + 2-oxoglutarate(aq) = 4-hydroxyphenylpyruvate(aq) + L-glutamate(aq) 0.88 298.15 7.45 3594 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_516 98TEW/KIS calorimetry A 2.6.1.5 tyrosine aminotransferase C00079 + C00026 = C00166 + C00025 L-phenylalanine(aq) + 2-oxoglutarate(aq) = phenylpyruvate(aq) + L-glutamate(aq) 298.15 7.3 3595 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_515 98TEW/KIS HPLC A 2.6.1.5 tyrosine aminotransferase C00079 + C00026 = C00166 + C00025 L-phenylalanine(aq) + 2-oxoglutarate(aq) = phenylpyruvate(aq) + L-glutamate(aq) 1.069 298.15 7.57 3596 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_515 98TEW/KIS HPLC A 2.6.1.5 tyrosine aminotransferase C00079 + C00026 = C00166 + C00025 L-phenylalanine(aq) + 2-oxoglutarate(aq) = phenylpyruvate(aq) + L-glutamate(aq) 1.024 298.15 7.46 3597 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_514 98TEW/KIS calorimetry A 2.6.1.2 alanine aminotransferase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 298.15 7.37 3598 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/KIS_518 98TEW/KIS calorimetry A 2.6.1.5 tyrosine aminotransferase C00082 + C00026 = C01179 + C00025 L-tyrosine(aq) + 2-oxoglutarate(aq) = 4-hydroxyphenylpyruvate(aq) + L-glutamate(aq) 298.15 7.64 3599 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02KIM/BAK_1570 02KIM/BAK spectrophotometry B 2.6.1.37 (2-aminoethyl)phosphonate-pyruvate transferase C03557 + C00022 = C03167 + C00041 (2-aminoethyl)phosphonate(aq) + pyruvate(aq) = 2-phosphonoacetaldehyde(aq) + L-alanine(aq) 0.5 298.15 8.5 3600 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64AVI_424 64AVI spectrophotometry B 2.4.1.13 sucrose synthase C00029 + C00095 = C00015 + C00089 UDPglucose(aq) + D-fructose(aq) = UDP(aq) + sucrose(aq) 1.6 303.15 7.6 3601 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53COH_1294 53COH spectrophotometry C 5.3.1.3 arabinose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.18 310.15 7 3602 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1153 85GAJ/GOL gas chromatography A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.16 298.15 7.63 3603 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1153 85GAJ/GOL gas chromatography A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 2.66 320.05 7.99 3604 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1153 85GAJ/GOL gas chromatography A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.25 298.15 7.3 3605 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1153 85GAJ/GOL gas chromatography A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 3.28 309.41 7.99 3606 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85GAJ/GOL_1153 85GAJ/GOL gas chromatography A 4.2.1.2 fumarate hydratase C00122 + C00001 = C00149 fumarate(aq) + H2O(l) = (S)-malate(aq) 4.14 298.15 7.99 3607 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64SAT/TSU_1298 64SAT/TSU polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1 323.15 7.65 3608 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70ALB_670 70ALB enzymatic assay B 2.7.4.10 nucleoside-triphosphate-adenylate kinase C00044 + C00020 = C00008 + C00035 GTP(aq) + AMP(aq) = ADP(aq) + GDP(aq) 0.82 298.15 8.5 3609 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1078 56POD/MOR calorimetry B 3.6.1.32 myosin ATPase C00081 + C00001 = C00104 + C00009 ITP(aq) + H2O(l) = IDP(aq) + orthophosphate(aq) 293.15 8 3610 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 3611 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 3612 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 3613 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 3614 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 293.15 8 3615 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56POD/MOR_1073 56POD/MOR calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 292.2 8 3616 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67GRO_1088 67GRO spectrophotometry B 4.1.2.4 deoxyribose-phosphate aldolase C00673 = C00118 + C00084 2-deoxy-D-ribose 5-phosphate(aq) = D-glyceraldehyde 3-phosphate(aq) + acetaldehyde(aq) 0.00025 295.15 7.5 3617 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.64 303.15 7.4 2.05 3618 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 2.19 303.15 7.4 1.77 3619 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.05 303.15 7.4 3.22 3620 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 2 303.15 7.4 1.89 3621 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.28 303.15 7.4 3 3622 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.14 303.15 7.4 3 3623 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.26 303.15 7.4 2.52 3624 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.41 303.15 7.4 2.3 3625 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.84 303.15 7.4 2.05 3626 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 2.14 303.15 7.4 1.77 3627 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.43 303.15 7.4 2.52 3628 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.4 303.15 7.4 2.7 3629 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.66 303.15 7.4 2.3 3630 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.53 303.15 7.4 2.15 3631 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.92 303.15 7.4 1.89 3632 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.17 303.15 7.4 2.7 3633 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 1.76 303.15 7.4 2.15 3634 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR_1502 06AIR radioactivity A 6.1.1.19 arginine-tRNA ligase C00002 + C00062 + C01636 = C00020 + C00013 + C02163 ATP(aq) + L-arginine(aq) + tRNA-Arg(aq) = AMP(aq) + pyrophosphate(aq) + L-arginyl-tRNA-Arg(aq) 0.97 303.15 7.4 3.22 3635 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67HIR/GRE_538 67HIR/GRE spectrophotometry and radioactivity D 2.6.1.52 phosphoserine transaminase C03232 + C00025 = C00026 + C01005 3-phosphonooxypyruvate(aq) + L-glutamate(aq) = 2-oxoglutarate(aq) + O-phospho-L-serine(aq) 0.15 298.15 8.2 3636 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68MIZ/WEE_1200 68MIZ/WEE enzymatic assay and spectrophotometry C 4.2.1.58 crotonoyl-[acyl-carrier-protein] hydratase C04618 = C04246 + C00001 (3R)-3-hydroxybutanoyl-[acyl-carrier protein](aq) = cis-but-2-enoyl-[acyl-carrier protein](aq) + H2O(l) 0.32 298.15 8.5 3637 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83BRA_33 83BRA calorimetry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 298.15 8.9 3638 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91GOL/BEL_901 91GOL/BEL calorimetry A 3.2.1.3 glucan 1,4--glucosidase C00713 + 2 C00001 = 3 C00031 panose(aq) + 2 H2O(l) = 3 D-glucose(aq) 298.15 6 3639 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60ICH/FUR_1238 60ICH/FUR B 5.1.1.5 lysine racemase C00047 = C00739 L-lysine(aq) = D-lysine(aq) 1 303.15 8 3640 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TAV/LEE_483 87TAV/LEE NMR B 2.4.2.10 orotate phosphoribosyltransferase C01103 + C00013 = C00295 + C00119 orotidine 5'-phosphate(aq) + pyrophosphate(aq) = orotate(aq) + 5-phospho--D-ribose 1-diphosphate(aq) 1.4 301.15 8 3641 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79VAN_1688 79VAN radioactivity C 3.6.1.a inosine triphosphate pyrophosphohydrolase C00081 + C00001 = C00130 + C00013 ITP(aq) + H2O(l) = IMP(aq) + pyrophosphate(aq) 38000 303.15 8.5 3642 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75SCH/GRE_218 75SCH/GRE spectrophotometry C 1.1.1.141 15-hydroxyprostaglandin dehydrogenase (NAD+) C00584 + C00003 = C04707 + C00004 prostaglandin E2(aq) + NAD(aq) = 15-oxo-prostaglandin E2(aq) + NADH(aq) 298.15 7 3643 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75SCH/GRE_218 75SCH/GRE spectrophotometry C 1.1.1.141 15-hydroxyprostaglandin dehydrogenase (NAD+) C00584 + C00003 = C04707 + C00004 prostaglandin E2(aq) + NAD(aq) = 15-oxo-prostaglandin E2(aq) + NADH(aq) 298.15 8 3644 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82BAR/HEB_1277 82BAR/HEB C 5.1.3.18 GDP-D-mannose 3,5-epimerase C00096 = C02280 GDPmannose(aq) = GDP-L-galactose(aq) 0.52 310.15 8 3645 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0023 311.15 7.5 3646 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0925 311.15 8.2 3647 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.191 311.15 8.5 3648 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.138 311.15 9.5 3649 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.365 311.15 9.05 3650 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0061 311.15 9.7 3651 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0049 311.15 7.6 3652 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0239 311.15 7.8 3653 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43BAN_590 43BAN chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.039 311.15 8.55 3654 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69WAN/BAR_1191 69WAN/BAR spectrophotometry C 4.2.1.34 (S)-2-methylmalate dehydratase C02614 = C01732 + C00001 (S)-2-methylmalate(aq) = 2-methylfumarate(aq) + H2O(l) 0.17 298.15 8.2 3655 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61PRA_624 61PRA C 2.7.3.4 taurocyamine kinase C00002 + C01959 = C00008 + C03149 ATP(aq) + taurocyamine(aq) = ADP(aq) + N-w-phosphotaurocyamine(aq) 0.53 303.15 7.1 3656 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80PET/AMI_503 80PET/AMI spectrophotometry C 1.1.1.37&2.6.1.1 malate dehydrogenase and aspartate transaminase C00025 + C00149 + C00003 = C00049 + C00026 + C00004 L-glutamate(aq) + (S)-malate(aq) + NAD(aq) = L-aspartate(aq) + 2-oxoglutarate(aq) + NADH(aq) 4.1E-05 298.15 7.4 3657 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BRA/JAR_217 75BRA/JAR spectrophotometry B 1.1.1.141 15-hydroxyprostaglandin dehydrogenase (NAD+) C04741 + C00003 = C04654 + C00004 prostaglandin E1(aq) + NAD(aq) = 15-oxo-prostaglandin E1(aq) + NADH(aq) 0.065 298.15 6 3658 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BRA/JAR_217 75BRA/JAR spectrophotometry B 1.1.1.141 15-hydroxyprostaglandin dehydrogenase (NAD+) C04741 + C00003 = C04654 + C00004 prostaglandin E1(aq) + NAD(aq) = 15-oxo-prostaglandin E1(aq) + NADH(aq) 0.65 298.15 7 3659 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BRA/JAR_217 75BRA/JAR spectrophotometry B 1.1.1.141 15-hydroxyprostaglandin dehydrogenase (NAD+) C04741 + C00003 = C04654 + C00004 prostaglandin E1(aq) + NAD(aq) = 15-oxo-prostaglandin E1(aq) + NADH(aq) 6.5 298.15 8 3660 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DAV/GIL_82 55DAV/GIL enzymatic assay and spectrophotometry C 1.1.1.25 shikimate dehydrogenase C00493 + C00006 = C02652 + C00005 shikimate(aq) + NADP(aq) = 5-dehydroshikimate(aq) + NADPH(aq) 0.18 303.15 7.8 3661 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DAV/GIL_82 55DAV/GIL enzymatic assay and spectrophotometry C 1.1.1.25 shikimate dehydrogenase C00493 + C00006 = C02652 + C00005 shikimate(aq) + NADP(aq) = 5-dehydroshikimate(aq) + NADPH(aq) 0.036 303.15 7 3662 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DAV/GIL_81 55DAV/GIL spectrophotometry D 1.1.1.24 quinate dehydrogenase C00296 + C00003 = C00944 + C00004 quinate(aq) + NAD(aq) = 5-dehydroquinate(aq) + NADH(aq) 0.00461 305.15 7.2 3663 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68KOH/JAK2_90 68KOH/JAK2 spectrophotometry C 1.1.1.26 glyoxylate reductase C00160 + C00003 = C00048 + C00004 glycolate(aq) + NAD(aq) = glyoxylate(aq) + NADH(aq) 2.4E-07 298.15 8 3664 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 320 308.15 5 3665 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 214 308.15 5 2 3666 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 100 308.15 6 2 3667 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 120 308.15 6.1 2.3 3668 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 100 308.15 6.1 1.72 3669 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 96 308.15 6.1 1.3 3670 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 74 308.15 6.1 0.76 3671 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 63 308.15 7 3672 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 3 3673 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 2.72 3674 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 61 308.15 7 2.3 3675 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 63 308.15 7 2 3676 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 61 308.15 7 1 3677 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 0.7 3678 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 21 308.15 7 2.1 3679 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 58 308.15 7.2 2.1 3680 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 29 308.15 7.2 2.1 3681 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 45 308.15 7.8 3682 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47 308.15 7.8 3 3683 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 45 308.15 7.8 2 3684 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 53 308.15 8 2 3685 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 53 308.15 8 2 3686 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 12 308.15 8 3.05 3687 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47 308.15 9 3688 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47 308.15 10 3689 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 490 298.2 7.8 1.3 3690 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 500 303.5 7.8 2 3691 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 490 308.2 7.8 2 3692 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 400 313.4 7.8 2 3693 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 490 313.4 7.8 1.3 3694 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 140 308.15 6.1 3 3695 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 3696 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 47 308.15 8 3697 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 530 311 7.8 1.3 3698 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49 308.15 7.8 1.3 3699 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 550 308.2 7.8 1.3 3700 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 83 308.15 6.1 1 3701 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 530 303.5 7.8 1.3 3702 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 140 308.15 6.1 3703 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 3 3704 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 440 311 7.8 2 3705 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 156 308.15 6 3706 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 156 308.15 6 3707 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 49 308.15 7 3708 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 42 308.15 8 3.05 3709 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 45 308.15 7.8 1 3710 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 110 308.15 6.1 2 3711 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 39 308.15 7 2.3 3712 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7.2 2.1 3713 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 620 298.2 7.8 2 3714 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 120 308.15 6.1 2.68 3715 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 56 308.15 7 2.68 3716 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_808 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 46 308.15 7 1 3717 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=97YOR/ISH_540 97YOR/ISH spectrophotometry B 2.6.1.- polyamine aminotransferase C00041 + C05665 = C00022 + C00986 L-alanine(aq) + 3-aminopropionaldehyde(aq) = pyruvate(aq) + 1,3-diaminopropane(aq) 2.9 303.15 9 3718 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67BAR_1134 67BAR spectrophotometry C 4.1.3.22 citramalate lyase C02614 = C00033 + C00022 (S)-2-methylmalate(aq) = acetate(aq) + pyruvate(aq) 8.3 298.15 7.4 3719 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64WIL/HOG_1252 64WIL/HOG spectrophotometry B 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.289 300.15 7.1 3720 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64WIL/HOG_1252 64WIL/HOG spectrophotometry B 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.278 300.15 8.7 3721 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63EDM/WRI_195 63EDM/WRI spectrophotometry B 1.1.1.67 mannitol dehydrogenase C00392 + C00003 = C00095 + C00004 D-mannitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.056 310.15 8.05 3722 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SCH/GIF_59 91SCH/GIF spectrophotometry C 1.1.1.14 L-iditol dehydrogenase C01697 + C00003 = C00795 + C00004 galactitol(aq) + NAD(aq) = D-tagatose(aq) + NADH(aq) 0.013 298.15 7 3723 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78ROS/DUB_1604 78ROS/DUB radioactivity C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 12.7 298.15 7.5 3724 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95SCH/TRA_581 95SCH/TRA radioactivity C 2.7.2.3 phosphoglycerate kinase C00002 + C00197 = C00008 + C00236 ATP(aq) + 3-phospho-D-glycerate(aq) = ADP(aq) + 3-phospho-D-glyceroyl phosphate(aq) 0.00015 277.15 7.5 3725 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69BAR_40 69BAR spectrophotometry C 1.1.1.6 glycerol dehydrogenase C00116 + C00003 = C00184 + C00004 glycerol(aq) + NAD(aq) = dihydroxyacetone(aq) + NADH(aq) 0.014 298.15 9 3726 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=50OES/MEY_1283 50OES/MEY spectrophotometry C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 22 311.15 7.3 3727 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 4.23 298.15 8.8 3728 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.73 298.15 8.8 3729 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.27 298.15 8.8 3730 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.73 308.15 8.8 3731 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.6 308.15 8.8 3732 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.08 308.15 8.8 3733 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.22 308.15 8.8 3734 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 2.54 298.15 8.8 3735 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.98 308.15 8.8 3736 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.81 308.15 8.8 3737 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.84 298.15 8.8 3738 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89JEE/SHI_21 89JEE/SHI spectrophotometry D 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 1.33 298.15 8.8 3739 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MAN/LAN_336 75MAN/LAN calorimetry C 1.14.14.3 alkanal monooxygenase (FMN-linked) C02278 + C01847 + C00007 = C02679 + C00061 + C00001 dodecanal(aq) + FMN(reduced) + O2(aq) = dodecanoic acid(aq) + FMN(oxidized) + H2O(l) 280.15 7 3740 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75MAN/LAN_336 75MAN/LAN calorimetry C 1.14.14.3 alkanal monooxygenase (FMN-linked) C02278 + C01847 + C00007 = C02679 + C00061 + C00001 dodecanal(aq) + FMN(reduced) + O2(aq) = dodecanoic acid(aq) + FMN(oxidized) + H2O(l) 298.15 7 3741 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91PAR/HOR_1594 91PAR/HOR chromatography B 3.2.2.2 inosine nucleosidase C00294 + C00001 = C00262 + C00121 inosine(aq) + H2O(l) = hypoxanthine(aq) + D-ribose(aq) 106 310.15 7.5 3742 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 290000 311.15 0.25 6.39 2.56 3743 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 409000 311.15 0.25 6.52 2.56 3744 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 697000 311.15 0.25 6.75 2.56 3745 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 595000 311.15 0.25 6.79 2.56 3746 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1230000 311.15 0.25 7.2 2.56 3747 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1730000 311.15 0.25 7.28 2.56 3748 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1030000 311.15 0.25 7.1 5 3749 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1090000 311.15 0.25 7.1 4 3750 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 6750000 311.15 0.25 6.94 1.52 3751 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 2260000 311.15 0.25 7.11 2.56 3752 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 773000 311.15 0.25 6.82 2.56 3753 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 733000 311.15 0.25 6.91 2.56 3754 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 5400000 311.15 0.25 7 1.7 3755 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 3110000 311.15 0.25 7.06 2 3756 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1340000 311.15 0.25 6.82 2.56 3757 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1290000 311.15 0.25 7.09 3 3758 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1530000 311.15 0.25 7.08 2.56 3759 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1140000 311.15 0.25 7.05 2.56 3760 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 2420000 311.15 0.25 7.35 2.56 3761 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1800000 311.15 0.25 7.22 2.56 3762 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 992000 311.15 0.25 6.36 2.56 3763 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 992000 311.15 0.25 6.36 2.56 3764 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 1310000 311.15 0.25 6.81 2.56 3765 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=73GUY/GEL_1128 73GUY/GEL spectrophotometry A 4.1.3.7 citrate (si)-synthase C00036 + C00024 + C00001 = C00158 + C00010 oxaloacetate(aq) + acetyl-CoA(aq) + H2O(l) = citrate(aq) + CoA(aq) 418000 311.15 0.25 6.42 2.56 3766 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1127 73GUY/GEL spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.168 311.15 0.25 7 2 3767 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1127 73GUY/GEL spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.314 311.15 0.25 7 2.29 3768 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1127 73GUY/GEL spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.877 311.15 0.25 7 3.94 3769 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1127 73GUY/GEL spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.592 311.15 0.25 7 2.7 3770 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73GUY/GEL_1127 73GUY/GEL spectrophotometry A 4.1.3.6 citrate (pro-3S)-lyase C00158 = C00033 + C00036 citrate(aq) = acetate(aq) + oxaloacetate(aq) 0.909 311.15 0.25 7 2.99 3771 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52LEL/CAR_1260 52LEL/CAR paper chromatography and chemical analysis C 5.1.3.2&2.7.7.12 UDPglucose 4-epimerase and UDPglucose-hexose 1-phosphate uridylyltransferase C03384 = C00103 -D-galactose 1-phosphate(aq) =-D-glucose 1-phosphate(aq) 3 310.15 7.4 3772 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61VEN/RAC_373 61VEN/RAC enzymatic assay B 2.2.1.2 transaldolase C05382 + C00118 = C00279 + C00085 sedoheptulose 7-phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) = D-erythrose 4-phosphate(aq) + D-fructose 6-phosphate(aq) 1.05 310.15 7.4 3773 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=92KRA_1273 92KRA A 5.1.3.8 N-acylglucosamine 2-epimerase C00140 = C00645 N-acetyl-D-glucosamine(aq) = N-acetyl-D-mannosamine(aq) 0.201 298.15 7.5 3774 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99KIS/TEW_988 99KIS/TEW calorimetry A 3.5.1.1 asparaginase C00152 + C00001 = C00049 + C00014 L-asparagine(aq) + H2O(l) = L-aspartate(aq) + ammonia(aq) 298.15 7.03 3775 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=36LEH_614 36LEH chemical analysis C 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.323 293.15 7.7 3776 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.09E-06 303.65 6.74 3777 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.06E-06 303.65 7.08 3778 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.17E-06 303.65 7.38 3779 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 4.08E-06 303.65 7.55 3780 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 2.3E-06 303.65 7.69 3781 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.44E-06 303.65 7.89 3782 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.88E-05 303.65 8.27 3783 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 9.67E-05 303.65 8.32 3784 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 9.95E-06 303.65 7.6 3785 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 3.47E-07 303.65 6.37 3786 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 7.2E-05 303.65 8.17 3787 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 6.21E-05 303.65 8.25 3788 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53STR_274 53STR spectrophotometry B 1.4.1.2 glutamate dehydrogenase C00025 + C00003 + C00001 = C00026 + C00004 + C00014 L-glutamate(aq) + NAD(aq) + H2O(l) = 2-oxoglutarate(aq) + NADH(aq) + ammonia(aq) 1.47E-06 303.65 7.02 3789 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96OES/SCH_1410 96OES/SCH enzymatic assay and spectrophotometry B 5.4.2.6 _-phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 3.7 298.15 7 3790 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00049 303.15 7.72 3791 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000386 303.15 7.72 3792 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000179 303.15 8.31 3793 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00413 303.15 8.7 3794 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000429 303.15 8.7 3795 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00152 303.15 8.31 3796 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000735 303.15 7.94 3797 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000685 303.15 7.94 3798 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00208 303.15 8.31 3799 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00045 303.15 7.72 3800 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.00495 303.15 8.7 3801 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59KRI_564 59KRI enzymatic assay B 2.7.1.40 pyruvate kinase C00002 + C00022 = C00008 + C00074 ATP(aq) + pyruvate(aq) = ADP(aq) + phosphoenolpyruvate(aq) 0.000552 303.15 7.94 3802 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96OES/SCH_1415 96OES/SCH enzymatic assay and spectrophotometry B 5.4.2.8 phosphomannomutase C00636 = C00275 D-mannose 1-phosphate(aq) = D-mannose 6-phosphate(aq) 1 298.15 7 3803 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GAU/MAI_1271 74GAU/MAI radioactivity B 5.1.3.6 UDPglucuronate 4-epimerase C00167 = C00617 UDP-D-glucuronate(aq) = UDP-D-galacturonate(aq) 2.6 298.15 7.5 3804 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65CHI/FEI_1110 65CHI/FEI spectrophotometry C 4.1.2.19 rhamnulose-1-phosphate aldolase C01131 = C00111 + C00424 L-rhamnulose 1-phosphate(aq) = glycerone phosphate(aq) + (S)-lactaldehyde(aq) 0.083 310.15 7.5 3805 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80LER/COH_619 80LER/COH NMR B 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + N-w-phospho-L-arginine(aq) 0.17 303.15 8 3806 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81RAO/COH_600 81RAO/COH NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.08 277.15 7.8 3807 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63VIL/LAR_686 63VIL/LAR spectrophotometry C 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 1 303.15 7.45 3808 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62GRI_1393 62GRI spectrophotometry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 6.1 303.15 7 3809 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53MIT/LAM_1324 53MIT/LAM chromatography and spectrophotometry C 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.16 310.15 7 3810 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65SHA/CLE_1383 65SHA/CLE radioactivity C 5.3.3.2 isopentenyl-diphosphate-isomerase C00129 = C00235 isopentenyl diphosphate(aq) = dimethylallyl diphosphate(aq) 6.7 310.15 8 3811 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58WIL/BAN_1068 58WIL/BAN chemical analysis and radioactivity C 2.7.7.4&3.6.1.1 sulfate adenylyltransferase and inorganic pyrophosphatase C00002 + C00059 + C00001 = C00224 + 2 C00009 ATP(aq) + sulfate(aq) + H2O(l) = adenylyl sulfate(aq) + 2 orthophosphate(aq) 6E-07 303.15 7.5 3812 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62CHA/VEI_62 62CHA/VEI spectrophotometry B 1.1.1.14 L-iditol dehydrogenase C00392 + C00003 = C00095 + C00004 D-mannitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 1.43 296.15 8.6 3813 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62CHA/VEI_67 62CHA/VEI spectrophotometry B 1.1.1.14 L-iditol dehydrogenase C00794 + C00003 = C00095 + C00004 D-sorbitol(aq) + NAD(aq) = D-fructose(aq) + NADH(aq) 0.454 296.15 8.6 3814 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62CHA/VEI_64 62CHA/VEI spectrophotometry B 1.1.1.14 L-iditol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.0179 296.15 8.6 3815 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67HER/JEN_721 67HER/JEN spectrophotometry C 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.067 298.15 8.1 3816 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0103 298.15 0.25 6.4 3 3817 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.465 298.15 0.25 8.2 3 3818 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0221 278.15 0.25 7 3 3819 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0307 298.15 0.25 7 3 3820 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0277 298.15 0.25 7.13 2.25 3821 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0445 298.15 0.25 7 3.3 3822 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0725 298.15 0.25 7.4 3 3823 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0334 313.15 0.25 7 3 3824 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0321 298.15 0.25 7 3 3825 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0606 298.15 0.25 7 3.6 3826 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.174 298.15 0.25 7.8 3 3827 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0282 298.15 0.25 7 3 3828 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0903 298.15 0.25 7 4 3829 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0252 288.15 0.25 7 3 3830 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0252 298.15 0.25 7 2.7 3831 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0173 298.15 0.25 6.7 3 3832 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0299 306.15 0.25 7 3 3833 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=99TEA/DOB_1610 99TEA/DOB spectrophotometry A 2.7.3.3 arginine kinase C00002 + C00062 = C00008 + C05945 ATP(aq) + L-arginine(aq) = ADP(aq) + Nomega-phospho-L-arginine(aq) 0.0215 298.15 0.25 7 2.4 3834 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35JAC/TAP_1207 35JAC/TAP polarimetry and chemical analysis C 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0024 278.15 7 3835 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=35JAC/TAP_1207 35JAC/TAP polarimetry and chemical analysis C 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0076 310.15 7 3836 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70WUR/SCH_1359 70WUR/SCH enzymatic assay B 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.28 298.15 6.4 3837 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67WIL/HIR_1215 67WIL/HIR spectrophotometry C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 3 298.15 8 3838 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49BAR_43 49BAR spectrophotometry C 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate(aq) + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 7.1E-05 295.15 7 3839 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65CAN/FOC_1420 65CAN/FOC enzymatic assay and spectrophotometry B 5.4.99.2 methylmalonyl-CoA mutase C01213 = C00091 (R)-methylmalonyl-CoA(aq) = succinyl-CoA(aq) 18.6 303.15 7.5 3840 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96PRO/GRO_1258 96PRO/GRO spectrophotometry C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.29 298.15 8.5 3841 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.418 303.15 6 1.49 3842 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.413 303.15 7 1.8 3843 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.245 303.15 7 1.49 3844 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.197 303.15 10 1.49 3845 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.205 303.15 9 1.49 3846 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.303 280.3 7 1.49 3847 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.269 303.15 7 1.49 3848 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.245 322.6 7 1.49 3849 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.272 300.4 7 1.49 3850 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.216 303.15 7 1.19 3851 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.496 303.15 5 1.49 3852 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.64 303.15 7 2.09 3853 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68SU/RUS_642 68SU/RUS paper chromatography and spectrophotometry C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.236 303.15 8 1.49 3854 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.0411 287.75 8.1 3855 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.0664 292.35 8.1 3856 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.0655 295.65 8.1 3857 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.079 298.15 8.1 3858 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.0383 284.95 8.1 3859 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89AIR_1032 89AIR paper chromatography and radioactivity B 3.5.1.22 pantothenase C00864 + C00001 = C00522 + C00099 pantothenate + H2O = pantoic acid + beta-alanine 0.0764 299.25 8.1 3860 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79MCK/TAV_1311 79MCK/TAV polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.06 343.15 7 3861 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79MCK/TAV_1311 79MCK/TAV polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.12 353.15 7 3862 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79MCK/TAV_1311 79MCK/TAV polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.84 323.15 7 3863 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79MCK/TAV_1311 79MCK/TAV polarimetry C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.33 333.15 7 3864 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 2.09 292.15 7.62 3865 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 2.47 298.05 7.69 3866 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.11 304.45 7.62 3867 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 4.48 316.45 7.23 3868 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.58 309.95 7.28 3869 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.7 309.95 7.39 3870 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.61 309.95 6.98 3871 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.46 309.95 7.71 3872 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 1.54 285.65 7.68 3873 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87TEW/GAJ_1220 87TEW/GAJ HPLC A 4.3.1.5 phenylalanine ammonia-lyase C00079 = C00423 + C00014 L-phenylalanine(aq) = trans-cinnamate(aq) + ammonia(aq) 3.74 309.95 7.25 3874 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BUR/WAL_1284 68BUR/WAL enzymatic assay C 5.3.1.1 triose-phosphate isomerase C00118 = C00111 D-glyceraldehyde 3-phosphate(aq) = glycerone phosphate(aq) 22 298.15 7.8 3875 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=44LIP_572 44LIP chemical analysis C 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.0056 310.15 6.5 3876 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60AGO/ARA_1336 60AGO/ARA spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.179 298.15 7.5 3877 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60AGO/ARA_1336 60AGO/ARA spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.312 311.15 7.5 3878 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60AGO/ARA_1336 60AGO/ARA spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.227 304.15 7.5 3879 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 5.87 3880 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 5.92 3881 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 6.15 3882 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 6.55 3883 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 5.7 3884 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 304.65 6.1 3885 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 298.15 7.21 3886 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1051 93TEW/KIS calorimetry A 3.5.3.6 arginine deiminase C00062 + C00001 = C00327 + C00014 L-arginine(aq) + H2O(l) = L-citrulline(aq) + ammonia(aq) 310.15 6.13 3887 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TAB/SRE_1335 58TAB/SRE enzymatic assay and spectrophotometry B 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.32 310.15 7.5 3888 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71JOS/WAK_413 71JOS/WAK B 2.3.1.39 [acyl-carrier-protein] S-malonyltransferase C00083 + C00229 = C00010 + C01209 malonyl-CoA(aq) + acyl-carrier protein(aq) = CoA(aq) + malonyl-[acyl-carrier protein](aq) 0.018 298.15 6.5 3889 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MUD/KLE_341 66MUD/KLE calorimetry A 2.1.1.3 thetin-homocysteine S-methyltransferase C03392 + C00155 = C03173 + C00073 dimethylacetothetin(aq) + L-homocysteine(aq) = S-methylthioglycolate(aq) + L-methionine(aq) 297.15 7.07 3890 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 9.62E-05 282.95 7 3891 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 5.8E-05 297.65 7 3892 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 5.59E-05 298.28 7 3893 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 3.07E-05 309.7 7 3894 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 7.15E-05 294.58 7 3895 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 5.34E-05 301.06 7 3896 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58YOU/PAC_45 58YOU/PAC spectrophotometry B 1.1.1.8 glycerol-3-phosphate dehydrogenase (NAD+) C00093 + C00003 = C00111 + C00004 sn-glycerol 3-phosphate + NAD(aq) = dihydroxyacetone phosphate(aq) + NADH(aq) 6.64E-05 295.26 7 3897 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MUD/KLE_344 66MUD/KLE calorimetry A 2.1.1.3 thetin-homocysteine S-methyltransferase C01008 + C00155 = C00580 + C00073 trimethylsulfonium(aq) + L-homocysteine(aq) = dimethylsulfide(aq) + L-methionine(aq) 297.15 7.07 3898 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66MUD/KLE_345 66MUD/KLE calorimetry A 2.1.1.10 homocysteine S-methyltransferase C00019 + C00155 = C00021 + C00073 S-adenosyl-L-methionine(aq) + L-homocysteine(aq) = S-adenosyl-L-homocysteine(aq) + L-methionine(aq) 297.15 7.07 3899 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58TAB/SRE_1247 58TAB/SRE enzymatic assay and spectrophotometry B 5.1.3.1 ribulose-phosphate 3-epimerase C00199 = C00231 D-ribulose 5-phosphate(aq) = D-xylulose 5-phosphate(aq) 3 310.15 7.5 3900 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71SHI/SUG_669 71SHI/SUG spectrophotometry C 2.7.4.8 guanylate kinase C00002 + C00362 = C00008 + C00361 ATP(aq) + dGMP(aq) = ADP(aq) + dGDP(aq) 0.28 310.15 7.5 3901 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71SHI/SUG_667 71SHI/SUG spectrophotometry C 2.7.4.8 guanylate kinase C00002 + C00144 = C00008 + C00035 ATP(aq) + GMP(aq) = ADP(aq) + GDP(aq) 0.24 310.15 7.5 3902 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84RAG/LJU_303 84RAG/LJU spectrophotometry D 1.5.1.15 methylenetetrahydrofolate dehydrogenase (NAD+) C00143 + C00003 = C00445 + C00004 5,10-methylenetetrahydrofolate(aq) + NAD(aq) = 5,10-methenyltetrahydrofolate(aq) + NADH(aq) 2 298.15 6.7 3903 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65ANN/KOS_1382 65ANN/KOS NMR D 5.3.2.2 oxaloacetate tautomerase C00036 = C03981 keto-oxaloacetate(aq) = enol-oxaloacetate(aq) 0.1 298.15 7.5 3904 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84PAU_317 84PAU calorimetry B 1.6.4.2 glutathione reductase (NAD(P)H) 2 C00051 + C00006 = C00127 + C00005 2 reduced glutathione(aq) + NADP(aq) = oxidized glutathione(aq) + NADPH(aq) 298.15 6.8 3905 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56RAT/ROC_364 56RAT/ROC spectrophotometry B 2.1.4.1 glycine amidinotransferase C00062 + C00037 = C00077 + C00581 L-arginine(aq) + glycine(aq) = L-ornithine(aq) + guanidinoacetate(aq) 1.1 311.15 7.5 3906 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53TAL/DOB_178 53TAL/DOB spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 0.032 298.65 6.1 3907 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53TAL/DOB_178 53TAL/DOB spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 1.4 298.65 7.6 3908 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53TAL/DOB_178 53TAL/DOB spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 89 298.65 9.2 3909 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53TAL/DOB_178 53TAL/DOB spectrophotometry B 1.1.1.51 3(or 17)_-hydroxysteroid dehydrogenase C00535 + C00003 = C00280 + C00004 4-androstene-17-ol-3-one(aq) + NAD(aq) = 4-androstene-3,17-dione(aq) + NADH(aq) 4 298.65 8.1 3910 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66SCH/HOR_79 66SCH/HOR spectrophotometry B 1.1.1.21 aldehyde reductase C00379 + C00006 = C00181 + C00005 xylitol(aq) + NADP(aq) = D-xylose(aq) + NADPH(aq) 0.021 298.15 7.8 3911 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1698 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00121 D-arabinose(aq) = D-ribose(aq) 0.22 298.15 7.2 3912 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1698 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00121 D-arabinose(aq) = D-ribose(aq) 0.37 333.15 7.2 3913 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1698 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00121 D-arabinose(aq) = D-ribose(aq) 0.4 343.15 7.2 3914 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1698 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00121 D-arabinose(aq) = D-ribose(aq) 0.32 323.15 7.2 3915 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1698 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00121 D-arabinose(aq) = D-ribose(aq) 0.3 313.15 7.2 3916 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1693 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.03 333.15 7.2 3917 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1696 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C06463 D-erythrose(aq) = D-threose(aq) 0.76 343.15 7.2 3918 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1696 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C06463 D-erythrose(aq) = D-threose(aq) 1.1 333.15 7.2 3919 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1696 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C06463 D-erythrose(aq) = D-threose(aq) 1.04 313.15 7.2 3920 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1696 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C06463 D-erythrose(aq) = D-threose(aq) 0.82 323.15 7.2 3921 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1696 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C06463 D-erythrose(aq) = D-threose(aq) 0.96 298.15 7.2 3922 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1697 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.038 298.15 7.2 3923 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1697 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.14 343.15 7.2 3924 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1697 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.085 323.15 7.2 3925 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1697 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.067 313.15 7.2 3926 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1697 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00216 = C00309 D-arabinose(aq) = D-ribulose(aq) 0.12 333.15 7.2 3927 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1694 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C00031 = C00159 D-glucose(aq) = D-mannose(aq) 0.48 333.15 7.2 3928 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1695 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 2.67 333.15 7.2 3929 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1695 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 2.73 323.15 7.2 3930 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1695 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 2.04 298.15 7.2 3931 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1695 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 2.3 313.15 7.2 3932 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02VUO/PAS_1695 02VUO/PAS chromatography C 5.3.1.5 xylose isomerase C01796 = C02022 D-erythrose(aq) = D-erythrulose(aq) 3 343.15 7.2 3933 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78MCG/BRO_231 78MCG/BRO calorimetry B 1.1.3.6&1.11.1.6 cholesterol oxidase and catalase C00187 + 0.5 C00007 = C00599 + C00001 cholesterol(aq) + 1/2 O2(aq) = cholest-4-en-3-one(aq) + H2O(l) 303.15 7 3934 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81PAH/JAG_294 81PAH/JAG spectrophotometry C 1.5.1.2 pyrroline-5-carboxylate reductase C00148 + C00006 = C03912 + C00005 (S)-proline(aq) + NADP(aq) =D-1-pyrroline-5-carboxylate(aq) + NADPH(aq) 4.3E-05 298.15 9.23 3935 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=84DEY_1257 84DEY spectrophotometry C 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.31 303.15 8 3936 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69LAN/DEK_93 69LAN/DEK chromatography and spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C05984 + C00003 = C00109 + C00004 2-hydroxybutanoate(aq) + NAD(aq) = 2-oxobutanoate(aq) + NADH(aq) 0.003 298.65 8 3937 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69LAN/DEK_93 69LAN/DEK chromatography and spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C05984 + C00003 = C00109 + C00004 2-hydroxybutanoate(aq) + NAD(aq) = 2-oxobutanoate(aq) + NADH(aq) 0.03 298.65 8 3938 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1340 308.15 6 2 3939 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 15000 308.15 6.1 2.72 3940 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1300 308.15 6.1 2 3941 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 420 308.15 6.1 1.44 3942 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 130 308.15 6.1 1 3943 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 838 308.15 6.53 2 3944 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 301 308.15 6.97 2 3945 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 290 308.15 7 2 3946 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 160 308.15 7 1.72 3947 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 100 308.15 7 1.38 3948 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 14 308.15 7.2 2.1 3949 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1400 308.15 7.8 3 3950 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 330 308.15 7.8 2.38 3951 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 83 308.15 7.8 1.38 3952 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 112 308.15 7.8 1.3 3953 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 346 308.15 8 3.05 3954 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 218 293.2 7.8 1.3 3955 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 158 299.9 7.8 1.3 3956 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 128 302.3 7.8 1.3 3957 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 256 308.15 7.2 2.1 3958 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 73 308.15 6.1 0.7 3959 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 73 308.15 6.1 0.7 3960 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 590 308.15 7.8 2.68 3961 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 0.9 308.15 7 2.1 3962 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3100 308.15 6.1 2.38 3963 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 1600 308.15 7.8 3 3964 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 458 302.3 7.8 2 3965 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 127 308.15 8.83 2 3966 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3700 308.15 7 3 3967 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 180 308.15 7.8 2 3968 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 313 308.15 7.8 2 3969 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 20000 308.15 7 3.15 3970 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 357 308.15 7.8 2 3971 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 867 293.2 7.8 2 3972 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 0.2 308.15 8 3.05 3973 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 549 299.9 7.8 2 3974 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 58 308.15 7 1 3975 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 3900 308.15 7 3 3976 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 82 313.2 7.8 1.3 3977 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 490 308.15 7 2.38 3978 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 184 308.15 7.8 2 3979 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 100 308.15 7.8 1.3 3980 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=89ROM/DEM_812 89ROM/DEM chromatography and radioactivity B 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 100 308.15 7.8 1.3 3981 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75SCH/RIF_150 75SCH/RIF spectrophotometry B 1.1.1.40 malate dehydrogenase (oxaloacetate-decarboxylating) (NADP+) C00149 + C00006 + C00001 = C00022 + C00005 + C00288 (S)-malate(aq) + NADP(aq) + H2O(l) = pyruvate(aq) + NADPH(aq) + carbon dioxide(aq) 0.03 298.15 7.1 3982 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6 3983 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7.6 3984 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7 3985 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.3 3986 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.86 3987 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7 3988 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95HUT/BOH_1001 95HUT/BOH calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.5 3989 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75WYR/GRI_223 75WYR/GRI spectrophotometry C 1.1.1.194 coniferyl-alcohol dehydrogenase C00590 + C00006 = C02666 + C00005 coniferyl alcohol(aq) + NADP(aq) = coniferyl aldehyde(aq) + NADPH(aq) 0.28 303.15 8 3990 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75WYR/GRI_223 75WYR/GRI spectrophotometry C 1.1.1.194 coniferyl-alcohol dehydrogenase C00590 + C00006 = C02666 + C00005 coniferyl alcohol(aq) + NADP(aq) = coniferyl aldehyde(aq) + NADPH(aq) 0.18 303.15 7.8 3991 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75WYR/GRI_223 75WYR/GRI spectrophotometry C 1.1.1.194 coniferyl-alcohol dehydrogenase C00590 + C00006 = C02666 + C00005 coniferyl alcohol(aq) + NADP(aq) = coniferyl aldehyde(aq) + NADPH(aq) 1.8 303.15 8.8 3992 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80COO/BLA_109 80COO/BLA spectrophotometry B 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00045 298.15 8 3993 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_819 49MEY/GRE chemical analysis C 3.1.3.2 acid phosphatase C00085 + C00001 = C00095 + C00009 D-fructose 6-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 260 311.15 5.8 3994 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 2900 303.15 8 3995 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 800 298.15 7 3996 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 1000 303.15 7 3997 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 2700 310.15 7 3998 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 4800 310.15 8 3999 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_551 75BOH/SCH calorimetry C 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 2800 298.15 8 4000 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 7 4001 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 310.15 7 4002 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 303.15 8 4003 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 303.15 7 4004 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 310.15 8 4005 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=75BOH/SCH_552 75BOH/SCH calorimetry B 2.7.1.11 6-phosphofructokinase C00002 + C00085 = C00008 + C00354 ATP(aq) + D-fructose 6-phosphate(aq) = ADP(aq) + D-fructose 1,6-bisphosphate(aq) 298.15 8 4006 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71TAK/KUR_1230 71TAK/KUR chromatography, fluorimetry, and radioactivity C 4.6.1.1 adenylate cyclase C00002 = C00575 + C00013 ATP(aq) = adenosine 3':5'-(cyclic)phosphate(aq) + diphosphate(aq) 0.255 303.15 7.3 4007 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65TAK/HIR_898 65TAK/HIR calorimetry A 3.2.1.3 glucan 1,4--glucosidase C01835 + 2 C00001 = 3 C00031 maltotriose(aq) + 2 H2O(l) = 3 D-glucose(aq) 298.15 4.5 4008 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43KRE/EGG_1156 43KRE/EGG polarimetry and manometry B 4.2.1.3 aconitate hydratase C00158 = C00417 + C00001 citrate(aq) = cis-aconitate(aq) + H2O(l) 0.048 298.15 6.8 4009 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.3 293.15 9.02 1.7 4010 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.35 293.15 9.02 2.22 4011 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.01 303.15 7.4 2 4012 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.01 303.15 7.4 2.22 4013 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.037 303.15 8 1.7 4014 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.038 303.15 8 2 4015 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.078 303.15 8 2.7 4016 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.22 303.15 8.9 1.7 4017 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.78 303.15 8.9 3 4018 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 1.3 303.15 9.8 1.7 4019 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 2.7 303.15 9.8 2.7 4020 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.12 303.15 8.6 4021 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.17 303.15 8.77 4022 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.18 303.15 8.78 4023 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.88 303.15 8.87 4024 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.52 311.15 8.82 2.7 4025 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0096 303.15 7.4 1.7 4026 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.19 311.15 8.82 2 4027 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.032 303.15 7.4 2.7 4028 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.29 303.15 8.82 4029 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 1.4 303.15 9.8 2 4030 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 1.4 303.15 9.8 2 4031 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.18 311.15 8.82 1.7 4032 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.61 303.15 8.9 2.7 4033 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.044 303.15 8 2.22 4034 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.22 311.15 8.82 2.22 4035 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.78 293.15 9.02 2.7 4036 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 1.7 303.15 9.8 2.22 4037 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.24 303.15 8.9 2 4038 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.31 293.15 9.02 2 4039 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=54NOD/KUB_593 54NOD/KUB spectrophotometry A 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.29 303.15 8.9 2.22 4040 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87BED/TES_20 87BED/TES spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 0.00024 298.15 7.4 4041 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MIL/LUK_1225 59MIL/LUK spectrophotometry, chromatography, and radioactivity C 4.3.2.2 adenylosuccinate lyase C04823 = C00122 + C04677 1-(5'-Phosphoribosyl)-5-amino-4-(N-succinocarboxamide)-imidazole = Fumarate + 1-(5'-Phosphoribosyl)-5-amino-4-imidazolecarboxamide 0.0023 310.15 7.2 4042 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.37 293.15 6 6 4043 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.36 293.15 6 5 4044 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.96 293.15 6 3.84 4045 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.24 293.15 6 3.53 4046 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.09 293.15 6 3.27 4047 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.47 293.15 6 2.61 4048 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.76 293.15 6 3 4049 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.52 293.15 6 4 4050 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56BOW/KER_637 56BOW/KER enzymatic assay C 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.68 293.15 6 2.8 4051 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06ONO/YAN_1593 06ONO/YAN chromatography B 5.1.1.1 alanine racemase C00041 = C00133 L-alanine(aq) = D-alanine(aq) 1 310.15 9 4052 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58FRO2_187 58FRO2 spectrophotometry B 1.1.1.56 ribitol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.0096 310.15 8 4053 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58FRO2_187 58FRO2 spectrophotometry B 1.1.1.56 ribitol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.07 310.15 8.5 4054 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58FRO2_187 58FRO2 spectrophotometry B 1.1.1.56 ribitol dehydrogenase C00474 + C00003 = C00309 + C00004 ribitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.0031 310.15 7.4 4055 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67POE/GUT_263 67POE/GUT calorimetry B 1.3.99.1 succinate dehydrogenase 2 C00042 + C00007 = 2 C00122 + 2 C00001 2 succinate(aq) + O2(aq) = 2 fumarate(aq) + 2 H2O(l) 298.15 7.4 4056 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.000877 298.15 7 4057 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.000826 298.15 7.06 4058 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.00119 298.15 7.18 4059 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.00145 298.15 7.22 4060 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.5 298.15 8.39 4061 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.01 298.15 7.53 4062 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.00555 298.15 7.39 4063 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.000175 298.15 6.51 4064 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.000935 298.15 6.91 4065 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.17 298.15 8.19 4066 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68REE/MEN_713 68REE/MEN enzymatic assay and spectrophotometry B 2.7.9.1 pyruvate,orthophosphate dikinase C00002 + C00022 + C00009 = C00020 + C00074 + C00013 ATP(aq) + pyruvate(aq) + orthophosphate(aq) = AMP(aq) + phosphoenolpyruvate(aq) + pyrophosphate(aq) 0.071 298.15 7.88 4067 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73MCC/KOL_1216 73MCC/KOL spectrophotometry and thin layer chromatography C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 0.025 305.3 7.2 4068 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73MCC/KOL_1216 73MCC/KOL spectrophotometry and thin layer chromatography C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 0.028 308.2 7.2 4069 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73MCC/KOL_1216 73MCC/KOL spectrophotometry and thin layer chromatography C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 0.04 311.3 7.2 4070 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73MCC/KOL_1216 73MCC/KOL spectrophotometry and thin layer chromatography C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 0.1 316.4 7.2 4071 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=73MCC/KOL_1216 73MCC/KOL spectrophotometry and thin layer chromatography C 4.3.1.3 histidine ammonia-lyase C00135 = C00785 + C00014 L-histidine(aq) = urocanate(aq) + ammonia(aq) 0.016 303.2 7.2 4072 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89HAG/ROS_1548 89HAG/ROS calorimetry A 3.1.4.35 3 ', 5 '-cyclic-GMP phosphodiesterase C00942 + C00001 = C00144 guanosine 3 ',5 '-cyclic phosphate(aq) + H2O(l) = guanosine 5 '-phosphate(aq) 298.15 7.15 4073 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56PAL/DOU_1340 56PAL/DOU chemical analysis and spectrophotometry C 5.3.1.7 mannose isomerase C00476 = C00310 D-lyxose(aq) = D-xylulose(aq) 0.39 303.15 7.4 4074 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56PAL/DOU_1341 56PAL/DOU chemical analysis and spectrophotometry C 5.3.1.7 mannose isomerase C00159 = C00095 D-mannose(aq) = D-fructose(aq) 2.45 303.15 7.4 4075 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74CHE/PAT_837 74CHE/PAT calorimetry B 3.1.4.17 3',5'-cyclic-nucleotide phosphodiesterase C00575 + C00001 = C00020 adenosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = AMP(aq) 298.15 7.8 4076 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65ICH/HIR_1299 65ICH/HIR spectrophotometry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.08 343.15 8 4077 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72FOR/GAU_206 72FOR/GAU spectrophotometry C 1.1.1.97 3-hydroxybenzyl-alcohol dehydrogenase C03351 + C00006 = C03067 + C00005 3-hydroxybenzyl alcohol(aq) + NADP(aq) = 3-hydroxybenzaldehyde(aq) + NADPH(aq) 0.18 303.15 7.6 4078 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VEE/EGG_501 69VEE/EGG C 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.151 311.15 0.25 7 4079 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CHI/SUG_1391 59CHI/SUG polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.3 298.15 5.4 4080 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CHI/SUG_1391 59CHI/SUG polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.1 298.15 6.5 4081 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CHI/SUG_1391 59CHI/SUG polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.25 298.15 7.2 4082 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CHI/SUG_1391 59CHI/SUG polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 4.9 298.15 5 4083 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59CHI/SUG_1391 59CHI/SUG polarimetry C 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 5.35 298.15 5.9 4084 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MER/TOM_5 59MER/TOM spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00854 + C00003 = C00414 + C00004 cyclohexanol(aq) + NAD(aq) = cyclohexanone(aq) + NADH(aq) 0.09 298.15 7.2 4085 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MER/TOM_5 59MER/TOM spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00854 + C00003 = C00414 + C00004 cyclohexanol(aq) + NAD(aq) = cyclohexanone(aq) + NADH(aq) 0.158 298.15 7.5 4086 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MER/TOM_5 59MER/TOM spectrophotometry C 1.1.1.1 alcohol dehydrogenase C00854 + C00003 = C00414 + C00004 cyclohexanol(aq) + NAD(aq) = cyclohexanone(aq) + NADH(aq) 19 298.15 9.5 4087 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79GRI/TAN_1043 79GRI/TAN calorimetry B 3.5.2.6 _-lactamase C05551 + C00001 = C06567 penicillin G(aq) + H2O(l) = penicillinoic acid(aq) 298.15 7.5 4088 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63BER/HOL_396 63BER/HOL spectrophotometry C 2.3.1.8 phosphate acetyltransferase C00024 + C00009 = C00010 + C00227 acetyl-CoA(aq) + orthophosphate(aq) = CoA(aq) + acetyl phosphate(aq) 0.0068 298.15 7.4 4089 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65PIN_809 65PIN calorimetry A 3.1.3.1 alkaline phosphatase C03149 + C00001 = C01959 + C00009 phosphotaurocyamine(aq) + H2O(l) = taurocyamine(aq) + orthophosphate(aq) 298.15 9 4090 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76JES_139 76JES calorimetry B 1.1.1.37 malate dehydrogenase C00149 + C00003 = C00036 + C00004 (S)-malate(aq) + NAD(aq) = oxaloacetate(aq) + NADH(aq) 298.15 7.4 4091 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65PIN_804 65PIN calorimetry A 3.1.3.1 alkaline phosphatase C03166 + C00001 = C00581 + C00009 phosphoguanidinoacetate(aq) + H2O(l) = guanidinoacetate(aq) + orthophosphate(aq) 298.15 9 4092 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 2.91 303.15 7.4 1.74 4093 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 2.46 303.15 7.4 1.85 4094 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.07 303.15 7.4 2.7 4095 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.91 303.15 7.4 3.49 4096 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.98 303.15 7.4 3.18 4097 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 2.69 303.15 7.4 1.85 4098 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.21 303.15 7.4 2.52 4099 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.96 303.15 7.4 3.18 4100 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.31 303.15 7.4 2.4 4101 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.09 303.15 7.4 2.7 4102 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.56 303.15 7.4 2.22 4103 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.96 303.15 7.4 2.96 4104 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.8 303.15 7.4 2.22 4105 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.35 303.15 7.4 2.4 4106 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.09 303.15 7.4 2.96 4107 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.21 303.15 7.4 2.52 4108 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 1.99 303.15 7.4 2 4109 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 2.16 303.15 7.4 2 4110 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.95 303.15 7.4 3.49 4111 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=06AIR2_1503 06AIR2 radioactivity A 6.1.1.1 tyrosine-tRNA ligase C00002 + C00082 + C00787 = C00020 + C00013 + C02839 ATP(aq) + L-tyrosine(aq) + tRNA-Tyr(aq) = AMP(aq) + pyrophosphate(aq) + L-tyrosyl-tRNA-Tyr(aq) 0.95 303.15 7.4 3.49 4112 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69LAN/DEK_105 69LAN/DEK spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.00048 298.65 8 4113 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69LAN/DEK_105 69LAN/DEK spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0048 298.65 9 4114 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86KON/POL_121 86KON/POL spectrophotometry C 1.1.1.30 3-hydroxybutyrate dehydrogenase C01089 + C00003 = C00164 + C00004 (R)-3-hydroxybutanoate(aq) + NAD(aq) = 3-oxobutanoate(aq) + NADH(aq) 1.66 298.15 9.15 4115 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIR_225 81HIR C 1.1.1.- sorbitol-6-phosphate dehydrogenase (NADP+) C01096 + C00006 = C00092 + C00005 D-sorbitol 6-phosphate(aq) + NADP(aq) = D-glucose 6-phosphate(aq) + NADPH(aq) 0.234 303.15 8.66 4116 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66ALB/BAS_687 66ALB/BAS spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.32 303.15 7.8 4117 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=79REK/EGO_334 79REK/EGO calorimetry B 1.12.1.2 hydrogen dehydrogenase C00282 + C00003 = C00004 H2(aq) + NAD(aq) = NADH(aq) 298.15 7.2 4118 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/COO_122 57ROB/COO spectrophotometry B 1.1.1.31 3-hydroxyisobutyrate dehydrogenase C01188 + C00003 = C00349 + C00004 3-hydroxy-2-methylpropanoate(aq) + NAD(aq) = 2-methyl-3-oxopropanoate(aq) + NADH(aq) 0.12 298.15 10 4119 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/COO_122 57ROB/COO spectrophotometry B 1.1.1.31 3-hydroxyisobutyrate dehydrogenase C01188 + C00003 = C00349 + C00004 3-hydroxy-2-methylpropanoate(aq) + NAD(aq) = 2-methyl-3-oxopropanoate(aq) + NADH(aq) 0.036 298.15 9 4120 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57ROB/COO_122 57ROB/COO spectrophotometry B 1.1.1.31 3-hydroxyisobutyrate dehydrogenase C01188 + C00003 = C00349 + C00004 3-hydroxy-2-methylpropanoate(aq) + NAD(aq) = 2-methyl-3-oxopropanoate(aq) + NADH(aq) 0.0031 298.15 8 4121 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80CAM/SGA_455 80CAM/SGA spectrophotometry B 2.4.2.1 purine-nucleoside phosphorylase C00212 + C00009 = C00147 + C00620 adenosine(aq) + orthophosphate(aq) = adenine(aq) + D-ribose 1-phosphate(aq) 0.00541 298.15 7 4122 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61SAN/ZIN_288 61SAN/ZIN spectrophotometry B 1.4.1.9 leucine dehydrogenase C00123 + C00003 + C00001 = C00233 + C00004 + C00014 L-leucine(aq) + NAD(aq) + H2O(l) = 4-methyl-2-oxopentanoate(aq) + NADH(aq) + ammonia(aq) 0.0111 298.15 11.1 4123 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74KNA/BLA_414 74KNA/BLA spectrophotometry C 2.3.1.54 formate C-acetyltransferase C00024 + C00058 = C00010 + C00022 acetyl-CoA(aq) + formate(aq) = CoA(aq) + pyruvate(aq) 0.00133 303.15 8.1 4124 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55POD/STU_1072 55POD/STU calorimetry A 3.6.1.32 myosin ATPase C00002 + C00001 = C00008 + C00009 ATP(aq) + H2O(l) = ADP(aq) + orthophosphate(aq) 298.15 8 4125 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BEE/DEL_236 68BEE/DEL spectrophotometry C 1.1.99.13 glucoside 3-dehydrogenase C00243 + 2 C00125 = C05403 + 2 C00126 lactose(aq) + 2 cytochrome c(aq) = 3-oxolactose(aq) + 2 reduced cytochrome c(aq) 6.3 298.15 5.92 4126 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BLA/WRI3_36 55BLA/WRI3 spectrophotometry C 1.1.1.3 homoserine dehydrogenase C00263 + C00003 = C00441 + C00004 L-homoserine(aq) + NAD(aq) = L-aspartate 4-semialdehyde(aq) + NADH(aq) 0.0088 298.15 7.9 4127 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BLA/WRI3_37 55BLA/WRI3 spectrophotometry C 1.1.1.3 homoserine dehydrogenase C00263 + C00006 = C00441 + C00005 L-homoserine(aq) + NADP(aq) = L-aspartate 4-semialdehyde(aq) + NADPH(aq) 0.00063 298.15 7.9 4128 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52KOR_574 52KOR D 2.7.2.1 acetate kinase C00002 + C00033 = C00008 + C00227 ATP(aq) + acetate(aq) = ADP(aq) + acetyl phosphate(aq) 0.013 298.15 4129 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63FRI/SCH_389 63FRI/SCH spectrophotometry B 2.3.1.7 carnitine O-acetyltransferase C00024 + C00318 = C00010 + C02571 acetyl-CoA(aq) + L-carnitine(aq) = CoA(aq) + L-acetylcarnitine(aq) 1.6 308.15 7 4130 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60LEA/GLA_1578 60LEA/GLA radioactivity B 6.1.1.3 threonin-tRNA ligase C00002 + C00188 + C01651 = C00020 + C00013 + C02992 ATP(aq) + L-threonine(aq) + tRNA-Thr(aq) = AMP(aq) + pyrophosphate(aq) + L-threonyl-tRNA-Thr(aq) 0.37 310.16 7 4131 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=45DAR_496 45DAR spectrophotometry C 2.6.1.1 aspartate transaminase C00049 + C00026 = C00036 + C00025 L-aspartate(aq) + 2-oxoglutarate(aq) = oxaloacetate(aq) + L-glutamate(aq) 0.18 298.15 7.15 4132 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=77REH/JAN_320 77REH/JAN calorimetry B 1.7.3.3&1.11.1.6 urate oxidase and catalase C00366 + 0.5 C00007 + 2 C00001 = C01551 + C00288 urate(aq) + 1/2 O2(aq) + 2 H2O(l) = allantoin(aq) + carbon dioxide(aq) 303.15 9 4133 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67LOM/GRE_1059 67LOM/GRE spectrophotometry C 3.5.4.9 methenyltetrahydrofolate cyclohydrolase C00445 + C00001 = C00234 5,10-methenyltetrahydrofolate(aq) + H2O(l) = 10-formyltetrahydrofolate(aq) 1.84 298.15 6.5 4134 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.6 311.15 0.25 6.86 3.23 4135 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.3 311.15 0.25 6.83 3.22 4136 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.5 311.15 0.25 6.66 2.34 4137 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.6 311.15 0.25 6.65 2.33 4138 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.3 311.15 0.25 6.79 2.34 4139 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.8 311.15 0.25 6.57 2.03 4140 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.8 311.15 0.25 6.68 2.05 4141 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.4 311.15 0.25 6.72 2.04 4142 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11 311.15 0.25 6.7 2.04 4143 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.8 311.15 0.25 6.48 1.84 4144 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.9 311.15 0.25 6.65 1.85 4145 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.3 311.15 0.25 6.63 1.85 4146 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.7 311.15 0.25 6.76 3.23 4147 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 10.7 311.15 0.25 6.78 3.23 4148 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11.3 311.15 0.25 6.76 2.33 4149 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=82GUY_1398 82GUY spectrophotometry A 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 11 311.15 0.25 6.48 1.84 4150 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72NEL/KIE_330 72NEL/KIE calorimetry A 1.11.1.6 catalase C00027 = 0.5 C00007 + C00001 H2O2(aq) = 1/2 O2(aq) + H2O(l) 298.15 4151 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 6.55 311.15 0.25 8.49 4152 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.138 298.15 0.25 6.87 4153 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.13 298.15 0.25 6.89 4154 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.267 298.15 0.25 7.08 4155 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.27 298.15 0.25 7.09 4156 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.579 298.15 0.25 7.41 4157 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.36 298.15 0.1 7.37 4158 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.349 298.15 0.35 7.21 4159 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.334 298.15 0.6 7.14 4160 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.16 298.15 1.1 7.03 4161 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.264 298.15 1.1 7.05 4162 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.051 311.15 0.25 6.27 4163 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.141 311.15 0.25 6.73 4164 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.129 311.15 0.25 6.82 4165 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.15 311.15 0.25 6.84 4166 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.139 311.15 0.25 6.91 4167 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.197 311.15 0.25 6.94 4168 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.26 311.15 0.25 6.98 4169 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.116 311.15 0.25 7.05 2 4170 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.266 311.15 0.25 7.06 4171 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.34 311.15 0.25 7.07 4172 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.34 311.15 0.25 7.07 4173 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.257 311.15 0.25 7.16 2 4174 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.268 311.15 0.25 7.17 4175 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.309 311.15 0.25 7.25 4176 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.385 311.15 0.25 7.3 4177 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.498 311.15 0.25 7.35 4178 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.634 311.15 0.25 7.58 4179 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 3.55 311.15 0.25 8.27 4180 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 3.55 311.15 0.25 8.39 4181 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.271 311.15 0.25 7.05 4182 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.321 311.15 0.25 7.24 4183 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 2.37 311.15 0.25 8.09 4184 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.329 298.15 0.25 7.12 4185 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 2.04 311.15 0.25 8.12 4186 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.1 298.15 0.12 6.6 4187 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.067 311.15 0.25 6.41 4188 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.187 311.15 0.25 6.94 4189 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 3.86 311.15 0.25 8.49 4190 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.294 298.15 0.25 7.09 4191 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.287 298.15 0.35 7.19 4192 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.088 311.15 0.25 6.72 4193 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.088 311.15 0.25 6.72 4194 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.253 298.15 0.6 7.11 4195 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.143 311.15 0.25 6.91 4196 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.105 311.15 0.25 7.07 2 4197 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 2.75 311.15 0.25 8.29 4198 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.445 298.15 0.25 7.35 4199 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.338 298.15 0.35 7.18 4200 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.141 311.15 0.25 6.75 4201 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.271 311.15 0.25 6.98 4202 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.351 311.15 0.25 7.23 4203 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.328 311.15 0.25 7.09 4204 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.62 311.15 0.25 7.6 4205 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85LIE_325 85LIE spectrophotometry A 1.8.1.4 dihydrolipoamide dehydrogenase C02147 + C00003 = C00725 + C00004 dihydro--lipoate(aq) + NAD(aq) =-lipoate(aq) + NADH(aq) 0.138 311.15 0.25 6.79 4206 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66HOR/HEN_474 66HOR/HEN C 2.4.2.7 adenine phosphoribosyltransferase C00147 + C00119 = C00020 + C00013 adenine(aq) + 5-phospho--D-ribose 1-diphosphate(aq) = AMP(aq) + pyrophosphate(aq) 290 303.15 7.4 4207 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 7.46 4208 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 7.79 4209 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 7.83 4210 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 7.94 4211 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 8.27 4212 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 7.67 4213 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 310.25 7.86 4214 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 6.47 4215 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 298.15 6.94 4216 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93TEW/KIS_1047 93TEW/KIS calorimetry A 3.5.3.1 arginase C00062 + C00001 = C00077 + C00086 L-arginine(aq) + H2O(l) = L-ornithine(aq) + urea(aq) 304.65 7.87 4217 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83BRA_18 83BRA calorimetry A 1.1.1.1 alcohol dehydrogenase C00469 + C00003 = C00084 + C00004 ethanol(aq) + NAD(aq) = acetaldehyde(aq) + NADH(aq) 298.15 8.9 4218 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61GOT/KOR_191 61GOT/KOR spectrophotometry B 1.1.1.60 2-hydroxy-3-oxopropionate reductase C00258 + C00003 = C01146 + C00004 (R)-glycerate(aq) + NAD(aq) = 2-hydroxy-3-oxopropanoate(aq) + NADH(aq) 1.9E-06 296.15 7.49 4219 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61GOT/KOR_191 61GOT/KOR spectrophotometry B 1.1.1.60 2-hydroxy-3-oxopropionate reductase C00258 + C00003 = C01146 + C00004 (R)-glycerate(aq) + NAD(aq) = 2-hydroxy-3-oxopropanoate(aq) + NADH(aq) 1.6E-05 296.15 8.49 4220 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.871 310.15 0.25 6.98 3.44 4221 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.899 310.15 0.25 6.99 3.6 4222 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.06 310.15 0.25 6.99 3.08 4223 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.842 310.15 0.25 6.99 2.71 4224 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.044 310.15 0.25 6.99 3.18 4225 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.98 310.15 0.25 6.91 2.97 4226 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 1.014 310.15 0.25 6.99 3.36 4227 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.964 310.15 0.25 6.89 2.96 4228 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.708 310.15 0.25 6.99 4 4229 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.983 310.15 0.25 6.91 2.97 4230 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.929 310.15 0.25 6.97 3.42 4231 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.981 310.15 0.25 6.97 3.42 4232 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.38 310.15 0.25 6.99 2 4233 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.946 310.15 0.25 6.98 3.43 4234 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.572 310.15 0.25 6.99 2.35 4235 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=76LAW/GUY_649 76LAW/GUY enzymatic assay; spectrophotometry A 2.7.4.3 adenylate kinase 2 C00008 = C00020 + C00002 2 ADP(aq) = AMP(aq) + ATP(aq) 0.982 310.15 0.25 6.9 2.97 4236 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74GUY/VEL_1404 74GUY/VEL enzymatic assay and spectrophotometry A 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 17.4 311.15 0.25 7.04 3.1 4237 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GEL/STU_613 60GEL/STU calorimetry A 2.7.3.2&3.6.1.32 creatine kinase and myosin ATPase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 8 4238 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59ITO/GRI_1392 59ITO/GRI D 5.4.2.1 phosphoglycerate mutase C00631 = C00197 2-phospho-D-glycerate(aq) = 3-phospho-D-glycerate(aq) 8 303.15 4239 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58LAN/ENG_194 58LAN/ENG spectrophotometry C 1.1.1.62 estradiol 17_-dehydrogenase C00951 + C00003 = C00468 + C00004 estradiol-17(aq) + NAD(aq) = estrone(aq) + NADH(aq) 0.18 298.15 7 4240 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58LAN/ENG_194 58LAN/ENG spectrophotometry C 1.1.1.62 estradiol 17_-dehydrogenase C00951 + C00003 = C00468 + C00004 estradiol-17(aq) + NAD(aq) = estrone(aq) + NADH(aq) 18 298.15 9 4241 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58LAN/ENG_194 58LAN/ENG spectrophotometry C 1.1.1.62 estradiol 17_-dehydrogenase C00951 + C00003 = C00468 + C00004 estradiol-17(aq) + NAD(aq) = estrone(aq) + NADH(aq) 1.8 298.15 8 4242 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58LAN/ENG_194 58LAN/ENG spectrophotometry C 1.1.1.62 estradiol 17_-dehydrogenase C00951 + C00003 = C00468 + C00004 estradiol-17(aq) + NAD(aq) = estrone(aq) + NADH(aq) 180 298.15 10 4243 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87WOL/REI_801 87WOL/REI calorimetry B 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 273.15 8 4244 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87WOL/REI_801 87WOL/REI calorimetry B 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 310.15 8 4245 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87WOL/REI_801 87WOL/REI calorimetry B 3.1.3.1 alkaline phosphatase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 8 4246 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.012 303.15 7 4247 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.003 303.15 7 4248 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.002 303.15 7 4249 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.004 303.15 7 4250 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0025 303.15 7 4251 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.015 303.15 7 3.52 4252 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.004 303.15 7 2.52 4253 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.005 303.15 7 4254 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.01 303.15 7 3 4255 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.003 303.15 7 2 4256 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.009 303.15 7 4257 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.005 303.15 7 4258 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=71CHE/ALI_597 71CHE/ALI chemical analysis C 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.025 303.15 7 4 4259 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65DAW/DIC_114 65DAW/DIC spectrophotometry C 1.1.1.29 glycerate dehydrogenase C00258 + C00003 = C00168 + C00004 (R)-glycerate(aq) + NAD(aq) = hydroxypyruvate(aq) + NADH(aq) 6.1E-05 298.15 9 4260 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98CON/DEL_1520 98CON/DEL chromatography B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.21 348.15 7 4261 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98CON/DEL_1520 98CON/DEL chromatography B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.39 353.15 7 4262 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98CON/DEL_1520 98CON/DEL chromatography B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.99 333.15 7 4263 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98CON/DEL_1520 98CON/DEL chromatography B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.02 338.15 7 4264 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98CON/DEL_1520 98CON/DEL chromatography B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.14 343.15 7 4265 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_769 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00035 + 2 C00001 = C00387 + 2 C00009 GDP(aq) + 2 H2O(l) = guanosine(aq) + 2 orthophosphate(aq) 298.15 8 4266 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_769 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00035 + 2 C00001 = C00387 + 2 C00009 GDP(aq) + 2 H2O(l) = guanosine(aq) + 2 orthophosphate(aq) 298.15 9 4267 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81HIN/POL_769 81HIN/POL calorimetry A 3.1.3.1 alkaline phosphatase C00035 + 2 C00001 = C00387 + 2 C00009 GDP(aq) + 2 H2O(l) = guanosine(aq) + 2 orthophosphate(aq) 298.15 9 4268 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ATK/BUR_550 61ATK/BUR electrophoresis and enzymatic assay A 2.7.1.6 galactokinase C00002 + C00124 = C00008 + C03384 ATP(aq) + D-galactose(aq) = ADP(aq) + D-galactose 1-phosphate(aq) 24 298.15 7 2 4269 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61ATK/BUR_550 61ATK/BUR electrophoresis and enzymatic assay A 2.7.1.6 galactokinase C00002 + C00124 = C00008 + C03384 ATP(aq) + D-galactose(aq) = ADP(aq) + D-galactose 1-phosphate(aq) 26 298.15 7 1.6 4270 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60FEI/NEU_1267 60FEI/NEU electrophoresis and radioactivity B 5.1.3.5 UDParabinose 4-epimerase C00935 = C00190 UDP-L-arabinose(aq) = UDP-D-xylose(aq) 1 310.15 7.5 4271 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 329 303.15 6.2 2.4 4272 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 133 303.15 6.2 2 4273 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 100 303.15 6.2 1.7 4274 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 619 303.15 7.2 3 4275 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 224 303.15 7.2 2.4 4276 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 79 303.15 7.2 2 4277 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 584 303.15 8 2.3 4278 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 413 303.15 8 2.15 4279 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 136 303.15 7.2 2.22 4280 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 406 303.15 7.2 2.7 4281 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=3.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 345.6 303.15 8 3 4282 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 400 303.15 8 2.05 4283 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=4.&T1=85DEM/BEH_1066 85DEM/BEH radioactivity B 3.6.1.1 inorganic pyrophosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 85.5 303.15 7.2 2.1 4284 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78SUB_285 78SUB spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 2.91E-06 298.15 7.6 4285 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78SUB_285 78SUB spectrophotometry B 1.4.1.3 glutamate dehydrogenase (NAD(P)+) C00025 + C00006 + C00001 = C00026 + C00005 + C00014 L-glutamate(aq) + NADP(aq) + H2O(l) = 2-oxoglutarate(aq) + NADPH(aq) + ammonia(aq) 6.37E-06 308.15 7.6 4286 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.046 5.85 4287 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.04 5.37 4288 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.025 4.76 4289 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.05 3.72 4290 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.0025 3.62 4291 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.039 5.27 4292 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.005 3.82 4293 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.014 4.32 4294 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55STU_825 55STU calorimetry A 3.1.3.2 acid phosphatase C03360 + C00001 = C00870 + C00009 4-nitrophenyl phosphate(aq) + H2O(l) = 4-nitrophenol(aq) + orthophosphate(aq) 298.15 0.025 4.74 4295 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=62WIL/SNE_359 62WIL/SNE spectrophotometry B 2.1.2.7 D-alanine 2-hydroxymethyltransferase C02115 + C00101 = C00143 + C00133 + C00001 2-methylserine(aq) + tetrahydrofolate(aq) = 5,10-methylenetetrahydrofolate(aq) + D-alanine(aq) + H2O(l) 3 311.15 7.5 4296 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56KAP/CIO_101 56KAP/CIO spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0012 303.15 9 4297 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.131 282.45 7.65 4298 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.128 282.55 7.621 4299 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.131 282.65 7.621 4300 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.157 285.55 7.653 4301 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.162 285.65 7.653 4302 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.171 286.1 7.663 4303 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.498 309.95 7.548 4304 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.516 310.35 7.547 4305 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.591 313.75 7.516 4306 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.713 314.85 7.565 4307 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.318 298.75 7.581 4308 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.556 311.35 7.546 4309 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.549 310.15 7.552 4310 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=74BUR_31 74BUR spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.158 285.85 7.653 4311 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66VER/ROD_707 66VER/ROD enzymatic assay and spectrophotometry C 2.7.7.34 glucose-1-phosphate guanylyltransferase C00044 + C00103 = C00394 + C00013 GTP(aq) + D-glucose 1-phosphate(aq) = GDPglucose(aq) + pyrophosphate(aq) 0.25 303.15 7.8 4312 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_760 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 298.15 8.42 3 4313 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_760 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 298.15 8.85 3 4314 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_760 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 304.55 7.78 3 4315 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_760 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 310.15 7.62 3 4316 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=93LAR/TEW_760 93LAR/TEW calorimetry A 3.1.3.1 alkaline phosphatase C00020 + C00001 = C00212 + C00009 AMP(aq) + H2O(l) = adenosine(aq) + orthophosphate(aq) 298.15 8.02 3 4317 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98LIA/QU_1582 98LIA/QU calorimetry B 1.15.1.1 superoxide dismutase 2 C00704 + 2 C00080 = C00007 + C00027 2 O2- + 2 H+ = O2 + H2O2 298.15 8 4318 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=64PRE/WOO_699 64PRE/WOO paper chromatography and chemical analysis B 2.7.7.13 mannose-1-phosphate guanylyltransferase C00044 + C00636 = C00096 + C00013 GTP(aq) + D-mannose 1-phosphate(aq) = GDPmannose(aq) + pyrophosphate(aq) 2.5 310.15 8.26 4319 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1004 98DIE/STR HPLC A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-4-hydroxyphenylglycine(aq) 7.04 298.15 5.6 4320 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1004 98DIE/STR HPLC A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-4-hydroxyphenylglycine(aq) 17.7 298.15 6 4321 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98DIE/STR_1004 98DIE/STR HPLC A 3.5.1.11 penicillin amidase C06827 + C00001 = C02954 + C03493 amoxicillin(aq) + H2O(l) = 6-aminopenicillanic acid(aq) + D-4-hydroxyphenylglycine(aq) 2.86 298.15 5 4322 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80REK/EGO_239 80REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 6.02 4323 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80REK/EGO_239 80REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 7.48 4324 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80REK/EGO_239 80REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 8.01 4325 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80REK/EGO_239 80REK/EGO calorimetry B 1.2.1.2 formate dehydrogenase C00058 + C00003 + C00001 = C00288 + C00004 formate(aq) + NAD(aq) + H2O(l) = carbon dioxide(aq) + NADH(aq) 298.15 6.44 4326 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65STI/DIA_810 65STI/DIA paper chromatography and radioactivity D 3.1.3.1 alkaline phosphatase C00013 + C00001 = 2 C00009 pyrophosphate(aq) + H2O(l) = 2 orthophosphate(aq) 69000 298.15 7.3 4327 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 41 311.15 0.25 6.89 4328 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 41 311.15 0.25 6.94 4329 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 71 311.15 0.25 7.01 4330 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 78 311.15 0.25 7.02 4331 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 35 311.15 0.25 6.92 4332 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 58 311.15 0.25 6.99 4333 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 68 311.15 0.25 6.97 4334 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 45 311.15 0.25 6.91 4335 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 28 311.15 0.25 6.88 4336 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 59 311.15 0.25 7 4337 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68VEE_256 68VEE spectrophotometry A 1.2.1.12&2.7.2.3 glyceraldehyde-3-phosphate dehydrogenase and phosphoglycerate kinase C00118 + C00008 + C00003 + C00009 = C00197 + C00002 + C00004 D-glyceraldehyde 3-phosphate(aq) + ADP(aq) + NAD(aq) + orthophosphate(aq) = 3-phospho-D-glycerate(aq) + ATP(aq) + NADH(aq) 61 311.15 0.25 6.98 4338 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=26QUA/WOO_1205 26QUA/WOO chemical analysis C 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.04 310.15 7.4 4339 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 0.99 323.15 7.5 4340 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.07 338.15 7.5 4341 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.05 333.15 7.5 4342 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.14 338.15 7.5 4343 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.11 333.15 7.5 4344 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83TIL_1312 83TIL polarimetry and HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.01 328.15 7.5 4345 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69GRE/RUD_840 69GRE/RUD calorimetry A 3.1.4.17 phosphodiesterase I C00942 + C00001 = C00144 guanosine 3':5'-(cyclic)phosphate(aq) + H2O(l) = GMP(aq) 298.15 7.3 4346 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85HEA/CHU_1549 85HEA/CHU spectrophotometry C 1.2.1.a succinate-semialdehyde reductase C00232 + C00005 = C00989 + C00006 4-oxobutanoate(aq) + NADP(red)(aq) = 4-hydroxybutanoate(aq) + NADP(ox)(aq) 3.7 298.15 7 4347 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=65GHO/ROS2_1272 65GHO/ROS2 radioactivity C 5.1.3.8 N-acylglucosamine 2-epimerase C00140 = C00645 N-acetyl-D-glucosamine(aq) = N-acetyl-D-mannosamine(aq) 0.26 310.15 7.6 4348 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.238 298.15 7.51 4349 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.263 298.15 7.52 4350 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.282 298.15 7.52 4351 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.328 298.15 7.68 4352 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.291 298.15 7.64 4353 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.27 298.15 7.63 4354 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.225 298.15 7.52 4355 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.23 298.15 7.52 4356 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.337 298.15 7.68 4357 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.136 298.15 7.28 4358 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.134 298.15 7.28 4359 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.129 298.15 7.3 4360 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 4.36 298.15 8.78 4361 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 4.71 298.15 8.83 4362 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 5.91 298.15 8.82 4363 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.223 298.15 7.51 4364 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.268 298.15 7.56 4365 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.361 298.15 7.68 4366 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 5.32 298.15 8.82 4367 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.308 298.15 7.64 4368 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 5.76 298.15 8.71 4369 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 5.76 298.15 8.71 4370 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.251 298.15 7.63 4371 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.0758 298.15 7.03 4372 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.109 298.15 7.18 4373 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=53BUR/WIL_30 53BUR/WIL spectrophotometry A 1.1.1.1 alcohol dehydrogenase C01845 + C00003 = C00207 + C00004 2-propanol(aq) + NAD(aq) = acetone(aq) + NADH(aq) 0.33 298.15 7.68 4374 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SOD/OSU_1241 67SOD/OSU manometry and enzymatic assay B 5.1.1.10 amino-acid racemase C00123 = C01570 L-leucine(aq) = D-leucine(aq) 1 310.15 8.3 4375 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SAK/YOR_470 67SAK/YOR electrophoresis C 2.4.2.2 pyrimidine-nucleoside phosphorylase C00299 + C00009 = C00106 + C00620 uridine(aq) + orthophosphate(aq) = uracil(aq) + D-ribose 1-phosphate(aq) 0.44 310.15 7 4376 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67SAK/YOR_470 67SAK/YOR electrophoresis C 2.4.2.2 pyrimidine-nucleoside phosphorylase C00299 + C00009 = C00106 + C00620 uridine(aq) + orthophosphate(aq) = uracil(aq) + D-ribose 1-phosphate(aq) 1 310.15 9 4377 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86RAG/CAR_1600 86RAG/CAR chromatography and radioactivity B 2.4.2.28 5 '-methylthioadenosine phosphorylase C00170 + C00009 = C00147 + C04188 5 '-methylthioadenosine(aq) + orthophosphate(aq) = adenine(aq) + 5-methylthio-D-ribose 1-phosphate(aq) 0.0139 310.15 7.4 4378 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=94NOE/COL_197 94NOE/COL HPLC and spectrophotometry B 1.1.1.67 mannitol dehydrogenase C00392 + C00006 = C00095 + C00005 D-mannitol(aq) + NADP(aq) = D-fructose(aq) + NADPH(aq) 0.0917 310.15 7.5 4379 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELD/DEG_602 89ELD/DEG NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0406 295.15 8.2 4380 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELD/DEG_602 89ELD/DEG NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.033 286.65 8.2 4381 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELD/DEG_602 89ELD/DEG NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0417 303.15 8.2 4382 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89ELD/DEG_602 89ELD/DEG NMR B 2.7.3.2 creatine kinase C00002 + C00300 = C00008 + C02305 ATP(aq) + creatine(aq) = ADP(aq) + phosphocreatine(aq) 0.0453 308.15 8.2 4383 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0042 303.15 7.5 4384 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0043 303.15 8.1 4385 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0088 303.15 8.1 2.28 4386 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0086 303.15 9.2 4387 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0028 303.15 7 4388 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.015 303.15 9.2 2.28 4389 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0049 303.15 7 2.28 4390 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56STE/COO_719 56STE/COO spectrophotometry B 2.8.3.5 3-oxoacid CoA-transferase C00091 + C00164 = C00042 + C00332 succinyl-CoA(aq) + acetoacetate(aq) = succinate(aq) + acetoacetyl-CoA(aq) 0.0059 303.15 7.5 2.28 4391 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.26 310.15 8.5 3 4392 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.63 310.15 8.5 2 4393 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.2 310.15 8.5 3.22 4394 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.33 310.15 8.5 2.4 4395 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.17 310.15 8.5 3.4 4396 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72GUS/GAN_691 72GUS/GAN enzymatic assay and spectrophotometry B 2.7.7.9 UTP-glucose-1-phosphate uridylyltransferase C00075 + C00103 = C00013 + C00029 UTP(aq) + D-glucose 1-phosphate(aq) = pyrophosphate(aq) + UDPglucose(aq) 0.13 310.15 8.5 3.7 4397 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=39COH_504 39COH C 2.6.1.2 alanine transaminase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 1 313.15 7.4 4398 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54HEL_1435 54HEL enzymatic assay C 6.2.1.1 acetate-CoA ligase C00002 + C00163 + C00010 = C00020 + C00013 + C00100 ATP(aq) + propanoate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + propanonyl-CoA(aq) 1.15 311.15 8 4399 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54HEL_1433 54HEL enzymatic assay C 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 0.86 311.15 8 4400 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54HEL_1433 54HEL enzymatic assay C 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 0.86 311.15 8.5 4401 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=54HEL_1433 54HEL enzymatic assay C 6.2.1.1 acetate-CoA ligase C00002 + C00033 + C00010 = C00020 + C00013 + C00024 ATP(aq) + acetate(aq) + CoA(aq) = AMP(aq) + diphosphate(aq) + acetyl-CoA(aq) 0.86 311.15 7.5 4402 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87OWU/TRE_1003 87OWU/TRE calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 6.9 4403 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=87OWU/TRE_1003 87OWU/TRE calorimetry B 3.5.1.5 urease C00086 + 2 C00001 = 2 C00014 + C00288 urea(aq) + 2 H2O(l) = 2 ammonia(aq) + carbon dioxide(aq) 298.15 7.9 4404 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=96OES/SCH_1412 96OES/SCH enzymatic assay and spectrophotometry B 5.4.2.8 phosphomannomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 1.4 298.15 7 4405 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=83VIT/HUA_1692 83VIT/HUA spectrophotometry B 2.4.2.3 uridine phosphorylase C00299 + C00009 = C00106 + C00620 uridine(aq) + orthophosphate(aq) = uracil(aq) + D-ribose 1-phosphate(aq) 0.58 303.15 7.56 4406 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=60GEL/STU_1079 60GEL/STU calorimetry A 2.7.3.2&3.6.1.32 creatine kinase and myosin ATPase C02305 + C00001 = C00300 + C00009 phosphocreatine(aq) + H2O(l) = creatine(aq) + orthophosphate(aq) 298.15 8 4407 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00215 278.05 7 4408 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00307 288.45 7 4409 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00511 300.55 7 4410 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0071 309.45 5.7 4411 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0091 309.45 7 4412 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.00673 309.45 7 4413 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0064 309.45 7.7 4414 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0067 309.45 7 4415 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0067 309.45 7 4416 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0098 309.45 7 4417 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68BAD/MIL_1211 68BAD/MIL amino acid analysis, Conway diffusion, and UV absorption A 4.3.1.1 aspartate ammonia-lyase C00049 = C00122 + C00014 L-aspartate(aq) = fumarate(aq) + ammonia(aq) 0.0098 309.45 7 4418 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=57REI_362 57REI radioactivity C 2.1.3.3 ornithine carbamoyltransferase C00169 + C00077 = C00327 + C00009 carbamoyl phosphate(aq) + L-ornithine(aq) = L-citrulline(aq) + orthophosphate(aq) 100000 310.15 7.4 4419 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61VLA/KOM_827 61VLA/KOM chromatography and radioactivity B 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 673 308.15 7.05 4420 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=61VLA/KOM_827 61VLA/KOM chromatography and radioactivity B 3.1.3.3 phosphoserine phosphatase C01005 + C00001 = C00065 + C00009 L-O-phosphoserine(aq) + H2O(l) = L-serine(aq) + orthophosphate(aq) 287 308.15 9.7 4421 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=80FUK/OBO_1256 80FUK/OBO spectrophotometry B 5.1.3.2 UDPglucose 4-epimerase C00029 = C00052 UDPglucose(aq) = UDPgalactose(aq) 0.29 298.15 8.7 4422 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.00775 291.1 9.1 4423 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.00585 297.6 9.1 4424 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.0103 281.2 9.1 4425 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.00719 285.3 9.1 4426 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.00526 305 9.1 4427 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=91SRI/NAM_308 91SRI/NAM spectrophotometry B 1.5.1.21 1-piperidine-2-carboxylate reductase C00408 + C00006 = C04092 + C00005 L-pipecolate(aq) + NADP(aq) =D-1-piperidine-2-carboxylate(aq) + NADPH(aq) 0.0111 277.8 9.1 4428 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=56RAB/PRI_353 56RAB/PRI spectrophotometry C 2.1.2.4 glycine formiminotransferase C00664 + C00037 = C02718 + C00101 5-formiminotetrahydrofolate(aq) + glycine(aq) = N-formiminoglycine(aq) + tetrahydrofolate(aq) 5 310.15 7 4429 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59MCC/NAJ_1403 59MCC/NAJ enzymatic assay C 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 17.2 303.15 7.5 4430 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55DIC/WIL_1332 55DIC/WIL chromatography and spectrophotometry C 5.3.1.6 ribose-5-phosphate isomerase C00117 = C00199 D-ribose 5-phosphate(aq) = D-ribulose 5-phosphate(aq) 0.59 310.15 7 4431 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02NES/ZHO_1591 02NES/ZHO chromatography and radioactivituy C 5.3.3.5 cholestenol -isomerase C05439 = C05437 (3,5)-cholesta-7,24-diene-3-ol(aq) = (3,5)-cholesta-8,24-diene-3-ol(aq) 14 310.15 7.5 4432 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=63DOM/ZEC_1372 63DOM/ZEC spectrophotometry C 5.3.1.14 L-rhamnose isomerase C00507 = C00861 L-rhamnose(aq) = L-rhamnulose(aq) 0.75 310.15 8.5 4433 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.53E-06 311.15 0.25 6.76 4434 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.64E-06 311.15 0.25 6.77 4435 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 3.1E-06 311.15 0.25 7.02 4436 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.28E-05 311.15 0.25 7.34 4437 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.09E-05 311.15 0.25 7.56 4438 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.46E-05 311.15 0.25 7.64 4439 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.86E-05 311.15 0.25 7.92 4440 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 3.28E-05 311.15 0.25 8.1 4441 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 3.77E-06 311.15 0.75 7 4442 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.45E-06 298.15 0.25 7.32 4443 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.28E-06 298.15 0.25 7.3 4444 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.61E-06 311.15 0.25 7.12 1.7 4445 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 3.14E-06 311.15 0.25 7 4446 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.83E-06 311.15 0.25 7.12 2.3 4447 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.23E-05 311.15 0.25 7.54 4448 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 3.14E-06 311.15 0.25 7.03 4449 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 1.12E-05 311.15 0.25 7.53 4450 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=81MER/MCA_204 81MER/MCA enzymatic assay and spectrophotometry A 1.1.1.95 phosphoglycerate dehydrogenase C00197 + C00003 = C03232 + C00004 3-phospho-D-glycerate(aq) + NAD(aq) = 3-phosphohydroxypyruvate(aq) + NADH(aq) 2.57E-06 311.15 0.15 7 4451 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=49MEY/GRE_818 49MEY/GRE chemical analysis C 3.1.3.2 acid phosphatase C01094 + C00001 = C00095 + C00009 D-fructose 1-phosphate(aq) + H2O(l) = D-fructose(aq) + orthophosphate(aq) 168 311.15 5.8 4452 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=86HUB/HUR_930 86HUB/HUR gas-liquid chromatography C 3.2.1.23 _-galactosidase C00243 + C00001 = C00124 + C00031 lactose(aq) + H2O(l) = D-galactose(aq) + D-glucose(aq) 86 298.15 7 4453 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 8.3E-05 298.15 7.61 4454 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0014 298.15 8.51 4455 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0025 298.15 8.83 4456 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 7.7E-05 298.15 7.58 4457 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.0011 298.15 8.38 4458 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=37EUL/ADL_95 37EUL/ADL spectrophotometry C 1.1.1.27 L-lactate dehydrogenase C00186 + C00003 = C00022 + C00004 (S)-lactate(aq) + NAD(aq) = pyruvate(aq) + NADH(aq) 0.002 298.15 8.82 4459 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.074 298.15 0.036 6.45 4460 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.079 298.15 0.048 7.3 4461 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.074 298.15 0.12 7.7 4462 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.076 298.15 0.25 6.95 4463 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.075 298.15 0.35 6.95 4464 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.083 298.15 0.084 6.8 4465 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.081 298.15 0.096 6.9 4466 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.069 298.15 0.45 6.95 4467 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=69VIL/DAL_157 69VIL/DAL spectrophotometry and pressure measurements A 1.1.1.44 phosphogluconate dehydrogenase (decarboxylating) C00345 + C00006 + C00001 = C00199 + C00005 + C00288 6-phospho-D-gluconate(aq) + NADP(aq) + H2O(l) = D-ribulose 5-phosphate(aq) + NADPH(aq) + carbon dioxide(aq) 0.08 298.15 0.12 6.95 4468 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=66GIB/MOR_534 66GIB/MOR D 2.6.1.35 glycine-oxaloacetate transaminase C00037 + C00036 = C00048 + C00049 glycine(aq) + oxaloacetate(aq) = glyoxylate(aq) + L-aspartate(aq) 0.016 298.15 7.1 4469 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43KRE/EGG_1159 43KRE/EGG polarimetry B 4.2.1.3 aconitate hydratase C00311 = C00417 + C00001 isocitrate(aq) = cis-aconitate(aq) + H2O(l) 0.69 311.15 7.4 4470 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1091 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 8E-05 303.15 7 4471 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1091 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00011 313.15 7 4472 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1091 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00045 333.15 7 4473 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=43MEY/JUN_1091 43MEY/JUN chemical analysis and polarimetry B 4.1.2.13 fructose-biphosphate aldolase C00354 = C00111 + C00118 D-fructose 1,6-bisphosphate(aq) = glycerone phosphate(aq) + D-glyceraldehyde 3-phosphate(aq) 0.00015 311.15 7 4474 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.19 273.3 0.12 8.5 4475 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.19 274.9 0.12 8.5 4476 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.2 278.2 0.12 8.5 4477 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.22 283.4 0.12 8.5 4478 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.25 289.9 0.12 8.5 4479 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.26 293.3 0.12 8.5 4480 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.27 299 0.12 8.5 4481 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.3 303.6 0.12 8.5 4482 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.31 303.6 0.12 8.5 4483 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.33 308.8 0.12 8.5 4484 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.36 313.3 0.12 8.5 4485 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.38 317.5 0.12 8.5 4486 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.34 313.7 0.12 8.5 4487 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.41 322.8 0.12 8.5 4488 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.24 288.4 0.12 8.5 4489 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.38 318.7 0.12 8.5 4490 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.2 279.3 0.12 8.5 4491 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.29 298.2 0.12 8.5 4492 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.26 294.3 0.12 8.5 4493 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.41 322 0.12 8.5 4494 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.22 284.7 0.12 8.5 4495 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.22 284.7 0.12 8.5 4496 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=2.&T1=68DYS/NOL_1358 68DYS/NOL spectrophotometry A 5.3.1.9 glucose-6-phosphate isomerase C00092 = C00085 D-glucose 6-phosphate(aq) = D-fructose 6-phosphate(aq) 0.33 308.2 0.12 8.5 4497 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=95LIA/WAN_331 95LIA/WAN calorimetry C 1.11.1.6 catalase C00027 = 0.5 C00007 + C00001 H2O2(aq) = 1/2 O2(aq) + H2O(l) 298.15 7 4498 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=58CAB/LEL_432 58CAB/LEL enzymatic assay and spectrophotometry C 2.4.1.15 ,-trehalose-phosphate synthase (UDP-forming) C00029 + C00092 = C00015 + C00689 UDP-glucose + D-glucose 6-phosphate = UDP + alpha,alpha'-trehalose 6-phosphate 40 310.15 6.1 4499 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.84E-05 318.14 0.25 7 3 4500 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.82E-05 298.15 6.94 3.26 4501 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.25E-05 278.43 0.25 7 3 4502 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.78E-05 298.15 0.25 7 3 4503 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 3.01E-05 298.15 6.98 3.22 4504 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 1.03E-05 298.15 0.25 7.8 3 4505 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.65E-05 298.15 0.25 7 3 4506 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 6.98E-05 298.15 0.25 6.7 3 4507 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.46E-05 280.13 0.25 7 3 4508 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 0.000111 298.15 0.25 6.4 3 4509 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 2.74E-05 307.93 0.25 7 3 4510 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=02DOB/HIT_1525 02DOB/HIT spectrophotometry and enzymatic assay A 2.7.1.40 pyruvate kinase C00002 + C00022 = C00074 + C00008 ATP(aq) + pyruvate(aq) = phosphoenolpyruvate(aq) + ADP(aq) 1.58E-05 298.15 0.25 7.4 3 4511 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=59ATK/JOH_1402 59ATK/JOH enzymatic assay and spectrophotometry B 5.4.2.2 phosphoglucomutase C00103 = C00092 -D-glucose 1-phosphate(aq) =-D-glucose 6-phosphate(aq) 17 298.15 7 4512 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=98TEW/CHE_1138 98TEW/CHE calorimetry A 4.1.3.- chorismate lyase C00251 = C00156 + C00022 chorismate(aq) = 4-hydroxybenzoate(aq) + pyruvate(aq) 298.15 6.98 4513 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BLA/WRI2_242 55BLA/WRI2 enzymatic assay B 1.2.1.11 aspartate-semialdehyde dehydrogenase C00441 + C00006 + C00009 = C03082 + C00005 L-aspartate 4-semialdehyde(aq) + NADP(aq) + orthophosphate(aq) = L-4-aspartyl phosphate(aq) + NADPH(aq) 200 298.15 5.7 4514 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55BLA/WRI2_242 55BLA/WRI2 enzymatic assay B 1.2.1.11 aspartate-semialdehyde dehydrogenase C00441 + C00006 + C00009 = C03082 + C00005 L-aspartate 4-semialdehyde(aq) + NADP(aq) + orthophosphate(aq) = L-4-aspartyl phosphate(aq) + NADPH(aq) 7.4 298.15 4.4 4515 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52STR/KOR_158 52STR/KOR spectrophotometry C 1.1.1.47 glucose dehydrogenase C00031 + C00003 = C00198 + C00004 -D-glucose(aq) + NAD(aq) = D-glucono-1,5-lactone(aq) + NADH(aq) 15 303.15 6.7 4516 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=70BRO/KRE_512 70BRO/KRE spectrophotometry A 2.6.1.2 alanine aminotransferase C00041 + C00026 = C00022 + C00025 L-alanine(aq) + 2-oxoglutarate(aq) = pyruvate(aq) + L-glutamate(aq) 0.68 311.15 0.25 7 4517 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=55SLE_1325 55SLE spectrophotometry B 5.3.1.5 xylose isomerase C00181 = C00310 D-xylose(aq) = D-xylulose(aq) 0.19 303.15 7.5 4518 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52FIT/DOU_419 52FIT/DOU chromatography C 2.4.1.8 maltose phosphorylase C00208 + C00009 = C00031 + C00103 maltose(aq) + orthophosphate(aq) = D-glucose(aq) + D-glucose 1-phosphate(aq) 0.23 310.15 7 4519 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.11 343.35 7.1 4520 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.107 343.35 7.1 4521 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.114 343.35 7.1 4522 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.104 343.35 7.1 4523 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.105 343.35 7.1 4524 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.109 343.35 7.1 4525 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=85MAK/KIE_1316 85MAK/KIE HPLC B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1.104 343.35 7.1 4526 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=89SCH/GIF_58 89SCH/GIF spectrophotometry C 1.1.1.14 L-iditol 2-dehydrogenase C01904 + C00003 = C00309 + C00004 D-arabitol(aq) + NAD(aq) = D-ribulose(aq) + NADH(aq) 0.0008 298.15 7 4527 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 0.0038 299.15 6.93 4528 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 0.0053 299.15 7.37 4529 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 5E-05 299.15 7.37 4530 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 0.0062 299.15 7.37 4531 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 0.0041 299.15 6.97 4532 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 0.004 299.15 7 4533 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=72BAK/JEN_290 72BAK/JEN radioactivity and spectrophotometry A 1.4.1.11 L-erythro-3,5-diaminohexanoate dehydrogenase C01186 + C00003 + C00001 = C03656 + C00004 + C00014 L-erythro-3,5-diaminohexanoate(aq) + NAD(aq) + H2O(l) = (S)-5-amino-3-oxohexanoate(aq) + NADH(aq) + ammonia(aq) 8.3E-05 299.15 7.37 4534 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=78CHR/MAT_1038 78CHR/MAT chromatography and radioactivity C 3.5.2.3 dihydroorotase C00337 + C00001 = C00438 (S)-dihydroorotate(aq) + H2O(l) = N-carbamoyl-L-aspartate(aq) 10.8 310.15 7.5 4535 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67DAN/YOS_1302 67DAN/YOS spectrophotometry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1 333.15 6.5 4536 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=67DAN/YOS_1302 67DAN/YOS spectrophotometry B 5.3.1.5 xylose isomerase C00031 = C00095 D-glucose(aq) = D-fructose(aq) 1 343.15 6.5 4537 +http://xpdb.nist.gov/enzyme_thermodynamics/enzyme_data1.pl?col=1.&T1=52LEL/CAR_698 52LEL/CAR paper chromatography and chemical analysis C 2.7.7.12&5.1.3.2 UDPglucose-hexose 1-phosphate uridylyltransferase and UDPglucose 4-epimerase C03384 = C00103 -D-galactose 1-phosphate(aq) =-D-glucose 1-phosphate(aq) 3 310.15 7.4 4538 + 85LIE A 1.1.-.- glycine cleavage system C00037 + C00003 + C00101 = C00143 + C00004 + C00014 + C00288 glycine(aq) + NAD+(aq) + THF(aq) = 5,10-CH2-THF(aq) + NADH(aq) + NH3(aq) + CO2(aq) 0.00156 311.15 0.25 7 4539 + 85LIE A 4.3.-.- formaldehyde condensation with THF C00101 + C00067 = C00143 THF(aq) + formaldehyde(aq) = 5,10-CH2-THF(aq) 30000 311.15 0.25 7 4540 + +66KAL/JEN E 4.3.-.- formaldehyde condensation with THF C00101 + C00067 = C00143 THF(aq) + formaldehyde(aq) = 5,10-CH2-THF(aq) 32000 298.15 1 7 4541 + +92MEY E 4.1.1.21 phosphoribosylaminoimidazole carboxylase C03373 + C00288 = C04751 + C00001 Aminoimidazole ribotide + CO2 = 1-(5-Phospho-D-ribosyl)-5-amino-4-imidazolecarboxylate 1.8 310.15 7.8 4542 + +00WAL E 2.1.2.3 phosphoribosylaminoimidazolecarboxamide formyltransferase C00234 + C04677 = C00101 + C04734 10-Formyltetrahydrofolate + 1-(5'-Phosphoribosyl)-5-amino-4-imidazolecarboxamide = Tetrahydrofolate + 1-(5'-Phosphoribosyl)-5-formamido-4-imidazolecarboxamide 0.024 298.15 7.5 4543 + +59BLA E 4.3.-.- formaldehyde condensation with THF C00101 + C00067 = C00143 THF(aq) + formaldehyde(aq) = 5,10-CH2-THF(aq) 7700 293.15 7.2 4544 + +74FER E 4.1.2.43 3-Hexulose-6-Phosphate synthase C00199 + C00067 = C06019 D-Ribulose 5-phosphate + Formaldehyde = D-arabino-Hex-3-ulose 6-phosphate 25000 303.15 7 4545 + +74FER E 5.3.1.27 3-Hexulose-6-Phosphate Isomerase C06019 = C00085 D-arabino-Hex-3-ulose 6-phosphate = D-Fructose 6-phosphate 188 303.15 7 4546 diff --git a/src/analysis/thermo/componentContribution/data/fixed_mappings.tsv b/src/analysis/thermo/trainingModel/data/fixed_mappings.tsv similarity index 100% rename from src/analysis/thermo/componentContribution/data/fixed_mappings.tsv rename to src/analysis/thermo/trainingModel/data/fixed_mappings.tsv diff --git a/src/analysis/thermo/componentContribution/data/formation_energies_transformed.tsv b/src/analysis/thermo/trainingModel/data/formation_energies_transformed.tsv similarity index 100% rename from src/analysis/thermo/componentContribution/data/formation_energies_transformed.tsv rename to src/analysis/thermo/trainingModel/data/formation_energies_transformed.tsv diff --git a/src/analysis/thermo/componentContribution/data/kegg_additions.tsv b/src/analysis/thermo/trainingModel/data/kegg_additions.tsv similarity index 100% rename from src/analysis/thermo/componentContribution/data/kegg_additions.tsv rename to src/analysis/thermo/trainingModel/data/kegg_additions.tsv diff --git a/src/analysis/thermo/componentContribution/data/kegg_inchi_additions.csv b/src/analysis/thermo/trainingModel/data/kegg_inchi_additions.csv similarity index 100% rename from src/analysis/thermo/componentContribution/data/kegg_inchi_additions.csv rename to src/analysis/thermo/trainingModel/data/kegg_inchi_additions.csv diff --git a/src/analysis/thermo/componentContribution/data/kegg_inchi_additions.txt b/src/analysis/thermo/trainingModel/data/kegg_inchi_additions.txt similarity index 100% rename from src/analysis/thermo/componentContribution/data/kegg_inchi_additions.txt rename to src/analysis/thermo/trainingModel/data/kegg_inchi_additions.txt diff --git a/src/analysis/thermo/trainingModel/data/mol/C00001.mol b/src/analysis/thermo/trainingModel/data/mol/C00001.mol new file mode 100644 index 0000000000..accc7eebf9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00001.mol @@ -0,0 +1,6 @@ +C00001 + Mrv1652304062119402D + + 1 0 0 0 0 0 999 V2000 + 10.5516 -7.7267 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00002.mol b/src/analysis/thermo/trainingModel/data/mol/C00002.mol new file mode 100644 index 0000000000..06758acc56 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00002.mol @@ -0,0 +1,70 @@ +C00002 + Mrv1652304062119402D + + 31 33 0 0 1 0 999 V2000 + 17.4246 -8.6466 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0509 -9.0826 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6633 -8.8923 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.7083 -7.8196 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7810 -8.5463 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1339 -9.9235 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9886 -8.3871 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4073 -9.6328 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.5665 -7.8231 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5250 -8.8716 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9160 -10.2729 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3311 -8.8577 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.5872 -9.6328 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.8848 -10.3075 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6218 -9.7504 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1823 -8.3837 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5491 -8.6051 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3242 -10.4148 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9367 -9.1588 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1062 -9.1588 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2793 -9.1588 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1029 -9.9857 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.1029 -8.3317 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4522 -9.1553 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6253 -9.1553 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4489 -9.9823 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.4489 -8.3248 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7949 -9.1518 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7914 -9.9788 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9679 -9.1449 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.7914 -8.3214 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 25 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 2 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 3 22 -1 26 -1 30 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00003.mol b/src/analysis/thermo/trainingModel/data/mol/C00003.mol new file mode 100644 index 0000000000..cb7b0ae69f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00003.mol @@ -0,0 +1,98 @@ +C00003 + Mrv1652304062119402D + + 44 48 0 0 1 0 999 V2000 + 15.5447 -12.5053 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.4132 -12.5053 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.6737 -11.7237 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.9789 -11.2026 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2842 -11.7237 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.0671 -13.2000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8908 -13.2000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4553 -11.4632 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5026 -10.4645 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 18.2803 -11.4632 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1487 -11.4632 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9737 -11.4632 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7987 -11.4632 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6237 -11.4632 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1487 -10.6382 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7987 -10.6382 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1487 -12.2882 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 20.7987 -12.2882 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.2408 -10.0303 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2408 -9.2053 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5026 -8.7711 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7645 -9.2053 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7645 -10.0303 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9355 -8.7711 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6737 -9.2053 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9355 -7.9461 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3605 -11.8539 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 23.6211 -12.6355 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.4895 -12.6355 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.7066 -11.8539 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 24.0553 -11.3329 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4921 -11.4632 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.4882 -10.5947 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1434 -13.3303 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9671 -13.2868 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0092 -9.9000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.5316 -9.2053 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7066 -9.4658 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7066 -10.2908 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0118 -9.0316 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2303 -9.4658 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2303 -10.2908 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9684 -10.7250 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0118 -8.2066 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 5 4 1 0 0 0 0 + 1 5 1 0 0 0 0 + 1 6 1 1 0 0 0 + 2 7 1 1 0 0 0 + 3 8 1 6 0 0 0 + 5 9 1 6 0 0 0 + 8 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 11 15 2 0 0 0 0 + 13 16 2 0 0 0 0 + 11 17 1 0 0 0 0 + 13 18 1 0 0 0 0 + 9 19 2 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 2 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 9 23 1 0 0 0 0 + 20 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 2 0 0 0 0 + 28 27 1 0 0 0 0 + 28 29 1 0 0 0 0 + 29 30 1 0 0 0 0 + 30 31 1 0 0 0 0 + 27 31 1 0 0 0 0 + 27 32 1 1 0 0 0 + 14 32 1 0 0 0 0 + 30 33 1 1 0 0 0 + 28 34 1 6 0 0 0 + 29 35 1 6 0 0 0 + 33 36 1 0 0 0 0 + 36 37 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 33 39 1 0 0 0 0 + 38 40 2 0 0 0 0 + 40 41 1 0 0 0 0 + 41 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 39 43 2 0 0 0 0 + 40 44 1 0 0 0 0 +M CHG 3 9 1 17 -1 18 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00004.mol b/src/analysis/thermo/trainingModel/data/mol/C00004.mol new file mode 100644 index 0000000000..e3fb4d9a56 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00004.mol @@ -0,0 +1,98 @@ +C00004 + Mrv1652304062119402D + + 44 48 0 0 1 0 999 V2000 + 20.9321 -10.2407 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1528 -9.9959 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5110 -11.6109 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.4027 -9.5743 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1453 -9.1791 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4375 -10.4139 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8335 -11.1217 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2626 -12.3790 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.9209 -8.9231 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4299 -8.7649 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7185 -10.0148 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1709 -11.5960 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.4306 -12.3790 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.7483 -13.0416 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7147 -9.1828 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4691 -7.9480 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3991 -11.3551 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9601 -13.0416 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7403 -11.3250 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8556 -11.3211 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7488 -11.3250 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8556 -12.2774 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.8556 -10.4063 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7247 -11.3211 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8438 -11.3286 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7285 -12.2361 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.7247 -10.4025 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0321 -11.3602 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2679 -11.6275 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5863 -11.1757 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0532 -12.4632 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.9276 -11.6877 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.2062 -12.4821 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.5390 -13.1083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1181 -10.8970 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7431 -13.1258 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7469 -10.4341 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3352 -10.4679 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7506 -9.6096 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3238 -9.6961 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0166 -9.2444 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4939 -9.1670 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2359 -9.5954 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4882 -8.3104 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 25 28 1 0 0 0 0 + 29 28 1 6 0 0 0 + 29 30 1 0 0 0 0 + 31 29 1 0 0 0 0 + 32 30 1 0 0 0 0 + 31 33 1 0 0 0 0 + 31 34 1 1 0 0 0 + 32 35 1 6 0 0 0 + 33 36 1 1 0 0 0 + 35 37 1 0 0 0 0 + 35 38 1 0 0 0 0 + 37 39 2 0 0 0 0 + 38 40 2 0 0 0 0 + 39 41 1 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 2 0 0 0 0 + 13 12 1 0 0 0 0 + 33 32 1 0 0 0 0 + 40 41 1 0 0 0 0 + 39 42 1 0 0 0 0 + 42 43 1 0 0 0 0 + 42 44 2 0 0 0 0 +M CHG 2 22 -1 26 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00005.mol b/src/analysis/thermo/trainingModel/data/mol/C00005.mol new file mode 100644 index 0000000000..cb9e6c1c56 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00005.mol @@ -0,0 +1,106 @@ +C00005 + Mrv1652304062119402D + + 48 52 0 0 1 0 999 V2000 + 28.1481 -14.1226 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 28.3590 -12.7514 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.9032 -14.8874 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 27.4736 -13.6329 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.5754 -12.5064 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.8299 -12.0845 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.0706 -14.8874 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 28.3853 -15.5504 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8107 -14.1075 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 27.5716 -11.6851 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8633 -12.9246 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3477 -11.4327 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5996 -15.5542 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3816 -16.6731 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0384 -13.8664 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8520 -11.2744 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1401 -12.5253 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3892 -17.6565 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 29.2255 -16.6770 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.5640 -16.6731 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3753 -13.8364 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1401 -11.6927 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8482 -10.4532 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.4899 -13.8325 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3861 -13.8325 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.4899 -14.7895 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.4937 -12.9132 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.3612 -13.8325 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4760 -13.8364 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.3651 -14.7480 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 22.3612 -12.9132 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6245 -13.8288 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8559 -14.0963 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.1778 -13.6442 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6450 -14.9325 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.5185 -14.1566 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.7935 -14.9477 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.1272 -15.5354 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7048 -13.3653 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3339 -15.5919 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3339 -12.9019 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9211 -12.9358 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3377 -12.0769 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9136 -12.1635 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6068 -11.7077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0234 -11.6248 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0196 -10.8977 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7542 -11.9939 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 6 0 0 0 + 9 4 1 0 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 6 0 0 0 + 8 14 1 0 0 0 0 + 9 15 1 1 0 0 0 + 10 16 2 0 0 0 0 + 11 17 1 0 0 0 0 + 14 18 1 0 0 0 0 + 14 19 1 0 0 0 0 + 14 20 2 0 0 0 0 + 15 21 1 0 0 0 0 + 16 22 1 0 0 0 0 + 16 23 1 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 25 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 2 0 0 0 0 + 29 32 1 0 0 0 0 + 33 32 1 6 0 0 0 + 33 34 1 0 0 0 0 + 35 33 1 0 0 0 0 + 36 34 1 0 0 0 0 + 35 37 1 0 0 0 0 + 35 38 1 1 0 0 0 + 36 39 1 6 0 0 0 + 37 40 1 1 0 0 0 + 39 41 1 0 0 0 0 + 39 42 1 0 0 0 0 + 41 43 2 0 0 0 0 + 42 44 2 0 0 0 0 + 43 45 1 0 0 0 0 + 43 46 1 0 0 0 0 + 46 47 1 0 0 0 0 + 46 48 2 0 0 0 0 + 7 9 1 0 0 0 0 + 10 12 1 0 0 0 0 + 17 22 2 0 0 0 0 + 37 36 1 0 0 0 0 + 44 45 1 0 0 0 0 +M CHG 4 18 -1 19 -1 26 -1 30 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00006.mol b/src/analysis/thermo/trainingModel/data/mol/C00006.mol new file mode 100644 index 0000000000..788e5af4bb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00006.mol @@ -0,0 +1,106 @@ +C00006 + Mrv1652304062119412D + + 48 52 0 0 1 0 999 V2000 + 27.6647 -13.9010 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 27.8676 -12.5593 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4227 -14.6483 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.9993 -13.4205 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.1025 -12.3173 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3302 -11.9079 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.6078 -14.6483 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 27.8961 -15.2961 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.3516 -13.8867 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 27.0988 -11.5131 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.4013 -12.7265 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8569 -11.2674 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1451 -15.3067 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8925 -16.4028 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 25.5971 -13.6094 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.3907 -11.1108 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.6967 -12.3350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8996 -17.3602 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 28.7146 -16.4065 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.0917 -16.4028 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9457 -13.6234 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.6967 -11.5202 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 26.3871 -10.3065 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0775 -13.6198 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 22.9990 -13.6198 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0775 -14.5523 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.0810 -12.7159 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9955 -13.6198 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1271 -13.6234 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9991 -14.5132 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 21.9955 -12.7159 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2943 -13.6162 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5435 -13.8760 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.8744 -13.4312 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3335 -14.6982 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.2302 -13.9330 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.5008 -14.7124 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.8068 -15.2818 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5003 -13.3933 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 18.0523 -15.3423 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2370 -12.9663 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7600 -12.9663 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2370 -12.1158 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7600 -12.1158 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5003 -11.6922 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9737 -11.6922 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7104 -12.1193 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9737 -10.8382 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 6 0 0 0 + 9 4 1 0 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 6 0 0 0 + 8 14 1 0 0 0 0 + 9 15 1 1 0 0 0 + 10 16 2 0 0 0 0 + 11 17 1 0 0 0 0 + 14 18 1 0 0 0 0 + 14 19 1 0 0 0 0 + 14 20 2 0 0 0 0 + 15 21 1 0 0 0 0 + 16 22 1 0 0 0 0 + 16 23 1 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 25 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 2 0 0 0 0 + 29 32 1 0 0 0 0 + 33 32 1 6 0 0 0 + 33 34 1 0 0 0 0 + 35 33 1 0 0 0 0 + 36 34 1 0 0 0 0 + 35 37 1 0 0 0 0 + 35 38 1 1 0 0 0 + 36 39 1 6 0 0 0 + 37 40 1 1 0 0 0 + 39 41 2 0 0 0 0 + 39 42 1 0 0 0 0 + 41 43 1 0 0 0 0 + 42 44 2 0 0 0 0 + 43 45 2 0 0 0 0 + 43 46 1 0 0 0 0 + 46 47 1 0 0 0 0 + 46 48 2 0 0 0 0 + 7 9 1 0 0 0 0 + 10 12 1 0 0 0 0 + 17 22 2 0 0 0 0 + 37 36 1 0 0 0 0 + 44 45 1 0 0 0 0 +M CHG 5 18 -1 19 -1 26 -1 30 -1 39 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00007.mol b/src/analysis/thermo/trainingModel/data/mol/C00007.mol new file mode 100644 index 0000000000..7c75f3fb68 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00007.mol @@ -0,0 +1,8 @@ +C00007 + Mrv1652304062119412D + + 2 1 0 0 0 0 999 V2000 + 14.3459 -10.0207 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1709 -10.0207 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00008.mol b/src/analysis/thermo/trainingModel/data/mol/C00008.mol new file mode 100644 index 0000000000..6fb8c86afe --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00008.mol @@ -0,0 +1,62 @@ +C00008 + Mrv1652304062119412D + + 27 29 0 0 1 0 999 V2000 + 17.2092 -8.9097 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8414 -9.3485 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4455 -9.1584 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.4926 -8.0804 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5740 -8.8094 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9209 -10.1950 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7683 -8.6540 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1864 -9.9048 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.3529 -8.0839 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3204 -9.1412 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7087 -10.5440 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1118 -9.1239 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3675 -9.9048 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.6667 -10.5786 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4136 -10.0223 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9769 -8.6505 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3274 -8.8682 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1014 -10.6857 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7124 -9.4211 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8832 -9.4211 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0573 -9.4211 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8797 -10.2468 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.8797 -8.5952 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2316 -9.4176 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2280 -10.2435 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4057 -9.4176 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2280 -8.5883 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 2 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 22 -1 26 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00009.mol b/src/analysis/thermo/trainingModel/data/mol/C00009.mol new file mode 100644 index 0000000000..20b76894b3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00009.mol @@ -0,0 +1,15 @@ +C00009 + Mrv1652304062119412D + + 5 4 0 0 0 0 999 V2000 + 16.2991 -12.7717 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6195 -13.1585 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0926 -13.1194 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.5006 -13.6823 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2991 -11.9880 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00010.mol b/src/analysis/thermo/trainingModel/data/mol/C00010.mol new file mode 100644 index 0000000000..9bff48fe0a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00010.mol @@ -0,0 +1,104 @@ +C00010 + Mrv1652304062119412D + + 48 50 0 0 1 0 999 V2000 + 12.6750 -8.3538 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3338 -9.7864 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.2348 -8.3538 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6787 -7.5239 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6518 -9.2937 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0838 -10.5633 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.2348 -7.5239 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5110 -8.7782 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9587 -7.1032 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9809 -9.7750 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.2424 -10.5633 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.5235 -11.1359 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5110 -7.1108 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7984 -8.3538 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2116 -9.5324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8218 -11.1545 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7984 -7.5239 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5110 -6.3299 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1275 -10.1121 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9463 -11.1469 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7673 -10.0819 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9616 -10.3171 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.1844 -11.1206 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.9840 -11.9769 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7673 -11.8706 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7748 -9.2029 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 6.9863 -10.1121 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7709 -13.5985 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6313 -13.5796 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8049 -14.5724 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 6.9448 -13.5833 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3399 -13.1702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0562 -13.5796 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7687 -13.1702 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.0448 -14.3147 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0373 -12.7759 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4850 -13.5796 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7687 -12.3440 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1974 -13.1702 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4850 -14.3605 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9099 -13.5796 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6262 -13.1702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3387 -13.5796 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0512 -13.1702 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3387 -14.4057 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7675 -13.5796 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4799 -13.1665 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1923 -13.5796 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 6 2 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 4 9 2 0 0 0 0 + 10 5 1 0 0 0 0 + 6 11 1 0 0 0 0 + 6 12 1 6 0 0 0 + 7 13 2 0 0 0 0 + 8 14 1 0 0 0 0 + 10 15 1 1 0 0 0 + 11 16 1 6 0 0 0 + 13 17 1 0 0 0 0 + 13 18 1 0 0 0 0 + 15 19 1 0 0 0 0 + 16 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 1 0 0 0 0 + 20 24 2 0 0 0 0 + 21 25 1 0 0 0 0 + 21 26 1 0 0 0 0 + 21 27 2 0 0 0 0 + 25 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 2 0 0 0 0 + 29 32 1 0 0 0 0 + 32 33 1 0 0 0 0 + 34 33 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 1 0 0 0 0 + 34 37 1 0 0 0 0 + 34 38 1 1 0 0 0 + 37 39 1 0 0 0 0 + 37 40 2 0 0 0 0 + 39 41 1 0 0 0 0 + 41 42 1 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 1 0 0 0 0 + 43 45 2 0 0 0 0 + 44 46 1 0 0 0 0 + 46 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 7 9 1 0 0 0 0 + 11 10 1 0 0 0 0 + 14 17 2 0 0 0 0 +M CHG 4 22 -1 23 -1 26 -1 30 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00011.mol b/src/analysis/thermo/trainingModel/data/mol/C00011.mol new file mode 100644 index 0000000000..f989ac7059 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00011.mol @@ -0,0 +1,10 @@ +C00011 + Mrv1652304062119412D + + 3 2 0 0 0 0 999 V2000 + 12.8697 -7.0664 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1560 -7.4802 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5834 -7.4802 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00013.mol b/src/analysis/thermo/trainingModel/data/mol/C00013.mol new file mode 100644 index 0000000000..762096ea30 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00013.mol @@ -0,0 +1,23 @@ +C00013 + Mrv1652304062119412D + + 9 8 0 0 0 0 999 V2000 + 13.2279 -11.9420 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9969 -11.9490 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5076 -11.9490 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2626 -12.7807 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.2486 -10.9886 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8148 -11.9524 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8426 -12.7841 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.5804 -11.9420 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.8251 -10.9851 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 9 2 0 0 0 0 +M CHG 3 4 -1 7 -1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00014.mol b/src/analysis/thermo/trainingModel/data/mol/C00014.mol new file mode 100644 index 0000000000..54f051825c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00014.mol @@ -0,0 +1,7 @@ +C00014 + Mrv1652304062119412D + + 1 0 0 0 0 0 999 V2000 + 12.2103 -9.1165 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 +M CHG 1 1 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00015.mol b/src/analysis/thermo/trainingModel/data/mol/C00015.mol new file mode 100644 index 0000000000..a3a69d4211 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00015.mol @@ -0,0 +1,57 @@ +C00015 + Mrv1652304062119412D + + 25 26 0 0 1 0 999 V2000 + 15.4915 -9.9021 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.3730 -9.5674 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8486 -9.4312 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2508 -10.7099 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.0431 -9.9906 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3481 -8.7418 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1784 -9.9227 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4224 -10.7099 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7355 -11.3732 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7668 -9.5856 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0741 -10.8116 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0609 -8.3351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3913 -9.6684 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9344 -11.3698 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7797 -8.7605 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8070 -10.2424 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5007 -8.3594 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9854 -10.2424 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1639 -10.2424 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9820 -11.0639 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.9820 -9.4209 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3424 -10.2390 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3355 -11.0605 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.5175 -10.2390 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3355 -9.4140 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 +M CHG 2 20 -1 23 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00016.mol b/src/analysis/thermo/trainingModel/data/mol/C00016.mol new file mode 100644 index 0000000000..cc2c3b8089 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00016.mol @@ -0,0 +1,117 @@ +C00016 + Mrv1652304062119412D + + 53 58 0 0 1 0 999 V2000 + 12.2513 -7.5900 0.0000 N 0 5 0 0 0 0 0 0 0 0 0 0 + 12.2513 -8.4150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9525 -8.8275 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6950 -8.4150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6950 -7.5900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9525 -7.1775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3963 -8.8275 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0975 -8.4150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0975 -7.5900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3963 -7.1775 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8400 -8.8275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5413 -8.4150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5413 -7.5900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8400 -7.1775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9525 -6.3525 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5500 -8.8275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2425 -7.1775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2425 -8.8275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3963 -10.1888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0975 -10.6013 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7988 -10.1888 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5000 -10.6013 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2013 -10.1888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9025 -10.6013 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0975 -11.4263 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5000 -11.4263 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7988 -9.3638 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7275 -10.6013 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5525 -10.6013 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7275 -9.7763 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7275 -11.4263 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 20.3775 -10.6013 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2025 -10.6013 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3775 -9.7763 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3775 -11.4263 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 22.6463 -10.6013 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.9450 -10.1888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8938 -11.3850 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 23.7188 -11.3850 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 23.9663 -10.6013 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 23.3063 -10.1063 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.3988 -12.0450 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1725 -12.0863 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.6875 -8.2088 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 22.6875 -9.0338 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3888 -9.4463 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1313 -9.0338 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1313 -8.2088 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3888 -7.7963 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9150 -9.2813 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3688 -8.6213 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9150 -7.9613 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3888 -6.9713 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 9 10 1 0 0 0 0 + 5 10 2 0 0 0 0 + 8 11 1 0 0 0 0 + 11 12 2 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 2 0 0 0 0 + 9 14 1 0 0 0 0 + 6 15 2 0 0 0 0 + 2 16 2 0 0 0 0 + 13 17 1 0 0 0 0 + 12 18 1 0 0 0 0 + 7 19 1 0 0 0 0 + 20 19 1 0 0 0 0 + 21 20 1 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 20 25 1 1 0 0 0 + 22 26 1 1 0 0 0 + 21 27 1 6 0 0 0 + 24 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 2 0 0 0 0 + 28 31 1 0 0 0 0 + 29 32 1 0 0 0 0 + 32 33 1 0 0 0 0 + 32 34 2 0 0 0 0 + 32 35 1 0 0 0 0 + 36 37 1 1 0 0 0 + 33 37 1 0 0 0 0 + 38 36 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 1 0 0 0 0 + 36 41 1 0 0 0 0 + 38 42 1 6 0 0 0 + 39 43 1 6 0 0 0 + 44 45 2 0 0 0 0 + 45 46 1 0 0 0 0 + 46 47 2 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 2 0 0 0 0 + 44 49 1 0 0 0 0 + 47 50 1 0 0 0 0 + 50 51 1 0 0 0 0 + 51 52 2 0 0 0 0 + 48 52 1 0 0 0 0 + 40 50 1 1 0 0 0 + 49 53 1 0 0 0 0 +M CHG 3 1 -1 31 -1 35 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00020.mol b/src/analysis/thermo/trainingModel/data/mol/C00020.mol new file mode 100644 index 0000000000..812edc5515 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00020.mol @@ -0,0 +1,54 @@ +C00020 + Mrv1652304062119412D + + 23 25 0 0 1 0 999 V2000 + 15.9639 -10.6383 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6017 -11.0786 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2013 -10.8879 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.2516 -9.8064 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3366 -10.5378 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6814 -11.9243 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5219 -10.3783 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9448 -11.6332 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.1148 -9.8099 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0854 -10.8671 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4718 -12.2744 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8633 -10.8532 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.1198 -11.6332 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3365 -12.3091 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1824 -11.7545 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7439 -10.3749 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0764 -10.5968 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8529 -12.4201 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4594 -11.1479 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6275 -11.1479 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6241 -11.9798 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.7991 -11.1479 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6241 -10.3194 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 2 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 21 -1 22 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00021.mol b/src/analysis/thermo/trainingModel/data/mol/C00021.mol new file mode 100644 index 0000000000..e29cebbb83 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00021.mol @@ -0,0 +1,60 @@ +C00021 + Mrv1652304062119412D + + 26 28 0 0 1 0 999 V2000 + 18.2395 -13.1357 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.6115 -12.6821 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0092 -13.8475 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.9975 -13.1218 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2382 -13.8475 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.4593 -14.4580 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2787 -12.8984 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7642 -14.5063 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0433 -12.8729 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7115 -13.3566 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3781 -12.8705 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1218 -12.0864 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2968 -12.0879 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7996 -14.1797 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5564 -14.5151 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2230 -14.0290 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1349 -13.2059 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8151 -12.7097 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5498 -13.3280 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8329 -12.9140 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1160 -13.3280 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3991 -12.9140 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.6821 -13.3280 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9652 -12.9140 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.3991 -12.0863 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.6821 -14.1556 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 4 2 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 1 6 0 0 0 + 4 7 1 1 0 0 0 + 5 8 1 6 0 0 0 + 5 4 1 0 0 0 0 + 1 9 1 1 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 2 0 0 0 0 + 9 13 1 0 0 0 0 + 10 14 2 0 0 0 0 + 14 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 16 17 1 0 0 0 0 + 11 17 2 0 0 0 0 + 17 18 1 0 0 0 0 + 7 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 22 21 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 22 25 1 1 0 0 0 + 23 26 2 0 0 0 0 +M CHG 2 24 -1 25 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00022.mol b/src/analysis/thermo/trainingModel/data/mol/C00022.mol new file mode 100644 index 0000000000..c33abc77a2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00022.mol @@ -0,0 +1,17 @@ +C00022 + Mrv1652304062119412D + + 6 5 0 0 0 0 999 V2000 + 7.4795 -10.2713 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.1940 -9.8588 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9084 -10.2713 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6241 -9.8580 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.1940 -9.0339 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9084 -11.0963 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 2 0 0 0 0 +M CHG 1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00023.mol b/src/analysis/thermo/trainingModel/data/mol/C00023.mol new file mode 100644 index 0000000000..3f4db85571 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00023.mol @@ -0,0 +1,6 @@ +C00023 + Mrv1652304062119412D + + 1 0 0 0 0 0 999 V2000 + 22.1200 -16.1700 0.0000 Fe 0 0 0 0 0 0 0 0 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00024.mol b/src/analysis/thermo/trainingModel/data/mol/C00024.mol new file mode 100644 index 0000000000..f016560db7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00024.mol @@ -0,0 +1,110 @@ +C00024 + Mrv1652304062119412D + + 51 53 0 0 1 0 999 V2000 + 5.1695 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8840 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.5984 -12.1275 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 7.3129 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0274 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7418 -11.7150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4563 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1708 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8852 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5997 -11.7150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3142 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0286 -11.7150 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.7431 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4576 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1720 -12.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8840 -10.8901 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4563 -12.9524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3142 -12.9523 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0286 -10.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7431 -11.3025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7431 -12.9525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9970 -12.1275 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8220 -12.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9970 -12.9525 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.1688 -9.1988 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.9938 -9.1988 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.2487 -8.4141 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.5813 -7.9292 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9138 -8.4141 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0263 -8.1614 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6838 -9.8662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4787 -9.8662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3037 -9.8662 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3037 -9.0412 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.1287 -9.8662 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3037 -10.6912 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4875 -7.3425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4875 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9165 -8.1675 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9165 -7.3425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2020 -6.9300 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7731 -6.9300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0585 -7.3425 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0585 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7731 -8.5800 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7731 -6.1051 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1944 -8.4162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0194 -8.4162 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0194 -7.5912 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.8444 -8.4162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0194 -10.3137 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 +M CHG 4 24 -1 34 -1 35 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00025.mol b/src/analysis/thermo/trainingModel/data/mol/C00025.mol new file mode 100644 index 0000000000..fc1f032695 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00025.mol @@ -0,0 +1,25 @@ +C00025 + Mrv1652304062119412D + + 10 9 0 0 1 0 999 V2000 + 14.0636 -10.3017 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.7646 -9.8665 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3351 -9.9114 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0878 -11.1269 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.4931 -10.2533 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6513 -10.3811 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.3454 -9.0862 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1941 -9.8182 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9226 -10.2084 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2078 -8.9929 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 3 4 1 6 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00026.mol b/src/analysis/thermo/trainingModel/data/mol/C00026.mol new file mode 100644 index 0000000000..380198dcd6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00026.mol @@ -0,0 +1,25 @@ +C00026 + Mrv1652304062119412D + + 10 9 0 0 0 0 999 V2000 + 16.4017 -12.3778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6859 -11.9649 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1137 -11.9649 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4017 -13.2446 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9738 -12.3778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8258 -12.3815 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.1099 -11.1430 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2580 -11.9649 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2618 -11.1430 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5459 -12.3815 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 8 10 1 0 0 0 0 +M CHG 2 6 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00027.mol b/src/analysis/thermo/trainingModel/data/mol/C00027.mol new file mode 100644 index 0000000000..82ad359f8b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00027.mol @@ -0,0 +1,8 @@ +C00027 + Mrv1652304062119412D + + 2 1 0 0 0 0 999 V2000 + 17.4487 -8.4975 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2737 -8.4975 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00029.mol b/src/analysis/thermo/trainingModel/data/mol/C00029.mol new file mode 100644 index 0000000000..0673b8125c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00029.mol @@ -0,0 +1,80 @@ +C00029 + Mrv1652304062119412D + + 36 38 0 0 1 0 999 V2000 + 17.2520 -9.2686 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.2116 -9.0395 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6110 -8.7937 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0094 -10.0763 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.9312 -9.4423 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2049 -8.2142 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9349 -9.2858 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.1844 -10.0763 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.4946 -10.7414 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6513 -9.0190 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9448 -10.2663 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9133 -7.7855 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1478 -9.0328 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6923 -10.7380 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6404 -8.1909 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5620 -9.6084 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3546 -7.7724 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7370 -9.6084 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9120 -9.6084 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7335 -10.4333 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7335 -8.7833 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0904 -9.6049 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2620 -9.6049 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0835 -10.4264 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.0835 -8.7799 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5478 -10.0137 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.8373 -9.6049 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5478 -10.8385 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.1233 -10.0137 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.8373 -11.2515 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.2620 -11.2515 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1233 -10.8385 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.4092 -9.6049 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8373 -12.0765 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4092 -11.2515 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6995 -10.0137 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 26 27 1 0 0 0 0 + 28 26 1 0 0 0 0 + 29 27 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 1 6 0 0 0 + 32 29 1 0 0 0 0 + 29 33 1 1 0 0 0 + 30 34 1 1 0 0 0 + 32 35 1 6 0 0 0 + 33 36 1 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 + 30 32 1 0 0 0 0 +M CHG 2 20 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00031.mol b/src/analysis/thermo/trainingModel/data/mol/C00031.mol new file mode 100644 index 0000000000..aa44b8748e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00031.mol @@ -0,0 +1,29 @@ +C00031 + Mrv1652304062119412D + + 12 12 0 0 1 0 999 V2000 + 14.3016 -9.7417 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3016 -10.5667 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.0132 -9.3292 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5866 -9.3292 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0132 -10.9791 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.5866 -10.9791 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7316 -9.7417 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 12.9610 -9.8655 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7316 -10.5667 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.0132 -11.8041 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4431 -9.3292 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4431 -10.9791 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 1 0 0 0 + 7 11 1 4 0 0 0 + 9 12 1 6 0 0 0 + 9 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00033.mol b/src/analysis/thermo/trainingModel/data/mol/C00033.mol new file mode 100644 index 0000000000..282e2d8171 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00033.mol @@ -0,0 +1,13 @@ +C00033 + Mrv1652304062119412D + + 4 3 0 0 0 0 999 V2000 + 14.4508 -9.2633 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1648 -9.6766 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7403 -9.6766 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.4508 -8.4401 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 +M CHG 1 3 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00034.mol b/src/analysis/thermo/trainingModel/data/mol/C00034.mol new file mode 100644 index 0000000000..8b87e7f2e6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00034.mol @@ -0,0 +1,6 @@ +C00034 + Mrv1652304062119412D + + 1 0 0 0 0 0 999 V2000 + 22.1200 -16.1700 0.0000 Mn 0 0 0 0 0 0 0 0 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00035.mol b/src/analysis/thermo/trainingModel/data/mol/C00035.mol new file mode 100644 index 0000000000..c0eeab3a67 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00035.mol @@ -0,0 +1,64 @@ +C00035 + Mrv1652304062119412D + + 28 30 0 0 1 0 999 V2000 + 17.1973 -8.5817 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8254 -9.0201 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4309 -8.8302 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.4803 -7.7533 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5606 -8.4816 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9083 -9.8624 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7578 -8.3229 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1756 -9.5724 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.3398 -7.7567 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3028 -8.8096 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6919 -10.2110 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1020 -8.7958 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3574 -9.5724 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.6553 -10.2454 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3995 -9.6932 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9621 -8.3194 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7816 -11.0325 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3150 -8.5403 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0917 -10.3560 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7006 -9.0892 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8756 -9.0892 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0507 -9.0892 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8722 -9.9176 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.8722 -8.2641 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2256 -9.0857 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2603 -9.9141 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.3972 -9.0857 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2603 -8.2608 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 2 0 0 0 0 + 11 17 1 0 0 0 0 + 12 18 1 1 0 0 0 + 13 19 1 6 0 0 0 + 18 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 22 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 25 27 1 0 0 0 0 + 25 28 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 1 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 23 -1 26 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00036.mol b/src/analysis/thermo/trainingModel/data/mol/C00036.mol new file mode 100644 index 0000000000..dbcb1b8a24 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00036.mol @@ -0,0 +1,23 @@ +C00036 + Mrv1652304062119412D + + 9 8 0 0 0 0 999 V2000 + 10.5602 -12.1278 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2747 -12.5403 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9892 -12.1278 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7037 -12.5403 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4182 -12.1278 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1327 -12.5403 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2747 -13.3652 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7037 -13.3653 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4182 -11.3028 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 2 0 0 0 0 +M CHG 2 1 -1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00037.mol b/src/analysis/thermo/trainingModel/data/mol/C00037.mol new file mode 100644 index 0000000000..e59351febb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00037.mol @@ -0,0 +1,15 @@ +C00037 + Mrv1652304062119412D + + 5 4 0 0 0 0 999 V2000 + 14.9132 -10.2522 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6028 -10.7050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1782 -10.6668 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.9272 -9.4128 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3288 -10.3401 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 +M CHG 2 3 -1 5 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00041.mol b/src/analysis/thermo/trainingModel/data/mol/C00041.mol new file mode 100644 index 0000000000..fccc7773ce --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00041.mol @@ -0,0 +1,17 @@ +C00041 + Mrv1652304062119412D + + 6 5 0 0 1 0 999 V2000 + 13.4054 -9.2810 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.1198 -8.8684 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8343 -9.2810 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.5488 -8.8684 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1198 -8.0436 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8343 -10.1058 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 6 0 0 0 +M CHG 2 1 -1 6 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00042.mol b/src/analysis/thermo/trainingModel/data/mol/C00042.mol new file mode 100644 index 0000000000..73fd9f36c2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00042.mol @@ -0,0 +1,21 @@ +C00042 + Mrv1652304062119412D + + 8 7 0 0 0 0 999 V2000 + 9.9827 -7.9202 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.6972 -7.5077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4117 -7.9202 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1262 -7.5077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8406 -7.9202 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5552 -7.5077 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.6972 -6.6828 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8406 -8.7451 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 5 8 2 0 0 0 0 +M CHG 2 1 -1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00043.mol b/src/analysis/thermo/trainingModel/data/mol/C00043.mol new file mode 100644 index 0000000000..c213f0c982 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00043.mol @@ -0,0 +1,86 @@ +C00043 + Mrv1652304062119412D + + 39 41 0 0 1 0 999 V2000 + 19.3904 -16.6885 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.0344 -15.3549 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7184 -16.1995 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1512 -17.4591 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.3271 -14.9256 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7593 -14.9256 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0568 -16.6744 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.3278 -17.4591 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.6368 -18.1277 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3271 -14.0916 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6093 -15.3338 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7593 -14.0916 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2756 -16.4281 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8422 -18.1277 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0379 -13.6834 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0997 -15.6223 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0379 -12.8566 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2728 -15.6223 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4494 -15.6223 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2728 -14.7954 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2693 -16.4422 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6295 -15.6223 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7991 -15.6188 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6295 -14.7954 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.6295 -16.4422 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0848 -16.0234 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.0848 -16.8539 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.3670 -15.6188 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3670 -17.2620 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.9539 -17.5436 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6527 -16.0234 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.6527 -16.8539 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.3670 -18.0854 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2038 -18.2825 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9523 -15.6188 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9523 -17.2620 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0166 -18.3845 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6970 -18.9335 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3225 -16.1466 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 27 26 1 0 0 0 0 + 26 28 1 0 0 0 0 + 27 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 31 28 1 0 0 0 0 + 29 32 1 0 0 0 0 + 29 33 1 1 0 0 0 + 30 34 1 0 0 0 0 + 31 35 1 1 0 0 0 + 32 36 1 6 0 0 0 + 34 37 1 0 0 0 0 + 34 38 2 0 0 0 0 + 35 39 1 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 + 32 31 1 0 0 0 0 +M CHG 2 20 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00044.mol b/src/analysis/thermo/trainingModel/data/mol/C00044.mol new file mode 100644 index 0000000000..6370476b19 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00044.mol @@ -0,0 +1,72 @@ +C00044 + Mrv1652304062119412D + + 32 34 0 0 1 0 999 V2000 + 18.0544 -8.5813 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6812 -9.0244 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2892 -8.8340 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.3314 -7.7572 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4117 -8.4809 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7608 -9.8658 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6140 -8.3250 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0330 -9.5750 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.1900 -7.7606 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1527 -8.8132 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5467 -10.2087 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9596 -8.7994 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.2158 -9.5750 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.4693 -10.3261 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2496 -9.6927 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.8071 -8.3215 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6368 -11.0292 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1770 -8.5397 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8663 -10.3126 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5608 -9.0902 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7333 -9.0902 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9022 -9.0902 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7263 -9.9177 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7263 -8.2627 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0746 -9.0867 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2471 -9.0867 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0712 -9.9144 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.0712 -8.2557 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4196 -9.0798 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4127 -9.9109 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.5886 -9.0764 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4127 -8.2523 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 2 0 0 0 0 + 11 17 1 0 0 0 0 + 12 18 1 1 0 0 0 + 13 19 1 6 0 0 0 + 18 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 22 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 25 27 1 0 0 0 0 + 25 28 2 0 0 0 0 + 26 29 1 0 0 0 0 + 29 30 1 0 0 0 0 + 29 31 1 0 0 0 0 + 29 32 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 1 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 3 23 -1 27 -1 30 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00047.mol b/src/analysis/thermo/trainingModel/data/mol/C00047.mol new file mode 100644 index 0000000000..abf020dedc --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00047.mol @@ -0,0 +1,25 @@ +C00047 + Mrv1652304062119412D + + 10 9 0 0 1 0 999 V2000 + 17.5264 -10.0808 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.8153 -9.6625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2375 -9.6207 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5264 -10.9174 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.1042 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9486 -10.0390 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.2375 -8.7841 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3513 -9.7044 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6402 -10.1227 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8873 -9.7044 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 +M CHG 3 4 1 6 -1 10 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00048.mol b/src/analysis/thermo/trainingModel/data/mol/C00048.mol new file mode 100644 index 0000000000..eeb5d2ab34 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00048.mol @@ -0,0 +1,15 @@ +C00048 + Mrv1652304062119412D + + 5 4 0 0 0 0 999 V2000 + 16.8786 -11.3200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1574 -11.7205 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5861 -11.7491 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.8925 -10.4900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1438 -12.5429 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 2 0 0 0 0 +M CHG 1 3 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00049.mol b/src/analysis/thermo/trainingModel/data/mol/C00049.mol new file mode 100644 index 0000000000..51d48c1cfa --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00049.mol @@ -0,0 +1,23 @@ +C00049 + Mrv1652304062119412D + + 9 8 0 0 1 0 999 V2000 + 17.3591 -10.4573 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.0702 -10.0390 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8231 -10.4573 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.5342 -10.0390 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2453 -10.4573 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9982 -10.0390 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.0702 -9.2024 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8231 -11.2939 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 20.2453 -11.2939 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 3 8 1 6 0 0 0 + 5 9 2 0 0 0 0 +M CHG 3 1 -1 6 -1 8 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00051.mol b/src/analysis/thermo/trainingModel/data/mol/C00051.mol new file mode 100644 index 0000000000..dc8c3159ab --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00051.mol @@ -0,0 +1,45 @@ +C00051 + Mrv1652304062119412D + + 20 19 0 0 1 0 999 V2000 + 14.1488 -9.6113 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.8500 -9.1988 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5925 -9.6113 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.2938 -9.1988 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9950 -9.6113 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7375 -9.1988 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4388 -9.6113 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1400 -9.1988 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.8825 -9.6113 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5838 -9.1988 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2850 -9.6113 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0275 -9.1988 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7288 -9.6113 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.8500 -8.3738 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5925 -10.4363 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 17.7375 -8.3738 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1400 -8.3738 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8413 -7.9613 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8825 -10.4363 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0275 -8.3738 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 8 7 1 1 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 2 14 2 0 0 0 0 + 3 15 1 6 0 0 0 + 6 16 2 0 0 0 0 + 8 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 9 19 2 0 0 0 0 + 12 20 2 0 0 0 0 +M CHG 3 1 -1 13 -1 15 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00052.mol b/src/analysis/thermo/trainingModel/data/mol/C00052.mol new file mode 100644 index 0000000000..f34732acda --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00052.mol @@ -0,0 +1,80 @@ +C00052 + Mrv1652304062119412D + + 36 38 0 0 1 0 999 V2000 + 19.2943 -16.9270 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9375 -15.5875 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6207 -16.4352 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0521 -17.6952 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.2300 -15.1637 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6641 -15.1637 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9623 -16.9082 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.2309 -17.6952 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.5401 -18.3611 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2300 -14.3313 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5147 -15.5686 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6641 -14.3313 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1791 -16.6584 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7467 -18.3649 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9413 -13.9189 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0050 -15.8562 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9413 -13.2202 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1801 -15.8524 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3552 -15.8524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1801 -14.9892 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2184 -16.6773 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5342 -15.8524 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7054 -15.8487 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5342 -14.9892 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5342 -16.6773 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9941 -16.2611 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2750 -15.8487 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9941 -17.0861 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5600 -16.2611 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2750 -17.4947 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.7054 -17.4947 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5600 -17.0861 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.8561 -15.8487 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2750 -18.3158 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8561 -17.4947 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2281 -16.3822 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 26 27 1 0 0 0 0 + 28 26 1 0 0 0 0 + 29 27 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 1 6 0 0 0 + 32 29 1 0 0 0 0 + 29 33 1 1 0 0 0 + 30 34 1 1 0 0 0 + 32 35 1 1 0 0 0 + 33 36 1 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 + 30 32 1 0 0 0 0 +M CHG 2 20 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00055.mol b/src/analysis/thermo/trainingModel/data/mol/C00055.mol new file mode 100644 index 0000000000..77f623076c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00055.mol @@ -0,0 +1,49 @@ +C00055 + Mrv1652304062119412D + + 21 22 0 0 1 0 999 V2000 + 14.6437 -12.1275 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.8912 -12.9112 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.7162 -12.9112 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.9637 -12.1275 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3037 -11.6325 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8600 -11.8387 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7475 -11.9212 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4487 -12.3337 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7475 -11.0962 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1912 -11.9212 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4487 -13.1587 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4487 -10.6837 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1912 -11.0962 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8925 -10.6837 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2039 -13.5767 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4036 -13.5767 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2259 -12.3666 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4009 -12.3666 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5759 -12.3666 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.4009 -11.5416 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4009 -13.1916 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 1 6 1 1 0 0 0 + 7 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 2 0 0 0 0 + 9 12 2 0 0 0 0 + 10 13 2 0 0 0 0 + 13 14 1 0 0 0 0 + 12 13 1 0 0 0 0 + 4 7 1 1 0 0 0 + 3 15 1 6 0 0 0 + 2 16 1 6 0 0 0 + 6 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 2 0 0 0 0 + 18 21 1 0 0 0 0 +M CHG 2 19 -1 21 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00058.mol b/src/analysis/thermo/trainingModel/data/mol/C00058.mol new file mode 100644 index 0000000000..7034def948 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00058.mol @@ -0,0 +1,11 @@ +C00058 + Mrv1652304062119412D + + 3 2 0 0 0 0 999 V2000 + 15.4691 -9.4462 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7237 -9.9465 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.4691 -8.6940 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 +M CHG 1 2 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00059.mol b/src/analysis/thermo/trainingModel/data/mol/C00059.mol new file mode 100644 index 0000000000..2d5329480e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00059.mol @@ -0,0 +1,15 @@ +C00059 + Mrv1652304062119412D + + 5 4 0 0 0 0 999 V2000 + 15.4522 -9.8411 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4522 -9.0161 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4522 -10.6661 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6272 -9.8411 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2772 -9.8411 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 0 0 0 0 +M CHG 2 4 -1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00061.mol b/src/analysis/thermo/trainingModel/data/mol/C00061.mol new file mode 100644 index 0000000000..b3f78806ab --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00061.mol @@ -0,0 +1,70 @@ +C00061 + Mrv1652304062119412D + + 31 33 0 0 1 0 999 V2000 + 5.1278 -8.2541 0.0000 N 0 5 0 0 0 0 0 0 0 0 0 0 + 5.1278 -9.0907 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8389 -9.5089 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 6.5918 -9.0907 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.5918 -8.2541 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8389 -7.8359 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.3029 -9.5089 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0139 -9.0907 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0139 -8.2541 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.3029 -7.8359 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7668 -9.5089 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4779 -9.0907 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4779 -8.2541 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7668 -7.8359 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8389 -6.9993 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.4167 -9.5089 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1890 -7.8359 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1890 -9.5089 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.3029 -10.8893 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0139 -11.3076 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 8.7250 -10.8893 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.4361 -11.3076 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.1471 -10.8893 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8582 -11.3076 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0139 -12.1441 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4361 -12.1441 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7250 -10.0527 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6948 -11.3076 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5313 -11.3076 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6948 -10.4710 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6948 -12.1441 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 9 10 1 0 0 0 0 + 5 10 2 0 0 0 0 + 8 11 1 0 0 0 0 + 11 12 2 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 2 0 0 0 0 + 9 14 1 0 0 0 0 + 6 15 2 0 0 0 0 + 2 16 2 0 0 0 0 + 13 17 1 0 0 0 0 + 12 18 1 0 0 0 0 + 7 19 1 0 0 0 0 + 20 19 1 0 0 0 0 + 21 20 1 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 20 25 1 1 0 0 0 + 22 26 1 1 0 0 0 + 21 27 1 6 0 0 0 + 24 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 2 0 0 0 0 + 28 31 1 0 0 0 0 +M CHG 3 1 -1 29 -1 31 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00062.mol b/src/analysis/thermo/trainingModel/data/mol/C00062.mol new file mode 100644 index 0000000000..45bcd656f6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00062.mol @@ -0,0 +1,29 @@ +C00062 + Mrv1652304062119412D + + 12 11 0 0 1 0 999 V2000 + 14.1798 -10.6050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8871 -11.0274 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4553 -11.0068 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.6081 -10.6257 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7823 -10.5673 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4827 -11.8309 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.3189 -11.0446 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0613 -10.9690 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.7548 -9.7398 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0400 -10.6462 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7473 -11.0651 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0503 -9.8188 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 1 6 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 2 0 0 0 0 + 7 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 +M CHG 3 6 1 8 -1 12 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00063.mol b/src/analysis/thermo/trainingModel/data/mol/C00063.mol new file mode 100644 index 0000000000..be71e9058e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00063.mol @@ -0,0 +1,65 @@ +C00063 + Mrv1652304062119412D + + 29 30 0 0 1 0 999 V2000 + 17.3212 -9.2278 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.6784 -8.7535 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0806 -10.0357 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.0081 -9.2484 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.2556 -10.0357 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.2208 -8.9941 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7640 -10.6957 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6124 -9.5441 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7907 -9.5441 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9692 -9.5441 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7874 -10.3692 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7874 -8.7225 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1442 -9.5406 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3226 -9.5406 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1407 -10.3623 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.1407 -8.7190 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5009 -9.5372 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4975 -10.3588 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.6793 -9.5337 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4975 -8.7156 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1107 -8.9674 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7855 -9.3830 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0776 -8.1449 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5056 -8.9734 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7850 -10.2075 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7895 -7.7298 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5089 -8.1449 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2262 -7.7393 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5759 -10.6999 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 4 2 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 1 1 0 0 0 + 5 7 1 6 0 0 0 + 6 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 9 12 2 0 0 0 0 + 10 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 13 16 2 0 0 0 0 + 14 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 17 19 1 0 0 0 0 + 17 20 2 0 0 0 0 + 5 4 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 23 26 2 0 0 0 0 + 24 27 2 0 0 0 0 + 27 28 1 0 0 0 0 + 26 27 1 0 0 0 0 + 1 21 1 1 0 0 0 + 3 29 1 6 0 0 0 +M CHG 3 11 -1 15 -1 18 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00064.mol b/src/analysis/thermo/trainingModel/data/mol/C00064.mol new file mode 100644 index 0000000000..3cb25dd27e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00064.mol @@ -0,0 +1,25 @@ +C00064 + Mrv1652304062119412D + + 10 9 0 0 1 0 999 V2000 + 14.0463 -10.2885 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.7460 -9.8508 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3190 -9.8990 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0704 -11.1124 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.4733 -10.2403 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6364 -10.3678 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.3292 -9.0752 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1731 -9.8059 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9003 -10.1955 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1867 -8.9821 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 2 4 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00065.mol b/src/analysis/thermo/trainingModel/data/mol/C00065.mol new file mode 100644 index 0000000000..bef293a8be --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00065.mol @@ -0,0 +1,19 @@ +C00065 + Mrv1652304062119412D + + 7 6 0 0 1 0 999 V2000 + 13.8601 -10.3003 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.1837 -9.8607 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5813 -9.8986 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8842 -11.1245 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.4660 -10.2625 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.1973 -9.0332 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2921 -10.3209 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 +M CHG 2 4 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00067.mol b/src/analysis/thermo/trainingModel/data/mol/C00067.mol new file mode 100644 index 0000000000..099b77af82 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00067.mol @@ -0,0 +1,8 @@ +C00067 + Mrv1652304062119412D + + 2 1 0 0 0 0 999 V2000 + 16.6624 -11.4283 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8374 -11.4208 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00073.mol b/src/analysis/thermo/trainingModel/data/mol/C00073.mol new file mode 100644 index 0000000000..8a8ffab300 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00073.mol @@ -0,0 +1,23 @@ +C00073 + Mrv1652304062119412D + + 9 8 0 0 1 0 999 V2000 + 14.3968 -11.4093 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.7241 -10.9700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1174 -11.0077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4208 -12.2363 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.0035 -11.3715 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7344 -10.1429 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8279 -11.4298 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5486 -11.0283 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2521 -11.4504 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 +M CHG 2 4 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00074.mol b/src/analysis/thermo/trainingModel/data/mol/C00074.mol new file mode 100644 index 0000000000..306461a9ee --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00074.mol @@ -0,0 +1,25 @@ +C00074 + Mrv1652304062119412D + + 10 9 0 0 0 0 999 V2000 + 11.3850 -12.2925 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0995 -11.8800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8140 -12.2925 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5284 -11.8800 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.8140 -13.1174 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0995 -11.0551 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5600 -12.2925 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7350 -12.2925 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.5600 -11.4675 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5600 -13.1175 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 2 6 2 0 0 0 0 + 1 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M CHG 3 4 -1 8 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00075.mol b/src/analysis/thermo/trainingModel/data/mol/C00075.mol new file mode 100644 index 0000000000..7722fd88dd --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00075.mol @@ -0,0 +1,65 @@ +C00075 + Mrv1652304062119422D + + 29 30 0 0 1 0 999 V2000 + 16.3196 -9.9166 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.1976 -9.7001 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6767 -9.4457 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0789 -10.7244 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.9276 -10.0961 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1868 -8.8735 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0065 -9.9372 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.2506 -10.7244 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5636 -11.3878 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6358 -9.6645 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9064 -10.9170 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8842 -8.4409 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2193 -9.6829 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7624 -11.3844 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6183 -8.8396 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6350 -10.2569 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3240 -8.4122 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8134 -10.2569 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9919 -10.2569 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8100 -11.0784 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.8100 -9.4354 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1669 -10.2535 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3453 -10.2535 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1635 -11.0750 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.1635 -9.4285 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5238 -10.2466 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5204 -11.0716 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.7022 -10.2432 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5204 -9.4250 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 23 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 26 28 1 0 0 0 0 + 26 29 2 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 +M CHG 3 20 -1 24 -1 27 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00077.mol b/src/analysis/thermo/trainingModel/data/mol/C00077.mol new file mode 100644 index 0000000000..08e1c58a99 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00077.mol @@ -0,0 +1,23 @@ +C00077 + Mrv1652304062119422D + + 9 8 0 0 1 0 999 V2000 + 14.4119 -9.5717 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.6958 -9.1621 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1279 -9.1621 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4119 -10.4013 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.9765 -9.5717 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.6958 -8.3324 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8475 -9.5717 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5636 -9.1621 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2830 -9.5717 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 +M CHG 3 4 1 5 -1 9 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00078.mol b/src/analysis/thermo/trainingModel/data/mol/C00078.mol new file mode 100644 index 0000000000..f54be111f5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00078.mol @@ -0,0 +1,37 @@ +C00078 + Mrv1652304062119422D + + 15 16 0 0 1 0 999 V2000 + 10.0743 -9.4533 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8586 -9.6184 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6615 -10.1550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6615 -8.7102 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4778 -9.1230 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1569 -10.7742 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7947 -10.1550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8359 -8.7102 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2208 -9.4946 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.3819 -9.4533 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2208 -10.3614 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.9226 -9.1230 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6243 -9.5358 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.9226 -8.2974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8586 -10.4434 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 9 5 1 0 0 0 0 + 7 10 1 0 0 0 0 + 9 11 1 1 0 0 0 + 9 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 12 14 2 0 0 0 0 + 8 10 2 0 0 0 0 + 2 15 2 0 0 0 0 + 15 6 1 0 0 0 0 +M CHG 2 11 1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00079.mol b/src/analysis/thermo/trainingModel/data/mol/C00079.mol new file mode 100644 index 0000000000..94f19d7214 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00079.mol @@ -0,0 +1,30 @@ +C00079 + Mrv1652304062119422D + + 12 12 0 0 1 0 999 V2000 + 15.1422 -9.5789 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1422 -10.4573 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3892 -10.8756 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6781 -10.4573 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6781 -9.5789 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3892 -9.1606 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8533 -9.1606 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5643 -9.5789 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2754 -9.1606 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9865 -9.5789 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.2754 -8.3240 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5643 -10.4573 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 1 7 1 0 0 0 0 + 8 7 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 2 0 0 0 0 + 8 12 1 1 0 0 0 +M CHG 2 10 -1 12 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00080.mol b/src/analysis/thermo/trainingModel/data/mol/C00080.mol new file mode 100644 index 0000000000..dec2f4be4c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00080.mol @@ -0,0 +1 @@ +majorms:FAILED diff --git a/src/analysis/thermo/trainingModel/data/mol/C00081.mol b/src/analysis/thermo/trainingModel/data/mol/C00081.mol new file mode 100644 index 0000000000..c107a5ac5a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00081.mol @@ -0,0 +1,70 @@ +C00081 + Mrv1652304062119422D + + 31 33 0 0 1 0 999 V2000 + 17.1099 -9.4956 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3211 -9.2428 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4908 -10.7035 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.5930 -8.8351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3211 -8.4124 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6038 -9.6655 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8152 -10.2053 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2418 -11.4697 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.1137 -8.1594 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6038 -8.0047 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8905 -9.2428 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1472 -10.6846 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4076 -11.4697 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.7287 -12.1341 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8905 -8.4124 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6001 -7.2655 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3734 -10.4430 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9395 -12.1416 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7619 -10.8054 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9391 -10.8054 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1162 -10.8054 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9391 -9.8990 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.9353 -11.6246 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2971 -10.8054 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4743 -10.8054 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2971 -9.8990 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2971 -11.6246 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6552 -10.8054 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8324 -10.8054 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6552 -9.8990 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.6552 -11.6246 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 2 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 25 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 1 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 3 22 -1 26 -1 30 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00082.mol b/src/analysis/thermo/trainingModel/data/mol/C00082.mol new file mode 100644 index 0000000000..8aa66ae16e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00082.mol @@ -0,0 +1,32 @@ +C00082 + Mrv1652304062119422D + + 13 13 0 0 1 0 999 V2000 + 14.9748 -9.4534 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9748 -10.2900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2637 -10.7083 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5526 -10.2900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5526 -9.4534 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2637 -9.0351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7278 -9.0351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7997 -10.7501 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4389 -9.4534 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.1500 -9.0351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8611 -9.4534 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.1500 -8.1985 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4389 -10.2900 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 1 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 9 7 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 + 9 13 1 1 0 0 0 +M CHG 2 11 -1 13 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00083.mol b/src/analysis/thermo/trainingModel/data/mol/C00083.mol new file mode 100644 index 0000000000..a7a9b47dd8 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00083.mol @@ -0,0 +1,116 @@ +C00083 + Mrv1652304062119422D + + 54 56 0 0 1 0 999 V2000 + 9.0470 -12.2100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7615 -11.7975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4759 -12.2100 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1904 -11.7975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9049 -12.2100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6193 -11.7975 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3338 -12.2100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0483 -11.7975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7627 -12.2100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4772 -11.7975 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1917 -12.2100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9061 -11.7975 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.6206 -12.2100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3351 -11.7975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0495 -12.2100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7615 -10.9726 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3338 -13.0349 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1917 -13.0348 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9061 -10.9725 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6206 -11.3850 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6206 -13.0350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8745 -12.2100 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6995 -12.2100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8745 -13.0350 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.0463 -9.2813 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.8713 -9.2813 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.1262 -8.4966 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.4588 -8.0117 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7913 -8.4966 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.9038 -8.2439 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5613 -9.9487 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3562 -9.9487 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1812 -9.9487 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1812 -9.1237 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.0062 -9.9487 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.1812 -10.7737 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3650 -7.4250 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3650 -8.2500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7940 -8.2500 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7940 -7.4250 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0795 -7.0125 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6506 -7.0125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9360 -7.4250 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9360 -8.2500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6506 -8.6625 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6506 -6.1876 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0719 -8.4987 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8969 -8.4987 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8969 -7.6737 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 20.7219 -8.4987 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8969 -10.3962 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3227 -11.7917 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6131 -12.2013 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.3228 -10.9726 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 52 54 2 0 0 0 0 +M CHG 5 24 -1 34 -1 35 -1 49 -1 53 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00084.mol b/src/analysis/thermo/trainingModel/data/mol/C00084.mol new file mode 100644 index 0000000000..e096aca5a0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00084.mol @@ -0,0 +1,10 @@ +C00084 + Mrv1652304062119422D + + 3 2 0 0 0 0 999 V2000 + 15.7987 -12.1274 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5131 -11.7149 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2170 -12.1214 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00085.mol b/src/analysis/thermo/trainingModel/data/mol/C00085.mol new file mode 100644 index 0000000000..f749093ce0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00085.mol @@ -0,0 +1,38 @@ +C00085 + Mrv1652304062119422D + + 16 16 0 0 1 0 999 V2000 + 15.1875 -8.8616 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.8506 -8.3839 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4520 -9.6415 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.4005 -8.6141 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5378 -8.8787 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 16.2870 -9.6415 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9744 -10.3185 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9056 -9.2773 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1152 -8.2876 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2904 -9.1536 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7715 -10.3151 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0774 -9.2739 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9090 -8.4938 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2562 -9.2670 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.1153 -10.0951 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.1153 -8.4492 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 4 0 0 0 + 6 11 1 1 0 0 0 + 8 12 1 0 0 0 0 + 9 13 1 0 0 0 0 + 12 14 1 0 0 0 0 + 12 15 1 0 0 0 0 + 12 16 2 0 0 0 0 + 6 5 1 0 0 0 0 +M CHG 2 14 -1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00086.mol b/src/analysis/thermo/trainingModel/data/mol/C00086.mol new file mode 100644 index 0000000000..acf83684e2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00086.mol @@ -0,0 +1,12 @@ +C00086 + Mrv1652304062119422D + + 4 3 0 0 0 0 999 V2000 + 14.6378 -11.2155 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9241 -11.6292 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3516 -11.6292 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6378 -10.3915 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00088.mol b/src/analysis/thermo/trainingModel/data/mol/C00088.mol new file mode 100644 index 0000000000..6ab28c5180 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00088.mol @@ -0,0 +1,10 @@ +C00088 + Mrv1652304062119422D + + 3 2 0 0 0 0 999 V2000 + 11.9036 -8.9544 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2163 -8.5460 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6424 -8.5331 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00089.mol b/src/analysis/thermo/trainingModel/data/mol/C00089.mol new file mode 100644 index 0000000000..8bb9a75b70 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00089.mol @@ -0,0 +1,52 @@ +C00089 + Mrv1652304062119422D + + 23 24 0 0 1 0 999 V2000 + 16.2167 -8.6591 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.6048 -9.2056 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9042 -8.1641 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4676 -9.4256 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.6393 -8.0713 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8933 -9.6181 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.5677 -8.6453 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.3030 -9.4256 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.9830 -10.0959 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8864 -8.4149 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1715 -9.2056 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8933 -10.4431 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.3548 -8.3978 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7809 -10.0994 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4633 -9.6216 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.1715 -10.8556 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.6014 -10.8556 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8498 -9.0612 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4633 -10.4431 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.7484 -9.2056 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1715 -11.6806 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7484 -10.8556 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1192 -9.7419 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 1 5 1 1 0 0 0 + 6 2 1 6 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 12 6 1 0 0 0 0 + 7 13 1 6 0 0 0 + 8 14 1 1 0 0 0 + 15 11 1 0 0 0 0 + 12 16 1 0 0 0 0 + 12 17 1 6 0 0 0 + 13 18 1 0 0 0 0 + 19 15 1 0 0 0 0 + 15 20 1 1 0 0 0 + 16 21 1 1 0 0 0 + 19 22 1 6 0 0 0 + 20 23 1 0 0 0 0 + 8 7 1 0 0 0 0 + 16 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00091.mol b/src/analysis/thermo/trainingModel/data/mol/C00091.mol new file mode 100644 index 0000000000..894833702d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00091.mol @@ -0,0 +1,118 @@ +C00091 + Mrv1652304062119422D + + 55 57 0 0 1 0 999 V2000 + 3.9732 -11.6738 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 4.6877 -11.2613 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.4022 -11.6738 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 6.1166 -11.2613 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.8311 -11.6738 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.5456 -11.2613 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2600 -11.6738 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9745 -11.2613 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6890 -11.6738 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4035 -11.2613 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1179 -11.6738 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8324 -11.2613 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.5469 -11.6738 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2613 -11.2613 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9758 -11.6738 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.6877 -10.4364 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2600 -12.4987 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1179 -12.4985 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8324 -10.4363 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5469 -10.8488 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5469 -12.4988 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8008 -11.6738 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6258 -11.6738 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8008 -12.4988 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.9725 -8.7450 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.7975 -8.7450 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.0524 -7.9604 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.3850 -7.4754 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7176 -7.9604 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.8300 -7.7077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4876 -9.4124 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2824 -9.4124 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1074 -9.4124 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1074 -8.5874 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9324 -9.4124 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.1074 -10.2374 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2913 -6.8888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2913 -7.7138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7202 -7.7138 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7202 -6.8888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0057 -6.4763 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.5768 -6.4763 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.8623 -6.8888 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 6.8623 -7.7138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.5768 -8.1263 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.5768 -5.6514 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9982 -7.9624 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8232 -7.9624 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8232 -7.1374 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.6482 -7.9624 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8232 -9.8599 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 3.2489 -11.2555 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 2.5394 -11.6651 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1.8423 -11.2625 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 2.5391 -12.4986 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 53 54 1 0 0 0 0 + 53 55 2 0 0 0 0 +M CHG 5 24 -1 34 -1 35 -1 49 -1 54 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00092.mol b/src/analysis/thermo/trainingModel/data/mol/C00092.mol new file mode 100644 index 0000000000..fdce993809 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00092.mol @@ -0,0 +1,38 @@ +C00092 + Mrv1652304062119422D + + 16 16 0 0 1 0 999 V2000 + 13.6262 -8.1927 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4519 -8.1927 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8004 -8.1867 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.6141 -9.0124 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.6141 -7.3670 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7733 -8.9464 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6229 -9.4058 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.5903 -10.2226 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.3347 -8.9884 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3496 -10.6309 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9294 -10.6459 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0553 -9.3908 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 17.0613 -10.2135 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.3557 -11.4953 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7639 -8.9734 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7790 -10.6219 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 1 0 0 0 + 8 7 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 1 6 0 0 0 + 9 12 1 0 0 0 0 + 10 13 1 0 0 0 0 + 10 14 1 1 0 0 0 + 12 15 1 4 0 0 0 + 13 16 1 6 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00093.mol b/src/analysis/thermo/trainingModel/data/mol/C00093.mol new file mode 100644 index 0000000000..325014e3e7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00093.mol @@ -0,0 +1,25 @@ +C00093 + Mrv1652304062119422D + + 10 9 0 0 1 0 999 V2000 + 13.7777 -12.7464 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4922 -13.1589 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2067 -12.7464 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.9211 -13.1589 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6357 -12.7464 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2067 -11.9215 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4607 -12.7464 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2857 -12.7464 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.4607 -11.9213 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4607 -13.5712 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 3 6 1 1 0 0 0 + 5 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M CHG 2 8 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00094.mol b/src/analysis/thermo/trainingModel/data/mol/C00094.mol new file mode 100644 index 0000000000..343a14004a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00094.mol @@ -0,0 +1,13 @@ +C00094 + Mrv1652304062119422D + + 4 3 0 0 0 0 999 V2000 + 15.0800 -9.0863 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7946 -8.6739 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0800 -9.9073 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3654 -8.6739 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 +M CHG 1 3 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00095.mol b/src/analysis/thermo/trainingModel/data/mol/C00095.mol new file mode 100644 index 0000000000..52ec716530 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00095.mol @@ -0,0 +1,29 @@ +C00095 + Mrv1652304062119422D + + 12 12 0 0 1 0 999 V2000 + 13.7615 -8.7825 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 13.5106 -9.5454 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.0777 -8.2877 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3388 -8.1914 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5175 -9.0575 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6790 -9.5454 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9951 -10.2189 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4110 -8.7654 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.0914 -8.5385 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1979 -10.2224 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6240 -8.5179 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1292 -9.1811 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 1 0 0 0 + 8 3 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 6 0 0 0 + 8 11 1 1 0 0 0 + 11 12 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00096.mol b/src/analysis/thermo/trainingModel/data/mol/C00096.mol new file mode 100644 index 0000000000..1469d67f97 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00096.mol @@ -0,0 +1,87 @@ +C00096 + Mrv1652304062119422D + + 39 42 0 0 1 0 999 V2000 + 20.0747 -8.6104 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2837 -8.3569 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0709 -10.2492 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.5592 -7.9480 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2837 -7.5280 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5646 -8.7807 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3896 -9.7571 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8211 -11.0250 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.0784 -7.2707 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5646 -7.1154 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8493 -8.3569 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7274 -10.2378 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.9961 -11.0250 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.3094 -11.6874 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8493 -7.5280 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5609 -6.2904 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1341 -8.7656 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9439 -9.9880 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5230 -11.6948 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2287 -10.3929 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4036 -10.3929 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5823 -10.3929 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3961 -11.3051 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.3688 -9.5718 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7573 -10.3929 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9360 -10.3968 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7497 -11.2445 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.7225 -9.5718 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2208 -10.8055 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.5054 -10.3968 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2208 -11.6268 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.7901 -10.8055 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.5054 -12.0431 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.9360 -12.0431 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7901 -11.6268 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.0861 -10.3968 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5054 -12.9067 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0861 -12.0431 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4542 -10.9265 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 2 0 0 0 0 + 11 17 1 0 0 0 0 + 12 18 1 1 0 0 0 + 13 19 1 6 0 0 0 + 18 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 22 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 25 27 1 0 0 0 0 + 25 28 2 0 0 0 0 + 29 26 1 6 0 0 0 + 29 30 1 0 0 0 0 + 31 29 1 0 0 0 0 + 32 30 1 0 0 0 0 + 31 33 1 0 0 0 0 + 31 34 1 1 0 0 0 + 35 32 1 0 0 0 0 + 32 36 1 1 0 0 0 + 33 37 1 1 0 0 0 + 35 38 1 6 0 0 0 + 36 39 1 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 1 0 0 0 0 + 13 12 1 0 0 0 0 + 33 35 1 0 0 0 0 +M CHG 2 23 -1 27 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00097.mol b/src/analysis/thermo/trainingModel/data/mol/C00097.mol new file mode 100644 index 0000000000..9ad2cd7d40 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00097.mol @@ -0,0 +1,19 @@ +C00097 + Mrv1652304062119422D + + 7 6 0 0 1 0 999 V2000 + 14.4237 -9.0829 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.7363 -8.6430 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1384 -8.6705 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4512 -9.9077 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.0216 -9.0279 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7363 -7.8183 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8533 -9.1104 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 +M CHG 2 4 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00099.mol b/src/analysis/thermo/trainingModel/data/mol/C00099.mol new file mode 100644 index 0000000000..e619adfb6a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00099.mol @@ -0,0 +1,17 @@ +C00099 + Mrv1652304062119422D + + 6 5 0 0 0 0 999 V2000 + 15.1057 -9.9371 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3970 -9.5263 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8211 -9.5263 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6816 -9.9406 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3970 -8.7013 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5332 -9.9371 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 +M CHG 2 4 -1 6 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00100.mol b/src/analysis/thermo/trainingModel/data/mol/C00100.mol new file mode 100644 index 0000000000..44072ecb11 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00100.mol @@ -0,0 +1,112 @@ +C00100 + Mrv1652304062119422D + + 52 54 0 0 1 0 999 V2000 + 4.3444 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.0590 -11.3025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.7734 -11.7150 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 6.4879 -11.3025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2024 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9168 -11.3025 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6313 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3458 -11.3025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0602 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7747 -11.3025 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4892 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2036 -11.3025 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.9181 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6326 -11.3025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3470 -11.7150 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 5.0590 -10.4776 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6313 -12.5399 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4892 -12.5398 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2036 -10.4775 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9181 -10.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9181 -12.5400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1720 -11.7150 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9970 -11.7150 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1720 -12.5400 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.3437 -8.7862 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.1687 -8.7862 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.4237 -8.0016 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.7562 -7.5167 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0888 -8.0016 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.2013 -7.7489 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8588 -9.4537 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6537 -9.4537 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4787 -9.4537 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4787 -8.6287 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3037 -9.4537 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.4787 -10.2787 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6625 -6.9300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6625 -7.7550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0915 -7.7550 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0915 -6.9300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3769 -6.5175 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9480 -6.5175 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2335 -6.9300 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2335 -7.7550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9480 -8.1675 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9480 -5.6926 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3694 -8.0037 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1944 -8.0037 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1944 -7.1787 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.0194 -8.0037 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1944 -9.9012 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 3.6202 -11.2967 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 +M CHG 4 24 -1 34 -1 35 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00101.mol b/src/analysis/thermo/trainingModel/data/mol/C00101.mol new file mode 100644 index 0000000000..d49369014a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00101.mol @@ -0,0 +1,72 @@ +C00101 + Mrv1652304062119422D + + 32 34 0 0 1 0 999 V2000 + 5.6121 -10.3531 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 5.6121 -11.1781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3134 -11.5907 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0559 -11.1781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0559 -10.3531 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3134 -9.9406 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7572 -11.5907 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4584 -11.1781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4584 -10.3531 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 7.7572 -9.9406 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3134 -9.1156 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.8959 -11.5878 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1730 -9.9406 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8875 -10.3531 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6019 -9.9406 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3177 -10.3538 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0321 -9.9413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0321 -9.1163 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3164 -8.7031 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6019 -9.1156 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7618 -8.7031 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4763 -9.1156 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7653 -7.8782 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2018 -8.6966 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9121 -9.1066 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6088 -8.7042 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3124 -9.1104 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0125 -8.7061 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.3126 -9.9404 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2017 -7.8781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4802 -7.4617 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9091 -7.4694 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 9 8 1 0 0 0 0 + 9 10 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 2 12 1 0 0 0 0 + 9 13 1 1 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 2 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 2 0 0 0 0 + 15 20 1 0 0 0 0 + 18 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 2 0 0 0 0 + 24 22 1 6 0 0 0 + 24 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 27 29 2 0 0 0 0 + 24 30 1 0 0 0 0 + 30 31 2 0 0 0 0 + 30 32 1 0 0 0 0 +M CHG 2 28 -1 32 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00103.mol b/src/analysis/thermo/trainingModel/data/mol/C00103.mol new file mode 100644 index 0000000000..acd8c02e51 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00103.mol @@ -0,0 +1,38 @@ +C00103 + Mrv1652304062119422D + + 16 16 0 0 1 0 999 V2000 + 16.3699 -12.3045 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.6500 -11.8952 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3699 -13.1269 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.0824 -11.8952 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9337 -12.3045 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.6500 -13.5437 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.0824 -13.5437 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9048 -11.8914 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9337 -13.1269 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.2289 -11.8952 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6500 -14.4071 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9048 -11.0278 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.9048 -12.7586 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.7309 -11.8914 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2289 -13.5437 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5960 -12.4256 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 6 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 9 5 1 0 0 0 0 + 5 10 1 1 0 0 0 + 6 11 1 1 0 0 0 + 8 12 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 2 0 0 0 0 + 9 15 1 6 0 0 0 + 10 16 1 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 2 12 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00104.mol b/src/analysis/thermo/trainingModel/data/mol/C00104.mol new file mode 100644 index 0000000000..30afcf8ab2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00104.mol @@ -0,0 +1,62 @@ +C00104 + Mrv1652304062119422D + + 27 29 0 0 1 0 999 V2000 + 16.3760 -9.5383 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5858 -9.2888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7560 -10.7482 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.8600 -8.8767 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5858 -8.4570 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8636 -9.7085 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0792 -10.2530 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5064 -11.5158 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.3760 -8.1999 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8636 -8.0449 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1528 -9.2888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4099 -10.7331 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.6708 -11.5158 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.9941 -12.1812 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1528 -8.4570 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8636 -7.3084 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6349 -10.4911 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1982 -12.1925 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0224 -10.8541 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1982 -10.8503 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3740 -10.8503 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1982 -9.9459 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.1906 -11.6745 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5535 -10.8503 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7293 -10.8503 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.5535 -9.9459 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5535 -11.6745 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 2 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 1 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 22 -1 25 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00105.mol b/src/analysis/thermo/trainingModel/data/mol/C00105.mol new file mode 100644 index 0000000000..8f9c65eaba --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00105.mol @@ -0,0 +1,49 @@ +C00105 + Mrv1652304062119422D + + 21 22 0 0 1 0 999 V2000 + 14.6780 -9.8984 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.5494 -9.5481 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0351 -9.4275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4338 -10.7063 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.2724 -9.9513 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5425 -8.7222 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3614 -9.9191 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.6088 -10.7063 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9185 -11.3697 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9877 -9.5253 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2885 -10.7715 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2479 -8.2985 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5777 -9.6646 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1208 -11.3662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9777 -8.7002 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9933 -10.2387 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6871 -8.2792 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1717 -10.2387 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1649 -11.0603 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.3468 -10.2387 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.1649 -9.4173 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 +M CHG 2 19 -1 20 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00106.mol b/src/analysis/thermo/trainingModel/data/mol/C00106.mol new file mode 100644 index 0000000000..8224a50e85 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00106.mol @@ -0,0 +1,21 @@ +C00106 + Mrv1652304062119422D + + 8 8 0 0 0 0 999 V2000 + 15.0059 -10.9835 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2884 -10.5750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0059 -11.8109 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5812 -10.9870 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2884 -9.7510 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2952 -12.2264 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7235 -12.2195 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5812 -11.8144 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 2 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00109.mol b/src/analysis/thermo/trainingModel/data/mol/C00109.mol new file mode 100644 index 0000000000..38e3febfab --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00109.mol @@ -0,0 +1,19 @@ +C00109 + Mrv1652304062119422D + + 7 6 0 0 0 0 999 V2000 + 13.0576 -9.7494 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7750 -9.3356 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3439 -9.3356 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0950 -10.6518 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4887 -9.7494 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7713 -8.5493 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6303 -9.7494 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00111.mol b/src/analysis/thermo/trainingModel/data/mol/C00111.mol new file mode 100644 index 0000000000..3939533266 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00111.mol @@ -0,0 +1,25 @@ +C00111 + Mrv1652304062119422D + + 10 9 0 0 0 0 999 V2000 + 13.3587 -12.1281 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0598 -11.7156 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8023 -12.1281 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5036 -11.7156 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2048 -12.1281 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0298 -12.1281 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8548 -12.1281 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.0298 -12.9531 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.8023 -12.9531 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0298 -11.3031 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 3 9 2 0 0 0 0 + 6 10 2 0 0 0 0 +M CHG 2 7 -1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00112.mol b/src/analysis/thermo/trainingModel/data/mol/C00112.mol new file mode 100644 index 0000000000..09fc3681c6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00112.mol @@ -0,0 +1,57 @@ +C00112 + Mrv1652304062119422D + + 25 26 0 0 1 0 999 V2000 + 16.5413 -9.2400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.9225 -8.7863 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2938 -10.0650 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.2213 -9.2813 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4688 -10.0650 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.7888 -10.7250 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4375 -9.0338 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9738 -10.7250 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8188 -9.5700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9938 -9.5700 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1688 -9.5700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9938 -10.3950 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.9938 -8.7450 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3850 -9.5700 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3850 -10.3950 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.5600 -9.5700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3850 -8.7450 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3250 -8.9925 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0675 -9.4050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3250 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7688 -8.9513 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0675 -10.2300 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0263 -7.7550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7688 -8.1263 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4700 -7.7138 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 4 2 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 1 6 0 0 0 + 4 7 1 1 0 0 0 + 5 8 1 6 0 0 0 + 7 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 10 13 2 0 0 0 0 + 11 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 14 16 1 0 0 0 0 + 14 17 2 0 0 0 0 + 5 4 1 0 0 0 0 + 1 18 1 1 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 19 22 2 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 2 0 0 0 0 + 24 25 1 0 0 0 0 + 23 24 1 0 0 0 0 +M CHG 2 12 -1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00114.mol b/src/analysis/thermo/trainingModel/data/mol/C00114.mol new file mode 100644 index 0000000000..da16f3658e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00114.mol @@ -0,0 +1,19 @@ +C00114 + Mrv1652304062119422D + + 7 6 0 0 0 0 999 V2000 + 3.6301 -7.4664 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 4.3445 -7.0539 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 5.0591 -7.4664 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.7735 -7.0539 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.4880 -7.4664 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.3445 -6.2290 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 4.3445 -7.8789 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 0 0 0 0 +M CHG 1 2 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00116.mol b/src/analysis/thermo/trainingModel/data/mol/C00116.mol new file mode 100644 index 0000000000..3e32e0aeaa --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00116.mol @@ -0,0 +1,16 @@ +C00116 + Mrv1652304062119422D + + 6 5 0 0 0 0 999 V2000 + 11.8690 -11.8799 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8656 -11.0549 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8656 -12.7049 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0440 -11.8765 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6906 -11.0549 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6906 -12.7049 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00117.mol b/src/analysis/thermo/trainingModel/data/mol/C00117.mol new file mode 100644 index 0000000000..615910a810 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00117.mol @@ -0,0 +1,34 @@ +C00117 + Mrv1652304062119422D + + 14 14 0 0 1 0 999 V2000 + 11.3357 -9.4637 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1625 -9.4637 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5125 -9.4637 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.3357 -10.3280 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.3319 -8.5955 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6595 -8.8112 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4408 -9.0540 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.7025 -9.8430 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.1083 -8.5724 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5407 -9.8430 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.2284 -10.5143 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7910 -9.0655 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 15.0300 -10.5030 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6175 -8.7739 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 1 0 0 0 + 8 7 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 1 6 0 0 0 + 9 12 1 0 0 0 0 + 10 13 1 6 0 0 0 + 12 14 1 4 0 0 0 + 10 12 1 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00118.mol b/src/analysis/thermo/trainingModel/data/mol/C00118.mol new file mode 100644 index 0000000000..9e881661f5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00118.mol @@ -0,0 +1,25 @@ +C00118 + Mrv1652304062119422D + + 10 9 0 0 1 0 999 V2000 + 14.6025 -11.6738 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9013 -12.0863 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1588 -11.6738 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.4575 -12.0863 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7563 -11.6738 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1588 -10.8488 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9313 -11.6738 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1063 -11.6738 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.9313 -12.4988 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9313 -10.8488 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 3 6 1 1 0 0 0 + 5 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M CHG 2 8 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00119.mol b/src/analysis/thermo/trainingModel/data/mol/C00119.mol new file mode 100644 index 0000000000..bb28b95f0b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00119.mol @@ -0,0 +1,50 @@ +C00119 + Mrv1652304062119422D + + 22 22 0 0 1 0 999 V2000 + 13.1233 -9.3697 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.4411 -8.8770 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8732 -10.1427 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9115 -9.1195 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7742 -9.3583 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.0394 -10.1427 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.3620 -10.8059 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7338 -9.1120 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9935 -9.1157 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5657 -10.8135 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5561 -9.1120 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7300 -8.2484 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.7338 -9.9381 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5008 -9.7675 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3824 -9.1120 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6710 -9.7638 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2046 -9.1120 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3824 -8.2484 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.3824 -9.9381 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8486 -9.7638 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.6710 -10.5862 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.6671 -8.9377 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 6 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 1 0 0 0 + 6 10 1 6 0 0 0 + 8 11 1 0 0 0 0 + 8 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 9 14 1 0 0 0 0 + 11 15 1 0 0 0 0 + 14 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 18 1 0 0 0 0 + 15 19 2 0 0 0 0 + 16 20 1 0 0 0 0 + 16 21 1 0 0 0 0 + 16 22 2 0 0 0 0 + 6 5 1 0 0 0 0 +M CHG 4 12 -1 18 -1 20 -1 21 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00121.mol b/src/analysis/thermo/trainingModel/data/mol/C00121.mol new file mode 100644 index 0000000000..3e9d8e9bef --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00121.mol @@ -0,0 +1,25 @@ +C00121 + Mrv1652304062119422D + + 10 10 0 0 1 0 999 V2000 + 13.6513 -9.4992 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.9225 -10.2820 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3173 -9.0151 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8788 -9.2520 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7533 -10.2820 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.4350 -10.9514 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9970 -9.5130 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 12.3810 -9.9112 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2339 -10.9480 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7797 -9.2555 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 6 0 0 0 + 7 10 1 4 0 0 0 + 5 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00122.mol b/src/analysis/thermo/trainingModel/data/mol/C00122.mol new file mode 100644 index 0000000000..dc400e585b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00122.mol @@ -0,0 +1,21 @@ +C00122 + Mrv1652304062119422D + + 8 7 0 0 0 0 999 V2000 + 12.0474 -8.9935 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7612 -9.4072 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3337 -9.4072 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.0474 -8.1694 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4783 -8.9935 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1921 -9.4072 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9058 -8.9935 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.1921 -10.2312 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 +M CHG 2 3 -1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00123.mol b/src/analysis/thermo/trainingModel/data/mol/C00123.mol new file mode 100644 index 0000000000..9bf49e6ff3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00123.mol @@ -0,0 +1,23 @@ +C00123 + Mrv1652304062119422D + + 9 8 0 0 1 0 999 V2000 + 14.8049 -11.4619 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.5058 -11.0268 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0763 -11.0751 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8325 -12.2905 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.2344 -11.4170 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3927 -11.5413 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0901 -10.2464 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9354 -10.9818 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2621 -12.2423 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 1 0 0 0 0 +M CHG 2 4 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00124.mol b/src/analysis/thermo/trainingModel/data/mol/C00124.mol new file mode 100644 index 0000000000..fab6933002 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00124.mol @@ -0,0 +1,29 @@ +C00124 + Mrv1652304062119422D + + 12 12 0 0 1 0 999 V2000 + 12.3223 -7.9685 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.3223 -8.7935 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.0339 -7.5561 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6073 -7.5561 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0339 -9.2060 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.6073 -9.2060 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7523 -7.9685 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 10.9817 -8.0924 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7523 -8.7935 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.0339 -10.0310 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4638 -7.5561 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4638 -9.2060 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 1 0 0 0 + 7 11 1 4 0 0 0 + 9 12 1 6 0 0 0 + 9 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00125.mol b/src/analysis/thermo/trainingModel/data/mol/C00125.mol new file mode 100644 index 0000000000..cdf6e6187c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00125.mol @@ -0,0 +1,141 @@ +C00125 + + + 65 70 0 0 1 0 0 0 0 0999 V2000 + 37.2546 -27.2650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 36.0121 -27.8070 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.3489 -25.9105 0.0000 N 0 0 3 0 0 0 0 0 0 0 0 0 + 38.5858 -27.7773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.7334 -27.2965 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.6683 -25.5959 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.3944 -26.7428 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.5274 -27.9017 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.5190 -25.9468 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 39.1556 -24.3767 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.4245 -23.0212 0.0000 N 0 0 3 0 0 0 0 0 0 0 0 0 + 32.5575 -26.9972 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.1880 -25.7266 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.6566 -23.1589 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.5971 -21.6717 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.0750 -23.2591 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.6473 -24.5261 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.2686 -21.9280 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.3129 -22.9502 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 33.3663 -21.0959 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 35.8280 -21.0132 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.4341 -22.0702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.3000 -20.9888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.0936 -21.6193 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.3547 -19.7230 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.0670 -22.0702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.2884 -19.6157 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.5384 -19.0229 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.6241 -21.7026 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 41.5382 -22.8129 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.5488 -29.2205 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.7896 -29.9705 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.7531 -31.4126 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.9937 -32.1626 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 38.4900 -32.1117 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 33.4723 -29.2455 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.2756 -29.8769 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.2206 -31.2206 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.0239 -31.8449 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 33.3555 -31.9470 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 31.1164 -27.0635 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.7022 -26.8060 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 35.8454 -24.4671 0.0000 Fe 0 3 0 0 0 0 0 0 0 0 0 0 + 32.1489 -19.0419 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 32.1352 -17.6332 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.8956 -16.9332 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.7075 -17.6344 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 30.8822 -15.5346 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.6382 -14.8317 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 32.0618 -14.8382 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 41.1212 -20.3756 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 42.5128 -20.1439 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 43.0036 -18.8345 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 44.4010 -18.6020 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 42.1149 -17.7545 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 45.3016 -19.6967 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 44.8910 -17.2951 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 29.7075 -19.0344 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.7149 -17.7545 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.6382 -13.4317 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 46.2910 -17.2951 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4951 -19.7344 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 40.0149 -16.5421 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 30.9199 -19.7344 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 40.0149 -18.9669 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11 16 1 0 0 0 + 13 17 2 0 0 0 + 14 18 1 0 0 0 + 14 19 2 0 0 0 + 15 20 2 0 0 0 + 15 21 1 0 0 0 + 16 22 2 0 0 0 + 18 23 2 0 0 0 + 19 24 1 0 0 0 + 20 25 1 0 0 0 + 22 26 1 0 0 0 + 23 27 1 0 0 0 + 6 7 1 0 0 0 + 12 13 1 0 0 0 + 16 17 1 0 0 0 + 20 22 1 0 0 0 + 21 24 2 0 0 0 + 23 24 1 0 0 0 + 25 28 1 0 0 0 + 18 29 1 0 0 0 + 29 30 1 0 0 0 + 1 2 2 0 0 0 + 4 31 1 0 0 0 + 1 3 1 0 0 0 + 31 32 1 0 0 0 + 1 4 1 0 0 0 + 32 33 1 0 0 0 + 2 5 1 0 0 0 + 33 34 2 0 0 0 + 3 6 1 0 0 0 + 33 35 1 0 0 0 + 4 7 2 0 0 0 + 8 36 1 0 0 0 + 5 8 1 0 0 0 + 36 37 1 0 0 0 + 5 9 2 0 0 0 + 37 38 1 0 0 0 + 6 10 2 0 0 0 + 38 39 1 0 0 0 + 8 12 2 0 0 0 + 38 40 2 0 0 0 + 9 13 1 0 0 0 + 12 41 1 0 0 0 + 10 14 1 0 0 0 + 7 42 1 0 0 0 + 11 15 1 0 0 0 + 11 43 1 0 0 0 + 3 43 1 0 0 0 + 25 44 1 0 0 0 + 44 45 1 0 0 0 + 46 45 1 6 0 0 + 46 47 1 0 0 0 + 46 48 1 0 0 0 + 48 49 1 0 0 0 + 48 50 2 0 0 0 + 29 51 1 0 0 0 + 51 52 1 0 0 0 + 53 52 1 6 0 0 + 53 54 1 0 0 0 + 53 55 1 0 0 0 + 54 56 2 0 0 0 + 54 57 1 0 0 0 + 47 58 1 0 0 0 + 55 59 1 0 0 0 + 49 60 1 0 0 0 + 57 61 1 0 0 0 + 58 62 1 0 0 0 + 59 63 1 0 0 0 + 58 64 2 0 0 0 + 59 65 2 0 0 0 +M CHG 1 43 1 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C00126.mol b/src/analysis/thermo/trainingModel/data/mol/C00126.mol new file mode 100644 index 0000000000..e1fef2a733 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00126.mol @@ -0,0 +1,140 @@ +C00126 + + + 65 70 0 0 1 0 0 0 0 0999 V2000 + 37.2546 -27.2650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 36.0121 -27.8070 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.3489 -25.9105 0.0000 N 0 0 3 0 0 0 0 0 0 0 0 0 + 38.5858 -27.7773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.7334 -27.2965 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.6683 -25.5959 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.3944 -26.7428 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.5274 -27.9017 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.5190 -25.9468 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 39.1556 -24.3767 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.4245 -23.0212 0.0000 N 0 0 3 0 0 0 0 0 0 0 0 0 + 32.5575 -26.9972 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.1880 -25.7266 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.6566 -23.1589 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.5971 -21.6717 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.0750 -23.2591 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.6473 -24.5261 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.2686 -21.9280 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.3129 -22.9502 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 33.3663 -21.0959 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 35.8280 -21.0132 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.4341 -22.0702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.3000 -20.9888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.0936 -21.6193 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.3547 -19.7230 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.0670 -22.0702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.2884 -19.6157 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.5384 -19.0229 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.6241 -21.7026 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 41.5382 -22.8129 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.5488 -29.2205 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.7896 -29.9705 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.7531 -31.4126 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.9937 -32.1626 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 38.4900 -32.1117 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 33.4723 -29.2455 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.2756 -29.8769 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.2206 -31.2206 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.0239 -31.8449 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 33.3555 -31.9470 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 31.1164 -27.0635 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.7022 -26.8060 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 35.8454 -24.4671 0.0000 Fe 0 0 0 0 0 0 0 0 0 0 0 0 + 32.1489 -19.0419 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 32.1352 -17.6332 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.8956 -16.9332 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.7075 -17.6344 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 30.8822 -15.5346 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.6382 -14.8317 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 32.0618 -14.8382 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 41.1212 -20.3756 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 42.5128 -20.1439 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 43.0036 -18.8345 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 44.4010 -18.6020 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 42.1149 -17.7545 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 45.3016 -19.6967 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 44.8910 -17.2951 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 29.7075 -19.0344 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.7149 -17.7545 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.6382 -13.4317 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 46.2910 -17.2951 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4951 -19.7344 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 40.0149 -16.5421 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 30.9199 -19.7344 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 40.0149 -18.9669 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11 16 1 0 0 0 + 13 17 2 0 0 0 + 14 18 1 0 0 0 + 14 19 2 0 0 0 + 15 20 2 0 0 0 + 15 21 1 0 0 0 + 16 22 2 0 0 0 + 18 23 2 0 0 0 + 19 24 1 0 0 0 + 20 25 1 0 0 0 + 22 26 1 0 0 0 + 23 27 1 0 0 0 + 6 7 1 0 0 0 + 12 13 1 0 0 0 + 16 17 1 0 0 0 + 20 22 1 0 0 0 + 21 24 2 0 0 0 + 23 24 1 0 0 0 + 25 28 1 0 0 0 + 18 29 1 0 0 0 + 29 30 1 0 0 0 + 1 2 2 0 0 0 + 4 31 1 0 0 0 + 1 3 1 0 0 0 + 31 32 1 0 0 0 + 1 4 1 0 0 0 + 32 33 1 0 0 0 + 2 5 1 0 0 0 + 33 34 2 0 0 0 + 3 6 1 0 0 0 + 33 35 1 0 0 0 + 4 7 2 0 0 0 + 8 36 1 0 0 0 + 5 8 1 0 0 0 + 36 37 1 0 0 0 + 5 9 2 0 0 0 + 37 38 1 0 0 0 + 6 10 2 0 0 0 + 38 39 1 0 0 0 + 8 12 2 0 0 0 + 38 40 2 0 0 0 + 9 13 1 0 0 0 + 12 41 1 0 0 0 + 10 14 1 0 0 0 + 7 42 1 0 0 0 + 11 15 1 0 0 0 + 11 43 1 0 0 0 + 3 43 1 0 0 0 + 25 44 1 0 0 0 + 44 45 1 0 0 0 + 46 45 1 6 0 0 + 46 47 1 0 0 0 + 46 48 1 0 0 0 + 48 49 1 0 0 0 + 48 50 2 0 0 0 + 29 51 1 0 0 0 + 51 52 1 0 0 0 + 53 52 1 6 0 0 + 53 54 1 0 0 0 + 53 55 1 0 0 0 + 54 56 2 0 0 0 + 54 57 1 0 0 0 + 47 58 1 0 0 0 + 55 59 1 0 0 0 + 49 60 1 0 0 0 + 57 61 1 0 0 0 + 58 62 1 0 0 0 + 59 63 1 0 0 0 + 58 64 2 0 0 0 + 59 65 2 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C00127.mol b/src/analysis/thermo/trainingModel/data/mol/C00127.mol new file mode 100644 index 0000000000..7c7c510deb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00127.mol @@ -0,0 +1,85 @@ +C00127 + Mrv1652304062119422D + + 40 39 0 0 1 0 999 V2000 + 14.8075 -8.1567 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.5186 -8.5750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2297 -8.1567 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.9826 -8.5750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6937 -8.1567 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4467 -8.5750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1578 -8.1567 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8689 -8.5750 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.6218 -8.1567 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3329 -8.5750 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0440 -8.1567 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7969 -8.5750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5080 -8.1567 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.5186 -9.4116 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4467 -9.4116 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2297 -7.3201 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 19.8689 -9.4116 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6218 -7.3201 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7969 -9.4116 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1578 -9.8299 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1578 -10.6664 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9107 -11.1266 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9107 -11.9631 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.6218 -12.3396 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1578 -12.3814 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3329 -11.9631 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0440 -12.3396 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7551 -11.9631 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6218 -13.2180 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.4662 -12.3396 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 22.7551 -11.0847 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4467 -11.9631 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7356 -12.3814 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4467 -11.0847 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0245 -11.9631 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3134 -12.3814 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.6023 -11.9631 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3134 -13.2180 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.8912 -12.3396 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.6023 -11.0847 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 8 7 1 6 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 2 14 2 0 0 0 0 + 6 15 2 0 0 0 0 + 3 16 1 1 0 0 0 + 8 17 1 0 0 0 0 + 9 18 2 0 0 0 0 + 12 19 2 0 0 0 0 + 17 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 23 22 1 0 0 0 0 + 23 24 1 0 0 0 0 + 23 25 1 1 0 0 0 + 24 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 24 29 2 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 2 0 0 0 0 + 25 32 1 0 0 0 0 + 32 33 1 0 0 0 0 + 32 34 2 0 0 0 0 + 33 35 1 0 0 0 0 + 36 35 1 0 0 0 0 + 36 37 1 0 0 0 0 + 36 38 1 6 0 0 0 + 37 39 1 0 0 0 0 + 37 40 2 0 0 0 0 +M CHG 6 1 -1 13 -1 16 1 30 -1 38 1 39 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00129.mol b/src/analysis/thermo/trainingModel/data/mol/C00129.mol new file mode 100644 index 0000000000..69b3385f9d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00129.mol @@ -0,0 +1,33 @@ +C00129 + Mrv1652304062119422D + + 14 13 0 0 0 0 999 V2000 + 13.4997 -10.3424 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3235 -10.3387 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4884 -9.4422 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4845 -11.2841 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.6722 -10.3424 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1473 -10.3387 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7861 -9.0247 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1435 -9.4308 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.1358 -11.3067 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9711 -10.3387 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0724 -9.4385 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3588 -9.0247 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6413 -9.4385 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3588 -8.2429 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 6 10 2 0 0 0 0 + 7 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 12 14 2 0 0 0 0 +M CHG 2 4 -1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00130.mol b/src/analysis/thermo/trainingModel/data/mol/C00130.mol new file mode 100644 index 0000000000..ce785c69ee --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00130.mol @@ -0,0 +1,54 @@ +C00130 + Mrv1652304062119422D + + 23 25 0 0 1 0 999 V2000 + 15.5574 -9.5457 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7688 -9.2966 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9387 -10.7530 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.0404 -8.8853 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7688 -8.4666 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0519 -9.7154 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2670 -10.2587 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6896 -11.5189 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.5611 -8.2099 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0519 -8.0552 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3389 -9.2966 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5954 -10.7378 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.8596 -11.5189 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1763 -12.1830 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3389 -8.4666 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0482 -7.2328 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8258 -10.4926 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3879 -12.1905 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2144 -10.8548 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3882 -10.8548 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5695 -10.8548 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.3882 -10.0324 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.3844 -11.6736 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 2 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 1 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 21 -1 22 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00131.mol b/src/analysis/thermo/trainingModel/data/mol/C00131.mol new file mode 100644 index 0000000000..b661ba9e5a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00131.mol @@ -0,0 +1,68 @@ +C00131 + Mrv1652304062119422D + + 30 32 0 0 1 0 999 V2000 + 16.1032 -9.1037 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7353 -9.5424 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2154 -9.3939 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.3864 -8.2748 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4674 -9.0035 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8147 -10.3886 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5384 -8.8896 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9564 -10.1399 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2464 -8.2783 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2136 -9.3351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6022 -10.7374 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8823 -9.3593 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.1378 -10.1399 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.3483 -10.2573 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8697 -8.8447 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0983 -9.1037 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8719 -10.9205 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4800 -9.6598 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6511 -9.6598 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8256 -9.6598 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6476 -10.4853 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6476 -8.8344 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0001 -9.6564 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1748 -9.6564 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9968 -10.4818 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.9968 -8.8309 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3458 -9.6529 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3423 -10.4784 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.5203 -9.6460 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.3423 -8.8240 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 13 8 1 0 0 0 0 + 10 14 1 0 0 0 0 + 10 15 1 0 0 0 0 + 12 16 1 1 0 0 0 + 13 17 1 6 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 19 22 2 0 0 0 0 + 20 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 23 25 1 0 0 0 0 + 23 26 2 0 0 0 0 + 24 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 27 29 1 0 0 0 0 + 27 30 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 14 2 0 0 0 0 + 12 13 1 0 0 0 0 +M CHG 3 21 -1 25 -1 29 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00132.mol b/src/analysis/thermo/trainingModel/data/mol/C00132.mol new file mode 100644 index 0000000000..77679f042d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00132.mol @@ -0,0 +1,8 @@ +C00132 + Mrv1652304062119432D + + 2 1 0 0 0 0 999 V2000 + 13.0350 -8.6213 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8600 -8.6213 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00133.mol b/src/analysis/thermo/trainingModel/data/mol/C00133.mol new file mode 100644 index 0000000000..e43f60a957 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00133.mol @@ -0,0 +1,17 @@ +C00133 + Mrv1652304062119432D + + 6 5 0 0 1 0 999 V2000 + 13.4054 -9.2810 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.1198 -8.8684 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8343 -9.2810 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.5488 -8.8684 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1198 -8.0436 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8343 -10.1058 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 1 0 0 0 +M CHG 2 1 -1 6 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00135.mol b/src/analysis/thermo/trainingModel/data/mol/C00135.mol new file mode 100644 index 0000000000..2dbaf98b82 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00135.mol @@ -0,0 +1,28 @@ +C00135 + Mrv1652304062119432D + + 11 11 0 0 1 0 999 V2000 + 14.2606 -10.6217 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5325 -11.4005 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3573 -11.3825 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5951 -10.5925 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9173 -10.1222 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0595 -11.7975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7740 -11.3850 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.4884 -11.7975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2029 -11.3850 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.4884 -12.6225 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7740 -10.5601 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 7 6 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 + 7 11 1 6 0 0 0 +M CHG 2 9 -1 11 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00136.mol b/src/analysis/thermo/trainingModel/data/mol/C00136.mol new file mode 100644 index 0000000000..090980b699 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00136.mol @@ -0,0 +1,114 @@ +C00136 + Mrv1652304062119432D + + 53 55 0 0 1 0 999 V2000 + 5.3344 -10.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.0490 -10.4775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.7634 -10.8900 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 7.4779 -10.4775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.1924 -10.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9068 -10.4775 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6213 -10.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3358 -10.4775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0502 -10.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7647 -10.4775 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4792 -10.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1936 -10.4775 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9081 -10.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6226 -10.4775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3370 -10.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.0490 -9.6526 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6213 -11.7149 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4792 -11.7148 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1936 -9.6525 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9081 -10.0650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9081 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1620 -10.8900 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9870 -10.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1620 -11.7150 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.3337 -7.9612 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.1587 -7.9612 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.4137 -7.1766 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.7462 -6.6917 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0788 -7.1766 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.1913 -6.9239 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8488 -8.6287 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6437 -8.6287 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4687 -8.6287 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4687 -7.8037 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.2937 -8.6287 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.4687 -9.4537 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6525 -6.1050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6525 -6.9300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0815 -6.9300 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0815 -6.1050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3669 -5.6925 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9380 -5.6925 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2235 -6.1050 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2235 -6.9300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9380 -7.3425 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9380 -4.8676 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3594 -7.1787 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1844 -7.1787 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1844 -6.3537 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.0094 -7.1787 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1844 -9.0762 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.6102 -10.4717 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 3.9006 -10.8813 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 52 53 1 0 0 0 0 +M CHG 4 24 -1 34 -1 35 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00137.mol b/src/analysis/thermo/trainingModel/data/mol/C00137.mol new file mode 100644 index 0000000000..b9238868f1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00137.mol @@ -0,0 +1,29 @@ +C00137 + Mrv1652304062119432D + + 12 12 0 0 1 0 999 V2000 + 17.4497 -8.2017 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.1549 -7.7930 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.4497 -9.0270 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.6181 -7.8315 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8712 -8.2017 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.1511 -6.9791 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1549 -9.4432 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.6572 -9.4320 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8712 -9.0270 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.6181 -7.7930 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1511 -10.2571 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5764 -9.4320 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 1 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 1 0 0 0 + 7 11 1 1 0 0 0 + 9 12 1 6 0 0 0 + 7 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00140.mol b/src/analysis/thermo/trainingModel/data/mol/C00140.mol new file mode 100644 index 0000000000..1f106901e3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00140.mol @@ -0,0 +1,35 @@ +C00140 + Mrv1652304062119432D + + 15 15 0 0 1 0 999 V2000 + 15.5614 -10.9386 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.8432 -11.3547 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.5614 -10.1136 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 14.1355 -10.9386 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.8467 -12.1761 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8432 -9.6975 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2799 -9.6975 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1355 -10.1136 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.4243 -11.3547 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4243 -9.6975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7949 -10.2380 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3149 -11.3511 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0541 -10.9244 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7932 -11.3511 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0541 -10.1564 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 1 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 4 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 8 10 1 1 0 0 0 + 10 11 1 0 0 0 0 + 8 6 1 0 0 0 0 + 1 12 1 6 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00143.mol b/src/analysis/thermo/trainingModel/data/mol/C00143.mol new file mode 100644 index 0000000000..14e9e040a4 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00143.mol @@ -0,0 +1,75 @@ +C00143 + Mrv1652304062119432D + + 33 36 0 0 1 0 999 V2000 + 12.0208 -9.8894 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3155 -9.4832 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7679 -9.4480 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.0208 -10.6922 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3155 -8.6769 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6137 -9.8929 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2648 -10.1745 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8056 -8.6315 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8373 -10.9252 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0172 -8.2673 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6137 -8.2775 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9223 -9.4832 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6137 -10.6922 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9223 -8.6769 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2274 -8.2775 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6039 -11.4439 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6039 -12.2690 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3184 -12.6815 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0329 -12.2690 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0329 -11.4439 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3184 -11.0314 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7298 -12.6640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4443 -12.2515 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1588 -12.6640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8733 -12.2515 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5878 -12.6640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3022 -12.2515 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7331 -13.4889 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1588 -13.4890 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8745 -13.9023 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.4455 -13.9008 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0191 -12.6654 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.3022 -11.4265 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 6 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 10 1 0 0 0 0 + 5 11 1 0 0 0 0 + 6 12 1 0 0 0 0 + 6 13 2 0 0 0 0 + 11 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 12 14 2 0 0 0 0 + 9 16 1 0 0 0 0 + 16 17 2 0 0 0 0 + 17 18 1 0 0 0 0 + 18 19 2 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 2 0 0 0 0 + 16 21 1 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 22 28 2 0 0 0 0 + 24 29 1 0 0 0 0 + 29 30 1 0 0 0 0 + 29 31 2 0 0 0 0 + 27 32 1 0 0 0 0 + 27 33 2 0 0 0 0 +M CHG 2 30 -1 32 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00144.mol b/src/analysis/thermo/trainingModel/data/mol/C00144.mol new file mode 100644 index 0000000000..2d08064895 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00144.mol @@ -0,0 +1,56 @@ +C00144 + Mrv1652304062119432D + + 24 26 0 0 1 0 999 V2000 + 16.3583 -13.3742 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7275 -12.9306 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0929 -12.8302 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4379 -14.2163 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9652 -13.1836 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.0116 -12.1059 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8711 -12.1093 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8344 -13.2043 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2211 -14.5594 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2929 -12.6742 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7087 -13.9251 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.9315 -14.0430 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4929 -12.6708 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3112 -15.3806 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6380 -13.1489 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.8874 -13.9251 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1904 -14.5941 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8548 -12.8891 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6275 -14.7049 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2344 -13.4435 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4096 -13.4435 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4062 -14.2682 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.5849 -13.4435 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.4062 -12.6187 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 5 2 1 1 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 11 5 1 0 0 0 0 + 8 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 9 14 1 0 0 0 0 + 15 10 1 0 0 0 0 + 11 16 1 0 0 0 0 + 11 17 1 6 0 0 0 + 15 18 1 1 0 0 0 + 16 19 1 6 0 0 0 + 18 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 6 7 2 0 0 0 0 + 9 12 1 0 0 0 0 + 16 15 1 0 0 0 0 +M CHG 2 22 -1 23 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00147.mol b/src/analysis/thermo/trainingModel/data/mol/C00147.mol new file mode 100644 index 0000000000..58d24502db --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00147.mol @@ -0,0 +1,26 @@ +C00147 + Mrv1652304062119432D + + 10 11 0 0 0 0 999 V2000 + 7.7138 -9.9825 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7138 -10.8075 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4282 -11.2200 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1427 -10.8075 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1427 -9.9825 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4282 -9.5700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.9291 -9.7276 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 6.4442 -10.3950 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.9291 -11.0624 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4282 -8.7451 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 2 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 2 0 0 0 0 + 1 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 2 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00148.mol b/src/analysis/thermo/trainingModel/data/mol/C00148.mol new file mode 100644 index 0000000000..dccf1594db --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00148.mol @@ -0,0 +1,22 @@ +C00148 + Mrv1652304062119432D + + 8 8 0 0 1 0 999 V2000 + 5.9210 -11.4693 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.1694 -12.2146 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.9975 -12.2146 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2460 -11.4279 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 6.5835 -10.9311 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 7.9499 -11.0139 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6952 -11.4279 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.9499 -10.1858 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 4 6 1 6 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 +M CHG 2 5 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00149.mol b/src/analysis/thermo/trainingModel/data/mol/C00149.mol new file mode 100644 index 0000000000..52a50398f4 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00149.mol @@ -0,0 +1,23 @@ +C00149 + Mrv1652304062119432D + + 9 8 0 0 1 0 999 V2000 + 14.9931 -11.1252 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7107 -11.5391 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2794 -11.5391 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9931 -10.2977 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4243 -11.1252 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5657 -11.1215 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.2413 -12.4455 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1380 -11.5391 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.4205 -10.2977 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 2 0 0 0 0 +M CHG 2 6 -1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00152.mol b/src/analysis/thermo/trainingModel/data/mol/C00152.mol new file mode 100644 index 0000000000..8ef6440dc9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00152.mol @@ -0,0 +1,23 @@ +C00152 + Mrv1652304062119432D + + 9 8 0 0 1 0 999 V2000 + 11.0607 -10.1205 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.7897 -9.7345 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5188 -10.1205 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3337 -9.7345 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5187 -11.0211 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3316 -9.7345 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6025 -10.1633 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.3316 -8.8768 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0607 -11.0211 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 1 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 + 1 9 1 6 0 0 0 +M CHG 2 7 -1 9 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00153.mol b/src/analysis/thermo/trainingModel/data/mol/C00153.mol new file mode 100644 index 0000000000..88350d2298 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00153.mol @@ -0,0 +1,23 @@ +C00153 + Mrv1652304062119432D + + 9 9 0 0 0 0 999 V2000 + 14.8088 -10.0238 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0663 -9.6113 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8088 -10.8488 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5100 -9.6113 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3650 -10.0238 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0663 -11.2613 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2113 -10.0238 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5100 -8.7863 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3650 -10.8488 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 2 0 0 0 0 + 6 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00154.mol b/src/analysis/thermo/trainingModel/data/mol/C00154.mol new file mode 100644 index 0000000000..6942c53c4a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00154.mol @@ -0,0 +1,138 @@ +C00154 + Mrv1652304062119432D + + 65 67 0 0 1 0 999 V2000 + 12.0170 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7315 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4459 -15.4688 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1604 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8749 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5893 -15.0563 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3038 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0183 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7327 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4472 -15.0563 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1617 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8761 -15.0563 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.5906 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3051 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0195 -15.4688 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7315 -14.2314 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3038 -16.2937 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1617 -16.2935 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8761 -14.2313 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5906 -14.6438 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5906 -16.2938 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8445 -15.4688 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 23.6695 -15.4688 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8445 -16.2938 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.0163 -12.5400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.8413 -12.5400 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.0962 -11.7554 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.4288 -11.2704 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7613 -11.7554 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.8738 -11.5027 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5313 -13.2074 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3262 -13.2074 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1512 -13.2074 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1512 -12.3824 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 21.9762 -13.2074 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 21.1512 -14.0324 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3350 -10.6838 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3350 -11.5088 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7640 -11.5088 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7640 -10.6838 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0495 -10.2713 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6206 -10.2713 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9060 -10.6838 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9060 -11.5088 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6206 -11.9213 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6206 -9.4464 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0419 -11.7574 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8669 -11.7574 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8669 -10.9324 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 23.6919 -11.7574 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8669 -13.6549 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2893 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5748 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8603 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1459 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4314 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7169 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0025 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.2880 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.5735 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 4.8590 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 4.1446 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 3.4301 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 2.7156 -15.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 2.0012 -15.4688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 53 54 1 0 0 0 0 + 54 55 1 0 0 0 0 + 55 56 1 0 0 0 0 + 56 57 1 0 0 0 0 + 57 58 1 0 0 0 0 + 58 59 1 0 0 0 0 + 59 60 1 0 0 0 0 + 60 61 1 0 0 0 0 + 61 62 1 0 0 0 0 + 62 63 1 0 0 0 0 + 63 64 1 0 0 0 0 + 64 65 1 0 0 0 0 +M CHG 4 24 -1 34 -1 35 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00155.mol b/src/analysis/thermo/trainingModel/data/mol/C00155.mol new file mode 100644 index 0000000000..11439ed494 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00155.mol @@ -0,0 +1,21 @@ +C00155 + Mrv1652304062119432D + + 8 7 0 0 1 0 999 V2000 + 11.1790 -8.9102 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.8935 -8.4977 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6080 -8.9102 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.3225 -8.4977 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0369 -8.9102 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7514 -8.4977 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8935 -7.6728 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6080 -9.7351 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 3 8 1 6 0 0 0 +M CHG 2 1 -1 8 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00158.mol b/src/analysis/thermo/trainingModel/data/mol/C00158.mol new file mode 100644 index 0000000000..69a908fb7c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00158.mol @@ -0,0 +1,31 @@ +C00158 + Mrv1652304062119432D + + 13 12 0 0 0 0 999 V2000 + 8.4562 -13.3650 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.1707 -12.9525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8852 -13.3650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5997 -12.9525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3141 -13.3650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0286 -12.9525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7431 -13.3650 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.1707 -12.1276 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0286 -12.2102 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5997 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3153 -11.6318 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.8864 -11.6332 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8132 -13.9144 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 2 0 0 0 0 + 6 9 2 0 0 0 0 + 4 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 + 4 13 1 0 0 0 0 +M CHG 3 1 -1 7 -1 11 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00159.mol b/src/analysis/thermo/trainingModel/data/mol/C00159.mol new file mode 100644 index 0000000000..35a6f58d40 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00159.mol @@ -0,0 +1,29 @@ +C00159 + Mrv1652304062119432D + + 12 12 0 0 1 0 999 V2000 + 14.7140 -8.5046 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7140 -9.3296 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4255 -8.0921 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9990 -8.0921 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4255 -9.7421 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9990 -9.7421 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1439 -8.5046 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 13.3734 -8.6284 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1439 -9.3296 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4255 -10.5670 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8554 -8.0921 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8554 -9.7421 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 1 0 0 0 + 7 11 1 4 0 0 0 + 9 12 1 1 0 0 0 + 9 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00160.mol b/src/analysis/thermo/trainingModel/data/mol/C00160.mol new file mode 100644 index 0000000000..4b64eae8ba --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00160.mol @@ -0,0 +1,15 @@ +C00160 + Mrv1652304062119432D + + 5 4 0 0 0 0 999 V2000 + 15.4984 -9.5493 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7861 -9.9656 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2107 -9.9656 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.4984 -8.7201 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0705 -9.5493 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 +M CHG 1 3 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00163.mol b/src/analysis/thermo/trainingModel/data/mol/C00163.mol new file mode 100644 index 0000000000..a3a9d92aaf --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00163.mol @@ -0,0 +1,15 @@ +C00163 + Mrv1652304062119432D + + 5 4 0 0 0 0 999 V2000 + 14.5596 -11.0519 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2734 -11.4657 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8459 -11.4657 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5596 -10.2278 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9871 -11.0519 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 +M CHG 1 3 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00164.mol b/src/analysis/thermo/trainingModel/data/mol/C00164.mol new file mode 100644 index 0000000000..7e515203f1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00164.mol @@ -0,0 +1,19 @@ +C00164 + Mrv1652304062119432D + + 7 6 0 0 0 0 999 V2000 + 15.1003 -12.5487 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8114 -12.9252 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3474 -12.9670 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1003 -11.7122 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5225 -12.5069 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5225 -11.6703 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2754 -12.9252 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 7 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00166.mol b/src/analysis/thermo/trainingModel/data/mol/C00166.mol new file mode 100644 index 0000000000..f4b13957d7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00166.mol @@ -0,0 +1,30 @@ +C00166 + Mrv1652304062119432D + + 12 12 0 0 0 0 999 V2000 + 17.2363 -10.5998 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2438 -11.4204 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9503 -10.1757 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9663 -11.8306 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6728 -10.5859 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6813 -11.4201 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5274 -10.1883 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8129 -10.6008 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0985 -10.1883 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3841 -10.6008 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.8129 -11.4257 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0985 -9.3634 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 8 11 2 0 0 0 0 + 9 12 2 0 0 0 0 +M CHG 1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00167.mol b/src/analysis/thermo/trainingModel/data/mol/C00167.mol new file mode 100644 index 0000000000..6084cfa7fc --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00167.mol @@ -0,0 +1,82 @@ +C00167 + Mrv1652304062119432D + + 37 39 0 0 1 0 999 V2000 + 17.0663 -10.9547 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.5411 -9.6151 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3927 -10.4627 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8241 -11.7228 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.8334 -9.1913 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2676 -9.1913 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7343 -10.9395 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.9991 -11.7228 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.3084 -12.3888 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8334 -8.3589 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1183 -9.6000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2676 -8.3589 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9511 -10.6898 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5186 -12.3926 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5449 -7.9464 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7769 -9.8839 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5411 -7.2517 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9520 -9.8839 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1272 -9.8839 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9520 -9.0168 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9483 -10.7470 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3060 -9.8839 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4811 -9.8800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3060 -9.0168 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.3060 -10.7470 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6600 -9.8800 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.2476 -9.1611 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2476 -10.6028 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.4150 -9.1687 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.4226 -10.6066 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.6600 -11.3141 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9988 -9.8915 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.9988 -8.4573 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0178 -11.3217 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.1778 -9.8952 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4037 -7.7421 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.1739 -8.4648 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 26 27 1 0 0 0 0 + 28 26 1 0 0 0 0 + 29 27 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 1 6 0 0 0 + 32 29 1 0 0 0 0 + 29 33 1 1 0 0 0 + 30 34 1 1 0 0 0 + 32 35 1 6 0 0 0 + 33 36 1 0 0 0 0 + 33 37 2 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 + 30 32 1 0 0 0 0 +M CHG 3 20 -1 24 -1 36 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00168.mol b/src/analysis/thermo/trainingModel/data/mol/C00168.mol new file mode 100644 index 0000000000..0aa3636688 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00168.mol @@ -0,0 +1,19 @@ +C00168 + Mrv1652304062119432D + + 7 6 0 0 0 0 999 V2000 + 15.7547 -12.1374 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4523 -11.7044 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0281 -11.7467 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7371 -12.9597 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1822 -12.0929 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.4297 -10.8767 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3110 -12.2189 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00169.mol b/src/analysis/thermo/trainingModel/data/mol/C00169.mol new file mode 100644 index 0000000000..0065ee7547 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00169.mol @@ -0,0 +1,21 @@ +C00169 + Mrv1652304062119432D + + 8 7 0 0 0 0 999 V2000 + 13.7095 -9.7531 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8845 -9.7570 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5649 -9.7494 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7058 -8.9433 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7133 -10.5966 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1729 -9.3481 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4576 -9.7570 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1729 -8.5231 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00170.mol b/src/analysis/thermo/trainingModel/data/mol/C00170.mol new file mode 100644 index 0000000000..36ec184c4d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00170.mol @@ -0,0 +1,47 @@ +C00170 + Mrv1652304062119432D + + 20 22 0 0 1 0 999 V2000 + 16.9882 -13.0867 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.3523 -12.6294 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7579 -13.8050 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7302 -13.0695 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.9811 -13.8050 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2082 -14.4306 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5411 -14.4306 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7810 -12.8253 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4508 -13.3075 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1165 -12.8195 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8580 -12.0357 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0327 -12.0393 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5406 -14.1276 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2957 -14.4599 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9613 -13.9719 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8716 -13.1518 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5407 -12.6612 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9350 -12.8118 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2182 -13.2414 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5036 -12.8289 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 4 2 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 1 6 0 0 0 + 5 7 1 6 0 0 0 + 5 4 1 0 0 0 0 + 1 8 1 1 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 2 0 0 0 0 + 8 12 1 0 0 0 0 + 9 13 2 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 2 0 0 0 0 + 15 16 1 0 0 0 0 + 10 16 2 0 0 0 0 + 16 17 1 0 0 0 0 + 4 18 1 1 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00178.mol b/src/analysis/thermo/trainingModel/data/mol/C00178.mol new file mode 100644 index 0000000000..c655ac37b3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00178.mol @@ -0,0 +1,23 @@ +C00178 + Mrv1652304062119432D + + 9 9 0 0 0 0 999 V2000 + 15.1187 -8.9375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8279 -9.3506 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4026 -9.3472 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1187 -8.1112 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8279 -10.1803 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5439 -8.9409 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4026 -10.1769 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1118 -10.5934 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6830 -10.5866 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00181.mol b/src/analysis/thermo/trainingModel/data/mol/C00181.mol new file mode 100644 index 0000000000..b09ec7192f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00181.mol @@ -0,0 +1,25 @@ +C00181 + Mrv1652304062119432D + + 10 10 0 0 1 0 999 V2000 + 14.6621 -11.4222 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.3782 -11.0125 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.9460 -11.0125 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.6621 -12.2483 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3782 -10.1898 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 16.0943 -11.4222 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9460 -10.1898 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2334 -11.4222 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6621 -9.7766 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0943 -9.7766 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 6 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 4 0 0 0 + 7 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00183.mol b/src/analysis/thermo/trainingModel/data/mol/C00183.mol new file mode 100644 index 0000000000..3a04d1bcde --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00183.mol @@ -0,0 +1,21 @@ +C00183 + Mrv1652304062119432D + + 8 7 0 0 1 0 999 V2000 + 14.6656 -11.2582 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3836 -10.8475 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9476 -10.8372 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6622 -12.0867 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.0948 -11.2651 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3871 -10.0225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2330 -11.2479 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9510 -10.0155 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 +M CHG 2 4 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00184.mol b/src/analysis/thermo/trainingModel/data/mol/C00184.mol new file mode 100644 index 0000000000..4417f38800 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00184.mol @@ -0,0 +1,16 @@ +C00184 + Mrv1652304062119432D + + 6 5 0 0 0 0 999 V2000 + 15.6994 -11.7873 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4110 -11.3698 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9835 -11.3799 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7038 -12.6123 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1235 -11.7808 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2718 -11.7974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00185.mol b/src/analysis/thermo/trainingModel/data/mol/C00185.mol new file mode 100644 index 0000000000..ea9e679a20 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00185.mol @@ -0,0 +1,52 @@ +C00185 + Mrv1652304062119432D + + 23 24 0 0 1 0 999 V2000 + 16.1158 -8.5028 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.1158 -7.6777 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4008 -8.9118 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8239 -8.9118 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.8239 -7.2616 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4008 -7.2616 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6823 -9.3278 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.5424 -8.5028 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.8239 -9.7369 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5424 -7.6777 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 14.7716 -7.7980 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9638 -8.9153 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6823 -10.1528 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.2540 -8.9118 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2540 -7.2616 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2521 -9.3312 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9638 -10.5654 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.3973 -10.5654 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2521 -10.1528 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.5405 -8.9153 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9672 -11.3904 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5405 -10.5654 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9115 -9.4480 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 6 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 7 3 1 1 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 1 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 13 7 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 4 0 0 0 + 16 12 1 0 0 0 0 + 13 17 1 0 0 0 0 + 13 18 1 6 0 0 0 + 19 16 1 0 0 0 0 + 16 20 1 1 0 0 0 + 17 21 1 1 0 0 0 + 19 22 1 6 0 0 0 + 20 23 1 0 0 0 0 + 8 10 1 0 0 0 0 + 17 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00186.mol b/src/analysis/thermo/trainingModel/data/mol/C00186.mol new file mode 100644 index 0000000000..352ac940c3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00186.mol @@ -0,0 +1,17 @@ +C00186 + Mrv1652304062119432D + + 6 5 0 0 1 0 999 V2000 + 15.1045 -9.2861 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3996 -8.8552 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1228 -10.1109 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8265 -8.8952 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6606 -9.2126 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.4272 -8.0320 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00188.mol b/src/analysis/thermo/trainingModel/data/mol/C00188.mol new file mode 100644 index 0000000000..390246338b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00188.mol @@ -0,0 +1,21 @@ +C00188 + Mrv1652304062119432D + + 8 7 0 0 1 0 999 V2000 + 13.2824 -10.7661 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9968 -10.3536 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7113 -10.7661 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4258 -10.3536 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.1402 -10.7661 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9968 -9.5287 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7113 -11.5910 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.4258 -9.5285 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 6 0 0 0 +M CHG 2 1 -1 7 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00189.mol b/src/analysis/thermo/trainingModel/data/mol/C00189.mol new file mode 100644 index 0000000000..64d15a9604 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00189.mol @@ -0,0 +1,13 @@ +C00189 + Mrv1652304062119432D + + 4 3 0 0 0 0 999 V2000 + 15.0886 -10.2053 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3740 -9.7930 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7997 -9.7930 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.6629 -10.2053 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 +M CHG 1 3 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00190.mol b/src/analysis/thermo/trainingModel/data/mol/C00190.mol new file mode 100644 index 0000000000..c0639938af --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00190.mol @@ -0,0 +1,76 @@ +C00190 + Mrv1652304062119432D + + 34 36 0 0 1 0 999 V2000 + 19.0460 -17.0480 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6891 -15.7089 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3689 -16.5563 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8002 -17.8159 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.9779 -15.2852 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4116 -15.2852 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7145 -17.0291 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.9793 -17.8159 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.2881 -18.4816 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9779 -14.4531 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2629 -15.6939 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4116 -14.4531 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9277 -16.7794 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4989 -18.4855 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6929 -14.0409 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7537 -15.9775 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6891 -13.3043 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9291 -15.9737 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1083 -15.9737 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9329 -15.1107 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.9291 -16.7985 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2837 -15.9737 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4589 -15.9700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2837 -15.1107 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.2837 -16.7985 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7440 -16.3822 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.7440 -17.2031 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.0253 -15.9700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0253 -17.6192 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.4589 -17.6192 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3142 -16.3822 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3142 -17.2031 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.0253 -18.5243 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6106 -17.6192 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 27 26 1 0 0 0 0 + 26 28 1 0 0 0 0 + 27 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 28 31 1 0 0 0 0 + 29 32 1 0 0 0 0 + 29 33 1 1 0 0 0 + 32 34 1 6 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 + 32 31 1 0 0 0 0 +M CHG 2 20 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00191.mol b/src/analysis/thermo/trainingModel/data/mol/C00191.mol new file mode 100644 index 0000000000..80619c00a1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00191.mol @@ -0,0 +1,32 @@ +C00191 + Mrv1652304062119432D + + 13 13 0 0 1 0 999 V2000 + 14.7474 -10.8327 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7474 -11.6577 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4555 -10.4168 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0324 -10.4580 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4555 -12.0668 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0324 -12.0668 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1740 -10.8327 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 13.4034 -10.9943 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0255 -9.5987 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1740 -11.6577 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4555 -12.8918 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8855 -10.4168 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8855 -12.0668 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 5 11 1 1 0 0 0 + 7 12 1 4 0 0 0 + 10 13 1 6 0 0 0 + 10 7 1 0 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00197.mol b/src/analysis/thermo/trainingModel/data/mol/C00197.mol new file mode 100644 index 0000000000..d201a0fd17 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00197.mol @@ -0,0 +1,27 @@ +C00197 + Mrv1652304062119432D + + 11 10 0 0 1 0 999 V2000 + 16.2571 -9.3805 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4627 -9.3772 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0683 -9.3940 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2706 -8.6098 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2504 -10.1380 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7458 -8.9632 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0322 -9.3772 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.3185 -8.9632 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0322 -10.2053 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6016 -9.3772 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.3185 -8.1385 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 1 1 0 0 0 + 8 10 1 0 0 0 0 + 8 11 2 0 0 0 0 +M CHG 3 3 -1 4 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00198.mol b/src/analysis/thermo/trainingModel/data/mol/C00198.mol new file mode 100644 index 0000000000..bdeedef472 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00198.mol @@ -0,0 +1,29 @@ +C00198 + Mrv1652304062119432D + + 12 12 0 0 1 0 999 V2000 + 14.2290 -10.2869 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.2201 -11.1118 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.9521 -9.8823 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5250 -9.8693 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9259 -11.5326 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.5087 -11.5141 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6664 -10.3027 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6902 -11.1281 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.9133 -12.3510 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3647 -9.8692 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3515 -11.5507 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8138 -10.2690 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 1 1 0 0 0 + 7 10 2 0 0 0 0 + 8 11 1 6 0 0 0 + 8 7 1 0 0 0 0 + 4 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00199.mol b/src/analysis/thermo/trainingModel/data/mol/C00199.mol new file mode 100644 index 0000000000..d6780b08d6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00199.mol @@ -0,0 +1,33 @@ +C00199 + Mrv1652304062119432D + + 14 13 0 0 1 0 999 V2000 + 13.2302 -9.7709 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.9458 -10.1823 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.5186 -10.1823 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2302 -8.9474 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6609 -9.7709 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9458 -11.0058 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7995 -9.7709 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5186 -11.0058 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3765 -10.1823 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0879 -10.1823 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2000 -10.1788 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0270 -10.1788 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2000 -9.3520 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2000 -11.0024 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 7 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 11 14 2 0 0 0 0 +M CHG 2 12 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00204.mol b/src/analysis/thermo/trainingModel/data/mol/C00204.mol new file mode 100644 index 0000000000..d068c85298 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00204.mol @@ -0,0 +1,29 @@ +C00204 + Mrv1652304062119432D + + 12 11 0 0 1 0 999 V2000 + 7.7139 -9.6115 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4284 -9.1990 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.1429 -9.6115 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.8574 -9.1990 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5718 -9.6115 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2864 -9.1990 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0008 -9.6115 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2864 -8.3741 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5718 -10.4364 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4284 -8.3741 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1429 -10.4364 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.9995 -9.1990 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 + 5 9 2 0 0 0 0 + 2 10 1 1 0 0 0 + 3 11 1 6 0 0 0 + 1 12 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00206.mol b/src/analysis/thermo/trainingModel/data/mol/C00206.mol new file mode 100644 index 0000000000..73c809ff73 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00206.mol @@ -0,0 +1,60 @@ +C00206 + Mrv1652304062119432D + + 26 28 0 0 1 0 999 V2000 + 17.2918 -8.9334 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9205 -9.3711 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5276 -9.1800 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.5766 -8.1033 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6534 -8.8327 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0003 -10.2151 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8502 -8.6763 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2670 -9.9235 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4380 -8.1067 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4002 -9.1593 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7889 -10.5660 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1903 -9.1454 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4472 -9.9235 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.4974 -10.0415 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0601 -8.6694 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4052 -8.8917 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1798 -10.7119 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7870 -9.4476 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9567 -9.4476 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1266 -9.4476 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9533 -10.2777 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.9533 -8.6174 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2963 -9.4441 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2895 -10.2742 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4628 -9.4441 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2895 -8.6139 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 13 8 1 0 0 0 0 + 10 14 1 0 0 0 0 + 10 15 1 0 0 0 0 + 12 16 1 1 0 0 0 + 13 17 1 6 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 19 22 2 0 0 0 0 + 20 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 23 25 1 0 0 0 0 + 23 26 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 14 2 0 0 0 0 + 12 13 1 0 0 0 0 +M CHG 2 21 -1 25 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00207.mol b/src/analysis/thermo/trainingModel/data/mol/C00207.mol new file mode 100644 index 0000000000..14ee30d0ce --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00207.mol @@ -0,0 +1,12 @@ +C00207 + Mrv1652304062119432D + + 4 3 0 0 0 0 999 V2000 + 13.0485 -9.7450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3347 -10.1589 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7622 -10.1589 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0485 -8.9175 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00208.mol b/src/analysis/thermo/trainingModel/data/mol/C00208.mol new file mode 100644 index 0000000000..8f9e88582c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00208.mol @@ -0,0 +1,52 @@ +C00208 + Mrv1652304062119432D + + 23 24 0 0 1 0 999 V2000 + 16.1922 -10.4066 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.1922 -9.5803 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4792 -10.8180 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9088 -10.8146 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.9088 -9.1689 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4792 -9.1654 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7660 -11.2295 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.6220 -10.4066 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.9088 -11.6409 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6220 -9.5803 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 14.7660 -9.5803 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0564 -10.8146 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7660 -12.0557 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.3351 -10.8146 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3351 -9.1689 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3398 -11.2295 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0564 -12.4638 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4792 -12.4638 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3398 -12.0557 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.6232 -10.8146 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0564 -13.2900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6232 -12.4638 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9101 -11.2295 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 6 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 7 3 1 6 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 1 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 13 7 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 4 0 0 0 + 16 12 1 0 0 0 0 + 13 17 1 0 0 0 0 + 13 18 1 6 0 0 0 + 19 16 1 0 0 0 0 + 16 20 1 1 0 0 0 + 17 21 1 1 0 0 0 + 19 22 1 6 0 0 0 + 20 23 1 0 0 0 0 + 8 10 1 0 0 0 0 + 17 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00209.mol b/src/analysis/thermo/trainingModel/data/mol/C00209.mol new file mode 100644 index 0000000000..865f99b5b6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00209.mol @@ -0,0 +1,17 @@ +C00209 + Mrv1652304062119432D + + 6 5 0 0 0 0 999 V2000 + 12.7278 -9.7712 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4431 -9.3601 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0085 -9.3601 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.7278 -10.6421 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1625 -9.7712 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.4431 -8.6134 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 +M CHG 2 3 -1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00212.mol b/src/analysis/thermo/trainingModel/data/mol/C00212.mol new file mode 100644 index 0000000000..ad0eb138c2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00212.mol @@ -0,0 +1,45 @@ +C00212 + Mrv1652304062119432D + + 19 21 0 0 1 0 999 V2000 + 13.1082 -9.9246 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7454 -10.3658 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3342 -10.1733 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.3918 -9.0877 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4843 -9.8230 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8259 -11.2167 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6514 -9.6655 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0786 -10.9226 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.2602 -9.0911 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2338 -10.1523 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6174 -11.5704 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9930 -10.1383 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.2487 -10.9226 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.3237 -11.7210 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3317 -11.0417 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8955 -9.6620 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2121 -9.8931 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9825 -11.7176 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5468 -10.3939 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 2 0 0 0 0 + 13 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00214.mol b/src/analysis/thermo/trainingModel/data/mol/C00214.mol new file mode 100644 index 0000000000..e17a6bdbff --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00214.mol @@ -0,0 +1,40 @@ +C00214 + Mrv1652304062119432D + + 17 18 0 0 1 0 999 V2000 + 14.9388 -9.6069 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.2624 -9.0927 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6938 -10.3730 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5964 -9.5896 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.8552 -10.3730 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.8096 -9.3412 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5998 -11.1804 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1989 -9.8967 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6932 -9.4240 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3994 -9.8366 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6972 -8.6021 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1212 -9.4316 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3596 -10.6679 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4134 -8.1877 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1193 -8.6145 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4174 -7.3657 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8370 -8.2070 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 4 2 1 0 0 0 0 + 5 3 1 0 0 0 0 + 4 6 1 1 0 0 0 + 5 7 1 6 0 0 0 + 6 8 1 0 0 0 0 + 4 5 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 10 13 2 0 0 0 0 + 11 14 2 0 0 0 0 + 12 15 1 0 0 0 0 + 14 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 14 15 1 0 0 0 0 + 1 9 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00216.mol b/src/analysis/thermo/trainingModel/data/mol/C00216.mol new file mode 100644 index 0000000000..a9a30b18e5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00216.mol @@ -0,0 +1,25 @@ +C00216 + Mrv1652304062119442D + + 10 10 0 0 1 0 999 V2000 + 15.1136 -9.7343 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.8320 -9.3218 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4055 -9.3218 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1205 -10.5593 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8320 -8.4968 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 16.5471 -9.7343 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4055 -8.4968 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6940 -9.7343 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1136 -8.0809 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5471 -8.0809 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 6 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 4 0 0 0 + 7 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00217.mol b/src/analysis/thermo/trainingModel/data/mol/C00217.mol new file mode 100644 index 0000000000..1ef293171e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00217.mol @@ -0,0 +1,25 @@ +C00217 + Mrv1652304062119442D + + 10 9 0 0 1 0 999 V2000 + 14.0636 -10.3017 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7646 -9.8665 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3351 -9.9114 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0878 -11.1269 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.4931 -10.2533 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6513 -10.3811 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.3454 -9.0862 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1941 -9.8182 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9226 -10.2084 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2078 -8.9929 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 3 4 1 6 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00218.mol b/src/analysis/thermo/trainingModel/data/mol/C00218.mol new file mode 100644 index 0000000000..8f5de4787c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00218.mol @@ -0,0 +1,9 @@ +C00218 + Mrv1652304062119442D + + 2 1 0 0 0 0 999 V2000 + 12.6768 -9.7338 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3921 -9.3229 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 +M CHG 1 2 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00219.mol b/src/analysis/thermo/trainingModel/data/mol/C00219.mol new file mode 100644 index 0000000000..31c28be801 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00219.mol @@ -0,0 +1,49 @@ +C00219 + Mrv1652304062119442D + + 22 21 0 0 0 0 999 V2000 + 13.1377 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9593 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4233 -10.4937 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6736 -10.4937 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7131 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3880 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8874 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2097 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1813 -10.4937 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9239 -10.4937 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4628 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6341 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7485 -10.4937 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4599 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0383 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1742 -10.4937 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.3241 -10.4937 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.0383 -9.2590 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8844 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5987 -10.4937 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3089 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0233 -10.4937 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 2 0 0 0 0 + 6 8 2 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 12 14 2 0 0 0 0 + 13 15 1 0 0 0 0 + 14 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 18 2 0 0 0 0 + 16 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 +M CHG 1 17 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00222.mol b/src/analysis/thermo/trainingModel/data/mol/C00222.mol new file mode 100644 index 0000000000..b8e2261638 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00222.mol @@ -0,0 +1,17 @@ +C00222 + Mrv1652304062119442D + + 6 5 0 0 0 0 999 V2000 + 15.1080 -9.9608 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8253 -9.5470 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3943 -9.5470 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5389 -9.9608 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.8253 -8.7229 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6806 -9.9608 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 2 0 0 0 0 +M CHG 1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00224.mol b/src/analysis/thermo/trainingModel/data/mol/C00224.mol new file mode 100644 index 0000000000..96fd310057 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00224.mol @@ -0,0 +1,62 @@ +C00224 + Mrv1652304062119442D + + 27 29 0 0 1 0 999 V2000 + 16.1959 -9.4899 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4068 -9.2407 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5011 -10.6878 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.6791 -8.8292 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4068 -8.4100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6857 -9.6598 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8328 -10.2082 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2482 -11.4731 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.1997 -8.1532 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6857 -7.9985 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9758 -9.2407 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1721 -10.6878 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4213 -11.4731 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7277 -12.1339 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9758 -8.4100 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6857 -7.1753 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3943 -10.4311 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9380 -12.1339 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2282 -9.6268 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4012 -9.6231 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5858 -9.6268 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4012 -8.7617 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.3975 -10.4461 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7589 -9.6231 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7589 -8.7617 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.9395 -9.6231 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7551 -10.4461 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 2 0 0 0 0 + 24 27 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 2 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 22 -1 25 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00225.mol b/src/analysis/thermo/trainingModel/data/mol/C00225.mol new file mode 100644 index 0000000000..49671acdd7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00225.mol @@ -0,0 +1,35 @@ + + Mrv1652304062119442D + + 14 15 0 0 0 0 999 V2000 + 14.1845 -13.6231 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9957 -13.6163 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7755 -14.3450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7617 -12.9081 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4151 -14.3278 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4014 -12.9013 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9539 -14.3450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9402 -12.9219 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2401 -14.3278 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2264 -12.9321 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5380 -13.6300 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.6457 -13.6059 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 11.7199 -13.6369 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5428 -13.6368 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 2 0 0 0 0 + 7 11 2 0 0 0 0 + 8 11 1 0 0 0 0 + 9 12 2 0 0 0 0 + 10 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 12 14 1 0 0 0 0 +M CHG 2 11 1 12 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00227.mol b/src/analysis/thermo/trainingModel/data/mol/C00227.mol new file mode 100644 index 0000000000..14484b130c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00227.mol @@ -0,0 +1,21 @@ +C00227 + Mrv1652304062119442D + + 8 7 0 0 0 0 999 V2000 + 14.3705 -9.9179 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5807 -9.9264 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1561 -9.9264 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3744 -10.8182 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3705 -9.0645 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8381 -9.4958 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1344 -9.9264 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8381 -8.6775 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00229.mol b/src/analysis/thermo/trainingModel/data/mol/C00229.mol new file mode 100644 index 0000000000..89a0fdbd8d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00229.mol @@ -0,0 +1,8 @@ +C00229 + + + 2 1 0 0 0 0 0 0 0 0999 V2000 + 25.7319 -20.5760 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 27.1319 -20.5702 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C00231.mol b/src/analysis/thermo/trainingModel/data/mol/C00231.mol new file mode 100644 index 0000000000..082b562c05 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00231.mol @@ -0,0 +1,33 @@ +C00231 + Mrv1652304062119442D + + 14 13 0 0 1 0 999 V2000 + 12.2163 -9.3451 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.9298 -9.7589 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5026 -9.7589 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2163 -8.5214 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6474 -9.3451 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9298 -10.5826 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7851 -9.3451 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5026 -10.5826 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3609 -9.7589 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0715 -9.7589 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1847 -9.7551 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0122 -9.7551 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.1847 -8.8863 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.1847 -10.5788 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 7 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 11 14 2 0 0 0 0 +M CHG 2 12 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00232.mol b/src/analysis/thermo/trainingModel/data/mol/C00232.mol new file mode 100644 index 0000000000..12d49b9ded --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00232.mol @@ -0,0 +1,19 @@ +C00232 + Mrv1652304062119442D + + 7 6 0 0 0 0 999 V2000 + 16.9037 -11.7359 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6197 -11.3193 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1876 -11.3262 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3393 -11.7359 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.6197 -10.4964 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4749 -11.7393 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7594 -11.3279 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 6 7 2 0 0 0 0 +M CHG 1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00233.mol b/src/analysis/thermo/trainingModel/data/mol/C00233.mol new file mode 100644 index 0000000000..e0874cbab9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00233.mol @@ -0,0 +1,23 @@ +C00233 + Mrv1652304062119442D + + 9 8 0 0 0 0 999 V2000 + 13.4103 -9.3247 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6927 -9.7386 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1240 -9.7386 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4103 -8.5384 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9790 -9.3247 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8377 -9.3247 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.1240 -10.6863 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2652 -9.7386 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9790 -8.5384 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 1 0 0 0 0 +M CHG 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00234.mol b/src/analysis/thermo/trainingModel/data/mol/C00234.mol new file mode 100644 index 0000000000..c2f016827c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00234.mol @@ -0,0 +1,76 @@ +C00234 + Mrv1652304062119442D + + 34 36 0 0 1 0 999 V2000 + 5.6121 -10.3531 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 5.6121 -11.1781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3134 -11.5907 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0559 -11.1781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0559 -10.3531 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3134 -9.9406 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7572 -11.5907 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4584 -11.1781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4584 -10.3531 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 7.7572 -9.9406 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3134 -9.1156 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.8959 -11.5878 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1730 -9.9406 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8875 -10.3531 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6019 -9.9406 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3177 -10.3538 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0321 -9.9413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0321 -9.1163 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3164 -8.7031 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6019 -9.1156 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7618 -8.7031 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4763 -9.1156 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7653 -7.8782 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2018 -8.6966 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9121 -9.1066 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6088 -8.7042 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3124 -9.1104 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0125 -8.7061 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.3126 -9.9404 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2017 -7.8781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4802 -7.4617 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9091 -7.4694 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.8874 -11.1604 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6007 -11.5722 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 9 8 1 0 0 0 0 + 9 10 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 2 12 1 0 0 0 0 + 9 13 1 1 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 2 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 2 0 0 0 0 + 15 20 1 0 0 0 0 + 18 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 2 0 0 0 0 + 24 22 1 6 0 0 0 + 24 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 27 29 2 0 0 0 0 + 24 30 1 0 0 0 0 + 30 31 2 0 0 0 0 + 30 32 1 0 0 0 0 + 14 33 1 0 0 0 0 + 33 34 2 0 0 0 0 +M CHG 2 28 -1 32 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00235.mol b/src/analysis/thermo/trainingModel/data/mol/C00235.mol new file mode 100644 index 0000000000..dbf3d399de --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00235.mol @@ -0,0 +1,33 @@ +C00235 + Mrv1652304062119442D + + 14 13 0 0 0 0 999 V2000 + 13.6358 -9.6926 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4607 -9.6926 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8185 -9.7002 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6358 -8.7892 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.6358 -10.5176 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2819 -9.6926 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1071 -9.2878 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1068 -9.6926 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.2819 -8.7892 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2819 -10.5176 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3919 -9.7002 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6804 -9.2878 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9653 -9.7002 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6804 -8.4628 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 6 10 2 0 0 0 0 + 7 11 1 0 0 0 0 + 11 12 2 0 0 0 0 + 12 13 1 0 0 0 0 + 12 14 1 0 0 0 0 +M CHG 2 4 -1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00236.mol b/src/analysis/thermo/trainingModel/data/mol/C00236.mol new file mode 100644 index 0000000000..b895c8bc45 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00236.mol @@ -0,0 +1,35 @@ +C00236 + Mrv1652304062119442D + + 15 14 0 0 1 0 999 V2000 + 11.8189 -13.4861 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6257 -13.4995 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0289 -13.4861 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.7922 -12.7229 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.8122 -14.2426 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3453 -13.0844 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0650 -13.4995 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.3453 -12.2542 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7779 -13.0844 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0650 -14.3296 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5009 -13.4995 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2977 -13.4995 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1111 -13.5128 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.3110 -12.7262 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2909 -14.2627 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 0 0 0 0 + 6 8 2 0 0 0 0 + 7 9 1 0 0 0 0 + 7 10 1 1 0 0 0 + 9 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 12 14 1 0 0 0 0 + 12 15 2 0 0 0 0 +M CHG 4 3 -1 4 -1 13 -1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00237.mol b/src/analysis/thermo/trainingModel/data/mol/C00237.mol new file mode 100644 index 0000000000..abe6729794 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00237.mol @@ -0,0 +1,9 @@ +C00237 + Mrv1652304062119442D + + 2 1 0 0 0 0 999 V2000 + 13.2825 -7.2600 0.0000 O 0 3 0 0 0 0 0 0 0 0 0 0 + 12.4575 -7.2600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 3 0 0 0 0 +M CHG 1 1 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00239.mol b/src/analysis/thermo/trainingModel/data/mol/C00239.mol new file mode 100644 index 0000000000..62ab7fc77a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00239.mol @@ -0,0 +1,47 @@ +C00239 + Mrv1652304062119442D + + 20 21 0 0 1 0 999 V2000 + 15.7984 -13.3066 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0099 -13.5636 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.4154 -13.8550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9698 -12.5010 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3689 -13.0940 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7701 -14.3692 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2004 -13.5945 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2508 -14.6571 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7479 -12.2405 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7005 -13.5842 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9438 -14.3692 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.3683 -12.7889 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9155 -13.3305 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4572 -15.0273 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1499 -12.5319 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3088 -13.8824 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4895 -13.8824 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4861 -14.7017 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.6702 -13.8824 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.4861 -13.0632 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 4 9 2 0 0 0 0 + 10 5 1 0 0 0 0 + 11 6 1 0 0 0 0 + 7 12 2 0 0 0 0 + 10 13 1 1 0 0 0 + 11 14 1 6 0 0 0 + 12 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 17 19 1 0 0 0 0 + 17 20 2 0 0 0 0 + 9 12 1 0 0 0 0 + 10 11 1 0 0 0 0 +M CHG 2 18 -1 19 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00242.mol b/src/analysis/thermo/trainingModel/data/mol/C00242.mol new file mode 100644 index 0000000000..ddf774e28a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00242.mol @@ -0,0 +1,28 @@ +C00242 + Mrv1652304062119442D + + 11 12 0 0 0 0 999 V2000 + 13.5269 -10.7496 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5235 -9.8668 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2251 -11.1740 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8220 -10.9927 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2079 -9.4664 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8254 -9.6170 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9506 -10.7633 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3327 -10.2843 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9574 -9.9010 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2079 -8.6861 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6589 -11.1775 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 7 11 1 0 0 0 0 + 6 8 2 0 0 0 0 + 7 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00243.mol b/src/analysis/thermo/trainingModel/data/mol/C00243.mol new file mode 100644 index 0000000000..71dd20ec5e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00243.mol @@ -0,0 +1,52 @@ +C00243 + Mrv1652304062119442D + + 23 24 0 0 1 0 999 V2000 + 23.0516 -12.5899 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 23.0516 -11.7649 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 22.3366 -12.9990 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.7596 -12.9990 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 23.7596 -11.3490 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.3366 -11.3490 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6181 -13.4150 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.4781 -12.5899 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 23.7596 -13.8240 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.4781 -11.7649 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 21.7074 -11.8853 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.8997 -12.9990 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6181 -14.2399 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.1896 -12.9990 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.1896 -11.3490 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1881 -13.4150 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.8997 -14.6524 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 22.3331 -14.6524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1881 -14.2399 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.4765 -12.9990 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9031 -15.4774 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4765 -14.6524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8475 -13.5352 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 6 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 7 3 1 1 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 1 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 13 7 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 4 0 0 0 + 16 12 1 0 0 0 0 + 13 17 1 0 0 0 0 + 13 18 1 6 0 0 0 + 19 16 1 0 0 0 0 + 16 20 1 1 0 0 0 + 17 21 1 1 0 0 0 + 19 22 1 1 0 0 0 + 20 23 1 0 0 0 0 + 8 10 1 0 0 0 0 + 17 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00244.mol b/src/analysis/thermo/trainingModel/data/mol/C00244.mol new file mode 100644 index 0000000000..cd4d965fc2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00244.mol @@ -0,0 +1,13 @@ +C00244 + Mrv1652304062119442D + + 4 3 0 0 0 0 999 V2000 + 12.3390 -8.8480 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3390 -9.6730 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.0466 -8.4437 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5924 -8.4404 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 2 0 0 0 0 +M CHG 1 2 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00246.mol b/src/analysis/thermo/trainingModel/data/mol/C00246.mol new file mode 100644 index 0000000000..ebaaaa40c6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00246.mol @@ -0,0 +1,17 @@ +C00246 + Mrv1652304062119442D + + 6 5 0 0 0 0 999 V2000 + 15.1113 -9.9681 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4002 -9.5559 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8293 -9.5559 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6823 -9.9681 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.4002 -8.7279 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5439 -9.9681 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 +M CHG 1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00247.mol b/src/analysis/thermo/trainingModel/data/mol/C00247.mol new file mode 100644 index 0000000000..699c64d958 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00247.mol @@ -0,0 +1,29 @@ +C00247 + Mrv1652304062119442D + + 12 12 0 0 1 0 999 V2000 + 15.4908 -8.5045 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 15.4908 -9.3295 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7792 -8.0920 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2059 -8.0920 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0719 -9.0855 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7792 -9.7421 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.2059 -9.7421 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0608 -8.5045 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8316 -8.6282 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0608 -9.3295 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7792 -10.5672 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3492 -9.7421 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 1 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 0 0 0 0 + 6 11 1 6 0 0 0 + 10 12 1 1 0 0 0 + 10 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00248.mol b/src/analysis/thermo/trainingModel/data/mol/C00248.mol new file mode 100644 index 0000000000..e35e57d750 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00248.mol @@ -0,0 +1,29 @@ +C00248 + Mrv1652304062119442D + + 12 12 0 0 0 0 999 V2000 + 16.9125 -9.2813 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0875 -9.2813 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8400 -10.0650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5000 -10.5600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1600 -10.0650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8613 -10.4775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6038 -10.0650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3050 -10.4775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0063 -10.0650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7488 -10.4775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4500 -10.0650 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7488 -11.3025 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00249.mol b/src/analysis/thermo/trainingModel/data/mol/C00249.mol new file mode 100644 index 0000000000..4eb8aab1d6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00249.mol @@ -0,0 +1,41 @@ +C00249 + Mrv1652304062119442D + + 18 17 0 0 0 0 999 V2000 + 17.4441 -10.6983 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1586 -10.2859 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7294 -10.2859 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8664 -10.6983 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0217 -10.6983 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5811 -10.2859 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3070 -10.2859 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2889 -10.6983 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5993 -10.6983 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0035 -10.2859 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8846 -10.2859 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7181 -10.6983 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1735 -10.7017 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.8880 -9.4648 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4259 -10.2859 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1405 -10.6983 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8517 -10.2859 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.5629 -10.6983 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 11 14 2 0 0 0 0 + 12 15 1 0 0 0 0 + 15 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 1 0 0 0 0 +M CHG 1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00250.mol b/src/analysis/thermo/trainingModel/data/mol/C00250.mol new file mode 100644 index 0000000000..6158df769d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00250.mol @@ -0,0 +1,29 @@ +C00250 + Mrv1652304062119442D + + 12 12 0 0 0 0 999 V2000 + 14.7744 -9.1063 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4851 -9.5253 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0567 -9.5253 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7744 -8.2857 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4851 -10.3560 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2026 -9.1201 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0567 -10.3560 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3425 -9.1166 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4884 -7.8772 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7744 -10.7680 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9099 -9.5320 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3425 -10.7680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 7 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00251.mol b/src/analysis/thermo/trainingModel/data/mol/C00251.mol new file mode 100644 index 0000000000..bd005e8393 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00251.mol @@ -0,0 +1,38 @@ +C00251 + Mrv1652304062119442D + + 16 16 0 0 1 0 999 V2000 + 15.4514 -11.4928 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4514 -10.6648 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7292 -11.9163 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.2035 -11.9464 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7292 -10.2526 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0145 -11.4928 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7254 -12.7370 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9145 -11.5341 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0145 -10.6648 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7254 -9.4283 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6291 -11.9425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9145 -10.7512 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4401 -9.0199 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0108 -9.0237 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6291 -12.7668 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2574 -11.5679 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 0 0 0 0 + 8 11 1 0 0 0 0 + 8 12 2 0 0 0 0 + 10 13 1 0 0 0 0 + 10 14 2 0 0 0 0 + 11 15 2 0 0 0 0 + 11 16 1 0 0 0 0 + 6 9 2 0 0 0 0 +M CHG 2 13 -1 16 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00252.mol b/src/analysis/thermo/trainingModel/data/mol/C00252.mol new file mode 100644 index 0000000000..527a5114e9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00252.mol @@ -0,0 +1,52 @@ +C00252 + Mrv1652304062119442D + + 23 24 0 0 1 0 999 V2000 + 14.3960 -8.7855 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.6742 -8.3730 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1076 -8.3696 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3960 -9.6105 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.9661 -8.7889 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7367 -7.8333 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6742 -10.0230 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.1042 -10.0642 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9661 -9.6105 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.2512 -8.3730 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4516 -8.2458 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.6742 -10.8480 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2512 -10.0230 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6222 -8.9092 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4516 -9.0708 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.1597 -7.8333 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1597 -9.4833 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7367 -9.4833 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8781 -8.2458 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 17.8781 -9.0708 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.1597 -10.3082 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5896 -7.8333 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5896 -9.4833 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 6 0 0 0 + 4 1 1 0 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 1 6 0 0 0 + 9 5 1 0 0 0 0 + 5 10 1 1 0 0 0 + 11 6 1 1 0 0 0 + 7 12 1 1 0 0 0 + 9 13 1 6 0 0 0 + 10 14 1 0 0 0 0 + 15 11 1 0 0 0 0 + 11 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 18 1 6 0 0 0 + 16 19 1 0 0 0 0 + 17 20 1 0 0 0 0 + 17 21 1 1 0 0 0 + 19 22 1 4 0 0 0 + 20 23 1 6 0 0 0 + 7 9 1 0 0 0 0 + 20 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00253.mol b/src/analysis/thermo/trainingModel/data/mol/C00253.mol new file mode 100644 index 0000000000..5988db6aae --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00253.mol @@ -0,0 +1,24 @@ +C00253 + Mrv1652304062119442D + + 9 9 0 0 0 0 999 V2000 + 14.7821 -9.9969 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0565 -9.5863 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7890 -10.7842 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4872 -9.5828 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3411 -10.0038 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0565 -11.2395 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1957 -9.9867 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.4735 -8.7648 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3446 -10.8288 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 2 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00256.mol b/src/analysis/thermo/trainingModel/data/mol/C00256.mol new file mode 100644 index 0000000000..7fc78e3d40 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00256.mol @@ -0,0 +1,17 @@ +C00256 + Mrv1652304062119442D + + 6 5 0 0 1 0 999 V2000 + 14.8028 -13.8640 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0883 -13.4552 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8028 -14.6920 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5174 -13.4552 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0883 -12.6273 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3737 -13.8675 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 +M CHG 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00257.mol b/src/analysis/thermo/trainingModel/data/mol/C00257.mol new file mode 100644 index 0000000000..36534bf918 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00257.mol @@ -0,0 +1,31 @@ +C00257 + Mrv1652304062119442D + + 13 12 0 0 1 0 999 V2000 + 12.7421 -12.3338 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4566 -11.9213 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1710 -12.3338 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.8855 -11.9213 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.5999 -12.3338 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.3144 -11.9213 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.0289 -12.3338 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7433 -11.9213 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.1710 -13.1587 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8855 -11.0963 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3144 -11.0965 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5999 -13.1588 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0288 -13.1472 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 3 9 1 6 0 0 0 + 4 10 1 1 0 0 0 + 6 11 1 1 0 0 0 + 5 12 1 1 0 0 0 + 7 13 2 0 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00258.mol b/src/analysis/thermo/trainingModel/data/mol/C00258.mol new file mode 100644 index 0000000000..78bf85a5ae --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00258.mol @@ -0,0 +1,19 @@ +C00258 + Mrv1652304062119442D + + 7 6 0 0 1 0 999 V2000 + 14.4657 -13.8779 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.7484 -13.4674 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1796 -13.4674 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4657 -14.7056 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0344 -13.8779 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7484 -12.6397 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8936 -13.8779 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00259.mol b/src/analysis/thermo/trainingModel/data/mol/C00259.mol new file mode 100644 index 0000000000..0e06a49475 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00259.mol @@ -0,0 +1,25 @@ +C00259 + Mrv1652304062119442D + + 10 10 0 0 1 0 999 V2000 + 15.1159 -9.7313 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.8319 -9.3215 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3998 -9.3215 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.1159 -10.5574 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8319 -8.4988 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 16.5481 -9.7313 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3998 -8.4988 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6872 -9.7313 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1159 -8.0857 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5481 -8.0857 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 1 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 4 0 0 0 + 7 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00261.mol b/src/analysis/thermo/trainingModel/data/mol/C00261.mol new file mode 100644 index 0000000000..ee316ce46c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00261.mol @@ -0,0 +1,21 @@ +C00261 + Mrv1652304062119442D + + 8 8 0 0 0 0 999 V2000 + 16.4554 -11.2877 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7487 -11.6937 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1736 -11.6937 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4517 -10.4680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7487 -12.5208 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1736 -12.5208 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1585 -10.0583 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4554 -12.9419 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 2 0 0 0 0 + 5 8 2 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00262.mol b/src/analysis/thermo/trainingModel/data/mol/C00262.mol new file mode 100644 index 0000000000..eaf20255a2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00262.mol @@ -0,0 +1,26 @@ +C00262 + Mrv1652304062119442D + + 10 11 0 0 0 0 999 V2000 + 14.8500 -10.5079 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8500 -11.3329 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5448 -10.1171 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5448 -11.7671 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2395 -10.5079 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5448 -9.2921 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2395 -11.3329 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0654 -10.2530 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5805 -10.9204 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0654 -11.5879 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 2 0 0 0 0 + 5 7 1 0 0 0 0 + 1 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 9 10 1 0 0 0 0 + 2 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00263.mol b/src/analysis/thermo/trainingModel/data/mol/C00263.mol new file mode 100644 index 0000000000..0209b9c323 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00263.mol @@ -0,0 +1,21 @@ +C00263 + Mrv1652304062119442D + + 8 7 0 0 1 0 999 V2000 + 14.7511 -9.5269 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4657 -9.1146 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0365 -9.1146 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7511 -10.3514 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.1803 -9.5269 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3219 -9.5269 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0365 -8.2901 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8948 -9.1146 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 +M CHG 2 4 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00266.mol b/src/analysis/thermo/trainingModel/data/mol/C00266.mol new file mode 100644 index 0000000000..583e649aaa --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00266.mol @@ -0,0 +1,12 @@ +C00266 + Mrv1652304062119442D + + 4 3 0 0 0 0 999 V2000 + 12.6899 -9.3323 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4035 -9.7462 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9760 -9.7462 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1174 -9.3285 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00270.mol b/src/analysis/thermo/trainingModel/data/mol/C00270.mol new file mode 100644 index 0000000000..2ea2ac02e3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00270.mol @@ -0,0 +1,48 @@ +C00270 + Mrv1652304062119442D + + 21 21 0 0 1 0 999 V2000 + 14.2278 -12.5962 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.2278 -13.4212 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9432 -12.1889 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5123 -12.1889 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9432 -13.8353 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.5123 -13.8353 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6517 -12.5962 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 13.5157 -11.3638 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.8002 -12.5962 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6517 -13.4212 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9432 -14.6568 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5157 -14.6533 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2337 -12.0109 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4424 -12.8084 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8002 -10.9497 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2278 -10.9497 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8071 -15.0641 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2242 -15.0608 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0312 -12.2196 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.0111 -11.2167 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8002 -10.1281 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 1 6 0 0 0 + 6 12 1 0 0 0 0 + 7 13 1 0 0 0 0 + 7 14 1 4 0 0 0 + 8 15 1 0 0 0 0 + 8 16 1 1 0 0 0 + 12 17 1 0 0 0 0 + 12 18 2 0 0 0 0 + 13 19 1 0 0 0 0 + 13 20 2 0 0 0 0 + 15 21 1 0 0 0 0 + 7 10 1 0 0 0 0 +M CHG 1 19 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00273.mol b/src/analysis/thermo/trainingModel/data/mol/C00273.mol new file mode 100644 index 0000000000..3a66388def --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00273.mol @@ -0,0 +1,28 @@ +C00273 + Mrv1652304062119442D + + 12 11 0 0 1 0 999 V2000 + 12.9264 -9.8710 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2153 -9.4527 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5042 -9.8710 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.7932 -9.4527 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.0403 -9.8710 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3292 -9.4527 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6181 -9.8710 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0403 -10.7075 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7514 -8.6162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5042 -10.7075 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2153 -8.6162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6793 -9.4527 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 6 7 1 0 0 0 0 + 3 4 1 0 0 0 0 + 5 8 2 0 0 0 0 + 4 9 1 1 0 0 0 + 4 5 1 0 0 0 0 + 3 10 1 1 0 0 0 + 3 2 1 0 0 0 0 + 2 11 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00275.mol b/src/analysis/thermo/trainingModel/data/mol/C00275.mol new file mode 100644 index 0000000000..fd40b494ce --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00275.mol @@ -0,0 +1,38 @@ +C00275 + Mrv1652304062119442D + + 16 16 0 0 1 0 999 V2000 + 14.3089 -12.0686 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1352 -12.0723 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4827 -12.0686 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3089 -11.2049 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3015 -12.8948 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7681 -11.5417 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4731 -11.9511 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.4731 -12.7736 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.1894 -11.5417 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1894 -13.1905 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7681 -13.1905 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9095 -11.9511 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 17.9095 -12.7736 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.1894 -14.0129 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6221 -11.5417 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6221 -13.1905 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 1 0 0 0 + 8 7 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 1 6 0 0 0 + 9 12 1 0 0 0 0 + 10 13 1 0 0 0 0 + 10 14 1 1 0 0 0 + 12 15 1 4 0 0 0 + 13 16 1 1 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00279.mol b/src/analysis/thermo/trainingModel/data/mol/C00279.mol new file mode 100644 index 0000000000..02179cedfb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00279.mol @@ -0,0 +1,29 @@ +C00279 + Mrv1652304062119442D + + 12 11 0 0 1 0 999 V2000 + 9.5290 -11.2202 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2434 -10.8077 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.9580 -11.2202 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.6724 -10.8077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3869 -11.2202 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2434 -9.9828 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5290 -12.0453 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9580 -12.0451 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2119 -11.2202 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0369 -11.2202 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.2119 -10.3952 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2119 -12.0453 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 1 7 2 0 0 0 0 + 3 8 1 1 0 0 0 + 5 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 2 0 0 0 0 + 9 12 1 0 0 0 0 +M CHG 2 10 -1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00280.mol b/src/analysis/thermo/trainingModel/data/mol/C00280.mol new file mode 100644 index 0000000000..51b6d2dfdf --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00280.mol @@ -0,0 +1,50 @@ +C00280 + Mrv1652304062119442D + + 21 24 0 0 1 0 999 V2000 + 11.9233 -9.2137 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9233 -10.0387 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6378 -10.4512 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3523 -10.0387 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3523 -9.2137 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.6378 -8.8012 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0668 -10.4512 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7813 -10.0387 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7813 -9.2137 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.0668 -8.8012 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4958 -8.8012 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4958 -7.9761 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7813 -7.5636 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0668 -7.9761 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9248 -8.8012 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9248 -7.9761 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2103 -7.5636 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2089 -10.4512 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2103 -6.7386 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3523 -8.3887 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4958 -7.1511 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 5 4 1 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 9 8 1 6 0 0 0 + 9 10 1 0 0 0 0 + 10 5 1 0 0 0 0 + 9 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 10 14 1 1 0 0 0 + 11 15 1 1 0 0 0 + 15 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 12 17 1 0 0 0 0 + 2 18 2 0 0 0 0 + 17 19 2 0 0 0 0 + 5 20 1 1 0 0 0 + 12 21 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00282.mol b/src/analysis/thermo/trainingModel/data/mol/C00282.mol new file mode 100644 index 0000000000..c7b0cb50de --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00282.mol @@ -0,0 +1,8 @@ +C00282 + + + 2 1 0 0 0 0 0 0 0 0999 V2000 + 19.8100 -19.5300 0.0000 H 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2100 -19.5300 0.0000 H 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C00283.mol b/src/analysis/thermo/trainingModel/data/mol/C00283.mol new file mode 100644 index 0000000000..2698042c5b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00283.mol @@ -0,0 +1,7 @@ +C00283 + Mrv1652304062119442D + + 1 0 0 0 0 0 999 V2000 + 11.0762 -8.0969 0.0000 S 0 5 0 0 0 0 0 0 0 0 0 0 +M CHG 1 1 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00288.mol b/src/analysis/thermo/trainingModel/data/mol/C00288.mol new file mode 100644 index 0000000000..5b19e2e0eb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00288.mol @@ -0,0 +1,13 @@ +C00288 + Mrv1652304062119442D + + 4 3 0 0 0 0 999 V2000 + 13.2490 -9.5627 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7080 -8.8875 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7424 -10.3197 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.4241 -9.5551 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 +M CHG 1 3 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00294.mol b/src/analysis/thermo/trainingModel/data/mol/C00294.mol new file mode 100644 index 0000000000..c0732ffba8 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00294.mol @@ -0,0 +1,45 @@ +C00294 + Mrv1652304062119442D + + 19 21 0 0 1 0 999 V2000 + 15.4278 -10.1477 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1703 -9.9414 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5203 -10.5190 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.9328 -9.5289 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1703 -9.1164 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9129 -10.3539 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8190 -9.9827 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2315 -11.2615 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4278 -8.8690 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9129 -8.7039 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6141 -9.9414 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1590 -10.5190 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.4065 -11.2615 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.7266 -11.9215 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6141 -9.1164 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9129 -7.9202 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4165 -10.2715 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9527 -11.9215 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7565 -10.8077 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 2 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 1 0 0 0 0 + 13 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00295.mol b/src/analysis/thermo/trainingModel/data/mol/C00295.mol new file mode 100644 index 0000000000..5b3ae00ef9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00295.mol @@ -0,0 +1,28 @@ +C00295 + Mrv1652304062119442D + + 11 11 0 0 0 0 999 V2000 + 14.7909 -9.8338 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0762 -10.2460 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5093 -10.2460 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7871 -9.0133 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0762 -11.0778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5093 -11.0778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4979 -8.6012 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0724 -8.6049 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7909 -11.4975 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3615 -11.4861 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2239 -11.4861 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 2 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00296.mol b/src/analysis/thermo/trainingModel/data/mol/C00296.mol new file mode 100644 index 0000000000..9d8c387a94 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00296.mol @@ -0,0 +1,32 @@ +C00296 + Mrv1652304062119442D + + 13 13 0 0 1 0 999 V2000 + 13.0716 -9.0224 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.4779 -8.3086 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7854 -9.4363 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3579 -9.4363 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5264 -8.3498 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3018 -8.3086 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.0602 -7.5911 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7854 -10.2600 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.3579 -10.2600 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.0716 -10.6740 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.5366 -10.7152 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6402 -10.6702 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0640 -11.5428 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 6 0 0 0 + 2 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 8 3 1 0 0 0 0 + 9 4 1 0 0 0 0 + 10 8 1 0 0 0 0 + 8 11 1 1 0 0 0 + 9 12 1 6 0 0 0 + 10 13 1 6 0 0 0 + 10 9 1 0 0 0 0 +M CHG 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00299.mol b/src/analysis/thermo/trainingModel/data/mol/C00299.mol new file mode 100644 index 0000000000..0daf48da2f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00299.mol @@ -0,0 +1,40 @@ +C00299 + Mrv1652304062119442D + + 17 18 0 0 1 0 999 V2000 + 13.8818 -9.9140 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7944 -9.6280 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2402 -9.4405 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6383 -10.7203 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.5105 -10.0402 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7994 -8.8070 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5677 -9.9312 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.8148 -10.7203 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.1220 -11.3825 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2311 -9.6281 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5163 -10.8624 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5085 -8.3901 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7854 -9.6772 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3275 -11.3791 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2280 -8.8017 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1232 -10.1679 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9459 -8.3936 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00300.mol b/src/analysis/thermo/trainingModel/data/mol/C00300.mol new file mode 100644 index 0000000000..bbe817c70e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00300.mol @@ -0,0 +1,23 @@ +C00300 + Mrv1652304062119442D + + 9 8 0 0 0 0 999 V2000 + 10.6970 -8.9100 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4115 -9.3225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1259 -8.9100 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8404 -9.3225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5549 -8.9100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2693 -9.3225 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.5549 -8.0852 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4115 -10.1474 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.1259 -8.0850 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 2 0 0 0 0 + 2 8 2 0 0 0 0 + 3 9 1 0 0 0 0 +M CHG 2 6 -1 8 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00305.mol b/src/analysis/thermo/trainingModel/data/mol/C00305.mol new file mode 100644 index 0000000000..cf54ebef6f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00305.mol @@ -0,0 +1,7 @@ +C00305 + Mrv1652304062119442D + + 1 0 0 0 0 0 999 V2000 + 25.6900 -19.0400 0.0000 Mg 0 2 0 0 0 0 0 0 0 0 0 0 +M CHG 1 1 2 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00307.mol b/src/analysis/thermo/trainingModel/data/mol/C00307.mol new file mode 100644 index 0000000000..01c5d3896a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00307.mol @@ -0,0 +1,69 @@ +C00307 + Mrv1652304062119442D + + 31 32 0 0 1 0 999 V2000 + 8.8275 -13.1588 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.6525 -13.1588 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.9074 -12.3741 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.2400 -11.8892 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5726 -12.3741 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.6219 -11.1366 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8581 -11.9616 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.1436 -12.3741 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3426 -13.8262 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1374 -13.8262 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3364 -10.7241 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3364 -9.8991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6219 -9.4866 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9075 -9.8991 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9075 -10.7241 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1870 -11.1401 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6219 -8.6627 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3186 -12.3741 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 5.4936 -12.3741 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.6686 -12.3741 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 3.8436 -12.3741 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3186 -11.5501 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3186 -13.1999 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 4.6686 -11.5501 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.6686 -13.1999 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 3.1292 -11.9616 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 2.4147 -12.3741 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1.7150 -11.9700 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1.0107 -11.5630 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1.3102 -12.6712 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 2.1351 -11.2424 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 5 4 1 0 0 0 0 + 1 5 1 0 0 0 0 + 3 6 1 1 0 0 0 + 5 7 1 1 0 0 0 + 7 8 1 0 0 0 0 + 1 9 1 6 0 0 0 + 2 10 1 6 0 0 0 + 6 11 1 0 0 0 0 + 11 12 2 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 2 0 0 0 0 + 14 15 1 0 0 0 0 + 6 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 13 17 1 0 0 0 0 + 8 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 18 22 2 0 0 0 0 + 18 23 1 0 0 0 0 + 20 24 2 0 0 0 0 + 20 25 1 0 0 0 0 + 21 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 1 0 0 0 0 +M CHG 3 23 -1 25 -1 28 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00309.mol b/src/analysis/thermo/trainingModel/data/mol/C00309.mol new file mode 100644 index 0000000000..b2c9e742aa --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00309.mol @@ -0,0 +1,25 @@ +C00309 + Mrv1652304062119452D + + 10 10 0 0 1 0 999 V2000 + 14.1324 -9.5286 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 13.8890 -10.2965 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.4536 -9.0383 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7152 -8.9423 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8900 -9.8062 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0559 -10.2965 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3689 -10.9649 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7920 -9.5148 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4624 -9.2851 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5761 -10.9683 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 6 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 6 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00310.mol b/src/analysis/thermo/trainingModel/data/mol/C00310.mol new file mode 100644 index 0000000000..81185ed464 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00310.mol @@ -0,0 +1,25 @@ +C00310 + Mrv1652304062119452D + + 10 10 0 0 1 0 999 V2000 + 15.1633 -8.8730 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 14.9200 -9.6409 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.4845 -8.3828 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7461 -8.2867 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9210 -9.1507 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0868 -9.6409 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3999 -10.3094 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8229 -8.8592 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4935 -8.6330 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6069 -10.3127 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 1 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 6 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00311.mol b/src/analysis/thermo/trainingModel/data/mol/C00311.mol new file mode 100644 index 0000000000..d263d4c0bd --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00311.mol @@ -0,0 +1,31 @@ +C00311 + Mrv1652304062119452D + + 13 12 0 0 0 0 999 V2000 + 14.8175 -13.4408 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5282 -13.8540 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1026 -13.8540 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8175 -12.6176 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5282 -14.6805 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2463 -13.4408 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3886 -13.4408 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5315 -12.2078 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0992 -12.2078 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8175 -15.0905 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2463 -15.0905 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3919 -12.6176 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.6737 -13.8575 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 7 12 1 0 0 0 0 + 7 13 2 0 0 0 0 +M CHG 3 8 -1 10 -1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00312.mol b/src/analysis/thermo/trainingModel/data/mol/C00312.mol new file mode 100644 index 0000000000..597a4516e5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00312.mol @@ -0,0 +1,25 @@ +C00312 + Mrv1652304062119452D + + 10 10 0 0 1 0 999 V2000 + 15.1599 -8.8709 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 14.9165 -9.6388 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4812 -8.3807 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7427 -8.2847 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9176 -9.1486 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0835 -9.6388 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.3964 -10.3073 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8195 -8.8572 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4900 -8.6275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6036 -10.3107 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 6 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 1 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00313.mol b/src/analysis/thermo/trainingModel/data/mol/C00313.mol new file mode 100644 index 0000000000..f170171b1b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00313.mol @@ -0,0 +1,114 @@ +C00313 + Mrv1652304062119452D + + 53 55 0 0 1 0 999 V2000 + 6.8888 -12.4575 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6313 -12.0450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3325 -12.4575 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0338 -12.0450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7763 -12.4575 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4775 -12.0450 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1788 -12.4575 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9213 -12.0450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6225 -12.4575 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3238 -12.0450 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0663 -12.4575 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7675 -12.0450 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4688 -12.4575 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1700 -12.0450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9125 -12.4575 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6313 -11.2200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1788 -13.2825 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0663 -13.2825 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7675 -11.2200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4688 -11.6325 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4688 -13.2825 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7375 -12.4575 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5625 -12.4575 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7375 -13.2825 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9013 -9.5288 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7263 -9.5288 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9738 -8.7450 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3138 -8.2500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6538 -8.7450 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7575 -8.4975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4063 -10.1888 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2213 -10.1888 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0463 -10.1888 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0463 -9.3638 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.8713 -10.1888 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.0463 -11.0138 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2200 -7.6725 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2200 -8.4975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6638 -8.4975 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6638 -7.6725 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9213 -7.2600 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5188 -7.2600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7763 -7.6725 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7763 -8.4975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5188 -8.9100 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5188 -6.4350 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9125 -8.7450 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7375 -8.7450 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7375 -7.9200 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.5625 -8.7450 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7375 -10.6425 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.1875 -12.0450 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 6.8888 -13.2825 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 1 53 2 0 0 0 0 +M CHG 5 24 -1 34 -1 35 -1 49 -1 52 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00314.mol b/src/analysis/thermo/trainingModel/data/mol/C00314.mol new file mode 100644 index 0000000000..73c3afd72a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00314.mol @@ -0,0 +1,29 @@ +C00314 + Mrv1652304062119452D + + 12 12 0 0 0 0 999 V2000 + 14.5792 -10.6535 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3011 -11.0626 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8643 -11.0626 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5759 -9.8285 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3011 -11.8943 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0092 -10.6501 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8643 -11.8943 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1562 -10.6535 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2874 -9.4160 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5792 -12.3137 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7242 -11.0591 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1528 -12.3035 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 7 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00318.mol b/src/analysis/thermo/trainingModel/data/mol/C00318.mol new file mode 100644 index 0000000000..e2c7001a9a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00318.mol @@ -0,0 +1,27 @@ +C00318 + Mrv1652304062119452D + + 11 10 0 0 1 0 999 V2000 + 13.8299 -8.9707 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5186 -9.4310 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.0926 -9.3410 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.5498 -10.2582 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3078 -9.6906 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3624 -8.9672 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0926 -10.2409 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6736 -9.4172 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9156 -9.0468 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6701 -10.1924 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3210 -9.0157 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 6 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 + 2 11 1 0 0 0 0 +M CHG 2 2 1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00322.mol b/src/analysis/thermo/trainingModel/data/mol/C00322.mol new file mode 100644 index 0000000000..8df4cb3eb9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00322.mol @@ -0,0 +1,27 @@ +C00322 + Mrv1652304062119452D + + 11 10 0 0 0 0 999 V2000 + 13.4339 -9.3210 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1476 -9.7348 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7164 -9.7348 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8613 -9.3210 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1476 -10.5585 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0027 -9.3210 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5750 -9.7348 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.8574 -8.5761 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2853 -9.7348 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5716 -9.3172 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2891 -10.5585 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 6 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 2 0 0 0 0 +M CHG 2 7 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00327.mol b/src/analysis/thermo/trainingModel/data/mol/C00327.mol new file mode 100644 index 0000000000..8b0a1c6b19 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00327.mol @@ -0,0 +1,29 @@ +C00327 + Mrv1652304062119452D + + 12 11 0 0 1 0 999 V2000 + 14.3899 -9.1398 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0967 -9.5652 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6660 -9.5377 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.8207 -9.1672 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9627 -9.1123 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6523 -10.3612 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.5275 -9.5927 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2387 -9.5172 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.9764 -8.2855 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2480 -9.1912 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9548 -9.6166 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2618 -8.3644 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 1 6 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 2 0 0 0 0 + 7 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 +M CHG 2 6 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00331.mol b/src/analysis/thermo/trainingModel/data/mol/C00331.mol new file mode 100644 index 0000000000..a004085973 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00331.mol @@ -0,0 +1,37 @@ +C00331 + Mrv1652304062119452D + + 15 16 0 0 0 0 999 V2000 + 9.3638 -9.7763 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3638 -10.6013 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0782 -11.0138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7927 -10.6013 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7927 -9.7763 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0782 -9.3638 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5773 -10.8562 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0623 -10.1888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5773 -9.5213 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8314 -8.7395 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6442 -8.5667 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2115 -9.1969 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8973 -7.7888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7160 -7.6149 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.3555 -7.1866 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 5 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 2 0 0 0 0 + 11 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 2 0 0 0 0 +M CHG 1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00332.mol b/src/analysis/thermo/trainingModel/data/mol/C00332.mol new file mode 100644 index 0000000000..966c722fe4 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00332.mol @@ -0,0 +1,116 @@ +C00332 + Mrv1652304062119452D + + 54 56 0 0 1 0 999 V2000 + 17.5313 -22.0275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2738 -21.6150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9750 -22.0275 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6763 -21.6150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4188 -22.0275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1200 -21.6150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8213 -22.0275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5638 -21.6150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2650 -22.0275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9663 -21.6150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7088 -22.0275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.4100 -21.6150 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.1113 -22.0275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8125 -21.6150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.5550 -22.0275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2738 -20.7900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8213 -22.8525 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7088 -22.8525 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.4100 -20.7900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1113 -21.2025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1113 -22.8525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3800 -22.0275 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 29.2050 -22.0275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3800 -22.8525 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.5438 -19.0988 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 25.3688 -19.0988 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.6163 -18.3150 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.9563 -17.8200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.2963 -18.3150 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.4000 -18.0675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0488 -19.7588 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.8638 -19.7588 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.6888 -19.7588 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 26.6888 -18.9338 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.5138 -19.7588 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 26.6888 -20.5838 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8625 -17.2425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8625 -18.0675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3063 -18.0675 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3063 -17.2425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5638 -16.8300 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1613 -16.8300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4188 -17.2425 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4188 -18.0675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1613 -18.4800 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1613 -16.0050 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.5550 -18.3150 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3800 -18.3150 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3800 -17.4900 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 29.2050 -18.3150 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3800 -20.2125 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8237 -21.6033 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1025 -22.0039 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8372 -20.7901 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 52 54 2 0 0 0 0 +M CHG 4 24 -1 34 -1 35 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00333.mol b/src/analysis/thermo/trainingModel/data/mol/C00333.mol new file mode 100644 index 0000000000..488cd59173 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00333.mol @@ -0,0 +1,32 @@ +C00333 + Mrv1652304062119452D + + 13 13 0 0 1 0 999 V2000 + 14.7474 -10.8327 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7474 -11.6577 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4555 -10.4168 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0324 -10.4580 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4555 -12.0668 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0324 -12.0668 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1740 -10.8327 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 13.4034 -10.9943 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0255 -9.5987 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1740 -11.6577 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4555 -12.8918 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8855 -10.4168 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8855 -12.0668 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 5 11 1 1 0 0 0 + 7 12 1 4 0 0 0 + 10 13 1 6 0 0 0 + 10 7 1 0 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00334.mol b/src/analysis/thermo/trainingModel/data/mol/C00334.mol new file mode 100644 index 0000000000..eeaa6a6521 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00334.mol @@ -0,0 +1,19 @@ +C00334 + Mrv1652304062119452D + + 7 6 0 0 0 0 999 V2000 + 12.8786 -10.8387 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5923 -10.4249 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1648 -10.4249 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3060 -10.8424 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.5923 -9.6012 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4474 -10.8387 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7337 -10.4249 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 6 7 1 0 0 0 0 +M CHG 2 4 -1 7 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00337.mol b/src/analysis/thermo/trainingModel/data/mol/C00337.mol new file mode 100644 index 0000000000..2ac8439261 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00337.mol @@ -0,0 +1,28 @@ +C00337 + Mrv1652304062119452D + + 11 11 0 0 1 0 999 V2000 + 15.9045 -11.6828 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.2133 -11.2633 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9045 -12.4977 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6335 -11.2736 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4912 -11.6622 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1858 -12.9035 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3453 -11.6966 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.6472 -10.4551 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4774 -12.4806 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7793 -11.2426 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1754 -13.7357 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 2 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00342.mol b/src/analysis/thermo/trainingModel/data/mol/C00342.mol new file mode 100644 index 0000000000..3e1f654679 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00342.mol @@ -0,0 +1,52 @@ +C00342 + + + 24 23 0 0 1 0 0 0 0 0999 V2000 + 32.7753 -23.1496 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 33.9341 -23.8187 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 35.0931 -23.1496 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 36.2519 -23.8187 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.4107 -23.1496 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 38.5695 -23.8187 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 36.2519 -25.1568 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 35.0931 -21.8115 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.5695 -25.1568 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.7283 -25.8259 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 37.4107 -25.8259 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 40.8871 -25.1568 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.8871 -23.8187 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 42.0460 -25.8259 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 39.7283 -23.1496 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 42.0460 -23.1496 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 39.7283 -21.8115 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.8871 -21.1425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 42.0460 -21.8115 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 40.8871 -19.8044 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 39.8620 -24.1650 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 38.5326 -21.1212 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.5326 -19.7405 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 36.0693 -20.8352 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 2 3 1 0 0 0 + 3 4 1 0 0 0 + 4 5 1 0 0 0 + 5 6 1 0 0 0 + 4 7 2 0 0 0 + 3 8 1 1 0 0 + 6 9 1 0 0 0 + 9 10 1 0 0 0 + 9 11 2 0 0 0 + 10 12 1 0 0 0 + 12 13 1 0 0 0 + 12 14 1 6 0 0 + 13 15 1 0 0 0 + 13 16 2 0 0 0 + 15 17 1 0 0 0 + 17 18 1 0 0 0 + 18 19 2 0 0 0 + 18 20 1 0 0 0 + 6 21 1 1 0 0 + 17 22 1 1 0 0 + 22 23 1 0 0 0 + 8 24 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C00343.mol b/src/analysis/thermo/trainingModel/data/mol/C00343.mol new file mode 100644 index 0000000000..d56d8eb3db --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00343.mol @@ -0,0 +1,53 @@ +C00343 + + + 24 24 0 0 1 0 0 0 0 0999 V2000 + 32.6652 -23.1180 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 33.8402 -23.7964 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 35.0153 -23.1180 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 36.1903 -23.7964 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.3653 -23.1180 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 38.5403 -23.7964 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 36.1903 -25.1532 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 35.0153 -21.7612 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.5403 -25.1532 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.7153 -25.8316 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 37.3653 -25.8316 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 40.8903 -25.1532 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.8903 -23.7964 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 42.0654 -25.8316 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 39.7153 -23.1180 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 42.0654 -23.1180 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 39.7153 -21.7612 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.8903 -21.0828 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 42.0654 -21.7612 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 40.8903 -19.7260 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 39.8509 -24.1475 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 38.5029 -21.0612 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.5029 -19.6612 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 36.0052 -20.7712 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 2 3 1 0 0 0 + 3 4 1 0 0 0 + 4 5 1 0 0 0 + 5 6 1 0 0 0 + 4 7 2 0 0 0 + 3 8 1 1 0 0 + 6 9 1 0 0 0 + 9 10 1 0 0 0 + 9 11 2 0 0 0 + 10 12 1 0 0 0 + 12 13 1 0 0 0 + 12 14 1 6 0 0 + 13 15 1 0 0 0 + 13 16 2 0 0 0 + 15 17 1 0 0 0 + 17 18 1 0 0 0 + 18 19 2 0 0 0 + 18 20 1 0 0 0 + 6 21 1 1 0 0 + 17 22 1 1 0 0 + 22 23 1 0 0 0 + 8 24 1 0 0 0 + 24 23 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C00345.mol b/src/analysis/thermo/trainingModel/data/mol/C00345.mol new file mode 100644 index 0000000000..e6119f29a7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00345.mol @@ -0,0 +1,39 @@ +C00345 + Mrv1652304062119452D + + 17 16 0 0 1 0 999 V2000 + 16.0891 -10.3124 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7903 -9.8998 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.5328 -10.3124 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.2341 -9.8998 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.9353 -10.3124 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.6778 -9.8998 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3790 -10.3124 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.6880 -9.0749 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9252 -11.1373 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2341 -9.0748 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5430 -11.1373 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3712 -9.9057 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5462 -9.9057 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7212 -9.9057 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5461 -9.0750 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5463 -10.7246 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.7801 -9.0749 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 + 5 9 1 6 0 0 0 + 4 10 1 6 0 0 0 + 3 11 1 6 0 0 0 + 1 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 2 0 0 0 0 + 13 16 1 0 0 0 0 + 2 17 1 1 0 0 0 +M CHG 3 7 -1 14 -1 16 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00346.mol b/src/analysis/thermo/trainingModel/data/mol/C00346.mol new file mode 100644 index 0000000000..9d9a509eee --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00346.mol @@ -0,0 +1,21 @@ +C00346 + Mrv1652304062119452D + + 8 7 0 0 0 0 999 V2000 + 13.3101 -9.5122 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1338 -9.5496 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5926 -9.9673 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9575 -9.5496 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.1713 -8.6846 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.1713 -10.4185 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8789 -9.5534 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1652 -9.9673 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 7 8 1 0 0 0 0 +M CHG 3 4 -1 5 -1 8 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00349.mol b/src/analysis/thermo/trainingModel/data/mol/C00349.mol new file mode 100644 index 0000000000..237f1ba7c5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00349.mol @@ -0,0 +1,19 @@ +C00349 + Mrv1652304062119452D + + 7 6 0 0 0 0 999 V2000 + 13.0754 -9.7635 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3617 -9.3497 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7891 -9.3497 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0754 -10.5872 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6442 -9.7635 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.3617 -8.5221 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5066 -9.7635 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 2 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00352.mol b/src/analysis/thermo/trainingModel/data/mol/C00352.mol new file mode 100644 index 0000000000..6a478db6b1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00352.mol @@ -0,0 +1,38 @@ +C00352 + Mrv1652304062119452D + + 16 16 0 0 1 0 999 V2000 + 15.4158 -11.3864 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2337 -11.3864 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6017 -11.3864 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.4158 -10.5276 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.4158 -12.2415 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9391 -10.9776 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6481 -11.3864 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.6481 -12.2118 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.3535 -10.9776 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3535 -12.6282 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.9391 -12.6170 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0700 -11.3864 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 19.0700 -12.2118 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.3535 -13.4870 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7754 -10.9776 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7754 -12.6170 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 1 0 0 0 + 8 7 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 1 6 0 0 0 + 9 12 1 0 0 0 0 + 10 13 1 0 0 0 0 + 10 14 1 1 0 0 0 + 12 15 1 4 0 0 0 + 13 16 1 6 0 0 0 + 13 12 1 0 0 0 0 +M CHG 3 3 -1 4 -1 16 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00354.mol b/src/analysis/thermo/trainingModel/data/mol/C00354.mol new file mode 100644 index 0000000000..2d192ae016 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00354.mol @@ -0,0 +1,46 @@ +C00354 + Mrv1652304062119452D + + 20 20 0 0 1 0 999 V2000 + 16.4526 -9.8167 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2776 -9.8167 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.5325 -9.0321 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8651 -8.5471 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1977 -9.0321 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.9676 -10.4841 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7626 -10.4841 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4201 -8.7794 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3575 -9.0321 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5325 -8.2071 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8047 -9.3334 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7678 -8.3215 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5876 -8.3215 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9797 -9.3334 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1547 -9.3334 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9797 -8.4967 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9796 -10.1467 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 20.4126 -8.3215 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5876 -9.1567 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.5876 -7.5067 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 5 4 1 0 0 0 0 + 1 5 1 0 0 0 0 + 1 6 1 6 0 0 0 + 2 7 1 1 0 0 0 + 5 8 1 1 0 0 0 + 3 9 1 0 0 0 0 + 3 10 1 0 0 0 0 + 8 11 1 0 0 0 0 + 9 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 11 14 1 0 0 0 0 + 14 15 2 0 0 0 0 + 14 16 1 0 0 0 0 + 14 17 1 0 0 0 0 + 13 18 2 0 0 0 0 + 13 19 1 0 0 0 0 + 13 20 1 0 0 0 0 +M CHG 4 16 -1 17 -1 19 -1 20 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00357.mol b/src/analysis/thermo/trainingModel/data/mol/C00357.mol new file mode 100644 index 0000000000..6e4cc9acce --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00357.mol @@ -0,0 +1,44 @@ +C00357 + Mrv1652304062119452D + + 19 19 0 0 1 0 999 V2000 + 17.9757 -11.4735 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.2571 -11.8861 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.9757 -10.6483 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 18.6908 -11.8861 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5487 -11.4735 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2571 -12.7044 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2571 -10.2357 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6908 -10.2357 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5487 -10.6483 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.8405 -11.8861 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8405 -10.2357 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2079 -10.7652 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3826 -10.7618 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5609 -10.7618 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3861 -9.9434 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3999 -11.6110 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4228 -11.4562 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1366 -11.8683 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4197 -10.7145 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 4 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 9 11 1 1 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 13 16 2 0 0 0 0 + 9 7 1 0 0 0 0 + 4 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 17 19 2 0 0 0 0 +M CHG 2 14 -1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00360.mol b/src/analysis/thermo/trainingModel/data/mol/C00360.mol new file mode 100644 index 0000000000..8e797a0966 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00360.mol @@ -0,0 +1,52 @@ +C00360 + Mrv1652304062119452D + + 22 24 0 0 1 0 999 V2000 + 18.8695 -14.1502 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5038 -14.5893 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0995 -14.3976 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.1554 -13.3174 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2391 -14.0491 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5840 -15.4360 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4234 -13.8923 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8451 -15.1434 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0161 -13.3243 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9883 -14.3802 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3750 -15.7880 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7648 -14.3628 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.0227 -15.1434 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 21.0859 -15.2653 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6469 -13.8888 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9773 -14.1083 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7543 -15.9309 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3570 -14.6660 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5241 -14.6660 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5206 -15.5022 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.6913 -14.6660 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5206 -13.8331 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 13 8 1 0 0 0 0 + 10 14 1 0 0 0 0 + 10 15 1 0 0 0 0 + 12 16 1 1 0 0 0 + 13 17 1 6 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 19 22 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 14 2 0 0 0 0 + 12 13 1 0 0 0 0 +M CHG 2 20 -1 21 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00361.mol b/src/analysis/thermo/trainingModel/data/mol/C00361.mol new file mode 100644 index 0000000000..b0f4005650 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00361.mol @@ -0,0 +1,62 @@ +C00361 + Mrv1652304062119452D + + 27 29 0 0 1 0 999 V2000 + 18.4050 -11.4515 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7771 -11.0109 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1370 -10.9103 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4848 -12.2980 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0104 -11.2606 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.0545 -10.1817 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9150 -10.1886 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8794 -11.2433 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2723 -12.6414 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3339 -10.7542 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7536 -12.0065 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9765 -12.1244 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5386 -10.7507 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3625 -13.4636 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6782 -11.2259 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.9348 -12.0065 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.8941 -10.9692 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6677 -12.7871 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2731 -11.5243 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4440 -11.5243 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6148 -11.5243 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4405 -12.3534 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.4405 -10.6917 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7857 -11.5174 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7787 -12.3500 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.9530 -11.5174 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7787 -10.6883 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 5 2 1 1 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 5 11 1 0 0 0 0 + 8 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 9 14 1 0 0 0 0 + 15 10 1 0 0 0 0 + 16 11 1 0 0 0 0 + 15 17 1 1 0 0 0 + 16 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 6 7 2 0 0 0 0 + 9 12 1 0 0 0 0 + 15 16 1 0 0 0 0 +M CHG 2 22 -1 25 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00362.mol b/src/analysis/thermo/trainingModel/data/mol/C00362.mol new file mode 100644 index 0000000000..6c87ac357a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00362.mol @@ -0,0 +1,54 @@ +C00362 + Mrv1652304062119452D + + 23 25 0 0 1 0 999 V2000 + 17.5996 -11.4764 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9701 -11.0313 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3405 -10.9304 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6832 -12.3218 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2049 -11.2852 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.2553 -10.1999 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1179 -10.2069 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0849 -11.2643 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4692 -12.6660 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5265 -10.7739 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9439 -12.0295 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1823 -12.1478 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7424 -10.7703 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5596 -13.4904 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8727 -11.2504 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1230 -12.0295 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0831 -10.9896 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8622 -12.8122 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4639 -11.5460 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6361 -11.5460 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6326 -12.3739 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.8082 -11.5460 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.6326 -10.7182 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 5 2 1 1 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 5 11 1 0 0 0 0 + 8 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 9 14 1 0 0 0 0 + 15 10 1 0 0 0 0 + 16 11 1 0 0 0 0 + 15 17 1 1 0 0 0 + 16 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 6 7 2 0 0 0 0 + 9 12 1 0 0 0 0 + 15 16 1 0 0 0 0 +M CHG 2 21 -1 22 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00363.mol b/src/analysis/thermo/trainingModel/data/mol/C00363.mol new file mode 100644 index 0000000000..a59df3b198 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00363.mol @@ -0,0 +1,57 @@ +C00363 + Mrv1652304062119452D + + 25 26 0 0 1 0 999 V2000 + 17.0117 -12.0420 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.7988 -11.7807 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3689 -11.5676 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7677 -12.8464 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4175 -12.3308 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9707 -10.9764 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6951 -12.0591 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.9426 -12.8464 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.2081 -12.0729 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2560 -13.1385 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7509 -10.7117 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9114 -11.8049 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4545 -13.5097 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3765 -11.2617 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9125 -9.9040 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2996 -12.3548 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1603 -11.0074 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4781 -12.3548 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6531 -12.3548 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4712 -13.1798 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.4712 -11.5333 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8315 -12.3513 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8281 -13.1763 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.0100 -12.3513 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8281 -11.5298 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 8 4 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 1 0 0 0 + 8 13 1 6 0 0 0 + 9 14 1 0 0 0 0 + 11 15 1 0 0 0 0 + 12 16 1 0 0 0 0 + 14 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 7 8 1 0 0 0 0 + 11 14 1 0 0 0 0 +M CHG 2 20 -1 23 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00364.mol b/src/analysis/thermo/trainingModel/data/mol/C00364.mol new file mode 100644 index 0000000000..c6f3ea17e8 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00364.mol @@ -0,0 +1,49 @@ +C00364 + Mrv1652304062119452D + + 21 22 0 0 1 0 999 V2000 + 16.1861 -12.0667 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.9733 -11.8055 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5434 -11.5924 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9421 -12.8745 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5920 -12.3554 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1451 -11.0012 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8697 -12.0873 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1172 -12.8745 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.3826 -12.0977 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4304 -13.1631 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9254 -10.7364 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0860 -11.8295 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6291 -13.5343 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5475 -11.2864 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0869 -9.9321 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4742 -12.3829 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3347 -11.0321 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6527 -12.3829 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6458 -13.2044 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.8278 -12.3829 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.6458 -11.5580 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 8 4 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 1 0 0 0 + 8 13 1 6 0 0 0 + 9 14 1 0 0 0 0 + 11 15 1 0 0 0 0 + 12 16 1 0 0 0 0 + 14 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 7 8 1 0 0 0 0 + 11 14 1 0 0 0 0 +M CHG 2 19 -1 20 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00366.mol b/src/analysis/thermo/trainingModel/data/mol/C00366.mol new file mode 100644 index 0000000000..9cba9d23cb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00366.mol @@ -0,0 +1,30 @@ +C00366 + Mrv1652304062119452D + + 12 13 0 0 0 0 999 V2000 + 14.2312 -9.4875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2312 -10.3125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9737 -9.0750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4887 -9.2400 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9737 -10.7250 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4887 -10.5600 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6750 -9.4875 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9737 -8.2500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9937 -9.9000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6750 -10.2712 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4175 -10.6837 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1687 -9.9000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 4 9 1 0 0 0 0 + 5 10 1 0 0 0 0 + 10 11 2 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 1 0 0 0 0 + 9 12 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00376.mol b/src/analysis/thermo/trainingModel/data/mol/C00376.mol new file mode 100644 index 0000000000..265fdf3e17 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00376.mol @@ -0,0 +1,47 @@ +C00376 + Mrv1652304062119452D + + 21 21 0 0 0 0 999 V2000 + 10.1708 -9.3203 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1708 -10.1529 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4519 -8.9079 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8821 -8.9041 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4519 -10.5728 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8860 -10.5615 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1708 -11.2060 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7367 -9.3203 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4480 -8.0829 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5973 -9.3166 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7367 -10.1529 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3087 -8.9004 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0239 -9.3127 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3087 -8.0792 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7352 -8.8965 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4504 -9.3051 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1580 -8.8852 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8732 -9.2939 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1769 -8.1289 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5770 -8.8360 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3111 -9.2105 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 3 9 1 0 0 0 0 + 4 10 2 0 0 0 0 + 5 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 12 13 2 0 0 0 0 + 12 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 2 0 0 0 0 + 17 19 1 0 0 0 0 + 18 20 1 4 0 0 0 + 20 21 2 0 0 0 0 + 8 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00379.mol b/src/analysis/thermo/trainingModel/data/mol/C00379.mol new file mode 100644 index 0000000000..f320d21015 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00379.mol @@ -0,0 +1,24 @@ +C00379 + Mrv1652304062119452D + + 10 9 0 0 1 0 999 V2000 + 10.2302 -11.1377 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9447 -10.7252 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6592 -11.1377 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.3737 -10.7252 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.0881 -11.1377 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.8027 -10.7252 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5171 -11.1377 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6592 -11.9626 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3737 -9.9002 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0881 -11.9627 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 3 8 1 1 0 0 0 + 4 9 1 1 0 0 0 + 5 10 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00385.mol b/src/analysis/thermo/trainingModel/data/mol/C00385.mol new file mode 100644 index 0000000000..df77252175 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00385.mol @@ -0,0 +1,28 @@ +C00385 + Mrv1652304062119452D + + 11 12 0 0 0 0 999 V2000 + 14.2312 -9.4875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2312 -10.3125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9737 -9.0750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4887 -9.2400 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9737 -10.7250 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4887 -10.5600 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6750 -9.4875 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9737 -8.2500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9937 -9.9000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6750 -10.2712 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4175 -10.6837 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 10 11 2 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00387.mol b/src/analysis/thermo/trainingModel/data/mol/C00387.mol new file mode 100644 index 0000000000..0475c1cff3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00387.mol @@ -0,0 +1,47 @@ +C00387 + Mrv1652304062119452D + + 20 22 0 0 1 0 999 V2000 + 16.8924 -11.5855 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2512 -11.1336 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6387 -11.0390 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9730 -12.4299 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4803 -11.3789 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.5421 -10.2927 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4145 -10.2927 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3955 -11.3649 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7684 -12.7838 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7937 -10.8743 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2176 -12.1321 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.4972 -12.2583 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0647 -10.8813 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8490 -13.6073 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1313 -11.3508 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3836 -12.1321 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7747 -12.7558 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3465 -11.0985 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9246 -12.8329 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7263 -11.6591 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 5 2 1 1 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 11 5 1 0 0 0 0 + 8 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 9 14 1 0 0 0 0 + 15 10 1 0 0 0 0 + 11 16 1 0 0 0 0 + 11 17 1 6 0 0 0 + 15 18 1 1 0 0 0 + 16 19 1 6 0 0 0 + 18 20 1 0 0 0 0 + 6 7 2 0 0 0 0 + 9 12 1 0 0 0 0 + 16 15 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00390.mol b/src/analysis/thermo/trainingModel/data/mol/C00390.mol new file mode 100644 index 0000000000..259ff9718a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00390.mol @@ -0,0 +1,58 @@ +C00390 + + + 23 23 0 0 0 0 0 0 0 0999 V2000 + 14.0000 -21.2800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0000 -22.6800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2124 -23.3800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4249 -22.6800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4249 -21.2800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2124 -20.5800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7876 -20.5800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5921 -21.2704 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7876 -23.3800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5921 -22.6896 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2124 -19.1802 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6560 -20.5690 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2124 -24.7798 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6624 -23.3800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8749 -22.6800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0873 -23.3800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2997 -22.6800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5122 -23.3800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.7246 -22.6800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9370 -23.3800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1495 -22.6800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0873 -24.7800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9370 -24.7799 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 + 2 3 1 0 0 0 + 3 4 2 0 0 0 + 4 5 1 0 0 0 + 5 6 2 0 0 0 + 1 6 1 0 0 0 + 1 7 1 0 0 0 + 7 8 1 0 0 0 + 2 9 1 0 0 0 + 9 10 1 0 0 0 + 6 11 1 0 0 0 + 5 12 1 0 0 0 + 3 13 1 0 0 0 + 4 14 1 0 0 0 + 14 15 1 0 0 0 + 15 16 2 0 0 0 + 16 17 1 0 0 0 + 17 18 1 0 0 0 + 18 19 1 0 0 0 + 19 20 2 0 0 0 + 20 21 1 0 0 0 + 16 22 1 0 0 0 + 20 23 1 0 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 5 14 15 16 17 22 +M SDI 1 4 17.2200 -23.8700 17.2200 -22.3300 +M SDI 1 4 21.4200 -22.4700 21.4200 -24.0100 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C00392.mol b/src/analysis/thermo/trainingModel/data/mol/C00392.mol new file mode 100644 index 0000000000..f9787d822c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00392.mol @@ -0,0 +1,28 @@ +C00392 + Mrv1652304062119452D + + 12 11 0 0 1 0 999 V2000 + 11.4265 -3.9188 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1410 -3.5063 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8555 -3.9188 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.5700 -3.5063 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.2844 -3.9188 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9989 -3.5063 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7134 -3.9188 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4279 -3.5063 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8555 -4.7437 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9989 -2.6815 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5700 -2.6813 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2844 -4.7438 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 3 9 1 6 0 0 0 + 6 10 1 6 0 0 0 + 4 11 1 1 0 0 0 + 5 12 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00394.mol b/src/analysis/thermo/trainingModel/data/mol/C00394.mol new file mode 100644 index 0000000000..36e3a3ab20 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00394.mol @@ -0,0 +1,87 @@ +C00394 + Mrv1652304062119452D + + 39 42 0 0 1 0 999 V2000 + 20.9882 -11.8568 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1973 -11.6070 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9807 -13.4954 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4726 -11.1945 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1973 -10.7745 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4745 -12.0271 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3032 -13.0033 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7346 -14.2712 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.9882 -10.5172 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4745 -10.3620 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7630 -11.6070 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6410 -13.4840 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.9059 -14.2712 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 21.2190 -14.9334 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7630 -10.7745 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4745 -9.6640 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0902 -11.9697 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8577 -13.2343 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4328 -14.9409 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1386 -13.6391 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3175 -13.6391 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4925 -13.6391 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3364 -14.4906 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.3213 -12.7757 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6714 -13.6391 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8501 -13.6430 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6902 -14.5284 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.6328 -12.7757 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1350 -14.0516 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.4159 -13.6430 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1350 -14.8766 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.7044 -14.0516 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.4159 -15.2891 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.8501 -15.2891 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7044 -14.8766 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.9968 -13.6430 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4159 -16.1103 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9968 -15.3737 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3687 -14.1727 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 2 0 0 0 0 + 11 17 1 0 0 0 0 + 12 18 1 1 0 0 0 + 13 19 1 6 0 0 0 + 18 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 22 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 25 27 1 0 0 0 0 + 25 28 2 0 0 0 0 + 29 26 1 6 0 0 0 + 29 30 1 0 0 0 0 + 31 29 1 0 0 0 0 + 32 30 1 0 0 0 0 + 31 33 1 0 0 0 0 + 31 34 1 6 0 0 0 + 35 32 1 0 0 0 0 + 32 36 1 1 0 0 0 + 33 37 1 1 0 0 0 + 35 38 1 6 0 0 0 + 36 39 1 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 1 0 0 0 0 + 13 12 1 0 0 0 0 + 33 35 1 0 0 0 0 +M CHG 2 23 -1 27 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00399.mol b/src/analysis/thermo/trainingModel/data/mol/C00399.mol new file mode 100644 index 0000000000..f0145d550b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00399.mol @@ -0,0 +1,58 @@ +C00399 + + + 23 23 0 0 0 0 0 0 0 0999 V2000 + 21.5600 -19.1800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.5600 -20.5800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7724 -21.2800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9849 -20.5800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9849 -19.1800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7724 -18.4800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7724 -17.0802 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7724 -22.6798 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3476 -18.4800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1521 -19.1704 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3476 -21.2800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1521 -20.5896 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.2160 -18.4690 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.2224 -21.2800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.4349 -20.5800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.6473 -21.2800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.8597 -20.5800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.0722 -21.2800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.2846 -20.5800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.4970 -21.2800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.7095 -20.5800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.6473 -22.6800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.4970 -22.6799 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 + 2 3 1 0 0 0 + 3 4 1 0 0 0 + 4 5 2 0 0 0 + 5 6 1 0 0 0 + 1 6 1 0 0 0 + 6 7 2 0 0 0 + 3 8 2 0 0 0 + 1 9 1 0 0 0 + 9 10 1 0 0 0 + 2 11 1 0 0 0 + 11 12 1 0 0 0 + 5 13 1 0 0 0 + 4 14 1 0 0 0 + 14 15 1 0 0 0 + 15 16 2 0 0 0 + 16 17 1 0 0 0 + 17 18 1 0 0 0 + 18 19 1 0 0 0 + 19 20 2 0 0 0 + 20 21 1 0 0 0 + 16 22 1 0 0 0 + 20 23 1 0 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 5 14 15 16 17 22 +M SDI 1 4 24.8500 -21.9100 24.8500 -20.3000 +M SDI 1 4 29.1200 -20.3700 29.1200 -21.9800 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C00407.mol b/src/analysis/thermo/trainingModel/data/mol/C00407.mol new file mode 100644 index 0000000000..022db39e8b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00407.mol @@ -0,0 +1,23 @@ +C00407 + Mrv1652304062119452D + + 9 8 0 0 1 0 999 V2000 + 13.2555 -10.1011 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9553 -9.6668 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.5282 -9.7116 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2831 -10.9250 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.6826 -10.0563 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9312 -8.8429 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8457 -10.1803 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.5420 -8.8877 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3858 -9.6220 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 5 9 1 0 0 0 0 +M CHG 2 4 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00408.mol b/src/analysis/thermo/trainingModel/data/mol/C00408.mol new file mode 100644 index 0000000000..fb6ad42a20 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00408.mol @@ -0,0 +1,24 @@ +C00408 + Mrv1652304062119452D + + 9 9 0 0 1 0 999 V2000 + 14.6850 -10.3538 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.6850 -11.1788 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9425 -9.9413 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.3863 -9.9413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9425 -11.5913 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2413 -10.3538 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3863 -9.0338 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.0463 -10.3125 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2413 -11.1788 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 2 3 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00414.mol b/src/analysis/thermo/trainingModel/data/mol/C00414.mol new file mode 100644 index 0000000000..542fb13208 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00414.mol @@ -0,0 +1,19 @@ +C00414 + Mrv1652304062119452D + + 7 7 0 0 0 0 999 V2000 + 15.5852 -11.2848 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8715 -11.6986 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2990 -11.6986 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5887 -10.4608 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8715 -12.5227 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2990 -12.5227 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5852 -12.9365 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00415.mol b/src/analysis/thermo/trainingModel/data/mol/C00415.mol new file mode 100644 index 0000000000..9a00bc7664 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00415.mol @@ -0,0 +1,72 @@ +C00415 + Mrv1652304062119452D + + 32 34 0 0 1 0 999 V2000 + 6.6912 -11.9055 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.6912 -11.1060 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.3143 -12.3346 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 5.9575 -12.3279 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.3662 -10.7219 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 5.9783 -10.6908 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0307 -11.9055 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.2653 -11.8952 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0307 -11.1060 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.2618 -11.0887 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 5.9887 -9.9254 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.5073 -12.3209 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7091 -10.7460 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3528 -11.0784 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1385 -10.7321 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1317 -9.9257 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8447 -11.1372 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8586 -9.5000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5645 -10.7114 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5577 -9.8945 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3227 -9.4446 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1187 -9.9223 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3158 -8.6970 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8767 -9.4446 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.6346 -9.8877 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8732 -8.5345 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3235 -9.3685 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1256 -8.1156 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.6139 -8.1088 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0503 -9.8703 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8291 -9.5000 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.0468 -10.7423 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 2 0 0 0 0 + 6 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 8 12 1 0 0 0 0 + 9 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 15 17 1 0 0 0 0 + 16 18 1 0 0 0 0 + 17 19 2 0 0 0 0 + 18 20 2 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 2 0 0 0 0 + 24 22 1 6 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 25 27 1 0 0 0 0 + 26 28 1 0 0 0 0 + 26 29 2 0 0 0 0 + 27 30 1 0 0 0 0 + 30 31 1 0 0 0 0 + 30 32 2 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 19 20 1 0 0 0 0 +M CHG 2 28 -1 31 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00417.mol b/src/analysis/thermo/trainingModel/data/mol/C00417.mol new file mode 100644 index 0000000000..aa4ab0d48b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00417.mol @@ -0,0 +1,29 @@ +C00417 + Mrv1652304062119452D + + 12 11 0 0 0 0 999 V2000 + 13.0361 -9.3761 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4499 -8.6586 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2123 -9.3761 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4499 -10.0899 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2737 -8.6586 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7984 -10.0899 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2411 -10.8834 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.2737 -10.0860 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6837 -9.4167 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.6470 -8.0260 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9709 -10.0860 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.0832 -10.8670 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 6 12 2 0 0 0 0 +M CHG 3 7 -1 9 -1 11 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00423.mol b/src/analysis/thermo/trainingModel/data/mol/C00423.mol new file mode 100644 index 0000000000..4c4e15f27a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00423.mol @@ -0,0 +1,28 @@ +C00423 + Mrv1652304062119452D + + 11 11 0 0 0 0 999 V2000 + 7.8789 -9.9827 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.5934 -9.5702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3079 -9.9827 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0224 -9.5702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7368 -9.9827 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5934 -8.7453 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7368 -10.8077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4514 -11.2202 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1658 -10.8077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1658 -9.9827 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4514 -9.5702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 4 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 5 7 2 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 2 0 0 0 0 + 5 11 1 0 0 0 0 +M CHG 1 1 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00424.mol b/src/analysis/thermo/trainingModel/data/mol/C00424.mol new file mode 100644 index 0000000000..4b5f108024 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00424.mol @@ -0,0 +1,14 @@ +C00424 + Mrv1652304062119452D + + 5 4 0 0 1 0 999 V2000 + 16.6575 -11.9959 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.3699 -11.5829 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9415 -11.5829 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6575 -12.9456 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0820 -11.9959 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00429.mol b/src/analysis/thermo/trainingModel/data/mol/C00429.mol new file mode 100644 index 0000000000..c1b1a550ed --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00429.mol @@ -0,0 +1,21 @@ +C00429 + Mrv1652304062119452D + + 8 8 0 0 0 0 999 V2000 + 14.2070 -9.8220 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9187 -9.4115 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2070 -10.6502 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6340 -9.8220 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9149 -8.6359 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9187 -11.0681 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4955 -11.0568 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6340 -10.6502 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00437.mol b/src/analysis/thermo/trainingModel/data/mol/C00437.mol new file mode 100644 index 0000000000..d15327dffe --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00437.mol @@ -0,0 +1,29 @@ +C00437 + Mrv1652304062119452D + + 12 11 0 0 1 0 999 V2000 + 16.7315 -14.6729 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.7353 -15.6219 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0178 -14.2590 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4490 -14.2590 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0178 -16.0356 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0255 -13.3783 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3041 -14.6766 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.1627 -14.6690 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0216 -16.9466 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3041 -15.6256 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8763 -14.2553 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5939 -14.6690 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 8 11 1 0 0 0 0 + 11 12 1 0 0 0 0 +M CHG 2 7 -1 12 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00438.mol b/src/analysis/thermo/trainingModel/data/mol/C00438.mol new file mode 100644 index 0000000000..b2ae5efd84 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00438.mol @@ -0,0 +1,29 @@ +C00438 + Mrv1652304062119452D + + 12 11 0 0 1 0 999 V2000 + 8.2089 -11.5915 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.9234 -11.1790 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6379 -11.5915 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.3524 -11.1790 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0669 -11.5915 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7814 -11.1790 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.0669 -12.4165 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6379 -12.4164 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9345 -12.8225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2356 -12.4190 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9344 -13.6539 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9234 -10.3541 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 2 0 0 0 0 + 3 8 1 6 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 2 0 0 0 0 + 2 12 2 0 0 0 0 +M CHG 2 1 -1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00439.mol b/src/analysis/thermo/trainingModel/data/mol/C00439.mol new file mode 100644 index 0000000000..67ff7ba498 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00439.mol @@ -0,0 +1,29 @@ +C00439 + Mrv1652304062119452D + + 12 11 0 0 1 0 999 V2000 + 12.1955 -11.2202 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.9099 -10.8077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6244 -11.2202 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3389 -10.8077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0534 -11.2202 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7679 -10.8077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4824 -11.2202 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.7679 -9.9828 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9099 -9.9827 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6244 -12.0452 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3302 -12.4527 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0304 -12.0484 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 + 2 9 2 0 0 0 0 + 3 10 1 6 0 0 0 + 10 11 1 0 0 0 0 + 11 12 2 0 0 0 0 +M CHG 3 1 -1 7 -1 12 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00440.mol b/src/analysis/thermo/trainingModel/data/mol/C00440.mol new file mode 100644 index 0000000000..5977227b43 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00440.mol @@ -0,0 +1,74 @@ +C00440 + Mrv1652304062119452D + + 33 35 0 0 1 0 999 V2000 + 5.6119 -10.3528 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 5.6119 -11.1778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3132 -11.5904 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0557 -11.1778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0557 -10.3528 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3132 -9.9403 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7570 -11.5904 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4582 -11.1778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4582 -10.3528 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 7.7570 -9.9403 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3132 -9.1153 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.8958 -11.5875 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1727 -9.9403 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8872 -10.3528 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6016 -9.9403 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3174 -10.3535 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0318 -9.9410 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0318 -9.1160 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3161 -8.7028 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6016 -9.1153 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7615 -8.7028 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4759 -9.1153 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7649 -7.8780 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2015 -8.6963 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9116 -9.1063 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6084 -8.7039 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3120 -9.1101 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0120 -8.7059 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.3121 -9.9402 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2013 -7.8779 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4798 -7.4615 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9087 -7.4692 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.7573 -9.1011 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 9 8 1 0 0 0 0 + 9 10 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 2 12 1 0 0 0 0 + 9 13 1 1 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 2 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 2 0 0 0 0 + 15 20 1 0 0 0 0 + 18 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 2 0 0 0 0 + 24 22 1 6 0 0 0 + 24 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 27 29 2 0 0 0 0 + 24 30 1 0 0 0 0 + 30 31 2 0 0 0 0 + 30 32 1 0 0 0 0 + 10 33 1 0 0 0 0 +M CHG 2 28 -1 32 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00441.mol b/src/analysis/thermo/trainingModel/data/mol/C00441.mol new file mode 100644 index 0000000000..6da7f9589f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00441.mol @@ -0,0 +1,21 @@ +C00441 + Mrv1652304062119452D + + 8 7 0 0 1 0 999 V2000 + 9.1985 -9.7347 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.9129 -9.3222 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6274 -9.7347 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.3419 -9.3222 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0563 -9.7347 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7708 -9.3222 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9129 -8.4974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6274 -10.5596 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 2 7 2 0 0 0 0 + 3 8 1 6 0 0 0 +M CHG 2 1 -1 8 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00445.mol b/src/analysis/thermo/trainingModel/data/mol/C00445.mol new file mode 100644 index 0000000000..255fd0ebf8 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00445.mol @@ -0,0 +1,75 @@ +C00445 + Mrv1652304062119462D + + 33 36 0 0 1 0 999 V2000 + 7.0950 -11.1375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0950 -11.9625 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8094 -12.3750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5240 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5240 -11.1375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8094 -10.7250 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2384 -12.3750 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9529 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9529 -11.1375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2384 -10.7250 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4099 -13.1820 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2304 -13.2682 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 10.5660 -12.5145 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3805 -10.7250 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8094 -13.1999 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6490 -13.9932 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2390 -14.7033 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6515 -15.4178 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4765 -15.4178 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8865 -14.7076 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4740 -13.9931 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8910 -16.1355 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7050 -16.1353 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4788 -16.8496 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1148 -16.8448 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9424 -16.8447 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7094 -17.5470 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8802 -17.5472 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1141 -18.2476 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.6569 -17.2425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3715 -16.8300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0859 -17.2425 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.3715 -16.0051 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 5 10 1 0 0 0 0 + 7 11 1 0 0 0 0 + 11 12 2 0 0 0 0 + 12 13 1 0 0 0 0 + 8 13 1 0 0 0 0 + 1 14 1 0 0 0 0 + 3 15 2 0 0 0 0 + 12 16 1 0 0 0 0 + 16 17 2 0 0 0 0 + 17 18 1 0 0 0 0 + 18 19 2 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 2 0 0 0 0 + 16 21 1 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 2 0 0 0 0 + 25 23 1 1 0 0 0 + 25 26 1 0 0 0 0 + 25 27 1 0 0 0 0 + 27 28 2 0 0 0 0 + 27 29 1 0 0 0 0 + 26 30 1 0 0 0 0 + 30 31 1 0 0 0 0 + 31 32 1 0 0 0 0 + 31 33 2 0 0 0 0 +M CHG 3 12 1 29 -1 32 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00449.mol b/src/analysis/thermo/trainingModel/data/mol/C00449.mol new file mode 100644 index 0000000000..a13fbd9bbd --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00449.mol @@ -0,0 +1,43 @@ +C00449 + Mrv1652304062119462D + + 19 18 0 0 1 0 999 V2000 + 9.1165 -12.2928 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.8309 -11.8803 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5454 -12.2928 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.2599 -11.8803 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9744 -12.2928 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6889 -11.8803 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4034 -12.2928 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.8309 -11.0554 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6889 -11.0554 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5454 -13.6127 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 11.2747 -14.0253 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9892 -13.6128 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7037 -14.0253 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4182 -13.6128 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1327 -14.0253 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.8471 -13.6128 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5616 -14.0253 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.1327 -14.8501 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.8471 -12.7878 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 2 0 0 0 0 + 6 9 2 0 0 0 0 + 3 10 1 6 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 15 14 1 0 0 0 0 + 15 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 15 18 1 1 0 0 0 + 16 19 2 0 0 0 0 +M CHG 5 1 -1 7 -1 10 1 17 -1 18 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00455.mol b/src/analysis/thermo/trainingModel/data/mol/C00455.mol new file mode 100644 index 0000000000..12c7962c16 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00455.mol @@ -0,0 +1,51 @@ +C00455 + Mrv1652304062119462D + + 22 23 0 0 1 0 999 V2000 + 14.0666 -11.0295 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.6351 -9.6798 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.3953 -10.5535 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8110 -11.8146 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3525 -9.2606 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9211 -9.2606 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7346 -11.0295 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.9798 -11.8146 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.2940 -12.4788 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3525 -8.4258 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9211 -8.4258 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9532 -10.7702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5002 -12.4788 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6351 -8.0138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0665 -8.0138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7898 -9.9675 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7805 -8.4223 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0630 -7.2359 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9621 -9.9675 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1380 -9.9675 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.9586 -10.7879 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9621 -9.1008 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 1 0 0 0 + 8 13 1 6 0 0 0 + 10 14 2 0 0 0 0 + 10 15 1 0 0 0 0 + 12 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 18 2 0 0 0 0 + 16 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 19 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 8 7 1 0 0 0 0 + 11 14 1 0 0 0 0 +M CHG 3 2 1 20 -1 22 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00459.mol b/src/analysis/thermo/trainingModel/data/mol/C00459.mol new file mode 100644 index 0000000000..964d4cd810 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00459.mol @@ -0,0 +1,65 @@ +C00459 + Mrv1652304062119462D + + 29 30 0 0 1 0 999 V2000 + 17.6976 -9.9805 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.4858 -9.7224 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0540 -9.5090 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4568 -10.7893 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1088 -10.2731 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6579 -8.9135 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3794 -10.0012 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.6272 -10.7893 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.8970 -10.0114 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9436 -11.0784 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4393 -8.6519 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5947 -9.7465 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1386 -11.4502 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0657 -9.2026 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6009 -7.8431 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9820 -10.2971 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.8504 -8.9444 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1594 -10.2971 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3369 -10.2971 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1561 -11.1197 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.1561 -9.4746 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5142 -10.2937 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6882 -10.2937 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5074 -11.1163 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.5074 -9.4710 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8656 -10.2902 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8623 -11.1129 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.0431 -10.2868 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8623 -9.4677 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 8 4 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 1 0 0 0 + 8 13 1 6 0 0 0 + 9 14 1 0 0 0 0 + 11 15 1 0 0 0 0 + 12 16 1 0 0 0 0 + 14 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 23 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 26 28 1 0 0 0 0 + 26 29 2 0 0 0 0 + 7 8 1 0 0 0 0 + 11 14 1 0 0 0 0 +M CHG 3 20 -1 24 -1 27 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00463.mol b/src/analysis/thermo/trainingModel/data/mol/C00463.mol new file mode 100644 index 0000000000..9bf9cdc33e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00463.mol @@ -0,0 +1,24 @@ +C00463 + Mrv1652304062119462D + + 9 10 0 0 0 0 999 V2000 + 18.4424 -12.2692 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4662 -13.0735 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1977 -11.9894 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7430 -11.8391 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2424 -13.3462 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7116 -13.4826 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7048 -12.6574 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0192 -12.2342 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0018 -13.0595 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 5 7 1 0 0 0 0 + 8 9 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00468.mol b/src/analysis/thermo/trainingModel/data/mol/C00468.mol new file mode 100644 index 0000000000..88d2f9ed42 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00468.mol @@ -0,0 +1,48 @@ +C00468 + Mrv1652304062119462D + + 20 23 0 0 1 0 999 V2000 + 14.5749 -10.4641 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.8614 -10.8840 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.5786 -9.6354 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.0094 -10.4715 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1441 -10.4715 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.8465 -11.7016 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8540 -9.2266 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2996 -9.2229 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5228 -8.7547 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0130 -9.6427 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4380 -10.8877 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1366 -9.6465 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1516 -12.1141 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2996 -8.4549 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4380 -11.7053 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7282 -10.4826 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7282 -12.1179 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0295 -10.8877 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0295 -11.7053 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3272 -12.1067 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 3 9 1 1 0 0 0 + 4 10 1 0 0 0 0 + 5 11 1 1 0 0 0 + 5 12 1 0 0 0 0 + 6 13 1 0 0 0 0 + 8 14 2 0 0 0 0 + 11 15 2 0 0 0 0 + 11 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 16 18 2 0 0 0 0 + 17 19 2 0 0 0 0 + 19 20 1 0 0 0 0 + 7 12 1 0 0 0 0 + 8 10 1 0 0 0 0 + 13 15 1 0 0 0 0 + 18 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00469.mol b/src/analysis/thermo/trainingModel/data/mol/C00469.mol new file mode 100644 index 0000000000..2bf0c7738a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00469.mol @@ -0,0 +1,10 @@ +C00469 + Mrv1652304062119462D + + 3 2 0 0 0 0 999 V2000 + 13.0347 -9.3339 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3210 -9.7477 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7484 -9.7477 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00473.mol b/src/analysis/thermo/trainingModel/data/mol/C00473.mol new file mode 100644 index 0000000000..1b89fa99d7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00473.mol @@ -0,0 +1,47 @@ +C00473 + Mrv1652304062119462D + + 21 21 0 0 0 0 999 V2000 + 10.3389 -10.9455 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3389 -11.7705 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0534 -12.1830 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7679 -11.7705 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7679 -10.9455 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0534 -10.5330 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4824 -12.1830 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1968 -10.9455 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4824 -10.5330 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9026 -10.5380 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6028 -10.9423 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7679 -10.1204 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3389 -10.1204 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3046 -10.5370 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9026 -9.7081 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0056 -10.9418 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7069 -10.5368 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4083 -10.9417 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1095 -10.5367 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8108 -10.9417 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7070 -9.7081 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 8 9 2 0 0 0 0 + 5 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 10 11 2 0 0 0 0 + 6 12 1 0 0 0 0 + 6 13 1 0 0 0 0 + 11 14 1 0 0 0 0 + 10 15 1 0 0 0 0 + 14 16 2 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 2 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 17 21 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00474.mol b/src/analysis/thermo/trainingModel/data/mol/C00474.mol new file mode 100644 index 0000000000..9c8f58e82c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00474.mol @@ -0,0 +1,24 @@ +C00474 + Mrv1652304062119462D + + 10 9 0 0 1 0 999 V2000 + 8.8279 -9.7354 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5424 -9.3229 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2570 -9.7354 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.9714 -9.3229 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.6859 -9.7354 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.4005 -9.3229 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1150 -9.7354 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9714 -8.4979 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2570 -10.5604 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6859 -10.5605 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 4 8 1 6 0 0 0 + 3 9 1 1 0 0 0 + 5 10 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00475.mol b/src/analysis/thermo/trainingModel/data/mol/C00475.mol new file mode 100644 index 0000000000..158105afd4 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00475.mol @@ -0,0 +1,40 @@ +C00475 + Mrv1652304062119462D + + 17 18 0 0 1 0 999 V2000 + 15.2690 -9.5607 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.0581 -9.3091 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5935 -9.0507 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0242 -10.3258 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.6543 -9.8709 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2442 -8.5131 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9284 -9.5469 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.1868 -10.3258 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.2759 -11.1287 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4470 -9.6365 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4717 -10.6807 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0335 -8.2683 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1427 -9.2954 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9318 -11.1322 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6262 -8.8370 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5326 -9.8502 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4291 -8.6026 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 2 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00476.mol b/src/analysis/thermo/trainingModel/data/mol/C00476.mol new file mode 100644 index 0000000000..e35b8b1236 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00476.mol @@ -0,0 +1,25 @@ +C00476 + Mrv1652304062119462D + + 10 10 0 0 1 0 999 V2000 + 15.1037 -9.7283 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.8222 -9.3159 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3990 -9.3159 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1037 -10.5533 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8222 -8.4909 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 16.5372 -9.7283 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3990 -8.4909 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6806 -9.7283 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1037 -8.0784 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5372 -8.0784 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 6 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 4 0 0 0 + 7 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00482.mol b/src/analysis/thermo/trainingModel/data/mol/C00482.mol new file mode 100644 index 0000000000..0f93b51bf5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00482.mol @@ -0,0 +1,38 @@ +C00482 + Mrv1652304062119462D + + 16 16 0 0 0 0 999 V2000 + 14.9328 -10.8902 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9328 -11.7153 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6473 -12.1278 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3618 -11.7153 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3618 -10.8902 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6473 -10.4777 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0873 -10.4712 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0873 -9.6462 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0873 -12.1342 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6473 -12.9527 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9229 -13.3710 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2184 -10.4777 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5139 -10.8846 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8141 -10.4806 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1122 -10.8861 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.8140 -9.6528 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 3 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 1 1 4 0 0 0 + 12 13 2 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 14 16 2 0 0 0 0 +M CHG 1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00491.mol b/src/analysis/thermo/trainingModel/data/mol/C00491.mol new file mode 100644 index 0000000000..cb550fa609 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00491.mol @@ -0,0 +1,33 @@ +C00491 + Mrv1652304062119462D + + 14 13 0 0 1 0 999 V2000 + 14.7403 -8.9523 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0257 -9.3646 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4549 -9.3646 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7403 -8.1277 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.3111 -8.9523 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1695 -8.9523 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.4549 -10.1892 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5999 -9.3646 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8819 -8.9523 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1673 -9.3646 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.4528 -8.9523 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1673 -10.1892 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 9.7348 -9.3646 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.4528 -8.1277 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 10 9 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 1 6 0 0 0 + 11 13 1 0 0 0 0 + 11 14 2 0 0 0 0 +M CHG 4 4 1 6 -1 12 1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00492.mol b/src/analysis/thermo/trainingModel/data/mol/C00492.mol new file mode 100644 index 0000000000..2550f4c98e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00492.mol @@ -0,0 +1,75 @@ +C00492 + Mrv1652304062119462D + + 34 36 0 0 1 0 999 V2000 + 17.8979 -8.1738 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.3170 -8.7169 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5648 -7.6890 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1524 -8.9575 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.5986 -9.1740 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.2317 -8.1738 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.9774 -8.9575 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.6711 -9.6243 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8802 -8.7650 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5986 -9.9990 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.0154 -7.9227 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4585 -9.6243 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1651 -9.1740 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.8802 -10.4149 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.3170 -10.4149 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6239 -8.4728 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4501 -8.7615 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1651 -9.9990 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.8802 -11.2399 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7352 -9.1775 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4501 -10.3703 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0202 -9.5934 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2983 -9.1844 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0202 -10.4184 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5832 -9.5934 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2983 -10.8343 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.7352 -10.8756 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5832 -10.4184 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.8820 -9.1844 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2983 -11.6593 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8820 -10.8343 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2461 -9.7171 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3146 -7.5904 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5266 -7.8016 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 5 2 1 6 0 0 0 + 6 3 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 1 6 0 0 0 + 5 9 1 0 0 0 0 + 10 5 1 0 0 0 0 + 6 11 1 6 0 0 0 + 7 12 1 1 0 0 0 + 13 9 1 0 0 0 0 + 10 14 1 0 0 0 0 + 10 15 1 6 0 0 0 + 11 16 1 0 0 0 0 + 13 17 1 1 0 0 0 + 18 13 1 0 0 0 0 + 14 19 1 1 0 0 0 + 17 20 1 0 0 0 0 + 18 21 1 6 0 0 0 + 22 20 1 6 0 0 0 + 22 23 1 0 0 0 0 + 24 22 1 0 0 0 0 + 25 23 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 1 6 0 0 0 + 28 25 1 0 0 0 0 + 25 29 1 1 0 0 0 + 26 30 1 1 0 0 0 + 28 31 1 1 0 0 0 + 29 32 1 0 0 0 0 + 7 6 1 0 0 0 0 + 14 18 1 0 0 0 0 + 26 28 1 0 0 0 0 + 1 33 1 1 0 0 0 + 33 34 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00493.mol b/src/analysis/thermo/trainingModel/data/mol/C00493.mol new file mode 100644 index 0000000000..7aa4d0ec8b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00493.mol @@ -0,0 +1,30 @@ +C00493 + Mrv1652304062119462D + + 12 12 0 0 1 0 999 V2000 + 13.0012 -8.8826 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7168 -9.2931 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2894 -9.2931 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9975 -8.0654 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7168 -10.1216 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.2894 -10.1216 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.7054 -7.6548 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.2856 -7.6585 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0012 -10.5398 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4286 -10.5284 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5775 -10.5284 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9975 -11.3608 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 5 2 1 0 0 0 0 + 6 3 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 9 5 1 0 0 0 0 + 5 10 1 1 0 0 0 + 6 11 1 6 0 0 0 + 9 12 1 6 0 0 0 + 9 6 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00497.mol b/src/analysis/thermo/trainingModel/data/mol/C00497.mol new file mode 100644 index 0000000000..ddaa738d01 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00497.mol @@ -0,0 +1,23 @@ +C00497 + Mrv1652304062119462D + + 9 8 0 0 1 0 999 V2000 + 14.9923 -11.1246 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.7098 -11.5385 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2787 -11.5385 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4234 -11.1246 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5650 -11.1209 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.2824 -12.4448 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1371 -11.5385 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.4197 -10.2972 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9912 -10.2893 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 1 9 1 6 0 0 0 +M CHG 2 5 -1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00498.mol b/src/analysis/thermo/trainingModel/data/mol/C00498.mol new file mode 100644 index 0000000000..ce3423c9d2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00498.mol @@ -0,0 +1,85 @@ +C00498 + Mrv1652304062119462D + + 38 41 0 0 1 0 999 V2000 + 18.2177 -9.0879 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4356 -8.8298 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6938 -10.4699 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.6998 -8.4159 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4356 -8.0059 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7106 -9.2436 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0105 -9.9763 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4432 -11.2443 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.2215 -7.7592 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7181 -7.5807 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9892 -8.7576 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3423 -10.4584 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.6043 -11.2443 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.9330 -11.9087 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9931 -7.9946 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7220 -6.7569 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5564 -10.2154 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1297 -11.9161 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7327 -10.2154 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9050 -10.2154 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0813 -10.2154 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9050 -11.0813 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9050 -9.3457 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2536 -10.2154 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4260 -10.2154 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2536 -11.0813 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.2536 -9.3457 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7085 -10.6293 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.9872 -10.2154 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7085 -11.4531 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.2734 -10.6293 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.9872 -11.8668 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.4260 -11.8668 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2734 -11.4531 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.5636 -10.2154 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9872 -12.6907 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5636 -11.8668 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9334 -10.7507 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 28 25 1 6 0 0 0 + 28 29 1 0 0 0 0 + 30 28 1 0 0 0 0 + 31 29 1 0 0 0 0 + 30 32 1 0 0 0 0 + 30 33 1 6 0 0 0 + 34 31 1 0 0 0 0 + 31 35 1 1 0 0 0 + 32 36 1 1 0 0 0 + 34 37 1 6 0 0 0 + 35 38 1 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 2 0 0 0 0 + 13 12 1 0 0 0 0 + 32 34 1 0 0 0 0 +M CHG 2 22 -1 26 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00499.mol b/src/analysis/thermo/trainingModel/data/mol/C00499.mol new file mode 100644 index 0000000000..edc98ff060 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00499.mol @@ -0,0 +1,29 @@ +C00499 + Mrv1652304062119462D + + 12 11 0 0 0 0 999 V2000 + 15.7343 -15.0376 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8143 -15.4476 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6130 -15.4476 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7343 -14.2101 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2206 -15.0376 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2479 -15.0376 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4480 -13.7962 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.0206 -13.7962 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5069 -15.4476 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2206 -14.3338 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9616 -15.4476 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2479 -14.3338 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 6 12 2 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00501.mol b/src/analysis/thermo/trainingModel/data/mol/C00501.mol new file mode 100644 index 0000000000..e88b38f104 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00501.mol @@ -0,0 +1,80 @@ +C00501 + Mrv1652304062119462D + + 36 38 0 0 1 0 999 V2000 + 17.5744 -10.5671 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.0974 -9.1877 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8923 -10.0744 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3243 -11.3401 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.3774 -8.7671 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8212 -8.7823 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2291 -10.5557 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.4906 -11.3401 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.8131 -12.0033 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3811 -7.9409 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6611 -9.1763 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8212 -7.9447 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4409 -10.3132 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0168 -12.0109 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1012 -7.5240 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6185 -10.3132 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1012 -6.7016 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7924 -10.3132 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9701 -10.3132 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7924 -11.1776 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7924 -9.4449 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1401 -10.3132 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3178 -10.3094 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1364 -11.1776 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.1401 -9.4449 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6015 -10.7186 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.8816 -10.3094 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6015 -11.5410 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.1691 -10.7225 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.8816 -11.9579 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.3178 -11.9579 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1691 -11.5448 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.4642 -10.3094 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8816 -12.7802 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4642 -11.9579 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8313 -10.8400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 2 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 26 27 1 0 0 0 0 + 28 26 1 0 0 0 0 + 29 27 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 1 6 0 0 0 + 32 29 1 0 0 0 0 + 29 33 1 1 0 0 0 + 30 34 1 1 0 0 0 + 32 35 1 6 0 0 0 + 33 36 1 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 + 30 32 1 0 0 0 0 +M CHG 2 20 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00504.mol b/src/analysis/thermo/trainingModel/data/mol/C00504.mol new file mode 100644 index 0000000000..36bc07b362 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00504.mol @@ -0,0 +1,72 @@ +C00504 + Mrv1652304062119462D + + 32 34 0 0 1 0 999 V2000 + 9.1955 -10.8792 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1955 -10.0516 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9196 -11.2929 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4818 -11.2964 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9162 -9.6275 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4818 -9.6413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6438 -10.8826 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7681 -10.8792 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6369 -10.0447 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7681 -10.0516 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4784 -8.8207 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0577 -11.2860 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3437 -9.6310 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0575 -10.0412 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7713 -9.6275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4815 -10.0378 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7644 -8.8000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1953 -9.6206 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4746 -8.3862 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1919 -8.7965 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9057 -8.3827 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6195 -8.7931 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9022 -7.5587 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3331 -8.3793 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.0504 -8.7896 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3331 -7.5551 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7642 -8.3758 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0435 -7.1414 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.6159 -7.1449 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4779 -8.7862 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1917 -8.3724 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.4813 -9.6102 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 2 0 0 0 0 + 6 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 8 12 1 0 0 0 0 + 9 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 15 17 1 0 0 0 0 + 16 18 1 0 0 0 0 + 17 19 2 0 0 0 0 + 18 20 2 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 2 0 0 0 0 + 24 22 1 6 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 25 27 1 0 0 0 0 + 26 28 1 0 0 0 0 + 26 29 2 0 0 0 0 + 27 30 1 0 0 0 0 + 30 31 1 0 0 0 0 + 30 32 2 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 19 20 1 0 0 0 0 +M CHG 2 28 -1 31 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00507.mol b/src/analysis/thermo/trainingModel/data/mol/C00507.mol new file mode 100644 index 0000000000..33ed7c6dce --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00507.mol @@ -0,0 +1,27 @@ +C00507 + Mrv1652304062119462D + + 11 11 0 0 1 0 999 V2000 + 15.1600 -9.7890 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.4334 -9.3688 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.8765 -9.3688 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.1600 -10.6190 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4334 -8.5457 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.7238 -9.7890 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8765 -8.5457 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 16.5928 -9.7890 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1600 -8.1358 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7204 -8.1324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5928 -8.1358 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 6 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 7 11 1 4 0 0 0 + 7 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00508.mol b/src/analysis/thermo/trainingModel/data/mol/C00508.mol new file mode 100644 index 0000000000..c1d9e06b55 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00508.mol @@ -0,0 +1,25 @@ +C00508 + Mrv1652304062119462D + + 10 10 0 0 1 0 999 V2000 + 15.1633 -8.8730 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 14.9200 -9.6409 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.4845 -8.3828 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7461 -8.2867 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9210 -9.1507 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0868 -9.6409 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.3999 -10.3094 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8229 -8.8592 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4935 -8.6330 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6069 -10.3127 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 1 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 1 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00515.mol b/src/analysis/thermo/trainingModel/data/mol/C00515.mol new file mode 100644 index 0000000000..8ca6a8efe9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00515.mol @@ -0,0 +1,23 @@ +C00515 + Mrv1652304062119462D + + 9 8 0 0 1 0 999 V2000 + 8.5755 -14.4319 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3000 -14.8502 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 7.8510 -14.8502 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.5755 -13.5953 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0144 -14.4377 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7240 -14.8473 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4359 -14.4362 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1467 -14.8465 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 9.3001 -15.6868 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 2 9 1 1 0 0 0 +M CHG 3 3 -1 8 1 9 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00522.mol b/src/analysis/thermo/trainingModel/data/mol/C00522.mol new file mode 100644 index 0000000000..1fa7826c4a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00522.mol @@ -0,0 +1,25 @@ +C00522 + Mrv1652304062119462D + + 10 9 0 0 1 0 999 V2000 + 17.4176 -9.5422 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.7092 -9.9588 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9591 -9.5422 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.2508 -9.9588 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5424 -9.5422 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7924 -9.9588 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7092 -10.7922 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9591 -8.7088 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6674 -10.5422 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8341 -10.5422 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 3 8 1 1 0 0 0 + 4 9 1 0 0 0 0 + 4 10 1 0 0 0 0 +M CHG 1 1 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00534.mol b/src/analysis/thermo/trainingModel/data/mol/C00534.mol new file mode 100644 index 0000000000..776a2086a1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00534.mol @@ -0,0 +1,30 @@ +C00534 + Mrv1652304062119462D + + 12 12 0 0 0 0 999 V2000 + 14.7846 -9.1196 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4992 -9.5319 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0630 -9.5319 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7880 -8.2984 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4992 -10.3632 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2069 -9.1196 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0630 -10.3632 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3553 -9.1196 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4992 -7.8895 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.7846 -10.7823 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9216 -9.5319 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3518 -10.7721 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 7 10 1 0 0 0 0 +M CHG 1 9 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00535.mol b/src/analysis/thermo/trainingModel/data/mol/C00535.mol new file mode 100644 index 0000000000..7b8fe5a24b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00535.mol @@ -0,0 +1,50 @@ +C00535 + Mrv1652304062119462D + + 21 24 0 0 1 0 999 V2000 + 17.4561 -11.1513 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4561 -12.0091 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1852 -12.3951 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9144 -12.0091 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9144 -11.1513 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.1852 -10.7224 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6435 -12.3951 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3297 -12.0091 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3297 -11.1513 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.6435 -10.7224 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.1017 -10.7224 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 21.1017 -9.9075 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.3297 -9.4786 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6435 -9.9075 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7699 -12.3951 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1017 -9.0926 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9144 -10.3364 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5600 -10.7224 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5600 -9.9075 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8309 -9.4786 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.8309 -8.6637 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 5 4 1 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 9 8 1 6 0 0 0 + 9 10 1 0 0 0 0 + 10 5 1 0 0 0 0 + 9 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 10 14 1 1 0 0 0 + 2 15 2 0 0 0 0 + 12 16 1 1 0 0 0 + 5 17 1 1 0 0 0 + 11 18 1 1 0 0 0 + 18 19 1 0 0 0 0 + 20 19 1 0 0 0 0 + 12 20 1 0 0 0 0 + 20 21 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00543.mol b/src/analysis/thermo/trainingModel/data/mol/C00543.mol new file mode 100644 index 0000000000..9cbd824752 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00543.mol @@ -0,0 +1,11 @@ +C00543 + Mrv1652304062119462D + + 3 2 0 0 0 0 999 V2000 + 16.9825 -13.5726 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.2438 -14.0571 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6034 -14.0223 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 +M CHG 1 1 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00546.mol b/src/analysis/thermo/trainingModel/data/mol/C00546.mol new file mode 100644 index 0000000000..3b56e88436 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00546.mol @@ -0,0 +1,14 @@ +C00546 + Mrv1652304062119462D + + 5 4 0 0 0 0 999 V2000 + 16.0269 -11.5935 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7446 -11.1833 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3130 -11.1833 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0269 -12.4627 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4502 -11.5949 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00552.mol b/src/analysis/thermo/trainingModel/data/mol/C00552.mol new file mode 100644 index 0000000000..8ef715c2f9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00552.mol @@ -0,0 +1,25 @@ +C00552 + Mrv1652304062119462D + + 10 9 0 0 1 0 999 V2000 + 11.3159 -4.9089 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.0305 -5.3214 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7449 -4.9089 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.4594 -5.3214 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.1739 -4.9089 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8884 -5.3214 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.0305 -6.1463 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7449 -4.0838 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4594 -6.1463 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1739 -4.0840 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 3 8 1 6 0 0 0 + 4 9 1 1 0 0 0 + 5 10 2 0 0 0 0 +M CHG 2 1 -1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00556.mol b/src/analysis/thermo/trainingModel/data/mol/C00556.mol new file mode 100644 index 0000000000..2ab5b8a3be --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00556.mol @@ -0,0 +1,21 @@ +C00556 + Mrv1652304062119462D + + 8 8 0 0 0 0 999 V2000 + 12.4707 -10.0173 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7639 -10.4233 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1889 -10.4233 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4670 -9.1977 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7639 -11.2505 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1889 -11.2505 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1775 -8.7879 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4707 -11.6715 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 2 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00558.mol b/src/analysis/thermo/trainingModel/data/mol/C00558.mol new file mode 100644 index 0000000000..9478e5abd9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00558.mol @@ -0,0 +1,32 @@ +C00558 + Mrv1652304062119462D + + 13 13 0 0 1 0 999 V2000 + 15.8168 -9.2297 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 15.5680 -9.9930 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.1329 -8.7359 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3969 -8.6426 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5696 -9.5061 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7358 -9.9930 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.0516 -10.6664 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4699 -9.2124 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.1498 -8.9879 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2522 -10.6698 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6825 -8.9708 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1851 -9.6304 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.6720 -8.0797 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 1 0 0 0 + 8 3 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 1 0 0 0 + 8 11 1 1 0 0 0 + 11 12 1 0 0 0 0 + 11 13 2 0 0 0 0 + 6 8 1 0 0 0 0 +M CHG 1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00559.mol b/src/analysis/thermo/trainingModel/data/mol/C00559.mol new file mode 100644 index 0000000000..6b087b9f40 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00559.mol @@ -0,0 +1,43 @@ +C00559 + Mrv1652304062119462D + + 18 20 0 0 1 0 999 V2000 + 17.5824 -13.5792 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2205 -14.0210 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8110 -13.8281 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.8699 -12.7413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9637 -13.4775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3011 -14.8729 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1309 -13.3197 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5516 -14.5784 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7394 -12.7448 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7175 -13.8071 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0970 -15.2270 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4683 -13.7930 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7207 -14.5784 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.8122 -14.6976 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3801 -13.3163 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6864 -13.5477 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4578 -15.3672 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0693 -14.1156 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 13 8 1 0 0 0 0 + 10 14 1 0 0 0 0 + 10 15 1 0 0 0 0 + 12 16 1 1 0 0 0 + 13 17 1 6 0 0 0 + 16 18 1 0 0 0 0 + 5 9 1 0 0 0 0 + 11 14 2 0 0 0 0 + 12 13 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00565.mol b/src/analysis/thermo/trainingModel/data/mol/C00565.mol new file mode 100644 index 0000000000..d60bcc745c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00565.mol @@ -0,0 +1,13 @@ +C00565 + Mrv1652304062119462D + + 4 3 0 0 0 0 999 V2000 + 13.0485 -9.3321 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.7622 -8.9183 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3347 -8.9183 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0485 -10.2010 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 +M CHG 1 1 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00570.mol b/src/analysis/thermo/trainingModel/data/mol/C00570.mol new file mode 100644 index 0000000000..9138c54dd8 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00570.mol @@ -0,0 +1,63 @@ +C00570 + Mrv1652304062119462D + + 28 29 0 0 1 0 999 V2000 + 16.9754 -11.0069 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.4973 -9.6263 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2982 -10.5115 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7295 -11.7787 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.7787 -9.2065 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2198 -9.2217 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6326 -10.9919 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.8936 -11.7787 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2136 -12.4406 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7824 -8.3856 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0675 -9.6150 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2198 -8.3856 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8496 -10.7498 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4206 -12.4481 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5011 -7.9696 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0249 -10.7498 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5011 -7.1450 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2041 -10.7498 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3794 -10.7498 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2041 -11.6168 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.2041 -9.9289 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5511 -10.7498 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7303 -10.7498 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5473 -11.6168 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.5511 -9.9289 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0154 -10.3375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3042 -10.7498 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5931 -10.3375 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 2 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 23 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 +M CHG 3 20 -1 24 -1 28 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00575.mol b/src/analysis/thermo/trainingModel/data/mol/C00575.mol new file mode 100644 index 0000000000..eda3d5f519 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00575.mol @@ -0,0 +1,53 @@ +C00575 + Mrv1652304062119462D + + 22 25 0 0 1 0 999 V2000 + 15.9833 -8.7870 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2176 -9.0342 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.6204 -9.2256 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2688 -7.9551 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9635 -9.7790 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.5388 -8.5259 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3547 -8.6861 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7004 -10.0715 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1321 -7.9586 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1385 -9.7790 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3533 -10.4578 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8844 -8.9994 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.0997 -9.0133 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4871 -10.4229 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5503 -10.3638 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0908 -8.7383 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1971 -9.8974 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7575 -8.5225 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6453 -10.1097 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4712 -9.2952 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6383 -10.9452 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.9178 -9.6920 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 5 2 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 5 11 1 6 0 0 0 + 12 6 1 1 0 0 0 + 7 13 2 0 0 0 0 + 8 14 1 0 0 0 0 + 10 15 1 6 0 0 0 + 12 16 1 0 0 0 0 + 13 17 1 0 0 0 0 + 13 18 1 0 0 0 0 + 15 19 1 0 0 0 0 + 16 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 19 22 2 0 0 0 0 + 7 9 1 0 0 0 0 + 10 12 1 0 0 0 0 + 14 17 2 0 0 0 0 + 19 20 1 0 0 0 0 +M CHG 1 21 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00577.mol b/src/analysis/thermo/trainingModel/data/mol/C00577.mol new file mode 100644 index 0000000000..eb67b994be --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00577.mol @@ -0,0 +1,16 @@ +C00577 + Mrv1652304062119462D + + 6 5 0 0 1 0 999 V2000 + 15.8114 -12.0886 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.1003 -12.5069 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5643 -12.5069 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8114 -11.2520 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3892 -12.0886 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2754 -12.0886 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00579.mol b/src/analysis/thermo/trainingModel/data/mol/C00579.mol new file mode 100644 index 0000000000..a8c23bf3a6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00579.mol @@ -0,0 +1,28 @@ +C00579 + Mrv1652304062119462D + + 12 11 0 0 0 0 999 V2000 + 12.4367 -10.0399 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7191 -9.6298 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1505 -9.6298 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7191 -8.8021 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0054 -10.0399 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8642 -10.0399 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0054 -8.3884 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5818 -9.6298 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2879 -8.8021 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2956 -10.0399 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0320 -9.5121 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2956 -10.9508 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00580.mol b/src/analysis/thermo/trainingModel/data/mol/C00580.mol new file mode 100644 index 0000000000..2a9706f289 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00580.mol @@ -0,0 +1,10 @@ +C00580 + Mrv1652304062119462D + + 3 2 0 0 0 0 999 V2000 + 12.1367 -9.1267 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4685 -8.6715 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8398 -8.6644 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00581.mol b/src/analysis/thermo/trainingModel/data/mol/C00581.mol new file mode 100644 index 0000000000..3ca9276965 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00581.mol @@ -0,0 +1,21 @@ +C00581 + Mrv1652304062119462D + + 8 7 0 0 0 0 999 V2000 + 16.5452 -11.7667 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8288 -12.1759 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2575 -12.1759 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.5452 -11.0229 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2400 -11.7667 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4002 -12.1759 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4002 -13.0433 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.6878 -11.7667 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 2 0 0 0 0 + 6 8 1 0 0 0 0 +M CHG 2 3 -1 7 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00583.mol b/src/analysis/thermo/trainingModel/data/mol/C00583.mol new file mode 100644 index 0000000000..a019326aab --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00583.mol @@ -0,0 +1,14 @@ +C00583 + Mrv1652304062119462D + + 5 4 0 0 0 0 999 V2000 + 12.6652 -9.3202 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3775 -8.9072 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9492 -8.9072 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6652 -10.2286 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0897 -9.3202 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00588.mol b/src/analysis/thermo/trainingModel/data/mol/C00588.mol new file mode 100644 index 0000000000..16e7142817 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00588.mol @@ -0,0 +1,27 @@ +C00588 + Mrv1652304062119462D + + 11 10 0 0 0 0 999 V2000 + 14.8404 -10.8063 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8778 -11.3672 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.5564 -11.2161 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8437 -10.8024 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8778 -12.5207 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8437 -11.9559 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2684 -10.8024 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0837 -10.8024 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9071 -10.8024 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.0837 -9.8352 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.0837 -11.6733 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 2 0 0 0 0 +M CHG 3 2 1 9 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00590.mol b/src/analysis/thermo/trainingModel/data/mol/C00590.mol new file mode 100644 index 0000000000..013809b1eb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00590.mol @@ -0,0 +1,31 @@ +C00590 + Mrv1652304062119462D + + 13 13 0 0 0 0 999 V2000 + 20.3627 -10.9752 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3627 -11.8003 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0772 -12.2128 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7917 -11.8003 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7917 -10.9752 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0772 -10.5628 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5172 -10.5562 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5172 -9.7313 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5172 -12.2192 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6482 -10.5628 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9438 -10.9696 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2441 -10.5656 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2441 -9.7420 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 1 10 1 0 0 0 0 + 10 11 2 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00603.mol b/src/analysis/thermo/trainingModel/data/mol/C00603.mol new file mode 100644 index 0000000000..0a5b4d5bdc --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00603.mol @@ -0,0 +1,23 @@ +C00603 + Mrv1652304062119462D + + 9 8 0 0 1 0 999 V2000 + 7.7552 -12.4578 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4696 -12.0453 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1842 -12.4578 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8986 -12.0453 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.6131 -12.4578 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4696 -11.2204 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8986 -11.2202 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3188 -12.0503 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.6132 -13.2827 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 4 7 1 1 0 0 0 + 5 8 1 0 0 0 0 + 5 9 2 0 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00617.mol b/src/analysis/thermo/trainingModel/data/mol/C00617.mol new file mode 100644 index 0000000000..7c96d26abc --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00617.mol @@ -0,0 +1,82 @@ +C00617 + Mrv1652304062119462D + + 37 39 0 0 1 0 999 V2000 + 19.3132 -16.9121 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9571 -15.5714 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6391 -16.4197 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0708 -17.6809 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.2489 -15.1472 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6842 -15.1472 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9801 -16.8931 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.2489 -17.6809 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.5593 -18.3475 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2489 -14.3139 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5330 -15.5562 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6842 -14.3139 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1961 -16.6431 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7641 -18.3512 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9608 -13.9012 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0219 -15.8402 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9608 -13.2056 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1962 -15.8365 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3706 -15.8365 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1962 -15.0146 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.1925 -16.6621 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5487 -15.8365 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7231 -15.8365 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5487 -15.0146 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5487 -16.6621 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0111 -16.2492 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2916 -15.8402 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0111 -17.0711 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5795 -16.2492 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2916 -17.4877 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.7270 -17.4877 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5795 -17.0711 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.8638 -15.8365 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2916 -18.3096 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8714 -17.4877 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8676 -15.0146 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.1518 -16.2492 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 26 27 1 0 0 0 0 + 28 26 1 0 0 0 0 + 29 27 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 1 6 0 0 0 + 32 29 1 0 0 0 0 + 29 33 1 1 0 0 0 + 30 34 1 1 0 0 0 + 32 35 1 1 0 0 0 + 33 36 1 0 0 0 0 + 33 37 2 0 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 + 30 32 1 0 0 0 0 +M CHG 3 20 -1 24 -1 36 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00620.mol b/src/analysis/thermo/trainingModel/data/mol/C00620.mol new file mode 100644 index 0000000000..f94f216354 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00620.mol @@ -0,0 +1,34 @@ +C00620 + Mrv1652304062119462D + + 14 14 0 0 1 0 999 V2000 + 15.4005 -11.6676 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.1497 -12.4469 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.7163 -11.1735 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1912 -11.4168 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3132 -12.4469 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.6400 -13.1123 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0510 -11.6563 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.0162 -11.4129 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8381 -13.1199 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2679 -11.4129 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8411 -11.4129 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.0124 -10.5842 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.0162 -12.2379 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7698 -12.0668 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 6 0 0 0 + 7 10 1 1 0 0 0 + 8 11 1 0 0 0 0 + 8 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 10 14 1 0 0 0 0 + 5 7 1 0 0 0 0 +M CHG 2 11 -1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00624.mol b/src/analysis/thermo/trainingModel/data/mol/C00624.mol new file mode 100644 index 0000000000..1e2b58cfff --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00624.mol @@ -0,0 +1,31 @@ +C00624 + Mrv1652304062119462D + + 13 12 0 0 1 0 999 V2000 + 13.1344 -10.8338 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.4233 -10.4155 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6703 -10.8338 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9592 -10.4155 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2481 -10.8338 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.4952 -10.4155 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7841 -10.8338 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.4233 -9.5789 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2481 -11.6703 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4952 -9.5789 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9592 -12.0886 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6703 -11.6703 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9592 -12.9252 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 5 4 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 2 0 0 0 0 + 5 9 1 6 0 0 0 + 6 10 2 0 0 0 0 + 9 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 11 13 2 0 0 0 0 +M CHG 2 1 -1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00631.mol b/src/analysis/thermo/trainingModel/data/mol/C00631.mol new file mode 100644 index 0000000000..4f91abce54 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00631.mol @@ -0,0 +1,27 @@ +C00631 + Mrv1652304062119462D + + 11 10 0 0 1 0 999 V2000 + 15.9178 -11.7790 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9313 -11.0116 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1234 -11.7790 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.7256 -11.7925 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.9077 -12.5397 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9313 -10.1835 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.2143 -9.7695 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6448 -9.7695 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4973 -10.1835 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.2143 -8.9449 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3618 -10.1835 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 6 2 1 1 0 0 0 + 6 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 8 11 1 0 0 0 0 +M CHG 3 3 -1 4 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00636.mol b/src/analysis/thermo/trainingModel/data/mol/C00636.mol new file mode 100644 index 0000000000..3f260610b2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00636.mol @@ -0,0 +1,38 @@ +C00636 + Mrv1652304062119462D + + 16 16 0 0 1 0 999 V2000 + 13.3954 -9.3110 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.6754 -8.8978 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3954 -10.1334 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.1078 -8.8978 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9591 -9.3110 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.6754 -10.5427 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.1078 -10.5427 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0849 -8.8978 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9591 -10.1334 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.2541 -8.8978 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6791 -11.4110 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9111 -8.8978 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.0849 -7.9874 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.0886 -9.7771 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2541 -10.5427 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6212 -9.4285 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 6 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 1 0 0 0 + 4 8 1 0 0 0 0 + 9 5 1 0 0 0 0 + 5 10 1 1 0 0 0 + 6 11 1 1 0 0 0 + 8 12 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 2 0 0 0 0 + 9 15 1 6 0 0 0 + 10 16 1 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 2 12 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00644.mol b/src/analysis/thermo/trainingModel/data/mol/C00644.mol new file mode 100644 index 0000000000..5c45939057 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00644.mol @@ -0,0 +1,37 @@ +C00644 + Mrv1652304062119462D + + 16 15 0 0 1 0 999 V2000 + 11.6059 -9.8359 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.3235 -9.4222 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.8922 -9.4222 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.6059 -10.6598 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0372 -9.8359 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.3235 -8.5945 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1785 -9.8359 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8922 -8.5945 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7509 -9.4222 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0372 -10.6598 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4610 -9.4222 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4684 -9.8359 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5550 -9.4222 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7313 -9.4222 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.5550 -8.5945 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.5550 -10.2835 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 1 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 1 0 0 0 + 7 11 1 0 0 0 0 + 9 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 13 16 2 0 0 0 0 +M CHG 2 14 -1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00645.mol b/src/analysis/thermo/trainingModel/data/mol/C00645.mol new file mode 100644 index 0000000000..3b82ee7c17 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00645.mol @@ -0,0 +1,35 @@ +C00645 + Mrv1652304062119472D + + 15 15 0 0 1 0 999 V2000 + 17.0551 -10.8959 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.3369 -11.3121 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.0551 -10.0709 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 15.6292 -10.8959 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.3403 -12.1335 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3369 -9.6549 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7736 -9.6549 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6292 -10.0709 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.9179 -11.3121 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9179 -9.6549 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2885 -10.1954 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7989 -11.3247 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5339 -10.8817 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2731 -11.3085 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5339 -10.1990 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 1 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 4 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 8 10 1 1 0 0 0 + 10 11 1 0 0 0 0 + 8 6 1 0 0 0 0 + 1 12 1 1 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00664.mol b/src/analysis/thermo/trainingModel/data/mol/C00664.mol new file mode 100644 index 0000000000..43eb0e25ae --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00664.mol @@ -0,0 +1,76 @@ +C00664 + Mrv1652304062119472D + + 34 36 0 0 1 0 999 V2000 + 5.6121 -10.3531 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 5.6121 -11.1781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3134 -11.5907 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0559 -11.1781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0559 -10.3531 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3134 -9.9406 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7572 -11.5907 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4584 -11.1781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4584 -10.3531 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 7.7572 -9.9406 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3134 -9.1156 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.8959 -11.5878 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1730 -9.9406 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8875 -10.3531 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6019 -9.9406 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3177 -10.3538 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0321 -9.9413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0321 -9.1163 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3164 -8.7031 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6019 -9.1156 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7618 -8.7031 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4763 -9.1156 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7653 -7.8782 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2018 -8.6966 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9121 -9.1066 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6088 -8.7042 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3124 -9.1104 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0125 -8.7061 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.3126 -9.9404 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2017 -7.8781 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4802 -7.4617 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9091 -7.4694 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.7572 -9.1169 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4704 -8.7051 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 9 8 1 0 0 0 0 + 9 10 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 2 12 1 0 0 0 0 + 9 13 1 1 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 2 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 2 0 0 0 0 + 15 20 1 0 0 0 0 + 18 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 2 0 0 0 0 + 24 22 1 6 0 0 0 + 24 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 27 29 2 0 0 0 0 + 24 30 1 0 0 0 0 + 30 31 2 0 0 0 0 + 30 32 1 0 0 0 0 + 10 33 1 0 0 0 0 + 33 34 2 0 0 0 0 +M CHG 2 28 -1 32 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00666.mol b/src/analysis/thermo/trainingModel/data/mol/C00666.mol new file mode 100644 index 0000000000..c3f17ba2da --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00666.mol @@ -0,0 +1,31 @@ +C00666 + Mrv1652304062119472D + + 13 12 0 0 1 0 999 V2000 + 17.6099 -11.1009 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.3268 -10.6926 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8964 -10.6926 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6099 -11.9275 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 19.0369 -11.1009 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.3268 -9.8660 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1829 -11.1009 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4660 -10.6926 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7560 -11.1009 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0390 -10.6926 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7560 -11.9275 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.3290 -11.1009 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0390 -9.8660 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 9 8 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 1 6 0 0 0 + 10 12 1 0 0 0 0 + 10 13 2 0 0 0 0 +M CHG 4 4 1 5 -1 11 1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00668.mol b/src/analysis/thermo/trainingModel/data/mol/C00668.mol new file mode 100644 index 0000000000..f0537a27c1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00668.mol @@ -0,0 +1,38 @@ +C00668 + Mrv1652304062119472D + + 16 16 0 0 1 0 999 V2000 + 11.3247 -8.9946 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1535 -8.9983 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4960 -8.9946 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.3247 -8.1696 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.3172 -9.8233 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7883 -8.4662 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4954 -8.8767 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.4954 -9.7017 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.2138 -8.4662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2138 -10.1199 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.7883 -10.1199 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9362 -8.8767 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9362 -9.7017 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.2138 -10.9448 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6509 -8.4662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6509 -10.1199 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 1 0 0 0 + 8 7 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 1 6 0 0 0 + 12 9 1 0 0 0 0 + 10 13 1 0 0 0 0 + 10 14 1 1 0 0 0 + 12 15 1 6 0 0 0 + 13 16 1 6 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00672.mol b/src/analysis/thermo/trainingModel/data/mol/C00672.mol new file mode 100644 index 0000000000..3140a7c726 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00672.mol @@ -0,0 +1,32 @@ +C00672 + Mrv1652304062119472D + + 13 13 0 0 1 0 999 V2000 + 15.9078 -12.3959 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.2380 -11.9193 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6542 -13.1868 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6910 -12.1387 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5758 -12.3959 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.8255 -13.1868 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.5121 -12.1387 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7963 -12.1387 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3412 -13.8491 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3332 -12.1387 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.5084 -11.3137 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.5084 -12.9598 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6260 -11.3327 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 5 2 1 0 0 0 0 + 6 3 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 1 0 0 0 + 6 9 1 6 0 0 0 + 7 10 1 0 0 0 0 + 7 11 1 0 0 0 0 + 7 12 2 0 0 0 0 + 8 13 1 0 0 0 0 + 5 6 1 0 0 0 0 +M CHG 2 10 -1 11 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00673.mol b/src/analysis/thermo/trainingModel/data/mol/C00673.mol new file mode 100644 index 0000000000..be4695476f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00673.mol @@ -0,0 +1,32 @@ +C00673 + Mrv1652304062119472D + + 13 13 0 0 1 0 999 V2000 + 11.4997 -8.7053 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3285 -8.7053 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6784 -8.7053 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.5034 -7.8802 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.4959 -9.5265 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4950 -9.5114 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2784 -9.7687 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.5282 -10.5559 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.9369 -9.2881 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3532 -10.5559 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0401 -11.2182 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6106 -9.7687 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 15.5137 -9.5114 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 1 0 0 0 + 7 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 1 6 0 0 0 + 9 12 1 0 0 0 0 + 12 13 1 4 0 0 0 + 10 12 1 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00680.mol b/src/analysis/thermo/trainingModel/data/mol/C00680.mol new file mode 100644 index 0000000000..4ffb7f904e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00680.mol @@ -0,0 +1,31 @@ +C00680 + Mrv1652304062119472D + + 13 12 0 0 1 0 999 V2000 + 17.6099 -11.1009 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.3268 -10.6926 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8964 -10.6926 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6099 -11.9275 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 19.0369 -11.1009 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.3268 -9.8660 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1829 -11.1009 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4660 -10.6926 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7560 -11.1009 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0390 -10.6926 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7560 -11.9275 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.3290 -11.1009 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0390 -9.8660 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 9 8 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 1 6 0 0 0 + 10 12 1 0 0 0 0 + 10 13 2 0 0 0 0 +M CHG 4 4 1 5 -1 11 1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00683.mol b/src/analysis/thermo/trainingModel/data/mol/C00683.mol new file mode 100644 index 0000000000..e1eae6859a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00683.mol @@ -0,0 +1,118 @@ +C00683 + Mrv1652304062119472D + + 55 57 0 0 1 0 999 V2000 + 12.6770 -19.1400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.3915 -18.7275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1059 -19.1400 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8204 -18.7275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5349 -19.1400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2493 -18.7275 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9638 -19.1400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6783 -18.7275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3927 -19.1400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1072 -18.7275 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8217 -19.1400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5361 -18.7275 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 21.2506 -19.1400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9651 -18.7275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.6795 -19.1400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3915 -17.9026 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9638 -19.9649 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8217 -19.9648 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5361 -17.9025 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2506 -18.3150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2506 -19.9650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5045 -19.1400 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 24.3295 -19.1400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5045 -19.9650 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.6763 -16.2113 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.5013 -16.2113 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.7562 -15.4266 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.0888 -14.9417 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4213 -15.4266 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 21.5338 -15.1739 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1913 -16.8787 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9862 -16.8787 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8112 -16.8787 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8112 -16.0537 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 22.6362 -16.8787 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 21.8112 -17.7037 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9950 -14.3550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9950 -15.1800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4240 -15.1800 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4240 -14.3550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7095 -13.9425 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2806 -13.9425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5660 -14.3550 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5660 -15.1800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2806 -15.5925 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2806 -13.1176 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7019 -15.4287 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5269 -15.4287 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5269 -14.6037 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.3519 -15.4287 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5269 -17.3262 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9527 -18.7217 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2431 -19.1313 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.9528 -17.9026 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6769 -19.9649 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 52 54 2 0 0 0 0 + 1 55 1 1 0 0 0 +M CHG 5 24 -1 34 -1 35 -1 49 -1 53 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00684.mol b/src/analysis/thermo/trainingModel/data/mol/C00684.mol new file mode 100644 index 0000000000..4c14ae6994 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00684.mol @@ -0,0 +1,25 @@ +C00684 + Mrv1652304062119472D + + 10 9 0 0 1 0 999 V2000 + 10.9037 -9.3225 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6182 -9.7350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3327 -9.3225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0471 -9.7350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7616 -9.3225 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.4761 -9.7350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1905 -9.3225 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6182 -10.6425 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3327 -8.4975 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7616 -8.4975 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 5 4 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 2 0 0 0 0 + 3 9 2 0 0 0 0 + 5 10 1 1 0 0 0 +M CHG 1 1 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00689.mol b/src/analysis/thermo/trainingModel/data/mol/C00689.mol new file mode 100644 index 0000000000..4d841e246f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00689.mol @@ -0,0 +1,61 @@ +C00689 + Mrv1652304062119472D + + 27 28 0 0 1 0 999 V2000 + 13.7682 -9.2743 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.3482 -8.6255 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4834 -8.8640 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7682 -10.1023 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.2416 -9.2315 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1947 -9.2743 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4834 -10.5202 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.0568 -10.3483 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5227 -8.8213 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2416 -10.0596 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1947 -10.1023 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.9024 -8.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4871 -11.3407 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8151 -9.2315 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.5227 -10.4774 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.8552 -10.8538 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9061 -10.4234 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6138 -9.2743 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8151 -10.0596 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.1075 -8.8213 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5227 -11.2979 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4268 -9.2743 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1037 -10.4662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3960 -9.2315 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2473 -9.2743 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.4268 -8.4538 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.4658 -10.0911 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 5 2 1 6 0 0 0 + 6 3 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 1 1 0 0 0 + 5 9 1 0 0 0 0 + 10 5 1 0 0 0 0 + 11 6 1 0 0 0 0 + 6 12 1 6 0 0 0 + 7 13 1 6 0 0 0 + 14 9 1 0 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 6 0 0 0 + 11 17 1 1 0 0 0 + 12 18 1 0 0 0 0 + 19 14 1 0 0 0 0 + 14 20 1 1 0 0 0 + 15 21 1 1 0 0 0 + 18 22 1 0 0 0 0 + 19 23 1 6 0 0 0 + 20 24 1 0 0 0 0 + 22 25 1 0 0 0 0 + 22 26 1 0 0 0 0 + 22 27 2 0 0 0 0 + 7 11 1 0 0 0 0 + 15 19 1 0 0 0 0 +M CHG 2 25 -1 26 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00697.mol b/src/analysis/thermo/trainingModel/data/mol/C00697.mol new file mode 100644 index 0000000000..f012aeb84e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00697.mol @@ -0,0 +1,8 @@ +C00697 + Mrv1652304062119472D + + 2 1 0 0 0 0 999 V2000 + 14.3550 -10.0237 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1800 -10.0237 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 3 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00705.mol b/src/analysis/thermo/trainingModel/data/mol/C00705.mol new file mode 100644 index 0000000000..08576ee82c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00705.mol @@ -0,0 +1,55 @@ +C00705 + Mrv1652304062119472D + + 24 25 0 0 1 0 999 V2000 + 18.4115 -10.6109 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6211 -10.8686 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.0302 -11.1608 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5834 -9.8032 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9784 -10.3978 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3805 -11.6762 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8172 -10.8996 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8652 -11.9650 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3636 -9.5421 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3082 -10.8893 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5523 -11.6762 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.9856 -10.0919 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5212 -10.6349 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0642 -12.3361 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7692 -9.8376 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9129 -11.1882 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0915 -11.1882 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2702 -11.1882 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0880 -12.0096 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0880 -10.3668 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4453 -11.1848 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4419 -12.0062 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6239 -11.1848 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4419 -10.3634 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 4 9 2 0 0 0 0 + 10 5 1 0 0 0 0 + 11 6 1 0 0 0 0 + 7 12 2 0 0 0 0 + 10 13 1 1 0 0 0 + 11 14 1 6 0 0 0 + 12 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 17 19 1 0 0 0 0 + 17 20 2 0 0 0 0 + 18 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 9 12 1 0 0 0 0 + 10 11 1 0 0 0 0 +M CHG 2 19 -1 22 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00725.mol b/src/analysis/thermo/trainingModel/data/mol/C00725.mol new file mode 100644 index 0000000000..110138c783 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00725.mol @@ -0,0 +1,30 @@ +C00725 + Mrv1652304062119472D + + 12 12 0 0 0 0 999 V2000 + 18.7628 -6.7239 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9377 -6.7239 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6828 -7.5086 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3502 -7.9935 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0177 -7.5086 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7248 -7.9202 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4393 -7.5077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1538 -7.9202 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8682 -7.5077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5828 -7.9202 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2973 -7.5077 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 22.5828 -8.7453 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 +M CHG 1 11 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00739.mol b/src/analysis/thermo/trainingModel/data/mol/C00739.mol new file mode 100644 index 0000000000..d11560464c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00739.mol @@ -0,0 +1,25 @@ +C00739 + Mrv1652304062119472D + + 10 9 0 0 1 0 999 V2000 + 13.9718 -9.5374 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.6859 -9.1391 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2954 -9.0979 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9958 -10.3648 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.3967 -9.5580 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5744 -9.4997 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.2679 -8.2738 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1178 -9.1562 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8285 -9.5786 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5496 -9.1768 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 +M CHG 3 4 1 6 -1 10 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00740.mol b/src/analysis/thermo/trainingModel/data/mol/C00740.mol new file mode 100644 index 0000000000..6a5525a2b8 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00740.mol @@ -0,0 +1,19 @@ +C00740 + Mrv1652304062119472D + + 7 6 0 0 1 0 999 V2000 + 15.0525 -9.5191 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3761 -9.0795 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7737 -9.1174 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0766 -10.3433 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.6584 -9.4813 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3897 -8.2520 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4845 -9.5397 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 +M CHG 2 4 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00756.mol b/src/analysis/thermo/trainingModel/data/mol/C00756.mol new file mode 100644 index 0000000000..2ff68c80f1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00756.mol @@ -0,0 +1,22 @@ +C00756 + Mrv1652304062119472D + + 9 8 0 0 0 0 999 V2000 + 13.0479 -9.7621 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3325 -9.3512 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7633 -9.3512 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6134 -9.7621 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4824 -9.7621 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8980 -9.3512 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1978 -9.3512 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1826 -9.7621 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9132 -9.7621 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00785.mol b/src/analysis/thermo/trainingModel/data/mol/C00785.mol new file mode 100644 index 0000000000..d0fd41b08b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00785.mol @@ -0,0 +1,26 @@ +C00785 + Mrv1652304062119472D + + 10 10 0 0 0 0 999 V2000 + 10.5104 -9.7368 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7649 -10.5216 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5899 -10.5221 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8453 -9.7376 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1781 -9.2523 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3059 -10.9314 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0204 -10.5189 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7349 -10.9314 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4494 -10.5189 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7349 -11.7565 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 6 3 1 4 0 0 0 + 6 7 2 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00791.mol b/src/analysis/thermo/trainingModel/data/mol/C00791.mol new file mode 100644 index 0000000000..46f59517bb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00791.mol @@ -0,0 +1,21 @@ +C00791 + Mrv1652304062119472D + + 8 8 0 0 0 0 999 V2000 + 12.5411 -11.7567 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3660 -11.7567 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6209 -10.9721 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9535 -10.4872 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2861 -10.9721 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0562 -12.4241 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3985 -10.7194 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9535 -9.6531 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 1 6 2 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00794.mol b/src/analysis/thermo/trainingModel/data/mol/C00794.mol new file mode 100644 index 0000000000..72e0fe1fc6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00794.mol @@ -0,0 +1,28 @@ +C00794 + Mrv1652304062119472D + + 12 11 0 0 1 0 999 V2000 + 12.2103 -4.4138 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9247 -4.0013 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6393 -4.4138 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3537 -4.0013 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.0682 -4.4138 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7827 -4.0013 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.4972 -4.4138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2116 -4.0013 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6393 -5.2387 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3537 -3.1763 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0682 -5.2388 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7827 -3.1765 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 3 9 1 1 0 0 0 + 4 10 1 1 0 0 0 + 5 11 1 1 0 0 0 + 6 12 1 6 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00795.mol b/src/analysis/thermo/trainingModel/data/mol/C00795.mol new file mode 100644 index 0000000000..3675a1747d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00795.mol @@ -0,0 +1,29 @@ +C00795 + Mrv1652304062119472D + + 12 12 0 0 1 0 999 V2000 + 15.6153 -8.6235 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 15.6153 -9.4485 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.9156 -8.2058 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3324 -8.2058 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4334 -9.0795 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9156 -9.8558 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.3324 -9.8558 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1950 -8.6235 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0460 -8.6235 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1950 -9.4485 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9156 -10.6808 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4814 -9.8558 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 1 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 0 0 0 0 + 6 11 1 1 0 0 0 + 10 12 1 6 0 0 0 + 10 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00798.mol b/src/analysis/thermo/trainingModel/data/mol/C00798.mol new file mode 100644 index 0000000000..708f2c64f9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00798.mol @@ -0,0 +1,108 @@ +C00798 + Mrv1652304062119472D + + 50 52 0 0 1 0 999 V2000 + 17.7227 -18.3975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4372 -18.8100 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1516 -18.3975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8661 -18.8100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5806 -18.3975 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2950 -18.8100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0095 -18.3975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7240 -18.8100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.4385 -18.3975 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1529 -18.8100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.8674 -18.3975 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.5819 -18.8100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.2963 -18.3975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.0108 -18.8100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7227 -17.5726 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2950 -19.6349 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1529 -19.6348 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.8674 -17.5725 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.5819 -17.9850 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.5819 -19.6350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8358 -18.8100 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 28.6608 -18.8100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8358 -19.6350 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.0075 -15.8813 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.8325 -15.8813 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.0874 -15.0966 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.4200 -14.6117 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.7526 -15.0966 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.8650 -14.8439 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5226 -16.5487 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3174 -16.5487 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1424 -16.5487 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1424 -15.7237 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 26.9674 -16.5487 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 26.1424 -17.3737 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3263 -14.0250 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3263 -14.8500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7552 -14.8500 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7552 -14.0250 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0407 -13.6125 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6118 -13.6125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8973 -14.0250 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8973 -14.8500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6118 -15.2625 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6118 -12.7876 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.0332 -15.0987 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8582 -15.0987 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8582 -14.2737 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 28.6832 -15.0987 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8582 -16.9962 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 11 10 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 1 15 2 0 0 0 0 + 6 16 2 0 0 0 0 + 10 17 2 0 0 0 0 + 11 18 1 6 0 0 0 + 12 19 1 0 0 0 0 + 12 20 1 0 0 0 0 + 14 21 1 0 0 0 0 + 21 22 2 0 0 0 0 + 21 23 1 0 0 0 0 + 24 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 28 27 1 0 0 0 0 + 24 28 1 0 0 0 0 + 26 29 1 6 0 0 0 + 24 30 1 1 0 0 0 + 25 31 1 1 0 0 0 + 31 32 1 0 0 0 0 + 32 33 1 0 0 0 0 + 32 34 1 0 0 0 0 + 32 35 2 0 0 0 0 + 36 37 1 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 2 0 0 0 0 + 36 40 1 0 0 0 0 + 36 41 2 0 0 0 0 + 41 42 1 0 0 0 0 + 42 43 2 0 0 0 0 + 43 44 1 0 0 0 0 + 37 44 2 0 0 0 0 + 41 45 1 0 0 0 0 + 28 38 1 6 0 0 0 + 29 46 1 0 0 0 0 + 46 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 47 49 2 0 0 0 0 + 47 50 1 0 0 0 0 + 21 50 1 0 0 0 0 +M CHG 4 23 -1 33 -1 34 -1 48 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00810.mol b/src/analysis/thermo/trainingModel/data/mol/C00810.mol new file mode 100644 index 0000000000..c751bfd330 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00810.mol @@ -0,0 +1,16 @@ +C00810 + Mrv1652304062119472D + + 6 5 0 0 1 0 999 V2000 + 10.6840 -12.7465 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3985 -12.3340 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1130 -12.7465 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.8274 -12.3340 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3985 -11.5091 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1130 -13.5714 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00828.mol b/src/analysis/thermo/trainingModel/data/mol/C00828.mol new file mode 100644 index 0000000000..e154091302 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00828.mol @@ -0,0 +1,59 @@ +C00828 + + + 23 24 0 0 0 0 0 0 0 0999 V2000 + 18.3400 -16.5200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3400 -15.1200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5300 -14.4200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7900 -15.1200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7900 -16.5200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5300 -17.2200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9800 -14.4200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1700 -15.1200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1700 -16.5200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9800 -17.2200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9800 -18.6200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9800 -13.0200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.3600 -14.4200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.6200 -15.1200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8100 -14.4200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.0000 -15.1200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.2600 -14.4200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.4500 -15.1200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.6400 -14.4200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.9000 -15.1200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8100 -13.0200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.6400 -13.0200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.3600 -17.2200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 + 2 3 1 0 0 0 + 3 4 2 0 0 0 + 4 5 1 0 0 0 + 5 6 2 0 0 0 + 1 6 1 0 0 0 + 4 7 1 0 0 0 + 7 8 1 0 0 0 + 8 9 2 0 0 0 + 9 10 1 0 0 0 + 5 10 1 0 0 0 + 10 11 2 0 0 0 + 7 12 2 0 0 0 + 8 13 1 0 0 0 + 13 14 1 0 0 0 + 14 15 2 0 0 0 + 15 16 1 0 0 0 + 16 17 1 0 0 0 + 17 18 1 0 0 0 + 18 19 2 0 0 0 + 19 20 1 0 0 0 + 15 21 1 0 0 0 + 19 22 1 0 0 0 + 9 23 1 0 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 5 13 14 15 16 21 +M SDI 1 4 24.1500 -15.5400 24.1500 -12.8100 +M SDI 1 4 28.7700 -12.8100 28.7700 -15.5400 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C00835.mol b/src/analysis/thermo/trainingModel/data/mol/C00835.mol new file mode 100644 index 0000000000..1dc205c12a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00835.mol @@ -0,0 +1,40 @@ +C00835 + Mrv1652304062119472D + + 17 18 0 0 1 0 999 V2000 + 13.9861 -10.7099 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9861 -9.8828 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7086 -11.1289 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2671 -11.1289 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7017 -9.4645 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2671 -9.4749 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4310 -10.7175 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5584 -10.7099 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4276 -9.8794 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5584 -9.8828 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2636 -8.6582 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8504 -11.1186 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1287 -9.4680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8409 -9.8725 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.1287 -8.6513 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5454 -9.4645 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8443 -10.6927 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 2 0 0 0 0 + 6 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 8 12 1 0 0 0 0 + 9 13 1 0 0 0 0 + 14 13 1 0 0 0 0 + 13 15 2 0 0 0 0 + 14 16 1 0 0 0 0 + 14 17 1 6 0 0 0 + 7 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00842.mol b/src/analysis/thermo/trainingModel/data/mol/C00842.mol new file mode 100644 index 0000000000..df57bf83be --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00842.mol @@ -0,0 +1,80 @@ +C00842 + Mrv1652304062119472D + + 36 38 0 0 1 0 999 V2000 + 19.7620 -13.2391 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.1986 -12.0201 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0948 -12.7606 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5070 -14.0251 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4860 -11.5975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9216 -11.5975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4312 -13.2391 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.6862 -14.0251 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.4860 -10.7661 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7735 -12.0062 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9216 -10.7661 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6557 -12.9806 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2006 -14.6887 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1986 -10.3505 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6271 -10.3505 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0375 -13.5256 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1986 -9.5332 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2167 -13.5256 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3958 -13.5256 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2132 -14.3464 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2167 -12.7012 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5750 -13.5256 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7541 -13.5290 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5750 -14.3464 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5750 -12.7012 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0416 -13.9447 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.3220 -13.5290 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0416 -14.7761 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.6096 -13.9447 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.3220 -15.1917 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.7541 -15.1813 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6096 -14.7761 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.8970 -13.5290 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3186 -16.0194 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8970 -15.1813 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8970 -12.7117 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 8 4 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 1 0 0 0 + 8 13 1 6 0 0 0 + 9 14 1 0 0 0 0 + 11 15 1 0 0 0 0 + 12 16 1 0 0 0 0 + 14 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 26 27 1 0 0 0 0 + 28 26 1 0 0 0 0 + 29 27 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 1 6 0 0 0 + 32 29 1 0 0 0 0 + 29 33 1 1 0 0 0 + 30 34 1 1 0 0 0 + 32 35 1 6 0 0 0 + 33 36 1 0 0 0 0 + 7 8 1 0 0 0 0 + 11 14 1 0 0 0 0 + 30 32 1 0 0 0 0 +M CHG 2 20 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00849.mol b/src/analysis/thermo/trainingModel/data/mol/C00849.mol new file mode 100644 index 0000000000..eb9c653caa --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00849.mol @@ -0,0 +1,16 @@ +C00849 + Mrv1652304062119472D + + 6 5 0 0 0 0 999 V2000 + 11.6246 -10.1456 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3378 -9.7309 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0511 -10.1415 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7644 -9.7269 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4776 -10.1374 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7626 -8.9015 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 6 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00854.mol b/src/analysis/thermo/trainingModel/data/mol/C00854.mol new file mode 100644 index 0000000000..f568c1c985 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00854.mol @@ -0,0 +1,19 @@ +C00854 + Mrv1652304062119472D + + 7 7 0 0 0 0 999 V2000 + 16.1857 -10.4933 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4702 -10.9007 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8977 -10.9007 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1890 -9.6683 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4702 -11.7258 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8977 -11.7258 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1857 -12.1366 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00861.mol b/src/analysis/thermo/trainingModel/data/mol/C00861.mol new file mode 100644 index 0000000000..9309bef5ee --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00861.mol @@ -0,0 +1,26 @@ +C00861 + Mrv1652304062119472D + + 11 10 0 0 1 0 999 V2000 + 13.0353 -11.0552 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7498 -10.6427 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4643 -11.0552 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1787 -10.6427 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.8932 -11.0552 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.6077 -10.6427 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.3222 -11.0552 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4643 -11.8801 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1787 -9.8177 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8932 -11.8802 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6077 -9.8179 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 5 4 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 6 0 0 0 + 6 11 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00864.mol b/src/analysis/thermo/trainingModel/data/mol/C00864.mol new file mode 100644 index 0000000000..1b7510386f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00864.mol @@ -0,0 +1,35 @@ +C00864 + Mrv1652304062119472D + + 15 14 0 0 1 0 999 V2000 + 14.0459 -8.9345 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.3279 -9.3467 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7604 -9.3467 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0459 -8.1100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6134 -8.9345 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6134 -9.7624 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0459 -9.7624 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4715 -8.9345 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7604 -10.1713 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8954 -9.3467 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1895 -9.3467 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9042 -8.9345 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6186 -9.3467 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3366 -8.9345 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.6186 -10.1713 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 3 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 8 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 2 0 0 0 0 +M CHG 1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00876.mol b/src/analysis/thermo/trainingModel/data/mol/C00876.mol new file mode 100644 index 0000000000..f2166229cc --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00876.mol @@ -0,0 +1,114 @@ +C00876 + Mrv1652304062119472D + + 53 55 0 0 1 0 999 V2000 + 12.9350 -12.0488 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9350 -12.8744 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6518 -13.2873 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6518 -11.6359 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3644 -12.0488 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3610 -12.8744 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0742 -13.2903 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0812 -11.6390 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7945 -12.0550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7870 -12.8784 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4965 -13.2966 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2546 -12.8913 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2209 -12.0678 0.0000 N 0 5 0 0 0 0 0 0 0 0 0 0 + 16.5115 -11.6496 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2202 -13.2877 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5189 -10.8241 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9247 -13.3107 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0550 -14.1044 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7696 -14.5167 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7699 -15.3417 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.4845 -15.7540 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.4848 -16.5791 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1994 -16.9913 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4736 -14.1099 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2091 -15.3352 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0451 -15.7606 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0244 -16.9913 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8494 -16.9913 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0244 -16.1670 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0244 -17.8170 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.5642 -16.5796 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.2788 -16.9920 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9932 -16.5796 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7077 -16.9920 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 22.4222 -16.5796 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1367 -16.9920 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8512 -16.5796 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.5656 -16.9920 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 25.2801 -16.5796 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.9946 -16.9920 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7028 -16.5832 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4040 -16.9881 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5646 -15.7546 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2788 -17.8168 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8512 -15.7546 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.2801 -15.7545 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.5692 -15.3440 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.9982 -15.3398 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.4042 -17.8168 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.0954 -16.5892 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 21.7077 -17.8169 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0066 -18.2215 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4196 -18.2280 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 2 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 9 1 0 0 0 0 + 5 6 2 0 0 0 0 + 2 15 1 0 0 0 0 + 6 7 1 0 0 0 0 + 14 16 2 0 0 0 0 + 7 10 1 0 0 0 0 + 12 17 2 0 0 0 0 + 9 8 2 0 0 0 0 + 8 5 1 0 0 0 0 + 5 4 1 0 0 0 0 + 4 1 2 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 2 0 0 0 0 + 3 6 1 0 0 0 0 + 7 18 1 0 0 0 0 + 19 18 1 0 0 0 0 + 20 19 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 19 24 1 6 0 0 0 + 21 25 1 6 0 0 0 + 20 26 1 1 0 0 0 + 23 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 27 29 2 0 0 0 0 + 27 30 1 0 0 0 0 + 31 28 1 0 0 0 0 + 31 32 1 0 0 0 0 + 32 33 1 0 0 0 0 + 34 33 1 1 0 0 0 + 34 35 1 0 0 0 0 + 35 36 1 0 0 0 0 + 36 37 1 0 0 0 0 + 37 38 1 0 0 0 0 + 39 38 1 6 0 0 0 + 39 40 1 0 0 0 0 + 40 41 1 0 0 0 0 + 41 42 1 0 0 0 0 + 31 43 1 1 0 0 0 + 32 44 2 0 0 0 0 + 37 45 2 0 0 0 0 + 39 46 1 0 0 0 0 + 46 47 2 0 0 0 0 + 46 48 1 0 0 0 0 + 42 49 2 0 0 0 0 + 42 50 1 0 0 0 0 + 34 51 1 0 0 0 0 + 51 52 2 0 0 0 0 + 51 53 1 0 0 0 0 +M CHG 5 13 -1 30 -1 48 -1 50 -1 53 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00877.mol b/src/analysis/thermo/trainingModel/data/mol/C00877.mol new file mode 100644 index 0000000000..86503a3197 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00877.mol @@ -0,0 +1,114 @@ +C00877 + Mrv1652304062119472D + + 53 55 0 0 1 0 999 V2000 + 17.4620 -17.5725 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1765 -17.1600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8909 -17.5725 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6054 -17.1600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3199 -17.5725 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0343 -17.1600 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7488 -17.5725 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4633 -17.1600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1777 -17.5725 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8922 -17.1600 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.6067 -17.5725 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3211 -17.1600 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.0356 -17.5725 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7501 -17.1600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4645 -17.5725 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1765 -16.3351 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7488 -18.3974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.6067 -18.3973 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3211 -16.3350 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0356 -16.7475 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0356 -18.3975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2895 -17.5725 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 29.1145 -17.5725 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2895 -18.3975 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.4613 -14.6438 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 25.2863 -14.6438 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.5412 -13.8591 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.8738 -13.3742 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.2063 -13.8591 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.3188 -13.6064 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9763 -15.3112 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.7712 -15.3112 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5962 -15.3112 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5962 -14.4862 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.4212 -15.3112 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 26.5962 -16.1362 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7800 -12.7875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7800 -13.6125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2090 -13.6125 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2090 -12.7875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4945 -12.3750 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0656 -12.3750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3510 -12.7875 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3510 -13.6125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0656 -14.0250 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0656 -11.5501 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4869 -13.8612 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3119 -13.8612 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3119 -13.0362 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 29.1369 -13.8612 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3119 -15.7587 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7377 -17.1542 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0281 -17.5638 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 2 0 0 0 0 + 52 53 1 0 0 0 0 +M CHG 4 24 -1 34 -1 35 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00882.mol b/src/analysis/thermo/trainingModel/data/mol/C00882.mol new file mode 100644 index 0000000000..0d8f83bbf7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00882.mol @@ -0,0 +1,96 @@ +C00882 + Mrv1652304062119472D + + 44 46 0 0 1 0 999 V2000 + 17.8217 -10.4300 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4160 -10.4300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5043 -11.8358 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.8217 -9.6138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4160 -9.6138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6904 -10.8382 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8241 -11.3823 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2322 -12.6067 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.0962 -9.2056 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6904 -9.2056 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9648 -10.4300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1439 -11.8358 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.4160 -12.6067 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.7311 -13.2870 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9648 -9.6138 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6904 -8.3894 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3730 -11.6091 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0078 -13.1963 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4660 -12.1079 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5590 -12.1079 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5590 -13.6044 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5590 -11.2916 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.7428 -12.1079 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5590 -15.1009 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4207 -15.1009 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5590 -16.0985 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.7428 -15.1009 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1009 -14.6927 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8264 -15.1009 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5067 -14.6927 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.2322 -15.1009 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5067 -13.8765 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9578 -14.6927 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2322 -15.9171 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6380 -15.1009 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3636 -14.6927 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0891 -15.1009 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7694 -14.6927 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0891 -15.9171 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4949 -15.1009 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1752 -14.6927 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.9007 -15.1009 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1916 -15.7811 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4613 -15.7811 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 25 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 30 29 1 0 0 0 0 + 30 31 1 0 0 0 0 + 30 32 1 1 0 0 0 + 31 33 1 0 0 0 0 + 31 34 2 0 0 0 0 + 33 35 1 0 0 0 0 + 35 36 1 0 0 0 0 + 36 37 1 0 0 0 0 + 37 38 1 0 0 0 0 + 37 39 2 0 0 0 0 + 38 40 1 0 0 0 0 + 40 41 1 0 0 0 0 + 41 42 1 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 2 0 0 0 0 + 13 12 1 0 0 0 0 + 29 43 1 0 0 0 0 + 29 44 1 0 0 0 0 +M CHG 2 22 -1 26 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00885.mol b/src/analysis/thermo/trainingModel/data/mol/C00885.mol new file mode 100644 index 0000000000..305c08f31c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00885.mol @@ -0,0 +1,38 @@ +C00885 + Mrv1652304062119472D + + 16 16 0 0 1 0 999 V2000 + 16.2303 -10.8128 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.2303 -9.9814 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.5085 -11.2322 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5085 -9.5695 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9408 -9.5695 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7981 -10.8128 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7981 -9.9814 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5047 -8.8731 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2190 -8.4613 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.7905 -8.4649 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9649 -11.2353 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6636 -10.8303 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3696 -11.2365 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0693 -10.8310 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.3711 -12.0696 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6622 -10.1685 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 6 0 0 0 + 3 6 2 0 0 0 0 + 4 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 + 6 7 1 0 0 0 0 + 1 11 1 1 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 2 0 0 0 0 + 12 16 2 0 0 0 0 +M CHG 2 9 -1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00887.mol b/src/analysis/thermo/trainingModel/data/mol/C00887.mol new file mode 100644 index 0000000000..1a351dd5f5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00887.mol @@ -0,0 +1,11 @@ +C00887 + Mrv1652304062119472D + + 3 2 0 0 0 0 999 V2000 + 14.7846 -10.0271 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.9337 -10.0237 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5837 -10.0237 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 3 0 0 0 0 + 1 3 1 0 0 0 0 +M CHG 2 1 1 3 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00905.mol b/src/analysis/thermo/trainingModel/data/mol/C00905.mol new file mode 100644 index 0000000000..282005dc98 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00905.mol @@ -0,0 +1,32 @@ +C00905 + Mrv1652304062119472D + + 13 13 0 0 1 0 999 V2000 + 15.8168 -9.2297 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 15.5680 -9.9930 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.1329 -8.7359 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3969 -8.6426 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5696 -9.5061 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7358 -9.9930 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.0516 -10.6664 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4699 -9.2124 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.1498 -8.9879 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2522 -10.6698 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6825 -8.9708 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1851 -9.6304 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.6720 -8.0797 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 1 0 0 0 + 8 3 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 6 0 0 0 + 8 11 1 1 0 0 0 + 11 12 1 0 0 0 0 + 11 13 2 0 0 0 0 + 6 8 1 0 0 0 0 +M CHG 1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00920.mol b/src/analysis/thermo/trainingModel/data/mol/C00920.mol new file mode 100644 index 0000000000..7bc614dc0b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00920.mol @@ -0,0 +1,144 @@ +C00920 + Mrv1652304062119472D + + 68 70 0 0 1 0 999 V2000 + 15.2818 -18.5626 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9939 -18.9792 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.2928 -17.8243 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7072 -18.5737 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9872 -19.8461 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 17.4142 -18.9902 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1326 -18.5847 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8396 -19.0013 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1383 -17.8464 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7365 -18.5972 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.4434 -19.0138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7100 -17.6203 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2969 -18.4172 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4366 -19.8807 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0980 -19.0835 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8109 -18.7226 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8169 -17.9449 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 23.5231 -19.1446 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4982 -19.0043 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.8581 -10.7867 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2489 -12.2621 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.4219 -10.7867 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8581 -9.9539 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5708 -11.7710 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9979 -13.0309 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.4219 -9.9539 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7012 -11.2085 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1374 -9.5374 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8981 -12.2462 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.1597 -13.0309 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4837 -13.6983 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7012 -9.5427 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9858 -10.7867 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1292 -12.0058 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7379 -13.6236 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9858 -9.9539 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6958 -8.8543 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9581 -12.6734 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8623 -13.6182 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6447 -12.6896 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8817 -12.7888 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.0614 -13.6396 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.8568 -14.4458 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6447 -14.4301 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6555 -11.7228 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.8225 -12.6734 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6501 -16.1066 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5097 -16.0905 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6394 -17.0782 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.8225 -16.0905 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2197 -15.6794 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9298 -16.0905 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6400 -15.6794 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9191 -16.8665 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9138 -15.2863 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3553 -16.0905 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6400 -14.9019 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0654 -15.6794 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3553 -16.9574 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7809 -16.0905 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4910 -15.6794 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2063 -16.0905 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9164 -15.6794 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2063 -16.9574 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6265 -16.0905 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3419 -15.6794 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0520 -16.0905 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0520 -16.9866 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 2 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 6 0 0 0 + 4 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 10 8 1 1 0 0 0 + 10 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 11 14 2 0 0 0 0 + 13 15 1 0 0 0 0 + 15 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 16 18 2 0 0 0 0 + 1 19 1 0 0 0 0 + 21 20 1 1 0 0 0 + 20 22 1 0 0 0 0 + 20 23 1 0 0 0 0 + 21 24 1 0 0 0 0 + 25 21 1 0 0 0 0 + 22 26 1 0 0 0 0 + 22 27 2 0 0 0 0 + 23 28 2 0 0 0 0 + 29 24 1 0 0 0 0 + 25 30 1 0 0 0 0 + 25 31 1 6 0 0 0 + 26 32 2 0 0 0 0 + 27 33 1 0 0 0 0 + 29 34 1 1 0 0 0 + 30 35 1 6 0 0 0 + 32 36 1 0 0 0 0 + 32 37 1 0 0 0 0 + 34 38 1 0 0 0 0 + 35 39 1 0 0 0 0 + 38 40 1 0 0 0 0 + 39 41 1 0 0 0 0 + 39 42 1 0 0 0 0 + 39 43 2 0 0 0 0 + 40 44 1 0 0 0 0 + 40 45 1 0 0 0 0 + 40 46 2 0 0 0 0 + 44 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 47 49 1 0 0 0 0 + 47 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 51 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 52 54 1 0 0 0 0 + 52 55 1 0 0 0 0 + 53 56 1 0 0 0 0 + 53 57 1 0 0 0 0 + 56 58 1 0 0 0 0 + 56 59 2 0 0 0 0 + 58 60 1 0 0 0 0 + 60 61 1 0 0 0 0 + 61 62 1 0 0 0 0 + 62 63 1 0 0 0 0 + 62 64 2 0 0 0 0 + 63 65 1 0 0 0 0 + 65 66 1 0 0 0 0 + 66 67 1 0 0 0 0 + 26 28 1 0 0 0 0 + 30 29 1 0 0 0 0 + 33 36 2 0 0 0 0 + 67 68 1 0 0 0 0 + 12 68 1 0 0 0 0 +M CHG 7 5 1 17 -1 19 -1 41 -1 42 -1 45 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00922.mol b/src/analysis/thermo/trainingModel/data/mol/C00922.mol new file mode 100644 index 0000000000..e33136a62e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00922.mol @@ -0,0 +1,25 @@ +C00922 + Mrv1652304062119472D + + 10 9 0 0 0 0 999 V2000 + 10.0240 -10.3127 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7384 -9.9002 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4530 -10.3127 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1674 -9.9002 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7384 -9.0753 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3095 -9.9002 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.0240 -11.1377 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4530 -11.1376 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1785 -11.5566 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.7496 -11.5438 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 2 0 0 0 0 + 3 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 1 6 1 0 0 0 0 + 1 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 2 6 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00935.mol b/src/analysis/thermo/trainingModel/data/mol/C00935.mol new file mode 100644 index 0000000000..9edefe0910 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00935.mol @@ -0,0 +1,76 @@ +C00935 + Mrv1652304062119472D + + 34 36 0 0 1 0 999 V2000 + 19.1172 -16.8880 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8431 -15.6398 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4415 -16.3974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8719 -17.6581 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.1335 -15.2132 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5640 -15.2132 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7885 -16.8729 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.0529 -17.6581 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.3588 -18.3225 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1335 -14.3828 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5042 -15.5789 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5640 -14.3828 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0072 -16.6239 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5734 -18.3225 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8468 -13.9752 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8298 -15.8199 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8431 -13.3207 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0069 -15.8199 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1878 -15.8199 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9687 -14.9127 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.0069 -16.6389 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3650 -15.8199 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5232 -15.8274 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3650 -14.9127 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3650 -16.6389 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7230 -15.8160 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.3115 -16.5332 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.3153 -15.0951 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4924 -16.5369 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.7230 -17.2429 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4811 -15.1027 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0698 -15.8236 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.0428 -17.2926 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2506 -15.8274 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 27 26 1 0 0 0 0 + 26 28 1 0 0 0 0 + 27 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 28 31 1 0 0 0 0 + 29 32 1 0 0 0 0 + 29 33 1 1 0 0 0 + 32 34 1 1 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 + 32 31 1 0 0 0 0 +M CHG 2 20 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00940.mol b/src/analysis/thermo/trainingModel/data/mol/C00940.mol new file mode 100644 index 0000000000..33c2124ebe --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00940.mol @@ -0,0 +1,25 @@ +C00940 + Mrv1652304062119472D + + 10 9 0 0 0 0 999 V2000 + 6.8889 -11.9628 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.6034 -11.5503 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3179 -11.9628 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0324 -11.5503 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7468 -11.9628 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4613 -11.5503 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1758 -11.9628 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6034 -10.7254 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4613 -10.7254 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3179 -12.7877 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 2 0 0 0 0 + 6 9 2 0 0 0 0 + 3 10 2 0 0 0 0 +M CHG 1 1 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00944.mol b/src/analysis/thermo/trainingModel/data/mol/C00944.mol new file mode 100644 index 0000000000..ec251ed309 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00944.mol @@ -0,0 +1,32 @@ +C00944 + Mrv1652304062119472D + + 13 13 0 0 1 0 999 V2000 + 13.6607 -10.2020 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4406 -10.4582 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9411 -10.6240 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6607 -9.3770 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6344 -11.2840 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9423 -11.3447 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.0472 -9.9083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2328 -10.2059 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.9374 -8.9700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2328 -9.3770 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5207 -10.6929 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9374 -8.3166 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5207 -8.9663 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 6 0 0 0 + 2 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 1 1 0 0 0 + 9 12 2 0 0 0 0 + 10 13 1 6 0 0 0 + 10 9 1 0 0 0 0 +M CHG 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00951.mol b/src/analysis/thermo/trainingModel/data/mol/C00951.mol new file mode 100644 index 0000000000..00e345e870 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00951.mol @@ -0,0 +1,48 @@ +C00951 + Mrv1652304062119472D + + 20 23 0 0 1 0 999 V2000 + 18.0497 -10.1977 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.3343 -10.6086 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.0532 -9.3763 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.5119 -10.2154 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6226 -10.1871 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.3343 -11.4336 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3485 -8.9584 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7720 -8.9725 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.0497 -8.5511 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4803 -9.3939 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9038 -10.6015 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6296 -9.3655 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6155 -11.8408 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7685 -8.1440 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9003 -11.4265 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1886 -10.1871 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1886 -11.8372 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4768 -10.6015 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5156 -11.4265 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7544 -11.8372 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 3 9 1 1 0 0 0 + 4 10 1 0 0 0 0 + 5 11 1 1 0 0 0 + 5 12 1 0 0 0 0 + 6 13 1 0 0 0 0 + 8 14 1 1 0 0 0 + 11 15 2 0 0 0 0 + 11 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 16 18 2 0 0 0 0 + 17 19 2 0 0 0 0 + 19 20 1 0 0 0 0 + 7 12 1 0 0 0 0 + 8 10 1 0 0 0 0 + 13 15 1 0 0 0 0 + 18 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00956.mol b/src/analysis/thermo/trainingModel/data/mol/C00956.mol new file mode 100644 index 0000000000..a538ee7345 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00956.mol @@ -0,0 +1,27 @@ +C00956 + Mrv1652304062119472D + + 11 10 0 0 1 0 999 V2000 + 14.7462 -12.8268 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0325 -12.4130 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4636 -12.4130 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3188 -12.8268 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1774 -12.8268 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8911 -12.4130 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6048 -12.8308 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.8911 -11.6718 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6093 -12.4190 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.3204 -13.6440 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0326 -11.6017 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 + 4 9 1 0 0 0 0 + 4 10 2 0 0 0 0 + 2 11 1 1 0 0 0 +M CHG 3 7 -1 9 -1 11 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00966.mol b/src/analysis/thermo/trainingModel/data/mol/C00966.mol new file mode 100644 index 0000000000..858b3f6453 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00966.mol @@ -0,0 +1,25 @@ +C00966 + Mrv1652304062119472D + + 10 9 0 0 0 0 999 V2000 + 10.6972 -8.2502 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4117 -8.6627 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1262 -8.2502 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8406 -8.6627 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5552 -8.2502 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2696 -8.6627 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.8406 -9.4876 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5552 -7.4253 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6683 -7.5843 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6245 -7.5964 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 4 7 2 0 0 0 0 + 5 8 2 0 0 0 0 + 3 9 1 0 0 0 0 + 3 10 1 0 0 0 0 +M CHG 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00975.mol b/src/analysis/thermo/trainingModel/data/mol/C00975.mol new file mode 100644 index 0000000000..b5dae07725 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00975.mol @@ -0,0 +1,25 @@ +C00975 + Mrv1652304062119472D + + 10 9 0 0 0 0 999 V2000 + 12.6259 -9.5323 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4537 -9.5323 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2159 -8.8185 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1746 -10.2873 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8674 -10.2460 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8674 -8.8597 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6298 -8.1459 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.3883 -8.8185 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4085 -11.0011 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.6913 -10.2460 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 +M CHG 2 7 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00979.mol b/src/analysis/thermo/trainingModel/data/mol/C00979.mol new file mode 100644 index 0000000000..a9f156348d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00979.mol @@ -0,0 +1,25 @@ +C00979 + Mrv1652304062119472D + + 10 9 0 0 1 0 999 V2000 + 15.5474 -10.2274 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.2594 -9.8099 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8340 -9.8216 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5543 -11.0495 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.9762 -10.2176 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1238 -10.2360 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.8290 -8.9963 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6830 -9.8014 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5072 -10.2702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6795 -8.9812 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 2 4 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00986.mol b/src/analysis/thermo/trainingModel/data/mol/C00986.mol new file mode 100644 index 0000000000..b53a969210 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00986.mol @@ -0,0 +1,15 @@ +C00986 + Mrv1652304062119472D + + 5 4 0 0 0 0 999 V2000 + 13.0606 -9.7558 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3469 -9.3421 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7743 -9.3421 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6294 -9.7558 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.4919 -9.7558 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 +M CHG 2 4 1 5 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C00989.mol b/src/analysis/thermo/trainingModel/data/mol/C00989.mol new file mode 100644 index 0000000000..f102178fde --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C00989.mol @@ -0,0 +1,19 @@ +C00989 + Mrv1652304062119472D + + 7 6 0 0 0 0 999 V2000 + 17.2083 -10.2825 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8881 -9.8576 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4435 -9.9001 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6530 -10.2400 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.8881 -8.9653 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7637 -10.3675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9989 -9.9426 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 6 7 1 0 0 0 0 +M CHG 1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01003.mol b/src/analysis/thermo/trainingModel/data/mol/C01003.mol new file mode 100644 index 0000000000..4d2d5e2603 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01003.mol @@ -0,0 +1,26 @@ +C01003 + + + 11 10 0 0 1 0 0 0 0 0999 V2000 + 27.7646 -22.0083 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.5482 -22.7126 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.7646 -20.6115 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 28.9695 -22.7126 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3376 -22.0083 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5482 -24.1153 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5482 -19.9130 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.1802 -22.0083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1270 -22.7126 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5482 -18.5161 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3376 -20.6115 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 1 0 0 + 1 4 1 0 0 0 + 2 5 1 0 0 0 + 2 6 2 0 0 0 + 3 7 1 0 0 0 + 4 8 1 0 0 0 + 5 9 1 0 0 0 + 7 10 2 0 0 0 + 7 11 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C01005.mol b/src/analysis/thermo/trainingModel/data/mol/C01005.mol new file mode 100644 index 0000000000..5beb8accd6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01005.mol @@ -0,0 +1,27 @@ +C01005 + Mrv1652304062119482D + + 11 10 0 0 1 0 999 V2000 + 9.9415 -12.2103 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.6559 -11.7978 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3705 -12.2103 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.0849 -11.7978 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7994 -12.2103 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6559 -10.9729 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3705 -13.0352 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.6244 -12.2103 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4494 -12.2103 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.6244 -11.3853 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6244 -13.0352 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 6 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 + 8 11 1 0 0 0 0 +M CHG 4 1 -1 7 1 9 -1 11 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01013.mol b/src/analysis/thermo/trainingModel/data/mol/C01013.mol new file mode 100644 index 0000000000..520732225d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01013.mol @@ -0,0 +1,17 @@ +C01013 + Mrv1652304062119482D + + 6 5 0 0 0 0 999 V2000 + 13.0589 -10.1762 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7725 -9.7624 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3415 -9.7624 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4862 -10.1762 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7687 -8.9349 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6278 -10.1762 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 +M CHG 1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01019.mol b/src/analysis/thermo/trainingModel/data/mol/C01019.mol new file mode 100644 index 0000000000..1d96935c68 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01019.mol @@ -0,0 +1,27 @@ +C01019 + Mrv1652304062119482D + + 11 11 0 0 1 0 999 V2000 + 15.0995 -9.7555 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3879 -9.3395 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.8179 -9.3395 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1029 -10.5805 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3879 -8.5145 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.6763 -9.7555 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8179 -8.5145 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 16.5330 -9.7555 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0995 -8.1020 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6763 -8.1053 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5330 -8.1020 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 1 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 7 11 1 4 0 0 0 + 7 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01041.mol b/src/analysis/thermo/trainingModel/data/mol/C01041.mol new file mode 100644 index 0000000000..cd82986246 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01041.mol @@ -0,0 +1,30 @@ +C01041 + OpenBabel04062119392D + + 12 12 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 7 1 0 0 0 0 + 2 1 1 1 0 0 0 + 2 8 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 5 1 0 0 0 0 + 3 9 1 0 0 0 0 + 4 6 1 0 0 0 0 + 4 10 1 0 0 0 0 + 5 2 1 1 0 0 0 + 5 12 1 0 0 0 0 + 6 11 2 0 0 0 0 + 6 12 1 0 0 0 0 +M RAD 1 9 2 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01080.mol b/src/analysis/thermo/trainingModel/data/mol/C01080.mol new file mode 100644 index 0000000000..0508c3728e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01080.mol @@ -0,0 +1,114 @@ +C01080 + Mrv1652304062119482D + + 53 55 0 0 1 0 999 V2000 + 12.9555 -12.0879 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9555 -12.9130 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6568 -13.3255 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6568 -11.6753 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3581 -12.0879 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3581 -12.9130 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1007 -13.3255 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1007 -11.6753 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8020 -12.0879 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8020 -12.9130 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5032 -13.3667 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2458 -12.9542 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2458 -12.1292 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5445 -11.7166 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2130 -13.3255 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5445 -10.8915 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9471 -13.3667 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1007 -14.1505 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8020 -14.5631 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.8020 -15.3881 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5032 -15.8006 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5032 -16.6257 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2046 -17.0382 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5858 -14.5218 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2458 -15.3881 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0594 -15.8006 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0296 -17.0382 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8547 -17.0382 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0296 -16.2131 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0296 -17.8632 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.5972 -16.6257 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.2985 -17.0382 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9998 -16.6257 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7424 -17.0382 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 22.4436 -16.6257 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1449 -17.0382 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8874 -16.6257 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.5888 -17.0382 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 25.2901 -16.6257 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.0326 -17.0382 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7339 -16.6257 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4352 -17.0382 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5972 -15.8006 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2985 -17.8632 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8874 -15.8006 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7424 -17.8632 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.2901 -15.8006 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9998 -18.2757 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4436 -18.2757 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.5888 -15.3881 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0326 -15.3881 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 28.1365 -16.6257 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.4352 -17.8632 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9 10 2 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 9 1 0 0 0 0 + 5 6 2 0 0 0 0 + 2 15 1 0 0 0 0 + 6 7 1 0 0 0 0 + 14 16 2 0 0 0 0 + 7 10 1 0 0 0 0 + 12 17 2 0 0 0 0 + 9 8 1 0 0 0 0 + 8 5 1 0 0 0 0 + 5 4 1 0 0 0 0 + 4 1 2 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 2 0 0 0 0 + 3 6 1 0 0 0 0 + 7 18 1 0 0 0 0 + 19 18 1 0 0 0 0 + 20 19 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 19 24 1 6 0 0 0 + 21 25 1 6 0 0 0 + 20 26 1 1 0 0 0 + 23 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 27 29 2 0 0 0 0 + 27 30 1 0 0 0 0 + 31 28 1 0 0 0 0 + 31 32 1 0 0 0 0 + 32 33 1 0 0 0 0 + 34 33 1 1 0 0 0 + 34 35 1 0 0 0 0 + 35 36 1 0 0 0 0 + 36 37 1 0 0 0 0 + 37 38 1 0 0 0 0 + 39 38 1 6 0 0 0 + 39 40 1 0 0 0 0 + 40 41 1 0 0 0 0 + 41 42 1 0 0 0 0 + 31 43 1 1 0 0 0 + 32 44 2 0 0 0 0 + 37 45 2 0 0 0 0 + 34 46 1 0 0 0 0 + 39 47 1 0 0 0 0 + 46 48 2 0 0 0 0 + 46 49 1 0 0 0 0 + 47 50 2 0 0 0 0 + 47 51 1 0 0 0 0 + 42 52 1 0 0 0 0 + 42 53 2 0 0 0 0 +M CHG 4 30 -1 49 -1 51 -1 52 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01081.mol b/src/analysis/thermo/trainingModel/data/mol/C01081.mol new file mode 100644 index 0000000000..c63af0126f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01081.mol @@ -0,0 +1,51 @@ +C01081 + Mrv1652304062119482D + + 22 23 0 0 0 0 999 V2000 + 12.5069 -11.1266 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 11.7540 -10.7083 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1762 -10.6664 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7579 -11.9631 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0429 -11.1266 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8455 -11.1266 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1762 -9.9135 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5945 -11.9631 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0429 -12.0050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3318 -10.7083 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3318 -12.4233 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7540 -12.4233 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5789 -11.1266 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5789 -12.0050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8678 -12.3814 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5565 -10.7083 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3095 -11.1266 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0206 -10.7083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8572 -10.7083 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7356 -10.7083 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.8572 -9.8717 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8572 -11.5448 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 9 12 1 0 0 0 0 + 10 13 2 0 0 0 0 + 11 14 2 0 0 0 0 + 14 15 1 0 0 0 0 + 6 8 1 0 0 0 0 + 13 14 1 0 0 0 0 + 6 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 19 21 2 0 0 0 0 + 19 22 1 0 0 0 0 +M CHG 3 1 1 20 -1 22 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01083.mol b/src/analysis/thermo/trainingModel/data/mol/C01083.mol new file mode 100644 index 0000000000..46d6519020 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01083.mol @@ -0,0 +1,52 @@ +C01083 + Mrv1652304062119482D + + 23 24 0 0 1 0 999 V2000 + 15.8059 -8.9046 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.0943 -9.3205 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5243 -9.3205 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8059 -8.0796 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3827 -9.7364 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2359 -8.9046 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5243 -7.6705 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.0943 -7.6705 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6643 -9.3205 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3827 -10.5614 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2359 -8.0796 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.9508 -9.3205 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5243 -6.8455 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9527 -9.7364 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.6643 -10.9705 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.0943 -10.9705 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9508 -7.6705 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5764 -8.7843 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9527 -10.5614 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.2377 -9.3205 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6643 -11.7955 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2377 -10.9705 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6121 -9.8602 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 5 2 1 6 0 0 0 + 6 3 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 1 6 0 0 0 + 5 9 1 0 0 0 0 + 10 5 1 0 0 0 0 + 11 6 1 0 0 0 0 + 6 12 1 1 0 0 0 + 7 13 1 1 0 0 0 + 14 9 1 0 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 6 0 0 0 + 11 17 1 6 0 0 0 + 12 18 1 0 0 0 0 + 19 14 1 0 0 0 0 + 14 20 1 1 0 0 0 + 15 21 1 1 0 0 0 + 19 22 1 6 0 0 0 + 20 23 1 0 0 0 0 + 7 11 1 0 0 0 0 + 15 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01087.mol b/src/analysis/thermo/trainingModel/data/mol/C01087.mol new file mode 100644 index 0000000000..07acaead11 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01087.mol @@ -0,0 +1,25 @@ +C01087 + Mrv1652304062119482D + + 10 9 0 0 1 0 999 V2000 + 17.8901 -9.8820 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.1754 -10.2942 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6009 -10.2942 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8901 -9.0167 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4646 -9.8820 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5971 -11.1559 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2706 -9.8783 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.7499 -10.2942 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0391 -9.8783 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.7536 -11.1559 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 2 7 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01089.mol b/src/analysis/thermo/trainingModel/data/mol/C01089.mol new file mode 100644 index 0000000000..50b677805b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01089.mol @@ -0,0 +1,19 @@ +C01089 + Mrv1652304062119482D + + 7 6 0 0 1 0 999 V2000 + 8.2502 -11.1377 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9646 -10.7252 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.6792 -11.1377 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3936 -10.7252 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1081 -11.1377 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.3936 -9.9002 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9646 -9.9003 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 4 6 2 0 0 0 0 + 2 7 1 1 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01094.mol b/src/analysis/thermo/trainingModel/data/mol/C01094.mol new file mode 100644 index 0000000000..2c068294de --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01094.mol @@ -0,0 +1,38 @@ +C01094 + Mrv1652304062119482D + + 16 16 0 0 1 0 999 V2000 + 12.8413 -9.3499 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 12.5951 -10.1185 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.1559 -8.8614 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6264 -8.6433 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5947 -9.6263 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7622 -10.1185 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.0798 -10.7925 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4934 -9.3385 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.5034 -8.9018 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2851 -10.7962 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7134 -9.0886 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3249 -8.9018 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2137 -9.7513 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1465 -8.9018 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.3249 -8.0802 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.3211 -9.7271 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 1 0 0 0 + 8 3 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 6 0 0 0 + 8 11 1 1 0 0 0 + 9 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 12 14 1 0 0 0 0 + 12 15 1 0 0 0 0 + 12 16 2 0 0 0 0 + 6 8 1 0 0 0 0 +M CHG 2 14 -1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01096.mol b/src/analysis/thermo/trainingModel/data/mol/C01096.mol new file mode 100644 index 0000000000..ca61903179 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01096.mol @@ -0,0 +1,37 @@ +C01096 + Mrv1652304062119482D + + 16 15 0 0 1 0 999 V2000 + 9.1577 -10.8077 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8722 -10.3952 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5867 -10.8077 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.3012 -10.3952 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.0156 -10.8077 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.7301 -10.3952 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.4446 -10.8077 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1591 -10.3952 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5867 -11.6326 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3012 -9.5702 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0156 -11.6327 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7301 -9.5704 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9841 -10.3952 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8091 -10.3952 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.9841 -9.5702 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9841 -11.2202 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 3 9 1 1 0 0 0 + 4 10 1 1 0 0 0 + 5 11 1 1 0 0 0 + 6 12 1 6 0 0 0 + 8 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 2 0 0 0 0 + 13 16 1 0 0 0 0 +M CHG 2 14 -1 16 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01099.mol b/src/analysis/thermo/trainingModel/data/mol/C01099.mol new file mode 100644 index 0000000000..b12779877f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01099.mol @@ -0,0 +1,35 @@ +C01099 + Mrv1652304062119482D + + 15 14 0 0 1 0 999 V2000 + 9.4877 -10.2715 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2022 -9.8590 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.9167 -10.2715 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.6312 -9.8590 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.3456 -10.2715 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0602 -9.8590 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7746 -10.2715 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2022 -9.0341 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9167 -11.0964 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6312 -9.0339 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3456 -11.0964 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5996 -10.2715 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4247 -10.2715 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5996 -11.0965 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5996 -9.4465 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 1 6 0 0 0 + 3 9 1 6 0 0 0 + 4 10 1 1 0 0 0 + 5 11 2 0 0 0 0 + 7 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 12 14 1 0 0 0 0 + 12 15 2 0 0 0 0 +M CHG 2 13 -1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01100.mol b/src/analysis/thermo/trainingModel/data/mol/C01100.mol new file mode 100644 index 0000000000..772f699642 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01100.mol @@ -0,0 +1,34 @@ +C01100 + Mrv1652304062119482D + + 14 14 0 0 1 0 999 V2000 + 18.8444 -9.9859 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1361 -9.5813 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4243 -9.9859 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.7154 -9.5813 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0036 -9.9859 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1706 -9.9849 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1663 -9.1535 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3392 -9.9849 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.1663 -10.8163 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4226 -10.8172 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 18.9353 -10.8135 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7506 -10.9829 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1635 -10.2599 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6035 -9.6436 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 1 2 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 9 2 0 0 0 0 + 3 2 1 0 0 0 0 + 3 10 1 6 0 0 0 + 1 11 2 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 2 0 0 0 0 + 1 14 1 0 0 0 0 +M CHG 3 7 -1 8 -1 10 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01101.mol b/src/analysis/thermo/trainingModel/data/mol/C01101.mol new file mode 100644 index 0000000000..b7a33acd8e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01101.mol @@ -0,0 +1,33 @@ +C01101 + Mrv1652304062119482D + + 14 13 0 0 1 0 999 V2000 + 16.1549 -9.7699 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.8705 -10.1814 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4432 -10.1814 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1549 -8.9463 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5856 -9.7699 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8705 -11.0048 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7242 -9.7699 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4432 -11.0048 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3012 -10.1814 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0126 -10.1814 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1248 -10.1779 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9516 -10.1779 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.1248 -9.3509 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.1248 -11.0014 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 7 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 11 14 2 0 0 0 0 +M CHG 2 12 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01103.mol b/src/analysis/thermo/trainingModel/data/mol/C01103.mol new file mode 100644 index 0000000000..57d1e964a8 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01103.mol @@ -0,0 +1,55 @@ +C01103 + Mrv1652304062119482D + + 24 25 0 0 1 0 999 V2000 + 13.9657 -11.0199 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7900 -9.7344 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2965 -10.5397 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7124 -11.8063 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.5159 -9.3108 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0792 -9.3108 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6349 -11.0199 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.8844 -11.8063 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.1964 -12.4717 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5159 -8.4791 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2268 -9.7230 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0792 -8.4791 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3684 -9.7193 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8522 -10.7628 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3967 -12.4717 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7938 -8.0707 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2268 -10.5435 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.8523 -9.3071 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6859 -9.9575 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7900 -7.3745 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8616 -9.9575 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0374 -9.9575 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.8616 -9.0479 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.8578 -10.7779 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 2 0 0 0 0 + 5 11 1 0 0 0 0 + 6 12 1 0 0 0 0 + 6 13 2 0 0 0 0 + 7 14 1 1 0 0 0 + 8 15 1 6 0 0 0 + 10 16 1 0 0 0 0 + 11 17 1 0 0 0 0 + 11 18 2 0 0 0 0 + 14 19 1 0 0 0 0 + 16 20 2 0 0 0 0 + 19 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 8 7 1 0 0 0 0 + 12 16 1 0 0 0 0 +M CHG 3 17 -1 22 -1 23 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01104.mol b/src/analysis/thermo/trainingModel/data/mol/C01104.mol new file mode 100644 index 0000000000..a25d0a292c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01104.mol @@ -0,0 +1,15 @@ +C01104 + Mrv1652304062119482D + + 5 4 0 0 0 0 999 V2000 + 15.0221 -8.9948 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.3419 -8.5813 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4182 -9.5986 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0221 -8.2468 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7977 -9.5130 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 0 0 0 0 +M CHG 2 1 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01107.mol b/src/analysis/thermo/trainingModel/data/mol/C01107.mol new file mode 100644 index 0000000000..74e463b6f4 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01107.mol @@ -0,0 +1,33 @@ +C01107 + Mrv1652304062119482D + + 14 13 0 0 1 0 999 V2000 + 6.0226 -10.4365 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 6.7371 -10.0240 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.4516 -10.4365 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.1661 -10.0240 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.8806 -10.4365 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5951 -10.0240 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3095 -10.4365 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.7371 -9.1991 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7494 -9.4406 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.5827 -9.4406 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1346 -10.4365 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9596 -10.4365 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1346 -9.6115 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.1346 -11.2615 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 2 0 0 0 0 + 4 9 1 1 0 0 0 + 4 10 1 6 0 0 0 + 7 11 1 0 0 0 0 + 11 12 2 0 0 0 0 + 11 13 1 0 0 0 0 + 11 14 1 0 0 0 0 +M CHG 3 1 -1 13 -1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01112.mol b/src/analysis/thermo/trainingModel/data/mol/C01112.mol new file mode 100644 index 0000000000..18512cae9c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01112.mol @@ -0,0 +1,33 @@ +C01112 + Mrv1652304062119482D + + 14 13 0 0 1 0 999 V2000 + 14.2331 -11.3030 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9756 -11.7155 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.6769 -11.3030 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.3782 -11.7155 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.1207 -11.3030 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8219 -11.7155 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9756 -12.5405 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6769 -10.4780 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3782 -12.5405 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6470 -11.7155 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4720 -11.7155 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.6470 -12.5405 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6470 -10.8905 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.5258 -11.7271 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 2 7 1 6 0 0 0 + 3 8 1 6 0 0 0 + 4 9 1 1 0 0 0 + 6 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 + 10 13 1 0 0 0 0 + 1 14 2 0 0 0 0 +M CHG 2 11 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01113.mol b/src/analysis/thermo/trainingModel/data/mol/C01113.mol new file mode 100644 index 0000000000..013b384451 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01113.mol @@ -0,0 +1,38 @@ +C01113 + Mrv1652304062119482D + + 16 16 0 0 1 0 999 V2000 + 15.2721 -9.4346 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0972 -9.4381 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2652 -10.2597 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.4470 -9.4346 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.2652 -8.6130 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7264 -8.9017 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4380 -9.3177 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.4380 -10.1427 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.1496 -8.9017 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1496 -10.5553 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.7264 -10.5553 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8682 -9.3177 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 18.8682 -10.1394 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.1531 -11.3804 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5867 -8.9017 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5833 -10.5553 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 1 0 0 0 + 8 7 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 1 1 0 0 0 + 9 12 1 0 0 0 0 + 10 13 1 0 0 0 0 + 10 14 1 1 0 0 0 + 12 15 1 4 0 0 0 + 13 16 1 6 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01127.mol b/src/analysis/thermo/trainingModel/data/mol/C01127.mol new file mode 100644 index 0000000000..588afafa90 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01127.mol @@ -0,0 +1,27 @@ +C01127 + Mrv1652304062119482D + + 11 10 0 0 0 0 999 V2000 + 16.2731 -10.1627 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5569 -9.7534 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9857 -9.7534 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2731 -10.9889 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5606 -8.9272 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8443 -10.1665 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.6982 -10.1627 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4145 -9.7534 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6982 -10.9889 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1270 -10.1665 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.4107 -8.9272 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 2 0 0 0 0 +M CHG 2 6 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01131.mol b/src/analysis/thermo/trainingModel/data/mol/C01131.mol new file mode 100644 index 0000000000..0f0d506e05 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01131.mol @@ -0,0 +1,35 @@ +C01131 + Mrv1652304062119482D + + 15 14 0 0 1 0 999 V2000 + 8.7863 -9.8175 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4875 -9.4050 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.2300 -9.8175 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.9313 -9.4050 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.6325 -9.8175 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3750 -9.4050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0763 -9.8175 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4875 -8.5800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2300 -10.6425 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9313 -8.5800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6325 -10.6425 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9013 -9.8175 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7263 -9.8175 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9013 -8.9925 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9013 -10.6425 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 1 6 0 0 0 + 3 9 1 1 0 0 0 + 4 10 1 1 0 0 0 + 5 11 2 0 0 0 0 + 7 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 12 14 2 0 0 0 0 + 12 15 1 0 0 0 0 +M CHG 2 13 -1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01142.mol b/src/analysis/thermo/trainingModel/data/mol/C01142.mol new file mode 100644 index 0000000000..deb7a53f24 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01142.mol @@ -0,0 +1,25 @@ +C01142 + Mrv1652304062119482D + + 10 9 0 0 1 0 999 V2000 + 16.4302 -9.8240 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7165 -10.2377 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.1438 -10.2377 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9991 -9.8240 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7165 -11.1893 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 17.1438 -11.1893 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8613 -9.8240 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.2853 -10.2377 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5718 -9.8240 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8543 -10.2377 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 1 0 0 0 + 3 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 +M CHG 3 5 1 7 -1 10 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01143.mol b/src/analysis/thermo/trainingModel/data/mol/C01143.mol new file mode 100644 index 0000000000..bc174ab939 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01143.mol @@ -0,0 +1,41 @@ +C01143 + Mrv1652304062119482D + + 18 17 0 0 1 0 999 V2000 + 17.9243 -10.1031 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1194 -10.1031 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7156 -10.1031 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9622 -10.9115 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.9243 -9.2911 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5241 -10.1031 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3360 -10.1031 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5206 -10.9115 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.5241 -9.2911 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4047 -9.6940 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6901 -10.1065 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9757 -9.6940 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.2612 -10.1065 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5467 -9.6940 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8322 -10.1065 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.5590 -9.1106 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3923 -9.1106 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5467 -8.8691 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 9 2 0 0 0 0 + 2 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 12 16 1 1 0 0 0 + 12 17 1 6 0 0 0 + 14 18 2 0 0 0 0 +M CHG 3 4 -1 8 -1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01144.mol b/src/analysis/thermo/trainingModel/data/mol/C01144.mol new file mode 100644 index 0000000000..8f99b6daf9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01144.mol @@ -0,0 +1,116 @@ +C01144 + Mrv1652304062119482D + + 54 56 0 0 1 0 999 V2000 + 17.4620 -24.7088 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1765 -24.2963 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8909 -24.7088 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6054 -24.2963 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3199 -24.7088 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0343 -24.2963 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7488 -24.7088 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4633 -24.2963 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1777 -24.7088 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8922 -24.2963 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.6067 -24.7088 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3211 -24.2963 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.0356 -24.7088 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7501 -24.2963 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4645 -24.7088 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1765 -23.4714 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7488 -25.5337 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.6067 -25.5335 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3211 -23.4713 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0356 -23.8838 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0356 -25.5338 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2895 -24.7088 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 29.1145 -24.7088 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2895 -25.5338 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.4613 -21.7800 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 25.2863 -21.7800 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.5412 -20.9954 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.8738 -20.5104 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.2063 -20.9954 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.3188 -20.7427 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9763 -22.4474 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.7712 -22.4474 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5962 -22.4474 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5962 -21.6224 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.4212 -22.4474 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 26.5962 -23.2724 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7800 -19.9238 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7800 -20.7488 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2090 -20.7488 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2090 -19.9238 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4945 -19.5113 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0656 -19.5113 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3510 -19.9238 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3510 -20.7488 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0656 -21.1613 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0656 -18.6864 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4869 -20.9974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3119 -20.9974 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3119 -20.1724 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 29.1369 -20.9974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3119 -22.8949 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7377 -24.2905 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.0281 -24.7001 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7378 -23.4713 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 52 1 1 0 0 0 0 + 52 53 1 0 0 0 0 + 52 54 1 6 0 0 0 +M CHG 4 24 -1 34 -1 35 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01146.mol b/src/analysis/thermo/trainingModel/data/mol/C01146.mol new file mode 100644 index 0000000000..63c0ce3442 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01146.mol @@ -0,0 +1,19 @@ +C01146 + Mrv1652304062119482D + + 7 6 0 0 0 0 999 V2000 + 17.1135 -10.2598 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4073 -9.8444 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8612 -9.8444 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1135 -11.0905 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4073 -9.0137 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7012 -10.2598 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.5673 -10.2598 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 2 0 0 0 0 +M CHG 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01157.mol b/src/analysis/thermo/trainingModel/data/mol/C01157.mol new file mode 100644 index 0000000000..42c71dd742 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01157.mol @@ -0,0 +1,24 @@ +C01157 + Mrv1652304062119482D + + 9 9 0 0 1 0 999 V2000 + 13.1120 -9.1924 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.4537 -9.6729 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7817 -9.6729 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.1120 -8.3713 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7033 -10.4600 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.5283 -10.4600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8233 -7.9588 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.3931 -7.9627 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2152 -11.1259 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 6 0 0 0 + 5 6 1 0 0 0 0 +M CHG 2 3 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01172.mol b/src/analysis/thermo/trainingModel/data/mol/C01172.mol new file mode 100644 index 0000000000..9f07b37951 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01172.mol @@ -0,0 +1,38 @@ +C01172 + Mrv1652304062119482D + + 16 16 0 0 1 0 999 V2000 + 15.2181 -9.3396 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0411 -9.3396 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3985 -9.3396 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.2181 -8.5166 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.2181 -10.1592 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7529 -8.9281 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4680 -9.3396 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.4680 -10.1695 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.1756 -8.9281 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1756 -10.5879 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.7529 -10.5776 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8976 -9.3396 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.8976 -10.1695 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.1756 -11.4109 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6095 -8.9281 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6095 -10.5776 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 1 0 0 0 + 8 7 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 1 6 0 0 0 + 12 9 1 0 0 0 0 + 10 13 1 0 0 0 0 + 10 14 1 1 0 0 0 + 12 15 1 1 0 0 0 + 13 16 1 6 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01175.mol b/src/analysis/thermo/trainingModel/data/mol/C01175.mol new file mode 100644 index 0000000000..c6b049a815 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01175.mol @@ -0,0 +1,60 @@ +C01175 + Mrv1652304062119482D + + 27 28 0 0 1 0 999 V2000 + 14.7262 -13.5712 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7262 -14.3962 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4407 -14.8087 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1552 -14.3962 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1552 -13.5712 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4407 -13.1587 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8807 -13.1523 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8807 -14.8152 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4407 -15.6336 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7163 -16.0520 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8807 -12.3273 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0118 -13.1587 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3073 -13.5656 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6076 -13.1616 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9056 -13.5671 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6075 -12.3339 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1912 -13.9796 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.4693 -13.5627 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7548 -13.9751 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.7547 -14.8001 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.4766 -15.2170 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.1911 -14.8046 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.0296 -13.5560 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3115 -13.9700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0217 -15.2233 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4764 -16.0462 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8980 -15.2129 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 3 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 7 11 1 0 0 0 0 + 12 1 1 4 0 0 0 + 12 13 2 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 14 16 2 0 0 0 0 + 17 15 1 1 0 0 0 + 17 18 1 0 0 0 0 + 19 18 1 0 0 0 0 + 20 19 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 22 17 1 0 0 0 0 + 19 23 1 1 0 0 0 + 23 24 1 0 0 0 0 + 20 25 1 6 0 0 0 + 21 26 1 1 0 0 0 + 22 27 1 6 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01179.mol b/src/analysis/thermo/trainingModel/data/mol/C01179.mol new file mode 100644 index 0000000000..02489323a0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01179.mol @@ -0,0 +1,32 @@ +C01179 + Mrv1652304062119482D + + 13 13 0 0 0 0 999 V2000 + 15.5513 -13.6538 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2525 -13.2413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8088 -13.2413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5513 -14.4788 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9538 -13.6538 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2525 -12.4163 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1075 -13.6538 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1075 -14.4788 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4063 -13.2413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4063 -14.8913 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6638 -13.6538 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6638 -14.4788 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9625 -14.8913 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 7 8 2 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 9 11 2 0 0 0 0 + 10 12 2 0 0 0 0 + 12 13 1 0 0 0 0 + 11 12 1 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01185.mol b/src/analysis/thermo/trainingModel/data/mol/C01185.mol new file mode 100644 index 0000000000..cd54f3b6b0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01185.mol @@ -0,0 +1,51 @@ +C01185 + Mrv1652304062119482D + + 22 23 0 0 1 0 999 V2000 + 13.8524 -10.5797 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.8882 -9.9196 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.1747 -10.0846 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6031 -11.3486 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.6114 -9.4982 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1789 -9.4982 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5076 -10.5656 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.7675 -11.3486 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0877 -12.0087 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6114 -8.6662 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1789 -8.6662 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7317 -10.3199 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3040 -12.0158 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8882 -8.2589 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2786 -8.2553 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2401 -10.9765 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9843 -8.6662 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2716 -7.5214 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4151 -10.9765 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4186 -10.0849 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.4115 -11.8261 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.5655 -10.9695 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 1 0 0 0 + 8 13 1 6 0 0 0 + 10 14 2 0 0 0 0 + 10 15 1 0 0 0 0 + 12 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 18 2 0 0 0 0 + 16 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 19 22 2 0 0 0 0 + 8 7 1 0 0 0 0 + 11 14 1 0 0 0 0 +M CHG 4 2 1 17 -1 20 -1 21 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01186.mol b/src/analysis/thermo/trainingModel/data/mol/C01186.mol new file mode 100644 index 0000000000..541d32852c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01186.mol @@ -0,0 +1,25 @@ +C01186 + Mrv1652304062119482D + + 10 9 0 0 1 0 999 V2000 + 16.3017 -10.6126 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0154 -10.2008 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.5843 -10.2008 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.7292 -10.6126 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0154 -9.3736 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.8704 -10.6126 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5843 -9.3736 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 18.4465 -10.2008 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1604 -10.6160 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.4432 -9.3736 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 3 1 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 6 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 3 5 1 7 1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01188.mol b/src/analysis/thermo/trainingModel/data/mol/C01188.mol new file mode 100644 index 0000000000..9556822c6c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01188.mol @@ -0,0 +1,19 @@ +C01188 + Mrv1652304062119482D + + 7 6 0 0 0 0 999 V2000 + 17.0922 -10.2489 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8119 -9.8337 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3793 -9.8337 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0922 -11.0725 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5282 -10.2489 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.8119 -8.9997 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6596 -10.2489 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01194.mol b/src/analysis/thermo/trainingModel/data/mol/C01194.mol new file mode 100644 index 0000000000..0eee0552cb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01194.mol @@ -0,0 +1,59 @@ +C01194 + + + 27 27 0 0 1 0 0 0 0 0999 V2000 + 16.8149 -22.4936 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.0299 -21.7925 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.8149 -23.9073 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.2626 -22.4936 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.0242 -20.3964 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0299 -24.6257 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.6115 -24.5966 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2626 -23.9073 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.4659 -21.7925 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0242 -26.0220 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4659 -24.5966 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4100 -18.9700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4100 -20.3700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4100 -21.7700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0100 -20.3700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6100 -20.3700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2100 -20.3700 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6100 -18.9700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8100 -18.9700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2100 -18.9700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6100 -18.9700 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2100 -17.5700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8100 -21.7700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2100 -21.7700 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6100 -21.7700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2100 -20.3700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2100 -23.1700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 2 4 1 0 0 0 + 2 5 1 6 0 0 + 3 6 1 0 0 0 + 3 7 1 1 0 0 + 4 8 1 0 0 0 + 4 9 1 1 0 0 + 6 10 1 1 0 0 + 8 11 1 6 0 0 + 6 8 1 0 0 0 + 12 13 1 0 0 0 + 13 14 1 0 0 0 + 13 15 1 0 0 0 + 15 16 1 0 0 0 + 16 17 1 0 0 0 + 16 18 2 0 0 0 + 12 19 1 0 0 0 + 19 20 1 0 0 0 + 20 21 1 0 0 0 + 20 22 2 0 0 0 + 14 23 1 0 0 0 + 23 24 1 0 0 0 + 24 25 1 0 0 0 + 24 26 2 0 0 0 + 24 27 1 0 0 0 + 1 25 1 1 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C01209.mol b/src/analysis/thermo/trainingModel/data/mol/C01209.mol new file mode 100644 index 0000000000..fae9e6e97f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01209.mol @@ -0,0 +1,20 @@ +C01209 + + + 8 7 0 0 0 0 0 0 0 0999 V2000 + 25.6534 -17.5699 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.4437 -18.2713 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8630 -18.2713 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 25.6470 -16.1673 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2277 -17.5699 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2592 -18.2713 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2343 -16.1673 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0181 -18.2713 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 2 0 0 0 + 2 5 1 0 0 0 + 3 6 1 0 0 0 + 5 7 2 0 0 0 + 5 8 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C01213.mol b/src/analysis/thermo/trainingModel/data/mol/C01213.mol new file mode 100644 index 0000000000..3566d85b43 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01213.mol @@ -0,0 +1,118 @@ +C01213 + Mrv1652304062119482D + + 55 57 0 0 1 0 999 V2000 + 17.7920 -24.3788 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.5065 -23.9663 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2209 -24.3788 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9354 -23.9663 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6499 -24.3788 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3643 -23.9663 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0788 -24.3788 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7933 -23.9663 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5077 -24.3788 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.2222 -23.9663 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9367 -24.3788 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.6511 -23.9663 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.3656 -24.3788 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.0801 -23.9663 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.7945 -24.3788 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5065 -23.1414 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0788 -25.2037 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9367 -25.2035 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.6511 -23.1413 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.3656 -23.5538 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.3656 -25.2038 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.6195 -24.3788 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 29.4445 -24.3788 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.6195 -25.2038 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.7913 -21.4500 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 25.6163 -21.4500 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.8712 -20.6654 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 25.2038 -20.1804 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.5363 -20.6654 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.6488 -20.4127 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.3063 -22.1174 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1012 -22.1174 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.9262 -22.1174 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 26.9262 -21.2924 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.7512 -22.1174 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 26.9262 -22.9424 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1100 -19.5938 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1100 -20.4188 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5390 -20.4188 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5390 -19.5938 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8245 -19.1813 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3956 -19.1813 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6810 -19.5938 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6810 -20.4188 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3956 -20.8313 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3956 -18.3564 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8169 -20.6674 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.6419 -20.6674 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 28.6419 -19.8424 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 29.4669 -20.6674 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.6419 -22.5649 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0677 -23.9605 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3581 -24.3701 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.0678 -23.1413 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7919 -25.2036 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 52 54 2 0 0 0 0 + 1 55 1 6 0 0 0 +M CHG 5 24 -1 34 -1 35 -1 49 -1 53 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01217.mol b/src/analysis/thermo/trainingModel/data/mol/C01217.mol new file mode 100644 index 0000000000..feffe4f6e3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01217.mol @@ -0,0 +1,115 @@ +C01217 + Mrv1652304062119482D + + 53 56 0 0 1 0 999 V2000 + 8.5889 -12.3824 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5889 -13.2184 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3114 -11.9609 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8629 -11.9720 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3148 -13.6364 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8629 -13.6399 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0407 -12.3790 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 7.1557 -12.3824 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8629 -11.1471 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0442 -13.2218 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 7.1557 -13.2184 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7522 -11.9644 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 6.4453 -13.6253 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4629 -12.3714 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7668 -11.1617 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1803 -11.9684 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1803 -11.1367 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8909 -12.3864 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8909 -10.7220 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6136 -11.9684 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6136 -11.1367 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3284 -10.7220 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0433 -11.1289 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7548 -10.7186 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.0433 -11.9539 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4655 -11.1289 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7548 -9.8936 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1845 -10.7151 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4730 -11.9505 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8994 -11.1256 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6801 -10.8688 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.3471 -11.3490 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9368 -10.0847 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.0109 -10.8722 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.7651 -10.0881 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.4531 -9.4133 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7915 -11.1289 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2489 -9.4168 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9604 -11.9394 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7818 -11.9394 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 22.6101 -11.9394 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7818 -11.1144 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 21.7818 -12.7643 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3908 -12.1996 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 23.5597 -13.0100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0068 -11.6536 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.9437 -13.5525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7915 -11.9137 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 23.8420 -10.8431 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1050 -14.3588 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4891 -14.9090 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 23.8856 -14.6231 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7590 -13.6358 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 10 5 1 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 1 0 0 0 + 11 13 1 0 0 0 0 + 12 14 1 0 0 0 0 + 12 15 1 1 0 0 0 + 14 16 1 0 0 0 0 + 16 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 17 19 1 0 0 0 0 + 18 20 2 0 0 0 0 + 19 21 2 0 0 0 0 + 21 22 1 0 0 0 0 + 23 22 1 0 0 0 0 + 24 23 1 0 0 0 0 + 23 25 1 1 0 0 0 + 24 26 1 0 0 0 0 + 24 27 1 6 0 0 0 + 26 28 1 0 0 0 0 + 26 29 1 1 0 0 0 + 28 30 1 0 0 0 0 + 31 30 1 6 0 0 0 + 31 32 1 0 0 0 0 + 33 31 1 0 0 0 0 + 34 32 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 1 6 0 0 0 + 34 37 1 1 0 0 0 + 35 38 1 6 0 0 0 + 37 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 1 0 0 0 0 + 40 42 1 0 0 0 0 + 40 43 2 0 0 0 0 + 44 41 1 6 0 0 0 + 44 45 1 0 0 0 0 + 44 46 1 0 0 0 0 + 45 47 1 0 0 0 0 + 46 48 1 0 0 0 0 + 46 49 2 0 0 0 0 + 47 50 1 0 0 0 0 + 50 51 1 0 0 0 0 + 50 52 2 0 0 0 0 + 7 10 1 0 0 0 0 + 8 11 2 0 0 0 0 + 20 21 1 0 0 0 0 + 35 34 1 0 0 0 0 + 1 2 2 0 0 0 0 + 10 53 1 6 0 0 0 +M CHG 3 42 -1 48 -1 51 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01231.mol b/src/analysis/thermo/trainingModel/data/mol/C01231.mol new file mode 100644 index 0000000000..a08c18c642 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01231.mol @@ -0,0 +1,46 @@ +C01231 + Mrv1652304062119482D + + 20 20 0 0 1 0 999 V2000 + 15.6389 -8.6973 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8188 -8.7124 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4590 -8.6973 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.6726 -7.8322 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.6465 -9.5173 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1084 -9.1243 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.1084 -9.9557 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.3865 -8.7162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3865 -10.3752 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.8227 -10.3677 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6762 -9.1243 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.6762 -9.9557 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.3865 -11.1990 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9657 -8.7162 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9618 -10.3639 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2514 -9.1243 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4313 -9.1243 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6075 -9.1243 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.4313 -8.2630 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.4275 -9.9482 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 6 2 1 6 0 0 0 + 7 6 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 7 10 1 6 0 0 0 + 11 8 1 0 0 0 0 + 9 12 1 0 0 0 0 + 9 13 1 1 0 0 0 + 11 14 1 1 0 0 0 + 12 15 1 6 0 0 0 + 14 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 17 19 1 0 0 0 0 + 17 20 2 0 0 0 0 + 12 11 1 0 0 0 0 +M CHG 4 3 -1 4 -1 18 -1 19 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01235.mol b/src/analysis/thermo/trainingModel/data/mol/C01235.mol new file mode 100644 index 0000000000..32413d751d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01235.mol @@ -0,0 +1,52 @@ +C01235 + Mrv1652304062119482D + + 23 24 0 0 1 0 999 V2000 + 18.5020 -12.8911 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2289 -11.9505 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2087 -12.4850 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.5020 -13.7182 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.9995 -12.4431 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.9269 -12.8911 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.2087 -11.7091 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2087 -14.1356 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.8733 -14.2394 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2815 -12.0333 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9995 -13.2702 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.9269 -13.7182 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.7209 -12.4812 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2087 -14.9551 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5747 -12.4431 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.2815 -13.6876 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.6282 -13.6756 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6374 -14.1280 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5747 -13.2702 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.8678 -12.0333 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2815 -14.5033 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8641 -13.6726 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1573 -12.4431 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 5 2 1 6 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 1 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 11 5 1 0 0 0 0 + 6 12 1 0 0 0 0 + 6 13 1 1 0 0 0 + 8 14 1 1 0 0 0 + 15 10 1 0 0 0 0 + 11 16 1 0 0 0 0 + 11 17 1 6 0 0 0 + 12 18 1 6 0 0 0 + 19 15 1 0 0 0 0 + 15 20 1 1 0 0 0 + 16 21 1 1 0 0 0 + 19 22 1 1 0 0 0 + 20 23 1 0 0 0 0 + 8 12 1 0 0 0 0 + 16 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01236.mol b/src/analysis/thermo/trainingModel/data/mol/C01236.mol new file mode 100644 index 0000000000..61f3362598 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01236.mol @@ -0,0 +1,38 @@ +C01236 + Mrv1652304062119482D + + 16 16 0 0 1 0 999 V2000 + 11.2399 -8.8879 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0636 -8.8879 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4199 -8.8879 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2399 -8.0229 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2399 -9.7078 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7740 -8.4761 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4881 -8.8879 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.4881 -9.7191 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.1985 -8.4761 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1985 -10.1386 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.7740 -10.1273 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9202 -8.8879 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9202 -9.7191 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.1985 -11.0448 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6307 -8.4761 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6307 -10.1273 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 6 1 1 0 0 0 + 8 7 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 1 6 0 0 0 + 9 12 1 0 0 0 0 + 10 13 1 0 0 0 0 + 10 14 1 1 0 0 0 + 12 15 2 0 0 0 0 + 13 16 1 6 0 0 0 + 13 12 1 0 0 0 0 +M CHG 2 3 -1 4 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01244.mol b/src/analysis/thermo/trainingModel/data/mol/C01244.mol new file mode 100644 index 0000000000..64ffcfe9ec --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01244.mol @@ -0,0 +1,36 @@ +C01244 + Mrv1652304062119482D + + 15 15 0 0 0 0 999 V2000 + 12.7199 -9.1501 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7199 -9.9770 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9988 -8.7386 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4298 -8.7348 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9988 -10.3999 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2890 -9.1501 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1434 -9.1464 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2890 -9.9770 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9988 -11.3019 0.0000 I 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5753 -8.7386 0.0000 I 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8532 -8.7311 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1434 -9.9657 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5753 -10.3848 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5630 -9.1426 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.8233 -7.9979 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 + 7 11 1 0 0 0 0 + 7 12 2 0 0 0 0 + 8 13 1 0 0 0 0 + 11 14 1 0 0 0 0 + 11 15 2 0 0 0 0 + 6 8 1 0 0 0 0 +M CHG 1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01267.mol b/src/analysis/thermo/trainingModel/data/mol/C01267.mol new file mode 100644 index 0000000000..e623c02880 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01267.mol @@ -0,0 +1,34 @@ +C01267 + Mrv1652304062119482D + + 14 14 0 0 0 0 999 V2000 + 17.8949 -10.2366 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1809 -10.6425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4737 -10.2366 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7553 -10.6425 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1790 -11.4766 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9196 -10.6415 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9153 -9.8074 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0855 -10.6415 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.9153 -11.4757 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6266 -10.6657 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8834 -11.4492 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7084 -11.4500 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9642 -10.6656 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2972 -10.1800 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 1 2 1 0 0 0 0 + 6 9 2 0 0 0 0 + 1 10 1 0 0 0 0 + 10 11 2 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 2 0 0 0 0 + 10 14 1 0 0 0 0 +M CHG 2 7 -1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01277.mol b/src/analysis/thermo/trainingModel/data/mol/C01277.mol new file mode 100644 index 0000000000..e9a4146ecf --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01277.mol @@ -0,0 +1,67 @@ +C01277 + + + 31 31 0 0 1 0 0 0 0 0999 V2000 + 26.4408 -20.3163 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 27.6292 -19.6229 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.4408 -21.7259 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.2407 -19.6229 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.8525 -20.3163 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 27.6292 -18.2364 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.6292 -22.4309 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.2290 -22.4076 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8891 -19.5762 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 28.8525 -21.7259 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 30.0527 -19.6172 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.6292 -23.8115 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1123 -19.6346 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8367 -18.1140 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8367 -21.0971 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 30.0584 -22.4134 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1123 -18.2540 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.4333 -22.4076 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 20.9064 -17.5606 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 32.8257 -22.4076 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 31.4333 -21.0211 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 31.4333 -23.7941 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9064 -16.1800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7064 -18.2540 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1123 -15.4809 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5062 -17.5606 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1123 -14.0944 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5062 -16.1800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3062 -18.2540 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9064 -13.4070 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3123 -13.4070 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 1 1 0 0 + 2 5 1 0 0 0 + 2 6 1 6 0 0 + 3 7 1 0 0 0 + 3 8 1 1 0 0 + 4 9 1 0 0 0 + 5 10 1 0 0 0 + 5 11 1 1 0 0 + 7 12 1 1 0 0 + 9 13 1 0 0 0 + 9 14 1 0 0 0 + 9 15 2 0 0 0 + 10 16 1 6 0 0 + 13 17 1 0 0 0 + 16 18 1 0 0 0 + 17 19 1 0 0 0 + 18 20 1 0 0 0 + 18 21 1 0 0 0 + 18 22 2 0 0 0 + 19 23 1 0 0 0 + 19 24 1 6 0 0 + 23 25 1 0 0 0 + 24 26 1 0 0 0 + 25 27 1 0 0 0 + 26 28 2 0 0 0 + 26 29 1 0 0 0 + 27 30 2 0 0 0 + 27 31 1 0 0 0 + 7 10 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C01281.mol b/src/analysis/thermo/trainingModel/data/mol/C01281.mol new file mode 100644 index 0000000000..33a7e5fa13 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01281.mol @@ -0,0 +1,39 @@ +C01281 + + + 17 17 0 0 1 0 0 0 0 0999 V2000 + 29.6135 -21.3782 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4019 -20.6792 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.1961 -21.3782 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4019 -19.2813 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.9788 -20.6792 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.1961 -18.5764 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.9788 -19.2813 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7615 -18.5823 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5498 -19.2813 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 22.3324 -18.5823 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5498 -20.6792 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1209 -19.2813 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 22.3324 -17.1843 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9085 -18.5813 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 22.3374 -21.3792 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1249 -20.6792 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.3374 -22.7792 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 2 3 2 0 0 0 + 2 4 1 0 0 0 + 3 5 1 0 0 0 + 4 6 2 0 0 0 + 5 7 2 0 0 0 + 7 8 1 0 0 0 + 8 9 1 0 0 0 + 9 10 1 0 0 0 + 9 11 1 6 0 0 + 10 12 1 0 0 0 + 10 13 2 0 0 0 + 6 7 1 0 0 0 + 12 14 1 0 0 0 + 11 15 1 0 0 0 + 15 16 2 0 0 0 + 15 17 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C01286.mol b/src/analysis/thermo/trainingModel/data/mol/C01286.mol new file mode 100644 index 0000000000..c4568db250 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01286.mol @@ -0,0 +1,37 @@ +C01286 + Mrv1652304062119482D + + 16 15 0 0 1 0 999 V2000 + 11.3025 -10.9313 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0038 -11.3438 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7463 -10.9313 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.4475 -11.3438 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.1488 -10.9313 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8913 -11.3438 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5925 -10.9313 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2938 -11.3438 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.4775 -10.9313 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4775 -11.7563 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4775 -10.1063 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.6525 -10.9313 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.7463 -10.1063 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4475 -12.1688 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8913 -12.1688 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5925 -10.1063 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 1 9 1 0 0 0 0 + 9 10 2 0 0 0 0 + 9 11 1 0 0 0 0 + 9 12 1 0 0 0 0 + 3 13 1 1 0 0 0 + 4 14 1 1 0 0 0 + 6 15 2 0 0 0 0 + 7 16 2 0 0 0 0 +M CHG 3 8 -1 11 -1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01299.mol b/src/analysis/thermo/trainingModel/data/mol/C01299.mol new file mode 100644 index 0000000000..93b6ea5b0f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01299.mol @@ -0,0 +1,86 @@ +C01299 + + + 39 42 0 0 1 0 0 0 0 0999 V2000 + 32.0600 -22.7500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 30.8700 -22.0500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.6800 -22.7500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.8700 -20.6500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4200 -22.0500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.6800 -19.9500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4200 -20.6500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.2300 -20.0200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.9700 -20.6500 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 24.7800 -20.0200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.9700 -22.0500 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5900 -20.6500 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7800 -18.6200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.3300 -19.9500 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7800 -22.7500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5900 -22.0500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7800 -24.1500 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 33.4600 -22.7500 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 33.4600 -21.3500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 34.8600 -22.7500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 33.4600 -24.1500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 36.0500 -22.0500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.3100 -22.7500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.7300 -24.0800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.1300 -24.0800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 39.5500 -22.7500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.4300 -21.9100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 37.0300 -25.2700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 39.8300 -25.2700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 40.8800 -22.4000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 41.9300 -23.3100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 41.9300 -24.7100 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 43.1200 -25.4100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 44.3800 -24.7100 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 44.3800 -23.3100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 43.1200 -22.6100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 42.8400 -21.2100 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 41.4400 -21.0700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 45.5700 -22.6100 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 2 3 2 0 0 0 + 2 4 1 0 0 0 + 3 5 1 0 0 0 + 4 6 2 0 0 0 + 5 7 2 0 0 0 + 7 8 1 0 0 0 + 8 9 1 0 0 0 + 9 10 1 0 0 0 + 9 11 1 6 0 0 + 10 12 1 0 0 0 + 10 13 2 0 0 0 + 6 7 1 0 0 0 + 12 14 1 0 0 0 + 11 15 1 0 0 0 + 15 16 2 0 0 0 + 15 17 1 0 0 0 + 1 18 1 0 0 0 + 18 19 2 0 0 0 + 18 20 1 0 0 0 + 18 21 1 0 0 0 + 20 22 1 0 0 0 + 23 22 1 1 0 0 + 24 25 1 0 0 0 + 25 26 1 0 0 0 + 26 27 1 0 0 0 + 27 23 1 0 0 0 + 24 23 1 0 0 0 + 24 28 1 6 0 0 + 25 29 1 6 0 0 + 26 30 1 1 0 0 + 31 32 1 0 0 0 + 32 33 2 0 0 0 + 33 34 1 0 0 0 + 34 35 2 0 0 0 + 35 36 1 0 0 0 + 31 36 2 0 0 0 + 36 37 1 0 0 0 + 37 38 2 0 0 0 + 38 30 1 0 0 0 + 31 30 1 0 0 0 + 35 39 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C01326.mol b/src/analysis/thermo/trainingModel/data/mol/C01326.mol new file mode 100644 index 0000000000..30c485ebf9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01326.mol @@ -0,0 +1,8 @@ +C01326 + Mrv1652304062119482D + + 2 1 0 0 0 0 999 V2000 + 9.1990 -11.4678 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9134 -11.0552 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 3 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01342.mol b/src/analysis/thermo/trainingModel/data/mol/C01342.mol new file mode 100644 index 0000000000..7edd895ee3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01342.mol @@ -0,0 +1,7 @@ +C01342 + Mrv1652304062119482D + + 1 0 0 0 0 0 999 V2000 + 25.1300 -17.2200 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 +M CHG 1 1 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01352.mol b/src/analysis/thermo/trainingModel/data/mol/C01352.mol new file mode 100644 index 0000000000..a6f3b8e340 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01352.mol @@ -0,0 +1,117 @@ +C01352 + Mrv1652304062119482D + + 53 58 0 0 1 0 999 V2000 + 7.2471 -8.2343 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2471 -9.0920 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9762 -9.5209 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7482 -9.0920 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7482 -8.2343 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9762 -7.8482 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4344 -9.5209 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1635 -9.0920 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1635 -8.2343 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4344 -7.8482 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8926 -9.5209 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6217 -9.0920 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6217 -8.2343 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8926 -7.8482 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9762 -6.9905 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.5609 -9.5209 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3080 -7.8482 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3080 -9.5209 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4344 -10.8933 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1635 -11.3222 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.8497 -10.8933 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5788 -11.3222 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2650 -10.8933 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9941 -11.3222 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1635 -12.1371 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5788 -12.1371 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8497 -10.0355 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8519 -11.3222 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6668 -11.3222 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8519 -10.4644 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8519 -12.1371 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.5246 -11.3222 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3395 -11.3222 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5246 -10.4644 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5246 -12.1371 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.7977 -11.3222 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.1115 -10.8933 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0550 -12.0942 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.8699 -12.0942 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.1272 -11.3222 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.4839 -10.8076 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5403 -12.7804 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3417 -12.8233 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8406 -8.8775 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8406 -9.6925 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5697 -10.1213 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2988 -9.6925 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2988 -8.8775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5697 -8.4487 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1137 -9.9498 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5426 -9.3064 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1137 -8.6202 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5697 -7.6338 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 9 10 1 0 0 0 0 + 5 10 1 0 0 0 0 + 8 11 1 0 0 0 0 + 11 12 2 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 2 0 0 0 0 + 9 14 1 0 0 0 0 + 6 15 2 0 0 0 0 + 2 16 2 0 0 0 0 + 13 17 1 0 0 0 0 + 12 18 1 0 0 0 0 + 7 19 1 0 0 0 0 + 20 19 1 0 0 0 0 + 21 20 1 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 20 25 1 1 0 0 0 + 22 26 1 1 0 0 0 + 21 27 1 6 0 0 0 + 24 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 2 0 0 0 0 + 28 31 1 0 0 0 0 + 29 32 1 0 0 0 0 + 32 33 1 0 0 0 0 + 32 34 2 0 0 0 0 + 32 35 1 0 0 0 0 + 36 37 1 1 0 0 0 + 33 37 1 0 0 0 0 + 38 36 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 1 0 0 0 0 + 36 41 1 0 0 0 0 + 38 42 1 6 0 0 0 + 39 43 1 6 0 0 0 + 44 45 2 0 0 0 0 + 45 46 1 0 0 0 0 + 46 47 2 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 2 0 0 0 0 + 44 49 1 0 0 0 0 + 47 50 1 0 0 0 0 + 50 51 1 0 0 0 0 + 51 52 2 0 0 0 0 + 48 52 1 0 0 0 0 + 40 50 1 1 0 0 0 + 49 53 1 0 0 0 0 +M CHG 2 31 -1 35 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01384.mol b/src/analysis/thermo/trainingModel/data/mol/C01384.mol new file mode 100644 index 0000000000..aec3e7918d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01384.mol @@ -0,0 +1,21 @@ +C01384 + Mrv1652304062119482D + + 8 7 0 0 0 0 999 V2000 + 14.3039 -9.7910 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8912 -9.0790 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9374 -10.5491 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.1296 -9.7872 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9028 -9.0828 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4938 -9.7985 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6682 -9.7985 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.9104 -10.5529 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 +M CHG 2 3 -1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01412.mol b/src/analysis/thermo/trainingModel/data/mol/C01412.mol new file mode 100644 index 0000000000..78ce11bb6a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01412.mol @@ -0,0 +1,14 @@ +C01412 + Mrv1652304062119482D + + 5 4 0 0 0 0 999 V2000 + 16.5326 -12.1498 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8173 -11.7389 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2480 -11.7389 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0982 -12.1498 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9671 -12.1498 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01417.mol b/src/analysis/thermo/trainingModel/data/mol/C01417.mol new file mode 100644 index 0000000000..e43d42d75e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01417.mol @@ -0,0 +1,11 @@ +C01417 + Mrv1652304062119492D + + 3 2 0 0 0 0 999 V2000 + 15.5931 -12.1280 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8794 -12.5418 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3068 -11.7142 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 3 0 0 0 0 + 1 3 1 0 0 0 0 +M CHG 1 3 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01438.mol b/src/analysis/thermo/trainingModel/data/mol/C01438.mol new file mode 100644 index 0000000000..cf7e611046 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01438.mol @@ -0,0 +1,6 @@ +C01438 + Mrv1652304062119492D + + 1 0 0 0 0 0 999 V2000 + 26.4600 -20.5800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01487.mol b/src/analysis/thermo/trainingModel/data/mol/C01487.mol new file mode 100644 index 0000000000..4a92374393 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01487.mol @@ -0,0 +1,29 @@ +C01487 + Mrv1652304062119492D + + 12 12 0 0 1 0 999 V2000 + 21.6417 -12.5870 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.6417 -13.4120 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 22.3532 -12.1745 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9267 -12.1745 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.3532 -13.8245 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.9267 -13.8245 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.0716 -12.5870 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 20.3011 -12.7108 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.0716 -13.4120 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 22.3532 -14.6494 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.7832 -12.1745 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.7832 -13.8245 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 7 11 1 4 0 0 0 + 9 12 1 6 0 0 0 + 9 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01507.mol b/src/analysis/thermo/trainingModel/data/mol/C01507.mol new file mode 100644 index 0000000000..60b71c3c63 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01507.mol @@ -0,0 +1,28 @@ +C01507 + Mrv1652304062119492D + + 12 11 0 0 1 0 999 V2000 + 8.2089 -10.5602 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9234 -10.1477 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6379 -10.5602 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.3524 -10.1477 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.0669 -10.5602 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.7814 -10.1477 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.4958 -10.5602 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2103 -10.1477 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6379 -11.3851 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3524 -9.3227 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0669 -11.3852 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7814 -9.3229 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 3 9 1 1 0 0 0 + 4 10 1 1 0 0 0 + 5 11 1 1 0 0 0 + 6 12 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01545.mol b/src/analysis/thermo/trainingModel/data/mol/C01545.mol new file mode 100644 index 0000000000..b924cfba32 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01545.mol @@ -0,0 +1,22 @@ +C01545 + Mrv1652304062119492D + + 9 8 0 0 0 0 999 V2000 + 14.0375 -10.0087 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7501 -9.5991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3215 -9.5991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4731 -10.0087 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6020 -10.0087 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1926 -9.5991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8859 -9.5991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9052 -10.0087 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1698 -10.0087 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01563.mol b/src/analysis/thermo/trainingModel/data/mol/C01563.mol new file mode 100644 index 0000000000..9cdb2885f9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01563.mol @@ -0,0 +1,13 @@ +C01563 + Mrv1652304062119492D + + 4 3 0 0 0 0 999 V2000 + 13.0288 -9.7304 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3151 -10.1442 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7425 -10.1442 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.0288 -8.9066 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 +M CHG 1 3 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01570.mol b/src/analysis/thermo/trainingModel/data/mol/C01570.mol new file mode 100644 index 0000000000..f347d30570 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01570.mol @@ -0,0 +1,23 @@ +C01570 + Mrv1652304062119492D + + 9 8 0 0 1 0 999 V2000 + 14.9300 -11.5337 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.6406 -11.1178 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2089 -11.1178 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9195 -12.4246 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.3581 -11.5337 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4949 -11.5337 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.2089 -10.2997 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1067 -11.1975 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3684 -12.3587 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 1 0 0 0 0 +M CHG 2 4 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01589.mol b/src/analysis/thermo/trainingModel/data/mol/C01589.mol new file mode 100644 index 0000000000..d98c14a2f7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01589.mol @@ -0,0 +1,16 @@ +C01589 + Mrv1652304062119492D + + 5 5 0 0 0 0 999 V2000 + 12.3251 -14.3974 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5793 -15.1822 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4043 -15.1830 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.6600 -14.3986 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9930 -13.9130 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 +M CHG 1 3 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01595.mol b/src/analysis/thermo/trainingModel/data/mol/C01595.mol new file mode 100644 index 0000000000..28c58c6397 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01595.mol @@ -0,0 +1,45 @@ +C01595 + Mrv1652304062119492D + + 20 19 0 0 0 0 999 V2000 + 13.5461 -9.5375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2614 -9.9470 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8269 -9.9506 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9807 -9.5339 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1114 -9.5413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8069 -9.5339 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3959 -9.9543 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5334 -9.9248 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6804 -9.5449 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2488 -9.5118 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9613 -9.9580 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0750 -9.5118 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2458 -9.5487 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8015 -9.9063 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5266 -9.9617 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.2420 -8.7262 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5022 -9.4749 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2288 -9.8622 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9295 -9.4306 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6560 -9.8179 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 2 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 10 12 2 0 0 0 0 + 11 13 1 0 0 0 0 + 12 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 13 16 2 0 0 0 0 + 14 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 +M CHG 1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01613.mol b/src/analysis/thermo/trainingModel/data/mol/C01613.mol new file mode 100644 index 0000000000..8c4720ed45 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01613.mol @@ -0,0 +1,98 @@ +C01613 + Mrv1652304062119492D + + 45 48 0 0 1 0 999 V2000 + 19.8898 -10.6992 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.3022 -11.2827 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5600 -10.2141 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1460 -11.4838 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.1051 -10.4468 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5925 -11.6967 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 21.2303 -10.6992 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.9741 -11.4838 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.6649 -12.1501 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9315 -9.6385 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8710 -11.2867 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5925 -12.5247 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 22.0150 -10.4468 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4550 -12.1501 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1612 -11.7046 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.8789 -12.9387 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.3101 -12.9349 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.6261 -10.9988 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4475 -11.2946 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1651 -12.5287 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.8828 -13.7628 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7339 -11.7085 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4515 -12.8189 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0202 -12.1187 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3105 -11.7085 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0202 -12.9426 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.5929 -12.1187 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3105 -13.3567 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.7378 -13.4392 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8791 -11.7046 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5929 -12.9426 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3105 -14.1808 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1655 -12.1187 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8378 -13.2329 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4479 -12.5326 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.7342 -12.1187 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4479 -13.3567 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.0205 -12.5326 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.7342 -13.7707 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.1616 -13.8492 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0205 -13.3567 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.3030 -12.1187 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7342 -14.5948 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3030 -13.7707 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5892 -12.5326 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 1 5 1 1 0 0 0 + 6 2 1 6 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 12 6 1 0 0 0 0 + 7 13 1 6 0 0 0 + 8 14 1 1 0 0 0 + 15 11 1 0 0 0 0 + 12 16 1 0 0 0 0 + 12 17 1 6 0 0 0 + 13 18 1 0 0 0 0 + 15 19 1 1 0 0 0 + 20 15 1 0 0 0 0 + 16 21 1 1 0 0 0 + 19 22 1 0 0 0 0 + 20 23 1 6 0 0 0 + 24 22 1 6 0 0 0 + 24 25 1 0 0 0 0 + 26 24 1 0 0 0 0 + 27 25 1 0 0 0 0 + 26 28 1 0 0 0 0 + 26 29 1 6 0 0 0 + 27 30 1 1 0 0 0 + 31 27 1 0 0 0 0 + 28 32 1 1 0 0 0 + 30 33 1 0 0 0 0 + 31 34 1 1 0 0 0 + 35 33 1 6 0 0 0 + 35 36 1 0 0 0 0 + 37 35 1 0 0 0 0 + 38 36 1 0 0 0 0 + 37 39 1 0 0 0 0 + 37 40 1 6 0 0 0 + 41 38 1 0 0 0 0 + 38 42 1 1 0 0 0 + 39 43 1 1 0 0 0 + 41 44 1 1 0 0 0 + 42 45 1 0 0 0 0 + 8 7 1 0 0 0 0 + 16 20 1 0 0 0 0 + 28 31 1 0 0 0 0 + 39 41 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01620.mol b/src/analysis/thermo/trainingModel/data/mol/C01620.mol new file mode 100644 index 0000000000..a52d94568a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01620.mol @@ -0,0 +1,23 @@ +C01620 + Mrv1652304062119492D + + 9 8 0 0 1 0 999 V2000 + 11.3775 -11.2102 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6664 -11.6285 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9135 -11.2102 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.2024 -11.6285 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.4913 -11.2102 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9135 -10.3736 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2024 -12.4651 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7802 -11.6285 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.4913 -10.3736 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 3 6 1 1 0 0 0 + 4 7 1 1 0 0 0 + 5 8 1 0 0 0 0 + 5 9 2 0 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01697.mol b/src/analysis/thermo/trainingModel/data/mol/C01697.mol new file mode 100644 index 0000000000..061139a76c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01697.mol @@ -0,0 +1,28 @@ +C01697 + Mrv1652304062119492D + + 12 11 0 0 1 0 999 V2000 + 9.4052 -11.3027 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1197 -10.8902 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8342 -11.3027 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5487 -10.8902 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.2631 -11.3027 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.9777 -10.8902 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.6921 -11.3027 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4066 -10.8902 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8342 -12.1276 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5487 -10.0652 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2631 -12.1277 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9777 -10.0654 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 3 9 1 1 0 0 0 + 4 10 1 1 0 0 0 + 5 11 1 6 0 0 0 + 6 12 1 6 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01721.mol b/src/analysis/thermo/trainingModel/data/mol/C01721.mol new file mode 100644 index 0000000000..5e3ced3ab0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01721.mol @@ -0,0 +1,26 @@ +C01721 + Mrv1652304062119492D + + 11 10 0 0 1 0 999 V2000 + 12.0050 -10.4991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7161 -10.0808 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.4690 -10.4991 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.1801 -10.0808 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.8912 -10.4991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6441 -10.0808 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3552 -10.4991 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7161 -9.2442 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4690 -11.3357 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1801 -9.2442 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8912 -11.3357 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 1 6 0 0 0 + 3 9 1 6 0 0 0 + 4 10 1 1 0 0 0 + 5 11 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01732.mol b/src/analysis/thermo/trainingModel/data/mol/C01732.mol new file mode 100644 index 0000000000..8943eea156 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01732.mol @@ -0,0 +1,23 @@ +C01732 + Mrv1652304062119492D + + 9 8 0 0 0 0 999 V2000 + 11.9628 -11.8803 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.6772 -12.2928 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3918 -11.8803 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1062 -12.2928 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8207 -11.8803 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5352 -12.2928 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.6772 -13.1177 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1062 -13.1178 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8207 -11.0553 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 2 0 0 0 0 +M CHG 2 1 -1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01755.mol b/src/analysis/thermo/trainingModel/data/mol/C01755.mol new file mode 100644 index 0000000000..d84cce241d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01755.mol @@ -0,0 +1,11 @@ +C01755 + Mrv1652304062119492D + + 3 2 0 0 0 0 999 V2000 + 18.3150 -12.6225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4900 -12.6225 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1400 -12.6225 0.0000 S 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 3 0 0 0 0 + 1 3 1 0 0 0 0 +M CHG 1 3 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01762.mol b/src/analysis/thermo/trainingModel/data/mol/C01762.mol new file mode 100644 index 0000000000..a77b48a08a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01762.mol @@ -0,0 +1,47 @@ +C01762 + Mrv1652304062119492D + + 20 22 0 0 1 0 999 V2000 + 11.9981 -7.5101 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7842 -7.7633 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9981 -6.6785 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2762 -7.9296 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5765 -9.3999 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.2720 -7.0981 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7881 -6.4252 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2762 -6.2665 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5656 -7.5101 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8998 -8.9085 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3269 -10.1710 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.5656 -6.6785 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2724 -5.5326 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8513 -7.9183 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2421 -9.3886 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5068 -10.1710 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.8183 -10.8325 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4560 -9.1392 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0267 -10.8400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8513 -9.6909 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 5 2 1 1 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 10 1 0 0 0 0 + 11 5 1 0 0 0 0 + 8 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 9 14 2 0 0 0 0 + 15 10 1 0 0 0 0 + 11 16 1 0 0 0 0 + 11 17 1 6 0 0 0 + 15 18 1 1 0 0 0 + 16 19 1 6 0 0 0 + 18 20 1 0 0 0 0 + 6 7 2 0 0 0 0 + 9 12 1 0 0 0 0 + 16 15 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01796.mol b/src/analysis/thermo/trainingModel/data/mol/C01796.mol new file mode 100644 index 0000000000..7ac4c5188a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01796.mol @@ -0,0 +1,21 @@ +C01796 + Mrv1652304062119492D + + 8 8 0 0 1 0 999 V2000 + 15.1949 -9.5993 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3688 -9.5993 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4384 -8.8314 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 15.6818 -10.2645 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1048 -8.8177 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8922 -10.2679 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7664 -8.3377 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2201 -8.5777 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 4 0 0 0 + 5 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01845.mol b/src/analysis/thermo/trainingModel/data/mol/C01845.mol new file mode 100644 index 0000000000..c82e39f359 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01845.mol @@ -0,0 +1,12 @@ +C01845 + Mrv1652304062119492D + + 4 3 0 0 0 0 999 V2000 + 13.0288 -9.7304 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3151 -10.1442 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0288 -8.9066 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7425 -10.1854 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01847.mol b/src/analysis/thermo/trainingModel/data/mol/C01847.mol new file mode 100644 index 0000000000..10aa30a4e9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01847.mol @@ -0,0 +1,70 @@ +C01847 + Mrv1652304062119492D + + 31 33 0 0 1 0 999 V2000 + 7.9765 -8.5091 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9765 -9.3456 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6876 -9.7639 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4405 -9.3456 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4405 -8.5091 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6876 -8.0908 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1515 -9.7639 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8625 -9.3456 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8625 -8.5091 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1515 -8.0908 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6154 -9.7639 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3265 -9.3456 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3265 -8.5091 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6154 -8.0908 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6876 -7.2543 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2654 -9.7639 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0376 -8.0908 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0376 -9.7639 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1515 -11.1442 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8625 -11.5624 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5736 -11.1442 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2847 -11.5624 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.9957 -11.1442 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7068 -11.5624 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8625 -12.3989 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2847 -12.3989 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5736 -10.3076 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5433 -11.5624 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3798 -11.5624 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5433 -10.7259 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5433 -12.3989 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 9 10 1 0 0 0 0 + 5 10 1 0 0 0 0 + 8 11 1 0 0 0 0 + 11 12 2 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 2 0 0 0 0 + 9 14 1 0 0 0 0 + 6 15 2 0 0 0 0 + 2 16 2 0 0 0 0 + 13 17 1 0 0 0 0 + 12 18 1 0 0 0 0 + 7 19 1 0 0 0 0 + 20 19 1 0 0 0 0 + 21 20 1 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 20 25 1 1 0 0 0 + 22 26 1 1 0 0 0 + 21 27 1 6 0 0 0 + 24 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 2 0 0 0 0 + 28 31 1 0 0 0 0 +M CHG 2 29 -1 31 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01904.mol b/src/analysis/thermo/trainingModel/data/mol/C01904.mol new file mode 100644 index 0000000000..e002454ce7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01904.mol @@ -0,0 +1,24 @@ +C01904 + Mrv1652304062119492D + + 10 9 0 0 1 0 999 V2000 + 8.3739 -12.9528 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0884 -12.5403 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8029 -12.9528 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.5174 -12.5403 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2319 -12.9528 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.9464 -12.5403 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6608 -12.9528 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8029 -13.7777 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5174 -11.7153 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2319 -13.7777 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 5 4 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 3 8 1 6 0 0 0 + 4 9 1 0 0 0 0 + 5 10 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01931.mol b/src/analysis/thermo/trainingModel/data/mol/C01931.mol new file mode 100644 index 0000000000..914a029b5c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01931.mol @@ -0,0 +1,104 @@ +C01931 + + + 45 47 0 0 1 0 0 0 0 0999 V2000 + 24.8306 -15.7560 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.4327 -14.5228 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 26.1590 -15.7560 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 23.9171 -17.4430 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.4752 -13.7607 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.7995 -13.2058 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5290 -14.5397 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.9268 -16.7984 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9171 -18.7488 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 22.4992 -13.2058 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.7844 -14.1474 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5008 -18.7600 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9171 -20.0381 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.6168 -18.7488 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3468 -13.2058 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 27.9581 -18.7600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3468 -11.9112 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3468 -14.5061 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0465 -13.2058 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.8493 -20.0603 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.3468 -10.6164 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 29.2584 -21.2935 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 29.8917 -19.3037 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9434 -9.3777 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.6753 -10.6164 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 30.5812 -21.2935 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 28.2273 -22.9046 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 30.9566 -20.0772 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.9915 -8.6211 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0452 -9.3946 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 22.4431 -11.6589 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 31.3545 -22.3358 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 32.2009 -19.6793 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2949 -9.0078 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.9976 -22.1900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.7851 -22.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.5727 -22.1900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3603 -22.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1478 -22.1900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9354 -22.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.9995 -20.7901 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.7851 -24.2898 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7189 -22.1877 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6191 -8.9457 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5709 -9.8871 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 1 6 0 0 + 2 5 1 0 0 0 + 2 6 1 1 0 0 + 3 7 1 0 0 0 + 3 8 1 6 0 0 + 4 9 1 0 0 0 + 6 10 1 0 0 0 + 7 11 1 1 0 0 + 9 12 1 0 0 0 + 9 13 1 0 0 0 + 9 14 2 0 0 0 + 10 15 1 0 0 0 + 12 16 1 0 0 0 + 15 17 1 0 0 0 + 15 18 1 0 0 0 + 15 19 2 0 0 0 + 20 16 1 1 0 0 + 21 17 1 6 0 0 + 20 22 1 0 0 0 + 20 23 1 0 0 0 + 21 24 1 0 0 0 + 21 25 1 0 0 0 + 22 26 1 0 0 0 + 22 27 1 6 0 0 + 23 28 1 0 0 0 + 24 29 1 0 0 0 + 25 30 1 0 0 0 + 25 31 1 6 0 0 + 26 32 1 6 0 0 + 28 33 1 1 0 0 + 30 34 1 1 0 0 + 5 7 1 0 0 0 + 26 28 1 0 0 0 + 29 30 1 0 0 0 + 27 35 1 0 0 0 + 35 36 1 0 0 0 + 36 37 1 0 0 0 + 37 38 1 0 0 0 + 38 39 1 0 0 0 + 39 40 1 0 0 0 + 35 41 2 0 0 0 + 36 42 1 1 0 0 + 40 43 1 0 0 0 + 24 44 1 1 0 0 + 44 45 1 0 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 13 1 2 3 4 5 6 7 8 9 10 11 13 14 +M SDI 1 4 21.7000 -13.8600 21.7000 -12.4600 +M SDI 1 4 25.2000 -18.1300 25.2000 -19.6000 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C01959.mol b/src/analysis/thermo/trainingModel/data/mol/C01959.mol new file mode 100644 index 0000000000..2fd51da531 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01959.mol @@ -0,0 +1,25 @@ +C01959 + Mrv1652304062119492D + + 10 9 0 0 0 0 999 V2000 + 8.6624 -11.6324 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3769 -11.2199 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0914 -11.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8058 -11.2199 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5203 -11.6324 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.5129 -10.6778 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0575 -10.7191 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9480 -11.2199 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2435 -11.6267 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9479 -10.3950 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 2 0 0 0 0 + 1 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 2 5 -1 10 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C01996.mol b/src/analysis/thermo/trainingModel/data/mol/C01996.mol new file mode 100644 index 0000000000..f4f02867b1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C01996.mol @@ -0,0 +1,25 @@ +C01996 + Mrv1652304062119492D + + 10 9 0 0 0 0 999 V2000 + 13.4467 -9.2782 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.1599 -9.6927 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0039 -10.0828 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0355 -8.4736 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6245 -9.2782 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8731 -9.2782 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5864 -9.6927 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2996 -9.2782 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0129 -9.6927 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2996 -8.4560 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 1 1 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02022.mol b/src/analysis/thermo/trainingModel/data/mol/C02022.mol new file mode 100644 index 0000000000..fb7a42f1eb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02022.mol @@ -0,0 +1,20 @@ +C02022 + Mrv1652304062119492D + + 8 7 0 0 1 0 999 V2000 + 5.1151 -6.8064 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8296 -7.2189 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.5441 -6.8064 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2586 -7.2189 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 7.9730 -6.8064 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6876 -7.2189 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.5441 -5.9815 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2586 -8.0439 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02037.mol b/src/analysis/thermo/trainingModel/data/mol/C02037.mol new file mode 100644 index 0000000000..7436549a60 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02037.mol @@ -0,0 +1,23 @@ +C02037 + Mrv1652304062119492D + + 9 8 0 0 0 0 999 V2000 + 11.8795 -11.7970 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.5939 -11.3845 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3084 -11.7970 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0228 -11.3845 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7373 -11.7970 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4518 -11.3845 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1662 -11.7970 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.4518 -10.5598 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3084 -12.6219 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 + 3 9 2 0 0 0 0 +M CHG 2 1 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02043.mol b/src/analysis/thermo/trainingModel/data/mol/C02043.mol new file mode 100644 index 0000000000..bb46e0d03d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02043.mol @@ -0,0 +1,37 @@ +C02043 + Mrv1652304062119492D + + 15 16 0 0 0 0 999 V2000 + 11.5500 -9.1987 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5500 -10.0237 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2644 -10.4362 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9790 -10.0237 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9790 -9.1987 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2644 -8.7862 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7636 -10.2787 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2485 -9.6112 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7636 -8.9438 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0176 -8.1620 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8305 -7.9892 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3977 -8.6194 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0835 -7.2113 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9023 -7.0374 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5417 -6.6091 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 5 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 2 0 0 0 0 +M CHG 1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02045.mol b/src/analysis/thermo/trainingModel/data/mol/C02045.mol new file mode 100644 index 0000000000..6b4906b554 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02045.mol @@ -0,0 +1,20 @@ +C02045 + Mrv1652304062119492D + + 8 7 0 0 1 0 999 V2000 + 6.3939 -10.6427 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.1084 -11.0552 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8229 -10.6427 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5373 -11.0552 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.2518 -10.6427 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9663 -11.0552 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8229 -9.8178 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5373 -11.8803 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 6 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02048.mol b/src/analysis/thermo/trainingModel/data/mol/C02048.mol new file mode 100644 index 0000000000..15d5c4f18c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02048.mol @@ -0,0 +1,52 @@ +C02048 + Mrv1652304062119492D + + 23 24 0 0 1 0 999 V2000 + 10.7381 -8.2904 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.7533 -9.2181 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0270 -7.8722 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.4604 -7.8722 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.8217 -9.6022 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.0270 -7.0547 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.3161 -8.2904 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4604 -7.0547 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1791 -8.2904 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0994 -9.1838 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8217 -10.4234 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.7381 -6.6364 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3085 -6.6402 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1791 -6.6364 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3883 -9.6022 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.0994 -10.8416 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.5366 -10.8416 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3085 -5.8152 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3883 -10.4234 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 7.6698 -9.1914 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0994 -11.6667 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6735 -10.8416 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6660 -8.3626 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 5 2 1 1 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 11 5 1 0 0 0 0 + 6 12 1 0 0 0 0 + 6 13 1 1 0 0 0 + 8 14 1 0 0 0 0 + 15 10 1 0 0 0 0 + 11 16 1 0 0 0 0 + 11 17 1 6 0 0 0 + 13 18 1 0 0 0 0 + 19 15 1 0 0 0 0 + 15 20 1 1 0 0 0 + 16 21 1 1 0 0 0 + 19 22 1 6 0 0 0 + 20 23 1 0 0 0 0 + 8 12 1 0 0 0 0 + 16 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02110.mol b/src/analysis/thermo/trainingModel/data/mol/C02110.mol new file mode 100644 index 0000000000..666061f191 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02110.mol @@ -0,0 +1,47 @@ +C02110 + Mrv1652304062119492D + + 21 21 0 0 0 0 999 V2000 + 9.0686 -8.1053 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3447 -7.6960 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0686 -8.9391 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7812 -7.6921 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6322 -8.1053 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6246 -7.2828 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0496 -7.2791 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3447 -9.3599 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7812 -9.3523 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4937 -8.1016 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6322 -8.9391 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2063 -7.6884 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9225 -8.0977 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2290 -6.8849 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6351 -7.6846 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3515 -8.0940 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3515 -8.9202 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6390 -9.3334 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0679 -9.3295 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6427 -10.1558 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9301 -10.5727 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 3 9 1 0 0 0 0 + 4 10 2 0 0 0 0 + 5 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 12 13 2 0 0 0 0 + 12 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 2 0 0 0 0 + 17 19 1 0 0 0 0 + 18 20 1 4 0 0 0 + 20 21 2 0 0 0 0 + 8 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02115.mol b/src/analysis/thermo/trainingModel/data/mol/C02115.mol new file mode 100644 index 0000000000..d8c4327b04 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02115.mol @@ -0,0 +1,21 @@ +C02115 + Mrv1652304062119492D + + 8 7 0 0 1 0 999 V2000 + 10.9553 -9.0027 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.6726 -8.5911 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2455 -8.5911 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7929 -8.1154 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9553 -9.8257 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.3823 -9.0027 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6726 -7.7757 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5395 -9.0027 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 1 0 0 0 + 2 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 3 8 1 0 0 0 0 +M CHG 2 5 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02147.mol b/src/analysis/thermo/trainingModel/data/mol/C02147.mol new file mode 100644 index 0000000000..bbf6be416d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02147.mol @@ -0,0 +1,29 @@ +C02147 + Mrv1652304062119492D + + 12 11 0 0 1 0 999 V2000 + 10.5733 -9.2778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8596 -9.6917 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.2870 -9.6917 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1421 -9.2778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8596 -10.5192 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0044 -9.2778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4284 -9.6917 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7181 -9.6917 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7148 -9.2778 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4356 -9.2778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1493 -9.6954 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.4508 -8.5034 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 1 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 +M CHG 1 11 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02163.mol b/src/analysis/thermo/trainingModel/data/mol/C02163.mol new file mode 100644 index 0000000000..1a219e5546 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02163.mol @@ -0,0 +1,128 @@ +C02163 + + + 56 60 0 0 1 0 0 0 0 0999 V2000 + 22.3300 -15.5400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.9100 -14.2800 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 23.6600 -15.5400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.4200 -17.2200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.9600 -13.5800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2800 -13.0200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0100 -14.3500 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 24.4300 -16.5900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4200 -18.5500 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 19.9500 -13.0200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.2700 -13.9300 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0100 -18.5500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4200 -19.8100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0900 -18.5500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8500 -13.0200 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 25.4100 -18.5500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8500 -11.6900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8500 -14.2800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5200 -13.0200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.3200 -19.8800 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.8500 -10.4300 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 26.7400 -21.0700 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 27.3700 -19.1100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4300 -9.1700 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.1800 -10.4300 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 28.0700 -21.0700 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 28.4200 -19.8800 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.4800 -8.4000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5300 -9.1700 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.9500 -11.4800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 29.2600 -22.5400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7900 -8.8200 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1000 -8.7500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0500 -9.6600 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.9000 -22.1900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 29.7500 -19.4600 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 30.8700 -20.3000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.9900 -19.4600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.5700 -18.1300 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 30.1700 -18.1300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.0100 -21.7000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 32.2700 -22.2600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.3900 -21.4200 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 33.3200 -20.0900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.4400 -19.2500 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 29.2600 -23.9400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.0700 -24.6400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 30.4500 -24.6400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.6400 -23.9400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.8300 -24.6400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.0200 -23.9400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 35.2100 -24.6400 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 30.4500 -26.0400 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 36.4281 -23.9499 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.6095 -24.6450 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 36.3698 -22.5406 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 1 6 0 0 + 2 5 1 0 0 0 + 2 6 1 1 0 0 + 3 7 1 0 0 0 + 3 8 1 6 0 0 + 4 9 1 0 0 0 + 6 10 1 0 0 0 + 7 11 1 1 0 0 + 9 12 1 0 0 0 + 9 13 1 0 0 0 + 9 14 2 0 0 0 + 10 15 1 0 0 0 + 12 16 1 0 0 0 + 15 17 1 0 0 0 + 15 18 1 0 0 0 + 15 19 2 0 0 0 + 20 16 1 1 0 0 + 21 17 1 6 0 0 + 20 22 1 0 0 0 + 20 23 1 0 0 0 + 21 24 1 0 0 0 + 21 25 1 0 0 0 + 22 26 1 0 0 0 + 23 27 1 0 0 0 + 24 28 1 0 0 0 + 25 29 1 0 0 0 + 25 30 1 6 0 0 + 26 31 1 6 0 0 + 29 32 1 1 0 0 + 5 7 1 0 0 0 + 26 27 1 0 0 0 + 28 29 1 0 0 0 + 24 33 1 1 0 0 + 33 34 1 0 0 0 + 22 35 1 6 0 0 + 27 36 1 1 0 0 + 36 37 1 0 0 0 + 37 38 1 0 0 0 + 38 39 1 0 0 0 + 39 40 2 0 0 0 + 36 40 1 0 0 0 + 37 41 2 0 0 0 + 41 42 1 0 0 0 + 42 43 2 0 0 0 + 43 44 1 0 0 0 + 38 44 2 0 0 0 + 44 45 1 0 0 0 + 31 46 1 0 0 0 + 46 47 2 0 0 0 + 46 48 1 0 0 0 + 48 49 1 0 0 0 + 49 50 1 0 0 0 + 50 51 1 0 0 0 + 51 52 1 0 0 0 + 48 53 1 6 0 0 + 52 54 1 0 0 0 + 54 55 1 0 0 0 + 54 56 2 0 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 13 1 2 3 4 5 6 7 8 9 10 11 13 14 +M SDI 1 4 19.1100 -13.6500 19.1100 -12.2500 +M SDI 1 4 22.6100 -17.7800 22.6100 -19.3900 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C02226.mol b/src/analysis/thermo/trainingModel/data/mol/C02226.mol new file mode 100644 index 0000000000..b155884296 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02226.mol @@ -0,0 +1,23 @@ +C02226 + Mrv1652304062119492D + + 9 8 0 0 0 0 999 V2000 + 16.3639 -12.5779 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6508 -12.9913 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3639 -11.7547 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1221 -12.9913 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8552 -12.5779 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0809 -11.3450 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.6508 -11.3450 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8552 -11.8372 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1420 -12.9951 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 2 0 0 0 0 + 5 9 1 0 0 0 0 +M CHG 2 6 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02237.mol b/src/analysis/thermo/trainingModel/data/mol/C02237.mol new file mode 100644 index 0000000000..949a1f3596 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02237.mol @@ -0,0 +1,24 @@ +C02237 + Mrv1652304062119492D + + 9 9 0 0 1 0 999 V2000 + 10.8189 -8.4910 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.8189 -9.2794 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0608 -8.1651 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5276 -8.0741 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9509 -9.4916 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5416 -8.7639 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2439 -8.4834 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.5276 -7.2289 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6211 -10.2458 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 2 0 0 0 0 + 5 6 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02271.mol b/src/analysis/thermo/trainingModel/data/mol/C02271.mol new file mode 100644 index 0000000000..5f63b72d42 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02271.mol @@ -0,0 +1,10 @@ +C02271 + Mrv1652304062119492D + + 3 2 0 0 0 0 999 V2000 + 10.8863 -8.8954 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5586 -8.4817 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1316 -8.4817 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02280.mol b/src/analysis/thermo/trainingModel/data/mol/C02280.mol new file mode 100644 index 0000000000..21906c9d5e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02280.mol @@ -0,0 +1,87 @@ +C02280 + Mrv1652304062119492D + + 39 42 0 0 1 0 999 V2000 + 15.9109 -8.0956 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1199 -7.8459 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3432 -9.3673 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.4369 -7.4371 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1199 -7.0132 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4008 -8.2660 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6620 -8.8752 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0935 -10.1393 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.9146 -6.7559 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4008 -6.6007 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6855 -7.8459 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0035 -9.3560 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.2683 -10.1393 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.5816 -10.7596 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6855 -7.0132 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3970 -5.8635 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0544 -8.2125 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2200 -9.1061 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7952 -10.7671 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5009 -9.5111 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6796 -9.5111 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8546 -9.5111 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6986 -10.3168 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6835 -8.7281 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0333 -9.5111 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2083 -9.5111 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0102 -10.3125 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.9950 -8.7281 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4967 -9.9236 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 7.7777 -9.5111 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4967 -10.7449 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 7.0623 -9.9236 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 7.7777 -11.1573 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.2083 -11.1573 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0623 -10.7449 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 6.3585 -9.5111 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7777 -11.9366 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3585 -11.1573 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 5.7302 -10.0447 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 2 0 0 0 0 + 11 17 1 0 0 0 0 + 12 18 1 1 0 0 0 + 13 19 1 6 0 0 0 + 18 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 22 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 25 27 1 0 0 0 0 + 25 28 2 0 0 0 0 + 29 26 1 6 0 0 0 + 29 30 1 0 0 0 0 + 31 29 1 0 0 0 0 + 32 30 1 0 0 0 0 + 31 33 1 0 0 0 0 + 31 34 1 1 0 0 0 + 35 32 1 0 0 0 0 + 32 36 1 6 0 0 0 + 33 37 1 6 0 0 0 + 35 38 1 6 0 0 0 + 36 39 1 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 1 0 0 0 0 + 13 12 1 0 0 0 0 + 33 35 1 0 0 0 0 +M CHG 2 23 -1 27 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02295.mol b/src/analysis/thermo/trainingModel/data/mol/C02295.mol new file mode 100644 index 0000000000..1e90af7807 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02295.mol @@ -0,0 +1,25 @@ +C02295 + Mrv1652304062119492D + + 10 9 0 0 0 0 999 V2000 + 6.8609 -8.4977 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.5754 -8.9102 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2898 -8.4977 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0043 -8.9102 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7188 -8.4977 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.5754 -9.7351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2898 -7.6727 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.1365 -8.9160 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 6.8608 -7.6728 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0043 -9.7352 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 1 8 1 0 0 0 0 + 1 9 2 0 0 0 0 + 4 10 2 0 0 0 0 +M CHG 2 5 -1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02305.mol b/src/analysis/thermo/trainingModel/data/mol/C02305.mol new file mode 100644 index 0000000000..0cbd7bc4f6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02305.mol @@ -0,0 +1,31 @@ +C02305 + Mrv1652304062119492D + + 13 12 0 0 0 0 999 V2000 + 14.4393 -11.1732 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1528 -10.7595 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7219 -10.7595 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.4393 -11.9968 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8664 -11.1732 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1528 -9.9358 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5838 -10.7595 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2974 -11.1732 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.5800 -9.9358 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8969 -10.7595 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0719 -10.7595 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.8970 -9.9414 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8968 -11.5911 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 3 10 1 4 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 + 10 13 1 0 0 0 0 +M CHG 4 3 1 8 -1 11 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02357.mol b/src/analysis/thermo/trainingModel/data/mol/C02357.mol new file mode 100644 index 0000000000..e01022148b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02357.mol @@ -0,0 +1,26 @@ +C02357 + Mrv1652304062119492D + + 10 10 0 0 0 0 999 V2000 + 16.5755 -9.7341 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2936 -10.1402 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8685 -10.1402 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6127 -8.9145 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2936 -10.9674 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0005 -9.7303 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8685 -10.9674 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2785 -8.5046 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.8647 -8.5083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5755 -11.3848 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 7 10 1 0 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02359.mol b/src/analysis/thermo/trainingModel/data/mol/C02359.mol new file mode 100644 index 0000000000..8fb45d5872 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02359.mol @@ -0,0 +1,26 @@ +C02359 + Mrv1652304062119492D + + 10 10 0 0 0 0 999 V2000 + 10.4396 -8.4445 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1561 -8.8534 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7343 -8.8534 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4768 -7.6715 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1561 -9.6787 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8614 -8.4445 0.0000 F 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7343 -9.6787 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1858 -7.2626 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.7677 -7.2662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4396 -10.0952 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 7 10 1 0 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02364.mol b/src/analysis/thermo/trainingModel/data/mol/C02364.mol new file mode 100644 index 0000000000..463783d893 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02364.mol @@ -0,0 +1,26 @@ +C02364 + Mrv1652304062119492D + + 10 10 0 0 0 0 999 V2000 + 10.4573 -8.4618 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1744 -8.8673 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7475 -8.8673 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4946 -7.6432 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1744 -9.6933 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7475 -9.6933 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2042 -7.2377 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.7849 -7.2415 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4573 -10.1139 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8804 -10.1026 0.0000 F 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02370.mol b/src/analysis/thermo/trainingModel/data/mol/C02370.mol new file mode 100644 index 0000000000..6b5e59bdbf --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02370.mol @@ -0,0 +1,26 @@ +C02370 + Mrv1652304062119492D + + 10 10 0 0 0 0 999 V2000 + 17.5344 -9.4997 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1827 -9.0581 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7675 -9.1196 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5318 -10.3247 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9065 -9.4349 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.1881 -8.2445 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0730 -9.5601 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8374 -10.7652 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0979 -10.3847 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4078 -10.8181 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 7 9 2 0 0 0 0 + 9 10 1 0 0 0 0 + 8 9 1 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02371.mol b/src/analysis/thermo/trainingModel/data/mol/C02371.mol new file mode 100644 index 0000000000..f18cd15fc5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02371.mol @@ -0,0 +1,26 @@ +C02371 + Mrv1652304062119492D + + 10 10 0 0 0 0 999 V2000 + 10.8191 -8.0607 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8154 -7.2410 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1085 -8.4667 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5372 -8.4667 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5260 -6.8348 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.1046 -6.8386 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1085 -9.2939 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5372 -9.2939 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8191 -9.7114 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8154 -10.5311 0.0000 F 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 7 9 2 0 0 0 0 + 9 10 1 0 0 0 0 + 8 9 1 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02405.mol b/src/analysis/thermo/trainingModel/data/mol/C02405.mol new file mode 100644 index 0000000000..33fc34d90d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02405.mol @@ -0,0 +1,19 @@ +C02405 + Mrv1652304062119492D + + 7 6 0 0 0 0 999 V2000 + 14.6871 -11.1625 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5091 -11.1587 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3348 -11.1587 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.5091 -10.3330 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5091 -11.9807 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9619 -10.7598 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9963 -9.9355 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 1 6 1 0 0 0 0 + 6 7 2 0 0 0 0 +M CHG 2 3 -1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02480.mol b/src/analysis/thermo/trainingModel/data/mol/C02480.mol new file mode 100644 index 0000000000..f2f03461f6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02480.mol @@ -0,0 +1,25 @@ +C02480 + Mrv1652304062119492D + + 10 9 0 0 0 0 999 V2000 + 17.7360 -9.1777 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4496 -9.5875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0190 -9.5910 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4532 -10.4114 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.1668 -9.1708 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0190 -10.4148 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3018 -10.8322 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5882 -10.4183 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5847 -9.5910 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.8711 -10.8391 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 6 7 2 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 2 4 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02553.mol b/src/analysis/thermo/trainingModel/data/mol/C02553.mol new file mode 100644 index 0000000000..3a134a5feb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02553.mol @@ -0,0 +1,98 @@ +C02553 + + + 42 44 0 0 1 0 0 0 0 0999 V2000 + 25.0600 -18.4100 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.6400 -17.1500 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 26.3900 -18.4100 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.1500 -20.0900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.6900 -16.4500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0100 -15.8900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7400 -17.2200 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 27.1600 -19.4600 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1500 -21.4200 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 22.6800 -15.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.0000 -16.8000 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7400 -21.4200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1500 -22.6800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8200 -21.4200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5800 -15.8900 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 28.1400 -21.4200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5800 -14.5600 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5800 -17.1500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2500 -15.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 29.0500 -22.7500 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.5800 -13.3000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 29.4700 -23.9400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 30.1000 -21.9800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1600 -12.0400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.9100 -13.3000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 30.8000 -23.9400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 31.1500 -22.7500 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.2100 -11.2700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.2600 -12.0400 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 22.6800 -14.3500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 31.5700 -24.9900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 32.4100 -22.3300 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5200 -11.6900 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2800 -24.6400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.0200 -23.9400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.8300 -24.6400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.6400 -23.9400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3800 -24.6400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.0200 -22.5400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.8300 -26.0400 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9700 -11.3400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7100 -12.0400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 1 6 0 0 + 2 5 1 0 0 0 + 2 6 1 1 0 0 + 3 7 1 0 0 0 + 3 8 1 6 0 0 + 4 9 1 0 0 0 + 6 10 1 0 0 0 + 7 11 1 1 0 0 + 9 12 1 0 0 0 + 9 13 1 0 0 0 + 9 14 2 0 0 0 + 10 15 1 0 0 0 + 12 16 1 0 0 0 + 15 17 1 0 0 0 + 15 18 1 0 0 0 + 15 19 2 0 0 0 + 20 16 1 1 0 0 + 21 17 1 6 0 0 + 20 22 1 0 0 0 + 20 23 1 0 0 0 + 21 24 1 0 0 0 + 21 25 1 0 0 0 + 22 26 1 0 0 0 + 23 27 1 0 0 0 + 24 28 1 0 0 0 + 25 29 1 0 0 0 + 25 30 1 6 0 0 + 26 31 1 6 0 0 + 27 32 1 1 0 0 + 29 33 1 1 0 0 + 5 7 1 0 0 0 + 26 27 1 0 0 0 + 28 29 1 0 0 0 + 22 34 1 6 0 0 + 34 35 1 0 0 0 + 35 36 1 0 0 0 + 36 37 1 0 0 0 + 37 38 1 0 0 0 + 35 39 2 0 0 0 + 36 40 1 1 0 0 + 24 41 1 1 0 0 + 41 42 1 0 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 13 1 2 3 4 5 6 7 8 9 10 11 13 14 +M SDI 1 4 21.9800 -16.5200 21.9800 -15.1200 +M SDI 1 4 25.2000 -20.9300 25.2000 -22.4000 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C02554.mol b/src/analysis/thermo/trainingModel/data/mol/C02554.mol new file mode 100644 index 0000000000..5029013098 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02554.mol @@ -0,0 +1,120 @@ +C02554 + + + 52 56 0 0 1 0 0 0 0 0999 V2000 + 22.7500 -15.3300 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 22.3300 -14.0700 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.0800 -15.3300 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.8400 -17.0100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3800 -13.3700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7000 -12.8100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.4300 -14.1400 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 24.8500 -16.3800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8400 -18.3400 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 20.3700 -12.8100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.6900 -13.7200 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 24.4300 -18.3400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8400 -19.6000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5100 -18.3400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2700 -12.8100 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 25.8300 -18.3400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2700 -11.4800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2700 -14.0700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9400 -12.8100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7400 -19.6700 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.2700 -10.2200 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 27.1600 -20.8600 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 27.7900 -18.9000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8500 -8.9600 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.6000 -10.2200 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 28.4900 -20.8600 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 28.8400 -19.6700 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.9000 -8.1900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9500 -8.9600 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.3700 -11.2700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 29.5400 -22.7500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 30.1000 -19.2500 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2100 -8.6100 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5200 -8.5400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4700 -9.4500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.3200 -21.9800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 31.2200 -20.0900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 32.3400 -19.2500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.9200 -17.9200 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 30.5200 -17.9200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.4300 -21.4900 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 32.6900 -22.0500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.8100 -21.2100 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 33.6700 -19.8100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.7900 -18.9700 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 29.5400 -24.1500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3276 -24.8500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 30.7524 -24.8500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.9424 -24.1500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.1549 -24.8500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.7581 -26.2497 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 31.9367 -22.7501 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 1 6 0 0 + 2 5 1 0 0 0 + 2 6 1 1 0 0 + 3 7 1 0 0 0 + 3 8 1 6 0 0 + 4 9 1 0 0 0 + 6 10 1 0 0 0 + 7 11 1 1 0 0 + 9 12 1 0 0 0 + 9 13 1 0 0 0 + 9 14 2 0 0 0 + 10 15 1 0 0 0 + 12 16 1 0 0 0 + 15 17 1 0 0 0 + 15 18 1 0 0 0 + 15 19 2 0 0 0 + 20 16 1 1 0 0 + 21 17 1 6 0 0 + 20 22 1 0 0 0 + 20 23 1 0 0 0 + 21 24 1 0 0 0 + 21 25 1 0 0 0 + 22 26 1 0 0 0 + 23 27 1 0 0 0 + 24 28 1 0 0 0 + 25 29 1 0 0 0 + 25 30 1 6 0 0 + 26 31 1 6 0 0 + 27 32 1 1 0 0 + 29 33 1 1 0 0 + 5 7 1 0 0 0 + 26 27 1 0 0 0 + 28 29 1 0 0 0 + 24 34 1 1 0 0 + 34 35 1 0 0 0 + 22 36 1 6 0 0 + 32 37 1 0 0 0 + 37 38 1 0 0 0 + 38 39 1 0 0 0 + 39 40 2 0 0 0 + 32 40 1 0 0 0 + 37 41 2 0 0 0 + 41 42 1 0 0 0 + 42 43 2 0 0 0 + 43 44 1 0 0 0 + 38 44 2 0 0 0 + 44 45 1 0 0 0 + 31 46 1 0 0 0 + 46 47 2 0 0 0 + 46 48 1 0 0 0 + 48 49 1 0 0 0 + 49 50 1 0 0 0 + 48 51 1 6 0 0 + 49 52 1 0 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 13 1 2 3 4 5 6 7 8 9 10 11 13 14 +M SDI 1 4 19.6000 -13.4400 19.6000 -12.0400 +M SDI 1 4 23.1000 -17.6400 23.1000 -19.1800 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C02557.mol b/src/analysis/thermo/trainingModel/data/mol/C02557.mol new file mode 100644 index 0000000000..8307041ff3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02557.mol @@ -0,0 +1,118 @@ +C02557 + Mrv1652304062119492D + + 55 57 0 0 1 0 999 V2000 + 17.4620 -22.6875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1765 -22.2750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8909 -22.6875 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6054 -22.2750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3199 -22.6875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0343 -22.2750 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7488 -22.6875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4633 -22.2750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1777 -22.6875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8922 -22.2750 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.6067 -22.6875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3211 -22.2750 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.0356 -22.6875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7501 -22.2750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4645 -22.6875 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1765 -21.4501 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7488 -23.5124 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.6067 -23.5123 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.3211 -21.4500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0356 -21.8625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0356 -23.5125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2895 -22.6875 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 29.1145 -22.6875 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2895 -23.5125 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.4613 -19.7588 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 25.2863 -19.7588 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.5412 -18.9741 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.8738 -18.4892 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.2063 -18.9741 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.3188 -18.7214 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9763 -20.4262 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.7712 -20.4262 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5962 -20.4262 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 26.5962 -19.6012 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.4212 -20.4262 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 26.5962 -21.2512 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7800 -17.9025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7800 -18.7275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2090 -18.7275 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2090 -17.9025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4945 -17.4900 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0656 -17.4900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3510 -17.9025 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3510 -18.7275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0656 -19.1400 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0656 -16.6651 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4869 -18.9762 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3119 -18.9762 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3119 -18.1512 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 29.1369 -18.9762 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3119 -20.8737 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7377 -22.2692 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0281 -22.6788 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.7378 -21.4501 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4619 -23.5124 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 52 54 2 0 0 0 0 + 1 55 1 0 0 0 0 +M CHG 5 24 -1 34 -1 35 -1 49 -1 53 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02560.mol b/src/analysis/thermo/trainingModel/data/mol/C02560.mol new file mode 100644 index 0000000000..6f53877747 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02560.mol @@ -0,0 +1,21 @@ +C02560 + Mrv1652304062119492D + + 8 8 0 0 0 0 999 V2000 + 15.5774 -9.4508 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5774 -8.6306 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9082 -9.9348 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2433 -9.9348 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2912 -8.2188 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8670 -8.2188 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1622 -10.7208 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9893 -10.7208 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 2 0 0 0 0 + 7 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02571.mol b/src/analysis/thermo/trainingModel/data/mol/C02571.mol new file mode 100644 index 0000000000..30f65751ab --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02571.mol @@ -0,0 +1,33 @@ +C02571 + Mrv1652304062119502D + + 14 13 0 0 1 0 999 V2000 + 11.5076 -9.7633 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7939 -9.3496 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2214 -9.3496 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 10.0801 -9.7633 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7939 -8.5255 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9763 -10.0107 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2516 -9.3462 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1843 -10.5137 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3630 -9.3496 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5076 -8.1118 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6492 -9.7633 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.3630 -8.5255 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2214 -8.5255 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5076 -7.2877 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 1 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 9 12 2 0 0 0 0 + 10 13 1 0 0 0 0 + 10 14 2 0 0 0 0 +M CHG 2 3 1 11 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02588.mol b/src/analysis/thermo/trainingModel/data/mol/C02588.mol new file mode 100644 index 0000000000..15d329578f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02588.mol @@ -0,0 +1,81 @@ +C02588 + Mrv1652304062119502D + + 38 38 0 0 0 0 999 V2000 + 8.6586 -13.0507 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3697 -12.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0808 -13.0507 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8338 -12.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5448 -13.0507 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8338 -11.8377 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2559 -12.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0089 -13.0507 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7200 -12.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4311 -13.0507 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7200 -11.7958 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1840 -12.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8951 -13.0507 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6062 -12.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3591 -13.0507 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6062 -11.7958 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0702 -12.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8231 -13.0507 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5342 -12.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2453 -13.0507 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9564 -12.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6675 -13.0507 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6675 -13.8873 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9564 -14.3056 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2453 -13.8873 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5342 -14.2637 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8231 -13.8873 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0284 -14.2637 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3173 -13.8455 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6062 -14.2637 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9475 -12.6324 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2364 -13.0507 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2364 -13.9291 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9475 -14.3474 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6586 -13.8873 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.4038 -12.0050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4077 -11.9213 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4116 -14.3056 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 2 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 7 8 2 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 2 0 0 0 0 + 9 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 14 16 2 0 0 0 0 + 15 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 29 30 1 0 0 0 0 + 1 31 1 0 0 0 0 + 31 32 1 0 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 34 35 1 0 0 0 0 + 1 35 2 0 0 0 0 + 31 36 1 0 0 0 0 + 31 37 1 0 0 0 0 + 35 38 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02595.mol b/src/analysis/thermo/trainingModel/data/mol/C02595.mol new file mode 100644 index 0000000000..4276feb83d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02595.mol @@ -0,0 +1,24 @@ +C02595 + Mrv1652304062119502D + + 9 9 0 0 0 0 999 V2000 + 12.4480 -9.4525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7068 -10.2358 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5318 -10.2317 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7828 -9.4458 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1130 -8.9642 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4918 -9.0337 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2063 -9.4462 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9208 -9.0337 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.2063 -10.2710 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02612.mol b/src/analysis/thermo/trainingModel/data/mol/C02612.mol new file mode 100644 index 0000000000..775b877bff --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02612.mol @@ -0,0 +1,25 @@ +C02612 + Mrv1652304062119502D + + 10 9 0 0 1 0 999 V2000 + 9.9002 -5.7339 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.6147 -6.1464 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3292 -5.7339 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0437 -6.1464 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.7581 -5.7339 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4727 -6.1464 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.7581 -4.9089 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6147 -6.9714 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4562 -6.8609 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6312 -6.8609 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 2 0 0 0 0 + 2 8 2 0 0 0 0 + 4 9 1 1 0 0 0 + 4 10 1 6 0 0 0 +M CHG 2 1 -1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02614.mol b/src/analysis/thermo/trainingModel/data/mol/C02614.mol new file mode 100644 index 0000000000..82f464a00b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02614.mol @@ -0,0 +1,25 @@ +C02614 + Mrv1652304062119502D + + 10 9 0 0 1 0 999 V2000 + 17.4492 -10.6427 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.1637 -11.0552 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8782 -10.6427 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5926 -11.0552 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.3071 -10.6427 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0216 -11.0552 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 20.3071 -9.8177 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1637 -11.8803 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0052 -11.7697 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1801 -11.7697 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 2 0 0 0 0 + 2 8 2 0 0 0 0 + 4 9 1 6 0 0 0 + 4 10 1 1 0 0 0 +M CHG 2 1 -1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02636.mol b/src/analysis/thermo/trainingModel/data/mol/C02636.mol new file mode 100644 index 0000000000..18c2df772b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02636.mol @@ -0,0 +1,27 @@ +C02636 + Mrv1652304062119502D + + 11 10 0 0 0 0 999 V2000 + 17.0538 -9.4751 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.3400 -9.8888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8501 -9.7238 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0538 -8.6510 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2676 -10.2715 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6229 -9.4751 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9091 -9.8888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1954 -9.4751 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1954 -8.6510 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4815 -9.8888 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.6588 -8.6461 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 8 10 1 0 0 0 0 + 6 11 2 0 0 0 0 +M CHG 2 1 1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02637.mol b/src/analysis/thermo/trainingModel/data/mol/C02637.mol new file mode 100644 index 0000000000..c364d740ca --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02637.mol @@ -0,0 +1,30 @@ +C02637 + Mrv1652304062119502D + + 12 12 0 0 1 0 999 V2000 + 10.8206 -8.0597 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5362 -8.4703 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1088 -8.4703 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8169 -7.2425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5362 -9.2988 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1088 -9.2988 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5249 -6.8320 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.1050 -6.8357 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8206 -9.7169 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2480 -9.7055 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3969 -9.7055 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8169 -10.5379 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 9 5 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 2 0 0 0 0 + 9 12 1 6 0 0 0 + 9 6 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02642.mol b/src/analysis/thermo/trainingModel/data/mol/C02642.mol new file mode 100644 index 0000000000..9a56b8e91c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02642.mol @@ -0,0 +1,23 @@ +C02642 + Mrv1652304062119502D + + 9 8 0 0 0 0 999 V2000 + 9.1165 -12.4578 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8309 -12.8703 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5454 -12.4578 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2599 -12.8703 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9744 -12.4578 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6889 -12.8703 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4034 -12.4578 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.8309 -13.6952 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6889 -13.6951 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 2 0 0 0 0 + 6 9 2 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02652.mol b/src/analysis/thermo/trainingModel/data/mol/C02652.mol new file mode 100644 index 0000000000..51766466fd --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02652.mol @@ -0,0 +1,30 @@ +C02652 + Mrv1652304062119502D + + 12 12 0 0 1 0 999 V2000 + 10.8206 -8.0597 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5362 -8.4703 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1088 -8.4703 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8169 -7.2425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5362 -9.2988 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1088 -9.2988 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.5249 -6.8320 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.1050 -6.8357 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8206 -9.7169 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2480 -9.7055 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4792 -9.6644 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8169 -10.5379 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 6 3 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 9 5 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 6 0 0 0 + 9 12 1 6 0 0 0 + 6 9 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02666.mol b/src/analysis/thermo/trainingModel/data/mol/C02666.mol new file mode 100644 index 0000000000..99a13fca0b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02666.mol @@ -0,0 +1,31 @@ +C02666 + Mrv1652304062119502D + + 13 13 0 0 0 0 999 V2000 + 20.3610 -10.9747 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3610 -11.7997 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0755 -12.2122 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7899 -11.7997 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7899 -10.9747 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0755 -10.5622 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5154 -12.2187 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5154 -10.5557 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5154 -9.7307 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6465 -10.5622 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9421 -10.9691 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2424 -10.5651 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2424 -9.7414 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 10 1 1 4 0 0 0 + 10 11 2 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02712.mol b/src/analysis/thermo/trainingModel/data/mol/C02712.mol new file mode 100644 index 0000000000..60176f992d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02712.mol @@ -0,0 +1,29 @@ +C02712 + Mrv1652304062119502D + + 12 11 0 0 1 0 999 V2000 + 16.3409 -9.0485 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.3409 -9.8742 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0560 -8.6373 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6221 -8.6373 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7713 -9.0485 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.0560 -7.8080 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9069 -9.0485 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1916 -8.6373 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4763 -9.0485 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0372 -10.2888 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7529 -9.8756 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0317 -11.1151 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 2 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02718.mol b/src/analysis/thermo/trainingModel/data/mol/C02718.mol new file mode 100644 index 0000000000..4b36aea3a7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02718.mol @@ -0,0 +1,19 @@ +C02718 + Mrv1652304062119502D + + 7 6 0 0 0 0 999 V2000 + 16.5053 -11.8998 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2190 -12.3136 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6677 -12.3136 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2190 -13.2199 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9327 -11.8961 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.9915 -11.8998 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2778 -12.3136 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 6 7 2 0 0 0 0 +M CHG 2 5 -1 7 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02763.mol b/src/analysis/thermo/trainingModel/data/mol/C02763.mol new file mode 100644 index 0000000000..efbea1b26d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02763.mol @@ -0,0 +1,30 @@ +C02763 + Mrv1652304062119502D + + 12 12 0 0 0 0 999 V2000 + 14.7493 -9.3303 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7493 -10.1045 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0566 -8.8822 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0566 -10.5527 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3232 -9.2896 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3232 -10.1452 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4419 -8.9229 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1346 -9.3303 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8272 -8.9229 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5199 -9.3303 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.1346 -10.1452 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8272 -8.1080 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 5 6 1 0 0 0 0 + 1 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 8 11 2 0 0 0 0 + 9 12 2 0 0 0 0 +M CHG 1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02780.mol b/src/analysis/thermo/trainingModel/data/mol/C02780.mol new file mode 100644 index 0000000000..dec2f4be4c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02780.mol @@ -0,0 +1 @@ +majorms:FAILED diff --git a/src/analysis/thermo/trainingModel/data/mol/C02782.mol b/src/analysis/thermo/trainingModel/data/mol/C02782.mol new file mode 100644 index 0000000000..8d8efcfd45 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02782.mol @@ -0,0 +1,29 @@ +C02782 + Mrv1652304062119502D + + 12 11 0 0 1 0 999 V2000 + 13.8933 -11.4764 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.1784 -11.8884 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6047 -11.8884 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.8933 -10.6517 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4637 -11.4764 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3194 -11.4764 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.6047 -12.7131 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7522 -11.8884 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.4637 -10.6517 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0266 -11.8884 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7449 -11.4764 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3125 -10.6495 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 1 0 0 0 + 5 8 1 0 0 0 0 + 5 9 2 0 0 0 0 + 6 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 6 12 1 6 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02798.mol b/src/analysis/thermo/trainingModel/data/mol/C02798.mol new file mode 100644 index 0000000000..5a85aa0687 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02798.mol @@ -0,0 +1,25 @@ +C02798 + Mrv1652304062119502D + + 10 9 0 0 0 0 999 V2000 + 14.4603 -10.3577 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1741 -9.9439 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8878 -10.3577 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1741 -9.1199 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6049 -9.9439 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.8878 -11.1819 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7571 -9.9532 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0427 -9.5407 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2732 -10.7327 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.2615 -9.1380 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 4 2 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 1 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 7 10 2 0 0 0 0 +M CHG 2 5 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02839.mol b/src/analysis/thermo/trainingModel/data/mol/C02839.mol new file mode 100644 index 0000000000..574eb6e34a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02839.mol @@ -0,0 +1,131 @@ +C02839 + + + 57 62 0 0 1 0 0 0 0 0999 V2000 + 10.9900 -9.4500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4100 -10.7800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8100 -10.7800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2300 -9.4500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1100 -8.6100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6600 -9.0300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5600 -9.0300 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5700 -11.9000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5800 -11.9000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6100 -9.9400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5700 -13.3000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8100 -13.3000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1700 -13.3000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5700 -14.7000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2100 -13.3000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4700 -14.0700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8900 -15.4000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2900 -15.4000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7100 -14.0700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5900 -13.2300 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0400 -13.6500 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0500 -16.5200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0600 -16.5200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0500 -17.9200 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4300 -17.9200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6500 -17.9200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0500 -19.3200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8300 -17.9200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3000 -18.8300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7200 -20.1600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1200 -20.1600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5400 -18.8300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4200 -17.9900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8800 -21.2800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8900 -21.2800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8730 -18.4020 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 25.0046 -19.2301 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1420 -18.4098 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.7132 -17.0746 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.3109 -17.0698 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.1462 -20.6230 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 26.4232 -21.1968 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.5605 -20.3764 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4190 -18.9836 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.5747 -18.1499 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8900 -22.6800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6776 -23.3800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1024 -23.3800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.2979 -22.6896 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.4853 -23.3751 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.4854 -24.7798 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.6979 -25.4797 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.9103 -24.7796 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.9101 -23.3749 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.6976 -22.6750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.1228 -25.4794 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1025 -24.7798 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 2 3 1 0 0 0 + 3 4 1 0 0 0 + 4 5 1 0 0 0 + 1 5 1 0 0 0 + 1 6 1 1 0 0 + 4 7 1 1 0 0 + 2 8 1 6 0 0 + 3 9 1 6 0 0 + 6 10 1 0 0 0 + 8 11 1 0 0 0 + 11 12 1 0 0 0 + 11 13 2 0 0 0 + 11 14 1 0 0 0 + 12 15 1 0 0 0 + 16 17 1 0 0 0 + 17 18 1 0 0 0 + 18 19 1 0 0 0 + 19 20 1 0 0 0 + 16 20 1 0 0 0 + 16 15 1 1 0 0 + 19 21 1 1 0 0 + 17 22 1 6 0 0 + 18 23 1 6 0 0 + 22 24 1 0 0 0 + 24 25 1 0 0 0 + 24 26 2 0 0 0 + 24 27 1 0 0 0 + 25 28 1 0 0 0 + 29 30 1 0 0 0 + 30 31 1 0 0 0 + 31 32 1 0 0 0 + 32 33 1 0 0 0 + 29 33 1 0 0 0 + 29 28 1 1 0 0 + 30 34 1 6 0 0 + 31 35 1 6 0 0 + 32 36 1 1 0 0 + 36 37 1 0 0 0 + 37 38 1 0 0 0 + 38 39 1 0 0 0 + 39 40 2 0 0 0 + 36 40 1 0 0 0 + 37 41 2 0 0 0 + 41 42 1 0 0 0 + 42 43 2 0 0 0 + 43 44 1 0 0 0 + 38 44 2 0 0 0 + 44 45 1 0 0 0 + 35 46 1 0 0 0 + 46 47 2 0 0 0 + 46 48 1 0 0 0 + 48 49 1 0 0 0 + 49 50 1 0 0 0 + 50 51 2 0 0 0 + 51 52 1 0 0 0 + 52 53 2 0 0 0 + 53 54 1 0 0 0 + 54 55 2 0 0 0 + 50 55 1 0 0 0 + 53 56 1 0 0 0 + 48 57 1 6 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 13 12 15 16 17 18 19 20 21 22 23 24 26 27 +M SDI 1 4 12.1800 -14.2100 12.1800 -12.4600 +M SDI 1 4 15.9600 -16.9400 15.9600 -18.7600 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C02930.mol b/src/analysis/thermo/trainingModel/data/mol/C02930.mol new file mode 100644 index 0000000000..bf5cfdab76 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02930.mol @@ -0,0 +1,25 @@ +C02930 + Mrv1652304062119502D + + 10 9 0 0 0 0 999 V2000 + 15.5158 -10.3399 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8003 -9.9271 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2276 -9.9271 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5158 -11.1652 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0885 -10.3399 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9394 -10.3436 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.2237 -9.1055 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3729 -9.9271 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3767 -9.1055 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6611 -10.3436 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 8 10 1 0 0 0 0 +M CHG 2 6 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02953.mol b/src/analysis/thermo/trainingModel/data/mol/C02953.mol new file mode 100644 index 0000000000..76ae735877 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02953.mol @@ -0,0 +1,40 @@ +C02953 + Mrv1652304062119502D + + 17 18 0 0 1 0 999 V2000 + 11.6974 -8.7220 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6974 -9.5513 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9774 -8.3149 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4136 -8.3035 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9774 -9.9697 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4211 -9.9697 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2688 -8.7220 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1411 -8.7183 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2688 -9.5513 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1449 -9.5551 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4211 -10.7878 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8460 -8.3035 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5564 -9.9584 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.8477 -9.5437 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.5525 -10.7802 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8552 -8.7220 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.1352 -9.9471 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 2 0 0 0 0 + 6 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 8 12 1 0 0 0 0 + 13 9 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 1 1 0 0 0 + 14 16 1 6 0 0 0 + 14 17 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02954.mol b/src/analysis/thermo/trainingModel/data/mol/C02954.mol new file mode 100644 index 0000000000..948018e7b0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02954.mol @@ -0,0 +1,35 @@ +C02954 + Mrv1652304062119502D + + 14 15 0 0 1 0 999 V2000 + 7.0197 -8.8566 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 7.0197 -9.6817 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8447 -9.6817 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8447 -8.8566 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.6285 -9.9291 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.1234 -9.2690 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6285 -8.6090 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7010 -9.8466 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7010 -8.6915 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9172 -10.7128 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7421 -10.7128 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.4221 -11.3728 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3184 -8.4440 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 6.3184 -10.0941 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 1 0 0 0 + 1 4 1 0 0 0 0 + 5 3 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 4 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 + 1 13 1 1 0 0 0 + 2 14 2 0 0 0 0 +M CHG 2 11 -1 13 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02988.mol b/src/analysis/thermo/trainingModel/data/mol/C02988.mol new file mode 100644 index 0000000000..5fb672e916 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02988.mol @@ -0,0 +1,107 @@ +C02988 + + + 46 49 0 0 1 0 0 0 0 0999 V2000 + 25.0600 -17.5000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.6400 -16.2400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 26.3900 -17.5000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.1500 -19.1800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.6900 -15.5400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0100 -14.9800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7400 -16.3100 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 27.1600 -18.5500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1500 -20.5100 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 22.6800 -14.9800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.0000 -15.8900 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7400 -20.5100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1500 -21.7700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8200 -20.5100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5800 -14.9800 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 28.1400 -20.5100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5800 -13.6500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5800 -16.2400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2500 -14.9800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 29.0500 -21.8400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.5800 -12.3900 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 29.4700 -23.0300 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 30.1000 -21.0700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1600 -11.1300 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.9100 -12.3900 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 30.8000 -23.0300 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 31.1500 -21.8400 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 21.2100 -10.3600 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.2600 -11.1300 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 22.6800 -13.4400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.5200 -10.7800 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8300 -10.7100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7800 -11.6200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 32.4800 -21.4200 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 31.6400 -24.1500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2100 -24.1500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.9976 -23.4500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.7851 -24.1500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.5727 -23.4500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3603 -24.1500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0978 -23.5878 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1731 -24.6147 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8639 -25.8116 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2157 -25.5244 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.7851 -25.5498 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 26.9976 -22.0502 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 1 6 0 0 + 2 5 1 0 0 0 + 2 6 1 1 0 0 + 3 7 1 0 0 0 + 3 8 1 6 0 0 + 4 9 1 0 0 0 + 6 10 1 0 0 0 + 7 11 1 1 0 0 + 9 12 1 0 0 0 + 9 13 1 0 0 0 + 9 14 2 0 0 0 + 10 15 1 0 0 0 + 12 16 1 0 0 0 + 15 17 1 0 0 0 + 15 18 1 0 0 0 + 15 19 2 0 0 0 + 20 16 1 1 0 0 + 21 17 1 6 0 0 + 20 22 1 0 0 0 + 20 23 1 0 0 0 + 21 24 1 0 0 0 + 21 25 1 0 0 0 + 22 26 1 0 0 0 + 23 27 1 0 0 0 + 24 28 1 0 0 0 + 25 29 1 0 0 0 + 25 30 1 6 0 0 + 29 31 1 1 0 0 + 5 7 1 0 0 0 + 26 27 1 0 0 0 + 28 29 1 0 0 0 + 24 32 1 1 0 0 + 32 33 1 0 0 0 + 27 34 1 1 0 0 + 26 35 1 6 0 0 + 36 37 1 0 0 0 + 37 38 1 0 0 0 + 38 39 1 0 0 0 + 39 40 1 0 0 0 + 40 41 1 0 0 0 + 41 42 2 0 0 0 + 42 43 1 0 0 0 + 43 44 1 0 0 0 + 40 44 2 0 0 0 + 38 45 1 1 0 0 + 37 46 2 0 0 0 + 22 36 1 6 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 13 1 2 3 4 5 6 7 8 9 10 11 13 14 +M SDI 1 4 21.8400 -15.6100 21.8400 -14.2100 +M SDI 1 4 25.3400 -19.7400 25.3400 -21.3500 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C02990.mol b/src/analysis/thermo/trainingModel/data/mol/C02990.mol new file mode 100644 index 0000000000..225011c2fc --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02990.mol @@ -0,0 +1,61 @@ +C02990 + Mrv1652304062119502D + + 28 27 0 0 1 0 999 V2000 + 19.9890 -4.8452 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.2830 -5.2506 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6917 -5.2472 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9857 -4.0311 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5805 -4.8452 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6950 -6.0612 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 20.6917 -3.6224 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8779 -5.2506 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5805 -4.0345 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4788 -6.4260 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9890 -6.4699 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.8639 -6.9666 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6883 -2.8117 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3943 -4.0311 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.1472 -4.8264 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4327 -5.2389 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7182 -4.8264 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0037 -5.2389 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2892 -4.8264 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5747 -5.2389 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8603 -4.8264 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1457 -5.2389 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4313 -4.8264 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7168 -5.2389 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0023 -4.8264 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2878 -5.2389 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5733 -4.8264 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8640 -5.2359 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 2 0 0 0 0 + 6 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 6 12 1 0 0 0 0 + 7 13 2 0 0 0 0 + 7 14 1 0 0 0 0 + 8 15 1 0 0 0 0 + 15 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 +M CHG 2 6 1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C02992.mol b/src/analysis/thermo/trainingModel/data/mol/C02992.mol new file mode 100644 index 0000000000..4c9c761a1f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C02992.mol @@ -0,0 +1,100 @@ +C02992 + + + 43 45 0 0 1 0 0 0 0 0999 V2000 + 16.3100 -10.1500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7300 -11.4800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1300 -11.4800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5500 -10.1500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4300 -9.3100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9800 -9.7300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.8800 -9.7300 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8900 -12.6000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9000 -12.6000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9300 -10.6400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8900 -14.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1300 -14.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4900 -14.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8900 -15.4000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5300 -14.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7900 -14.7700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2100 -16.1000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.6100 -16.1000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.0300 -14.7700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9100 -13.9300 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.3600 -14.3500 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3700 -17.2200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3800 -17.2200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3700 -18.6200 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7500 -18.6200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9700 -18.6200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3700 -20.0200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1500 -18.6200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.6200 -19.5300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0400 -20.8600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.4400 -20.8600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8600 -19.5300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7400 -18.6900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9200 -22.7500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2100 -21.9800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 29.1930 -19.1020 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 23.7076 -22.0500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4951 -22.7500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2827 -22.0500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0703 -22.7500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.7076 -20.6502 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2827 -21.0700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4951 -24.1498 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 2 3 1 0 0 0 + 3 4 1 0 0 0 + 4 5 1 0 0 0 + 1 5 1 0 0 0 + 1 6 1 1 0 0 + 4 7 1 1 0 0 + 2 8 1 6 0 0 + 3 9 1 6 0 0 + 6 10 1 0 0 0 + 8 11 1 0 0 0 + 11 12 1 0 0 0 + 11 13 2 0 0 0 + 11 14 1 0 0 0 + 12 15 1 0 0 0 + 16 17 1 0 0 0 + 17 18 1 0 0 0 + 18 19 1 0 0 0 + 19 20 1 0 0 0 + 16 20 1 0 0 0 + 16 15 1 1 0 0 + 19 21 1 1 0 0 + 17 22 1 6 0 0 + 18 23 1 6 0 0 + 22 24 1 0 0 0 + 24 25 1 0 0 0 + 24 26 2 0 0 0 + 24 27 1 0 0 0 + 25 28 1 0 0 0 + 29 30 1 0 0 0 + 30 31 1 0 0 0 + 31 32 1 0 0 0 + 32 33 1 0 0 0 + 29 33 1 0 0 0 + 29 28 1 1 0 0 + 30 34 1 6 0 0 + 31 35 1 6 0 0 + 32 36 1 1 0 0 + 34 37 1 0 0 0 + 37 38 1 0 0 0 + 38 39 1 0 0 0 + 39 40 1 0 0 0 + 37 41 2 0 0 0 + 39 42 1 6 0 0 + 38 43 1 1 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 13 12 15 16 17 18 19 20 21 22 23 24 26 27 +M SDI 1 4 17.4300 -14.9100 17.4300 -13.1600 +M SDI 1 4 21.2800 -17.6400 21.2800 -19.4600 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C03017.mol b/src/analysis/thermo/trainingModel/data/mol/C03017.mol new file mode 100644 index 0000000000..2c8e69a3ff --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03017.mol @@ -0,0 +1,35 @@ +C03017 + Mrv1652304062119502D + + 15 14 0 0 0 0 999 V2000 + 14.7575 -9.9958 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0437 -10.4096 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4712 -10.4096 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7575 -9.1717 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3264 -9.9958 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4712 -11.2338 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.4712 -8.7579 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6126 -10.4096 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3264 -9.1717 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4587 -12.3076 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2263 -11.6889 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6747 -11.6800 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4712 -7.9337 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1850 -9.1717 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.8988 -9.9958 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 2 0 0 0 0 + 6 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 6 12 1 0 0 0 0 + 7 13 2 0 0 0 0 + 7 14 1 0 0 0 0 + 8 15 1 0 0 0 0 +M CHG 2 6 1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03044.mol b/src/analysis/thermo/trainingModel/data/mol/C03044.mol new file mode 100644 index 0000000000..fe05a558ee --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03044.mol @@ -0,0 +1,16 @@ +C03044 + Mrv1652304062119502D + + 6 5 0 0 1 0 999 V2000 + 10.4887 -8.4960 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.2010 -8.9053 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.7724 -8.9053 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4887 -7.6699 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9173 -8.4960 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2010 -9.7313 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03059.mol b/src/analysis/thermo/trainingModel/data/mol/C03059.mol new file mode 100644 index 0000000000..716939ade2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03059.mol @@ -0,0 +1,23 @@ +C03059 + Mrv1652304062119502D + + 9 8 0 0 0 0 999 V2000 + 10.8056 -8.8710 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5246 -8.4623 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0941 -8.4623 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8056 -8.0460 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8056 -9.6999 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.2362 -8.8749 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.5246 -7.6449 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3901 -8.8710 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0941 -7.6373 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 +M CHG 2 5 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03064.mol b/src/analysis/thermo/trainingModel/data/mol/C03064.mol new file mode 100644 index 0000000000..e7baf63e79 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03064.mol @@ -0,0 +1,23 @@ +C03064 + Mrv1652304062119502D + + 9 8 0 0 1 0 999 V2000 + 15.2305 -12.3242 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.9442 -11.9104 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5168 -11.9104 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2305 -13.1481 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6580 -12.3242 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9442 -11.0864 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8031 -12.3242 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5168 -11.0864 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3751 -11.9104 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 5 9 1 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03067.mol b/src/analysis/thermo/trainingModel/data/mol/C03067.mol new file mode 100644 index 0000000000..1bd2c58dc1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03067.mol @@ -0,0 +1,23 @@ +C03067 + Mrv1652304062119502D + + 9 9 0 0 0 0 999 V2000 + 10.4601 -8.4683 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1783 -8.8744 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7533 -8.8744 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4601 -7.6487 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1783 -9.7016 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7533 -9.7016 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1670 -7.2388 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4601 -10.1189 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8926 -10.1152 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 2 0 0 0 0 + 5 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03082.mol b/src/analysis/thermo/trainingModel/data/mol/C03082.mol new file mode 100644 index 0000000000..e3b16ce75a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03082.mol @@ -0,0 +1,31 @@ +C03082 + Mrv1652304062119502D + + 13 12 0 0 1 0 999 V2000 + 15.2258 -11.3775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5565 -10.9174 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8036 -11.2939 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.0925 -10.9174 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8036 -12.2141 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.3814 -11.3357 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.0925 -10.0390 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9787 -11.0011 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2258 -12.2141 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7735 -11.0011 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7735 -10.1227 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5682 -11.0011 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.7735 -11.8377 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 5 1 6 0 0 0 + 4 6 1 0 0 0 0 + 4 7 2 0 0 0 0 + 1 8 1 0 0 0 0 + 1 9 2 0 0 0 0 + 10 11 2 0 0 0 0 + 10 12 1 0 0 0 0 + 10 8 1 0 0 0 0 + 10 13 1 0 0 0 0 +M CHG 4 5 1 6 -1 12 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03127.mol b/src/analysis/thermo/trainingModel/data/mol/C03127.mol new file mode 100644 index 0000000000..310bacdafd --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03127.mol @@ -0,0 +1,122 @@ +C03127 + + + 53 57 0 0 1 0 0 0 0 0999 V2000 + 19.8800 -10.6400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3000 -11.9700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7000 -11.9700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1200 -10.6400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0000 -9.8000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5500 -10.2200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.4500 -10.2200 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4600 -13.0900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4700 -13.0900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5000 -11.1300 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4600 -14.4900 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7000 -14.4900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0600 -14.4900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4600 -15.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.1000 -14.4900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.3600 -15.2600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7800 -16.5900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1800 -16.5900 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.6000 -15.2600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.4800 -14.4200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.9300 -14.8400 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9400 -17.7100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.9500 -17.7100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9400 -19.1100 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 26.3200 -19.1100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5400 -19.1100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9400 -20.5100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.7200 -19.1100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.1900 -20.0200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.6100 -21.3500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.0100 -21.3500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.4300 -20.0200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.3100 -19.1800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 31.9200 -23.1700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 32.7600 -19.6000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 28.7824 -22.4792 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 33.8858 -20.4322 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 35.0252 -19.6187 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.6036 -18.2837 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 33.2036 -18.2721 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.0206 -21.8257 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 35.2948 -22.4057 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 36.4342 -21.5922 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 36.2994 -20.1987 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.4436 -19.3816 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 31.9200 -24.5700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.7076 -25.2700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 33.1324 -25.2700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.3224 -24.5700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 35.5349 -25.2700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 36.7473 -24.5700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.3167 -23.1701 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 33.1381 -26.6697 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 2 3 1 0 0 0 + 3 4 1 0 0 0 + 4 5 1 0 0 0 + 1 5 1 0 0 0 + 1 6 1 1 0 0 + 4 7 1 1 0 0 + 2 8 1 6 0 0 + 3 9 1 6 0 0 + 6 10 1 0 0 0 + 8 11 1 0 0 0 + 11 12 1 0 0 0 + 11 13 2 0 0 0 + 11 14 1 0 0 0 + 12 15 1 0 0 0 + 16 17 1 0 0 0 + 17 18 1 0 0 0 + 18 19 1 0 0 0 + 19 20 1 0 0 0 + 16 20 1 0 0 0 + 16 15 1 1 0 0 + 19 21 1 1 0 0 + 17 22 1 6 0 0 + 18 23 1 6 0 0 + 22 24 1 0 0 0 + 24 25 1 0 0 0 + 24 26 2 0 0 0 + 24 27 1 0 0 0 + 25 28 1 0 0 0 + 29 30 1 0 0 0 + 30 31 1 0 0 0 + 31 32 1 0 0 0 + 32 33 1 0 0 0 + 29 33 1 0 0 0 + 29 28 1 1 0 0 + 31 34 1 6 0 0 + 32 35 1 1 0 0 + 30 36 1 6 0 0 + 35 37 1 0 0 0 + 37 38 1 0 0 0 + 38 39 1 0 0 0 + 39 40 2 0 0 0 + 35 40 1 0 0 0 + 37 41 2 0 0 0 + 41 42 1 0 0 0 + 42 43 2 0 0 0 + 43 44 1 0 0 0 + 38 44 2 0 0 0 + 44 45 1 0 0 0 + 34 46 1 0 0 0 + 46 47 2 0 0 0 + 46 48 1 0 0 0 + 48 49 1 0 0 0 + 49 50 1 0 0 0 + 50 51 1 0 0 0 + 49 52 1 1 0 0 + 48 53 1 6 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 13 12 15 16 17 18 19 20 21 22 23 24 26 27 +M SDI 1 4 21.0000 -15.4000 21.0000 -13.6500 +M SDI 1 4 24.8500 -18.1300 24.8500 -19.9500 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C03149.mol b/src/analysis/thermo/trainingModel/data/mol/C03149.mol new file mode 100644 index 0000000000..f9582681c7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03149.mol @@ -0,0 +1,33 @@ +C03149 + Mrv1652304062119502D + + 14 13 0 0 0 0 999 V2000 + 15.1003 -11.3357 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8114 -10.9174 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5225 -11.3357 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2336 -10.9174 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9447 -11.3357 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.9447 -10.3736 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5225 -10.4155 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3892 -10.9174 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7200 -11.3357 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.3892 -10.1227 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8834 -11.3357 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0468 -11.3357 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.8834 -10.4991 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8834 -12.1723 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 2 0 0 0 0 + 1 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 8 10 1 0 0 0 0 + 9 11 1 4 0 0 0 + 11 12 1 0 0 0 0 + 11 13 2 0 0 0 0 + 11 14 1 0 0 0 0 +M CHG 4 5 -1 9 1 12 -1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03150.mol b/src/analysis/thermo/trainingModel/data/mol/C03150.mol new file mode 100644 index 0000000000..41d4b49bff --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03150.mol @@ -0,0 +1,43 @@ +C03150 + Mrv1652304062119502D + + 18 19 0 0 1 0 999 V2000 + 15.0087 -12.4863 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.7716 -11.3646 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.3401 -12.0066 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7556 -13.2718 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.4930 -10.9453 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0615 -10.9453 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6792 -12.4863 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9285 -13.2718 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.2390 -13.9366 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4930 -10.1144 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0615 -10.1144 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9011 -12.2295 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4450 -13.9329 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7716 -9.7027 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2031 -9.6990 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7312 -11.4250 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9169 -10.1106 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2182 -8.8378 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 1 0 0 0 + 8 13 1 6 0 0 0 + 10 14 2 0 0 0 0 + 10 15 1 0 0 0 0 + 12 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 18 2 0 0 0 0 + 8 7 1 0 0 0 0 + 11 14 1 0 0 0 0 +M CHG 1 2 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03166.mol b/src/analysis/thermo/trainingModel/data/mol/C03166.mol new file mode 100644 index 0000000000..e36f47e82e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03166.mol @@ -0,0 +1,29 @@ +C03166 + Mrv1652304062119502D + + 12 11 0 0 0 0 999 V2000 + 12.0453 -12.6640 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7597 -13.0765 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4743 -12.6640 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1887 -13.0765 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9032 -12.6640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6177 -13.0765 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2202 -12.6640 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3952 -12.6640 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2202 -11.8390 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2202 -13.4890 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.7597 -13.9014 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9032 -11.8391 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 4 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 1 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 + 2 11 1 0 0 0 0 + 5 12 2 0 0 0 0 +M CHG 3 6 -1 8 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03167.mol b/src/analysis/thermo/trainingModel/data/mol/C03167.mol new file mode 100644 index 0000000000..372087e9a6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03167.mol @@ -0,0 +1,19 @@ +C03167 + Mrv1652304062119502D + + 7 6 0 0 0 0 999 V2000 + 17.1616 -12.4302 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8745 -12.0168 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4463 -12.0190 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7300 -11.6055 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9093 -12.8184 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.8592 -11.2197 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6267 -12.4494 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 2 7 2 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03178.mol b/src/analysis/thermo/trainingModel/data/mol/C03178.mol new file mode 100644 index 0000000000..cf4d0400df --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03178.mol @@ -0,0 +1,35 @@ +C03178 + Mrv1652304062119502D + + 14 15 0 0 0 0 999 V2000 + 10.8928 -7.9250 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8928 -8.7500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1731 -7.5143 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6123 -7.5031 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6161 -9.1683 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1731 -9.1720 0.0000 N 0 5 0 0 0 0 0 0 0 0 0 0 + 9.4649 -7.9250 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3356 -7.9175 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3394 -8.7539 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6161 -9.9859 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4649 -8.7500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7528 -7.5143 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0440 -7.5068 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7528 -9.1570 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 2 0 0 0 0 + 8 13 2 0 0 0 0 + 11 14 2 0 0 0 0 + 7 11 1 0 0 0 0 + 8 9 1 0 0 0 0 +M CHG 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03196.mol b/src/analysis/thermo/trainingModel/data/mol/C03196.mol new file mode 100644 index 0000000000..c1b8853efb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03196.mol @@ -0,0 +1,25 @@ +C03196 + Mrv1652304062119502D + + 10 9 0 0 1 0 999 V2000 + 11.5504 -8.4792 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.8352 -8.8917 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2619 -8.8917 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5504 -7.6542 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1237 -8.4792 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2619 -9.7541 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.9734 -8.4792 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4085 -8.8917 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4085 -9.7541 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.6970 -8.4792 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 2 6 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03210.mol b/src/analysis/thermo/trainingModel/data/mol/C03210.mol new file mode 100644 index 0000000000..830a5ca719 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03210.mol @@ -0,0 +1,27 @@ +C03210 + Mrv1652304062119502D + + 11 10 0 0 0 0 999 V2000 + 14.1900 -10.3125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9325 -9.8587 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6337 -10.3125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4887 -9.8587 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.1900 -11.1375 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9325 -9.0337 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.6337 -8.6212 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3350 -9.0337 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0362 -8.6212 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.6337 -7.7962 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3350 -9.7350 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 7 10 1 0 0 0 0 + 8 11 2 0 0 0 0 +M CHG 3 4 -1 6 1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03232.mol b/src/analysis/thermo/trainingModel/data/mol/C03232.mol new file mode 100644 index 0000000000..0c7d179698 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03232.mol @@ -0,0 +1,27 @@ +C03232 + Mrv1652304062119502D + + 11 10 0 0 0 0 999 V2000 + 9.4386 -8.9074 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2625 -8.9112 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6522 -8.9074 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.4386 -8.0797 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.4761 -9.7313 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9763 -8.4974 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6939 -8.9112 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4076 -8.4974 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6939 -9.7389 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1215 -8.9150 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.4039 -7.6734 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 8 10 1 0 0 0 0 + 8 11 2 0 0 0 0 +M CHG 3 3 -1 4 -1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03314.mol b/src/analysis/thermo/trainingModel/data/mol/C03314.mol new file mode 100644 index 0000000000..fcd66cff63 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03314.mol @@ -0,0 +1,35 @@ +C03314 + Mrv1652304062119502D + + 14 15 0 0 0 0 999 V2000 + 15.1759 -10.1520 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1759 -10.9770 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4633 -9.7433 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4633 -11.3932 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7547 -10.1520 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4595 -8.9727 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7547 -10.9770 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0460 -11.3820 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9605 -11.2320 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4454 -10.5646 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9605 -9.8971 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3269 -10.5218 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7503 -9.7897 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7680 -11.2865 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 2 0 0 0 0 + 5 7 1 0 0 0 0 + 2 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 2 0 0 0 0 + 1 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 12 13 2 0 0 0 0 + 12 14 1 0 0 0 0 +M CHG 1 14 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03341.mol b/src/analysis/thermo/trainingModel/data/mol/C03341.mol new file mode 100644 index 0000000000..144ffc76ae --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03341.mol @@ -0,0 +1,23 @@ +C03341 + Mrv1652304062119502D + + 9 8 0 0 1 0 999 V2000 + 16.0969 -12.0011 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.3847 -12.4135 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8127 -12.4135 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0969 -11.1761 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.6690 -12.0011 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7886 -13.3018 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5208 -11.9976 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9609 -12.4135 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6690 -11.1761 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 2 0 0 0 0 +M CHG 2 4 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03351.mol b/src/analysis/thermo/trainingModel/data/mol/C03351.mol new file mode 100644 index 0000000000..2aeb8b3d16 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03351.mol @@ -0,0 +1,23 @@ +C03351 + Mrv1652304062119502D + + 9 9 0 0 0 0 999 V2000 + 10.4694 -8.4726 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1844 -8.8829 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7580 -8.8829 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4656 -7.6522 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1844 -9.7108 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7580 -9.7108 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1731 -7.2419 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4694 -10.1286 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8958 -10.1173 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03373.mol b/src/analysis/thermo/trainingModel/data/mol/C03373.mol new file mode 100644 index 0000000000..be3407eaa7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03373.mol @@ -0,0 +1,45 @@ +C03373 + Mrv1652304062119502D + + 19 20 0 0 1 0 999 V2000 + 17.9161 -13.3578 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.2355 -12.8663 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6666 -14.1291 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5739 -13.3464 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.8348 -14.1291 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.1542 -14.7027 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1240 -12.8474 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3622 -14.7103 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1939 -12.8474 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3736 -12.8474 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5494 -12.8474 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3736 -12.0232 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3736 -13.6678 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7382 -13.0887 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4362 -13.5935 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1320 -13.0856 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 19.8640 -12.2670 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0026 -12.2688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4813 -11.5546 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 4 2 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 1 6 0 0 0 + 4 7 1 1 0 0 0 + 5 8 1 6 0 0 0 + 7 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 10 13 2 0 0 0 0 + 5 4 1 0 0 0 0 + 1 14 1 1 0 0 0 + 14 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 2 0 0 0 0 + 14 18 1 0 0 0 0 + 18 19 1 0 0 0 0 +M CHG 3 11 -1 12 -1 16 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03383.mol b/src/analysis/thermo/trainingModel/data/mol/C03383.mol new file mode 100644 index 0000000000..1243b97f50 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03383.mol @@ -0,0 +1,29 @@ +C03383 + Mrv1652304062119502D + + 12 12 0 0 1 0 999 V2000 + 16.0372 -12.3852 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.2878 -13.1751 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.7033 -11.9044 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2542 -12.1311 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.1189 -13.1751 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.8036 -13.8378 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3729 -12.3852 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6429 -12.6771 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0893 -11.3240 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6031 -13.8378 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1594 -12.1242 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8633 -12.4195 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 1 0 0 0 + 5 10 1 6 0 0 0 + 7 11 2 0 0 0 0 + 8 12 1 0 0 0 0 + 5 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03384.mol b/src/analysis/thermo/trainingModel/data/mol/C03384.mol new file mode 100644 index 0000000000..5a33604f0d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03384.mol @@ -0,0 +1,38 @@ +C03384 + Mrv1652304062119502D + + 16 16 0 0 1 0 999 V2000 + 11.0525 -8.2672 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3335 -7.8585 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0525 -9.0922 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.7640 -7.8585 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6181 -8.2672 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.3335 -9.5048 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.7640 -9.5048 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5853 -7.8546 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6181 -9.0922 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 8.9143 -7.8585 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3335 -10.3260 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4103 -7.8546 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.5853 -7.0333 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.5853 -8.6796 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9143 -9.5048 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2822 -8.3883 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 0 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 9 5 1 0 0 0 0 + 5 10 1 1 0 0 0 + 6 11 1 1 0 0 0 + 8 12 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 2 0 0 0 0 + 9 15 1 1 0 0 0 + 10 16 1 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 2 12 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03394.mol b/src/analysis/thermo/trainingModel/data/mol/C03394.mol new file mode 100644 index 0000000000..aeaaee1afb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03394.mol @@ -0,0 +1,29 @@ +C03394 + Mrv1652304062119502D + + 12 11 0 0 1 0 999 V2000 + 13.6950 -12.3750 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9938 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2513 -12.3750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5500 -11.9625 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.8488 -12.3750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1063 -11.9625 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5500 -11.1375 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2513 -13.2000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5200 -12.3750 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3450 -12.3750 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5200 -13.2000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5200 -11.5500 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 4 7 1 6 0 0 0 + 3 8 2 0 0 0 0 + 1 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 2 0 0 0 0 + 9 12 1 0 0 0 0 +M CHG 2 10 -1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03406.mol b/src/analysis/thermo/trainingModel/data/mol/C03406.mol new file mode 100644 index 0000000000..5bcd6e577d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03406.mol @@ -0,0 +1,45 @@ +C03406 + Mrv1652304062119502D + + 20 19 0 0 1 0 999 V2000 + 17.2485 -9.3288 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5304 -9.7411 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9597 -9.7411 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2485 -8.5042 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8157 -9.3288 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6742 -9.3288 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5304 -8.0884 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.9597 -8.0884 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0977 -9.7411 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8157 -8.5042 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 19.3923 -9.7411 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.6742 -8.5042 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3830 -9.3288 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6685 -9.7411 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9504 -9.3288 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2392 -9.7411 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.5246 -9.3288 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2392 -10.5655 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 10.8065 -9.7411 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.5246 -8.5042 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 6 12 2 0 0 0 0 + 9 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 16 15 1 0 0 0 0 + 16 17 1 0 0 0 0 + 16 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 17 20 2 0 0 0 0 +M CHG 5 7 -1 10 1 11 -1 18 1 19 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03410.mol b/src/analysis/thermo/trainingModel/data/mol/C03410.mol new file mode 100644 index 0000000000..a9ab4a4883 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03410.mol @@ -0,0 +1,50 @@ +C03410 + Mrv1652304062119502D + + 22 22 0 0 1 0 999 V2000 + 14.7600 -9.3379 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.7600 -10.1623 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4780 -8.9256 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0454 -8.9256 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4780 -10.5781 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.0454 -10.5781 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1925 -9.3379 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 14.0454 -8.1012 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.3309 -9.3379 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1925 -10.1623 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4814 -11.4059 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0489 -11.4024 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7731 -8.7470 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9861 -9.5509 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3309 -7.6855 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7634 -7.6855 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3378 -11.8147 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7600 -11.8113 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5735 -8.9600 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.5532 -7.9500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3309 -6.8577 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6232 -11.4059 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 1 6 0 0 0 + 6 12 1 0 0 0 0 + 7 13 1 0 0 0 0 + 7 14 1 4 0 0 0 + 8 15 1 0 0 0 0 + 8 16 1 1 0 0 0 + 12 17 1 0 0 0 0 + 12 18 2 0 0 0 0 + 13 19 1 0 0 0 0 + 13 20 2 0 0 0 0 + 15 21 1 0 0 0 0 + 17 22 1 0 0 0 0 + 7 10 1 0 0 0 0 +M CHG 1 19 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03440.mol b/src/analysis/thermo/trainingModel/data/mol/C03440.mol new file mode 100644 index 0000000000..75b021ebad --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03440.mol @@ -0,0 +1,24 @@ +C03440 + Mrv1652304062119502D + + 9 9 0 0 1 0 999 V2000 + 9.2349 -16.8143 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4732 -17.6042 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.2980 -17.6217 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5695 -16.8427 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.9125 -16.3437 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 8.9750 -18.2602 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2744 -16.4174 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9889 -16.8299 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.2664 -15.5924 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 4 7 1 1 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 +M CHG 2 5 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03451.mol b/src/analysis/thermo/trainingModel/data/mol/C03451.mol new file mode 100644 index 0000000000..fe11bac441 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03451.mol @@ -0,0 +1,55 @@ +C03451 + Mrv1652304062119502D + + 25 24 0 0 1 0 999 V2000 + 15.9119 -9.3688 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1946 -8.9550 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9233 -10.3444 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6256 -8.9550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4808 -9.3688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1300 -10.8037 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4369 -9.5586 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6256 -8.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7672 -8.9550 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4808 -10.1926 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1300 -11.6274 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2417 -8.9343 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0497 -9.3688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8435 -12.0412 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4163 -12.0412 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9591 -9.3480 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3360 -8.9550 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5611 -11.6274 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8435 -12.8687 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9552 -10.1718 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6728 -8.9305 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6224 -9.3688 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3360 -8.1275 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 10.9088 -8.9513 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6224 -10.1926 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 9 13 1 0 0 0 0 + 14 11 1 0 0 0 0 + 11 15 2 0 0 0 0 + 12 16 1 0 0 0 0 + 17 13 1 0 0 0 0 + 14 18 1 0 0 0 0 + 14 19 1 1 0 0 0 + 16 20 2 0 0 0 0 + 16 21 1 0 0 0 0 + 17 22 1 0 0 0 0 + 17 23 1 1 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 +M CHG 3 21 -1 23 1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03459.mol b/src/analysis/thermo/trainingModel/data/mol/C03459.mol new file mode 100644 index 0000000000..21ba074fd7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03459.mol @@ -0,0 +1,25 @@ +C03459 + Mrv1652304062119502D + + 10 9 0 0 0 0 999 V2000 + 11.2102 -8.5028 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4970 -8.9125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9233 -8.9125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2102 -7.6759 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7800 -8.5028 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4970 -9.8220 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9233 -9.8220 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.6402 -8.5028 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7839 -7.6759 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.0670 -8.9163 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 +M CHG 2 7 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03483.mol b/src/analysis/thermo/trainingModel/data/mol/C03483.mol new file mode 100644 index 0000000000..51ffe0b313 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03483.mol @@ -0,0 +1,78 @@ +C03483 + Mrv1652304062119512D + + 35 37 0 0 1 0 999 V2000 + 15.8599 -8.7136 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0691 -8.4789 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3756 -9.9700 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.3217 -8.0362 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0540 -7.6577 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3576 -8.9103 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6906 -9.5082 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1977 -10.7988 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.8298 -7.3927 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3273 -7.2490 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5847 -8.5168 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0472 -10.0192 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3273 -10.7837 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7578 -11.5152 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6158 -7.6804 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3122 -6.3218 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2525 -9.7959 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8126 -11.5018 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6622 -10.3674 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8371 -10.3674 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0158 -10.3674 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8371 -9.5461 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.8371 -11.1924 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1909 -10.3674 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3696 -10.3674 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1909 -9.5461 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.1909 -11.1924 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5446 -10.3674 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7235 -10.3674 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5446 -9.5461 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.5446 -11.1924 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.8984 -10.3674 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 6.0771 -10.3674 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.8984 -9.5461 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 6.8984 -11.1924 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 17 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 20 23 2 0 0 0 0 + 21 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 2 0 0 0 0 + 25 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 1 0 0 0 0 + 28 31 2 0 0 0 0 + 29 32 1 0 0 0 0 + 32 33 1 0 0 0 0 + 32 34 1 0 0 0 0 + 32 35 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 15 2 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 4 22 -1 26 -1 30 -1 34 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03493.mol b/src/analysis/thermo/trainingModel/data/mol/C03493.mol new file mode 100644 index 0000000000..729c0bfe57 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03493.mol @@ -0,0 +1,30 @@ +C03493 + Mrv1652304062119512D + + 12 12 0 0 1 0 999 V2000 + 8.3325 -9.7763 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3325 -10.6013 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0470 -11.0138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7615 -10.6013 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7615 -9.7763 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0470 -9.3638 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4907 -9.3638 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.2052 -9.7763 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9197 -9.3638 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.4944 -8.5389 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 11.2052 -10.6011 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6181 -11.0138 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 7 5 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 7 10 1 1 0 0 0 + 8 11 2 0 0 0 0 + 2 12 1 0 0 0 0 +M CHG 2 9 -1 10 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03506.mol b/src/analysis/thermo/trainingModel/data/mol/C03506.mol new file mode 100644 index 0000000000..888c65d9a4 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03506.mol @@ -0,0 +1,45 @@ +C03506 + Mrv1652304062119512D + + 19 20 0 0 1 0 999 V2000 + 10.7662 -10.7250 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7662 -11.5500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4807 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1952 -11.5500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1952 -10.7250 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4807 -10.3125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9798 -11.8049 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4648 -11.1375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9798 -10.4701 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2339 -9.6882 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0467 -9.5154 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.6140 -10.1457 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2998 -8.7375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1185 -8.5636 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9435 -8.5636 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6880 -9.0818 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7685 -8.5636 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9435 -7.7386 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.9435 -9.3886 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 5 9 1 0 0 0 0 + 10 9 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 1 0 0 0 + 11 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 10 16 1 6 0 0 0 + 15 17 2 0 0 0 0 + 15 18 1 0 0 0 0 + 15 19 1 0 0 0 0 +M CHG 2 18 -1 19 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03511.mol b/src/analysis/thermo/trainingModel/data/mol/C03511.mol new file mode 100644 index 0000000000..778d079395 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03511.mol @@ -0,0 +1,109 @@ +C03511 + ISISHOST03240423082D 1 1.00000 0.00000 3066 + + 47 50 0 1 0 999 V2000 + 0.2759 0.8034 0.0000 C 0 0 2 0 0 0 0 0 0 + 0.0586 1.4655 0.0000 C 0 0 2 0 0 0 0 0 0 + 0.9828 0.8034 0.0000 C 0 0 2 0 0 0 0 0 0 + -0.1483 0.2103 0.0000 O 0 0 0 0 0 0 0 0 0 + 0.6172 1.8655 0.0000 O 0 0 0 0 0 0 0 0 0 + -0.6345 1.6862 0.0000 C 0 0 0 0 0 0 0 0 0 + 1.1828 1.4517 0.0000 C 0 0 1 0 0 0 0 0 0 + 1.3966 0.2414 0.0000 O 0 0 0 0 0 0 0 0 0 + -0.1517 -0.5172 0.0000 P 0 0 3 0 0 0 0 0 0 + -0.7862 2.6793 0.0000 O 0 0 0 0 0 0 0 0 0 + 1.8483 1.6621 0.0000 R 0 0 0 0 0 0 0 0 0 + 0.5759 -0.5172 0.0000 O 0 0 0 0 0 0 0 0 0 + -0.1552 -1.2448 0.0000 O 0 0 0 0 0 0 0 0 0 + -0.8828 -0.5138 0.0000 O 0 0 0 0 0 0 0 0 0 + -1.4690 2.6759 0.0000 P 0 0 3 0 0 0 0 0 0 + 0.7241 -1.5069 0.0000 C 0 0 0 0 0 0 0 0 0 + -1.4621 3.3586 0.0000 O 0 0 0 0 0 0 0 0 0 + -1.4724 1.9897 0.0000 O 0 0 0 0 0 0 0 0 0 + -2.1517 2.6793 0.0000 O 0 0 0 0 0 0 0 0 0 + 1.4172 -1.7345 0.0000 C 0 0 2 0 0 0 0 0 0 + -1.0621 3.9138 0.0000 C 0 0 2 0 0 0 0 0 0 + 1.6310 -2.3931 0.0000 C 0 0 2 0 0 0 0 0 0 + 1.9759 -1.3310 0.0000 O 0 0 0 0 0 0 0 0 0 + -1.2759 4.5655 0.0000 C 0 0 2 0 0 0 0 0 0 + -0.3552 3.9138 0.0000 C 0 0 2 0 0 0 0 0 0 + 2.3379 -2.3931 0.0000 C 0 0 2 0 0 0 0 0 0 + 1.2034 -2.9828 0.0000 O 0 0 0 0 0 0 0 0 0 + 2.5379 -1.7414 0.0000 C 0 0 2 0 0 0 0 0 0 + -0.7207 4.9690 0.0000 O 0 0 0 0 0 0 0 0 0 + -1.9276 4.7724 0.0000 C 0 0 0 0 0 0 0 0 0 + -0.1517 4.5552 0.0000 C 0 0 1 0 0 0 0 0 0 + 0.0586 3.3517 0.0000 O 0 0 0 0 0 0 0 0 0 + 2.7552 -2.9552 0.0000 O 0 0 0 0 0 0 0 0 0 + 0.5069 -2.9069 0.0000 C 0 0 0 0 0 0 0 0 0 + 3.2345 -1.5138 0.0000 R 0 0 0 0 0 0 0 0 0 + -2.4345 4.3103 0.0000 O 0 0 0 0 0 0 0 0 0 + 0.5138 4.7586 0.0000 R 0 0 0 0 0 0 0 0 0 + 0.0931 -3.4690 0.0000 C 0 0 2 0 0 0 0 0 0 + 0.2241 -2.2655 0.0000 O 0 0 0 0 0 0 0 0 0 + -0.6000 -3.3931 0.0000 C 0 0 0 0 0 0 0 0 0 + 0.3759 -4.1103 0.0000 N 0 0 0 0 0 0 0 0 0 + -1.0138 -3.9586 0.0000 C 0 0 0 0 0 0 0 0 0 + -1.7069 -3.8793 0.0000 C 0 0 0 0 0 0 0 0 0 + -0.7276 -4.5966 0.0000 C 0 0 0 0 0 0 0 0 0 + -2.1172 -4.4448 0.0000 C 0 0 0 0 0 0 0 0 0 + -1.1414 -5.1586 0.0000 C 0 0 0 0 0 0 0 0 0 + -1.8345 -5.0828 0.0000 C 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 1 6 0 0 + 2 5 1 0 0 0 + 2 6 1 1 0 0 + 3 7 1 0 0 0 + 3 8 1 6 0 0 + 4 9 1 0 0 0 + 6 10 1 0 0 0 + 7 11 1 1 0 0 + 9 12 1 0 0 0 + 9 13 1 0 0 0 + 9 14 2 0 0 0 + 10 15 1 0 0 0 + 12 16 1 0 0 0 + 15 17 1 0 0 0 + 15 18 1 0 0 0 + 15 19 2 0 0 0 + 20 16 1 1 0 0 + 21 17 1 6 0 0 + 20 22 1 0 0 0 + 20 23 1 0 0 0 + 21 24 1 0 0 0 + 21 25 1 0 0 0 + 22 26 1 0 0 0 + 22 27 1 6 0 0 + 23 28 1 0 0 0 + 24 29 1 0 0 0 + 24 30 1 1 0 0 + 25 31 1 0 0 0 + 25 32 1 6 0 0 + 26 33 1 6 0 0 + 27 34 1 0 0 0 + 28 35 1 1 0 0 + 30 36 1 0 0 0 + 31 37 1 1 0 0 + 34 38 1 0 0 0 + 34 39 2 0 0 0 + 38 40 1 0 0 0 + 38 41 1 1 0 0 + 40 42 1 0 0 0 + 42 43 2 0 0 0 + 42 44 1 0 0 0 + 43 45 1 0 0 0 + 44 46 2 0 0 0 + 45 47 2 0 0 0 + 5 7 1 0 0 0 + 26 28 1 0 0 0 + 29 31 1 0 0 0 + 46 47 1 0 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 13 1 2 3 4 5 6 7 8 9 11 12 13 14 +M SBL 1 2 9 15 +M SDI 1 4 -1.0793 2.0793 -0.3483 2.0793 +M SDI 1 4 1.0000 -1.1000 0.2517 -1.1000 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C03521.mol b/src/analysis/thermo/trainingModel/data/mol/C03521.mol new file mode 100644 index 0000000000..413b0924a8 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03521.mol @@ -0,0 +1,37 @@ +C03521 + Mrv1652304062119512D + + 16 16 0 0 1 0 999 V2000 + 15.8165 -9.3138 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1012 -9.7263 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.8165 -8.4925 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.7740 -9.7301 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3858 -9.3138 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1049 -10.5514 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1012 -8.0838 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5318 -8.0838 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3858 -8.4925 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.6820 -9.7263 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6820 -8.0838 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0499 -8.6137 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5232 -9.3021 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2523 -9.7230 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9813 -9.3021 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5252 -8.4604 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 6 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 9 11 1 1 0 0 0 + 11 12 1 0 0 0 0 + 9 7 1 0 0 0 0 + 4 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 13 16 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03557.mol b/src/analysis/thermo/trainingModel/data/mol/C03557.mol new file mode 100644 index 0000000000..98b6671032 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03557.mol @@ -0,0 +1,19 @@ +C03557 + Mrv1652304062119512D + + 7 6 0 0 0 0 999 V2000 + 10.8241 -8.8725 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8241 -8.0512 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1089 -9.2850 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9991 -8.0512 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6454 -8.0512 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.8241 -7.2262 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1089 -10.1062 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 +M CHG 2 5 -1 7 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03561.mol b/src/analysis/thermo/trainingModel/data/mol/C03561.mol new file mode 100644 index 0000000000..9eaea0b4c2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03561.mol @@ -0,0 +1,116 @@ +C03561 + Mrv1652304062119512D + + 54 56 0 0 1 0 999 V2000 + 9.1294 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8440 -11.5500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5584 -11.9625 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2729 -11.5500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9874 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7018 -11.5500 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4163 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1308 -11.5500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8452 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5597 -11.5500 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2742 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9886 -11.5500 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.7031 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4176 -11.5500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1320 -11.9625 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8440 -10.7251 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4163 -12.7874 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2742 -12.7873 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9886 -10.7250 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7031 -11.1375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7031 -12.7875 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9570 -11.9625 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7820 -11.9625 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9570 -12.7875 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.1287 -9.0337 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.9537 -9.0337 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.2087 -8.2491 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.5412 -7.7642 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8738 -8.2491 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.9863 -7.9964 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6438 -9.7012 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4387 -9.7012 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2637 -9.7012 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2637 -8.8762 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.0887 -9.7012 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.2637 -10.5262 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4475 -7.1775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4475 -8.0025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8765 -8.0025 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8765 -7.1775 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1619 -6.7650 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7330 -6.7650 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0185 -7.1775 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0185 -8.0025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7330 -8.4150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7330 -5.9401 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1544 -8.2512 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9794 -8.2512 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9794 -7.4262 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 20.8044 -8.2512 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9794 -10.1487 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4018 -11.5500 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 7.6873 -11.9625 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3985 -10.7252 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 52 1 1 0 0 0 0 + 52 53 1 0 0 0 0 + 52 54 1 1 0 0 0 +M CHG 4 24 -1 34 -1 35 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03564.mol b/src/analysis/thermo/trainingModel/data/mol/C03564.mol new file mode 100644 index 0000000000..b6537560ad --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03564.mol @@ -0,0 +1,22 @@ +C03564 + Mrv1652304062119512D + + 8 8 0 0 0 0 999 V2000 + 9.4812 -11.9120 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7253 -12.7000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5502 -12.7113 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8159 -11.9303 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1552 -11.4362 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 11.5220 -11.5088 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2365 -11.9213 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.5160 -10.6838 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 1 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 +M CHG 2 5 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03598.mol b/src/analysis/thermo/trainingModel/data/mol/C03598.mol new file mode 100644 index 0000000000..97ccfc7ce5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03598.mol @@ -0,0 +1,76 @@ +C03598 + Mrv1652304062119512D + + 34 36 0 0 1 0 999 V2000 + 20.1966 -13.8158 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.7226 -12.4385 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5192 -13.3240 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9506 -14.5878 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.9997 -12.0184 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4415 -12.0336 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8532 -13.8045 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.1143 -14.5878 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.4349 -15.2500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0036 -11.1935 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2884 -12.4271 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4415 -11.1972 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0699 -13.5623 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6337 -15.2576 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7226 -10.7773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4606 -14.1186 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7226 -9.9561 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6357 -14.1186 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8145 -14.1186 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6357 -14.9435 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.6357 -13.2974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9859 -14.1186 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1647 -14.1148 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9821 -14.9435 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.9859 -13.2974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4496 -14.5272 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.4496 -15.3522 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.7343 -14.1148 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7343 -15.7647 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1647 -15.7647 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0191 -14.5272 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.0191 -15.3522 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.3153 -14.1148 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3153 -15.7647 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 2 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 26 27 1 0 0 0 0 + 26 28 1 0 0 0 0 + 27 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 31 28 1 0 0 0 0 + 32 29 1 0 0 0 0 + 31 33 1 1 0 0 0 + 32 34 1 6 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 + 31 32 1 0 0 0 0 +M CHG 2 20 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03599.mol b/src/analysis/thermo/trainingModel/data/mol/C03599.mol new file mode 100644 index 0000000000..d7aaa2171f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03599.mol @@ -0,0 +1,76 @@ +C03599 + Mrv1652304062119512D + + 34 36 0 0 1 0 999 V2000 + 20.1966 -13.8158 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 20.7226 -12.4385 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5192 -13.3240 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9506 -14.5878 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.9997 -12.0184 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4415 -12.0336 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8532 -13.8045 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.1143 -14.5878 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.4349 -15.2500 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0036 -11.1935 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2884 -12.4271 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4415 -11.1972 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0699 -13.5623 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6337 -15.2576 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7226 -10.7773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4606 -14.1186 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7226 -9.9561 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6357 -14.1186 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8145 -14.1186 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6357 -14.9435 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.6357 -13.2974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9859 -14.1186 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1647 -14.1148 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9821 -14.9435 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.9859 -13.2974 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4496 -14.5272 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.4496 -15.3522 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.7343 -14.1148 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7343 -15.7647 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1647 -15.7647 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0191 -14.5272 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.0191 -15.3522 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.3153 -14.1148 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3153 -15.7647 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 5 11 2 0 0 0 0 + 6 12 2 0 0 0 0 + 7 13 1 1 0 0 0 + 8 14 1 6 0 0 0 + 10 15 2 0 0 0 0 + 13 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 26 27 1 0 0 0 0 + 26 28 1 0 0 0 0 + 27 29 1 0 0 0 0 + 27 30 1 1 0 0 0 + 31 28 1 0 0 0 0 + 32 29 1 0 0 0 0 + 31 33 1 1 0 0 0 + 32 34 1 6 0 0 0 + 8 7 1 0 0 0 0 + 12 15 1 0 0 0 0 + 31 32 1 0 0 0 0 +M CHG 2 20 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03618.mol b/src/analysis/thermo/trainingModel/data/mol/C03618.mol new file mode 100644 index 0000000000..7b25337077 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03618.mol @@ -0,0 +1,25 @@ +C03618 + Mrv1652304062119512D + + 10 9 0 0 1 0 999 V2000 + 15.5576 -9.4153 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.2961 -9.7943 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.8726 -9.8669 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5614 -8.6113 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0348 -9.4268 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3719 -10.7352 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.8650 -10.7272 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1071 -9.4958 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.7428 -9.8631 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.0348 -8.6041 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 +M CHG 3 6 1 8 -1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03652.mol b/src/analysis/thermo/trainingModel/data/mol/C03652.mol new file mode 100644 index 0000000000..fb05894e00 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03652.mol @@ -0,0 +1,27 @@ +C03652 + Mrv1652304062119512D + + 11 10 0 0 1 0 999 V2000 + 11.7153 -9.0752 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.4297 -8.6627 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1442 -9.0752 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.8587 -8.6627 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5732 -9.0752 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2877 -8.6627 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.5732 -9.9002 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4297 -7.8378 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8587 -7.8377 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8587 -9.4877 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1442 -9.9001 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 2 0 0 0 0 + 2 8 2 0 0 0 0 + 4 9 1 0 0 0 0 + 4 10 1 0 0 0 0 + 3 11 1 6 0 0 0 +M CHG 2 1 -1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03656.mol b/src/analysis/thermo/trainingModel/data/mol/C03656.mol new file mode 100644 index 0000000000..20822252e0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03656.mol @@ -0,0 +1,25 @@ +C03656 + Mrv1652304062119512D + + 10 9 0 0 1 0 999 V2000 + 10.1455 -9.3299 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8594 -8.9198 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4278 -8.9198 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.5734 -9.3299 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8594 -8.0918 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7138 -9.3299 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4278 -8.0918 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.2911 -8.9198 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0463 -9.3749 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.2873 -8.0918 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 2 7 1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03680.mol b/src/analysis/thermo/trainingModel/data/mol/C03680.mol new file mode 100644 index 0000000000..11f0fcc109 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03680.mol @@ -0,0 +1,28 @@ +C03680 + Mrv1652304062119512D + + 11 11 0 0 0 0 999 V2000 + 17.4089 -11.2296 0.0000 C 0 5 0 0 0 0 0 0 0 0 0 0 + 18.1214 -11.6389 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8377 -11.2296 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5503 -11.6389 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5503 -12.5531 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2629 -11.2296 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.6721 -10.3746 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9372 -9.8566 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2175 -10.3954 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.5076 -11.2464 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0020 -11.9667 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 1 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 2 0 0 0 0 + 9 10 1 0 0 0 0 + 1 10 1 0 0 0 0 + 10 11 2 0 0 0 0 +M CHG 3 1 -1 6 -1 9 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03703.mol b/src/analysis/thermo/trainingModel/data/mol/C03703.mol new file mode 100644 index 0000000000..37f24da99b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03703.mol @@ -0,0 +1,28 @@ +C03703 + Mrv1652304062119512D + + 11 11 0 0 1 0 999 V2000 + 8.6133 -12.0465 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8669 -12.8316 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.6920 -12.8329 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9483 -12.0487 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2816 -11.5627 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7283 -11.7966 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8364 -11.7926 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3826 -13.4958 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.5576 -13.4958 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.1402 -12.7729 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.1457 -14.2092 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 4 6 2 0 0 0 0 + 1 7 2 0 0 0 0 + 2 8 1 1 0 0 0 + 8 9 1 0 0 0 0 + 9 10 2 0 0 0 0 + 9 11 1 0 0 0 0 +M CHG 1 11 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03794.mol b/src/analysis/thermo/trainingModel/data/mol/C03794.mol new file mode 100644 index 0000000000..96b1fc4764 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03794.mol @@ -0,0 +1,70 @@ +C03794 + Mrv1652304062119512D + + 31 33 0 0 1 0 999 V2000 + 18.3828 -10.5770 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6022 -10.3230 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8598 -11.9601 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.8640 -9.9100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6022 -9.4969 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8784 -10.7361 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1777 -11.4637 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6098 -12.7331 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.3867 -9.2507 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8860 -9.0763 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1546 -10.2851 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5109 -11.9449 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.7723 -12.7331 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.0986 -13.3963 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8936 -8.2541 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1622 -9.4894 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7265 -11.7024 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3024 -13.4039 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9027 -7.2878 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9042 -11.7024 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1865 -6.8784 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6150 -6.8784 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0781 -11.7024 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4741 -7.2878 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3314 -7.2878 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.6113 -6.0524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2558 -11.7024 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0781 -12.5285 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.0781 -10.8800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7617 -6.8747 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.4354 -8.1138 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 8 3 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 12 7 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 0 0 0 0 + 10 16 1 0 0 0 0 + 12 17 1 1 0 0 0 + 13 18 1 6 0 0 0 + 19 15 1 1 0 0 0 + 17 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 19 22 1 0 0 0 0 + 20 23 1 0 0 0 0 + 21 24 1 0 0 0 0 + 22 25 1 0 0 0 0 + 22 26 2 0 0 0 0 + 23 27 1 0 0 0 0 + 23 28 1 0 0 0 0 + 23 29 2 0 0 0 0 + 24 30 1 0 0 0 0 + 24 31 2 0 0 0 0 + 5 9 1 0 0 0 0 + 11 16 2 0 0 0 0 + 13 12 1 0 0 0 0 +M CHG 4 25 -1 27 -1 28 -1 30 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03875.mol b/src/analysis/thermo/trainingModel/data/mol/C03875.mol new file mode 100644 index 0000000000..32563c0b95 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03875.mol @@ -0,0 +1,34 @@ +C03875 + + + 15 14 0 0 1 0 0 0 0 0999 V2000 + 26.3646 -22.0083 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.1482 -22.7127 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.3646 -20.6115 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.5695 -22.7127 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9377 -22.0083 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 25.1482 -24.1153 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.1482 -19.9130 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.7802 -22.0083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7271 -22.7127 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 25.1482 -18.5161 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9377 -20.6115 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 30.1803 -22.0083 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 30.1803 -23.4084 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 31.5803 -22.0083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 30.1803 -20.6083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 1 0 0 + 1 4 1 0 0 0 + 2 5 1 0 0 0 + 2 6 2 0 0 0 + 3 7 1 0 0 0 + 4 8 1 0 0 0 + 5 9 1 0 0 0 + 7 10 2 0 0 0 + 7 11 1 0 0 0 + 8 12 1 0 0 0 + 12 13 2 0 0 0 + 12 14 1 0 0 0 + 12 15 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C03912.mol b/src/analysis/thermo/trainingModel/data/mol/C03912.mol new file mode 100644 index 0000000000..7b10dccdb6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03912.mol @@ -0,0 +1,22 @@ +C03912 + Mrv1652304062119512D + + 8 8 0 0 1 0 999 V2000 + 11.0881 -13.4906 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3424 -14.2755 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1674 -14.2761 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4230 -13.4917 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.7560 -13.0062 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1311 -13.0766 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8456 -13.4892 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.1284 -12.2517 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 2 0 0 0 0 + 4 6 1 6 0 0 0 + 6 7 1 0 0 0 0 + 6 8 2 0 0 0 0 +M CHG 1 7 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03926.mol b/src/analysis/thermo/trainingModel/data/mol/C03926.mol new file mode 100644 index 0000000000..e431261e68 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03926.mol @@ -0,0 +1,29 @@ +C03926 + Mrv1652304062119512D + + 12 11 0 0 1 0 999 V2000 + 14.5147 -11.5448 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8036 -11.9631 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0507 -11.5448 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.3396 -11.9631 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.6285 -11.5448 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8756 -11.9631 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1645 -11.5448 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4534 -11.9631 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.1645 -10.7083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6285 -10.7083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3396 -12.7997 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0507 -10.7083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 4 11 1 1 0 0 0 + 3 12 1 6 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03939.mol b/src/analysis/thermo/trainingModel/data/mol/C03939.mol new file mode 100644 index 0000000000..23476e55d9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03939.mol @@ -0,0 +1,14 @@ +C03939 + + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 13.8600 -13.5100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0724 -12.8100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2849 -13.5100 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0724 -11.4100 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6849 -13.5100 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 2 3 1 0 0 0 + 2 4 2 0 0 0 + 3 5 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C03943.mol b/src/analysis/thermo/trainingModel/data/mol/C03943.mol new file mode 100644 index 0000000000..8f4306e8bb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03943.mol @@ -0,0 +1,23 @@ +C03943 + Mrv1652304062119512D + + 9 8 0 0 1 0 999 V2000 + 16.0006 -9.2647 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.2919 -9.6751 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7169 -9.6751 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0006 -8.4397 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 14.5756 -9.2647 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.7342 -10.5353 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4298 -9.2612 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.8627 -9.6751 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5756 -8.4397 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 5 2 1 0 0 0 0 + 3 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 1 6 0 0 0 +M CHG 3 4 1 7 -1 9 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C03981.mol b/src/analysis/thermo/trainingModel/data/mol/C03981.mol new file mode 100644 index 0000000000..92ade4799c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C03981.mol @@ -0,0 +1,23 @@ +C03981 + Mrv1652304062119512D + + 9 8 0 0 0 0 999 V2000 + 11.2215 -8.9289 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5039 -8.5150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9352 -8.5150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2215 -9.7565 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7903 -8.9289 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6489 -8.9289 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.9352 -7.6912 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0765 -8.5150 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.7903 -9.7565 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 2 0 0 0 0 +M CHG 2 6 -1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04056.mol b/src/analysis/thermo/trainingModel/data/mol/C04056.mol new file mode 100644 index 0000000000..ae6a05af6d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04056.mol @@ -0,0 +1,45 @@ +C04056 + Mrv1652304062119512D + + 20 19 0 0 0 0 999 V2000 + 13.7608 -13.2042 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0433 -13.6066 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4745 -13.6180 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0433 -14.4342 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1920 -13.2042 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7570 -14.8481 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9057 -13.6180 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4783 -14.4304 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6232 -13.2042 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1844 -14.8556 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3369 -13.6180 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9057 -14.4570 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0507 -13.2042 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6119 -14.8822 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7682 -13.6180 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.0507 -12.3804 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3369 -14.4835 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0431 -14.9087 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7643 -14.5101 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4742 -14.9391 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 2 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 2 0 0 0 0 + 9 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 12 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 13 16 2 0 0 0 0 + 14 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 +M CHG 1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04092.mol b/src/analysis/thermo/trainingModel/data/mol/C04092.mol new file mode 100644 index 0000000000..e07f2f16a7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04092.mol @@ -0,0 +1,24 @@ +C04092 + Mrv1652304062119512D + + 9 9 0 0 0 0 999 V2000 + 14.6850 -10.3125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6850 -11.1375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9425 -9.9000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.3863 -9.9000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9425 -11.5500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2413 -10.3125 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3863 -9.0750 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0875 -10.3125 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.2413 -11.1375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 2 3 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04105.mol b/src/analysis/thermo/trainingModel/data/mol/C04105.mol new file mode 100644 index 0000000000..7200e575e0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04105.mol @@ -0,0 +1,26 @@ +C04105 + Mrv1652304062119512D + + 10 10 0 0 0 0 999 V2000 + 13.4326 -10.7965 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6855 -11.5817 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5105 -11.5839 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7675 -10.7999 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1012 -10.3133 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6546 -10.5414 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4856 -10.4062 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1924 -10.8318 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9143 -10.4324 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.1773 -11.6565 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 2 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 1 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 +M CHG 1 9 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04114.mol b/src/analysis/thermo/trainingModel/data/mol/C04114.mol new file mode 100644 index 0000000000..f51e75ca10 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04114.mol @@ -0,0 +1,25 @@ +C04114 + Mrv1652304062119512D + + 10 9 0 0 0 0 999 V2000 + 23.1180 -13.0094 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8077 -13.4703 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 22.3798 -13.3802 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8390 -14.2987 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.5979 -13.7303 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6486 -13.0059 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9589 -13.4565 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1999 -13.0856 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 20.9554 -14.2328 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.6111 -13.0544 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 2 10 1 0 0 0 0 +M CHG 2 2 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04137.mol b/src/analysis/thermo/trainingModel/data/mol/C04137.mol new file mode 100644 index 0000000000..4d161bc802 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04137.mol @@ -0,0 +1,39 @@ +C04137 + Mrv1652304062119512D + + 17 16 0 0 1 0 999 V2000 + 11.6740 -16.2116 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.3885 -15.7991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1030 -16.2116 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.8175 -15.7991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5319 -16.2116 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2465 -15.7991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9609 -16.2116 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6754 -15.7991 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3899 -16.2116 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6754 -14.9741 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.3885 -14.9742 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1030 -17.3665 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 12.3996 -17.7727 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7006 -17.3691 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9983 -17.7747 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.3995 -18.6040 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7005 -16.7892 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 + 2 11 2 0 0 0 0 + 3 12 1 6 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 13 16 1 0 0 0 0 + 14 17 2 0 0 0 0 +M CHG 4 1 -1 10 1 12 1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04188.mol b/src/analysis/thermo/trainingModel/data/mol/C04188.mol new file mode 100644 index 0000000000..2e38b2464f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04188.mol @@ -0,0 +1,36 @@ +C04188 + Mrv1652304062119512D + + 15 15 0 0 1 0 999 V2000 + 20.0480 -11.9005 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.3743 -11.4198 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7906 -12.6876 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.8277 -11.6432 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7158 -11.9005 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.9656 -12.6876 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.2751 -13.3538 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.6488 -11.6393 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9324 -11.6432 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4775 -13.3538 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4740 -11.6393 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 21.6488 -10.8180 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 21.6488 -12.4643 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7659 -10.8370 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9825 -10.5797 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 6 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 1 0 0 0 + 6 10 1 6 0 0 0 + 8 11 1 0 0 0 0 + 8 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 9 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 6 5 1 0 0 0 0 +M CHG 2 11 -1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04246.mol b/src/analysis/thermo/trainingModel/data/mol/C04246.mol new file mode 100644 index 0000000000..c280d9ec85 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04246.mol @@ -0,0 +1,18 @@ +C04246 + + + 7 6 0 0 0 0 0 0 0 0999 V2000 + 21.3906 -24.2263 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5929 -23.5201 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.8128 -24.2146 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.0211 -23.5142 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.2410 -24.2088 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 25.0153 -22.1076 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 27.6359 -24.2088 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 2 3 2 0 0 0 + 3 4 1 0 0 0 + 4 5 1 0 0 0 + 4 6 2 0 0 0 + 5 7 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C04256.mol b/src/analysis/thermo/trainingModel/data/mol/C04256.mol new file mode 100644 index 0000000000..c4288bb010 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04256.mol @@ -0,0 +1,44 @@ +C04256 + Mrv1652304062119512D + + 19 19 0 0 1 0 999 V2000 + 10.9553 -11.1280 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.9553 -10.3030 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2363 -11.5406 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.9204 -11.5557 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2363 -9.8906 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6669 -9.8906 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5210 -11.1280 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.2363 -12.3618 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6319 -11.1431 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5210 -10.3030 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.6669 -9.0655 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8171 -11.5406 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3435 -11.5557 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6281 -10.3220 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8171 -9.8906 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6669 -8.2442 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.4919 -9.0655 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.8456 -9.0655 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.1889 -10.4242 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 1 0 0 0 + 4 9 1 0 0 0 0 + 10 5 1 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 6 0 0 0 + 9 13 1 0 0 0 0 + 9 14 2 0 0 0 0 + 10 15 1 1 0 0 0 + 11 16 1 0 0 0 0 + 11 17 1 0 0 0 0 + 11 18 2 0 0 0 0 + 15 19 1 0 0 0 0 + 7 10 1 0 0 0 0 +M CHG 2 16 -1 17 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04257.mol b/src/analysis/thermo/trainingModel/data/mol/C04257.mol new file mode 100644 index 0000000000..d50079676a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04257.mol @@ -0,0 +1,44 @@ +C04257 + Mrv1652304062119512D + + 19 19 0 0 1 0 999 V2000 + 17.1951 -9.4983 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.4778 -9.9060 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.1951 -8.6717 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 18.1349 -9.9060 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7644 -9.4983 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.4778 -10.7251 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4778 -8.2640 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9047 -8.2640 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7644 -8.6717 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.0623 -9.9060 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0623 -8.2640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4357 -8.7925 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6090 -8.7925 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7861 -8.7925 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.6090 -7.9695 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.6053 -9.6116 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8703 -9.4912 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5945 -9.9093 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8745 -8.6551 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 4 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 9 11 1 1 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 13 16 2 0 0 0 0 + 9 7 1 0 0 0 0 + 4 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 17 19 2 0 0 0 0 +M CHG 2 14 -1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04268.mol b/src/analysis/thermo/trainingModel/data/mol/C04268.mol new file mode 100644 index 0000000000..368b4ad160 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04268.mol @@ -0,0 +1,78 @@ +C04268 + Mrv1652304062119512D + + 35 37 0 0 1 0 999 V2000 + 16.5461 -10.3832 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.9631 -9.4138 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9374 -9.9549 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3094 -11.0970 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6018 -9.0306 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3019 -9.0306 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3325 -10.3832 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.5692 -11.0970 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.6018 -8.2792 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2518 -9.4102 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3019 -8.2792 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8704 -9.6956 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1785 -11.7471 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9593 -7.9034 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6481 -7.9034 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0814 -9.2786 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9593 -7.1595 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1947 -9.2786 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3042 -9.2786 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2281 -8.3881 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.2281 -10.1690 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4100 -9.2786 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5233 -9.2786 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4062 -8.3881 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.4062 -10.1690 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8057 -9.6994 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.8057 -10.5297 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.0918 -9.2823 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0918 -10.9431 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 10.5233 -10.9431 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3705 -9.6994 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 8.3705 -10.5297 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.0805 -11.7734 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6528 -9.2823 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6528 -10.9393 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 8 4 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 1 0 0 0 + 8 13 1 6 0 0 0 + 9 14 1 0 0 0 0 + 11 15 1 0 0 0 0 + 12 16 1 0 0 0 0 + 14 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 27 26 1 0 0 0 0 + 26 28 1 0 0 0 0 + 27 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 31 28 1 0 0 0 0 + 29 32 1 0 0 0 0 + 29 33 1 1 0 0 0 + 31 34 1 1 0 0 0 + 32 35 1 6 0 0 0 + 7 8 1 0 0 0 0 + 11 14 1 0 0 0 0 + 32 31 1 0 0 0 0 +M CHG 3 20 -1 24 -1 35 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04327.mol b/src/analysis/thermo/trainingModel/data/mol/C04327.mol new file mode 100644 index 0000000000..ab679cc5b7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04327.mol @@ -0,0 +1,32 @@ +C04327 + Mrv1652304062119512D + + 13 13 0 0 0 0 999 V2000 + 11.9933 -10.0757 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2564 -10.8576 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0814 -10.8490 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3281 -10.0617 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6556 -9.5838 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0380 -9.6524 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7525 -10.0648 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4669 -9.6524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5711 -11.5085 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1814 -9.2399 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8959 -8.8274 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7661 -8.5204 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.5909 -9.9493 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 1 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 3 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 10 11 2 0 0 0 0 + 10 12 1 0 0 0 0 + 10 13 1 0 0 0 0 +M CHG 2 12 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04348.mol b/src/analysis/thermo/trainingModel/data/mol/C04348.mol new file mode 100644 index 0000000000..46e6327f67 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04348.mol @@ -0,0 +1,120 @@ +C04348 + Mrv1652304062119512D + + 56 58 0 0 1 0 999 V2000 + 5.1695 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8840 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.5984 -12.1275 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 7.3129 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0274 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7418 -11.7150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4563 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1708 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8852 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5997 -11.7150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3142 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0286 -11.7150 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.7431 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4576 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1720 -12.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8840 -10.8901 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4563 -12.9524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3142 -12.9523 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0286 -10.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7431 -11.3025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7431 -12.9525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9970 -12.1275 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8220 -12.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9970 -12.9525 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.1688 -9.1988 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.9938 -9.1988 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.2487 -8.4141 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.5813 -7.9292 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9138 -8.4141 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.0263 -8.1614 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6838 -9.8662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4787 -9.8662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3037 -9.8662 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3037 -9.0412 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.1287 -9.8662 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3037 -10.6912 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4875 -7.3425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4875 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9165 -8.1675 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9165 -7.3425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2020 -6.9300 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7731 -6.9300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0585 -7.3425 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0585 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7731 -8.5800 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7731 -6.1051 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1944 -8.4162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0194 -8.4162 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0194 -7.5912 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.8444 -8.4162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0194 -10.3137 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4.4418 -11.7150 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 3.7273 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 3.0128 -11.7150 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 4.4385 -10.8902 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 3.7273 -12.9524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 52 1 1 0 0 0 0 + 52 53 1 0 0 0 0 + 53 54 1 0 0 0 0 + 52 55 1 1 0 0 0 + 53 56 2 0 0 0 0 +M CHG 5 24 -1 34 -1 35 -1 49 -1 54 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04367.mol b/src/analysis/thermo/trainingModel/data/mol/C04367.mol new file mode 100644 index 0000000000..2da92644ab --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04367.mol @@ -0,0 +1,36 @@ +C04367 + Mrv1652304062119512D + + 15 15 0 0 0 0 999 V2000 + 16.5000 -9.1575 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5000 -9.9825 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7575 -8.7450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2012 -8.7450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7575 -10.3950 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0562 -9.1575 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9025 -9.1575 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0562 -9.9825 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7575 -11.2612 0.0000 I 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3550 -8.7450 0.0000 I 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6450 -8.7450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9025 -9.9825 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3550 -10.3950 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6450 -7.9200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3462 -9.1575 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 + 7 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 8 13 1 0 0 0 0 + 11 14 2 0 0 0 0 + 11 15 1 0 0 0 0 + 6 8 1 0 0 0 0 +M CHG 1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04377.mol b/src/analysis/thermo/trainingModel/data/mol/C04377.mol new file mode 100644 index 0000000000..14e46bfd54 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04377.mol @@ -0,0 +1,118 @@ +C04377 + Mrv1652304062119512D + + 54 58 0 0 1 0 999 V2000 + 10.4897 -11.8686 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4897 -11.0334 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2136 -12.2819 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7617 -12.2896 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2101 -10.6082 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7617 -10.6195 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9459 -11.8721 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.0525 -11.8686 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9795 -11.0258 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.0525 -11.0334 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7617 -9.7913 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6585 -12.2785 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3474 -12.2750 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5604 -10.4625 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.2168 -9.6967 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4236 -9.7044 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3662 -10.6316 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7677 -9.4026 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7677 -8.5633 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4804 -9.8201 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4804 -8.1534 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2007 -9.4026 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2007 -8.5633 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9141 -8.1534 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6353 -8.5598 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.3445 -8.1458 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.6353 -9.3838 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0613 -8.5598 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.3445 -7.3219 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7746 -8.1422 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0613 -9.3802 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4874 -8.5521 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2707 -8.2934 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.9394 -8.7773 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5294 -7.5100 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.6052 -8.3010 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.3533 -7.5100 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 19.0456 -6.8414 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3886 -8.5598 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.8451 -6.8448 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.0869 -8.2142 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.9108 -8.2142 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 23.7389 -8.2142 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.9487 -7.3861 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 22.9487 -9.0346 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.4704 -8.6198 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.1848 -8.2074 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.8991 -8.6198 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.6135 -8.2074 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.3279 -8.6198 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.4776 -9.4445 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.1800 -9.8422 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 23.7517 -9.8721 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.6135 -7.3826 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 9 5 1 1 0 0 0 + 6 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 6 0 0 0 + 8 13 1 0 0 0 0 + 9 7 1 0 0 0 0 + 8 10 2 0 0 0 0 + 9 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 15 16 1 0 0 0 0 + 5 16 1 0 0 0 0 + 14 17 1 6 0 0 0 + 33 34 1 0 0 0 0 + 35 33 1 0 0 0 0 + 36 34 1 0 0 0 0 + 35 37 1 0 0 0 0 + 35 38 1 6 0 0 0 + 36 39 1 1 0 0 0 + 37 40 1 6 0 0 0 + 39 41 1 0 0 0 0 + 41 42 1 0 0 0 0 + 42 43 1 0 0 0 0 + 42 44 1 0 0 0 0 + 42 45 2 0 0 0 0 + 22 23 1 0 0 0 0 + 37 36 1 0 0 0 0 + 18 19 2 0 0 0 0 + 18 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 20 22 2 0 0 0 0 + 21 23 2 0 0 0 0 + 23 24 1 0 0 0 0 + 25 24 1 0 0 0 0 + 26 25 1 0 0 0 0 + 25 27 1 1 0 0 0 + 26 28 1 0 0 0 0 + 26 29 1 6 0 0 0 + 28 30 1 0 0 0 0 + 28 31 1 1 0 0 0 + 30 32 1 0 0 0 0 + 33 32 1 6 0 0 0 + 15 18 1 0 0 0 0 + 46 43 1 1 0 0 0 + 46 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 49 50 1 0 0 0 0 + 46 51 1 0 0 0 0 + 51 52 1 0 0 0 0 + 51 53 2 0 0 0 0 + 49 54 2 0 0 0 0 +M CHG 3 44 -1 50 -1 52 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04421.mol b/src/analysis/thermo/trainingModel/data/mol/C04421.mol new file mode 100644 index 0000000000..a8c862c49c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04421.mol @@ -0,0 +1,45 @@ +C04421 + Mrv1652304062119512D + + 20 19 0 0 1 0 999 V2000 + 15.9616 -11.7093 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.9616 -12.5321 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2520 -11.2978 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6747 -11.2978 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6747 -12.9469 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5355 -11.7093 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3913 -11.7093 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.6747 -10.4716 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3913 -12.5321 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6747 -13.7697 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8224 -11.2978 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1044 -12.9469 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1092 -11.7093 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.8209 -12.5321 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3927 -11.2978 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1092 -12.5321 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 19.5340 -12.9469 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.8209 -11.7093 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6796 -11.7093 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.3927 -10.4716 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 9 12 1 0 0 0 0 + 13 11 1 0 0 0 0 + 12 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 13 16 1 6 0 0 0 + 14 17 1 0 0 0 0 + 14 18 2 0 0 0 0 + 15 19 1 0 0 0 0 + 15 20 2 0 0 0 0 +M CHG 4 7 -1 16 1 17 -1 19 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04442.mol b/src/analysis/thermo/trainingModel/data/mol/C04442.mol new file mode 100644 index 0000000000..27e2153562 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04442.mol @@ -0,0 +1,37 @@ +C04442 + Mrv1652304062119512D + + 16 15 0 0 1 0 999 V2000 + 9.2945 -9.3226 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0090 -9.7351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7235 -9.3226 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.4380 -9.7351 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.1525 -9.3226 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8669 -9.7351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5814 -9.3226 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2959 -9.7351 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.4695 -9.3226 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 7.6445 -9.3226 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.4695 -8.4976 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4695 -10.1476 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.7235 -8.4976 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4380 -10.5601 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8669 -10.5601 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5814 -8.4976 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 1 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 2 0 0 0 0 + 9 12 1 0 0 0 0 + 3 13 1 1 0 0 0 + 4 14 1 6 0 0 0 + 6 15 2 0 0 0 0 + 7 16 2 0 0 0 0 +M CHG 3 8 -1 10 -1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04446.mol b/src/analysis/thermo/trainingModel/data/mol/C04446.mol new file mode 100644 index 0000000000..9c9394a851 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04446.mol @@ -0,0 +1,34 @@ +C04446 + OpenBabel04062119392D + + 14 14 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 6 1 0 0 0 0 + 2 10 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 10 1 0 0 0 0 + 4 7 2 0 0 0 0 + 4 10 1 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 8 14 1 0 0 0 0 +M CHG 1 9 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04462.mol b/src/analysis/thermo/trainingModel/data/mol/C04462.mol new file mode 100644 index 0000000000..435f137a11 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04462.mol @@ -0,0 +1,45 @@ +C04462 + Mrv1652304062119512D + + 20 19 0 0 1 0 999 V2000 + 15.9254 -11.6837 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.9254 -12.5065 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2158 -11.2723 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6385 -11.2723 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6385 -12.9214 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4992 -11.6837 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3551 -11.6837 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.6385 -10.4461 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3551 -12.5065 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6385 -13.7442 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7861 -11.2723 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0682 -12.9214 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0730 -11.6837 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7848 -12.5065 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3565 -11.2723 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0730 -12.5032 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4978 -12.9214 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.7848 -11.6837 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6434 -11.6837 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.3565 -10.4529 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 9 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 12 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 13 16 2 0 0 0 0 + 14 17 1 0 0 0 0 + 14 18 2 0 0 0 0 + 15 19 1 0 0 0 0 + 15 20 2 0 0 0 0 +M CHG 3 7 -1 17 -1 19 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04618.mol b/src/analysis/thermo/trainingModel/data/mol/C04618.mol new file mode 100644 index 0000000000..960320cb9d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04618.mol @@ -0,0 +1,20 @@ +C04618 + + + 8 7 0 0 1 0 0 0 0 0999 V2000 + 21.3773 -24.2471 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5883 -23.5432 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 23.7991 -24.2471 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.0101 -23.5432 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.2140 -24.2471 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 27.6151 -24.2471 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 25.0030 -22.1420 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5883 -22.1420 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 4 5 1 0 0 0 + 2 3 1 0 0 0 + 5 6 1 0 0 0 + 1 2 1 0 0 0 + 4 7 2 0 0 0 + 3 4 1 0 0 0 + 2 8 1 1 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C04654.mol b/src/analysis/thermo/trainingModel/data/mol/C04654.mol new file mode 100644 index 0000000000..6493fb93fa --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04654.mol @@ -0,0 +1,56 @@ +C04654 + Mrv1652304062119512D + + 25 25 0 0 1 0 999 V2000 + 8.1501 -7.8820 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.1462 -8.7097 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 7.3642 -7.6240 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8637 -7.4683 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.3528 -8.9602 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 8.8600 -9.1234 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.8783 -8.2845 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.1136 -6.8381 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5813 -7.8744 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0088 -9.6602 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5698 -8.7058 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2950 -7.4607 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2874 -9.1197 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0535 -7.8668 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0010 -8.7058 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2874 -9.9435 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7224 -7.4531 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7148 -9.1197 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5120 -7.8099 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4323 -8.7058 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1536 -7.4455 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1460 -9.1197 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8710 -7.8555 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.1581 -6.6938 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9007 -8.7469 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 4 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 6 11 2 0 0 0 0 + 9 12 1 0 0 0 0 + 11 13 1 4 0 0 0 + 12 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 13 16 2 0 0 0 0 + 14 17 1 0 0 0 0 + 15 18 1 0 0 0 0 + 17 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 22 25 1 0 0 0 0 + 5 7 1 0 0 0 0 +M CHG 1 23 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04677.mol b/src/analysis/thermo/trainingModel/data/mol/C04677.mol new file mode 100644 index 0000000000..0c8eeef4ab --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04677.mol @@ -0,0 +1,51 @@ +C04677 + Mrv1652304062119512D + + 22 23 0 0 1 0 999 V2000 + 11.5068 -8.2156 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9392 -8.9422 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.3356 -8.2156 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2571 -7.4285 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2656 -8.4653 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6819 -9.7293 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.5891 -7.4285 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8199 -8.8816 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9192 -6.9517 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6072 -8.9422 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.8569 -9.7293 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.1662 -10.3953 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3686 -7.1712 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8239 -8.6848 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3687 -10.3953 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9817 -7.7237 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5352 -6.3651 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6573 -7.8789 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8286 -7.8789 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0074 -7.8789 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.8324 -7.0577 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.8248 -8.7038 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 6 2 1 0 0 0 0 + 3 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 10 5 1 0 0 0 0 + 6 11 1 0 0 0 0 + 6 12 1 6 0 0 0 + 7 13 1 0 0 0 0 + 10 14 1 1 0 0 0 + 11 15 1 6 0 0 0 + 13 16 1 0 0 0 0 + 13 17 2 0 0 0 0 + 14 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 19 22 2 0 0 0 0 + 7 9 1 0 0 0 0 + 11 10 1 0 0 0 0 +M CHG 2 20 -1 21 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04688.mol b/src/analysis/thermo/trainingModel/data/mol/C04688.mol new file mode 100644 index 0000000000..e853dab4b9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04688.mol @@ -0,0 +1,40 @@ +C04688 + + + 18 17 0 0 1 0 0 0 0 0999 V2000 + 37.7147 -20.6676 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 36.5026 -21.3727 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 38.9270 -21.3612 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 37.7031 -19.2631 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 35.3019 -20.6676 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 40.1392 -20.6559 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 34.0898 -21.3727 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 41.3515 -21.3553 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 40.1218 -19.2572 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 32.8777 -20.6792 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 42.7443 -21.3553 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 31.6654 -21.3786 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.4532 -20.6792 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 29.2352 -21.3727 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.0230 -20.6676 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8051 -21.3612 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.5870 -20.6559 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.3747 -21.3553 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 1 1 0 0 + 2 5 1 0 0 0 + 3 6 1 0 0 0 + 5 7 1 0 0 0 + 6 8 1 0 0 0 + 6 9 2 0 0 0 + 7 10 1 0 0 0 + 8 11 1 0 0 0 + 10 12 1 0 0 0 + 12 13 1 0 0 0 + 13 14 1 0 0 0 + 14 15 1 0 0 0 + 15 16 1 0 0 0 + 16 17 1 0 0 0 + 17 18 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C04734.mol b/src/analysis/thermo/trainingModel/data/mol/C04734.mol new file mode 100644 index 0000000000..65b56b0bee --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04734.mol @@ -0,0 +1,55 @@ +C04734 + Mrv1652304062119512D + + 24 25 0 0 1 0 999 V2000 + 11.6579 -10.0230 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0903 -10.7497 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.4867 -10.0230 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4081 -9.2358 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4203 -10.2689 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8329 -11.5368 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.7403 -9.2358 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9712 -10.6890 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0704 -8.7589 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7581 -10.7497 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.0079 -11.5368 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.3173 -12.2029 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5199 -8.9785 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6343 -11.4421 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9747 -10.4923 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5195 -12.2029 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1330 -9.5272 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6864 -8.1724 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1225 -12.1045 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8082 -9.6861 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9831 -9.6861 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 7.1581 -9.6861 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.9831 -8.8611 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.9755 -10.5074 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 6 2 1 0 0 0 0 + 3 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 10 5 1 0 0 0 0 + 6 11 1 0 0 0 0 + 6 12 1 6 0 0 0 + 7 13 1 0 0 0 0 + 8 14 1 0 0 0 0 + 10 15 1 1 0 0 0 + 11 16 1 6 0 0 0 + 13 17 1 0 0 0 0 + 13 18 2 0 0 0 0 + 14 19 2 0 0 0 0 + 15 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 7 9 1 0 0 0 0 + 11 10 1 0 0 0 0 +M CHG 2 22 -1 23 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04738.mol b/src/analysis/thermo/trainingModel/data/mol/C04738.mol new file mode 100644 index 0000000000..cad0834524 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04738.mol @@ -0,0 +1,118 @@ +C04738 + Mrv1652304062119512D + + 55 57 0 0 1 0 999 V2000 + 12.8006 -12.8176 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.8006 -13.6502 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.0814 -12.4050 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5121 -12.4013 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0814 -14.0702 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.9472 -14.3276 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3662 -12.8176 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3409 -12.4050 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3662 -13.6502 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.0777 -14.8915 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9426 -13.9492 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6546 -12.4050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1621 -12.4050 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3409 -11.5800 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3409 -13.2263 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6509 -14.0589 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0739 -15.7166 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6541 -14.3617 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9350 -13.1242 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9872 -12.4050 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7854 -16.1291 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3625 -16.1291 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8084 -12.4087 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9872 -11.5800 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.9834 -13.2263 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5007 -15.7166 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.9863 -13.2112 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2122 -16.1291 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5007 -14.8915 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7697 -13.4610 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.9237 -15.7166 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4244 -12.9879 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0347 -14.2481 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.6390 -16.1291 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1019 -13.4799 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.8559 -14.2481 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.5539 -14.9181 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3505 -15.7166 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7453 -12.1401 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3441 -14.9143 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0620 -16.1291 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0376 -11.7162 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4720 -11.7162 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7773 -15.7166 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0376 -10.8837 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3222 -12.1212 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4720 -10.8837 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4888 -16.1291 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7491 -10.4711 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2003 -15.7166 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7453 -9.6461 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9157 -16.1291 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6271 -15.7166 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.3424 -16.1291 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9245 -12.8248 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 1 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 1 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 0 0 0 0 + 8 15 2 0 0 0 0 + 9 16 1 6 0 0 0 + 10 17 1 0 0 0 0 + 11 18 1 0 0 0 0 + 11 19 2 0 0 0 0 + 13 20 1 0 0 0 0 + 17 21 1 0 0 0 0 + 17 22 2 0 0 0 0 + 20 23 1 0 0 0 0 + 20 24 1 0 0 0 0 + 20 25 2 0 0 0 0 + 26 21 1 0 0 0 0 + 23 27 1 0 0 0 0 + 26 28 1 0 0 0 0 + 26 29 1 6 0 0 0 + 30 27 1 1 0 0 0 + 28 31 1 0 0 0 0 + 30 32 1 0 0 0 0 + 33 30 1 0 0 0 0 + 31 34 1 0 0 0 0 + 35 32 1 0 0 0 0 + 33 36 1 0 0 0 0 + 33 37 1 6 0 0 0 + 34 38 1 0 0 0 0 + 35 39 1 1 0 0 0 + 36 40 1 6 0 0 0 + 38 41 1 0 0 0 0 + 39 42 1 0 0 0 0 + 39 43 1 0 0 0 0 + 41 44 1 0 0 0 0 + 42 45 1 0 0 0 0 + 42 46 2 0 0 0 0 + 43 47 2 0 0 0 0 + 44 48 1 0 0 0 0 + 45 49 1 0 0 0 0 + 48 50 1 0 0 0 0 + 49 51 2 0 0 0 0 + 50 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 53 54 1 0 0 0 0 + 9 7 1 0 0 0 0 + 36 35 1 0 0 0 0 + 47 49 1 0 0 0 0 + 12 55 1 0 0 0 0 +M CHG 2 14 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04741.mol b/src/analysis/thermo/trainingModel/data/mol/C04741.mol new file mode 100644 index 0000000000..d0fbe6da73 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04741.mol @@ -0,0 +1,56 @@ +C04741 + Mrv1652304062119512D + + 25 25 0 0 1 0 999 V2000 + 13.8844 -10.3002 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.8809 -11.1302 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.0955 -10.0464 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5978 -9.8851 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1057 -11.3840 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.5978 -11.5384 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6118 -10.7185 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8382 -9.2643 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3113 -10.3002 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8587 -12.1696 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3113 -11.1302 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0282 -9.8851 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0282 -11.5384 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.7381 -10.3002 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7416 -11.1302 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0282 -12.3650 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4550 -9.8851 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4550 -11.5384 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1719 -10.3002 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1719 -11.1302 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8854 -9.8851 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8854 -11.5384 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5988 -10.3036 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.8579 -9.0825 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6023 -11.1302 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 2 0 0 0 0 + 4 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 6 11 2 0 0 0 0 + 9 12 1 0 0 0 0 + 13 11 1 0 0 0 0 + 12 14 1 0 0 0 0 + 13 15 1 0 0 0 0 + 13 16 1 6 0 0 0 + 14 17 1 0 0 0 0 + 15 18 1 0 0 0 0 + 17 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 20 22 1 0 0 0 0 + 21 23 1 0 0 0 0 + 21 24 2 0 0 0 0 + 22 25 1 0 0 0 0 + 5 7 1 0 0 0 0 +M CHG 1 23 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04751.mol b/src/analysis/thermo/trainingModel/data/mol/C04751.mol new file mode 100644 index 0000000000..09bf2d1d8a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04751.mol @@ -0,0 +1,51 @@ +C04751 + Mrv1652304062119512D + + 22 23 0 0 1 0 999 V2000 + 11.6724 -10.0372 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1048 -10.7638 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.5012 -10.0372 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4227 -9.2501 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4312 -10.2870 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8475 -11.5509 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.7547 -9.2501 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9855 -10.7032 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0848 -8.7733 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 9.7728 -10.7638 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.0225 -11.5509 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.3318 -12.2170 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5342 -8.9928 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9895 -10.5065 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.5343 -12.2170 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1473 -9.5453 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.7008 -8.1867 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8229 -9.7005 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.9942 -9.7005 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 7.1730 -9.7005 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.9980 -8.8793 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.9904 -10.5254 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 6 2 1 0 0 0 0 + 3 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 10 5 1 0 0 0 0 + 6 11 1 0 0 0 0 + 6 12 1 6 0 0 0 + 7 13 1 0 0 0 0 + 10 14 1 1 0 0 0 + 11 15 1 6 0 0 0 + 13 16 1 0 0 0 0 + 13 17 2 0 0 0 0 + 14 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 19 21 1 0 0 0 0 + 19 22 2 0 0 0 0 + 7 9 1 0 0 0 0 + 11 10 1 0 0 0 0 +M CHG 4 9 1 16 -1 20 -1 21 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04752.mol b/src/analysis/thermo/trainingModel/data/mol/C04752.mol new file mode 100644 index 0000000000..643b0f9003 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04752.mol @@ -0,0 +1,42 @@ +C04752 + Mrv1652304062119512D + + 18 18 0 0 0 0 999 V2000 + 11.9172 -10.1551 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2016 -10.5640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6289 -10.5754 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9172 -9.3222 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4899 -10.1475 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3521 -10.1551 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6252 -11.3970 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6289 -8.9095 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6645 -10.1437 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3521 -9.3222 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8429 -10.1475 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6645 -9.3222 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 9.6607 -10.9691 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0638 -8.9095 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0175 -10.1437 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 7.1960 -10.1437 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0175 -9.3222 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.0138 -10.9691 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 2 0 0 0 0 + 9 11 1 0 0 0 0 + 9 12 1 0 0 0 0 + 9 13 2 0 0 0 0 + 10 14 1 0 0 0 0 + 11 15 1 0 0 0 0 + 15 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 18 2 0 0 0 0 + 8 10 1 0 0 0 0 +M CHG 2 12 -1 17 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C04823.mol b/src/analysis/thermo/trainingModel/data/mol/C04823.mol new file mode 100644 index 0000000000..4c8ace1c2e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C04823.mol @@ -0,0 +1,67 @@ +C04823 + Mrv1652304062119512D + + 30 31 0 0 1 0 999 V2000 + 17.0123 -9.7696 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4467 -10.4937 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.8383 -9.7696 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7634 -8.9851 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7753 -10.0147 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1902 -11.2781 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.0909 -8.9851 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3210 -10.4333 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4234 -8.5062 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1192 -10.4937 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3681 -11.2781 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.6730 -11.9419 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3385 -10.2372 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8816 -11.9419 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1725 -9.4340 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3466 -9.4340 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5282 -9.4340 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.3466 -8.6117 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.3429 -10.2522 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8142 -8.5611 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.5411 -8.9807 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2680 -8.5611 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.9948 -8.9807 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7217 -8.5611 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.4486 -8.9807 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.8114 -7.7218 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.7217 -7.8059 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2680 -7.7217 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9961 -7.3014 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.5423 -7.3028 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 6 2 1 0 0 0 0 + 3 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 10 5 1 0 0 0 0 + 6 11 1 0 0 0 0 + 6 12 1 6 0 0 0 + 10 13 1 1 0 0 0 + 11 14 1 6 0 0 0 + 13 15 1 0 0 0 0 + 15 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 16 18 1 0 0 0 0 + 16 19 2 0 0 0 0 + 7 9 1 0 0 0 0 + 11 10 1 0 0 0 0 + 7 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 22 21 1 6 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 20 26 2 0 0 0 0 + 24 27 2 0 0 0 0 + 22 28 1 0 0 0 0 + 28 29 1 0 0 0 0 + 28 30 2 0 0 0 0 +M CHG 4 17 -1 18 -1 25 -1 29 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05268.mol b/src/analysis/thermo/trainingModel/data/mol/C05268.mol new file mode 100644 index 0000000000..55edf0c12b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05268.mol @@ -0,0 +1,120 @@ +C05268 + Mrv1652304062119512D + + 56 58 0 0 1 0 999 V2000 + 8.7434 -12.1275 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4579 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1724 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8868 -11.7150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6013 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3158 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0302 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7447 -11.7150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4592 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1736 -11.7150 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.8881 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6026 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3170 -12.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6013 -12.9524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4592 -12.9523 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1736 -10.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8881 -11.3025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8881 -12.9525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1420 -12.1275 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9670 -12.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1420 -12.9525 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3138 -9.1988 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.1388 -9.1988 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3937 -8.4141 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.7263 -7.9292 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0588 -8.4141 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.1713 -8.1614 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8288 -9.8662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6237 -9.8662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4487 -9.8662 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4487 -9.0412 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.2737 -9.8662 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.4487 -10.6912 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6325 -7.3425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6325 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0615 -8.1675 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0615 -7.3425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3470 -6.9300 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9181 -6.9300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2035 -7.3425 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2035 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9181 -8.5800 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9181 -6.1051 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3394 -8.4162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1644 -8.4162 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1644 -7.5912 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.9894 -8.4162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1644 -10.3137 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0306 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.3160 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.6016 -11.7150 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 5.8871 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.1726 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 4.4582 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.0309 -10.8901 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.6016 -10.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 10 9 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 5 14 2 0 0 0 0 + 9 15 2 0 0 0 0 + 10 16 1 6 0 0 0 + 11 17 1 0 0 0 0 + 11 18 1 0 0 0 0 + 13 19 1 0 0 0 0 + 19 20 2 0 0 0 0 + 19 21 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 26 25 1 0 0 0 0 + 22 26 1 0 0 0 0 + 24 27 1 6 0 0 0 + 22 28 1 1 0 0 0 + 23 29 1 1 0 0 0 + 29 30 1 0 0 0 0 + 30 31 1 0 0 0 0 + 30 32 1 0 0 0 0 + 30 33 2 0 0 0 0 + 34 35 1 0 0 0 0 + 35 36 1 0 0 0 0 + 36 37 1 0 0 0 0 + 37 38 2 0 0 0 0 + 34 38 1 0 0 0 0 + 34 39 2 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 41 42 1 0 0 0 0 + 35 42 2 0 0 0 0 + 39 43 1 0 0 0 0 + 26 36 1 6 0 0 0 + 27 44 1 0 0 0 0 + 44 45 1 0 0 0 0 + 45 46 1 0 0 0 0 + 45 47 2 0 0 0 0 + 45 48 1 0 0 0 0 + 19 48 1 0 0 0 0 + 1 49 1 0 0 0 0 + 49 50 1 0 0 0 0 + 51 50 1 0 0 0 0 + 51 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 53 54 1 0 0 0 0 + 49 55 2 0 0 0 0 + 51 56 1 6 0 0 0 +M CHG 4 21 -1 31 -1 32 -1 46 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05269.mol b/src/analysis/thermo/trainingModel/data/mol/C05269.mol new file mode 100644 index 0000000000..596c8c12c7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05269.mol @@ -0,0 +1,120 @@ +C05269 + Mrv1652304062119522D + + 56 58 0 0 1 0 999 V2000 + 8.0009 -12.1275 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7154 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4299 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1443 -11.7150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8588 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5733 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2877 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0022 -11.7150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7167 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4311 -11.7150 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1456 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8601 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5745 -12.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8588 -12.9524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7167 -12.9523 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4311 -10.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1456 -11.3025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1456 -12.9525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3995 -12.1275 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2245 -12.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3995 -12.9525 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.5713 -9.1988 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3963 -9.1988 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.6512 -8.4141 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.9838 -7.9292 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3163 -8.4141 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4288 -8.1614 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0863 -9.8662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8812 -9.8662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7062 -9.8662 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7062 -9.0412 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.5312 -9.8662 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.7062 -10.6912 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8900 -7.3425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8900 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3190 -8.1675 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3190 -7.3425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6045 -6.9300 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1756 -6.9300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4610 -7.3425 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4610 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1756 -8.5800 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1756 -6.1051 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5969 -8.4162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4219 -8.4162 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4219 -7.5912 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.2469 -8.4162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4219 -10.3137 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2881 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.5735 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8591 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.1446 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 4.4301 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 3.7157 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2884 -10.8901 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8591 -10.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 10 9 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 5 14 2 0 0 0 0 + 9 15 2 0 0 0 0 + 10 16 1 6 0 0 0 + 11 17 1 0 0 0 0 + 11 18 1 0 0 0 0 + 13 19 1 0 0 0 0 + 19 20 2 0 0 0 0 + 19 21 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 26 25 1 0 0 0 0 + 22 26 1 0 0 0 0 + 24 27 1 6 0 0 0 + 22 28 1 1 0 0 0 + 23 29 1 1 0 0 0 + 29 30 1 0 0 0 0 + 30 31 1 0 0 0 0 + 30 32 1 0 0 0 0 + 30 33 2 0 0 0 0 + 34 35 1 0 0 0 0 + 35 36 1 0 0 0 0 + 36 37 1 0 0 0 0 + 37 38 2 0 0 0 0 + 34 38 1 0 0 0 0 + 34 39 2 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 41 42 1 0 0 0 0 + 35 42 2 0 0 0 0 + 39 43 1 0 0 0 0 + 26 36 1 6 0 0 0 + 27 44 1 0 0 0 0 + 44 45 1 0 0 0 0 + 45 46 1 0 0 0 0 + 45 47 2 0 0 0 0 + 45 48 1 0 0 0 0 + 19 48 1 0 0 0 0 + 1 49 1 0 0 0 0 + 49 50 1 0 0 0 0 + 50 51 1 0 0 0 0 + 51 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 53 54 1 0 0 0 0 + 49 55 2 0 0 0 0 + 51 56 2 0 0 0 0 +M CHG 4 21 -1 31 -1 32 -1 46 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05271.mol b/src/analysis/thermo/trainingModel/data/mol/C05271.mol new file mode 100644 index 0000000000..a7c96d0814 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05271.mol @@ -0,0 +1,118 @@ +C05271 + Mrv1652304062119522D + + 55 57 0 0 1 0 999 V2000 + 8.0009 -12.1275 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 8.7154 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4299 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1443 -11.7150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8588 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5733 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2877 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0022 -11.7150 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7167 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4311 -11.7150 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1456 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8601 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5745 -12.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8588 -12.9524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7167 -12.9523 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4311 -10.8900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1456 -11.3025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1456 -12.9525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3995 -12.1275 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2245 -12.1275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3995 -12.9525 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.5713 -9.1988 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.3963 -9.1988 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.6512 -8.4141 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.9838 -7.9292 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3163 -8.4141 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4288 -8.1614 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0863 -9.8662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8812 -9.8662 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7062 -9.8662 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7062 -9.0412 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.5312 -9.8662 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.7062 -10.6912 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8900 -7.3425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8900 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3190 -8.1675 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3190 -7.3425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6045 -6.9300 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1756 -6.9300 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4610 -7.3425 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4610 -8.1675 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1756 -8.5800 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1756 -6.1051 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5969 -8.4162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4219 -8.4162 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4219 -7.5912 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.2469 -8.4162 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4219 -10.3137 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2881 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.5735 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.8591 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.1446 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 4.4301 -11.7150 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 3.7157 -12.1275 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.2884 -10.8901 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 10 9 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 12 13 1 0 0 0 0 + 5 14 2 0 0 0 0 + 9 15 2 0 0 0 0 + 10 16 1 6 0 0 0 + 11 17 1 0 0 0 0 + 11 18 1 0 0 0 0 + 13 19 1 0 0 0 0 + 19 20 2 0 0 0 0 + 19 21 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 1 0 0 0 0 + 24 25 1 0 0 0 0 + 26 25 1 0 0 0 0 + 22 26 1 0 0 0 0 + 24 27 1 6 0 0 0 + 22 28 1 1 0 0 0 + 23 29 1 1 0 0 0 + 29 30 1 0 0 0 0 + 30 31 1 0 0 0 0 + 30 32 1 0 0 0 0 + 30 33 2 0 0 0 0 + 34 35 1 0 0 0 0 + 35 36 1 0 0 0 0 + 36 37 1 0 0 0 0 + 37 38 2 0 0 0 0 + 34 38 1 0 0 0 0 + 34 39 2 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 41 42 1 0 0 0 0 + 35 42 2 0 0 0 0 + 39 43 1 0 0 0 0 + 26 36 1 6 0 0 0 + 27 44 1 0 0 0 0 + 44 45 1 0 0 0 0 + 45 46 1 0 0 0 0 + 45 47 2 0 0 0 0 + 45 48 1 0 0 0 0 + 19 48 1 0 0 0 0 + 1 49 1 0 0 0 0 + 49 50 1 0 0 0 0 + 50 51 2 0 0 0 0 + 51 52 1 0 0 0 0 + 52 53 1 0 0 0 0 + 53 54 1 0 0 0 0 + 49 55 2 0 0 0 0 +M CHG 4 21 -1 31 -1 32 -1 46 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05361.mol b/src/analysis/thermo/trainingModel/data/mol/C05361.mol new file mode 100644 index 0000000000..eedfae2460 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05361.mol @@ -0,0 +1,8 @@ +C05361 + Mrv1652304062119522D + + 2 1 0 0 0 0 999 V2000 + 17.3663 -11.9213 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5413 -11.9213 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05382.mol b/src/analysis/thermo/trainingModel/data/mol/C05382.mol new file mode 100644 index 0000000000..3bea308f5e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05382.mol @@ -0,0 +1,41 @@ +C05382 + Mrv1652304062119522D + + 18 17 0 0 1 0 999 V2000 + 15.0936 -9.7320 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3924 -9.3195 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6498 -9.7320 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.9486 -9.3195 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.2474 -9.7320 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.5049 -9.3195 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.8036 -9.7320 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1024 -9.3195 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3599 -9.7320 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9486 -8.4945 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6498 -10.5570 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2474 -10.5570 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5049 -8.4945 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8036 -10.5570 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9186 -9.7320 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7436 -9.7320 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.9186 -8.9070 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9186 -10.5570 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 4 10 1 6 0 0 0 + 3 11 1 1 0 0 0 + 5 12 1 1 0 0 0 + 6 13 1 1 0 0 0 + 7 14 2 0 0 0 0 + 1 15 1 0 0 0 0 + 15 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 15 18 1 0 0 0 0 +M CHG 2 16 -1 18 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05385.mol b/src/analysis/thermo/trainingModel/data/mol/C05385.mol new file mode 100644 index 0000000000..6bae2fa509 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05385.mol @@ -0,0 +1,40 @@ +C05385 + Mrv1652304062119522D + + 17 17 0 0 1 0 999 V2000 + 16.3440 -12.2429 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.6309 -11.8280 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3440 -13.0692 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.0570 -11.8314 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9177 -12.2429 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.6309 -13.4772 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.0570 -13.4772 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8526 -11.9579 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9177 -13.0692 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.2046 -11.8280 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6309 -14.3034 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8232 -10.9280 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8353 -12.8257 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.7590 -11.9597 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.2046 -13.4806 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4880 -12.2429 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.2046 -11.0086 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 6 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 9 5 1 0 0 0 0 + 5 10 1 1 0 0 0 + 6 11 1 1 0 0 0 + 8 12 2 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 1 0 0 0 0 + 9 15 1 6 0 0 0 + 10 16 1 0 0 0 0 + 10 17 2 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 3 13 -1 14 -1 16 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05402.mol b/src/analysis/thermo/trainingModel/data/mol/C05402.mol new file mode 100644 index 0000000000..2056772102 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05402.mol @@ -0,0 +1,52 @@ +C05402 + Mrv1652304062119522D + + 23 24 0 0 1 0 999 V2000 + 14.8345 -11.5208 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.1154 -11.1119 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5464 -11.1046 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8345 -12.3458 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.3999 -11.5208 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.2581 -10.6921 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1154 -12.7582 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.5499 -12.7994 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3999 -12.3458 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.6990 -11.1119 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9737 -11.1046 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.1154 -13.5832 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6990 -12.7582 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0675 -11.6413 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9737 -11.9259 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.6818 -10.6921 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6818 -12.3385 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.2618 -12.2524 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4009 -11.1009 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 18.4009 -11.9259 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.6818 -13.1635 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1201 -10.6848 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1164 -12.3385 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 6 0 0 0 + 4 1 1 0 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 1 6 0 0 0 + 9 5 1 0 0 0 0 + 5 10 1 1 0 0 0 + 11 6 1 1 0 0 0 + 7 12 1 1 0 0 0 + 9 13 1 1 0 0 0 + 10 14 1 0 0 0 0 + 15 11 1 0 0 0 0 + 11 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 18 1 6 0 0 0 + 16 19 1 0 0 0 0 + 17 20 1 0 0 0 0 + 17 21 1 1 0 0 0 + 19 22 1 4 0 0 0 + 20 23 1 6 0 0 0 + 7 9 1 0 0 0 0 + 20 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05403.mol b/src/analysis/thermo/trainingModel/data/mol/C05403.mol new file mode 100644 index 0000000000..2a15f827fa --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05403.mol @@ -0,0 +1,52 @@ +C05403 + Mrv1652304062119522D + + 23 24 0 0 1 0 999 V2000 + 15.7906 -10.1559 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.7906 -9.3309 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.0756 -10.5649 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.4986 -10.5649 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.4986 -8.9149 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0756 -8.9149 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3572 -10.9810 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.2171 -10.1559 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.4986 -11.3900 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2171 -9.3309 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 14.4465 -9.4513 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6387 -10.5649 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3572 -11.8059 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.9287 -10.5649 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9287 -8.9149 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9271 -10.9810 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.6387 -12.2184 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0721 -12.2184 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9271 -11.8059 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.2155 -10.5649 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6421 -13.0434 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2155 -12.2184 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5865 -11.1012 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 6 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 7 3 1 1 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 1 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 7 13 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 4 0 0 0 + 16 12 1 0 0 0 0 + 13 17 1 0 0 0 0 + 13 18 1 6 0 0 0 + 16 19 1 0 0 0 0 + 16 20 1 1 0 0 0 + 17 21 2 0 0 0 0 + 19 22 1 1 0 0 0 + 20 23 1 0 0 0 0 + 8 10 1 0 0 0 0 + 19 17 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05437.mol b/src/analysis/thermo/trainingModel/data/mol/C05437.mol new file mode 100644 index 0000000000..fc2df8006a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05437.mol @@ -0,0 +1,64 @@ +C05437 + Mrv1652304062119522D + + 28 31 0 0 1 0 999 V2000 + 16.0554 -12.8704 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3304 -13.2919 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0589 -12.0395 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.5008 -12.8739 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6134 -12.8817 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3488 -14.1624 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7794 -11.6215 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.3270 -11.6250 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0299 -11.1506 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5045 -12.0430 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9034 -13.2989 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.6064 -12.0465 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6205 -14.5337 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7830 -10.8082 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9034 -14.1235 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.1856 -12.8923 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8532 -12.4814 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4895 -10.4009 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9054 -10.4652 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1856 -14.5372 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4826 -13.2989 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1968 -10.8118 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4826 -14.1235 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.9032 -10.4043 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7762 -14.5266 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6062 -10.8189 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3091 -10.4114 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6025 -11.6285 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 3 9 1 1 0 0 0 + 4 10 1 0 0 0 0 + 11 5 1 0 0 0 0 + 5 12 1 0 0 0 0 + 6 13 1 0 0 0 0 + 7 14 1 1 0 0 0 + 11 15 1 0 0 0 0 + 11 16 1 0 0 0 0 + 11 17 1 1 0 0 0 + 14 18 1 0 0 0 0 + 14 19 1 6 0 0 0 + 15 20 1 1 0 0 0 + 16 21 1 0 0 0 0 + 18 22 1 0 0 0 0 + 23 20 1 0 0 0 0 + 22 24 1 0 0 0 0 + 23 25 1 1 0 0 0 + 24 26 2 0 0 0 0 + 26 27 1 0 0 0 0 + 26 28 1 0 0 0 0 + 7 10 1 0 0 0 0 + 8 12 1 0 0 0 0 + 15 13 1 0 0 0 0 + 23 21 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05439.mol b/src/analysis/thermo/trainingModel/data/mol/C05439.mol new file mode 100644 index 0000000000..5a48e195fa --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05439.mol @@ -0,0 +1,64 @@ +C05439 + Mrv1652304062119522D + + 28 31 0 0 1 0 999 V2000 + 16.0588 -12.8952 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3339 -13.3167 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0622 -12.0644 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.5042 -12.8988 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6169 -12.9066 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3522 -14.1872 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7828 -11.6464 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.3304 -11.6500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0333 -11.1755 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5078 -12.0679 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9069 -13.3238 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.6098 -12.0715 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6240 -14.5585 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7864 -10.8332 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.9069 -14.1484 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.1891 -12.9172 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8567 -12.5063 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4928 -10.4258 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9088 -10.4902 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1891 -14.5621 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4862 -13.3238 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2000 -10.8368 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4862 -14.1484 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.9065 -10.4293 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7797 -14.5514 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6094 -10.8439 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.3124 -10.4364 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6058 -11.6535 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 3 9 1 1 0 0 0 + 4 10 1 0 0 0 0 + 11 5 1 0 0 0 0 + 5 12 1 0 0 0 0 + 6 13 1 0 0 0 0 + 7 14 1 1 0 0 0 + 11 15 1 0 0 0 0 + 11 16 1 0 0 0 0 + 11 17 1 1 0 0 0 + 14 18 1 0 0 0 0 + 14 19 1 6 0 0 0 + 15 20 1 1 0 0 0 + 16 21 1 0 0 0 0 + 18 22 1 0 0 0 0 + 23 20 1 0 0 0 0 + 22 24 1 0 0 0 0 + 23 25 1 1 0 0 0 + 24 26 2 0 0 0 0 + 26 27 1 0 0 0 0 + 26 28 1 0 0 0 0 + 7 10 1 0 0 0 0 + 8 12 1 0 0 0 0 + 15 13 1 0 0 0 0 + 23 21 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05512.mol b/src/analysis/thermo/trainingModel/data/mol/C05512.mol new file mode 100644 index 0000000000..d9862c8d7e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05512.mol @@ -0,0 +1,43 @@ +C05512 + Mrv1652304062119522D + + 18 20 0 0 1 0 999 V2000 + 16.1577 -11.8414 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7946 -12.2799 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3920 -12.0885 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.4432 -11.0095 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5291 -11.7404 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8748 -13.1258 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7133 -11.5803 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1380 -12.8333 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3063 -11.0131 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2740 -12.0677 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6614 -13.4772 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0589 -12.0537 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.3130 -12.8333 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.3714 -12.9517 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9318 -11.5769 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2688 -11.7927 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8258 -13.5051 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6493 -12.3496 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 1 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 2 0 0 0 0 + 12 7 1 0 0 0 0 + 13 8 1 0 0 0 0 + 10 14 1 0 0 0 0 + 10 15 2 0 0 0 0 + 12 16 1 1 0 0 0 + 13 17 1 6 0 0 0 + 16 18 1 0 0 0 0 + 5 9 1 0 0 0 0 + 11 14 1 0 0 0 0 + 12 13 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05551.mol b/src/analysis/thermo/trainingModel/data/mol/C05551.mol new file mode 100644 index 0000000000..441f117783 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05551.mol @@ -0,0 +1,54 @@ +C05551 + Mrv1652304062119522D + + 23 25 0 0 1 0 999 V2000 + 16.7201 -8.5500 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.7201 -9.3770 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5472 -9.3770 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5472 -8.5500 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.3329 -9.6251 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 18.8291 -8.9634 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3329 -8.3018 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4081 -9.5424 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4081 -8.3845 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6224 -10.4108 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4493 -10.4108 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.1260 -11.0724 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0171 -8.1364 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3141 -8.5500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0171 -9.7905 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3141 -9.3770 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5961 -8.1393 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8941 -8.5486 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1796 -8.1361 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4652 -8.5486 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4652 -9.3736 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1796 -9.7860 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8941 -9.3736 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 1 0 0 0 + 1 4 1 0 0 0 0 + 5 3 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 4 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 + 1 13 1 1 0 0 0 + 13 14 1 0 0 0 0 + 2 15 2 0 0 0 0 + 14 16 2 0 0 0 0 + 14 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 18 19 2 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 2 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 18 23 1 0 0 0 0 +M CHG 1 11 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05572.mol b/src/analysis/thermo/trainingModel/data/mol/C05572.mol new file mode 100644 index 0000000000..ccbaaed9d0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05572.mol @@ -0,0 +1,25 @@ +C05572 + Mrv1652304062119522D + + 10 9 0 0 0 0 999 V2000 + 9.9415 -11.2615 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.6559 -10.8490 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3705 -11.2615 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0849 -10.8490 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7994 -11.2615 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5139 -10.8490 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2284 -11.2615 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6559 -10.0241 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5139 -10.0241 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7994 -12.0865 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 2 8 2 0 0 0 0 + 6 9 2 0 0 0 0 + 5 10 2 0 0 0 0 +M CHG 1 1 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05598.mol b/src/analysis/thermo/trainingModel/data/mol/C05598.mol new file mode 100644 index 0000000000..8cd4c13ec6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05598.mol @@ -0,0 +1,34 @@ +C05598 + Mrv1652304062119522D + + 14 14 0 0 0 0 999 V2000 + 4.2900 -10.7662 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 4.2900 -11.5912 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.0044 -12.0037 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.7190 -11.5912 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.7190 -10.7662 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.0044 -10.3537 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.4482 -10.3537 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.1627 -10.7662 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.8772 -10.3537 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 8.5916 -10.7662 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3061 -10.3537 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0206 -10.7662 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 7.1627 -11.5911 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.3061 -9.5289 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 1 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 11 14 2 0 0 0 0 +M CHG 1 12 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05662.mol b/src/analysis/thermo/trainingModel/data/mol/C05662.mol new file mode 100644 index 0000000000..c31ad25f68 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05662.mol @@ -0,0 +1,33 @@ +C05662 + Mrv1652304062119522D + + 14 13 0 0 1 0 999 V2000 + 15.4768 -12.2978 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.1879 -11.8795 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7239 -11.8795 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.4768 -13.1344 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9408 -12.2978 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0128 -12.2978 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1879 -13.5526 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.7239 -13.5526 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6519 -11.8795 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0128 -13.0925 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3017 -11.8795 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.6519 -11.0429 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3630 -12.2978 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.7239 -11.0429 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 9 12 2 0 0 0 0 + 9 13 1 0 0 0 0 + 3 14 1 6 0 0 0 +M CHG 3 7 -1 11 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05665.mol b/src/analysis/thermo/trainingModel/data/mol/C05665.mol new file mode 100644 index 0000000000..5332dd1fa2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05665.mol @@ -0,0 +1,15 @@ +C05665 + Mrv1652304062119522D + + 5 4 0 0 0 0 999 V2000 + 16.2130 -12.1055 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4976 -12.5165 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9283 -12.5165 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7786 -12.1055 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 17.6473 -12.1055 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 +M CHG 1 4 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05819.mol b/src/analysis/thermo/trainingModel/data/mol/C05819.mol new file mode 100644 index 0000000000..adc270805a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05819.mol @@ -0,0 +1,59 @@ +C05819 + + + 23 24 0 0 0 0 0 0 0 0999 V2000 + 13.4400 -14.7700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4400 -16.1700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6524 -16.8700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8649 -16.1700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8649 -14.7700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6524 -14.0700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0773 -16.8700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2897 -16.1700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2897 -14.7700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0773 -14.0700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0773 -12.6700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0773 -18.2700 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4873 -14.0785 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.4873 -16.8615 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6756 -14.7645 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8664 -14.0769 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.0560 -14.7637 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.2461 -14.0765 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.4362 -14.7635 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.6261 -14.0763 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.8162 -14.7635 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.6261 -12.6702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8664 -12.6702 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 + 2 3 1 0 0 0 + 3 4 2 0 0 0 + 4 5 1 0 0 0 + 5 6 2 0 0 0 + 1 6 1 0 0 0 + 4 7 1 0 0 0 + 7 8 2 0 0 0 + 8 9 1 0 0 0 + 9 10 2 0 0 0 + 5 10 1 0 0 0 + 10 11 1 0 0 0 + 7 12 1 0 0 0 + 9 13 1 0 0 0 + 8 14 1 0 0 0 + 13 15 1 0 0 0 + 15 16 2 0 0 0 + 16 17 1 0 0 0 + 17 18 1 0 0 0 + 18 19 1 0 0 0 + 19 20 2 0 0 0 + 20 21 1 0 0 0 + 20 22 1 0 0 0 + 16 23 1 0 0 0 +M STY 1 1 SRU +M SLB 1 1 1 +M SCN 1 1 HT +M SAL 1 5 13 15 16 17 23 +M SDI 1 4 19.0400 -15.6100 19.0400 -12.9500 +M SDI 1 4 23.5900 -12.9500 23.5900 -15.6100 +M SMT 1 n +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C05922.mol b/src/analysis/thermo/trainingModel/data/mol/C05922.mol new file mode 100644 index 0000000000..4d86f9a3aa --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05922.mol @@ -0,0 +1,73 @@ +C05922 + Mrv1652304062119522D + + 33 34 0 0 1 0 999 V2000 + 24.8394 -11.3130 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.8394 -10.4902 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1340 -11.7263 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 25.5560 -11.7263 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 25.5560 -10.0768 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1340 -10.0730 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.6070 -12.6364 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 26.2689 -11.3130 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.2689 -10.4902 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 25.5636 -9.2539 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.4249 -10.4863 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.9395 -12.1510 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3491 -13.4213 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.9856 -11.7226 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 22.7120 -10.0692 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 22.2722 -12.6364 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 22.5262 -13.4213 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 23.7549 -14.1304 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8512 -11.9197 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1054 -14.1304 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.0284 -11.9197 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2017 -11.9159 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3790 -11.9083 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.1979 -11.0892 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 20.1979 -12.7388 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5522 -11.9045 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7295 -11.9007 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5485 -11.0817 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.5485 -12.7312 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.9027 -11.8970 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0799 -11.8970 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.8990 -11.0704 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8990 -12.7199 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 1 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 13 7 1 0 0 0 0 + 8 14 1 0 0 0 0 + 11 15 2 0 0 0 0 + 16 12 1 0 0 0 0 + 13 17 1 0 0 0 0 + 13 18 1 6 0 0 0 + 16 19 1 1 0 0 0 + 17 20 1 6 0 0 0 + 19 21 1 0 0 0 0 + 21 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 23 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 26 28 1 0 0 0 0 + 26 29 2 0 0 0 0 + 27 30 1 0 0 0 0 + 30 31 1 0 0 0 0 + 30 32 1 0 0 0 0 + 30 33 2 0 0 0 0 + 8 9 2 0 0 0 0 + 17 16 1 0 0 0 0 +M CHG 3 24 -1 28 -1 31 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05945.mol b/src/analysis/thermo/trainingModel/data/mol/C05945.mol new file mode 100644 index 0000000000..4b2424bfa0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05945.mol @@ -0,0 +1,37 @@ +C05945 + Mrv1652304062119522D + + 16 15 0 0 1 0 999 V2000 + 16.1702 -10.8197 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4595 -11.2268 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8879 -11.2336 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 16.1668 -9.9882 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7418 -10.8162 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7124 -11.2336 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.0277 -11.2232 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5438 -11.2336 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.7367 -12.0617 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.7367 -10.3195 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.3170 -10.8127 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5994 -11.2198 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.8852 -10.8025 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5925 -12.0513 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 11.1641 -11.2198 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.8816 -10.0158 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 4 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 6 10 2 0 0 0 0 + 7 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 12 14 1 6 0 0 0 + 13 15 1 0 0 0 0 + 13 16 2 0 0 0 0 +M CHG 5 3 1 8 -1 9 -1 14 1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05979.mol b/src/analysis/thermo/trainingModel/data/mol/C05979.mol new file mode 100644 index 0000000000..1913205c20 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05979.mol @@ -0,0 +1,12 @@ +C05979 + Mrv1652304062119522D + + 4 3 0 0 0 0 999 V2000 + 12.9407 -9.9131 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6588 -10.3257 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2263 -10.3257 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3732 -9.9131 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C05984.mol b/src/analysis/thermo/trainingModel/data/mol/C05984.mol new file mode 100644 index 0000000000..eced02c450 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C05984.mol @@ -0,0 +1,19 @@ +C05984 + Mrv1652304062119522D + + 7 6 0 0 1 0 999 V2000 + 15.6241 -12.3495 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.3389 -11.9376 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.9092 -11.9424 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6193 -13.1779 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0538 -12.3447 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.3341 -11.1091 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1944 -12.3542 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 7 1 0 0 0 0 +M CHG 1 5 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06019.mol b/src/analysis/thermo/trainingModel/data/mol/C06019.mol new file mode 100644 index 0000000000..cc0d131416 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06019.mol @@ -0,0 +1,37 @@ +C06019 + Mrv1652304062119522D + + 16 15 0 0 1 0 999 V2000 + 5.4038 -9.4050 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 6.1050 -9.8175 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 4.7025 -9.8175 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 5.4038 -8.5800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.8475 -9.4050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.1050 -10.6425 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 3.9600 -9.4050 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 4.7025 -10.6425 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.5488 -9.8175 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 3.2588 -9.8175 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.3738 -9.8175 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1988 -9.8175 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.3738 -8.9925 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.3738 -10.6425 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2.5575 -9.4050 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 3.9600 -8.5800 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 7 3 1 0 0 0 0 + 3 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 7 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 11 14 2 0 0 0 0 + 10 15 1 0 0 0 0 + 7 16 1 1 0 0 0 +M CHG 2 12 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06020.mol b/src/analysis/thermo/trainingModel/data/mol/C06020.mol new file mode 100644 index 0000000000..c8c277c3c2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06020.mol @@ -0,0 +1,102 @@ +C06020 + + + 46 50 0 0 1 0 0 0 0 0999 V2000 + 24.8808 -22.6091 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 24.8226 -20.1317 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 26.2681 -23.0288 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.1872 -23.6467 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 23.5810 -22.2536 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0933 -19.7005 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0181 -19.0534 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 23.6510 -20.7905 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.2274 -24.3638 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9450 -24.7426 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 22.8465 -24.7776 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5084 -23.3552 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0758 -18.3598 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7993 -17.9574 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 22.7241 -19.3915 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8582 -18.3772 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 27.2941 -25.1914 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.1548 -26.1299 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9307 -25.7278 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 27.1543 -17.5610 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.6334 -17.2872 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7934 -16.6168 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3609 -24.3812 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.2824 -26.5263 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2559 -18.3305 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.1309 -16.2203 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3376 -23.0405 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 29.6433 -24.7776 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 28.2909 -19.6655 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 29.5326 -17.8875 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 29.6083 -22.6091 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.4128 -23.6759 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 29.6899 -26.2699 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 30.6342 -25.6578 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 29.5676 -20.0560 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.3369 -18.9543 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 29.6200 -16.7101 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 30.8149 -17.5320 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 30.0047 -21.3267 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.8525 -23.3552 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 31.5144 -24.7018 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 31.7185 -18.4762 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 31.7185 -19.9743 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 31.3454 -21.3034 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 27.0900 -21.2800 0.0000 Co 0 3 0 0 0 0 0 0 0 0 0 0 + 32.4800 -20.5100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 1 0 0 0 + 1 5 1 4 0 0 + 2 6 1 0 0 0 + 2 7 1 0 0 0 + 2 8 1 4 0 0 + 3 9 1 0 0 0 + 4 10 1 0 0 0 + 4 11 1 0 0 0 + 4 12 1 0 0 0 + 6 13 2 0 0 0 + 7 14 1 0 0 0 + 7 15 1 0 0 0 + 7 16 1 0 0 0 + 9 17 2 0 0 0 + 10 18 1 0 0 0 + 10 19 1 0 0 0 + 13 20 1 0 0 0 + 14 21 1 0 0 0 + 14 22 1 0 0 0 + 17 23 1 0 0 0 + 17 24 1 0 0 0 + 20 25 2 0 0 0 + 20 26 1 0 0 0 + 23 27 2 0 0 0 + 23 28 1 0 0 0 + 25 29 1 0 0 0 + 25 30 1 0 0 0 + 27 31 1 0 0 0 + 28 32 1 0 0 0 + 28 33 1 0 0 0 + 28 34 1 0 0 0 + 29 35 2 0 0 0 + 30 36 1 0 0 0 + 30 37 1 0 0 0 + 30 38 1 0 0 0 + 31 39 2 0 0 0 + 32 40 1 0 0 0 + 32 41 1 0 0 0 + 36 42 1 0 0 0 + 36 43 1 0 0 0 + 39 44 1 0 0 0 + 9 10 1 0 0 0 + 13 14 1 0 0 0 + 31 32 1 0 0 0 + 35 36 1 0 0 0 + 35 39 1 0 0 0 + 3 45 1 0 0 0 + 45 46 1 0 0 0 +M CHG 1 45 1 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C06021.mol b/src/analysis/thermo/trainingModel/data/mol/C06021.mol new file mode 100644 index 0000000000..e1c96b0560 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06021.mol @@ -0,0 +1,99 @@ +C06021 + + + 45 49 0 0 1 0 0 0 0 0999 V2000 + 24.8994 -22.5751 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 24.8416 -20.1168 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 26.2760 -22.9916 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.2111 -23.6048 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 23.6096 -22.2224 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1025 -19.6889 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0433 -19.0468 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 23.6790 -20.7705 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.2356 -24.3163 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.9631 -24.6922 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 22.8807 -24.7270 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5452 -23.3155 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 26.0852 -18.3585 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.8185 -17.9592 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 22.7593 -19.3823 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 22.8923 -18.3758 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 27.2941 -25.1376 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.1713 -26.0688 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9566 -25.6698 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 27.1554 -17.5659 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.6616 -17.2942 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 24.8126 -16.6289 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3527 -24.3336 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.2825 -26.4622 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 28.2485 -18.3295 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.1321 -16.2355 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 28.3296 -23.0032 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 29.6252 -24.7270 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 28.2832 -19.6542 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 29.5154 -17.8899 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 29.5905 -22.5751 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.3888 -23.6337 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 29.6715 -26.2078 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 30.6085 -25.6004 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 29.5501 -20.0417 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 30.3135 -18.9485 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 29.6021 -16.7215 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 30.7878 -17.5371 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 29.9838 -21.3026 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 31.8174 -23.3155 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 31.4819 -24.6517 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 31.6844 -18.4740 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 31.6844 -19.9606 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 31.3142 -21.2795 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 27.0916 -21.2563 0.0000 Co 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 1 3 1 0 0 0 + 1 4 1 0 0 0 + 1 5 1 4 0 0 + 2 6 1 0 0 0 + 2 7 1 0 0 0 + 2 8 1 4 0 0 + 3 9 1 0 0 0 + 4 10 1 0 0 0 + 4 11 1 0 0 0 + 4 12 1 0 0 0 + 6 13 2 0 0 0 + 7 14 1 0 0 0 + 7 15 1 0 0 0 + 7 16 1 0 0 0 + 9 17 2 0 0 0 + 10 18 1 0 0 0 + 10 19 1 0 0 0 + 13 20 1 0 0 0 + 14 21 1 0 0 0 + 14 22 1 0 0 0 + 17 23 1 0 0 0 + 17 24 1 0 0 0 + 20 25 2 0 0 0 + 20 26 1 0 0 0 + 23 27 2 0 0 0 + 23 28 1 0 0 0 + 25 29 1 0 0 0 + 25 30 1 0 0 0 + 27 31 1 0 0 0 + 28 32 1 0 0 0 + 28 33 1 0 0 0 + 28 34 1 0 0 0 + 29 35 2 0 0 0 + 30 36 1 0 0 0 + 30 37 1 0 0 0 + 30 38 1 0 0 0 + 31 39 2 0 0 0 + 32 40 1 0 0 0 + 32 41 1 0 0 0 + 36 42 1 0 0 0 + 36 43 1 0 0 0 + 39 44 1 0 0 0 + 9 10 1 0 0 0 + 13 14 1 0 0 0 + 31 32 1 0 0 0 + 35 36 1 0 0 0 + 35 39 1 0 0 0 + 3 45 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C06142.mol b/src/analysis/thermo/trainingModel/data/mol/C06142.mol new file mode 100644 index 0000000000..fb7b405e83 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06142.mol @@ -0,0 +1,14 @@ +C06142 + Mrv1652304062119522D + + 5 4 0 0 0 0 999 V2000 + 14.4331 -9.1375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7125 -8.7273 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1434 -8.7204 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9988 -9.1410 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8606 -9.1375 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06156.mol b/src/analysis/thermo/trainingModel/data/mol/C06156.mol new file mode 100644 index 0000000000..bcdf44306b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06156.mol @@ -0,0 +1,38 @@ +C06156 + Mrv1652304062119522D + + 16 16 0 0 1 0 999 V2000 + 15.8468 -11.7452 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1758 -11.3257 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8848 -12.5731 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5978 -11.3223 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4558 -11.7384 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1689 -12.9823 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.5945 -12.9823 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 17.4258 -11.3223 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4523 -12.5628 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.7434 -11.3223 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1620 -13.8068 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4293 -10.4977 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 18.2503 -11.3223 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.4293 -12.1502 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7323 -12.9713 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0233 -11.7348 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 1 4 1 6 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 9 5 1 0 0 0 0 + 5 10 1 1 0 0 0 + 6 11 1 1 0 0 0 + 8 12 1 0 0 0 0 + 8 13 1 0 0 0 0 + 8 14 2 0 0 0 0 + 9 15 1 6 0 0 0 + 10 16 1 0 0 0 0 + 6 9 1 0 0 0 0 +M CHG 3 7 1 12 -1 13 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06159.mol b/src/analysis/thermo/trainingModel/data/mol/C06159.mol new file mode 100644 index 0000000000..885cdf085d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06159.mol @@ -0,0 +1,27 @@ +C06159 + Mrv1652304062119522D + + 11 10 0 0 1 0 999 V2000 + 16.9826 -11.9213 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6937 -12.3396 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.2715 -12.3396 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4467 -11.9213 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.6937 -13.1762 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5186 -11.9213 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2715 -13.1762 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.1578 -12.3396 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.4467 -11.0847 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8075 -12.3396 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.5186 -11.0847 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 6 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 6 10 1 0 0 0 0 + 6 11 2 0 0 0 0 +M CHG 1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06219.mol b/src/analysis/thermo/trainingModel/data/mol/C06219.mol new file mode 100644 index 0000000000..8ee3b41b27 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06219.mol @@ -0,0 +1,75 @@ +C06219 + Mrv1652304062119522D + + 34 36 0 0 1 0 999 V2000 + 10.7300 -9.5638 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.7300 -8.7399 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.8985 -9.9966 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4437 -9.9776 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.4437 -8.3260 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.0123 -8.3260 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1923 -10.4142 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.1575 -9.5638 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.4361 -10.8015 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1575 -8.7399 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.2986 -8.7323 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4747 -10.0003 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.1923 -11.2382 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.8676 -9.9776 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8676 -8.3222 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7609 -10.4142 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 8.4747 -11.6520 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.8985 -11.6520 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5813 -7.9122 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 7.7609 -11.2382 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 7.0434 -10.0003 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.4672 -12.4758 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5813 -7.0883 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.2988 -8.3260 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 7.0434 -11.6482 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 6.3296 -10.4066 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2988 -6.6745 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8676 -6.6745 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0127 -7.9122 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.2875 -9.1499 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0127 -7.0883 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 12.1499 -7.0807 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7188 -8.3260 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7188 -6.6707 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 6 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 7 3 1 1 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 1 0 0 0 + 10 5 1 0 0 0 0 + 6 11 1 0 0 0 0 + 7 12 1 0 0 0 0 + 13 7 1 0 0 0 0 + 8 14 1 6 0 0 0 + 10 15 1 1 0 0 0 + 16 12 1 0 0 0 0 + 13 17 1 0 0 0 0 + 13 18 1 6 0 0 0 + 19 15 1 6 0 0 0 + 20 16 1 0 0 0 0 + 16 21 1 1 0 0 0 + 17 22 1 1 0 0 0 + 19 23 1 0 0 0 0 + 19 24 1 0 0 0 0 + 20 25 1 6 0 0 0 + 21 26 1 0 0 0 0 + 23 27 1 0 0 0 0 + 23 28 1 1 0 0 0 + 24 29 1 0 0 0 0 + 24 30 1 1 0 0 0 + 27 31 1 0 0 0 0 + 28 32 1 0 0 0 0 + 29 33 1 6 0 0 0 + 31 34 1 4 0 0 0 + 8 10 1 0 0 0 0 + 17 20 1 0 0 0 0 + 29 31 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06255.mol b/src/analysis/thermo/trainingModel/data/mol/C06255.mol new file mode 100644 index 0000000000..024e6d39bc --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06255.mol @@ -0,0 +1,21 @@ +C06255 + Mrv1652304062119522D + + 8 7 0 0 0 0 999 V2000 + 15.3746 -10.6449 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0884 -10.2312 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6609 -10.2312 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3746 -11.4689 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8055 -10.6449 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9471 -10.6449 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.6609 -9.4072 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5192 -10.2312 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 5 8 1 0 0 0 0 +M CHG 1 6 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06322.mol b/src/analysis/thermo/trainingModel/data/mol/C06322.mol new file mode 100644 index 0000000000..ff8b4cea65 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06322.mol @@ -0,0 +1,121 @@ +C06322 + Mrv1652304062119522D + + 56 59 0 0 1 0 999 V2000 + 17.5146 -14.0779 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2599 -13.6638 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9637 -14.0779 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6676 -13.6638 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4129 -14.0779 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1168 -13.6638 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8207 -14.0779 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5660 -13.6638 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2699 -14.0779 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.9738 -13.6638 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7191 -14.0779 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.4230 -13.6638 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.1269 -14.0779 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8308 -13.6638 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.5761 -14.0779 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2599 -12.8357 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8207 -14.9060 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7191 -14.9060 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.4230 -12.8357 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1269 -13.2498 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1269 -14.9060 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4042 -14.0779 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 29.2323 -14.0779 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4042 -14.9060 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.5535 -11.1381 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 25.3816 -11.1381 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.6300 -10.3514 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.9676 -9.8545 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.3051 -10.3514 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.4167 -10.1030 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0566 -11.8006 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.8785 -11.8006 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7066 -11.8006 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7066 -10.9725 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.5347 -11.8006 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 26.7066 -12.6287 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8621 -9.2748 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8621 -10.1030 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3113 -10.1030 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3113 -9.2748 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.5660 -8.8608 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1582 -8.8608 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4129 -9.2748 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4129 -10.1030 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1582 -10.5170 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1582 -8.0327 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.5761 -10.3514 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4042 -10.3514 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4042 -9.5233 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 29.2323 -10.3514 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4042 -12.2560 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5146 -14.8232 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8521 -13.6638 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8521 -15.2372 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1896 -14.0779 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1896 -14.8232 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 52 54 2 0 0 0 0 + 53 55 1 0 0 0 0 + 54 56 1 0 0 0 0 + 55 56 1 0 0 0 0 + 53 1 2 0 0 0 0 +M CHG 4 24 -1 34 -1 35 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06397.mol b/src/analysis/thermo/trainingModel/data/mol/C06397.mol new file mode 100644 index 0000000000..4421963e86 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06397.mol @@ -0,0 +1,88 @@ +C06397 + OpenBabel04062119392D + + 40 43 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 1 23 1 0 0 0 0 + 2 34 1 0 0 0 0 + 3 19 2 0 0 0 0 + 3 20 1 0 0 0 0 + 4 21 2 0 0 0 0 + 4 22 1 0 0 0 0 + 5 1 1 1 0 0 0 + 5 24 1 0 0 0 0 + 6 2 1 1 0 0 0 + 6 8 1 0 0 0 0 + 6 35 1 0 0 0 0 + 7 14 2 0 0 0 0 + 7 15 1 0 0 0 0 + 7 21 1 0 0 0 0 + 8 11 1 0 0 0 0 + 8 25 1 1 0 0 0 + 9 10 1 0 0 0 0 + 9 12 1 0 0 0 0 + 9 26 1 1 0 0 0 + 10 13 1 0 0 0 0 + 10 27 1 1 0 0 0 + 11 16 1 0 0 0 0 + 11 28 1 1 0 0 0 + 12 17 1 0 0 0 0 + 12 29 1 1 0 0 0 + 13 5 1 1 0 0 0 + 13 36 1 0 0 0 0 + 14 18 1 0 0 0 0 + 14 19 1 0 0 0 0 + 15 20 2 0 0 0 0 + 15 22 1 0 0 0 0 + 16 22 1 1 0 0 0 + 16 35 1 0 0 0 0 + 17 36 1 0 0 0 0 + 17 37 1 0 0 0 0 + 30 39 1 0 0 0 0 + 31 39 2 0 0 0 0 + 32 40 1 0 0 0 0 + 33 40 2 0 0 0 0 + 34 39 1 0 0 0 0 + 37 40 1 0 0 0 0 + 38 39 1 0 0 0 0 + 38 40 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06398.mol b/src/analysis/thermo/trainingModel/data/mol/C06398.mol new file mode 100644 index 0000000000..0d8deab099 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06398.mol @@ -0,0 +1,88 @@ +C06398 + OpenBabel04062119392D + + 40 43 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 1 23 1 0 0 0 0 + 2 34 1 0 0 0 0 + 3 19 2 0 0 0 0 + 3 20 1 0 0 0 0 + 4 21 2 0 0 0 0 + 4 22 1 0 0 0 0 + 5 1 1 1 0 0 0 + 5 24 1 0 0 0 0 + 6 2 1 1 0 0 0 + 6 8 1 0 0 0 0 + 6 35 1 0 0 0 0 + 7 14 2 0 0 0 0 + 7 15 1 0 0 0 0 + 7 21 1 0 0 0 0 + 8 11 1 0 0 0 0 + 8 25 1 1 0 0 0 + 9 10 1 0 0 0 0 + 9 12 1 0 0 0 0 + 9 26 1 1 0 0 0 + 10 13 1 0 0 0 0 + 10 27 1 1 0 0 0 + 11 16 1 0 0 0 0 + 11 28 1 1 0 0 0 + 12 17 1 0 0 0 0 + 12 29 1 1 0 0 0 + 13 5 1 1 0 0 0 + 13 36 1 0 0 0 0 + 14 18 1 0 0 0 0 + 14 19 1 0 0 0 0 + 15 20 2 0 0 0 0 + 15 22 1 0 0 0 0 + 16 22 1 1 0 0 0 + 16 35 1 0 0 0 0 + 17 36 1 0 0 0 0 + 17 37 1 0 0 0 0 + 30 39 1 0 0 0 0 + 31 39 2 0 0 0 0 + 32 40 1 0 0 0 0 + 33 40 2 0 0 0 0 + 34 39 1 0 0 0 0 + 37 40 1 0 0 0 0 + 38 39 1 0 0 0 0 + 38 40 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06463.mol b/src/analysis/thermo/trainingModel/data/mol/C06463.mol new file mode 100644 index 0000000000..d2f0bdef28 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06463.mol @@ -0,0 +1,21 @@ +C06463 + Mrv1652304062119522D + + 8 8 0 0 1 0 999 V2000 + 15.2375 -9.6266 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4070 -9.6266 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4822 -8.8547 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 15.7233 -10.2916 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1450 -8.8443 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9314 -10.2952 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8067 -8.3584 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2678 -8.6032 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 4 0 0 0 + 5 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06464.mol b/src/analysis/thermo/trainingModel/data/mol/C06464.mol new file mode 100644 index 0000000000..e9c79122b1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06464.mol @@ -0,0 +1,29 @@ +C06464 + Mrv1652304062119522D + + 12 12 0 0 1 0 999 V2000 + 14.5890 -8.4540 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.5890 -9.2551 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.3150 -8.0553 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8663 -8.0553 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3150 -9.6471 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.8663 -9.6471 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0410 -8.4540 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 13.2325 -8.5699 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0410 -9.2551 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.3116 -10.4481 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7637 -8.0553 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7637 -9.6471 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 6 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 7 11 1 4 0 0 0 + 9 12 1 1 0 0 0 + 9 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06468.mol b/src/analysis/thermo/trainingModel/data/mol/C06468.mol new file mode 100644 index 0000000000..4d32b8d13f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06468.mol @@ -0,0 +1,29 @@ +C06468 + Mrv1652304062119522D + + 12 12 0 0 1 0 999 V2000 + 15.3421 -8.4405 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 15.3421 -9.2414 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.6162 -8.0417 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0272 -7.7964 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1261 -8.7437 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6162 -9.6334 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.0681 -9.6334 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8902 -8.4405 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7225 -8.2191 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8902 -9.2414 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.6127 -10.4343 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1710 -9.6334 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 2 1 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 4 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 6 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 6 10 1 0 0 0 0 + 6 11 1 6 0 0 0 + 10 12 1 6 0 0 0 + 10 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06473.mol b/src/analysis/thermo/trainingModel/data/mol/C06473.mol new file mode 100644 index 0000000000..27c9f0657b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06473.mol @@ -0,0 +1,31 @@ +C06473 + Mrv1652304062119522D + + 13 12 0 0 1 0 999 V2000 + 6.3526 -12.3753 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.0671 -11.9628 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7816 -12.3753 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 8.4961 -11.9628 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 9.2106 -12.3753 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 9.9251 -11.9628 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6396 -12.3753 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3540 -11.9628 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 8.4961 -11.1377 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2106 -13.2002 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9251 -11.1379 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6396 -13.2003 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7816 -13.2002 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 4 9 1 1 0 0 0 + 5 10 1 1 0 0 0 + 6 11 2 0 0 0 0 + 7 12 2 0 0 0 0 + 3 13 1 6 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06547.mol b/src/analysis/thermo/trainingModel/data/mol/C06547.mol new file mode 100644 index 0000000000..486c5fd943 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06547.mol @@ -0,0 +1,8 @@ +C06547 + Mrv1652304062119522D + + 2 1 0 0 0 0 999 V2000 + 16.5825 -9.9825 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4075 -9.9825 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06567.mol b/src/analysis/thermo/trainingModel/data/mol/C06567.mol new file mode 100644 index 0000000000..f77cdaba6b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06567.mol @@ -0,0 +1,41 @@ +C06567 + + + 18 18 0 0 1 0 0 0 0 0999 V2000 + 18.6900 -17.5000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6900 -18.9000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0900 -18.9000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0900 -17.5000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4215 -19.3326 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.2444 -18.2000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4215 -17.0674 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2900 -17.5000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.6900 -16.1000 0.0000 H 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0900 -16.1000 0.0000 H 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2343 -17.2101 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2343 -19.1899 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8503 -20.6522 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.2094 -20.9411 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.9101 -21.6965 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7800 -20.2300 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2900 -18.9000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5900 -16.2876 0.0000 R 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 + 3 4 1 0 0 0 + 1 4 1 0 0 0 + 3 5 1 0 0 0 + 5 6 1 0 0 0 + 6 7 1 0 0 0 + 4 7 1 0 0 0 + 1 8 1 1 0 0 + 1 9 1 6 0 0 + 4 10 1 6 0 0 + 6 11 1 1 0 0 + 6 12 1 6 0 0 + 5 13 1 6 0 0 + 13 14 2 0 0 0 + 13 15 1 0 0 0 + 2 16 2 0 0 0 + 2 17 1 0 0 0 + 8 18 1 0 0 0 +M END \ No newline at end of file diff --git a/src/analysis/thermo/trainingModel/data/mol/C06670.mol b/src/analysis/thermo/trainingModel/data/mol/C06670.mol new file mode 100644 index 0000000000..bce62a5161 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06670.mol @@ -0,0 +1,28 @@ +C06670 + Mrv1652304062119522D + + 11 11 0 0 0 0 999 V2000 + 16.6729 -9.3690 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3875 -9.7813 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9548 -9.7813 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6763 -8.5445 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3875 -10.6059 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0987 -9.3690 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9548 -10.6059 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9583 -8.1287 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.3910 -8.1287 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6729 -11.0216 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6763 -11.8427 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 5 10 2 0 0 0 0 + 10 11 1 0 0 0 0 + 7 10 1 0 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06749.mol b/src/analysis/thermo/trainingModel/data/mol/C06749.mol new file mode 100644 index 0000000000..dedf7a8fca --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06749.mol @@ -0,0 +1,123 @@ +C06749 + Mrv1652304062119522D + + 57 60 0 0 1 0 999 V2000 + 17.5725 -13.0350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3150 -12.6225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.0163 -13.0350 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7175 -12.6225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4600 -13.0350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1613 -12.6225 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8625 -13.0350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.6050 -12.6225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3063 -13.0350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0075 -12.6225 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7500 -13.0350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 25.4513 -12.6225 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.1525 -13.0350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.8538 -12.6225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 27.5963 -13.0350 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3150 -11.7975 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.8625 -13.8600 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.7500 -13.8600 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.4513 -11.7975 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1525 -12.2100 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 26.1525 -13.8600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4213 -13.0350 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 29.2463 -13.0350 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4213 -13.8600 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 24.5850 -10.1063 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 25.4100 -10.1063 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 25.6575 -9.3225 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 24.9975 -8.8275 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 24.3375 -9.3225 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 26.4413 -9.0750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 24.0900 -10.7663 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 25.9050 -10.7663 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7300 -10.7663 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 26.7300 -9.9413 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 27.5550 -10.7663 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 26.7300 -11.5913 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9038 -8.2500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9038 -9.0750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3475 -9.0750 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 23.3475 -8.2500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.6050 -7.8375 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2025 -7.8375 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4600 -8.2500 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4600 -9.0750 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2025 -9.4875 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 21.2025 -7.0125 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 27.5963 -9.3225 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4213 -9.3225 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4213 -8.4975 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 29.2463 -9.3225 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 28.4213 -11.2200 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5725 -13.8600 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8300 -12.6638 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8713 -14.3138 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2738 -14.2725 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1288 -13.0763 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1288 -13.9013 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 10 11 1 0 0 0 0 + 12 11 1 0 0 0 0 + 12 13 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 2 16 2 0 0 0 0 + 7 17 2 0 0 0 0 + 11 18 2 0 0 0 0 + 12 19 1 6 0 0 0 + 13 20 1 0 0 0 0 + 13 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 22 23 2 0 0 0 0 + 22 24 1 0 0 0 0 + 25 26 1 0 0 0 0 + 26 27 1 0 0 0 0 + 27 28 1 0 0 0 0 + 29 28 1 0 0 0 0 + 25 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 25 31 1 1 0 0 0 + 26 32 1 1 0 0 0 + 32 33 1 0 0 0 0 + 33 34 1 0 0 0 0 + 33 35 1 0 0 0 0 + 33 36 2 0 0 0 0 + 37 38 1 0 0 0 0 + 38 39 1 0 0 0 0 + 39 40 1 0 0 0 0 + 40 41 2 0 0 0 0 + 37 41 1 0 0 0 0 + 37 42 2 0 0 0 0 + 42 43 1 0 0 0 0 + 43 44 2 0 0 0 0 + 44 45 1 0 0 0 0 + 38 45 2 0 0 0 0 + 42 46 1 0 0 0 0 + 29 39 1 6 0 0 0 + 30 47 1 0 0 0 0 + 47 48 1 0 0 0 0 + 48 49 1 0 0 0 0 + 48 50 2 0 0 0 0 + 48 51 1 0 0 0 0 + 22 51 1 0 0 0 0 + 1 52 1 0 0 0 0 + 52 54 1 0 0 0 0 + 52 55 1 0 0 0 0 + 53 56 1 0 0 0 0 + 54 57 1 0 0 0 0 + 56 57 1 0 0 0 0 + 53 1 2 0 0 0 0 +M CHG 4 24 -1 34 -1 35 -1 49 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06752.mol b/src/analysis/thermo/trainingModel/data/mol/C06752.mol new file mode 100644 index 0000000000..12eb2c9d3a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06752.mol @@ -0,0 +1,12 @@ +C06752 + Mrv1652304062119522D + + 4 3 0 0 0 0 999 V2000 + 16.7190 -10.2374 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4319 -9.8221 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9993 -9.8221 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1515 -10.2374 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06789.mol b/src/analysis/thermo/trainingModel/data/mol/C06789.mol new file mode 100644 index 0000000000..5eeafd831a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06789.mol @@ -0,0 +1,16 @@ +C06789 + Mrv1652304062119522D + + 6 5 0 0 0 0 999 V2000 + 16.4334 -9.9000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2593 -9.9000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0171 -10.5758 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0205 -9.1868 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6654 -10.6133 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6654 -9.1834 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06790.mol b/src/analysis/thermo/trainingModel/data/mol/C06790.mol new file mode 100644 index 0000000000..54848124cd --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06790.mol @@ -0,0 +1,14 @@ +C06790 + Mrv1652304062119522D + + 5 4 0 0 0 0 999 V2000 + 16.3944 -9.8985 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2194 -9.8985 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9802 -10.5741 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9835 -9.1855 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6302 -10.6114 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06791.mol b/src/analysis/thermo/trainingModel/data/mol/C06791.mol new file mode 100644 index 0000000000..204426abbe --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06791.mol @@ -0,0 +1,12 @@ +C06791 + Mrv1652304062119522D + + 4 3 0 0 0 0 999 V2000 + 16.5486 -9.9626 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3736 -9.9626 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1360 -9.2510 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7861 -10.6742 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06792.mol b/src/analysis/thermo/trainingModel/data/mol/C06792.mol new file mode 100644 index 0000000000..2a5c1bd084 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06792.mol @@ -0,0 +1,12 @@ +C06792 + Mrv1652304062119522D + + 4 3 0 0 0 0 999 V2000 + 16.3342 -9.4894 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1592 -9.4894 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9200 -10.1650 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5667 -10.2023 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06793.mol b/src/analysis/thermo/trainingModel/data/mol/C06793.mol new file mode 100644 index 0000000000..266161e697 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06793.mol @@ -0,0 +1,10 @@ +C06793 + Mrv1652304062119522D + + 3 2 0 0 0 0 999 V2000 + 17.1894 -9.6068 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3644 -9.6068 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6019 -10.3184 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C06827.mol b/src/analysis/thermo/trainingModel/data/mol/C06827.mol new file mode 100644 index 0000000000..176d657aa5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C06827.mol @@ -0,0 +1,58 @@ +C06827 + Mrv1652304062119522D + + 25 27 0 0 1 0 999 V2000 + 15.2797 -8.7549 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.2797 -9.5820 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1068 -9.5820 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1068 -8.7549 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.8924 -9.8301 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.3886 -9.1684 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8924 -8.5068 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9676 -9.7474 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9676 -8.5894 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.1819 -10.6158 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0089 -10.6158 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.6856 -11.2774 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5767 -8.3414 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8737 -8.7549 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5767 -9.9955 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8737 -9.5820 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1557 -8.3443 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.4537 -8.7536 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1557 -7.5193 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 11.7392 -8.3411 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0248 -8.7536 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0248 -9.5785 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7392 -9.9910 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4537 -9.5785 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3050 -9.9942 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 4 3 1 1 0 0 0 + 1 4 1 0 0 0 0 + 5 3 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 4 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 5 10 1 6 0 0 0 + 10 11 1 0 0 0 0 + 10 12 2 0 0 0 0 + 1 13 1 1 0 0 0 + 13 14 1 0 0 0 0 + 2 15 2 0 0 0 0 + 14 16 2 0 0 0 0 + 17 14 1 0 0 0 0 + 17 18 1 0 0 0 0 + 17 19 1 1 0 0 0 + 18 20 2 0 0 0 0 + 20 21 1 0 0 0 0 + 21 22 2 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 2 0 0 0 0 + 18 24 1 0 0 0 0 + 22 25 1 0 0 0 0 +M CHG 2 11 -1 19 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C07064.mol b/src/analysis/thermo/trainingModel/data/mol/C07064.mol new file mode 100644 index 0000000000..94e67b7406 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C07064.mol @@ -0,0 +1,52 @@ +C07064 + Mrv1652304062119522D + + 23 24 0 0 1 0 999 V2000 + 13.8011 -9.0889 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.5470 -8.3055 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.6261 -9.0889 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.1814 -9.8443 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2153 -7.8182 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8716 -7.8878 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8802 -8.3055 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 15.1100 -9.7573 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4642 -10.2551 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.1614 -8.2603 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6217 -7.8878 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.6671 -8.8382 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7541 -9.8443 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4642 -11.0801 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.3320 -8.3021 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0369 -10.2551 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.7541 -11.4909 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.1814 -11.4909 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0369 -11.0801 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.3198 -9.8443 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7541 -12.3159 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3198 -11.4909 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6062 -10.2551 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 6 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 1 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 1 0 0 0 + 9 4 1 1 0 0 0 + 6 10 1 0 0 0 0 + 7 11 1 6 0 0 0 + 7 12 1 1 0 0 0 + 9 13 1 0 0 0 0 + 14 9 1 0 0 0 0 + 11 15 1 0 0 0 0 + 16 13 1 0 0 0 0 + 14 17 1 0 0 0 0 + 14 18 1 6 0 0 0 + 19 16 1 0 0 0 0 + 16 20 1 1 0 0 0 + 17 21 1 1 0 0 0 + 19 22 1 1 0 0 0 + 20 23 1 0 0 0 0 + 7 5 1 0 0 0 0 + 17 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C07086.mol b/src/analysis/thermo/trainingModel/data/mol/C07086.mol new file mode 100644 index 0000000000..aaf1eec99e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C07086.mol @@ -0,0 +1,26 @@ +C07086 + Mrv1652304062119522D + + 10 10 0 0 0 0 999 V2000 + 16.6405 -10.1967 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9224 -10.6090 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3551 -10.6090 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6405 -9.3720 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9224 -11.4336 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3551 -11.4336 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3586 -8.9564 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6405 -11.8493 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3586 -8.1352 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0698 -9.3687 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 2 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 + 6 8 1 0 0 0 0 +M CHG 1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C07561.mol b/src/analysis/thermo/trainingModel/data/mol/C07561.mol new file mode 100644 index 0000000000..ae2142b446 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C07561.mol @@ -0,0 +1,14 @@ +C07561 + Mrv1652304062119522D + + 5 4 0 0 0 0 999 V2000 + 17.0376 -10.0205 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0376 -9.1765 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0411 -10.8264 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8920 -10.0240 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2316 -10.0205 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C07756.mol b/src/analysis/thermo/trainingModel/data/mol/C07756.mol new file mode 100644 index 0000000000..a9756c7e52 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C07756.mol @@ -0,0 +1,43 @@ +C07756 + Mrv1652304062119522D + + 18 19 0 0 1 0 999 V2000 + 13.0159 -13.6392 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0159 -12.8142 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.7293 -14.0694 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1910 -13.6392 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1910 -12.8142 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 13.7293 -12.4018 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4529 -13.6460 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7637 -14.8943 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6071 -14.2195 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4529 -12.8142 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1622 -14.0551 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0056 -15.2924 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.4317 -15.3068 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8790 -13.6425 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5882 -14.0551 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3017 -13.6425 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5959 -14.8764 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6066 -12.2298 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 2 1 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 2 0 0 0 0 + 6 10 1 0 0 0 0 + 7 11 1 0 0 0 0 + 8 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 11 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 15 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 5 4 1 0 0 0 0 + 7 10 1 0 0 0 0 + 5 18 1 1 0 0 0 +M CHG 2 12 -1 18 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C07761.mol b/src/analysis/thermo/trainingModel/data/mol/C07761.mol new file mode 100644 index 0000000000..5eaeea4144 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C07761.mol @@ -0,0 +1,60 @@ +C07761 + Mrv1652304062119522D + + 26 28 0 0 1 0 999 V2000 + 16.3776 -8.6151 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.3776 -9.4400 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0920 -9.8525 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8065 -9.4400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8065 -8.6151 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0920 -8.2027 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5526 -8.6151 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.5526 -9.4400 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8383 -8.2027 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1238 -8.6151 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.1238 -9.4400 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8383 -9.8525 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4094 -8.2027 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5319 -9.8590 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0920 -10.6774 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3677 -11.0956 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.7965 -11.0841 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.6835 -8.6220 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.2492 -9.4450 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9641 -9.8577 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.6790 -9.4450 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0059 -8.1514 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3479 -8.6504 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6191 -9.4304 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.4447 -9.4135 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.9643 -10.6979 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 1 6 1 0 0 0 0 + 1 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 2 8 1 0 0 0 0 + 7 9 1 1 0 0 0 + 9 10 1 0 0 0 0 + 10 11 2 0 0 0 0 + 8 12 2 0 0 0 0 + 10 13 1 0 0 0 0 + 4 14 1 0 0 0 0 + 3 15 1 0 0 0 0 + 15 16 2 0 0 0 0 + 15 17 1 0 0 0 0 + 13 18 1 0 0 0 0 + 14 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 18 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 23 24 2 0 0 0 0 + 24 25 1 0 0 0 0 + 18 25 2 0 0 0 0 + 20 26 2 0 0 0 0 +M CHG 1 17 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C08240.mol b/src/analysis/thermo/trainingModel/data/mol/C08240.mol new file mode 100644 index 0000000000..32ee95ea68 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C08240.mol @@ -0,0 +1,52 @@ +C08240 + Mrv1652304062119522D + + 23 24 0 0 1 0 999 V2000 + 13.5804 -11.2379 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.8698 -10.8219 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.2944 -10.8219 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5804 -12.0629 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.1523 -11.2379 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.0743 -10.2777 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8698 -12.4719 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.2944 -12.4719 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1523 -12.0629 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.4382 -10.8219 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8265 -10.7353 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.8698 -13.2968 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.4382 -12.4719 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7207 -11.2344 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8265 -11.5602 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.5441 -10.3228 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.5441 -11.9727 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.1125 -11.8478 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2546 -10.7353 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 17.2546 -11.5602 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.5441 -12.7976 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9720 -10.3228 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9720 -11.9727 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 1 0 0 0 + 4 1 1 0 0 0 0 + 5 2 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 4 8 1 6 0 0 0 + 9 5 1 0 0 0 0 + 5 10 1 1 0 0 0 + 11 6 1 1 0 0 0 + 7 12 1 1 0 0 0 + 9 13 1 6 0 0 0 + 10 14 1 0 0 0 0 + 15 11 1 0 0 0 0 + 11 16 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 18 1 6 0 0 0 + 19 16 1 0 0 0 0 + 17 20 1 0 0 0 0 + 17 21 1 1 0 0 0 + 19 22 1 1 0 0 0 + 20 23 1 6 0 0 0 + 7 9 1 0 0 0 0 + 20 19 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C08492.mol b/src/analysis/thermo/trainingModel/data/mol/C08492.mol new file mode 100644 index 0000000000..126489070a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C08492.mol @@ -0,0 +1,18 @@ +C08492 + Mrv1652304062119532D + + 7 6 0 0 0 0 999 V2000 + 16.5650 -11.2749 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.7386 -11.2749 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2777 -11.6846 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.0259 -11.6846 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.9937 -11.2749 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3099 -11.2749 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.7065 -11.6846 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C09306.mol b/src/analysis/thermo/trainingModel/data/mol/C09306.mol new file mode 100644 index 0000000000..5e6300438b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C09306.mol @@ -0,0 +1,10 @@ +C09306 + Mrv1652304062119532D + + 3 2 0 0 0 0 999 V2000 + 15.4688 -9.8588 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2938 -9.8588 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6438 -9.8588 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C11143.mol b/src/analysis/thermo/trainingModel/data/mol/C11143.mol new file mode 100644 index 0000000000..3934dff952 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C11143.mol @@ -0,0 +1,12 @@ +C11143 + Mrv1652304062119532D + + 4 3 0 0 0 0 999 V2000 + 12.8275 -10.2129 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 12.8233 -9.3879 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1151 -10.6290 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5440 -10.6218 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C11355.mol b/src/analysis/thermo/trainingModel/data/mol/C11355.mol new file mode 100644 index 0000000000..a6050d834f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C11355.mol @@ -0,0 +1,38 @@ +C11355 + Mrv1652304062119532D + + 16 16 0 0 1 0 999 V2000 + 13.7354 -14.2863 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.7354 -13.4583 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0120 -14.7089 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.4485 -14.6986 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0120 -13.0460 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2996 -14.2863 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0086 -15.5301 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.1574 -14.2863 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.2996 -13.4583 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0086 -12.2214 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8740 -14.6951 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1574 -13.4617 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7251 -11.8125 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.2921 -11.8160 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8740 -15.5197 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 16.5830 -14.2794 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 3 7 1 6 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 1 0 0 0 0 + 8 11 1 0 0 0 0 + 8 12 2 0 0 0 0 + 10 13 1 0 0 0 0 + 10 14 2 0 0 0 0 + 11 15 1 0 0 0 0 + 11 16 2 0 0 0 0 + 6 9 2 0 0 0 0 +M CHG 3 7 1 13 -1 15 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C11695.mol b/src/analysis/thermo/trainingModel/data/mol/C11695.mol new file mode 100644 index 0000000000..ae0b8b0cbd --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C11695.mol @@ -0,0 +1,54 @@ +C11695 + Mrv1652304062119532D + + 25 24 0 0 0 0 999 V2000 + 14.0028 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.8258 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2894 -14.2773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5432 -14.2773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5754 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.2607 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.7489 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0838 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0383 -14.2773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.8012 -14.2773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.3215 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5110 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.6040 -14.2773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3377 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8901 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0550 -14.2773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.8901 -13.0366 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7690 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.4823 -14.2773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.1963 -13.8640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 22.9097 -14.2773 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.1788 -14.2746 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 7.4642 -13.8623 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.7529 -14.2728 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.0383 -13.8563 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 2 0 0 0 0 + 6 8 2 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 12 14 2 0 0 0 0 + 13 15 1 0 0 0 0 + 14 16 1 0 0 0 0 + 15 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 + 15 22 1 0 0 0 0 + 1 2 2 0 0 0 0 + 22 23 1 0 0 0 0 + 1 3 1 0 0 0 0 + 23 24 1 0 0 0 0 + 2 4 1 0 0 0 0 + 24 25 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C11907.mol b/src/analysis/thermo/trainingModel/data/mol/C11907.mol new file mode 100644 index 0000000000..a3fba31b66 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C11907.mol @@ -0,0 +1,78 @@ +C11907 + Mrv1652304062119532D + + 35 37 0 0 1 0 999 V2000 + 18.7972 -12.2711 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 19.5864 -12.0126 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1527 -11.7989 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.5525 -13.0810 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.2068 -12.5640 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.7589 -11.2026 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4771 -12.2918 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.7253 -13.0810 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 20.9996 -12.3021 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 20.0449 -13.3706 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 20.5412 -10.9407 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6913 -12.0367 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.2358 -13.7428 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1685 -11.4922 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.7033 -10.1307 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.0778 -12.5881 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 21.9543 -11.2336 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2540 -12.5881 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4302 -12.5881 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2506 -13.4119 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 15.2506 -11.7644 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6030 -12.5881 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7793 -12.5881 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.5996 -13.4119 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.5996 -11.7644 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0796 -12.9914 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.0727 -13.8049 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.3799 -12.5847 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3661 -14.2081 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 12.7862 -14.2219 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 10.6733 -12.9811 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.6665 -13.7945 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3593 -15.0319 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9771 -12.5778 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9496 -14.1978 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 1 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 7 3 1 0 0 0 0 + 8 4 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 10 2 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 1 0 0 0 + 8 13 1 6 0 0 0 + 9 14 1 0 0 0 0 + 11 15 1 0 0 0 0 + 12 16 1 0 0 0 0 + 14 17 2 0 0 0 0 + 16 18 1 0 0 0 0 + 18 19 1 0 0 0 0 + 18 20 1 0 0 0 0 + 18 21 2 0 0 0 0 + 19 22 1 0 0 0 0 + 22 23 1 0 0 0 0 + 22 24 1 0 0 0 0 + 22 25 2 0 0 0 0 + 26 23 1 6 0 0 0 + 27 26 1 0 0 0 0 + 26 28 1 0 0 0 0 + 27 29 1 0 0 0 0 + 27 30 1 6 0 0 0 + 31 28 1 0 0 0 0 + 29 32 1 0 0 0 0 + 29 33 1 1 0 0 0 + 31 34 1 1 0 0 0 + 32 35 2 0 0 0 0 + 7 8 1 0 0 0 0 + 11 14 1 0 0 0 0 + 31 32 1 0 0 0 0 +M CHG 2 20 -1 24 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C13827.mol b/src/analysis/thermo/trainingModel/data/mol/C13827.mol new file mode 100644 index 0000000000..1cdbba3c37 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C13827.mol @@ -0,0 +1,12 @@ +C13827 + Mrv1652304062119532D + + 4 3 0 0 0 0 999 V2000 + 16.6787 -10.0237 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3932 -10.4362 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9642 -10.4362 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6787 -9.1987 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C14039.mol b/src/analysis/thermo/trainingModel/data/mol/C14039.mol new file mode 100644 index 0000000000..c339155c40 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C14039.mol @@ -0,0 +1,12 @@ +C14039 + Mrv1652304062119532D + + 4 3 0 0 0 0 999 V2000 + 14.8840 -11.5032 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5981 -11.9154 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.3125 -11.5029 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.5981 -12.7400 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 2 0 0 0 0 + 2 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C14177.mol b/src/analysis/thermo/trainingModel/data/mol/C14177.mol new file mode 100644 index 0000000000..ee586cf45b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C14177.mol @@ -0,0 +1,39 @@ +C14177 + Mrv1652304062119532D + + 17 16 0 0 1 0 999 V2000 + 14.7657 -12.0050 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4768 -12.4233 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1879 -12.0050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8990 -12.4233 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6519 -12.0050 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3630 -12.4233 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 17.6519 -11.1684 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.8873 -12.0050 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8873 -12.8416 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.8873 -11.2102 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0925 -12.0050 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3814 -12.4233 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6285 -12.0050 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.9174 -12.4233 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2063 -12.0050 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6285 -11.1684 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 10.9174 -13.2598 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 2 0 0 0 0 + 1 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 + 8 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 13 12 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 13 16 1 1 0 0 0 + 14 17 2 0 0 0 0 +M CHG 4 7 1 9 -1 15 -1 16 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C14178.mol b/src/analysis/thermo/trainingModel/data/mol/C14178.mol new file mode 100644 index 0000000000..70b5912d4d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C14178.mol @@ -0,0 +1,47 @@ +C14178 + Mrv1652304062119532D + + 21 20 0 0 1 0 999 V2000 + 15.2625 -10.8075 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9638 -11.2200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6650 -10.8075 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3663 -11.2200 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 18.1088 -10.8075 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.8100 -11.2200 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 18.1088 -9.9413 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3963 -10.8075 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3963 -11.6325 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 14.3963 -9.9825 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.6125 -10.8075 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.9113 -11.2200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.1688 -10.8075 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 11.4263 -11.2200 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.7250 -10.8075 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 12.1688 -9.9413 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 11.4263 -12.0450 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6350 -11.2200 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4600 -11.2200 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 19.6350 -10.3950 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6350 -12.0450 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 7 1 0 0 0 0 + 1 8 1 0 0 0 0 + 8 9 1 0 0 0 0 + 8 10 2 0 0 0 0 + 8 11 1 0 0 0 0 + 11 12 1 0 0 0 0 + 13 12 1 0 0 0 0 + 13 14 1 0 0 0 0 + 14 15 1 0 0 0 0 + 13 16 1 1 0 0 0 + 14 17 2 0 0 0 0 + 6 18 1 4 0 0 0 + 18 19 1 0 0 0 0 + 18 20 2 0 0 0 0 + 18 21 1 0 0 0 0 +M CHG 6 6 1 9 -1 15 -1 16 1 19 -1 21 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C14400.mol b/src/analysis/thermo/trainingModel/data/mol/C14400.mol new file mode 100644 index 0000000000..4f322c3892 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C14400.mol @@ -0,0 +1,16 @@ +C14400 + Mrv1652304062119532D + + 6 5 0 0 0 0 999 V2000 + 15.9203 -9.9231 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6348 -10.3356 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2057 -10.3356 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 17.3394 -9.9287 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.0392 -10.3327 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6349 -11.1606 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 2 6 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C14705.mol b/src/analysis/thermo/trainingModel/data/mol/C14705.mol new file mode 100644 index 0000000000..a9384092f6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C14705.mol @@ -0,0 +1,16 @@ +C14705 + Mrv1652304062119532D + + 6 5 0 0 0 0 999 V2000 + 14.4875 -11.7412 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2021 -12.1535 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.7728 -12.1535 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4875 -10.9166 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4840 -12.5692 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9132 -11.7412 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 0 0 0 0 + 2 6 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C14818.mol b/src/analysis/thermo/trainingModel/data/mol/C14818.mol new file mode 100644 index 0000000000..42c5876f16 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C14818.mol @@ -0,0 +1,7 @@ +C14818 + Mrv1652304062119532D + + 1 0 0 0 0 0 999 V2000 + 24.6400 -20.3700 0.0000 Fe 0 2 0 0 0 0 0 0 0 0 0 0 +M CHG 1 1 2 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C14819.mol b/src/analysis/thermo/trainingModel/data/mol/C14819.mol new file mode 100644 index 0000000000..d142864fe7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C14819.mol @@ -0,0 +1,7 @@ +C14819 + Mrv1652304062119532D + + 1 0 0 0 0 0 999 V2000 + 27.9300 -17.6400 0.0000 Fe 0 1 0 0 0 0 0 0 0 0 0 0 +M CHG 1 1 3 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C15025.mol b/src/analysis/thermo/trainingModel/data/mol/C15025.mol new file mode 100644 index 0000000000..9f2d02703d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C15025.mol @@ -0,0 +1,27 @@ +C15025 + Mrv1652304062119532D + + 11 10 0 0 1 0 999 V2000 + 13.8299 -8.9707 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5186 -9.4310 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 13.0926 -9.3410 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.5498 -10.2582 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2628 -9.0607 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.3078 -9.6906 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.3624 -8.9672 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.0926 -10.2409 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.6736 -9.4172 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.9156 -9.0468 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.6701 -10.1924 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 1 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 8 1 1 0 0 0 + 7 9 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 11 2 0 0 0 0 +M CHG 2 2 1 10 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C15673.mol b/src/analysis/thermo/trainingModel/data/mol/C15673.mol new file mode 100644 index 0000000000..fef0cc4d68 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C15673.mol @@ -0,0 +1,31 @@ +C15673 + Mrv1652304062119532D + + 13 12 0 0 1 0 999 V2000 + 8.4973 -9.7350 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.2118 -9.3225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9263 -9.7350 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 10.6408 -9.3225 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 11.3552 -9.7350 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 12.0697 -9.3225 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7841 -9.7350 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.4985 -9.3225 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 10.6408 -8.4975 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.3552 -10.5600 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.0697 -8.4977 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.7841 -10.5601 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 9.9263 -10.5599 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 4 3 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 8 1 0 0 0 0 + 4 9 1 1 0 0 0 + 5 10 1 1 0 0 0 + 6 11 2 0 0 0 0 + 7 12 2 0 0 0 0 + 3 13 1 1 0 0 0 +M CHG 1 8 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C16310.mol b/src/analysis/thermo/trainingModel/data/mol/C16310.mol new file mode 100644 index 0000000000..3d4c4153dd --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C16310.mol @@ -0,0 +1,18 @@ +C16310 + Mrv1652304062119532D + + 7 6 0 0 0 0 999 V2000 + 15.2142 -11.8790 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9671 -12.2973 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6781 -11.8790 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5147 -11.8790 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2258 -12.2973 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9368 -11.8790 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.4967 -12.3091 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 2 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 1 7 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C16512.mol b/src/analysis/thermo/trainingModel/data/mol/C16512.mol new file mode 100644 index 0000000000..a337a4e6ce --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C16512.mol @@ -0,0 +1,46 @@ +C16512 + Mrv1652304062119532D + + 21 20 0 0 0 0 999 V2000 + 13.9825 -12.1680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.6988 -11.7546 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2660 -11.7546 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4084 -12.1680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 12.5565 -12.1680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1248 -11.7546 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8401 -11.7546 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8344 -12.1680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.1306 -12.1680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 17.5507 -11.7546 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4142 -11.7546 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.2671 -12.1680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.7013 -12.1714 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 10.4176 -10.9315 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 18.9766 -11.7546 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 19.6930 -12.1680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 20.4060 -11.7546 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 21.1190 -12.1680 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.9732 -11.7565 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.2752 -12.1646 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 7.5683 -11.7616 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 8 10 1 0 0 0 0 + 9 11 1 0 0 0 0 + 10 12 1 0 0 0 0 + 11 13 1 0 0 0 0 + 11 14 2 0 0 0 0 + 12 15 1 0 0 0 0 + 15 16 1 0 0 0 0 + 16 17 1 0 0 0 0 + 17 18 1 0 0 0 0 + 13 19 1 0 0 0 0 + 19 20 1 0 0 0 0 + 20 21 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C16688.mol b/src/analysis/thermo/trainingModel/data/mol/C16688.mol new file mode 100644 index 0000000000..2c83adbbd4 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C16688.mol @@ -0,0 +1,61 @@ +C16688 + Mrv1652304062119532D + + 27 28 0 0 1 0 999 V2000 + 16.7530 -11.3825 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.1412 -11.9289 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.4405 -10.8874 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 17.0039 -12.1490 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.1755 -10.7946 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4297 -12.3415 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.1040 -11.3687 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 17.8392 -12.1490 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.5193 -12.8193 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4228 -11.1383 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7078 -11.9289 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.4297 -13.1665 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 18.8911 -11.1211 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 18.3171 -12.8228 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9997 -12.3450 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 14.7078 -13.5790 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 16.1377 -13.5790 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 19.3861 -11.7846 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.9997 -13.1665 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.2847 -11.9289 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7078 -14.4040 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.2847 -13.5790 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 12.6555 -12.4653 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8302 -12.4653 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8302 -13.2906 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 11.8302 -11.6400 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 11.0050 -12.4653 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 1 2 1 6 0 0 0 + 1 3 1 0 0 0 0 + 4 1 1 0 0 0 0 + 1 5 1 1 0 0 0 + 6 2 1 6 0 0 0 + 7 3 1 0 0 0 0 + 4 8 1 0 0 0 0 + 4 9 1 6 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 12 6 1 0 0 0 0 + 7 13 1 6 0 0 0 + 8 14 1 1 0 0 0 + 15 11 1 0 0 0 0 + 12 16 1 0 0 0 0 + 12 17 1 6 0 0 0 + 13 18 1 0 0 0 0 + 19 15 1 0 0 0 0 + 15 20 1 1 0 0 0 + 16 21 1 1 0 0 0 + 19 22 1 6 0 0 0 + 20 23 1 0 0 0 0 + 8 7 1 0 0 0 0 + 16 19 1 0 0 0 0 + 23 24 1 0 0 0 0 + 24 25 2 0 0 0 0 + 24 26 1 0 0 0 0 + 24 27 1 0 0 0 0 +M CHG 2 26 -1 27 -1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C18054.mol b/src/analysis/thermo/trainingModel/data/mol/C18054.mol new file mode 100644 index 0000000000..e67cdbe666 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C18054.mol @@ -0,0 +1,38 @@ +C18054 + Mrv1652304062119532D + + 16 16 0 0 1 0 999 V2000 + 14.5356 -14.5167 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 14.5356 -13.6917 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 13.8161 -14.9386 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2850 -15.1320 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8161 -13.2811 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1040 -14.5167 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9933 -14.7213 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.1040 -13.6917 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 13.8123 -12.4597 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7052 -15.1283 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9933 -13.9413 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.5243 -12.0529 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.1004 -12.0567 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.7052 -15.9495 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 17.3312 -14.7550 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 15.2549 -13.1101 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 1 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 2 0 0 0 0 + 5 9 1 0 0 0 0 + 7 10 1 0 0 0 0 + 7 11 2 0 0 0 0 + 9 12 1 0 0 0 0 + 9 13 2 0 0 0 0 + 10 14 1 0 0 0 0 + 10 15 2 0 0 0 0 + 6 8 1 0 0 0 0 + 2 16 1 6 0 0 0 +M CHG 3 12 -1 14 -1 16 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C18246.mol b/src/analysis/thermo/trainingModel/data/mol/C18246.mol new file mode 100644 index 0000000000..dfcc724a5c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C18246.mol @@ -0,0 +1,14 @@ +C18246 + Mrv1652304062119532D + + 5 4 0 0 0 0 999 V2000 + 15.1738 -10.8351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1738 -10.0201 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1771 -11.6133 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 15.9988 -10.8384 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.3955 -10.8351 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C18247.mol b/src/analysis/thermo/trainingModel/data/mol/C18247.mol new file mode 100644 index 0000000000..bd5d3ee98a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C18247.mol @@ -0,0 +1,12 @@ +C18247 + Mrv1652304062119532D + + 4 3 0 0 0 0 999 V2000 + 15.8951 -11.5448 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.6062 -11.9631 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 15.1840 -11.9631 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 15.8951 -10.7083 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C18248.mol b/src/analysis/thermo/trainingModel/data/mol/C18248.mol new file mode 100644 index 0000000000..4d79be7656 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C18248.mol @@ -0,0 +1,10 @@ +C18248 + Mrv1652304062119532D + + 3 2 0 0 0 0 999 V2000 + 10.5409 -9.0351 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 11.2520 -8.6168 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9631 -9.0351 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C19034.mol b/src/analysis/thermo/trainingModel/data/mol/C19034.mol new file mode 100644 index 0000000000..3d295fbcf5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C19034.mol @@ -0,0 +1,14 @@ +C19034 + Mrv1652304062119532D + + 5 4 0 0 0 0 999 V2000 + 8.3739 -12.4990 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0884 -12.0865 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 9.8029 -12.4990 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.5174 -12.0865 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0884 -11.2616 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 2 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C19248.mol b/src/analysis/thermo/trainingModel/data/mol/C19248.mol new file mode 100644 index 0000000000..db13c69ad3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C19248.mol @@ -0,0 +1,20 @@ +C19248 + Mrv1652304062119532D + + 8 7 0 0 0 0 999 V2000 + 10.2713 -10.3950 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0963 -10.3950 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.9213 -10.3950 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0963 -9.5700 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 11.0963 -11.2200 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 9.4463 -10.3950 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2713 -9.5700 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 10.2713 -11.2200 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 1 6 1 0 0 0 0 + 1 7 1 0 0 0 0 + 1 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C19496.mol b/src/analysis/thermo/trainingModel/data/mol/C19496.mol new file mode 100644 index 0000000000..38fb3014b7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C19496.mol @@ -0,0 +1,18 @@ +C19496 + Mrv1652304062119532D + + 7 6 0 0 0 0 999 V2000 + 7.7962 -9.5700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 8.6212 -9.5700 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 6.9712 -9.5700 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7962 -8.7450 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 7.7962 -10.3950 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0337 -10.2844 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 9.0337 -8.8555 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 1 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C19536.mol b/src/analysis/thermo/trainingModel/data/mol/C19536.mol new file mode 100644 index 0000000000..1704bc3e14 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C19536.mol @@ -0,0 +1,14 @@ +C19536 + Mrv1652304062119532D + + 5 4 0 0 0 0 999 V2000 + 9.4046 -10.5596 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1190 -10.1471 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 10.8335 -10.5596 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 11.5479 -10.1471 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 10.1190 -9.3222 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 2 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C19838.mol b/src/analysis/thermo/trainingModel/data/mol/C19838.mol new file mode 100644 index 0000000000..4c667f9370 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C19838.mol @@ -0,0 +1,25 @@ +C19838 + Mrv1652304062119532D + + 10 9 0 0 1 0 999 V2000 + 13.2621 -12.9654 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9682 -12.5500 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7159 -12.9654 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 15.4220 -12.5500 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 16.1281 -12.9654 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 16.8759 -12.5500 0.0000 O 0 5 0 0 0 0 0 0 0 0 0 0 + 13.9682 -11.7193 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 14.7159 -13.7962 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 15.4220 -11.7193 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 16.1281 -13.7962 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 3 2 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 + 2 7 2 0 0 0 0 + 3 8 1 1 0 0 0 + 4 9 1 6 0 0 0 + 5 10 2 0 0 0 0 +M CHG 3 1 -1 6 -1 8 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80001.mol b/src/analysis/thermo/trainingModel/data/mol/C80001.mol new file mode 100644 index 0000000000..7ce43d140f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80001.mol @@ -0,0 +1,30 @@ +C80001 + OpenBabel04062119392D + + 12 12 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 10 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 10 1 0 0 0 0 + 4 9 2 0 0 0 0 + 4 10 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 2 1 1 0 0 0 + 6 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 11 2 0 0 0 0 + 7 12 1 0 0 0 0 +M CHG 1 8 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80002.mol b/src/analysis/thermo/trainingModel/data/mol/C80002.mol new file mode 100644 index 0000000000..f917e4ef2a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80002.mol @@ -0,0 +1,19 @@ +C80002 + OpenBabel04062119392D + + 7 7 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80003.mol b/src/analysis/thermo/trainingModel/data/mol/C80003.mol new file mode 100644 index 0000000000..352d4f4555 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80003.mol @@ -0,0 +1,21 @@ +C80003 + OpenBabel04062119392D + + 8 8 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80004.mol b/src/analysis/thermo/trainingModel/data/mol/C80004.mol new file mode 100644 index 0000000000..ff08291d88 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80004.mol @@ -0,0 +1,21 @@ +C80004 + OpenBabel04062119392D + + 8 8 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80005.mol b/src/analysis/thermo/trainingModel/data/mol/C80005.mol new file mode 100644 index 0000000000..d2e7afc9fc --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80005.mol @@ -0,0 +1,21 @@ +C80005 + OpenBabel04062119392D + + 8 8 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 2 0 0 0 0 + 3 4 2 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80006.mol b/src/analysis/thermo/trainingModel/data/mol/C80006.mol new file mode 100644 index 0000000000..f924eca52c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80006.mol @@ -0,0 +1,23 @@ +C80006 + OpenBabel04062119392D + + 9 9 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80007.mol b/src/analysis/thermo/trainingModel/data/mol/C80007.mol new file mode 100644 index 0000000000..6b33500e5e --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80007.mol @@ -0,0 +1,23 @@ +C80007 + OpenBabel04062119392D + + 9 9 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80008.mol b/src/analysis/thermo/trainingModel/data/mol/C80008.mol new file mode 100644 index 0000000000..ac08ab81fc --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80008.mol @@ -0,0 +1,23 @@ +C80008 + OpenBabel04062119392D + + 9 9 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 4 2 0 0 0 0 + 1 5 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80009.mol b/src/analysis/thermo/trainingModel/data/mol/C80009.mol new file mode 100644 index 0000000000..137b8e905b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80009.mol @@ -0,0 +1,25 @@ +C80009 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80010.mol b/src/analysis/thermo/trainingModel/data/mol/C80010.mol new file mode 100644 index 0000000000..bda5d448f6 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80010.mol @@ -0,0 +1,25 @@ +C80010 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80011.mol b/src/analysis/thermo/trainingModel/data/mol/C80011.mol new file mode 100644 index 0000000000..4ad703e363 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80011.mol @@ -0,0 +1,25 @@ +C80011 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80012.mol b/src/analysis/thermo/trainingModel/data/mol/C80012.mol new file mode 100644 index 0000000000..ed18c4c397 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80012.mol @@ -0,0 +1,27 @@ +C80012 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 9 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80013.mol b/src/analysis/thermo/trainingModel/data/mol/C80013.mol new file mode 100644 index 0000000000..2268ebf7e9 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80013.mol @@ -0,0 +1,29 @@ +C80013 + OpenBabel04062119392D + + 12 12 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 7 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 8 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 9 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 10 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 11 1 0 0 0 0 + 6 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80014.mol b/src/analysis/thermo/trainingModel/data/mol/C80014.mol new file mode 100644 index 0000000000..dc19a1fbbb --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80014.mol @@ -0,0 +1,25 @@ +C80014 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80015.mol b/src/analysis/thermo/trainingModel/data/mol/C80015.mol new file mode 100644 index 0000000000..b34b0ff344 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80015.mol @@ -0,0 +1,27 @@ +C80015 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80016.mol b/src/analysis/thermo/trainingModel/data/mol/C80016.mol new file mode 100644 index 0000000000..7f551e713b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80016.mol @@ -0,0 +1,27 @@ +C80016 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 5 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 7 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80017.mol b/src/analysis/thermo/trainingModel/data/mol/C80017.mol new file mode 100644 index 0000000000..285405279c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80017.mol @@ -0,0 +1,27 @@ +C80017 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80018.mol b/src/analysis/thermo/trainingModel/data/mol/C80018.mol new file mode 100644 index 0000000000..8c10f44441 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80018.mol @@ -0,0 +1,27 @@ +C80018 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80019.mol b/src/analysis/thermo/trainingModel/data/mol/C80019.mol new file mode 100644 index 0000000000..f80392be60 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80019.mol @@ -0,0 +1,27 @@ +C80019 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 4 2 0 0 0 0 + 1 5 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80020.mol b/src/analysis/thermo/trainingModel/data/mol/C80020.mol new file mode 100644 index 0000000000..b6e910b23b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80020.mol @@ -0,0 +1,29 @@ +C80020 + OpenBabel04062119392D + + 12 12 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 + 7 11 2 0 0 0 0 + 7 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80021.mol b/src/analysis/thermo/trainingModel/data/mol/C80021.mol new file mode 100644 index 0000000000..43f72b8523 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80021.mol @@ -0,0 +1,29 @@ +C80021 + OpenBabel04062119392D + + 12 12 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 + 7 11 2 0 0 0 0 + 7 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80022.mol b/src/analysis/thermo/trainingModel/data/mol/C80022.mol new file mode 100644 index 0000000000..fd7b4bae07 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80022.mol @@ -0,0 +1,25 @@ +C80022 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Br 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80023.mol b/src/analysis/thermo/trainingModel/data/mol/C80023.mol new file mode 100644 index 0000000000..342bba2e7d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80023.mol @@ -0,0 +1,25 @@ +C80023 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Br 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80024.mol b/src/analysis/thermo/trainingModel/data/mol/C80024.mol new file mode 100644 index 0000000000..c51993751b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80024.mol @@ -0,0 +1,25 @@ +C80024 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Br 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 7 10 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80025.mol b/src/analysis/thermo/trainingModel/data/mol/C80025.mol new file mode 100644 index 0000000000..4994fc409f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80025.mol @@ -0,0 +1,25 @@ +C80025 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 I 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80026.mol b/src/analysis/thermo/trainingModel/data/mol/C80026.mol new file mode 100644 index 0000000000..a823d85ad2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80026.mol @@ -0,0 +1,25 @@ +C80026 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 I 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80027.mol b/src/analysis/thermo/trainingModel/data/mol/C80027.mol new file mode 100644 index 0000000000..16deb92142 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80027.mol @@ -0,0 +1,25 @@ +C80027 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 I 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 7 10 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80028.mol b/src/analysis/thermo/trainingModel/data/mol/C80028.mol new file mode 100644 index 0000000000..b5ed2731b1 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80028.mol @@ -0,0 +1,27 @@ +C80028 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 5 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 7 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80029.mol b/src/analysis/thermo/trainingModel/data/mol/C80029.mol new file mode 100644 index 0000000000..3c495d6256 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80029.mol @@ -0,0 +1,27 @@ +C80029 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 5 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 7 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80030.mol b/src/analysis/thermo/trainingModel/data/mol/C80030.mol new file mode 100644 index 0000000000..601144c882 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80030.mol @@ -0,0 +1,27 @@ +C80030 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 5 1 0 0 0 0 + 2 3 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 7 2 0 0 0 0 + 6 9 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 10 2 0 0 0 0 + 8 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80031.mol b/src/analysis/thermo/trainingModel/data/mol/C80031.mol new file mode 100644 index 0000000000..146d451d9c --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80031.mol @@ -0,0 +1,23 @@ +C80031 + OpenBabel04062119392D + + 9 9 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80032.mol b/src/analysis/thermo/trainingModel/data/mol/C80032.mol new file mode 100644 index 0000000000..bcf57929fe --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80032.mol @@ -0,0 +1,23 @@ +C80032 + OpenBabel04062119392D + + 9 9 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 4 2 0 0 0 0 + 1 5 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80033.mol b/src/analysis/thermo/trainingModel/data/mol/C80033.mol new file mode 100644 index 0000000000..91eeb90ea2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80033.mol @@ -0,0 +1,25 @@ +C80033 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 10 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80034.mol b/src/analysis/thermo/trainingModel/data/mol/C80034.mol new file mode 100644 index 0000000000..688f2177a7 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80034.mol @@ -0,0 +1,25 @@ +C80034 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 5 1 0 0 0 0 + 2 4 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80035.mol b/src/analysis/thermo/trainingModel/data/mol/C80035.mol new file mode 100644 index 0000000000..be5181ac0f --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80035.mol @@ -0,0 +1,25 @@ +C80035 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80036.mol b/src/analysis/thermo/trainingModel/data/mol/C80036.mol new file mode 100644 index 0000000000..52b355b967 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80036.mol @@ -0,0 +1,25 @@ +C80036 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80037.mol b/src/analysis/thermo/trainingModel/data/mol/C80037.mol new file mode 100644 index 0000000000..fa17b45fba --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80037.mol @@ -0,0 +1,25 @@ +C80037 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80038.mol b/src/analysis/thermo/trainingModel/data/mol/C80038.mol new file mode 100644 index 0000000000..1758661ef5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80038.mol @@ -0,0 +1,25 @@ +C80038 + OpenBabel04062119392D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 10 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80039.mol b/src/analysis/thermo/trainingModel/data/mol/C80039.mol new file mode 100644 index 0000000000..d243b43ae0 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80039.mol @@ -0,0 +1,27 @@ +C80039 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 11 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80040.mol b/src/analysis/thermo/trainingModel/data/mol/C80040.mol new file mode 100644 index 0000000000..e5c51b5f0a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80040.mol @@ -0,0 +1,27 @@ +C80040 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 6 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 5 2 0 0 0 0 + 4 9 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80041.mol b/src/analysis/thermo/trainingModel/data/mol/C80041.mol new file mode 100644 index 0000000000..396d919136 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80041.mol @@ -0,0 +1,27 @@ +C80041 + OpenBabel04062119392D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 9 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80042.mol b/src/analysis/thermo/trainingModel/data/mol/C80042.mol new file mode 100644 index 0000000000..cd93ab30f8 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80042.mol @@ -0,0 +1,29 @@ +C80042 + OpenBabel04062119392D + + 12 12 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 7 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 8 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 9 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 10 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 11 1 0 0 0 0 + 6 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80043.mol b/src/analysis/thermo/trainingModel/data/mol/C80043.mol new file mode 100644 index 0000000000..70e43eb274 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80043.mol @@ -0,0 +1,8 @@ +C80043 + OpenBabel04062119392D + + 2 1 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80045.mol b/src/analysis/thermo/trainingModel/data/mol/C80045.mol new file mode 100644 index 0000000000..a57334a946 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80045.mol @@ -0,0 +1,8 @@ +C80045 + OpenBabel04062119392D + + 2 1 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80046.mol b/src/analysis/thermo/trainingModel/data/mol/C80046.mol new file mode 100644 index 0000000000..0b3df68090 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80046.mol @@ -0,0 +1,16 @@ +C80046 + OpenBabel04062119392D + + 6 5 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80047.mol b/src/analysis/thermo/trainingModel/data/mol/C80047.mol new file mode 100644 index 0000000000..f5204a7af2 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80047.mol @@ -0,0 +1,10 @@ +C80047 + OpenBabel04062119392D + + 3 2 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 2 3 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80048.mol b/src/analysis/thermo/trainingModel/data/mol/C80048.mol new file mode 100644 index 0000000000..804561510d --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80048.mol @@ -0,0 +1,12 @@ +C80048 + OpenBabel04062119392D + + 4 3 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80049.mol b/src/analysis/thermo/trainingModel/data/mol/C80049.mol new file mode 100644 index 0000000000..92d5082009 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80049.mol @@ -0,0 +1,14 @@ +C80049 + OpenBabel04062119392D + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80050.mol b/src/analysis/thermo/trainingModel/data/mol/C80050.mol new file mode 100644 index 0000000000..1e7b6548f3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80050.mol @@ -0,0 +1,12 @@ +C80050 + OpenBabel04062119392D + + 4 3 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 4 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80051.mol b/src/analysis/thermo/trainingModel/data/mol/C80051.mol new file mode 100644 index 0000000000..36af6e398a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80051.mol @@ -0,0 +1,14 @@ +C80051 + OpenBabel04062119392D + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80052.mol b/src/analysis/thermo/trainingModel/data/mol/C80052.mol new file mode 100644 index 0000000000..a539249aac --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80052.mol @@ -0,0 +1,14 @@ +C80052 + OpenBabel04062119392D + + 5 4 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80053.mol b/src/analysis/thermo/trainingModel/data/mol/C80053.mol new file mode 100644 index 0000000000..b4c60d66b3 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80053.mol @@ -0,0 +1,14 @@ +C80053 + OpenBabel04062119392D + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 5 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80054.mol b/src/analysis/thermo/trainingModel/data/mol/C80054.mol new file mode 100644 index 0000000000..35bc59eee5 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80054.mol @@ -0,0 +1,16 @@ +C80054 + OpenBabel04062119392D + + 6 5 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80055.mol b/src/analysis/thermo/trainingModel/data/mol/C80055.mol new file mode 100644 index 0000000000..ac7caf12ff --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80055.mol @@ -0,0 +1,15 @@ +C80055 + OpenBabel04062119392D + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 4 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 +M CHG 1 4 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80056.mol b/src/analysis/thermo/trainingModel/data/mol/C80056.mol new file mode 100644 index 0000000000..7e0358d864 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80056.mol @@ -0,0 +1,32 @@ +C80056 + OpenBabel04062119392D + + 14 13 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 14 1 0 0 0 0 + 7 10 1 0 0 0 0 + 7 14 1 0 0 0 0 + 8 13 1 0 0 0 0 + 9 11 2 0 0 0 0 + 9 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80057.mol b/src/analysis/thermo/trainingModel/data/mol/C80057.mol new file mode 100644 index 0000000000..9e64bf615a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80057.mol @@ -0,0 +1,98 @@ +C80057 + OpenBabel04062119392D + + 44 48 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 1 10 1 0 0 0 0 + 2 3 2 0 0 0 0 + 2 4 1 0 0 0 0 + 3 11 1 0 0 0 0 + 4 27 2 0 0 0 0 + 5 11 2 0 0 0 0 + 5 27 1 0 0 0 0 + 6 12 1 0 0 0 0 + 6 38 1 0 0 0 0 + 7 13 1 0 0 0 0 + 7 39 1 0 0 0 0 + 8 24 2 0 0 0 0 + 8 25 1 0 0 0 0 + 9 26 2 0 0 0 0 + 9 28 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 29 2 0 0 0 0 + 12 15 1 0 0 0 0 + 12 40 1 0 0 0 0 + 13 16 1 0 0 0 0 + 13 41 1 0 0 0 0 + 14 19 2 0 0 0 0 + 14 20 1 0 0 0 0 + 14 26 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 30 1 0 0 0 0 + 16 18 1 0 0 0 0 + 16 31 1 0 0 0 0 + 17 21 1 0 0 0 0 + 17 32 1 0 0 0 0 + 18 22 1 0 0 0 0 + 18 33 1 0 0 0 0 + 19 23 1 0 0 0 0 + 19 24 1 0 0 0 0 + 20 25 2 0 0 0 0 + 20 28 1 0 0 0 0 + 21 27 1 0 0 0 0 + 21 40 1 0 0 0 0 + 22 28 1 0 0 0 0 + 22 41 1 0 0 0 0 + 34 43 2 0 0 0 0 + 35 43 1 0 0 0 0 + 36 44 2 0 0 0 0 + 37 44 1 0 0 0 0 + 38 43 1 0 0 0 0 + 39 44 1 0 0 0 0 + 42 43 1 0 0 0 0 + 42 44 1 0 0 0 0 +M CHG 1 27 1 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80058.mol b/src/analysis/thermo/trainingModel/data/mol/C80058.mol new file mode 100644 index 0000000000..dd2a4e138b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80058.mol @@ -0,0 +1,97 @@ +C80058 + OpenBabel04062119392D + + 44 48 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 1 10 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 4 2 0 0 0 0 + 3 11 1 0 0 0 0 + 4 27 1 0 0 0 0 + 5 11 2 0 0 0 0 + 5 27 1 0 0 0 0 + 6 12 1 0 0 0 0 + 6 38 1 0 0 0 0 + 7 13 1 0 0 0 0 + 7 39 1 0 0 0 0 + 8 24 2 0 0 0 0 + 8 25 1 0 0 0 0 + 9 26 2 0 0 0 0 + 9 28 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 29 2 0 0 0 0 + 12 15 1 0 0 0 0 + 12 40 1 0 0 0 0 + 13 16 1 0 0 0 0 + 13 41 1 0 0 0 0 + 14 19 2 0 0 0 0 + 14 20 1 0 0 0 0 + 14 26 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 30 1 0 0 0 0 + 16 18 1 0 0 0 0 + 16 31 1 0 0 0 0 + 17 21 1 0 0 0 0 + 17 32 1 0 0 0 0 + 18 22 1 0 0 0 0 + 18 33 1 0 0 0 0 + 19 23 1 0 0 0 0 + 19 24 1 0 0 0 0 + 20 25 2 0 0 0 0 + 20 28 1 0 0 0 0 + 21 27 1 0 0 0 0 + 21 40 1 0 0 0 0 + 22 28 1 0 0 0 0 + 22 41 1 0 0 0 0 + 34 43 1 0 0 0 0 + 35 43 2 0 0 0 0 + 36 44 1 0 0 0 0 + 37 44 2 0 0 0 0 + 38 43 1 0 0 0 0 + 39 44 1 0 0 0 0 + 42 43 1 0 0 0 0 + 42 44 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80061.mol b/src/analysis/thermo/trainingModel/data/mol/C80061.mol new file mode 100644 index 0000000000..55545cf764 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80061.mol @@ -0,0 +1,14 @@ +C80061 + OpenBabel04062119392D + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 4 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 5 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80062.mol b/src/analysis/thermo/trainingModel/data/mol/C80062.mol new file mode 100644 index 0000000000..af58de7456 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80062.mol @@ -0,0 +1,24 @@ +C80062 + OpenBabel04062119392D + + 10 9 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 6 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 5 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 10 2 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80063.mol b/src/analysis/thermo/trainingModel/data/mol/C80063.mol new file mode 100644 index 0000000000..a224260059 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80063.mol @@ -0,0 +1,40 @@ +C80063 + OpenBabel04062119392D + + 18 17 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 15 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 16 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 5 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 2 0 0 0 0 + 9 17 1 0 0 0 0 + 10 17 1 0 0 0 0 + 11 17 2 0 0 0 0 + 12 18 1 0 0 0 0 + 13 18 1 0 0 0 0 + 14 18 2 0 0 0 0 + 15 17 1 0 0 0 0 + 16 18 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80064.mol b/src/analysis/thermo/trainingModel/data/mol/C80064.mol new file mode 100644 index 0000000000..3f60c5ddbd --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80064.mol @@ -0,0 +1,30 @@ +C80064 + OpenBabel04062119392D + + 13 12 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 7 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 8 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 9 1 0 0 0 0 + 4 6 1 0 0 0 0 + 4 10 2 0 0 0 0 + 5 6 1 0 0 0 0 + 5 11 2 0 0 0 0 + 5 12 1 0 0 0 0 + 6 13 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80065.mol b/src/analysis/thermo/trainingModel/data/mol/C80065.mol new file mode 100644 index 0000000000..7b3ebf0fcc --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80065.mol @@ -0,0 +1,46 @@ +C80065 + OpenBabel04062119392D + + 21 20 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 18 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 19 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 12 20 1 0 0 0 0 + 13 20 1 0 0 0 0 + 14 20 2 0 0 0 0 + 15 21 1 0 0 0 0 + 16 21 1 0 0 0 0 + 17 21 2 0 0 0 0 + 18 20 1 0 0 0 0 + 19 21 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80066.mol b/src/analysis/thermo/trainingModel/data/mol/C80066.mol new file mode 100644 index 0000000000..1b1a27849b --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80066.mol @@ -0,0 +1,26 @@ +C80066 + OpenBabel04062119392D + + 11 10 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 3 10 1 0 0 0 0 + 7 11 1 0 0 0 0 + 8 11 1 0 0 0 0 + 9 11 2 0 0 0 0 + 10 11 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80068.mol b/src/analysis/thermo/trainingModel/data/mol/C80068.mol new file mode 100644 index 0000000000..71b3235af8 --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80068.mol @@ -0,0 +1,38 @@ +C80068 + OpenBabel04062119392D + + 17 16 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 9 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 10 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 11 1 0 0 0 0 + 4 5 1 0 0 0 0 + 4 12 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 13 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 14 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 15 1 0 0 0 0 + 8 16 2 0 0 0 0 + 8 17 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/C80069.mol b/src/analysis/thermo/trainingModel/data/mol/C80069.mol new file mode 100644 index 0000000000..f44d9c260a --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/C80069.mol @@ -0,0 +1,32 @@ +C80069 + OpenBabel04062119392D + + 14 13 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 14 1 0 0 0 0 + 7 10 1 0 0 0 0 + 7 14 1 0 0 0 0 + 8 13 1 0 0 0 0 + 9 11 2 0 0 0 0 + 9 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/trainingModel/data/mol/tmp.sdf b/src/analysis/thermo/trainingModel/data/mol/tmp.sdf new file mode 100644 index 0000000000..70637598ce --- /dev/null +++ b/src/analysis/thermo/trainingModel/data/mol/tmp.sdf @@ -0,0 +1,2083 @@ +C00225 + OpenBabel04062119382D + + 14 15 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 1 13 1 0 0 0 0 + 2 14 1 0 0 0 0 + 3 7 1 0 0 0 0 + 3 11 2 0 0 0 0 + 4 8 2 0 0 0 0 + 4 11 1 0 0 0 0 + 5 9 1 0 0 0 0 + 5 12 2 0 0 0 0 + 6 10 2 0 0 0 0 + 6 12 1 0 0 0 0 + 7 13 2 0 0 0 0 + 8 13 1 0 0 0 0 + 9 14 2 0 0 0 0 + 10 14 1 0 0 0 0 + 11 12 1 0 0 0 0 +M CHG 2 13 1 14 1 +M END +$$$$ +C01041 + OpenBabel04062119382D + + 12 12 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 7 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 8 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 5 1 1 0 0 0 + 3 9 1 6 0 0 0 + 4 6 1 1 0 0 0 + 4 10 1 6 0 0 0 + 5 12 1 0 0 0 0 + 6 11 2 0 0 0 0 + 6 12 1 0 0 0 0 +M RAD 1 9 2 +M END +$$$$ +C02022 + OpenBabel04062119382D + + 8 7 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 5 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 2 0 0 0 0 +M END +$$$$ +C02045 + OpenBabel04062119382D + + 8 7 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 5 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 2 0 0 0 0 +M END +$$$$ +C04446 + OpenBabel04062119382D + + 14 14 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 6 1 0 0 0 0 + 2 10 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 10 1 0 0 0 0 + 4 7 2 0 0 0 0 + 4 10 1 0 0 0 0 + 5 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 11 2 0 0 0 0 + 7 12 1 0 0 0 0 + 8 13 2 0 0 0 0 + 8 14 1 0 0 0 0 +M CHG 1 9 1 +M END +$$$$ +C06397 + OpenBabel04062119382D + + 40 43 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 1 5 1 0 0 0 0 + 1 23 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 34 1 0 0 0 0 + 3 19 2 0 0 0 0 + 3 20 1 0 0 0 0 + 4 21 2 0 0 0 0 + 4 22 1 0 0 0 0 + 5 13 1 0 0 0 0 + 5 24 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 35 1 0 0 0 0 + 7 14 2 0 0 0 0 + 7 15 1 0 0 0 0 + 7 21 1 0 0 0 0 + 8 11 1 0 0 0 0 + 8 25 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 12 1 0 0 0 0 + 9 26 1 0 0 0 0 + 10 13 1 0 0 0 0 + 10 27 1 0 0 0 0 + 11 16 1 0 0 0 0 + 11 28 1 0 0 0 0 + 12 17 1 0 0 0 0 + 12 29 1 0 0 0 0 + 13 36 1 0 0 0 0 + 14 18 1 0 0 0 0 + 14 19 1 0 0 0 0 + 15 20 2 0 0 0 0 + 15 22 1 0 0 0 0 + 16 22 1 0 0 0 0 + 16 35 1 0 0 0 0 + 17 36 1 0 0 0 0 + 17 37 1 0 0 0 0 + 30 39 1 0 0 0 0 + 31 39 2 0 0 0 0 + 32 40 1 0 0 0 0 + 33 40 2 0 0 0 0 + 34 39 1 0 0 0 0 + 37 40 1 0 0 0 0 + 38 39 1 0 0 0 0 + 38 40 1 0 0 0 0 +M END +$$$$ +C06398 + OpenBabel04062119382D + + 40 43 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 2 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 1 5 1 0 0 0 0 + 1 23 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 34 1 0 0 0 0 + 3 19 2 0 0 0 0 + 3 20 1 0 0 0 0 + 4 21 2 0 0 0 0 + 4 22 1 0 0 0 0 + 5 13 1 0 0 0 0 + 5 24 1 0 0 0 0 + 6 8 1 0 0 0 0 + 6 35 1 0 0 0 0 + 7 14 2 0 0 0 0 + 7 15 1 0 0 0 0 + 7 21 1 0 0 0 0 + 8 11 1 0 0 0 0 + 8 25 1 0 0 0 0 + 9 10 1 0 0 0 0 + 9 12 1 0 0 0 0 + 9 26 1 0 0 0 0 + 10 13 1 0 0 0 0 + 10 27 1 0 0 0 0 + 11 16 1 0 0 0 0 + 11 28 1 0 0 0 0 + 12 17 1 0 0 0 0 + 12 29 1 0 0 0 0 + 13 36 1 0 0 0 0 + 14 18 1 0 0 0 0 + 14 19 1 0 0 0 0 + 15 20 2 0 0 0 0 + 15 22 1 0 0 0 0 + 16 22 1 0 0 0 0 + 16 35 1 0 0 0 0 + 17 36 1 0 0 0 0 + 17 37 1 0 0 0 0 + 30 39 1 0 0 0 0 + 31 39 2 0 0 0 0 + 32 40 1 0 0 0 0 + 33 40 2 0 0 0 0 + 34 39 1 0 0 0 0 + 37 40 1 0 0 0 0 + 38 39 1 0 0 0 0 + 38 40 1 0 0 0 0 +M END +$$$$ +C80001 + OpenBabel04062119382D + + 12 12 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 1 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 10 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 10 1 0 0 0 0 + 4 9 2 0 0 0 0 + 4 10 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 11 2 0 0 0 0 + 7 12 1 0 0 0 0 +M CHG 1 8 1 +M END +$$$$ +C80002 + OpenBabel04062119382D + + 7 7 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 5 6 1 0 0 0 0 + 6 7 1 0 0 0 0 +M END +$$$$ +C80003 + OpenBabel04062119382D + + 8 8 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END +$$$$ +C80004 + OpenBabel04062119382D + + 8 8 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END +$$$$ +C80005 + OpenBabel04062119382D + + 8 8 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 6 2 0 0 0 0 + 3 4 2 0 0 0 0 + 3 5 1 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END +$$$$ +C80006 + OpenBabel04062119382D + + 9 9 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END +$$$$ +C80007 + OpenBabel04062119382D + + 9 9 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END +$$$$ +C80008 + OpenBabel04062119382D + + 9 9 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 4 2 0 0 0 0 + 1 5 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END +$$$$ +C80009 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END +$$$$ +C80010 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END +$$$$ +C80011 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END +$$$$ +C80012 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 9 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 +M END +$$$$ +C80013 + OpenBabel04062119382D + + 12 12 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 7 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 8 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 9 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 10 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 11 1 0 0 0 0 + 6 12 1 0 0 0 0 +M END +$$$$ +C80014 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M END +$$$$ +C80015 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END +$$$$ +C80016 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 5 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 7 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END +$$$$ +C80017 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 7 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END +$$$$ +C80018 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END +$$$$ +C80019 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 4 2 0 0 0 0 + 1 5 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END +$$$$ +C80020 + OpenBabel04062119382D + + 12 12 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 + 7 11 2 0 0 0 0 + 7 12 1 0 0 0 0 +M END +$$$$ +C80021 + OpenBabel04062119382D + + 12 12 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 + 7 11 2 0 0 0 0 + 7 12 1 0 0 0 0 +M END +$$$$ +C80022 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Br 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M END +$$$$ +C80023 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Br 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M END +$$$$ +C80024 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Br 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 7 10 2 0 0 0 0 +M END +$$$$ +C80025 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 I 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 5 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M END +$$$$ +C80026 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 I 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 5 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 2 0 0 0 0 + 7 10 1 0 0 0 0 +M END +$$$$ +C80027 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 I 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 5 2 0 0 0 0 + 2 4 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 4 6 1 0 0 0 0 + 5 7 1 0 0 0 0 + 6 8 1 0 0 0 0 + 7 9 1 0 0 0 0 + 7 10 2 0 0 0 0 +M END +$$$$ +C80028 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 5 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 7 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END +$$$$ +C80029 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 6 1 0 0 0 0 + 3 4 2 0 0 0 0 + 3 5 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 7 1 0 0 0 0 + 6 9 1 0 0 0 0 + 7 10 2 0 0 0 0 + 7 11 1 0 0 0 0 +M END +$$$$ +C80030 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 5 1 0 0 0 0 + 2 3 2 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 7 2 0 0 0 0 + 6 9 1 0 0 0 0 + 7 8 1 0 0 0 0 + 8 10 2 0 0 0 0 + 8 11 1 0 0 0 0 +M END +$$$$ +C80031 + OpenBabel04062119382D + + 9 9 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 8 1 0 0 0 0 +M END +$$$$ +C80032 + OpenBabel04062119382D + + 9 9 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 4 2 0 0 0 0 + 1 5 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 6 2 0 0 0 0 + 3 5 2 0 0 0 0 + 3 6 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END +$$$$ +C80033 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 10 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END +$$$$ +C80034 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 5 1 0 0 0 0 + 2 4 2 0 0 0 0 + 2 6 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 2 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END +$$$$ +C80035 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END +$$$$ +C80036 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END +$$$$ +C80037 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END +$$$$ +C80038 + OpenBabel04062119382D + + 10 10 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 2 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 2 0 0 0 0 + 3 10 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 7 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 9 1 0 0 0 0 +M END +$$$$ +C80039 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 11 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 8 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 1 0 0 0 0 + 6 10 1 0 0 0 0 +M END +$$$$ +C80040 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 6 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 5 2 0 0 0 0 + 4 9 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 +M END +$$$$ +C80041 + OpenBabel04062119382D + + 11 11 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 8 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 9 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 +M END +$$$$ +C80042 + OpenBabel04062119382D + + 12 12 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 2 0 0 0 0 + 1 3 1 0 0 0 0 + 1 7 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 8 1 0 0 0 0 + 3 5 2 0 0 0 0 + 3 9 1 0 0 0 0 + 4 6 2 0 0 0 0 + 4 10 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 11 1 0 0 0 0 + 6 12 1 0 0 0 0 +M END +$$$$ +C80043 + OpenBabel04062119382D + + 2 1 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 +M END +$$$$ +C80045 + OpenBabel04062119382D + + 2 1 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 +M END +$$$$ +C80046 + OpenBabel04062119382D + + 6 5 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 5 1 0 0 0 0 + 2 6 1 0 0 0 0 +M END +$$$$ +C80047 + OpenBabel04062119382D + + 3 2 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 2 3 1 0 0 0 0 +M END +$$$$ +C80048 + OpenBabel04062119382D + + 4 3 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 +M END +$$$$ +C80049 + OpenBabel04062119382D + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 +M END +$$$$ +C80050 + OpenBabel04062119382D + + 4 3 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 4 1 0 0 0 0 +M END +$$$$ +C80051 + OpenBabel04062119382D + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 +M END +$$$$ +C80052 + OpenBabel04062119382D + + 5 4 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 +M END +$$$$ +C80053 + OpenBabel04062119382D + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 5 1 0 0 0 0 + 4 5 1 0 0 0 0 +M END +$$$$ +C80054 + OpenBabel04062119382D + + 6 5 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 Cl 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 2 3 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 + 5 6 1 0 0 0 0 +M END +$$$$ +C80055 + OpenBabel04062119382D + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 4 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 4 1 0 0 0 0 + 4 5 1 0 0 0 0 +M CHG 1 4 1 +M END +$$$$ +C80056 + OpenBabel04062119382D + + 14 13 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 14 1 0 0 0 0 + 7 10 1 0 0 0 0 + 7 14 1 0 0 0 0 + 8 13 1 0 0 0 0 + 9 11 2 0 0 0 0 + 9 12 1 0 0 0 0 +M END +$$$$ +C80057 + OpenBabel04062119382D + + 44 48 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 3 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 1 10 1 0 0 0 0 + 2 3 2 0 0 0 0 + 2 4 1 0 0 0 0 + 3 11 1 0 0 0 0 + 4 27 2 0 0 0 0 + 5 11 2 0 0 0 0 + 5 27 1 0 0 0 0 + 6 12 1 0 0 0 0 + 6 38 1 0 0 0 0 + 7 13 1 0 0 0 0 + 7 39 1 0 0 0 0 + 8 24 2 0 0 0 0 + 8 25 1 0 0 0 0 + 9 26 2 0 0 0 0 + 9 28 1 0 0 0 0 + 10 11 1 0 0 0 0 + 10 29 2 0 0 0 0 + 12 15 1 0 0 0 0 + 12 40 1 0 0 0 0 + 13 16 1 0 0 0 0 + 13 41 1 0 0 0 0 + 14 19 2 0 0 0 0 + 14 20 1 0 0 0 0 + 14 26 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 30 1 0 0 0 0 + 16 18 1 0 0 0 0 + 16 31 1 0 0 0 0 + 17 21 1 0 0 0 0 + 17 32 1 0 0 0 0 + 18 22 1 0 0 0 0 + 18 33 1 0 0 0 0 + 19 23 1 0 0 0 0 + 19 24 1 0 0 0 0 + 20 25 2 0 0 0 0 + 20 28 1 0 0 0 0 + 21 27 1 0 0 0 0 + 21 40 1 0 0 0 0 + 22 28 1 0 0 0 0 + 22 41 1 0 0 0 0 + 34 43 2 0 0 0 0 + 35 43 1 0 0 0 0 + 36 44 2 0 0 0 0 + 37 44 1 0 0 0 0 + 38 43 1 0 0 0 0 + 39 44 1 0 0 0 0 + 42 43 1 0 0 0 0 + 42 44 1 0 0 0 0 +M CHG 1 27 1 +M END +$$$$ +C80058 + OpenBabel04062119382D + + 44 48 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 3 0 0 0 0 0 0 0 0 0 + 1 10 1 0 0 0 0 + 2 3 1 1 0 0 0 + 2 4 2 0 0 0 0 + 3 11 1 1 0 0 0 + 4 27 1 1 0 0 0 + 5 11 2 0 0 0 0 + 5 27 1 1 0 0 0 + 6 12 1 0 0 0 0 + 6 38 1 0 0 0 0 + 7 13 1 0 0 0 0 + 7 39 1 0 0 0 0 + 8 24 2 0 0 0 0 + 8 25 1 0 0 0 0 + 9 26 2 0 0 0 0 + 9 28 1 0 0 0 0 + 10 11 1 6 0 0 0 + 10 29 2 0 0 0 0 + 12 15 1 0 0 0 0 + 12 40 1 0 0 0 0 + 13 16 1 0 0 0 0 + 13 41 1 0 0 0 0 + 14 19 2 0 0 0 0 + 14 20 1 0 0 0 0 + 14 26 1 0 0 0 0 + 15 17 1 0 0 0 0 + 15 30 1 0 0 0 0 + 16 18 1 0 0 0 0 + 16 31 1 0 0 0 0 + 17 21 1 0 0 0 0 + 17 32 1 0 0 0 0 + 18 22 1 0 0 0 0 + 18 33 1 0 0 0 0 + 19 23 1 0 0 0 0 + 19 24 1 0 0 0 0 + 20 25 2 0 0 0 0 + 20 28 1 0 0 0 0 + 21 27 1 0 0 0 0 + 21 40 1 0 0 0 0 + 22 28 1 0 0 0 0 + 22 41 1 0 0 0 0 + 34 43 1 0 0 0 0 + 35 43 2 0 0 0 0 + 36 44 1 0 0 0 0 + 37 44 2 0 0 0 0 + 38 43 1 0 0 0 0 + 39 44 1 0 0 0 0 + 42 43 1 0 0 0 0 + 42 44 1 0 0 0 0 +M END +$$$$ +C80061 + OpenBabel04062119382D + + 5 4 0 0 0 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 4 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 5 2 0 0 0 0 +M END +$$$$ +C80062 + OpenBabel04062119382D + + 10 9 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 6 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 7 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 5 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 10 2 0 0 0 0 +M END +$$$$ +C80063 + OpenBabel04062119382D + + 18 17 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 15 1 0 0 0 0 + 2 4 1 0 0 0 0 + 2 16 1 0 0 0 0 + 3 5 1 0 0 0 0 + 3 6 1 0 0 0 0 + 4 5 1 0 0 0 0 + 4 7 1 0 0 0 0 + 5 8 2 0 0 0 0 + 9 17 1 0 0 0 0 + 10 17 1 0 0 0 0 + 11 17 2 0 0 0 0 + 12 18 1 0 0 0 0 + 13 18 1 0 0 0 0 + 14 18 2 0 0 0 0 + 15 17 1 0 0 0 0 + 16 18 1 0 0 0 0 +M END +$$$$ +C80064 + OpenBabel04062119382D + + 13 12 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 7 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 8 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 9 1 0 0 0 0 + 4 6 1 0 0 0 0 + 4 10 2 0 0 0 0 + 5 6 1 0 0 0 0 + 5 11 2 0 0 0 0 + 5 12 1 0 0 0 0 + 6 13 1 0 0 0 0 +M END +$$$$ +C80065 + OpenBabel04062119382D + + 21 20 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 1 3 1 0 0 0 0 + 1 18 1 0 0 0 0 + 2 6 1 0 0 0 0 + 2 19 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 7 1 0 0 0 0 + 4 6 1 0 0 0 0 + 4 8 2 0 0 0 0 + 5 6 1 0 0 0 0 + 5 9 2 0 0 0 0 + 5 10 1 0 0 0 0 + 6 11 1 0 0 0 0 + 12 20 1 0 0 0 0 + 13 20 1 0 0 0 0 + 14 20 2 0 0 0 0 + 15 21 1 0 0 0 0 + 16 21 1 0 0 0 0 + 17 21 2 0 0 0 0 + 18 20 1 0 0 0 0 + 19 21 1 0 0 0 0 +M END +$$$$ +C80066 + OpenBabel04062119382D + + 11 10 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 P 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 4 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 5 1 0 0 0 0 + 3 6 2 0 0 0 0 + 3 10 1 0 0 0 0 + 7 11 1 0 0 0 0 + 8 11 1 0 0 0 0 + 9 11 2 0 0 0 0 + 10 11 1 0 0 0 0 +M END +$$$$ +C80068 + OpenBabel04062119382D + + 17 16 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 9 1 0 0 0 0 + 2 3 1 0 0 0 0 + 2 10 1 0 0 0 0 + 3 4 1 0 0 0 0 + 3 11 1 0 0 0 0 + 4 5 1 0 0 0 0 + 4 12 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 13 1 0 0 0 0 + 6 7 1 0 0 0 0 + 6 14 1 0 0 0 0 + 7 8 1 0 0 0 0 + 7 15 1 0 0 0 0 + 8 16 2 0 0 0 0 + 8 17 1 0 0 0 0 +M END +$$$$ +C80069 + OpenBabel04062119382D + + 14 13 0 0 1 0 0 0 0 0999 V2000 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 3 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0000 0.0000 0.0000 S 0 0 0 0 0 0 0 0 0 0 0 0 + 1 2 1 0 0 0 0 + 1 3 1 0 0 0 0 + 2 4 1 0 0 0 0 + 3 8 1 0 0 0 0 + 4 9 1 0 0 0 0 + 5 6 1 0 0 0 0 + 5 8 1 0 0 0 0 + 6 14 1 0 0 0 0 + 7 10 1 0 0 0 0 + 7 14 1 0 0 0 0 + 8 13 1 0 0 0 0 + 9 11 2 0 0 0 0 + 9 12 1 0 0 0 0 +M END diff --git a/src/analysis/thermo/componentContribution/data/redox.tsv b/src/analysis/thermo/trainingModel/data/redox.tsv similarity index 100% rename from src/analysis/thermo/componentContribution/data/redox.tsv rename to src/analysis/thermo/trainingModel/data/redox.tsv diff --git a/src/analysis/thermo/componentContribution/new/checkForMissingStereo.m b/src/analysis/thermo/trainingModel/new/checkForMissingStereo.m similarity index 100% rename from src/analysis/thermo/componentContribution/new/checkForMissingStereo.m rename to src/analysis/thermo/trainingModel/new/checkForMissingStereo.m diff --git a/src/analysis/thermo/componentContribution/new/updateTrainingModel.m b/src/analysis/thermo/trainingModel/new/createTrainingModel.m similarity index 66% rename from src/analysis/thermo/componentContribution/new/updateTrainingModel.m rename to src/analysis/thermo/trainingModel/new/createTrainingModel.m index f7ab779e87..45b84b74ae 100644 --- a/src/analysis/thermo/componentContribution/new/updateTrainingModel.m +++ b/src/analysis/thermo/trainingModel/new/createTrainingModel.m @@ -1,4 +1,4 @@ -function trainingModel = updateTrainingModel(trainingModel,trainingMolFileDir,forceMolReplacement,printLevel) +function trainingModel = createTrainingModel(trainingModel,trainingMolFileDir,forceMolReplacement,printLevel) % create the training model, or update it with additional data % % OPTIONAL INPUTS: @@ -26,10 +26,10 @@ % * .compositeInchiBool m x 1 true if inchi is composite -fullpath = which('updateTrainingModel.m'); -fullpath = regexprep(fullpath,'updateTrainingModel.m',''); +fullpath = which('Transform.m'); +fullpath = regexprep(fullpath,'Transform.m',''); if ~exist('molFileDir','var') || isempty(trainingMolFileDir) - trainingMolFileDir = [fullpath 'mol/']; + trainingMolFileDir = [fullpath 'data' filesep 'mol' filesep]; end if ~exist('forceMolReplacement','var') @@ -39,32 +39,11 @@ if isempty(trainingModel) trainingModel = loadTrainingData; cid = trainingModel.cids; + %convert numeric compound ids to proper KEGG compound ids if isnumeric(cid) eval(['cid = {' regexprep(sprintf('''C%05d''; ',cid),'(;\s)$','') '};']); end trainingModel.cids = cid; -% if ~iscell(trainingModel.cids) -% for i=1:length(trainingModel.cids) -% if 1 -% eval(['trainingModel.cids = {' regexprep(sprintf('''C%05d''; ',trainingModel.cids),'(;\s)$','') '};']); -% else -% switch length(num2str(trainingModel.cids(i))) -% case 1 -% trainingModel.mets{i,1} = ['C0000' num2str(trainingModel.cids(i))]; -% case 2 -% trainingModel.mets{i,1} = ['C000' num2str(trainingModel.cids(i))]; -% case 3 -% trainingModel.mets{i,1} = ['C00' num2str(trainingModel.cids(i))]; -% case 4 -% trainingModel.mets{i,1} = ['C0' num2str(trainingModel.cids(i))]; -% case 5 -% trainingModel.mets{i,1} = ['C' num2str(trainingModel.cids(i))]; -% otherwise -% trainingModel.mets{i,1} = ['C' num2str(trainingModel.cids(i))]; -% end -% end -% end -% end trainingModel.mets = trainingModel.cids; trainingModel.metKEGGID = trainingModel.cids; end @@ -102,23 +81,27 @@ added_inchis = filecols{1}; %convert the inchi into mol files - [success,result] = system([babel_cmd ' -iinchi ' KEGG_ADDITIONS_INCHI_FNAME ' -omol -O ' fullpath 'mol' filesep 'tmp.sdf -an']); + [success,result] = system([babel_cmd ' -iinchi ' KEGG_ADDITIONS_INCHI_FNAME ' -omol -O ' fullpath 'data' filesep 'mol' filesep 'tmp.sdf -an']); %split the sdf into multiple mol files - [success,result] = system([babel_cmd ' ' fullpath 'mol' filesep 'tmp.sdf -O ' fullpath 'mol' filesep 'new.mol -m']); + [success,result] = system([babel_cmd ' ' fullpath 'data' filesep 'mol' filesep 'tmp.sdf -O ' fullpath 'data' filesep 'mol' filesep 'new.mol -m']); %rename the files according to the CID for i=1:length(added_cids) - [success,result] = system(['mv ' fullpath 'mol' filesep 'new' int2str(i) '.mol ' fullpath 'mol' filesep added_cids{i} '.mol']); + [success,result] = system(['mv ' fullpath 'data' filesep 'mol' filesep 'new' int2str(i) '.mol ' fullpath 'data' filesep 'mol' filesep added_cids{i} '.mol']); end - [mol,success] = urlread('https://www.genome.jp/dbget-bin/www_bget?-f+m+compound+C00080'); - fid = fopen([fullpath 'mol' filesep 'C00080.mol'],'w+'); - fprintf(fid,'%s',mol); - fclose(fid); + if ~exist([fullpath 'data' filesep 'mol' filesep 'C00080.mol'],'file') + [mol,success] = urlread('https://www.genome.jp/dbget-bin/www_bget?-f+m+compound+C00080'); + fid = fopen([fullpath 'data' filesep 'mol' filesep 'C00080.mol'],'w+'); + fprintf(fid,'%s',mol); + fclose(fid); + end - [mol,success] = urlread('https://www.genome.jp/dbget-bin/www_bget?-f+m+compound+C02780'); - fid = fopen([fullpath 'mol' filesep 'C02780.mol'],'w+'); - fprintf(fid,'%s',mol); - fclose(fid); + if ~exist([fullpath 'data' filesep 'mol' filesep 'C02780.mol'],'file') + [mol,success] = urlread('https://www.genome.jp/dbget-bin/www_bget?-f+m+compound+C02780'); + fid = fopen([fullpath 'data' filesep 'mol' filesep 'C02780.mol'],'w+'); + fprintf(fid,'%s',mol); + fclose(fid); + end end % Retreive molfiles from KEGG if KEGG ID are given. @@ -126,7 +109,7 @@ takeMajorMS = true; % Convert molfile from KEGG to major tautomer of major microspecies at pH 7 pH = 7; takeMajorTaut = true; - kegg2mol(trainingModel.metKEGGID,[fullpath trainingMolFileDir],trainingModel.mets,takeMajorMS,pH,takeMajorTaut,forceMolReplacement); % Retreive mol files + kegg2mol(trainingModel.metKEGGID,trainingMolFileDir,trainingModel.mets,takeMajorMS,pH,takeMajorTaut,forceMolReplacement); % Retreive mol files end if ~isfield(trainingModel,'inchi') @@ -157,16 +140,19 @@ %% Estimate metabolite pKa values with ChemAxon calculator plugins and determine all relevant pseudoisomers. if printLevel>0 -fprintf('Estimating metabolite pKa values for training trainingModel.\n'); +fprintf('\nEstimating metabolite pKa values for training trainingModel...\n'); end if ~isfield(trainingModel,'pseudoisomers') npKas = 20; takeMajorTaut=1; - [pseudoisomers,errorMets] = estimate_pKa(trainingModel.mets, trainingModel.inchi.nonstandard, npKas, takeMajorTaut, printLevel); - fprintf('Training model metabolites with errors while estimating pKa values.\n'); - disp(errorMets) + [pseudoisomers,errorMets] = estimate_pKa(trainingModel.mets, trainingModel.inchi.nonstandard, npKas, takeMajorTaut, printLevel-1); + if ~isempty(errorMets) + fprintf('Training model metabolites with errors while estimating pKa values:\n'); + disp(errorMets) + end trainingModel.pseudoisomers = pseudoisomers; end +fprintf('\n ...done. \n') if ~isfield(trainingModel,'rxns') for i=1:nRxn @@ -177,5 +163,5 @@ trainingModel.lb=ones(size(trainingModel.S,2),1)*-inf; end if ~isfield(trainingModel,'ub') - trainingModel.lb=ones(size(trainingModel.S,2),1)*inf; + trainingModel.ub=ones(size(trainingModel.S,2),1)*inf; end diff --git a/src/analysis/thermo/trainingModel/new/driver_addChemoinfoToTrainingModel.m b/src/analysis/thermo/trainingModel/new/driver_addChemoinfoToTrainingModel.m new file mode 100644 index 0000000000..1ca6d6317e --- /dev/null +++ b/src/analysis/thermo/trainingModel/new/driver_addChemoinfoToTrainingModel.m @@ -0,0 +1,43 @@ +% Generate database + +% Clear workspace +clear + +% Load training data +load('~/work/sbgCloud/programExperimental/projects/xomics/data/thermoChemicalTrainingModel/trainingModel.mat'); + +%% Prepare user-defined parameters + +currentDirectory = pwd; +options.printlevel = 1; +options.debug = true; +options.standardisationApproach = 'explicitH'; +options.adjustToModelpH = false; +options.keepMolComparison = false; +options.onlyUnmapped = true; + +%% Function generateChemicalDatabase + +dbType = {'inchi'; 'kegg'; 'best'}; + +for i = 1:size(dbType, 1) + switch dbType{i} + case 'kegg' + model = trainingModel; + model = rmfield(model, {'inchi', 'inchiBool', 'compositeInchiBool'}); + options.outputDir = [currentDirectory filesep dbType{i}]; + info = generateChemicalDatabase(model, options); + case 'inchi' + model = trainingModel; + model.Inchi = model.inchi.standardWithStereoAndCharge; + model = rmfield(model, {'metKEGGID', 'inchiBool', 'compositeInchiBool', 'inchi'}); + options.outputDir = [currentDirectory filesep dbType{i}]; + info = generateChemicalDatabase(model, options); + case 'best' + model = trainingModel; + model.Inchi = model.inchi.standardWithStereoAndCharge; + model = rmfield(model, {'inchiBool', 'compositeInchiBool', 'inchi'}); + options.outputDir = [currentDirectory filesep dbType{i}]; + info = generateChemicalDatabase(model, options); + end +end diff --git a/src/analysis/thermo/trainingModel/new/driver_addChemoinfoToTrainingModel.mlx b/src/analysis/thermo/trainingModel/new/driver_addChemoinfoToTrainingModel.mlx new file mode 100644 index 0000000000..8be279a5f9 Binary files /dev/null and b/src/analysis/thermo/trainingModel/new/driver_addChemoinfoToTrainingModel.mlx differ diff --git a/src/analysis/thermo/trainingModel/new/driver_createTrainingModel.mlx b/src/analysis/thermo/trainingModel/new/driver_createTrainingModel.mlx new file mode 100644 index 0000000000..b52ca5ad20 Binary files /dev/null and b/src/analysis/thermo/trainingModel/new/driver_createTrainingModel.mlx differ diff --git a/src/analysis/thermo/componentContribution/new/getInchies.m b/src/analysis/thermo/trainingModel/new/getInchies.m similarity index 100% rename from src/analysis/thermo/componentContribution/new/getInchies.m rename to src/analysis/thermo/trainingModel/new/getInchies.m diff --git a/src/analysis/thermo/componentContribution/new/getKeggpKas.m b/src/analysis/thermo/trainingModel/new/getKeggpKas.m similarity index 100% rename from src/analysis/thermo/componentContribution/new/getKeggpKas.m rename to src/analysis/thermo/trainingModel/new/getKeggpKas.m diff --git a/src/analysis/thermo/componentContribution/new/loadTrainingData.m b/src/analysis/thermo/trainingModel/new/loadTrainingData.m similarity index 73% rename from src/analysis/thermo/componentContribution/new/loadTrainingData.m rename to src/analysis/thermo/trainingModel/new/loadTrainingData.m index 520b542546..e7c2a34585 100644 --- a/src/analysis/thermo/componentContribution/new/loadTrainingData.m +++ b/src/analysis/thermo/trainingModel/new/loadTrainingData.m @@ -1,17 +1,17 @@ -function training_data = loadTrainingData(param) +function trainingModel = loadTrainingData(param) % Generates the structure that contains all the training data needed for % Component Contribution. % % USAGE: % -% training_data = loadTrainingData(formation_weight) +% trainingModel = loadTrainingData(formation_weight) % % INPUT: % formation_weight: the relative weight to give the formation energies (Alberty's data) % compared to the reaction measurements (TECRDB) % % OUTPUT: -% training_data: structure with data for Component Contribution +% trainingModel: structure with data for Component Contribution % *.S `m x n` stoichiometric matrix of training data % *.cids: `m x 1` compound ids % *.dG0_prime: `n x 1` @@ -72,6 +72,7 @@ % Read the raw data of TECRDB (NIST) reactions = {}; +rxns={}; cids = []; cids_that_dont_decompose = []; thermo_params = []; % columns are: dG'0, T, I, pH, pMg, weight, balance? @@ -79,22 +80,23 @@ fid = fopen(TECRDB_TSV_FNAME, 'r'); % fields are: -% URL -% REF_ID -% METHOD -% EVAL -% EC -% ENZYME NAME -% REACTION IN KEGG IDS -% REACTION IN COMPOUND NAMES -% K -% K' -% T -% I -% pH -% pMg - -res = textscan(fid, '%s%s%s%s%s%s%s%s%f%f%f%f%f%f', 'delimiter','\t'); +% 1. URL +% 2. REF_ID +% 3. METHOD +% 4. EVAL +% 5. EC +% 6. ENZYME NAME +% 7. REACTION IN KEGG IDS +% 8. REACTION IN COMPOUND NAMES +% 9. K +% 10. K' +% 11. T +% 12. I +% 13. pH +% 14. pMg +% 15. ID + +res = textscan(fid, '%s%s%s%s%s%s%s%s%f%f%f%f%f%f%f', 'delimiter','\t'); fclose(fid); inds = find(~isnan(res{10}) .* ~isnan(res{11}) .* ~isnan(res{13})); @@ -109,6 +111,7 @@ sprs = reaction2sparse(res{7}{inds(i)}); cids = unique([cids, find(sprs)]); reactions = [reactions, {sprs}]; + rxns = [rxns;strtrim(['TECRDB_' int2str(res{15}(inds(i)))])]; end fprintf('Successfully added %d values from TECRDB\n', length(inds)); @@ -116,16 +119,17 @@ fid = fopen(FORMATION_TSV_FNAME, 'r'); fgetl(fid); % skip the first header line % fields are: -% cid -% name -% dG'0 -% pH -% I -% pMg -% T -% decompose? -% compound_ref -% remark +% 1. cid +% 2. name +% 3. dG'0 +% 4. pH +% 5. I +% 6. pMg +% 7. T +% 8. decompose? +% 9. compound_ref +% 10. remark + res = textscan(fid, '%f%s%f%f%f%f%f%f%s%s', 'delimiter','\t'); fclose(fid); @@ -134,10 +138,13 @@ res{4}(inds), res{6}(inds), ... WEIGHT_FORMATION * ones(size(inds)), ... false(size(inds))]]; + +eval(['cid = {' regexprep(sprintf('''C%05d''; ',res{1}),'(;\s)$','') '};']); for i = 1:length(inds) sprs = sparse([]); sprs(res{1}(inds(i))) = 1; reactions = [reactions, {sprs}]; + rxns = [rxns;['FORM_' cid{i}]]; end cids = union(cids, res{1}'); @@ -150,19 +157,19 @@ fid = fopen(REDOX_TSV_FNAME, 'r'); fgetl(fid); % skip the first header line % fields are: -% name -% CID_ox -% nH_ox -% charge_ox -% CID_red -% nH_red, -% charge_red -% E'0 -% pH -% I -% pMg -% T -% ref +% 1. name +% 2. CID_ox +% 3. nH_ox +% 4. charge_ox +% 5. CID_red +% 6. nH_red, +% 7. charge_red +% 8. E'0 +% 9. pH +% 10. I +% 11. pMg +% 12. T +% 13. ref res = textscan(fid, '%s%f%f%f%f%f%f%f%f%f%f%f%s', 'delimiter', '\t'); fclose(fid); @@ -179,6 +186,7 @@ sprs(res{5}(i)) = 1; cids = unique([cids, res{2}(i), res{5}(i)]); reactions = [reactions, {sprs}]; + rxns = [rxns;['REDOX_' strrep(res{1}{i},' ','_')]]; end fprintf('Successfully added %d redox potentials\n', length(res{1})); @@ -192,29 +200,30 @@ S(ismember(cids, find(r)), i) = r(r ~= 0); end -training_data.S = sparse(S); +trainingModel.S = sparse(S); -if ~isfield(training_data,'rxns') - for i=1:size(training_data.S,2) - training_data.rxns{i,1}=['rxn' int2str(i)]; +if ~isfield(trainingModel,'rxns') + for i=1:size(trainingModel.S,2) + trainingModel.rxns{i,1}=['rxn' int2str(i)]; end end -if ~isfield(training_data,'lb') - training_data.lb=ones(size(training_data.S,2),1)*-inf; +if ~isfield(trainingModel,'lb') + trainingModel.lb=ones(size(trainingModel.S,2),1)*-inf; end -if ~isfield(training_data,'ub') - training_data.lb=ones(size(training_data.S,2),1)*inf; +if ~isfield(trainingModel,'ub') + trainingModel.lb=ones(size(trainingModel.S,2),1)*inf; end -training_data.cids = cids'; -training_data.dG0_prime = thermo_params(:, 1); -training_data.T = thermo_params(:, 2); -training_data.I = thermo_params(:, 3); -training_data.pH = thermo_params(:, 4); -training_data.pMg = thermo_params(:, 5); -training_data.weights = thermo_params(:, 6); -training_data.balance = thermo_params(:, 7); -training_data.cids_that_dont_decompose = cids_that_dont_decompose; +trainingModel.rxns = rxns; +trainingModel.cids = cids'; +trainingModel.dG0_prime = thermo_params(:, 1); +trainingModel.T = thermo_params(:, 2); +trainingModel.I = thermo_params(:, 3); +trainingModel.pH = thermo_params(:, 4); +trainingModel.pMg = thermo_params(:, 5); +trainingModel.weights = thermo_params(:, 6); +trainingModel.balance = thermo_params(:, 7); +trainingModel.cids_that_dont_decompose = cids_that_dont_decompose; diff --git a/src/analysis/thermo/componentContribution/new/prepareTrainingData.m b/src/analysis/thermo/trainingModel/new/prepareTrainingData.m similarity index 100% rename from src/analysis/thermo/componentContribution/new/prepareTrainingData.m rename to src/analysis/thermo/trainingModel/new/prepareTrainingData.m diff --git a/src/analysis/thermo/componentContribution/new/reverseTransformTrainingData.m b/src/analysis/thermo/trainingModel/new/reverseTransformTrainingData.m similarity index 73% rename from src/analysis/thermo/componentContribution/new/reverseTransformTrainingData.m rename to src/analysis/thermo/trainingModel/new/reverseTransformTrainingData.m index 40d6cc335c..96ccebdc36 100644 --- a/src/analysis/thermo/componentContribution/new/reverseTransformTrainingData.m +++ b/src/analysis/thermo/trainingModel/new/reverseTransformTrainingData.m @@ -1,5 +1,16 @@ -function trainingModel = reverseTransformTrainingData(model, trainingModel, use_model_pKas_by_default) +function trainingModel = reverseTransformTrainingData(trainingModel, use_model_pKas_by_default,model) % Calculate the reverse transform for all reactions in trainingModel. +% +% INPUT +% trainingModel +% +% OPTIONAL INPUT +% use_model_pKas_by_default +% model + +if ~exist('use_model_pKas_by_default','var') + use_model_pKas_by_default=0; +end R = 8.31e-3; % kJ/mol/K @@ -31,14 +42,13 @@ end end - model_id = find(trainingModel.Model2TrainingMap == inds(j), 1); - if ~isempty(model_id) - model_diss = model.pseudoisomers(model_id); - else - model_diss.success = false; - end - if use_model_pKas_by_default + model_id = find(trainingModel.Model2TrainingMap == inds(j), 1); + if ~isempty(model_id) + model_diss = model.pseudoisomers(model_id); + else + model_diss.success = false; + end if model_diss.success diss = model_diss; else @@ -48,6 +58,12 @@ if ~isempty(training_diss) diss = training_diss; else + model_id = find(trainingModel.Model2TrainingMap == inds(j), 1); + if ~isempty(model_id) + model_diss = model.pseudoisomers(model_id); + else + model_diss.success = false; + end diss = model_diss; end end diff --git a/src/analysis/thermo/componentContribution/old/balanceReactionsInTrainingData.m b/src/analysis/thermo/trainingModel/old/balanceReactionsInTrainingData.m similarity index 100% rename from src/analysis/thermo/componentContribution/old/balanceReactionsInTrainingData.m rename to src/analysis/thermo/trainingModel/old/balanceReactionsInTrainingData.m diff --git a/src/analysis/thermo/componentContribution/old/checkForMissingStereo.m b/src/analysis/thermo/trainingModel/old/checkForMissingStereo.m similarity index 100% rename from src/analysis/thermo/componentContribution/old/checkForMissingStereo.m rename to src/analysis/thermo/trainingModel/old/checkForMissingStereo.m diff --git a/src/analysis/thermo/componentContribution/old/getInchies.m b/src/analysis/thermo/trainingModel/old/getInchies.m similarity index 100% rename from src/analysis/thermo/componentContribution/old/getInchies.m rename to src/analysis/thermo/trainingModel/old/getInchies.m diff --git a/src/analysis/thermo/componentContribution/old/getKeggpKas.m b/src/analysis/thermo/trainingModel/old/getKeggpKas.m similarity index 100% rename from src/analysis/thermo/componentContribution/old/getKeggpKas.m rename to src/analysis/thermo/trainingModel/old/getKeggpKas.m diff --git a/src/analysis/thermo/componentContribution/old/getTrainingDatapKas.m b/src/analysis/thermo/trainingModel/old/getTrainingDatapKas.m similarity index 100% rename from src/analysis/thermo/componentContribution/old/getTrainingDatapKas.m rename to src/analysis/thermo/trainingModel/old/getTrainingDatapKas.m diff --git a/src/analysis/thermo/componentContribution/old/loadTrainingData.m b/src/analysis/thermo/trainingModel/old/loadTrainingData.m similarity index 100% rename from src/analysis/thermo/componentContribution/old/loadTrainingData.m rename to src/analysis/thermo/trainingModel/old/loadTrainingData.m diff --git a/src/analysis/thermo/componentContribution/old/prepareTrainingData.m b/src/analysis/thermo/trainingModel/old/prepareTrainingData.m similarity index 100% rename from src/analysis/thermo/componentContribution/old/prepareTrainingData.m rename to src/analysis/thermo/trainingModel/old/prepareTrainingData.m diff --git a/src/analysis/thermo/componentContribution/old/reverseTransformTrainingData.m b/src/analysis/thermo/trainingModel/old/reverseTransformTrainingData.m similarity index 100% rename from src/analysis/thermo/componentContribution/old/reverseTransformTrainingData.m rename to src/analysis/thermo/trainingModel/old/reverseTransformTrainingData.m diff --git a/src/base/io/python/condalab/.gitignore b/src/base/io/python/condalab/.gitignore new file mode 100644 index 0000000000..a73aa92825 --- /dev/null +++ b/src/base/io/python/condalab/.gitignore @@ -0,0 +1,2 @@ +*DS_Store +*sublime-workspace diff --git a/src/base/io/python/condalab/README.md b/src/base/io/python/condalab/README.md new file mode 100644 index 0000000000..080bfa085a --- /dev/null +++ b/src/base/io/python/condalab/README.md @@ -0,0 +1,49 @@ +# condalab + +Handy MATLAB utility to switch between conda environments **from within MATLAB** + +## Installation + +1. Grab this repo. Chuck it somewhere on your path. +2. Determine where your base `conda` installation by opening a terminal and typing `which conda`. Make a note of that path. +3. Type `conda.init` in your MATLAB terminal. It should prompt you for the path you got in step 2. + + +## Usage + +`condalab` works exactly like `conda`. + +So if you want to list the environments you have, you can use + + +``` +% yes, type this in your matlab prompt +conda env list + +base /Users/srinivas/anaconda3 +*umap /Users/srinivas/anaconda3/envs/umap + +``` + +and the `*` indicates the currently active environment. + +To switch environments, use + +``` +% yes, type this in your matlab prompt +conda activate umap +``` + +To check that everything worked, you can run + +``` +conda.test + +The python executable I am using is located at: +/Users/srinivas/anaconda3/envs/umap/bin/python +``` + +and you see that it is using the right environment. + + +It's that simple. Enjoy. diff --git a/src/base/io/python/condalab/conda.m b/src/base/io/python/condalab/conda.m new file mode 100644 index 0000000000..2ee9d3ec5e --- /dev/null +++ b/src/base/io/python/condalab/conda.m @@ -0,0 +1,197 @@ +% conda.m +% a simple MATLAB utility to control conda +% environments on *nix systems +% +% usage +% +% MATLAB Shell +% =================================== +% conda.getenv conda env list +% conda.setenv(env) source activate env +% +% Srinivas Gorur-Shandilya + +classdef conda + + +properties +end + +methods + +end + +methods (Static) + + + + function varargout = conda(varargin) + + varargout = {}; + + if nargin == 2 + if strcmp(varargin{1},'env') && strcmp(varargin{2},'list') + conda.getenv(); + return + elseif strcmp(varargin{1},'activate') + conda.setenv(varargin{2}) + return + else + error('Unknown argument syntax') + end + else + error('Unknown argument syntax') + end + + end + + + function init() + + try + getpref('condalab','base_path'); + catch + str = input('Enter the path to your conda installation: \n','s'); + str = strrep(str,[filesep 'conda'],''); + setpref('condalab','base_path',str) + end + + + + conda.addBaseCondaPath() + + end + + + function addBaseCondaPath() + + try + condalab_base_path = getpref('condalab','base_path'); + catch + conda.init() + condalab_base_path = getpref('condalab','base_path'); + end + + + + [e,o]=system('which conda'); + if e == 0 + % conda is somewhere on the path, so do nothing + return + end + + P = strsplit(getenv('PATH'),pathsep); + add_to_path = true; + for i = 1:length(P) + if strcmp(P{i},condalab_base_path) + add_to_path = false; + end + end + if add_to_path + setenv('PATH',[condalab_base_path pathsep getenv('PATH') ]); + end + + + + end + + function varargout = getenv() + conda.addBaseCondaPath; + [~,envs] = system('conda env list'); + envs = strsplit(envs,'\n'); + + p = strsplit(getenv('PATH'),pathsep); + + % remove the asterix because it always is on root + for i = length(envs):-1:1 + envs{i} = strrep(envs{i},'*',' '); + if isempty(envs{i}) + continue + end + if strcmp(envs{i}(1),'#') + continue + end + + this_env = strsplit(envs{i}); + env_names{i} = this_env{1}; + env_paths{i} = this_env{2}; + + + active_path = 0; + for j = 1:length(env_paths) + this_env_path = [env_paths{j} filesep 'bin']; + if any(strcmp(this_env_path,p)) + active_path = j; + end + end + + end + + if nargout + varargout{1} = env_names; + varargout{2} = env_paths; + varargout{3} = active_path; + else + fprintf('\n') + for i = 1:length(env_names) + if isempty(env_names{i}) + continue + end + if active_path == i + disp(['*' env_names{i} ' ' env_paths{i}]) + else + disp([env_names{i} ' ' env_paths{i}]) + end + end + end + end % end getenv + + function setenv(env) + conda.addBaseCondaPath; + [~,envs] = system(['conda env list']); + envs = strsplit(envs,'\n'); + + [env_names, env_paths] = conda.getenv; + + % check that envs exists in the list + assert(any(strcmp(env_names,env)), 'env you want to activate is not valid') + + + p = getenv('PATH'); + % delete every conda env path from the path + p = strsplit(p,pathsep); + rm_this = false(length(p),1); + for i = 1:length(p) + % remove "bin" from the end + this_path = strtrim(strrep(p{i}, [filesep 'bin'],'')); + if any(strcmp(this_path,env_paths)) + rm_this(i) = true; + end + end + p(rm_this) = []; + + % add the path of the env we want to switch to + this_env_path = [env_paths{strcmp(env_names,env)} filesep 'bin']; + p = [this_env_path p]; + p = strjoin(p,pathsep); + + % append the base path to this, because apparently + % conda decides to change everything every 2 months + p = [p pathsep getpref('condalab','base_path')]; + + setenv('PATH', p); + + end % setenv + + + % asks the python interpreter where it is located + function test() + system(['python ' fileparts(which(mfilename)) filesep 'test.py']); + end + + +end + + + +end % end classdef \ No newline at end of file diff --git a/src/base/io/python/condalab/condalab.sublime-project b/src/base/io/python/condalab/condalab.sublime-project new file mode 100644 index 0000000000..9452cc4d3c --- /dev/null +++ b/src/base/io/python/condalab/condalab.sublime-project @@ -0,0 +1,17 @@ +{ + "build_systems": + [ + { + "file_regex": "^[ ]*File \"(...*?)\", line ([0-9]*)", + "name": "Anaconda Python Builder", + "selector": "source.python", + "shell_cmd": "\"python\" -u \"$file\"" + } + ], + "folders": + [ + { + "path": "." + } + ] +} diff --git a/src/base/io/python/condalab/test.py b/src/base/io/python/condalab/test.py new file mode 100644 index 0000000000..07440a99f5 --- /dev/null +++ b/src/base/io/python/condalab/test.py @@ -0,0 +1,4 @@ + +import sys +print("The python executable I am using is located at:") +print(sys.executable) \ No newline at end of file diff --git a/src/base/io/python/initPythonEnvironment.m b/src/base/io/python/initPythonEnvironment.m new file mode 100644 index 0000000000..35c378e3e6 --- /dev/null +++ b/src/base/io/python/initPythonEnvironment.m @@ -0,0 +1,213 @@ +function [pyEnvironment,pySearchPath]=initPythonEnvironment(environmentName,reset) +%initialise an interface to a Python environment using CPython3/2 or Anaconda +% +% OPTIONAL INPUT +% environmentName String denoting the Python environment to establish an interface to. +% Fixed options: 'CPython3' (default), 'CPython2', 'base' (Anaconda) +% Variable Anaconda options: environmentName as in anaconda3/env/environmentName +% See https://conda.io/projects/conda/en/latest/user-guide/tasks/manage-environments.html +% +% reset {(0),1}, reset with terminate(pyenv) if true +% +% OUTPUT +% pyEnvironment Python environment returned by pyenv +% pySearchPath Python search path (for loading packages) +% +% USAGE +% [pythonEnvironment,pythonPath]=initPythonEnvironment('base',1) +% or +% [pythonEnvironment,pythonPath]=initPythonEnvironment('CPython',1) + +% Author: Ronan M.T. Fleming 2021 + +if ~exist('environmentName','var') + environmentName = 'CPython3'; +end +if ~exist('reset','var') + reset = 0; +end + +%remove any preexisting Anaconda custom environment paths within matlab +matlab_PATH = getenv('PATH'); +matlab_PATH = split(matlab_PATH,':'); +matlab_PATH = matlab_PATH(~contains(matlab_PATH,{['anaconda3' filesep 'envs'],'$PATH'})); +matlab_PATH = join(matlab_PATH,':'); +setenv('PATH',matlab_PATH{1}); + +matlab_PATH = getenv('LD_LIBRARY_PATH'); +matlab_PATH = split(matlab_PATH,':'); +matlab_PATH = matlab_PATH(~contains(matlab_PATH,{['anaconda3' filesep 'envs'],'$LD_LIBRARY_PATH'}) | contains(matlab_PATH,{'condabin','$LD_LIBRARY_PATH'})); +matlab_PATH = join(matlab_PATH,':'); +setenv('LD_LIBRARY_PATH',matlab_PATH{1}); + +if reset + try + terminate(pyenv) + catch + warning('pyenv not initialised, no need to reset') + end + + +end + +switch environmentName + case 'CPython3' + [success,response]=system('which python3'); + case 'CPython2' + [success,response]=system('which python2'); + otherwise + %Anaconda + [successAnaconda,responseAnaconda]=system('which anaconda'); + if successAnaconda~=0 + error('Could not find anaconda on the matlab-system path') + end + [successAnaconda,responseAnaconda]=system('which conda'); + if successAnaconda~=0 + error('Could not find conda on the matlab-system path') + end + %conda env list + [env_names, env_paths,active_path] = conda.getenv;%from condalab + if ~any(contains(env_names(3:end),environmentName)) + disp([environmentName ' not a reconised anaconda environment.']) + disp('Recognised anaconda environments are:') + disp(env_names) + disp(['See https://conda.io/projects/conda/en/latest/user-guide/tasks/manage-environments.html']) + disp('Example of how to create a conda environment:') + disp('conda create -n dGPredictor python=3.8') + disp('conda install -n dGPredictor -c conda-forge rdkit') + disp('conda install -n dGPredictor -c conda-forge pandas') + disp('conda install -n dGPredictor -c conda-forge scikit-learn') + disp('conda install -n dGPredictor -c conda-forge streamlit') + disp('conda activate dGPredictor') + + + %conda install -n dGPredictor -c conda-forge future + %conda install -n dGPredictor -c conda-forge streamlit==0.55.2 + disp('Attempting to proceed with base anaconda environment') + environmentName='base'; + end + + if strcmp(env_names{active_path},environmentName) + disp([environmentName ' anaconda environment is already active.']) + else + conda.setenv(environmentName) + disp([environmentName ' anaconda environment activated.']) + end + %now get correct python path to the current environment + [success,response]=system('which python3'); +end +pythonExePath=strtrim(response); +if isempty(pythonExePath) + disp('Run the following command(s) in a terminal and then run initPythonEnvironment again:') + switch environmentName + case 'CPython3' + %Cpython + disp('sudo apt-get install python3 python3-all-dev') + case 'CPython2' + %Cpython + disp('sudo apt-get install python2 python2-all-dev') + otherwise + + end +end +if success~=0 + error('Could not find python with system command: which python*. Follow the instructions above.') +end + +switch environmentName + case 'CPython3' + % The reverence CPython installation version needs to be compatible with MATLAB + [success,response]=system('python3 --version'); + if ~(contains(response,'3.6') || contains(response,'3.7') || contains(response,'3.8')) + %MATLAB >=R2020b is compatible with python 2.7,3.6,3.7,3.8 + disp(response) + error('MATLAB >=R2020b is only stated to be compatible with Python 3.6,3.7,3.8') + end + + try + pyEnvironment = pyenv('ExecutionMode','OutOfProcess','Version',pythonExePath); + catch + %try to terminate Python environment if its allready loaded + terminate(pyenv) + %try to initialise Python environment + pyEnvironment = pyenv('ExecutionMode','OutOfProcess','Version',pythonExePath); + end + %Remove any paths from the matlab-python environment that are not in the system python environment to avoid dependency conflicts + % between the Anaconda environment and the python libraries provided by matlab + printLevel=0; + [common,system_not_matlab,matlab_not_system] = comparePaths('PYTHON',printLevel); + bool = contains(matlab_not_system,'interprocess/bin/glnxa64/pycli'); + %only remove the matlab added paths containing interprocess/bin/glnxa64/pycli + matlab_not_system=matlab_not_system(bool); + for i=1:length(matlab_not_system) + %new_py_path = py_rmpath('/usr/local/bin/MATLAB/R2021a/interprocess/bin/glnxa64/pycli', 0); + pySearchPath = py_rmpath(matlab_not_system{i}, 0); + end + case 'CPython2' + % The reverence CPython installation version needs to be compatible with MATLAB + [success,response]=system('python2 --version'); + if ~contains(response,'2.7') + %MATLAB >=R2020b is compatible with python 2.7,3.6,3.7,3.8 + disp(response) + error('MATLAB >=R2020b is only stated to be compatible with Python 2.7') + end + + try + pyEnvironment = pyenv('ExecutionMode','OutOfProcess','Version',pythonExePath); + catch + %try to terminate Python environment if its allready loaded + terminate(pyenv) + %try to initialise Python environment + pyEnvironment = pyenv('ExecutionMode','OutOfProcess','Version',pythonExePath); + end + %Remove any paths from the matlab-python environment that are not in the system python environment to avoid dependency conflicts + % between the Anaconda environment and the python libraries provided by matlab + printLevel=0; + [common,system_not_matlab,matlab_not_system] = comparePaths('PYTHON',printLevel); + bool = contains(matlab_not_system,'interprocess/bin/glnxa64/pycli'); + %only remove the matlab added paths containing interprocess/bin/glnxa64/pycli + matlab_not_system=matlab_not_system(bool); + for i=1:length(matlab_not_system) + %new_py_path = py_rmpath('/usr/local/bin/MATLAB/R2021a/interprocess/bin/glnxa64/pycli', 0); + pySearchPath = py_rmpath(matlab_not_system{i}, 0); + end + + otherwise + try + pyEnvironment = pyenv("ExecutionMode","OutOfProcess","Version", pythonExePath); + catch + %try to terminate Python environment if its allready loaded + terminate(pyenv) + %try to initialise Python environment + pyEnvironment = pyenv("ExecutionMode","OutOfProcess","Version", pythonExePath); + end + %Remove any paths from the matlab-python environment that are not in the system python environment to avoid dependency conflicts + % between the Anaconda environment and the python libraries provided by matlab + printLevel=0; + [common,system_not_matlab,matlab_not_system] = comparePaths('PYTHON',printLevel); + bool = contains(matlab_not_system,'interprocess/bin/glnxa64/pycli'); + %only remove the matlab added paths containing interprocess/bin/glnxa64/pycli + matlab_not_system=matlab_not_system(bool); + for i=1:length(matlab_not_system) + %new_py_path = py_rmpath('/usr/local/bin/MATLAB/R2021a/interprocess/bin/glnxa64/pycli', 0); + pySearchPath = py_rmpath(matlab_not_system{i}, 0); + end + + [success,anaconda_PATH]=system('which anaconda'); + anaconda_PATH=strtrim(anaconda_PATH); + anaconda_PATH=strrep(anaconda_PATH,'3/bin/anaconda','3'); + anacondaCustomEnv_PATH = [anaconda_PATH filesep 'env' environmentName filesep 'bin']; + matlab_PATH = getenv('PATH'); + setenv('PATH',[anacondaCustomEnv_PATH ':' matlab_PATH]); + + anacondaCustomEnv_LD_LIBRARY_PATH = [anaconda_PATH filesep 'envs' filesep environmentName filesep 'lib']; + matlab_LD_LIBRARY_PATH = getenv('LD_LIBRARY_PATH'); + setenv('LD_LIBRARY_PATH',[anacondaCustomEnv_LD_LIBRARY_PATH ':' matlab_LD_LIBRARY_PATH]); +end + +if ~isequal(pyEnvironment.ExecutionMode,'OutOfProcess') + error('dGPredictor requires Python to be called OutOfProcess\n','Restart MATLAB and run the following from the command line: \n', 'pyenv("ExecutionMode","OutOfProcess");') +end +if isequal(pyEnvironment.Library,'') + error('make sure to add python development libraries: sudo apt-get install python3-all-dev, then run init_dGPredictor again.') +end \ No newline at end of file diff --git a/src/base/io/python/pyPath/get_py_path.m b/src/base/io/python/pyPath/get_py_path.m new file mode 100644 index 0000000000..7cf78ef99a --- /dev/null +++ b/src/base/io/python/pyPath/get_py_path.m @@ -0,0 +1,4 @@ +function current_py_path = get_py_path() +%Function to return the current python search path as a cell array of strings + current_py_path = cellfun(@char, cell(py.sys.path), 'UniformOutput', 0)'; +end \ No newline at end of file diff --git a/src/base/io/python/pyPath/py_addpath.m b/src/base/io/python/pyPath/py_addpath.m new file mode 100644 index 0000000000..620bd249e9 --- /dev/null +++ b/src/base/io/python/pyPath/py_addpath.m @@ -0,0 +1,87 @@ +function new_py_path = py_addpath(directory, MATLAB_too) +%Add directory to import search path for the instance of +%the Python interpreter currently controlled by MATLAB +% +%EXAMPLE USAGE +% >> py_addpath('C:\Documents\ERPResults') +% +%REQUIRED INPUTS +% directory - Directory to add the Python import search path +% MATLAB_too - If true (or 1), directory will also be added to the +% MATLAB path. {default: false} +% +%OPTIONAL OUTPUT +% new_py_path - a cell array of the directories on the updated +% Python path; to get this output without updating the +% Python path, use an empty string as the input: +% py_path = py_addpath('') +% +%VERSION DATE: 3 Novemeber 2017 +%AUTHOR: Eric Fields +% +%NOTE: This function is provided "as is" and any express or implied warranties +%are disclaimed. + +%Copyright (c) 2017, Eric Fields +%All rights reserved. +%This code is free and open source software made available under the 3-clause BSD license. + +% Copyright (c) 2017, Eric Fields +% All rights reserved. +% +% Redistribution and use in source and binary forms, with or without +% modification, are permitted provided that the following conditions are +% met: +% +% * Redistributions of source code must retain the above copyright +% notice, this list of conditions and the following disclaimer. +% * Redistributions in binary form must reproduce the above copyright +% notice, this list of conditions and the following disclaimer in +% the documentation and/or other materials provided with the distribution +% +% THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS "AS IS" +% AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE +% IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE +% ARE DISCLAIMED. IN NO EVENT SHALL THE COPYRIGHT OWNER OR CONTRIBUTORS BE +% LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR +% CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF +% SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS +% INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN +% CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE) +% ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE +% POSSIBILITY OF SUCH DAMAGE. + + %check input + if ~ischar(directory) + error('Input must be a string') + elseif ~exist(directory, 'dir') && ~isempty(directory) + error('%s is not a valid directory', directory) + end + + %Convert relative path to absolute path + if exist(directory,'dir')~=7 + directory = char(py.os.path.abspath(directory)); + end + + %add directory to Python path if not already present + if ~any(strcmp(get_py_path(), directory)) + py_path = py.sys.path; + py_path.insert(int64(1), directory); + end + + %add directory to MATLAB path if requested + if nargin>1 && MATLAB_too + addpath(directory); + end + + %optionally return ammended path.sys as cell array + if nargout + new_py_path = get_py_path(); + end + +end + +function current_py_path = get_py_path() +%Function to return the current python search path as a cell array of strings + current_py_path = cellfun(@char, cell(py.sys.path), 'UniformOutput', 0)'; +end diff --git a/src/base/io/python/pyPath/py_rmpath.m b/src/base/io/python/pyPath/py_rmpath.m new file mode 100644 index 0000000000..42bf347e40 --- /dev/null +++ b/src/base/io/python/pyPath/py_rmpath.m @@ -0,0 +1,55 @@ +function new_py_path = py_rmpath(directory, MATLAB_too) +%Add directory to import search path for the instance of +%the Python interpreter currently controlled by MATLAB +% +%EXAMPLE USAGE +% >> py_rmpath('C:\Documents\ERPResults') +% +%REQUIRED INPUTS +% directory - Directory to remove from the Python import search path +% MATLAB_too - If true (or 1), directory will also be added to the +% MATLAB path. {default: false} +% +%OPTIONAL OUTPUT +% new_py_path - a cell array of the directories on the updated +% Python path; to get this output without updating the +% Python path, use an empty string as the input: +% py_path = py_addpath('') +% +%VERSION DATE: 13 April 2021 +%AUTHOR: Ronan Fleming, based on py_addpath by Eric Fields +% +%NOTE: This function is provided "as is" and any express or implied warranties +%are disclaimed. + +%This code is free and open source software made available under the 3-clause BSD license. + + %check input + if ~ischar(directory) + error('Input must be a string') + elseif ~exist(directory, 'dir') && ~isempty(directory) + error('%s is not a valid directory', directory) + end + + %Convert relative path to absolute path + if ~isempty(directory) + directory = char(py.os.path.abspath(directory)); + end + + %add directory to Python path if already present + if any(strcmp(get_py_path(), directory)) + py_path = py.sys.path; + py_path.remove(directory); + end + + %remove directory to MATLAB path if requested + if nargin>1 && MATLAB_too + rnpath(directory); + end + + %optionally return ammended path.sys as cell array + if nargout + new_py_path = get_py_path(); + end + +end \ No newline at end of file diff --git a/src/base/paths/comparePaths.m b/src/base/paths/comparePaths.m new file mode 100644 index 0000000000..0ff066dd4c --- /dev/null +++ b/src/base/paths/comparePaths.m @@ -0,0 +1,84 @@ +function [common,system_not_matlab,matlab_not_system] = comparePaths(NAME,printLevel) +%compare the system and matlab paths for a given NAME environment variable +% +% INPUT +% NAME environment variable, e.g., PATH or LD_LIBRARY_PATH +% printLevel +% +% OUTPUT +% common cell array +% system_not_matlab +% matlab_not_system +% +% USAGE example +% [common,system_not_matlab,matlab_not_system] = comparePaths('LD_LIBRARY_PATH',1); + +if ~exist('printLevel','var') + printLevel=0; +end + +if strcmp(NAME,'PYTHON') + matlab_split = get_py_path(); + [success,system_response]=system('python -c "import sys; print(sys.path)"'); + system_split = split(system_response,','); + system_split{1}=strtrim(system_split{1}); + system_split{1}=strrep(system_split{1},'[',''); + system_split{end}=strtrim(system_split{end}); + system_split{end}=strrep(system_split{end},']',''); + system_split{end}=strrep(system_split{end},'''',''); + for i=1:length(system_split) + system_split{i}=strrep(system_split{i},' ',''); + system_split{i}=strrep(system_split{i},'''',''); + end +else + [success,system_response]=system(['echo $' NAME]); + system_split = split(system_response,':'); + for i=1:length(system_split) + system_split{i} = strtrim(system_split{i}); + end + + matlab_response = getenv(NAME); + matlab_split = split(matlab_response,':'); + for i=1:length(matlab_split) + matlab_split{i} = strtrim(matlab_split{i}); + end +end + +if printLevel>1 + disp(system_split) + disp(matlab_split) +end + +common = intersect(system_split,matlab_split); +if printLevel>1 + fprintf('%s\n',[NAME ' common to system and matlab']) + for i=1:length(common) + fprintf('%s\n',common{i}) + end +end + +system_not_matlab = setdiff(system_split,matlab_split); +if printLevel>0 + if isempty(system_not_matlab) + fprintf('%s\n',['No ' NAME ' in system but not matlab']) + else + fprintf('\n%s\n',[NAME ' in system but not matlab']) + for i=1:length(system_not_matlab) + fprintf('%s\n',system_not_matlab{i}) + end + end +end + +matlab_not_system = setdiff(matlab_split,system_split); +if printLevel>0 + if isempty(matlab_not_system) + fprintf('%s\n',['No ' NAME ' in matlab but not system']) + else + fprintf('\n%s\n',[NAME ' in matlab but not system']) + for i=1:length(matlab_not_system) + fprintf('%s\n',matlab_not_system{i}) + end + end +end + + diff --git a/src/base/solvers/solveCobraLP.m b/src/base/solvers/solveCobraLP.m index db15761115..1fef61a743 100644 --- a/src/base/solvers/solveCobraLP.m +++ b/src/base/solvers/solveCobraLP.m @@ -8,14 +8,14 @@ % INPUT: % LPproblem: Structure containing the following fields describing the LP problem to be solved % -% * .A - LHS matrix -% * .b - RHS vector -% * .c - Objective coeff vector -% * .lb - Lower bound vector -% * .ub - Upper bound vector -% * .osense - Objective sense (-1 means maximise (default), 1 means minimise) -% * .csense - Constraint senses, a string containting the constraint sense for -% each row in A ('E', equality, 'G' greater than, 'L' less than). +% * .A - m x n linear constraint matrix +% * .b - m x 1 right hand sider vector for constraint A*x = b +% * .c - n x 1 linear objective coefficient vector +% * .lb - n x 1 lower bound vector for lb <= x +% * .ub - n x 1 upper bound vector for x <= ub +% * .osense - scalar objective sense (-1 means maximise (default), 1 means minimise) +% * .csense - m x 1 character array of constraint senses, one for each row in A +% must be either ('E', equality, 'G' greater than, 'L' less than). % % OPTIONAL INPUTS: % varargin: Additional parameters either as parameter struct, or as @@ -153,7 +153,12 @@ end % assume constraint A*v = b if csense not provided -if ~isfield(LPproblem, 'csense') +if isfield(LPproblem, 'csense') + bool = LPproblem.csense == 'E' | LPproblem.csense == 'G' | LPproblem.csense == 'L'; + if any(~bool) + error('Incorrect formulation of LPproblem.csense \n%s','LPproblem.csense must be an m x 1 character array containing the constraint sense {''E'',''L'',''G''} corresponding to each row of LPproblem.A') + end +else % if csense is not declared in the model, assume that all % constraints are equalities. LPproblem.csense(1:size(LPproblem.A,1), 1) = 'E'; diff --git a/src/base/utilities/duplicates.m b/src/base/utilities/duplicates.m new file mode 100644 index 0000000000..8dc4cdac4e --- /dev/null +++ b/src/base/utilities/duplicates.m @@ -0,0 +1,59 @@ +function [M,duplicateBool,C,IA,IC] = duplicates(A) +% create a map M between the first instance (row) and other instances (cols) +% of an equivalent set using [C,IA,IC]=unique(A,'rows','stable'); +% +% INPUT +% A m x n array (compatible with unique.m) +% +% OUTPUT +% M m x m array where M(i,j) = 1 if the first instance of i has a +% duplicate j, and M(i,j) = 0 otherwise. +% C unique first instances in the same order that they appear in A +% IA C = A(IA,:) +% IC A = C(IC,:) +% +% USAGE +% A=['a';'a';'b';'c';'d';'d';'b';'b';'e']; +% +% M = +% 0 1 0 0 0 0 0 0 0 +% 0 0 0 0 0 0 0 0 0 +% 0 0 0 0 0 0 1 1 0 +% 0 0 0 0 0 0 0 0 0 +% 0 0 0 0 0 1 0 0 0 +% 0 0 0 0 0 0 0 0 0 +% 0 0 0 0 0 0 0 0 0 +% 0 0 0 0 0 0 0 0 0 +% 0 0 0 0 0 0 0 0 0 +% +% duplicateBool = +% 0 +% 1 +% 0 +% 0 +% 0 +% 1 +% 1 +% 1 +% 0 + +N=size(A,1); + +if iscell(A) + [C,IA,IC]=unique(A,'stable'); +else + [C,IA,IC]=unique(A,'rows','stable'); +end + +M = sparse(N,N); +for i=1:N + if any(i==IA) %first index of an equivalent set + bool=i==IA(IC); + bool(i)=0; + M(i,bool)=1; + end +end + +duplicateBool = any(M,1)'; + + diff --git a/src/dataIntegration/chemoInformatics/addMetInfoInCBmodel.m b/src/dataIntegration/chemoInformatics/addMetInfoInCBmodel.m new file mode 100644 index 0000000000..eee5fc11fb --- /dev/null +++ b/src/dataIntegration/chemoInformatics/addMetInfoInCBmodel.m @@ -0,0 +1,116 @@ +function [newModel, hasEffect] = addMetInfoInCBmodel(model, inputData, replace) +% Integrates metabolite data from an external file and incorporates it into +% the COBRA model. +% +% USAGE: +% +% model = addMetInfoInCBmodel(model, inputData) +% +% INPUTS: +% model: COBRA model with following fields: +% +% * .S - The m x n stoichiometric matrix for the +% metabolic network. +% * .mets - An m x 1 array of metabolite identifiers. +% inputData: COBRA model with following fields: +% +% OPTIONAL INPUTS: +% replace: If the new ID should replace an existing ID, this +% logical value indicates so (default: false). +% +% OUTPUTS: COBRA model with updated identifiersCOBRA model with +% the identifiers updated. + +if nargin < 3 || isempty(replace) + replace = false; +end + +hasEffect = false; + +if isfile(inputData) + dbData = readtable(inputData); +elseif isstruct(inputData) + dbData = readtable(inputData); +end + +% Get data from model and external source +sources = {'KEGG', 'HMDB', 'ChEBI', 'PubChem', 'SMILES', 'InChI'}; +fields = fieldnames(model); +newDataVariableNames = dbData.Properties.VariableNames; +metsInModel = regexprep(model.mets, '(\[\w\])', ''); + +for i = 1:size(sources, 2) + + % Get the corresponding field for a database in the model + fieldInModelBool = ~cellfun(@isempty, regexpi(fields, sources{i})); + if sum(fieldInModelBool) > 1 + metDataInModelBool = ~cellfun(@isempty, regexpi(fields, 'met')); + fieldInModelBool = fieldInModelBool & metDataInModelBool; + end + % Create the field if it does not exist + if sum(fieldInModelBool) == 0 + model.(['met' sources{i}]) = cell(size(metsInModel, 1), 1); + fields = fieldnames(model); + fieldInModelBool = ~cellfun(@isempty, regexpi(fields, sources{i})); + end + + % Get the corresponding field for a database in the data + fieldInDataBool = ~cellfun(@isempty, regexpi(newDataVariableNames, sources{i})); + if sum(fieldInDataBool) > 1 + metDataInDataBool = ~cellfun(@isempty, regexpi(newDataVariableNames, 'met')); + inchiKeyInDataBool = cellfun(@isempty, regexpi(newDataVariableNames, 'inchikey')); + fieldInDataBool = fieldInDataBool & (metDataInDataBool | inchiKeyInDataBool); + end + + if sum(fieldInModelBool) == 1 && sum(fieldInDataBool) == 1 + + % Identify the correct idx per metabolite + for j = 1:size(dbData.(newDataVariableNames{1}), 1) + + % Fix for numeric values omitting 0 and NaN + if isnumeric(dbData.(newDataVariableNames{fieldInDataBool})(j)) + if ~isnan(dbData.(newDataVariableNames{fieldInDataBool})(j)) && dbData.(newDataVariableNames{fieldInDataBool})(j) ~= 0 + data2add = num2str(dbData.(newDataVariableNames{fieldInDataBool})(j)); + else + data2add = []; + end + else + data2add = dbData.(newDataVariableNames{fieldInDataBool}){j}; + end + idx = strmatch(dbData.(newDataVariableNames{1}){j}, metsInModel, 'exact'); + + % Fill the data + if ~isempty(idx) && replace && ~isempty(data2add) + + % Add the ID + for k = 1:size(idx, 1) + model.(fields{fieldInModelBool})(idx(k)) = data2add; + end + if ~hasEffect + hasEffect = true; + end + + elseif ~isempty(idx) && ~replace && ~isempty(data2add) + + % Only add data on empty cells + idxBool = cellfun(@isempty, model.(fields{fieldInModelBool})(idx)); + if any(idxBool) + idx = idx(idxBool); + % Add the ID + for k = 1:size(idx, 1) + model.(fields{fieldInModelBool}){idx(k)} = data2add; + end + if ~hasEffect + hasEffect = true; + end + end + + end + + end + elseif sum(fieldInModelBool) > 1 || sum(fieldInDataBool) > 1 + error(['Rename the data, nameTag "' sources{i} '" was found more than 1 time']) + end +end + +newModel = model; \ No newline at end of file diff --git a/src/dataIntegration/chemoInformatics/checkMetIdsInModel.m b/src/dataIntegration/chemoInformatics/checkMetIdsInModel.m new file mode 100644 index 0000000000..58d82e3ca7 --- /dev/null +++ b/src/dataIntegration/chemoInformatics/checkMetIdsInModel.m @@ -0,0 +1,75 @@ +function metsIdsStatistics = checkMetIdsInModel(model) +% Prints the statistics of the metabolites id in the a model. +% +% USAGE: +% +% metsIdsStatistics = checkMetIdsInModel(model) +% +% INPUTS: +% model: COBRA model with following fields: +% +% * .mets - An m x 1 array of metabolite identifiers. +% Should match metabolite identifiers in +% RXN. +% OUTPUTS: +% metsIdsStatistics: Information such as the number of metabolites per +% database, coverage, or the number of times another +% ID is shared for the same metabolite. + +fields = fieldnames(model); +sources = {'kegg', 'hmdb', 'chebi', 'pubchem', 'smiles', 'inchi'}; +mets = regexprep(model.mets, '(\[\w\])', ''); +umets = unique(mets); + +for i = 1:length(sources) + + fieldInModelBool = ~cellfun(@isempty, regexpi(fields, sources{i})); + if any(fieldInModelBool) + + if sum(fieldInModelBool) == 1 + sourceIdsPerMet = model.(fields{fieldInModelBool}); + else + dbFields = fields(fieldInModelBool); + sourceIdsPerMet = model.(dbFields{~cellfun(@isempty, regexpi(dbFields, 'met'))}); + end + + + sourceData.metWithIdBool = ~cellfun(@isempty, sourceIdsPerMet); + sourceData.metWithIdTotal = sum(sourceData.metWithIdBool); + sourceData.DBcoverage = (sourceData.metWithIdTotal * 100) / size(mets, 1); + + % unique metabolites + dbMets = sourceIdsPerMet(sourceData.metWithIdBool); + uDbMets = unique(dbMets); + uniqueBool = false(size(mets, 1), 1); + for j = 1:size(uDbMets, 1) + idx = find(ismember(sourceIdsPerMet, uDbMets{j})); + uniqueBool(idx(1)) = true; + end + + sourceData.uniqueMetWithIdBool = uniqueBool; + sourceData.uniqueMetWithIdTotal = sum(sourceData.uniqueMetWithIdBool); + sourceData.uniqueIdDBcoverage = (sourceData.uniqueMetWithIdTotal * 100) / size(umets, 1); + + switch sources{i} + + case 'kegg' + metsIdsStatistics.KEEG = sourceData; + case 'hmdb' + metsIdsStatistics.HMDB = sourceData; + case 'chebi' + metsIdsStatistics.ChEBi = sourceData; + case 'pubchem' + metsIdsStatistics.PubChem = sourceData; + case 'smiles' + metsIdsStatistics.SMILES = sourceData; + case 'inchi' + metsIdsStatistics.InChI = sourceData; + end + + clear DBdata dbIdsPerMet + end +end + +end + diff --git a/src/dataIntegration/chemoInformatics/editChemicalFormula.m b/src/dataIntegration/chemoInformatics/editChemicalFormula.m new file mode 100644 index 0000000000..4700258498 --- /dev/null +++ b/src/dataIntegration/chemoInformatics/editChemicalFormula.m @@ -0,0 +1,76 @@ +function newFormula = editChemicalFormula(metFormula, addOrRemove) +% For each instance, removes non-chemical characters from the chemical +% formula and replaces them with a R group. Removes atoms from the formula +% as well. Produces a chemical formula from a string of atoms. +% +% USAGE: +% +% [metFormula] = cobraFormulaToChemFormula(metReconFormula) +% +% INPUTS: +% metReconFormula: An n x 1 array of metabolite Recon formulas +% OPTIONAL INPUTS: +% addOrRemove: A struct array containing: +% *.elements - element to edit +% *.times - vector indicated the times the +% element will be deleted (negative) or +% added (positive) +% +% OUTPUTS: +% chemicalFormula: A chemical formula for a metabolite + +if nargin < 2 || isempty(addOrRemove) + addOrRemove = []; +end + +% Update R groups +metFormula = regexprep(char(metFormula), 'X|Y|*|FULLR', 'R'); + +% Rearrange the formulas (e.g., from RCRCOC to C3OR2) + +% Count the atoms +[elemetList, ~ , elemetEnd] = regexp(metFormula, ['[', 'A':'Z', '][', 'a':'z', ']?'], 'match'); +[num, numStart] = regexp(metFormula, '\d+', 'match'); +numList = ones(size(elemetList)); +idx = ismember(elemetEnd + 1, numStart); +numList(idx) = cellfun(@str2num, num); + +% Combine atoms if neccesary +uniqueElemetList = unique(elemetList); +for j = 1:size(uniqueElemetList, 2) + atomBool = ismember(elemetList, uniqueElemetList{j}); + if sum(atomBool) > 1 + dataToKeep = find(atomBool); + numList(dataToKeep(1)) = sum(numList(atomBool)); + numList(dataToKeep(2:end)) = []; + elemetList(dataToKeep(2:end)) = []; + end +end + +% Delete/add atoms if neccesary +if ~isempty(addOrRemove) + for i = 1:length(addOrRemove.elements) + elemetBool = ismember(elemetList, addOrRemove.elements(i)); + if any(elemetBool) + numList(elemetBool) = numList(elemetBool) + addOrRemove.times(i); + else + elemetList{size(elemetList, 2) + 1} = addOrRemove.elements{i}; + numList(size(elemetList, 2)) = addOrRemove.times(i); + end + end +end + +% Sort atoms +[elemetList, ia] = sort(elemetList); + +% Make formula +newFormula = []; +for j = 1:size(elemetList, 2) + if numList(ia(j)) == 1 + newFormula = [newFormula elemetList{j}]; + else + newFormula = [newFormula elemetList{j} num2str(numList(ia(j)))]; + end +end + +end diff --git a/src/dataIntegration/chemoInformatics/generateChemicalDatabase.m b/src/dataIntegration/chemoInformatics/generateChemicalDatabase.m new file mode 100644 index 0000000000..68d739e25e --- /dev/null +++ b/src/dataIntegration/chemoInformatics/generateChemicalDatabase.m @@ -0,0 +1,1095 @@ +function [info, newModel] = generateChemicalDatabase(model, options) +% This function uses the metabolite identifiers in the model to compare +% them and save the identifiers with the best score in MDL MOL format +% and/or inchi and simles and jpeg if it's installed cxcalc and openBabel. +% The obtained MDL MOL files will serve as the basis for creating the MDL +% RXN files that represent a metabolic reaction and can only be written if +% there is a MDL MOL file for each metabolite in a metabolic reaction. +% If JAVA is installed, it also atom maps the metabolic reactions +% with an MDL RXN file. +% +% USAGE: +% +% [info, newModel] = generateChemicalDatabase(model, options) +% +% INPUTS: +% +% model: COBRA model with following fields: +% +% * .S - The m x n stoichiometric matrix for the +% metabolic network. +% * .rxns - An n x 1 array of reaction identifiers. +% * .mets - An m x 1 array of metabolite identifiers. +% * .metFormulas - An m x 1 array of metabolite chemical formulas. +% * .metinchi - An m x 1 array of metabolite identifiers. +% * .metsmiles - An m x 1 array of metabolite identifiers. +% * .metKEGG - An m x 1 array of metabolite identifiers. +% * .metHMDB - An m x 1 array of metabolite identifiers. +% * .metPubChem - An m x 1 array of metabolite identifiers. +% * .metCHEBI - An m x 1 array of metabolite identifiers. +% +% options: A structure containing all the arguments for the function: +% +% * .outputDir: The path to the directory containing the RXN +% files with atom mappings (default: current directory) +% * .printlevel: Verbose level +% * .standardisationApproach: String containing the type of +% standardisation for the molecules (default: 'explicitH' +% if openBabel is installed, otherwise default: 'basic'): +% - explicitH: Normal chemical graphs; +% - implicitH: Hydrogen suppressed chemical graph; +% - neutral: Chemical graphs with protonated molecules; +% - basic: Update the header. +% * .keepMolComparison: Logic value for comparing MDL MOL +% files from various sources (default: FALSE) +% * .onlyUnmapped: Logic value to select create only unmapped +% MDL RXN files (default: FALSE). +% * .adjustToModelpH: Logic value used to determine whether a +% molecule's pH must be adjusted in accordance with the +% COBRA model. (default: TRUE, requires MarvinSuite). +% * .addDirsToCompare: Cell(s) with the path to directory to +% an existing database (default: empty). +% * .dirNames: Cell(s) with the name of the directory(ies) +% (default: empty). +% * .debug: Logical value used to determine whether or not +% the results of different points in the function will be +% saved for debugging (default: empty). +% +% OUTPUTS: +% +% newModel: A new model with the comparison and if onlyUnmapped = +% false, the informaton about the bonds broken and formed +% as well as the bond enthalpies for each metabolic +% reaction. +% info: A diary of the database generation process + +%% 1. Initialise data and set default variables + +if ~isfield(options, 'outputDir') + outputDir = [pwd filesep]; +else + % Make sure input path ends with directory separator + outputDir = [regexprep(options.outputDir,'(/|\\)$',''), filesep]; +end +metDir = [outputDir 'mets']; +rxnDir = [outputDir 'rxns']; + +modelFields = fieldnames(model); + +if ~isfield(options, 'debug') + options.debug = false; +end +if ~isfield(options, 'printlevel') + options.printlevel = 1; +end +if ~isfield(options, 'standardisationApproach') + options.standardisationApproach = 'explicitH'; +end +if ~isfield(options, 'keepMolComparison') + options.keepMolComparison = false; +end +if ~isfield(options, 'onlyUnmapped') + options.onlyUnmapped = false; +end +if ~isfield(options, 'adjustToModelpH') + options.adjustToModelpH = true; +end +if isfield(options, 'dirsToCompare') + dirsToCompare = true; + for i = 1:length(options.dirsToCompare) + options.dirsToCompare{i} = [regexprep(options.dirsToCompare{i},'(/|\\)$',''), filesep]; + if ~isfolder(options.dirsToCompare) + display([options.dirsToCompare{i} ' is not a directory']) + options.dirsToCompare{i} = []; + end + end +else + options.dirsToCompare = []; + dirsToCompare = false; +end +if ~isfield(options, 'dirNames') + for i = 1:length(options.dirsToCompare) + options.dirNames{i, 1} = ['localDir' num2str(i)]; + end +else + if isrow(options.dirNames) + options.dirNames = options.dirNames'; + end +end + +% Check if ChemAxon and openBabel are installed +[cxcalcInstalled, ~] = system('cxcalc'); +cxcalcInstalled = ~cxcalcInstalled; +if cxcalcInstalled == 0 + cxcalcInstalled = false; + display('cxcalc is not installed, two features cannot be used: ') + display('1 - jpeg files for molecular structures (obabel required)') + display('2 - pH adjustment according to model.met Formulas') +end +[oBabelInstalled, ~] = system('obabel'); +if oBabelInstalled ~= 1 + oBabelInstalled = false; + options.standardisationApproach = 'basic'; + display('obabel is not installed, two features cannot be used: ') + display('1 - Generation of SMILES, InChI and InChIkey') + display('2 - MOL file standardisation') +end +[javaInstalled, ~] = system('java'); +if javaInstalled ~= 1 && ~options.onlyUnmapped + display('java is not installed, atom mappings cannot be computed') + options.onlyUnmapped = true; +end + +% Start diary +if ~isfolder(outputDir) + mkdir(outputDir); +end +diaryFilename = [outputDir datestr(now,30) '_DatabaseDiary.txt']; +diary(diaryFilename) + +if options.printlevel > 0 + disp('--------------------------------------------------------------') + disp('CHEMICAL DATABASE') + disp('--------------------------------------------------------------') + disp(' ') + fprintf('%s\n', 'Generating a chemical database with the following options:') + disp(' ') + disp(options) + disp('--------------------------------------------------------------') +end + +directories = {'inchi'; 'smiles'; 'KEGG'; 'HMDB'; 'PubChem'; 'CHEBI'}; +if dirsToCompare + directories = [directories; options.dirNames]; +end + +mets = regexprep(model.mets, '(\[\w\])', ''); +umets = unique(mets); + +%% 2. Obtain metabolite structures from different sources + +% SOURCES +% 1.- InChI (requires openBabel to obtain MOL file) +% 2.- Smiles (requires openBabel to obtain MOL file) +% 3.- KEGG (https://www.genome.jp/) +% 4.- HMDB (https://hmdb.ca/) +% 5.- PubChem (https://pubchem.ncbi.nlm.nih.gov/) +% 6.- CHEBI (https://www.ebi.ac.uk/) + +if options.printlevel > 0 + fprintf('%s\n\n', 'Obtaining MOL files from chemical databases ...') +end + +comparisonDir = [metDir filesep 'molComparison' filesep]; +source = [0 0 0 0 0 0 0]; +for i = 1:6 + dirBool(i) = false; + if any(~cellfun(@isempty, regexpi(modelFields, directories{i}))) + dirBool(i) = true; + sourceData = source; + sourceData(i + 1) = source(i + 1) + i + 1; + molCollectionReport = obtainMetStructures(model, comparisonDir, false, [], sourceData); + movefile([comparisonDir filesep 'newMol'], ... + [comparisonDir filesep directories{i}]) + info.sourcesCoverage.(directories{i}) = molCollectionReport; + info.sourcesCoverage.totalCoverage(i) = molCollectionReport.noOfMets; + info.sourcesCoverage.source{i} = directories{i}; + if options.printlevel > 0 + disp([directories{i} ':']) + display(molCollectionReport) + end + end +end +if ~isempty(dirsToCompare) + for i = 1:length(options.dirsToCompare) + % Get list of MOL files + d = dir(options.dirsToCompare{i}); + d = d(~[d.isdir]); + metList = {d.name}'; + metList = metList(~cellfun('isempty', regexp(metList,'(\.mol)$'))); + metList = regexprep(metList, '.mol', ''); + metList(~ismember(metList, umets)) = []; + info.sourcesCoverage.totalCoverage(i + 6) = length(metList); + info.sourcesCoverage.source{i + 6} = options.dirNames{i}; + end +end +% Remove sources without a single metabolite present the model +if dirsToCompare + emptySourceBool = info.sourcesCoverage.totalCoverage == 0; + info.sourcesCoverage.totalCoverage(emptySourceBool) = []; + directories(emptySourceBool) = []; + dirsToDeleteBool = ismember(options.dirNames, info.sourcesCoverage.source(emptySourceBool)); + options.dirsToCompare(dirsToDeleteBool) = []; + options.dirNames(dirsToDeleteBool) = []; + info.sourcesCoverage.source(emptySourceBool) = []; +else + directories(~dirBool) = []; +end + +if options.debug + save([outputDir '2.debug_afterDownloadMetabolicStructures.mat']) +end + +%% 3. Compare MOL files downloaded and save the best match + +if options.printlevel > 0 + fprintf('%s\n', 'Comparing information from sources ...') +end + +for i = 1:size(directories, 1) + + % Set dir + if i > 6 && dirsToCompare + sourceDir = options.dirsToCompare{i - 6}; + else + sourceDir = [comparisonDir directories{i} filesep]; + end + + + % Get list of MOL files + d = dir(sourceDir); + d = d(~[d.isdir]); + metList = {d.name}'; + metList = metList(~cellfun('isempty', regexp(metList,'(\.mol)$'))); + metList = regexprep(metList, '.mol', ''); + metList(~ismember(metList, mets)) = []; + + warning('off') + for j = 1:size(metList, 1) + name = [metList{j} '.mol']; + + if oBabelInstalled + + % Get inchis of the original metabolites + command = ['obabel -imol ' sourceDir name ' -oinchi ']; + [~, result] = system(command); + result = split(result); + + % Group inchis in the correct group + if any(~cellfun(@isempty, regexp(result, 'InChI=1S'))) + + % Create InChI table + if ~exist('groupedInChIs','var') + groupedInChIs = table(); + end + % Identify the correct index + if ~ismember('metNames', groupedInChIs.Properties.VariableNames) + groupedInChIs.metNames{j} = regexprep(name, '.mol', ''); + idx = 1; + elseif ~ismember(regexprep(name, '.mol', ''), groupedInChIs.metNames) + idx = size(groupedInChIs.metNames, 1) + 1; + groupedInChIs.metNames{idx} = regexprep(name, '.mol', ''); + else + idx = find(ismember(groupedInChIs.metNames, regexprep(name, '.mol', ''))); + end + % Save inchi in the table + groupedInChIs.(directories{i}){idx} = result{~cellfun(@isempty, regexp(result, 'InChI=1S'))}; + + else + + % Create SMILES table for molecules with R groups + if ~exist('groupedSMILES','var') + groupedSMILES = table(); + end + % Identify the correct index + if ~ismember('metNames', groupedSMILES.Properties.VariableNames) + groupedSMILES.metNames{1} = regexprep(name, '.mol', ''); + idx = 1; + elseif ~ismember(regexprep(name, '.mol', ''), groupedSMILES.metNames) + idx = size(groupedSMILES.metNames, 1) + 1; + groupedSMILES.metNames{idx} = regexprep(name, '.mol', ''); + else + idx = find(ismember(groupedSMILES.metNames, regexprep(name, '.mol', ''))); + end + % Get SMILES + command = ['obabel -imol ' sourceDir name ' -osmiles ']; + [~, result] = system(command); + if contains(result, '0 molecules converted') + continue + end + result = splitlines(result); + result = split(result{end - 2}); + % Save SMILES in the table + groupedSMILES.(directories{i}){idx} = result{1}; + + end + + else + + % Create SMILES table for molecules with R groups + if ~exist('groupedFormula','var') + groupedFormula = table(); + end + % Identify the correct index + if ~ismember('metNames', groupedFormula.Properties.VariableNames) + groupedFormula.metNames{1} = regexprep(name, '.mol', ''); + idx = 1; + elseif ~ismember(regexprep(name, '.mol', ''), groupedFormula.metNames) + idx = size(groupedFormula.metNames, 1) + 1; + groupedFormula.metNames{idx} = regexprep(name, '.mol', ''); + else + idx = find(ismember(groupedFormula.metNames, regexprep(name, '.mol', ''))); + end + % Get formula from MOL + molFile = regexp(fileread([sourceDir name]), '\n', 'split')'; + atomsString = []; + for k = 1:str2num(molFile{4}(1:3)) + atomsString = [atomsString strtrim(molFile{4 + k}(32:33))]; + end + groupedFormula.(directories{i}){idx} = editChemicalFormula(atomsString); + + end + end + warning('on') +end + +if options.debug + save([outputDir '3a.debug_beforeComparison.mat']) +end + +if oBabelInstalled + + % Obtain the most consistent molecules + reportComparisonInChIs = consistentData(model, groupedInChIs, 'InChI'); + fields = fieldnames(reportComparisonInChIs); + metsInStruct = regexprep(fields(contains(fields, 'met_')), 'met_', ''); + emptyBool = cellfun(@isempty, reportComparisonInChIs.sourcesToSave); + source = reportComparisonInChIs.sourcesToSave(~emptyBool); + + % Obtain the most consistent for molecules with R groups + if exist('groupedSMILES','var') + reportComparisonSMILES = consistentData(model, groupedSMILES, 'SMILES'); + fields = fieldnames(reportComparisonSMILES); + metNamesSmiles = regexprep(fields(contains(fields, 'met_')), 'met_', ''); + metsInStruct(end + 1: end + size(metNamesSmiles, 1)) = metNamesSmiles; + emptyBool = cellfun(@isempty, reportComparisonSMILES.sourcesToSave); + source(end + 1: end + size(metNamesSmiles, 1)) = reportComparisonSMILES.sourcesToSave(~emptyBool); + end + + nRows = size(metsInStruct, 1); + varTypes = {'string', 'string', 'string', 'string', 'string', 'double', 'double', 'string'}; + varNames = {'mets', 'sourceWithHighestScore', 'metNames', 'metFormulas', 'sourceFormula', 'layersInChI', 'socre', 'idUsed'}; + info.comparisonTable = table('Size', [nRows length(varTypes)], 'VariableTypes', varTypes, 'VariableNames', varNames); + + fields = fieldnames(reportComparisonInChIs); + metFields = fields(contains(fields, 'met_')); + for i = 1:size(metFields, 1) + info.comparisonTable.mets(i) = metsInStruct(i); + info.comparisonTable.sourceWithHighestScore(i) = source(i); + if isfield(model, 'metNames') + info.comparisonTable.metNames(i) = reportComparisonInChIs.(metFields{i}).metNames; + end + info.comparisonTable.metFormulas(i) = reportComparisonInChIs.(metFields{i}).metFormula; + selectedIdIdx = find(reportComparisonInChIs.(metFields{i}).idsScore == max(reportComparisonInChIs.(metFields{i}).idsScore)); + info.comparisonTable.sourceFormula(i) = reportComparisonInChIs.(metFields{i}).sourceFormula(selectedIdIdx(1)); + info.comparisonTable.layersInChI(i) = reportComparisonInChIs.(metFields{i}).layersOfDataInChI(selectedIdIdx(1)); + info.comparisonTable.idUsed(i) = reportComparisonInChIs.(metFields{i}).ids(selectedIdIdx(1)); + info.comparisonTable.socre(i) = reportComparisonInChIs.(metFields{i}).idsScore(selectedIdIdx(1)); + end + if exist('groupedSMILES','var') + fields = fieldnames(reportComparisonSMILES); + metFields = fields(contains(fields, 'met_')); + startFrom = i; + for i = 1:size(metFields, 1) + info.comparisonTable.mets(i + startFrom) = metsInStruct(i + startFrom); + info.comparisonTable.sourceWithHighestScore(i + startFrom) = source(i + startFrom); + if isfield(model, 'metNames') + info.comparisonTable.metNames(i + startFrom, 1) = reportComparisonSMILES.(metFields{i}).metNames; + end + info.comparisonTable.metFormulas(i + startFrom) = char(reportComparisonSMILES.(metFields{i}).metFormula); + selectedIdIdx = find(reportComparisonSMILES.(metFields{i}).idsScore == max(reportComparisonSMILES.(metFields{i}).idsScore)); + info.comparisonTable.sourceFormula(i + startFrom) = reportComparisonSMILES.(metFields{i}).sourceFormula(selectedIdIdx(1)); + info.comparisonTable.layersInChI(i + startFrom) = NaN; + info.comparisonTable.idUsed(i + startFrom) = reportComparisonSMILES.(metFields{i}).ids(selectedIdIdx(1)); + info.comparisonTable.socre(i + startFrom) = reportComparisonSMILES.(metFields{i}).idsScore(selectedIdIdx(1)); + end + end + + % Print data + if options.printlevel > 0 + display(info.comparisonTable) + + % heatMap comparison + figure + comparison = reportComparisonInChIs.comparison; + if exist('groupedSMILES','var') + rows = size(comparison, 1); + comparison = [comparison; zeros(size(reportComparisonSMILES.comparison, 1),... + size(comparison, 2))]; + bool = ismember(reportComparisonInChIs.sources, reportComparisonSMILES.sources); + comparison(rows + 1:end, bool) = reportComparisonSMILES.comparison; + end + for i = 1:size(comparison, 2) + for j = 1:size(comparison, 2) + boolToCompare = ~isnan(comparison(:, i)) & ~isnan(comparison(:, j)); + group1 = comparison(boolToCompare, i); + group2 = comparison(boolToCompare, j); + comparisonMatrix(i, j) = sqrt(sum((group1 - group2).^2)); + end + end + h = heatmap(comparisonMatrix); + h.YDisplayLabels = directories; + h.XDisplayLabels = directories; + h.FontSize = 16; + title('Sources disimilarity comparison') + + % Sources comparison + figure + [db, ~, idx] = unique(split(strjoin(source, ' '), ' ')); + [~, ib1] = ismember(db, directories); + yyaxis left + bar(histcounts(idx, size(db, 1))) + title({'Sources comparison', ... + ['Metabolites collected: ' num2str(size(info.comparisonTable, 1))]}, 'FontSize', 20) + ylabel('Times with highest score', 'FontSize', 18) + set(gca, 'XTick', 1:size(db, 1), 'xticklabel', db, 'FontSize', 18) + xtickangle(45) + yyaxis right + bar(info.sourcesCoverage.totalCoverage(ib1), 0.3) + ylabel('IDs coverage', 'FontSize', 20) + + if options.printlevel > 1 + display(groupedInChIs) + end + end + +else + + % Obtain the most consistent molecules + reportComparisonFormula = consistentData(model, groupedFormula, 'MOL'); + fields = fieldnames(reportComparisonFormula); + metsInStruct = regexprep(fields(contains(fields, 'met_')), 'met_', ''); + emptyBool = cellfun(@isempty, reportComparisonFormula.sourcesToSave); + source = reportComparisonFormula.sourcesToSave(~emptyBool); + + nRows = size(metsInStruct, 1); + varTypes = {'string', 'string', 'string', 'string', 'string', 'double', 'double', 'string'}; + varNames = {'mets', 'sourceWithHighestScore', 'metNames', 'metFormulas', 'sourceFormula', 'layersInChI', 'socre', 'idUsed'}; + info.comparisonTable = table('Size', [nRows length(varTypes)], 'VariableTypes', varTypes, 'VariableNames', varNames); + + fields = fieldnames(reportComparisonFormula); + metFields = fields(contains(fields, 'met_')); + for i = 1:size(metFields, 1) + info.comparisonTable.mets(i) = metsInStruct(i); + info.comparisonTable.sourceWithHighestScore(i) = source(i); + if isfield(model, 'metNames') + info.comparisonTable.metNames(i) = reportComparisonFormula.(metFields{i}).metNames; + end + info.comparisonTable.metFormulas(i) = char(reportComparisonFormula.(metFields{i}).metFormula); + selectedIdIdx = find(reportComparisonFormula.(metFields{i}).idsScore == max(reportComparisonFormula.(metFields{i}).idsScore)); + info.comparisonTable.sourceFormula(i) = reportComparisonFormula.(metFields{i}).sourceFormula(selectedIdIdx(1)); + info.comparisonTable.idUsed(i) = reportComparisonFormula.(metFields{i}).ids(selectedIdIdx(1)); + info.comparisonTable.socre(i) = reportComparisonFormula.(metFields{i}).idsScore(selectedIdIdx(1)); + end + + if options.printlevel > 0 + display(info.comparisonTable) + + % heatMap comparison + figure + comparison = reportComparisonFormula.comparison; + for i = 1:size(comparison, 2) + for j = 1:size(comparison, 2) + % Ignore NaN data + boolToCompare = ~isnan(comparison(:, i)) & ~isnan(comparison(:, j)); + group1 = comparison(boolToCompare, i); + group2 = comparison(boolToCompare, j); + comparisonMatrix(i, j) = sqrt(sum((group1 - group2).^2)); + end + end + h = heatmap(comparisonMatrix); + h.YDisplayLabels = directories; + h.XDisplayLabels = directories; + title('Dissimilarity comparison') + + % Sources comparison + figure + [db, ~, idx] = unique(split(strjoin(source, ' '), ' ')); + bar(histcounts(idx, size(db, 1))) + title({'Source of molecules with the highest score', ... + ['Total ' num2str(size(info.comparisonTable, 1))]}, 'FontSize', 20) + ylabel('Times ', 'FontSize', 18) + set(gca, 'XTick', 1:size(db, 1), 'xticklabel', db, 'FontSize', 18) + xtickangle(45) + + if options.printlevel > 1 + display(groupedFormula) + end + end + +end + +% Save the MOL files with highest score +tmpDir = [metDir filesep 'tmp']; +if ~isfolder(tmpDir) + mkdir(tmpDir) +end +source = source(ismember(metsInStruct, unique(regexprep(model.mets, '(\[\w\])', '')))); +metsInStruct = metsInStruct(ismember(metsInStruct, unique(regexprep(model.mets, '(\[\w\])', '')))); +for i = 1:size(metsInStruct, 1) + dirToCopy = strsplit(source{i}, ' '); + if dirsToCompare && ismember(dirToCopy{1}, options.dirNames) + copyfile([options.dirsToCompare{ismember(options.dirNames, dirToCopy{1})} metsInStruct{i} '.mol'], tmpDir) + else + copyfile([comparisonDir dirToCopy{1} filesep metsInStruct{i} '.mol'], tmpDir) + end +end +if ~options.keepMolComparison + rmdir(comparisonDir, 's') +end +if ~options.adjustToModelpH || ~cxcalcInstalled + model.comparison = info.comparisonTable; +end +if options.debug + save([outputDir '3b.debug_afterComparison.mat']) +end + +%% 4. Adjust pH based on the model's chemical formula + +if options.adjustToModelpH && cxcalcInstalled + + info.adjustedpHTable = info.comparisonTable; + + if options.printlevel > 0 + fprintf('%s\n', 'Adjusting pH based on the model''s chemical formula ...') + display(' ') + end + + [needAdjustmentBool, differentFormula, loopError, pHRangePassed] = deal(false(size(info.comparisonTable, 1), 1)); + for i = 1:size(info.comparisonTable, 1) + try + + name = [info.comparisonTable.mets{i} '.mol']; + + if isequal(regexprep(info.comparisonTable.metFormulas(i), 'H\d*', ''),... + regexprep(info.comparisonTable.sourceFormula(i), 'H\d*', '')) % pH different only + + % Get number of hydrogens in the model's metabolite + [elemetList, ~ , elemetEnd] = regexp(info.comparisonTable.metFormulas(i), ['[', 'A':'Z', '][', 'a':'z', ']?'], 'match'); + hBool = contains(elemetList, 'H'); + [num, numStart] = regexp(info.comparisonTable.metFormulas(i), '\d+', 'match'); + numList = ones(size(elemetList)); + numList(ismember(elemetEnd + 1, numStart)) = cellfun(@str2num, num); + noOfH_model = numList(hBool); + + % Get number of hydrogens in the source's metabolite + [elemetList, ~ , elemetEnd] = regexp(info.comparisonTable.sourceFormula(i), ['[', 'A':'Z', '][', 'a':'z', ']?'], 'match'); + hBool = contains(elemetList, 'H'); + [num, numStart] = regexp(info.comparisonTable.sourceFormula(i), '\d+', 'match'); + numList = ones(size(elemetList)); + idx = ismember(elemetEnd + 1, numStart); + numList(idx) = cellfun(@str2num, num); + noOfH_source = numList(hBool); + + % Start with a neutral pH + pH = 7; + while noOfH_model ~= noOfH_source + + if ~needAdjustmentBool(i) + needAdjustmentBool(i) = true; + if noOfH_model - noOfH_source > 0 + pHDifference = -0.33; + else + pHDifference = 0.33; + end + end + + % Change pH + command = ['cxcalc majormicrospecies -H ' num2str(pH) ' -f mol ' tmpDir '' filesep name]; + [~, result] = system(command); + molFile = regexp(result, '\n', 'split')'; + fid2 = fopen([tmpDir filesep 'tmp.mol'], 'w'); + fprintf(fid2, '%s\n', molFile{:}); + fclose(fid2); + % Obtain the chemical formula + command = ['cxcalc elementalanalysistable -t "formula" ' tmpDir filesep 'tmp.mol']; + [~, formula] = system(command); + formula = split(formula); + formula = formula{end - 1}; + % Get number of hydrogens in the adjusted metabolite + [elemetList, ~ , elemetEnd] = regexp(formula, ['[', 'A':'Z', '][', 'a':'z', ']?'], 'match'); + hBool = contains(elemetList, 'H'); + [num, numStart] = regexp(formula, '\d+', 'match'); + numList = ones(size(elemetList)); + idx = ismember(elemetEnd + 1, numStart); + numList(idx) = cellfun(@str2num, num); + noOfH_source = numList(hBool); + + if pH <= 0 || pH >= 14 + pHRangePassed(i) = true; + break + end + pH = pH + pHDifference; + + if noOfH_model == noOfH_source + movefile([tmpDir filesep 'tmp.mol'], [tmpDir filesep name]) + info.adjustedpHTable.sourceFormula(i) = formula; + end + end + else + differentFormula(i) = true; + end + catch + loopError(i) = true; + end + end + + if isfile([tmpDir filesep 'tmp.mol']) + delete([tmpDir filesep 'tmp.mol']) + end + + info.adjustedpHTable.needAdjustmentBool = needAdjustmentBool; + info.adjustedpHTable.notPossible2AdjustBool = differentFormula | loopError | pHRangePassed; + info.adjustedpHTable.differentFormula = differentFormula; + info.adjustedpHTable.loopError = loopError; + info.adjustedpHTable.pHRangePassed = pHRangePassed; + + if options.printlevel > 0 + display('adjustedpH:') + display(info.adjustedpHTable) + end + + model.comparison = info.adjustedpHTable; + +end + +%% 5. Standardise the MOL files according options + +standardisationApproach = options.standardisationApproach; + +% Get list of MOL files +d = dir(tmpDir); +d = d(~[d.isdir]); +metList = {d.name}'; +metList = metList(~cellfun('isempty', regexp(metList,'(\.mol)$'))); +metList = regexprep(metList, '.mol', ''); +metList(~ismember(metList, regexprep(model.mets, '(\[\w\])', ''))) = []; + +% Standardise MOL files the most consitent MOL files +standardisationReport = standardiseMolDatabase(tmpDir, metList, metDir, standardisationApproach); +info.standardisationReport = standardisationReport; + +if oBabelInstalled + % Create table + nRows = size(standardisationReport.SMILES, 1); + varTypes = {'string', 'string', 'string', 'string'}; + varNames = {'mets', 'InChIKeys', 'InChIs', 'SMILES'}; + info.standardisationReport = table('Size', [nRows length(varTypes)], 'VariableTypes', varTypes, 'VariableNames', varNames); + info.standardisationReport.mets(1:end) = standardisationReport.standardised; + info.standardisationReport.InChIKeys(1:size(standardisationReport.InChIKeys, 1)) = standardisationReport.InChIKeys; + info.standardisationReport.InChIs(1:size(standardisationReport.InChIs, 1)) = standardisationReport.InChIs; + info.standardisationReport.SMILES(1:size(standardisationReport.SMILES, 1)) = standardisationReport.SMILES; + % Write table + writetable(info.standardisationReport, [metDir filesep 'standardisationReport']) +end + +if options.printlevel > 0 + display(info.standardisationReport) +end +rmdir(tmpDir, 's') +model.standardisation = info.standardisationReport; + +if options.debug + save([outputDir '5.debug_afterStandardisation.mat']) +end + +%% 6. Atom map data + +% Set options + +% MOL file directory +molFileDir = [metDir filesep 'molFiles']; + +% Create the reaction data directory +if ~isfolder(rxnDir) + mkdir(rxnDir) +end + +% Reactions to atom map +rxnsToAM = model.rxns; + +% Keep standardisation approach used with the molecular structures +switch options.standardisationApproach + case 'explicitH' + hMapping = true; + case 'implicitH' + hMapping = false; + case 'neutral' + case 'basic' + hMapping = true; +end + +% Atom map metabolic reactions +reactionsReport = obtainAtomMappingsRDT(model, molFileDir, rxnDir, rxnsToAM, hMapping, options.onlyUnmapped); +info.reactionsReport = reactionsReport; + + +rxnsFilesDir = [rxnDir filesep 'unMapped']; +if ~options.onlyUnmapped + + % Atom map transport reactions + mappedRxns = transportRxnAM(rxnsFilesDir, [rxnDir filesep 'atomMapped']); + for i = 1:size(mappedRxns, 2) + delete([rxnDir filesep 'images' filesep mappedRxns{i} '.png']); + end + + % Generate rinchis and reaction SMILES + if oBabelInstalled + + nRows = size(rxnsToAM, 1); + varTypes = {'string', 'string', 'string'}; + varNames = {'rxns', 'rinchi', 'rsmi'}; + info.reactionsReport.rxnxIDsTable = table('Size', [nRows length(varTypes)], 'VariableTypes', varTypes, 'VariableNames', varNames); + + model.rinchi = repmat({''}, size(model.rxns)); + model.rsmi = repmat({''}, size(model.rxns)); + for i = 1:size(rxnsToAM, 1) + info.reactionsReport.rxnxIDsTable.rxns(i) = rxnsToAM(i); + if isfile([rxnDir filesep 'atomMapped' filesep rxnsToAM{i} '.rxn']) + % Get rinchis + command = ['obabel -irxn ' rxnDir filesep 'atomMapped' filesep rxnsToAM{i} '.rxn -orinchi']; + [~, result] = system(command); + result = split(result); + info.reactionsReport.rxnxIDsTable.rinchi(i) = result{~cellfun(@isempty, regexp(result, 'RInChI='))}; + model.rinchi{findRxnIDs(model, rxnsToAM{i})} = result{~cellfun(@isempty, regexp(result, 'RInChI='))}; + % Get reaction SMILES + command = ['obabel -irxn ' rxnDir filesep 'atomMapped' filesep rxnsToAM{i} '.rxn -osmi']; + [~, result] = system(command); + result = splitlines(result); + result = split(result{end - 2}); + info.reactionsReport.rxnxIDsTable.rsmi(i) = result{1}; + model.rsmi{findRxnIDs(model, rxnsToAM{i}), 1} = result{1}; + end + end + end +end + +% Find unbalanced RXN files +% Get list of RXN files to check +d = dir(rxnsFilesDir); +d = d(~[d.isdir]); +rxnList = {d.name}'; +rxnList = rxnList(~cellfun('isempty', regexp(rxnList,'(\.rxn)$'))); +rxnList = regexprep(rxnList, '.rxn', ''); +rxnList(~ismember(rxnList, rxnsToAM)) = []; + +[unbalancedBool, v3000] = deal(false(size(rxnList))); +for i = 1:size(rxnList, 1) + + name = [rxnList{i} '.rxn']; + % Read the RXN file + rxnFile = regexp(fileread([rxnsFilesDir filesep name]), '\n', 'split')'; + + % Identify molecules + substrates = str2double(rxnFile{5}(1:3)); + products = str2double(rxnFile{5}(4:6)); + begMol = strmatch('$MOL', rxnFile); + + if ~isnan(products) + % Count atoms in substrates and products + atomsS = 0; + for j = 1:substrates + atomsS = atomsS + str2double(rxnFile{begMol(j) + 4}(1:3)); + end + atomsP = 0; + for j = substrates + 1: substrates +products + atomsP = atomsP + str2double(rxnFile{begMol(j) + 4}(1:3)); + end + + % Check if the file is unbalanced + if atomsS ~= atomsP + unbalancedBool(i) = true; + end + else + v3000(i) = true; + end +end + +info.reactionsReport.balancedReactions = rxnList(~unbalancedBool); +info.reactionsReport.unbalancedReactions = rxnList(unbalancedBool); +model = findSExRxnInd(model); +info.reactionsReport.rxnMissing = setdiff(model.rxns(model.SIntRxnBool), info.reactionsReport.rxnFilesWritten); + +metsInBalanced = unique(regexprep(findMetsFromRxns(model, rxnList(~unbalancedBool)), '(\[\w\])', '')); +metsInUnbalanced = unique(regexprep(findMetsFromRxns(model, rxnList(unbalancedBool)), '(\[\w\])', '')); +info.reactionsReport.metsAllwaysInBalancedRxns = umets(ismember(umets, setdiff(metsInBalanced, metsInUnbalanced))); +info.reactionsReport.metsSometimesInUnbalancedRxns = umets(ismember(umets, intersect(metsInBalanced, metsInUnbalanced))); +info.reactionsReport.metsAllwaysInUnbalancedRxns = umets(ismember(umets, setdiff(metsInUnbalanced, metsInBalanced))); +info.reactionsReport.missingMets = setdiff(umets, [metsInBalanced; metsInUnbalanced]); + +info.reactionsReport.table = table([... + size(info.reactionsReport.rxnFilesWritten, 1);... + size(info.reactionsReport.mappedRxns, 1);... + size(info.reactionsReport.balancedReactions, 1);... + size(info.reactionsReport.unbalancedReactions, 1);... + size(info.reactionsReport.rxnMissing, 1);... + size(info.reactionsReport.metsAllwaysInBalancedRxns, 1) + ... + size(info.reactionsReport.metsSometimesInUnbalancedRxns, 1) + ... + size(info.reactionsReport.metsAllwaysInUnbalancedRxns, 1);... + size(info.reactionsReport.metsAllwaysInBalancedRxns, 1) + ... + size(info.reactionsReport.metsSometimesInUnbalancedRxns, 1);... + size(info.reactionsReport.metsAllwaysInUnbalancedRxns, 1);... + size(info.reactionsReport.missingMets, 1)],... + ... + 'VariableNames', ... + {'Var'},... + 'RowNames',... + {'RXN files written'; ... + 'Atom mapped reactions';... + 'Balanced reactions';... + 'Unbalanced reactions';... + 'Missing reactions';... + 'Metabolites obtained'; ... + 'Metabolites in balanced rxns'; ... + 'Metabolites allways in unbalanced rxns'; ... + 'Missing metabolites'}); + +if options.printlevel > 0 + + if ~options.onlyUnmapped + display(info.reactionsReport.rxnxIDsTable) + end + + display(info.reactionsReport.table) + + % Reactions + figure + labelsToAdd = {'Balanced', 'Unbalanced', 'Missing'}; + X = [size(info.reactionsReport.balancedReactions, 1);... + size(info.reactionsReport.unbalancedReactions, 1);... + size(info.reactionsReport.rxnMissing, 1)]; + pieChart = pie(X(find(X))); + title({'RXN coverage', ['From ' num2str(sum(X)) ' internal rxns in the model']}, 'FontSize', 20) + legend(labelsToAdd(find(X)), 'FontSize', 16) + set(findobj(pieChart,'type','text'),'fontsize',18) + + % Metabolites + figure + labelsToAdd = {'In balanced rxn', 'Ocassionally in unbalanced rxn', 'In unbalanced rxn', 'Missing'}; + X = [size(info.reactionsReport.metsAllwaysInBalancedRxns, 1);... + size(info.reactionsReport.metsSometimesInUnbalancedRxns, 1);... + size(info.reactionsReport.metsAllwaysInUnbalancedRxns, 1);... + size(info.reactionsReport.missingMets, 1)]; + pieChart = pie(X(find(X))); + title({'Met percentage coverage', ['From ' num2str(size(umets, 1)) ' unique mets in the model']}, 'FontSize', 20) + legend(labelsToAdd(find(X)), 'FontSize', 16) + set(findobj(pieChart,'type','text'),'fontsize',18) + +end +if options.printlevel > 1 + disp('RXN files written') + display(info.reactionsReport.rxnFilesWritten) + disp('Atom mapped reactions') + display(info.reactionsReport.mappedRxns) + disp('Balanced reactions') + display(info.reactionsReport.balancedReactions) + disp('Unbalanced reactions') + display(info.reactionsReport.unbalancedReactions) + disp('Metabolites allways in balanced rxns') + display(info.reactionsReport.metsAllwaysInBalancedRxns) + disp('Metabolites ocasional in unbalanced rxns') + display(info.reactionsReport.metsSometimesInUnbalancedRxns) + disp('Metabolites allways in unbalanced rxns') + display(info.reactionsReport.metsAllwaysInUnbalancedRxns) + disp('Missing metabolites') + display(info.reactionsReport.missingMets) +end + +if options.debug + save([outputDir '6.debug_endOfreactionDatabase.mat']) +end + +%% 7. Bond enthalpies and bonds broken and formed + +if ~options.onlyUnmapped + + % Get bond enthalpies and bonds broken and formed + if options.printlevel > 0 + display('Obtaining RInChIes and reaction SMILES ...') + [bondsBF, bondsE, meanBBF, meanBE] = findBEandBBF(model, [rxnDir filesep 'atomMapped'], 1); + info.bondsData.bondsDataTable = table(model.rxns, model.rxnNames, bondsBF, bondsE, ... + 'VariableNames', {'rxns', 'rxnNames', 'bondsBF', 'bondsE'}); + info.bondsData.meanBBF = meanBBF; + info.bondsData.meanBE = meanBE; + display(info.bondsData.bondsDataTable) + else + [bondsBF, bondsE, meanBBF, meanBE] = findBEandBBF(model, [rxnDir filesep 'atomMapped']); + info.bondsData.table = table(model.rxns, model.rxnNames, bondsBF, bondsE, ... + 'VariableNames', {'rxns','rxnNames','bondsBF','bondsE'}); + info.bondsData.table = sortrows(info.bondsData.table, {'bondsBF'}, {'descend'}); + info.bondsData.meanBBF = meanBBF; + info.bondsData.meanBE = meanBE; + end + + % Add data in the model + model.bondsBF = bondsBF; + model.bondsE = bondsE; + model.meanBBF = meanBBF; + model.meanBE = meanBE; + +end + +newModel = model; +if options.debug + save([outputDir '7.debug_endOfGenerateChemicalDatabase.mat']) +end + +diary off +if options.printlevel > 0 > 0 + fprintf('%s\n', ['Diary written to: ' options.outputDir]) + fprintf('%s\n', 'generateChemicalDatabase run is complete.') +end + +end + +function reportComparison = consistentData(model, groupedIDs, typeID) +% The most cross-validated ID is saved. It's compared molecular formula of +% the model, the charge and the similarity with other IDs + +% Compare and sort results based on prime numbers. The smallest prime +% number represent the most similar inchis between databases +IDsArray = table2cell(groupedIDs); + +% Start report +reportComparison.groupedID = groupedIDs; +reportComparison.sources = groupedIDs.Properties.VariableNames(2:end)'; +reportComparison.sourcesToSave = cell(size(IDsArray, 1), 1); + +% Delete the Names +metNames = IDsArray(:, 1); +IDsArray(:, 1) = []; +for i = 1:size(IDsArray, 1) + + % 1st comparison - Similarity + emptyBool = cellfun(@isempty, IDsArray(i, 1:end)); + IDsArray(i, emptyBool) = {'noData'}; + [~, ia, ic] = unique(IDsArray(i, 1:end)); + ic(emptyBool) = NaN; + ia(contains(IDsArray(i, ia), 'noData')) = []; + if ~isempty(ia) + ia = sort(ia); + % Acsending values + c = 0; + icAcsending = ic; + for j = 1:size(ia, 1) + if ~isnan(ic(ia(j))) + c = c + 1; + icAcsending(ic == ic(ia(j))) = c; + end + end + comparison(i, :) = icAcsending'; + + % 2nd comparison - cross-validation & chemical formulas comparison & + % InChI data (if is inchi) + + % Cross-validation (assign score) + idsScore = zeros(size(ia, 1), 1); + for j = 1:size(ia, 1) + idsScore(j) = idsScore(j) + (sum(ic == ic(ia(j))) / size(ic, 1)); + end + + % Chemical formula comparison + % Get model formula + metIdx = find(ismember(regexprep(model.mets, '(\[\w\])', ''), groupedIDs.metNames{i})); + rGroup = ["X", "Y", "*", "FULLR"]; + if contains(model.metFormulas(metIdx(1)), rGroup) + modelFormula = editChemicalFormula(model.metFormulas{metIdx(1)}); + else + modelFormula = model.metFormulas{metIdx(1)}; + end + if isfield(model, 'metNames') + reportComparison.(['met_' groupedIDs.metNames{i}]).metNames = model.metNames(metIdx(1)); + end + reportComparison.(['met_' groupedIDs.metNames{i}]).metFormula = {modelFormula}; + % Get ID formula + reportComparison.(['met_' groupedIDs.metNames{i}]).uniqueIdIdx = ia; + for j = 1:size(ia, 1) + consistentID = IDsArray{i, ia(j)}; + + switch typeID + case 'InChI' + [elemetList, ~ , ~] = regexp(consistentID, '/([^/]*)/', 'match'); + if isempty(elemetList) + IDformula = ''; + else + IDformula = regexprep(elemetList{1}, '/', ''); + end + + case 'SMILES' + + % Get formula from MOL + currentDir = pwd; + fid2 = fopen([currentDir filesep 'tmp'], 'w'); + fprintf(fid2, '%s\n', consistentID); + fclose(fid2); + command = 'obabel -ismi tmp -O tmp.mol mol -h'; + [~, ~] = system(command); + molFile = regexp(fileread([currentDir filesep 'tmp.mol']), '\n', 'split')'; + if ~isempty(char(molFile)) + atomsString = []; + for k = 1:str2num(molFile{4}(1:3)) + atomsString = [atomsString strtrim(molFile{4 + k}(32:33))]; + end + IDformula = editChemicalFormula(atomsString); + end + delete([currentDir filesep 'tmp.mol']) + + case 'MOL' + IDformula = consistentID; + end + reportComparison.(['met_' groupedIDs.metNames{i}]).sourceFormula{j, 1} = IDformula; + + % Compare (assign score) + if isequal(modelFormula, IDformula) + idsScore(j) = idsScore(j) + 10; % ten times the scale in cross-validation + elseif isequal(regexprep(modelFormula, 'H\d*', ''), regexprep(IDformula, 'H\d*', '')) % pH different + idsScore(j) = idsScore(j) + 8; + end + + % InChI layers comparison + switch typeID + case 'InChI' + inchiLayersDetail = getInchiData(IDsArray{i, ia(j)}); + layersOfDataInChI(j, 1) = inchiLayersDetail.layers; + idsScore(j) = idsScore(j) + 4 + layersOfDataInChI(j, 1); % scale in formula comparison + reportComparison.(['met_' groupedIDs.metNames{i}]).layersOfDataInChI(j, 1) = ... + layersOfDataInChI(j, 1); + + case 'SMILES' + + fid2 = fopen([currentDir filesep 'tmp'], 'w'); + fprintf(fid2, '%s\n', IDsArray{i, ia(j)}); + fclose(fid2); + command = 'obabel -ismi tmp -O tmp.mol mol -h'; + [~, ~] = system(command); + molFile = regexp(fileread([currentDir filesep 'tmp.mol']), '\n', 'split')'; + molFile = regexprep(molFile, 'X|Y|*|R|A', 'H'); + fid2 = fopen([currentDir filesep 'tmp.mol'], 'w'); + fprintf(fid2, '%s\n', molFile{:}); + fclose(fid2); + % Get inchis of the original metabolites + command = ['obabel -imol ' currentDir filesep 'tmp.mol -oinchi']; + [~, result] = system(command); + result = split(result); + inchiLayersDetail = getInchiData(result{contains(result, 'InChI=1S')}); + layersOfDataInChI(j, 1) = inchiLayersDetail.layers; + idsScore(j) = idsScore(j) + 4 + layersOfDataInChI(j, 1); % scale in formula comparison + reportComparison.(['met_' groupedIDs.metNames{i}]).layersOfDataInChI(j, 1) = ... + layersOfDataInChI(j, 1); + delete([currentDir filesep 'tmp']) + delete([currentDir filesep 'tmp.mol']) + + end + end + + % Continue report + reportComparison.(['met_' groupedIDs.metNames{i}]).ids(:, 1) = IDsArray(i, ia); + reportComparison.(['met_' groupedIDs.metNames{i}]).idsScore = idsScore; + toSaveidx = find(ismember(ic, ic(ia(idsScore == max(idsScore))))); + reportComparison.sourcesToSave{i, :} = strjoin(reportComparison.sources(toSaveidx), ' '); + else + reportComparison.sourcesToSave{i, :} = ''; + end +end +reportComparison.comparison = comparison; +end diff --git a/src/dataIntegration/chemoInformatics/inchi/getInchiData.m b/src/dataIntegration/chemoInformatics/inchi/getInchiData.m new file mode 100644 index 0000000000..14d04cdc36 --- /dev/null +++ b/src/dataIntegration/chemoInformatics/inchi/getInchiData.m @@ -0,0 +1,70 @@ +function inchiLayersDetail = getInchiData(inchi) +% Classify the inchi according to its various layers of information +% +% USAGE: +% +% detailLevelInchi = inchiDetail(inchi) +% +% INPUTS: +% inchi: String with the InChI to classify +% +% OUTPUTS: +% detailLevelInchi: Struct file with the following fields: +% +% * .layers - Number of layers in the InChI. +% * .standart - Logical, indicates whether the inchi +% is standard or not. +% * .metFormulas - The molecula formula. +% * .positiveCharges - Number of positive charges. +% * .negativeCharges - Number of negative charges. +% * .netCharge - Summ of the charges. +% * .stereochemicalLayer - Logical, indicates whether +% the inchi represent +% stereochemical information +% or not. +% * .isotopicLayer - Logical, indicates whether the +% inchi represent isotopic +% information or not. + +inchiSplited = split(inchi, '/'); + +% Check inchi layers +inchiLayersDetail.layers = numel(inchiSplited); + +% Check if it is a standard inchi +assert(contains(inchiSplited{1}, 'InChI='), [inchi ' is not an InChI']) +if contains(inchiSplited{1}, '1S') + inchiLayersDetail.standart = true; +else + inchiLayersDetail.standart = false; +end + +% Chemical formula +inchiLayersDetail.metFormulas = inchiSplited{2}; + +% Charge layer +pLayer = contains(inchiSplited, 'p'); +if any(pLayer) + inchiLayersDetail.positiveCharges = str2double(regexprep(inchiSplited{pLayer}, 'p-|;', '')); +else + inchiLayersDetail.positiveCharges = 0; +end +qLayer = contains(inchiSplited, 'q'); +if any(qLayer) + inchiLayersDetail.negativeCharges = str2double(regexprep(inchiSplited{qLayer}, 'q\+|;', '')); +else + inchiLayersDetail.negativeCharges = 0; +end +inchiLayersDetail.netCharge = inchiLayersDetail.positiveCharges - inchiLayersDetail.negativeCharges; + +% Stereochemical layer +if any(~cellfun(@isempty, regexp(inchiSplited, 'b|t|m|s'))) + inchiLayersDetail.stereochemicalLayer = true; +end + +% Isotopic layer +if any(~cellfun(@isempty, regexp(inchiSplited, 'i|h'))) + inchiLayersDetail.isotopicLayer = true; +end + +end \ No newline at end of file diff --git a/src/dataIntegration/chemoInformatics/obtainAtomMappingsRDT.m b/src/dataIntegration/chemoInformatics/obtainAtomMappingsRDT.m index 5e8ea34b1a..65f96b43bb 100644 --- a/src/dataIntegration/chemoInformatics/obtainAtomMappingsRDT.m +++ b/src/dataIntegration/chemoInformatics/obtainAtomMappingsRDT.m @@ -1,10 +1,13 @@ -function standardisedRxns = obtainAtomMappingsRDT(model, molFileDir, outputDir, rxnsToAM, hMapping, maxTime, standariseRxn) -% Compute atom mappings for reactions with implicit hydrogens in a -% metabolic network using RDT algorithm +function atomMappingReport = obtainAtomMappingsRDT(model, molFileDir, rxnDir, rxnsToAM, hMapping, onlyUnmapped) +% Using the reaction decoder tool, compute atom mappings for reactions in a +% COBRA model. Atom mapping data is presented in a variety of formats, +% including MDL RXN, SMILES, and images. If this option is selected, the +% function can remove all protons from the model and represent the +% reactions as a hydrogen suppressed chemical graph. % % USAGE: % -% standardisedRxns = obtainAtomMappingsRDT(model, molFileDir, outputDir, rxnsToAM, hMapping, maxTime, standariseRxn) +% standardisedRxns = obtainAtomMappingsRDT(model, molFileDir, rxnDir, rxnsToAM, hMapping, maxTime, standariseRxn) % % INPUTS: % model: COBRA model with following fields: @@ -24,16 +27,14 @@ % reaction identifiers in input mets. % % OPTIONAL INPUTS: -% rxnsToAM: List of reactions to atom map (default: all in the +% rxnsToAM: List of reactions to atom map (default: all in the % model). % hMapping: Logic value to select if hydrogen atoms will be atom % mapped (default: TRUE). % rxnDir: Path to directory that will contain the RXN files with % atom mappings (default: current directory). -% maxTime: Maximum time assigned to compute atom mapping (default -% 1800s). -% standariseRxn: Logic value for standardising the atom mapped RXN file. -% ChemAxon license is required (default: TRUE). +% onlyUnmapped: Logic value to select create only unmapped MDL RXN +% files (default: FALSE). % % OUTPUTS: % balancedRxns: List of standadised atom mapped reactions. @@ -56,11 +57,11 @@ % % .. Author: - German A. Preciat Gonzalez 25/05/2017 -if nargin < 3 || isempty(outputDir) - outputDir = [pwd filesep]; +if nargin < 3 || isempty(rxnDir) + rxnDir = [pwd filesep]; else % Make sure input path ends with directory separator - outputDir = [regexprep(outputDir,'(/|\\)$',''), filesep]; + rxnDir = [regexprep(rxnDir,'(/|\\)$',''), filesep]; end if nargin < 4 || isempty(rxnsToAM) rxnsToAM = model.rxns; @@ -68,36 +69,37 @@ if nargin < 5 || isempty(hMapping) hMapping = true; end -if nargin < 6 || isempty(maxTime) - maxTime = 1800; -end -if nargin < 7 || isempty(standariseRxn) - standariseRxn = true; -end -if exist('rtdDir','var') - rtdDir = [pwd filesep]; -else - % Make sure input path ends with directory separator - rtdDir = [regexprep(rdtDir,'(/|\\)$',''), filesep]; +if nargin < 6 || isempty(onlyUnmapped) + onlyUnmapped = false; end + +maxTime = 1800; + +% Check if JAVA is installed +[javaInstalled, ~] = system('java'); + % Generating new directories -if ~exist([outputDir filesep 'rxnFiles'],'dir') - mkdir([outputDir filesep 'rxnFiles']) +if ~exist([rxnDir filesep 'unMapped'],'dir') + mkdir([rxnDir filesep 'unMapped']) end -if ~exist([outputDir filesep 'atomMapped'],'dir') - mkdir([outputDir filesep 'atomMapped']) -end -if ~exist([outputDir filesep 'images'],'dir') - mkdir([outputDir filesep 'images']) -end -if ~exist([outputDir filesep 'txtData'],'dir') - mkdir([outputDir filesep 'txtData']) +if javaInstalled && ~onlyUnmapped + if ~exist([rxnDir filesep 'atomMapped'],'dir') + mkdir([rxnDir filesep 'atomMapped']) + end + if ~exist([rxnDir filesep 'images'],'dir') + mkdir([rxnDir filesep 'images']) + end + if ~exist([rxnDir filesep 'txtData'],'dir') + mkdir([rxnDir filesep 'txtData']) + end end % Download the RDT algorithm, if it is not present in the output directory -if exist([rdtDir filesep 'rdtAlgorithm.jar'])~=2 - urlwrite('https://github.com/asad/ReactionDecoder/releases/download/v2.1.0/rdt-2.1.0-SNAPSHOT-jar-with-dependencies.jar',[rdtDir filesep 'rdtAlgorithm.jar']); - %urlwrite('https://github.com/asad/ReactionDecoder/releases/download/1.5.1/rdt-1.5.1-SNAPSHOT-jar-with-dependencies.jar',[outputDir filesep 'rdtAlgorithm.jar']); +if exist([rxnDir filesep 'rdtAlgorithm.jar']) ~= 2 && javaInstalled && ~onlyUnmapped + urlwrite('https://github.com/asad/ReactionDecoder/releases/download/v2.4.1/rdt-2.4.1-jar-with-dependencies.jar',[rxnDir filesep 'rdtAlgorithm.jar']); + % Previous releases: + % urlwrite('https://github.com/asad/ReactionDecoder/releases/download/v2.1.0/rdt-2.1.0-SNAPSHOT-jar-with-dependencies.jar',[outputDir filesep 'rdtAlgorithm.jar']); + % urlwrite('https://github.com/asad/ReactionDecoder/releases/download/1.5.1/rdt-1.5.1-SNAPSHOT-jar-with-dependencies.jar',[outputDir filesep 'rdtAlgorithm.jar']); end % Delete the protons (hydrogens) for the metabolic network @@ -114,20 +116,20 @@ model.S = S; end - % Format inputs mets = model.mets; fmets = regexprep(mets, '(\[\w\])', ''); rxns = rxnsToAM; +rxnsInModel = model.rxns; clear model % Get list of MOL files d = dir(molFileDir); d = d(~[d.isdir]); aMets = {d.name}'; -aMets = aMets(~cellfun('isempty',regexp(aMets,'(\.mol)$'))); +aMets = aMets(~cellfun('isempty', regexp(aMets,'(\.mol)$'))); % Identifiers for atom mapped reactions -aMets = regexprep(aMets, '(\.mol)$',''); +aMets = regexprep(aMets, '(\.mol)$', ''); assert(~isempty(aMets), 'MOL files directory is empty or nonexistent.'); % Extract MOL files @@ -140,72 +142,203 @@ % Create the RXN files. Three conditions are required: 1) To have all the % MOL files in the reaction, 2) No exchange reactions, 3) Only integers in % the stoichiometry -for i=1:length(rxns) - a = ismember(regexprep(mets(find(S(:,i))), '(\[\w\])', ''), aMets); - s = S(find(S(:, i)), i); - if all(a(:) > 0) && length(a) ~= 1 && all(abs(round(s) - s) < (1e-2)) - writeRxnfile(S(:, i), mets, fmets, molFileDir, rxns{i}, [outputDir... - filesep 'rxnFiles' filesep]) +rxnFilesWrittenBool = false(length(rxns), 1); +for i = 1:length(rxns) + rxnBool = ismember(rxnsInModel, rxns{i}); + metsInRxns = ismember(fmets(find(S(:, rxnBool))), aMets); + stoichiometry = S(find(S(:, rxnBool)), rxnBool); + if ~any(~metsInRxns) && length(metsInRxns) > 1 && all(abs(round(stoichiometry) - stoichiometry) < (1e-2)) + writeRxnfile(S(:, rxnBool), mets, fmets, molFileDir, rxns{i}, [rxnDir... + filesep 'unMapped' filesep]) + rxnFilesWrittenBool(i) = true; end end +atomMappingReport.rxnFilesWritten = rxns(rxnFilesWrittenBool); + +% Get list of new RXN files +d = dir([rxnDir filesep 'unMapped' filesep]); +d = d(~[d.isdir]); +aRxns = regexprep({d.name}', '.rxn', ''); +assert(~isempty(aRxns), 'No rxn file was written.'); +rxnsToAM = rxnsToAM(ismember(rxnsToAM, aRxns)); + +mappedBool = false(length(rxnsToAM), 1); % Atom map RXN files -fnames = dir([outputDir filesep 'rxnFiles' filesep '*.rxn']); -fprintf('Computing atom mappings for %d reactions.\n\n', length(fnames)); - -% Start from the lighter RXN to the heavier -[~,bytes] = sort([fnames.bytes]); -counterBalanced = 0; -counterNotMapped = 0; -counterUnbalanced = 0; -for i=1:length(fnames) - name = [outputDir 'rxnFiles' filesep fnames(bytes(i)).name]; - command = ['timeout ' num2str(maxTime) 's java -jar ' rdtDir filesep 'rdtAlgorithm.jar -Q RXN -q "' name '" -g -j AAM -f TEXT']; - if ismac - command = ['g' command]; - end - [status, result] = system(command); - if status ~= 0 - fprintf(result); - error('Command %s could not be run.\n', command); +if javaInstalled == 1 && ~onlyUnmapped + fprintf('Computing atom mappings for %d reactions.\n\n', length(rxnsToAM)); + for i = 1:length(rxnsToAM) + + name = [rxnDir 'unMapped' filesep rxnsToAM{i} '.rxn']; + command = ['timeout ' num2str(maxTime) 's java -jar ' rxnDir 'rdtAlgorithm.jar -Q RXN -q "' name '" -g -j AAM -f TEXT']; + + if ismac + command = ['g' command]; + end + [status, result] = system(command); + if contains(result, 'file not found!') + warning(['The file ' name ' was not found']) + end + if ~status + fprintf(result); + error('Command %s could not be run.\n', command); + end + mNames = dir('ECBLAST_*'); + if length(mNames) == 3 + name = regexprep({mNames.name}, 'ECBLAST_|_AAM', ''); + cellfun(@movefile, {mNames.name}, name) + cellfun(@movefile, name, {[rxnDir 'images'], [rxnDir... + 'atomMapped'], [rxnDir 'txtData']}) + mappedBool(i) = true; + elseif ~isempty(mNames) + delete(mNames.name) + end + end - mNames = dir('ECBLAST_*'); - if length(mNames) == 3 - name = regexprep({mNames.name}, 'ECBLAST_|_AAM', ''); - cellfun(@movefile, {mNames.name}, name) - cellfun(@movefile, name, {[outputDir 'images'], [outputDir... - 'atomMapped'], [outputDir 'txtData']}) - elseif ~isempty(mNames) - delete(mNames.name) - counterNotMapped = counterNotMapped + 1; - else - counterNotMapped = counterNotMapped + 1; - end -end - -% Standarize reactions -if standariseRxn == true - fnames = dir([outputDir filesep 'atomMapped' filesep '*.rxn']); - for i = 1:length(fnames) - standardised = canonicalRxn(fnames(i).name, [outputDir... - 'atomMapped'], [outputDir 'rxnFiles']); - if standardised - counterBalanced = counterBalanced + 1; - standardisedRxns{counterBalanced} = regexprep(fnames(i).name, '.rxn', ''); - else - counterUnbalanced = counterUnbalanced + 1; + mappedRxns = rxnsToAM(mappedBool); + atomMappingReport.mappedRxns = mappedRxns; + + delete([rxnDir 'rdtAlgorithm.jar']) + + for i = 1:length(mappedRxns) + + name = [mappedRxns{i} '.rxn']; + + % Add header + mappedFile = regexp(fileread([rxnDir 'atomMapped' filesep name]), '\n', 'split')'; + standardFile = regexp(fileread([rxnDir 'unMapped' filesep name]), '\n', 'split')'; + mappedFile{2} = standardFile{2}; + mappedFile{3} = ['COBRA Toolbox v3.0 - Atom mapped - ' datestr(datetime)]; + mappedFile{4} = standardFile{4}; + + formula = strsplit(mappedFile{4}, {'->', '<=>'}); + + substratesFormula = strtrim(strsplit(formula{1}, '+')); + % Check if a metabolite is repeated in the substrates formula + repMetsSubInx = find(~cellfun(@isempty, regexp(substratesFormula, ' '))); + if ~isempty(repMetsSubInx) + for j = 1:length(repMetsSubInx) + metRep = strsplit(substratesFormula{repMetsSubInx(j)}); + timesRep = str2double(metRep{1}); + metRep = metRep{2}; + substratesFormula{repMetsSubInx(j)} = strjoin(repmat({metRep}, [1 timesRep])); + end + substratesFormula = strsplit(strjoin(substratesFormula)); + end + + productsFormula = strtrim(strsplit(formula{2}, '+')); + % Check if a metabolite is repeated in the products formula + repMetsProInx = find(~cellfun(@isempty, regexp(productsFormula, ' '))); + if ~isempty(repMetsProInx) + for j = 1:length(repMetsProInx) + metRep = strsplit(productsFormula{repMetsProInx(j)}); + timesRep = str2double(metRep{1}); + metRep = metRep{2}; + productsFormula{repMetsProInx(j)} = strjoin(repmat({metRep}, [1 timesRep])); + end + productsFormula = strsplit(strjoin(productsFormula)); end + + % RXN file data + begmol = strmatch('$MOL', mappedFile); + noOfMolSubstrates = str2double(mappedFile{5}(1:3)); + substratesMol = mappedFile(begmol(1:noOfMolSubstrates) + 1)'; + noOfMolProducts = str2double(mappedFile{5}(4:6)); + productsMol = mappedFile(begmol(noOfMolSubstrates + 1:noOfMolSubstrates + noOfMolProducts) + 1)'; + + % Formula data + noOfsubstrates = numel(substratesFormula); + noOfproducts = numel(productsFormula); + + % Check if the stoichemestry is correct + if ~isequal(noOfsubstrates, substratesMol) || ~isequal(noOfproducts, productsMol) + mappedFile = sortMets(mappedFile, substratesMol, substratesFormula, productsMol, productsFormula, rxnDir); + end + % Rewrite the file + fid2 = fopen([rxnDir 'atomMapped' filesep name], 'w'); + fprintf(fid2, '%s\n', mappedFile{:}); + fclose(fid2); end else - standardisedRxns = []; - counterUnbalanced = length(dir([outputDir 'atomMapped' filesep '*.rxn'])); + atomMappingReport.mappedRxns = []; end -fprintf('\n%d reactions were atom mapped\n', length(dir([outputDir 'atomMapped' filesep '*.rxn']))); -fprintf('%d reactions are not standardised\n', counterUnbalanced); -fprintf('%d reactions were not mapped\n\n\n', counterNotMapped); +% fprintf('\n%d reactions were atom mapped\n', length(dir([outputDir 'atomMapped' filesep '*.rxn']))); +% fprintf('%d reactions are not standardised\n', counterUnbalanced); +% fprintf('%d reactions were not mapped\n\n\n', counterNotMapped); +% +% fprintf('RDT algorithm was developed by:\n'); +% fprintf('SA Rahman et al.: Reaction Decoder Tool (RDT): Extracting Features from Chemical\n'); +% fprintf('Reactions, Bioinformatics (2016), doi: 10.1093/bioinformatics/btw096\n'); +end + + +function newFile = sortMets(mappedFile, substratesMol, substratesFormula, productsMol, productsFormula, outputDir) +% Function to sort the metabolites as in the model's stoichiometry -fprintf('RDT algorithm was developed by:\n'); -fprintf('SA Rahman et al.: Reaction Decoder Tool (RDT): Extracting Features from Chemical\n'); -fprintf('Reactions, Bioinformatics (2016), doi: 10.1093/bioinformatics/btw096\n'); +begmol = strmatch('$MOL', mappedFile); + +% Check if bondless atoms were divided +if numel(substratesFormula) ~= numel(substratesMol) || numel(productsFormula) ~= numel(productsMol) + + if ~exist([outputDir filesep 'atomMapped' filesep 'toFix'],'dir') + mkdir([outputDir filesep 'atomMapped' filesep 'toFix']) + end + copyfile([outputDir filesep 'atomMapped' filesep mappedFile{2} '.rxn'], [outputDir filesep 'atomMapped' filesep 'toFix']) + newFile(1:5, 1) = mappedFile(1:5); +else + + newFile(1:5, 1) = mappedFile(1:5); + + %%% Sort substrates + [~,idm] = sort(substratesMol); + [~,ids] = sort(substratesFormula); + [~,ids] = sort(ids); + indexes = idm(ids); + + % Save each metabolite + for k = 1:numel(substratesFormula) + lineInMol = 1; + eval(sprintf('molS%d{%d} = mappedFile{begmol(%d)};', k, lineInMol, k)) + while ~isequal(mappedFile{begmol(k) + lineInMol}, 'M END') + eval(sprintf('molS%d{%d + 1} = mappedFile{begmol(%d) + %d};', k, lineInMol, k, lineInMol)) + lineInMol = lineInMol + 1; + end + eval(sprintf('molS%d{%d + 1} = ''M END'';', k, lineInMol)) + end + % From the start of the mol files + c = 5; + for k = 1:numel(substratesFormula) + eval(sprintf('noOfLines = numel(molS%d);', indexes(k))) + for j = 1:noOfLines + c = c + 1; + eval(sprintf('newFile{%d} = molS%d{%d};', c, indexes(k), j)) + end + end + + %%% Sort products + [~,idmp] = sort(productsMol); + [~,idp] = sort(productsFormula); + [~,idp] = sort(idp); + indexes = idmp(idp); + + for i = numel(substratesFormula) + 1:numel(substratesFormula) + numel(productsFormula) + lineInMol=1; + eval(sprintf('molP%d{%d} = mappedFile{begmol(%d)};', i - numel(substratesFormula), lineInMol, i)) + while ~isequal(mappedFile{begmol(i) + lineInMol}, 'M END') + eval(sprintf('molP%d{%d + 1} = mappedFile{begmol(%d) + %d};', i - numel(substratesFormula), lineInMol, i, lineInMol)) + lineInMol = lineInMol + 1; + end + eval(sprintf('molP%d{%d + 1} = ''M END'';', i - numel(substratesFormula), lineInMol)) + end + for i = numel(substratesFormula) + 1:numel(substratesFormula) + numel(productsFormula) + molName = regexprep(productsFormula{i - numel(substratesFormula)}, '\[|\]', '_'); + eval(sprintf('noOfLines = numel(molP%d);', indexes(i - numel(substratesFormula)))) + for j = 1:noOfLines + c = c + 1; + eval(sprintf('newFile{%d} = molP%d{%d};', c, indexes(i - numel(substratesFormula)), j)) + end + end +end +end \ No newline at end of file diff --git a/src/dataIntegration/chemoInformatics/obtainMetStructures.m b/src/dataIntegration/chemoInformatics/obtainMetStructures.m new file mode 100644 index 0000000000..285317ba26 --- /dev/null +++ b/src/dataIntegration/chemoInformatics/obtainMetStructures.m @@ -0,0 +1,379 @@ +function molCollectionReport = obtainMetStructures(model, outputDir, updateDB, standardisationApproach, orderOfPreference) +% Obtain MDL MOL files from various databases, including KEGG, HMDB, ChEBI, +% and PubChem. Alternatively, openBabel can be used to convert InChI +% strings or SMILES in MDL MOL files. +% +% USAGE: +% +% missingMolFiles = obtainMetStructures(model, outputDir, updateDB, standardisationApproach, orderOfPreference) +% +% INPUTS: +% model: COBRA model with following fields: +% +% * .S - The m x n stoichiometric matrix for the +% metabolic network. +% * .mets - An m x 1 array of metabolite identifiers. +% * .metInChIString - An m x 1 array of metabolite identifiers. +% * .metSmiles - An m x 1 array of metabolite identifiers. +% * .metVMHID - An m x 1 array of metabolite identifiers. +% * .metCHEBIID - An m x 1 array of metabolite identifiers. +% * .metKEGGID - An m x 1 array of metabolite identifiers. +% * .metPubChemID - An m x 1 array of metabolite identifiers. +% * .metHMDBID - An m x 1 array of metabolite identifiers. +% +% OPTIONAL INPUTS: +% outputDir: Path to directory that will contain the MOL files +% (default: current directory). +% updateDB: Logical value idicating if the database will be +% updated or not. If it's true, "outputDir" should +% contain an existing database (default: false). +% standardisationApproach: String contianing the type of standarization for +% the moldecules (default: empty) +% * explicitH - Normal chemical graphs. +% * implicitH - Hydrogen suppressed chemical +% graphs. +% * Neutral - Chemical graphs with protonated +% molecules. +% * basic - Adding the header. +% orderOfPreference: Vector indicating the source of preference +% (default: 1:7) +% 1.- VMH (http://vmh.life/) +% 2.- InChI (requires openBabel) +% 3.- Smiles (requires openBabel) +% 4.- KEGG (https://www.genome.jp/) +% 5.- HMDB (https://hmdb.ca/) +% 6.- PubChem (https://pubchem.ncbi.nlm.nih.gov/) +% 7.- CHEBI (https://www.ebi.ac.uk/) +% +% OUTPUTS: +% missingMolFiles: List of missing MOL files +% nonStandardised: List of non-standardised MDL MOL file. + +if nargin < 2 || isempty(outputDir) + outputDir = [pwd filesep]; +else + % Make sure input path ends with directory separator + outputDir = [regexprep(outputDir,'(/|\\)$',''), filesep]; +end +if nargin < 3 + updateDB = false; +end +if nargin < 4 + standardisationApproach = []; +end +if nargin < 5 + orderOfPreference = 1:7; +end + +[oBabelInstalled, ~] = system('obabel'); +webTimeout = weboptions('Timeout', 30); + +% Set directories +if exist([outputDir 'newMol'], 'dir') == 0 + mkdir([outputDir 'newMol']) +end +newMolFilesDir = [outputDir 'newMol' filesep]; +if updateDB + if exist([outputDir 'met' filesep standardisationApproach filesep], 'dir') ~= 0 + modelMets = regexprep(model.mets,'(\[\w\])',''); + fnames = dir([newMolFilesDir '*.mol']); + model = removeMetabolites(model, model.mets(~ismember(modelMets, setdiff(modelMets, split([fnames(:).name], '.mol'))))); + else + display('Directory with MOL files was not found to be updated in:') + display([outputDir 'met' filesep standardisationApproach filesep]) + display('A new database will be created') + end +end + +%% Obtain met data + +% Obtain ID's +fields = fieldnames(model); +% inchi +inchiFieldBool = ~cellfun(@isempty, regexpi(fields, 'inchi')); +if any(inchiFieldBool) + inchis = model.(fields{inchiFieldBool}); +end +% SMILES +smilesFieldBool = ~cellfun(@isempty, regexpi(fields, 'smiles')); +if any(smilesFieldBool) + smiles = model.(fields{smilesFieldBool}); +end +% HMDB +hmdbFieldBool = ~cellfun(@isempty, regexpi(fields, 'hmdb')); +if any(hmdbFieldBool) + hmdbIDs = model.(fields{hmdbFieldBool}); +end +% KEGG +keggFieldBool = ~cellfun(@isempty, regexpi(fields, 'kegg')); +if any(keggFieldBool) + if sum(keggFieldBool) > 1 + metFieldBool = ~cellfun(@isempty, regexpi(fields, 'met')); + keggFieldBool = keggFieldBool & metFieldBool; + end + keggIDs = model.(fields{keggFieldBool}); +end +% PubChem +PubChemFieldBool = ~cellfun(@isempty, regexpi(fields, 'PubChem')); +if any(PubChemFieldBool) + PubChemIDs = model.(fields{PubChemFieldBool}); +end +% chebi +chebiFieldBool = ~cellfun(@isempty, regexpi(fields, 'chebi')); +if any(chebiFieldBool) + chebiIDs = model.(fields{chebiFieldBool}); +end + +%% Obtain met structures + +% Unique metabolites idexes +[umets, ia] = unique(regexprep(model.mets, '(\[\w\])', '')); +% umets = model.mets; +% ia = 1:numel(model.mets); + +missingMetBool = true(length(umets), 1); +% Obtain MDL MOL files +idsToCheck = {}; +for i = 1:length(umets) + for j = 1:7 + switch orderOfPreference(j) + + case 1 + % VMH + % if prod(~isnan(VMH{metIdxs(i)})) && ~isempty(VMH{metIdxs(i)}) && exist('VMH', 'var') && missing + % + % end + + case 2 % inchi + if prod(~isnan(inchis{ia(i)})) && ~isempty(inchis{ia(i)}) && oBabelInstalled && missingMetBool(i) + try + fid2 = fopen([outputDir 'tmp'], 'w'); + fprintf(fid2, '%s\n', inchis{ia(i)}); + fclose(fid2); + command = ['obabel -iinchi ' outputDir 'tmp -O ' newMolFilesDir umets{i} '.mol mol']; + [status, cmdout] = system(command); + if contains(cmdout, '1 molecule converted') + missingMetBool(i) = false; + end + delete([outputDir 'tmp']) + catch ME + disp(ME.message) + idsToCheck(end + 1, 1) = inchis(ia(i)); + end + end + + case 3 % Smiles + if prod(~isnan(smiles{ia(i)})) && ~isempty(smiles{ia(i)}) && oBabelInstalled && missingMetBool(i) + try + fid2 = fopen([outputDir 'tmp'], 'w'); + fprintf(fid2, '%s\n', smiles{ia(i)}); + fclose(fid2); + command = ['obabel -ismi ' outputDir 'tmp -O ' newMolFilesDir umets{i} '.mol mol']; + [status,cmdout] = system(command); + if status == 0 + missingMetBool(i) = false; + end + delete([outputDir 'tmp']) + catch ME + disp(ME.message) + idsToCheck(end + 1, 1) = smiles(ia(i)); + end + end + + case 4 % KEGG + if prod(~isnan(keggIDs{ia(i)})) && ~isempty(keggIDs{ia(i)}) && missingMetBool(i) + try + switch keggIDs{ia(i)}(1) + case 'C' + molFile = webread(['https://www.genome.jp/dbget-bin/www_bget?-f+m+compound+' keggIDs{ia(i)}], webTimeout); + case 'D' + molFile = webread(['https://www.kegg.jp/dbget-bin/www_bget?-f+m+drug+' keggIDs{ia(i)}], webTimeout); + end + if ~isempty(regexp(molFile, 'M END')) + fid2 = fopen([newMolFilesDir umets{i} '.mol'], 'w'); + fprintf(fid2, '%s\n', molFile); + fclose(fid2); + missingMetBool(i) = false; + end + catch ME + disp(ME.message) + idsToCheck(end + 1, 1) = keggIDs(ia(i)); + end + end + + case 5 % HMDB + if prod(~isnan(hmdbIDs{ia(i)})) && ~isempty(hmdbIDs{ia(i)}) && missingMetBool(i) + try + numbersID = hmdbIDs{ia(i)}(5:end); + if size(numbersID, 2) < 7 + numbersID = [repelem('0', 7 - size(numbersID, 2)) numbersID]; + end + molFile = webread(['https://hmdb.ca/structures/metabolites/HMDB' numbersID '.mol'], webTimeout); + if ~isempty(regexp(molFile, 'M END')) + fid2 = fopen([newMolFilesDir umets{i} '.mol'], 'w'); + fprintf(fid2, '%s\n', molFile); + fclose(fid2); + missingMetBool(i) = false; + end + catch ME + disp(ME.message) + idsToCheck(end + 1, 1) = hmdbIDs(ia(i)); + end + end + + case 6 % PubChem + if prod(~isnan(PubChemIDs{ia(i)})) && ~isempty(PubChemIDs{ia(i)}) && missingMetBool(i) + try + molFile = webread(['https://pubchem.ncbi.nlm.nih.gov/rest/pug/compound/CID/'... + num2str(PubChemIDs{ia(i)}) ... + '/record/SDF/?record_type=2d&response_type=display'], webTimeout); + % Delete all after 'M END' from the SDF filte to + % make it MOL file + if ~isempty(regexp(molFile, 'M END')) + molFile(regexp(molFile, 'M END') + 6:end) = []; + fid2 = fopen([newMolFilesDir umets{i} '.mol'], 'w'); + fprintf(fid2, '%s\n', molFile); + fclose(fid2); + missingMetBool(i) = false; + end + catch ME + disp(ME.message) + idsToCheck(end + 1, 1) = PubChemIDs(ia(i)); + end + end + + case 7 % ChEBI + if prod(~isnan(chebiIDs{ia(i)})) && ~isempty(chebiIDs{ia(i)}) && missingMetBool(i) + try + molFile = webread(['https://www.ebi.ac.uk/chebi/saveStructure.do?defaultImage=true&chebiId=' num2str(chebiIDs{ia(i)}) '&imageId=0'], webTimeout); + if ~isempty(regexp(molFile, 'M END')) + fid2 = fopen([newMolFilesDir umets{i} '.mol'], 'w'); + fprintf(fid2, '%s\n', molFile); + fclose(fid2); + missingMetBool(i) = false; + end + catch ME + disp(ME.message) + idsToCheck(end + 1, 1) = chebiIDs(ia(i)); + end + end + end + end +end + +%% Standardise Mol Files + +if ~isempty(standardisationApproach) + + % Set up directories + switch standardisationApproach + case 'explicitH' + standardisedDir = [outputDir 'explicitH' filesep]; + case 'implicitH' + standardisedDir = [outputDir 'implicitH' filesep]; + case 'protonated' + standardisedDir = [outputDir 'protonated' filesep]; + otherwise + standardisationApproach = 'basic'; + standardisedDir = molDir; + end + + % Standardise files + umets(missingMetBool) = []; + standardisationReport = standardiseMolDatabase(tmpDir, umets, standardisedDir, standardisationApproach); + + % Get SMILES and InChIs + if isfield(standardisationReport, 'SMILES') + SMILES = standardisationReport.SMILES; + else + SMILES = ''; + end + if isfield(standardisationReport, 'InChIs') + InChIs = standardisationReport.InChIs; + else + InChIs = ''; + end + % Delete empty cells + InChIs(cellfun(@isempty, InChIs)) = []; + SMILES(cellfun(@isempty, SMILES)) = []; + + if updateDB && ~isempty(InChIs) && ~isempty(SMILES) + + % For InChIs + if isfile([standardisedDir 'InChIs']) + % Merge old and new InChIs + InChIsFile = regexp( fileread([standardisedDir 'InChIs']), '\n', 'split')'; + InChIsFile(cellfun(@isempty, InChIsFile)) = []; + InChIsFileSp = split(InChIsFile, ' - '); + smilesSp = split(InChIs, ' - '); + mergedSmiles(:, 2) = unique([InChIsFileSp(:, 2); smilesSp(:, 2)]); + mergedSmiles(ismember(mergedSmiles(:, 2), smilesSp(:, 2)), 1) = smilesSp(:, 2); + mergedSmiles(ismember(mergedSmiles(:, 2), InChIsFileSp(:, 2)), 1) = InChIsFileSp(:, 2); + mergedSmiles = strcat(mergedSmiles(:, 1), {' - '}, mergedSmiles(:, 2)); + % Write InChIs + fid2 = fopen([standardisedDir 'InChIs'], 'w'); + fprintf(fid2, '%s\n', mergedSmiles{:}); + fclose(fid2); + else + % Write InChIs + fid2 = fopen([standardisedDir 'InChIs'], 'w'); + fprintf(fid2, '%s\n', InChIs{:}); + fclose(fid2); + end + + % For SMILES + if isfile([standardisedDir 'SMILES']) + % Merge old and new InChIs + smilesFile = regexp( fileread([standardisedDir 'SMILES']), '\n', 'split')'; + smilesFile(cellfun(@isempty, smilesFile)) = []; + smilesFileSp = split(smilesFile, ' - '); + smilesSp = split(SMILES, ' - '); + mergedSmiles(:, 2) = unique([smilesFileSp(:, 2); smilesSp(:, 2)]); + mergedSmiles(ismember(mergedSmiles(:, 2), smilesSp(:, 2)), 1) = smilesSp(:, 2); + mergedSmiles(ismember(mergedSmiles(:, 2), smilesFileSp(:, 2)), 1) = smilesFileSp(:, 2); + mergedSmiles = strcat(mergedSmiles(:, 1), {' - '}, mergedSmiles(:, 2)); + % Write InChIs + fid2 = fopen([standardisedDir 'SMILES'], 'w'); + fprintf(fid2, '%s\n', mergedSmiles{:}); + fclose(fid2); + else + % Write InChIs + fid2 = fopen([standardisedDir 'SMILES'], 'w'); + fprintf(fid2, '%s\n', SMILES{:}); + fclose(fid2); + end + + else + % Write InChIs + fid2 = fopen([standardisedDir 'InChIs'], 'w'); + fprintf(fid2, '%s\n', InChIs{:}); + fclose(fid2); + % Write SMILES + fid2 = fopen([standardisedDir 'SMILES'], 'w'); + fprintf(fid2, '%s\n', SMILES{:}); + fclose(fid2); + end +end + +%% Report + +% Make report +molCollectionReport.noOfMets = size(umets, 1); +molCollectionReport.noOfMetsWithMol = sum(~missingMetBool); +molCollectionReport.noOfMetsWithoutMol = sum(missingMetBool); +molCollectionReport.coverage = (molCollectionReport.noOfMetsWithMol * 100) / molCollectionReport.noOfMets; + +% Check standardised data +if ~isempty(standardisationApproach) + nRows = size(standardisationReport.SMILES, 1); + varTypes = {'string', 'string', 'string', 'string'}; + varNames = {'mets', 'InChIKeys', 'InChIs', 'SMILES'}; + molCollectionReport.standardisationReport = table('Size', [nRows length(varTypes)], 'VariableTypes', varTypes, 'VariableNames', varNames); + molCollectionReport.standardisationApproach = standardisationApproach; + molCollectionReport.standardisationReport(1:end) = standardisationReport.standardised; + molCollectionReport.standardisationReport.InChIKeys(1:size(standardisationReport.InChIKeys, 1)) = standardisationReport.InChIKeys; + molCollectionReport.standardisationReport.InChIs(1:size(standardisationReport.InChIs, 1)) = standardisationReport.InChIs; + molCollectionReport.standardisationReport.SMILES(1:size(standardisationReport.SMILES, 1)) = standardisationReport.SMILES; +end + +end \ No newline at end of file diff --git a/src/dataIntegration/chemoInformatics/standardiseMolDatabase.m b/src/dataIntegration/chemoInformatics/standardiseMolDatabase.m new file mode 100644 index 0000000000..e49af35f31 --- /dev/null +++ b/src/dataIntegration/chemoInformatics/standardiseMolDatabase.m @@ -0,0 +1,212 @@ +function standardisationReport = standardiseMolDatabase(molDir, metList, standardisedDir, standardisationApproach) +% Standardize an MDL MOL file directory by representing the reaction using +% normal chemical graphs, hydrogen suppressed chemical graphs, and chemical +% graphs with protonated molecules. The function also updates the header +% with the standardization information. It makes use of ChemAxon's +% standardizer and openBabel. +% +% USAGE: +% +% [standardised, nonStandardised, InChIs, SMILES] = standardiseMolDatabase(molDir, standardisedDir, standardiseMolFiles) +% +% INPUTS: +% molDir: Path to directory that contain the MDL MOL files +% to be standardised. +% +% OPTIONAL INPUTS: +% metList: 1 x n lest of metabolites to standardise +% standardisedDir Path to directory that will contain the +% standardised MDL MOL files (default: current +% directory). +% standardisationApproach: String contianing the type of standarization for +% the moldecules (default: 'explicitH' if +% openBabel is installed, otherwise 'basic') +% * explicitH - Normal chemical graphs. +% * implicitH - Hydrogen suppressed chemical +% graphs. +% * neutral - Chemical graphs with protonated +% molecules. +% * basic - Updating the header. +% +% OUTPUTS: +% A standardised molecular structures database +% standardisationReport: Struct array with the standarization report +% * standardised +% * nonStandardised +% * InChIs +% * SMILES +% * InChIKeys +% +% .. Author: - German Preciat 25/06/2020 + + +molDir = [regexprep(molDir,'(/|\\)$',''), filesep]; +if nargin < 2 || isempty(metList) + metList = []; +end +if nargin < 3 || isempty(standardisedDir) + standardisedDir = [pwd filesep]; +else + % Make sure input path ends with directory separator + standardisedDir = [regexprep(standardisedDir,'(/|\\)$',''), filesep]; +end +% Check if openBabel is installed +if nargin < 4 || isempty(standardisationApproach) + standardisationApproach = 'explicitH'; +end + +% Check if chemAxon and OpenBabel are installed +[oBabelInstalled, ~] = system('obabel'); +[marvinInstalled, ~] = system('cxcalc'); +if marvinInstalled ~= 0 + marvinInstalled = false; +end +if oBabelInstalled ~= 1 + oBabelInstalled = false; + standardisationApproach = 'basic'; +end + +% Assign directories and create them +standardisedMolFiles = [standardisedDir 'molFiles' filesep]; +if marvinInstalled + standardisedImages = [standardisedDir 'images' filesep]; +end +if ~exist(standardisedMolFiles, 'dir') + mkdir(standardisedMolFiles) + if marvinInstalled + mkdir(standardisedImages) + end +end + +% The new MOL files are readed +% Get list of MOL files +d = dir(molDir); +d = d(~[d.isdir]); +aMets = {d.name}'; +aMets = aMets(~cellfun('isempty', regexp(aMets,'(\.mol)$'))); +if ~isempty(metList) + aMets = aMets(ismember(regexprep(aMets, '.mol', ''), metList)); +end + +fprintf('\n Standardizing %d MOL files ... \n', size(aMets, 1)); + +y = 0; +n = 0; +nonStandardised = []; +InChIs = []; +InChIKeys = []; +for i = 1:size(aMets, 1) +% try + name = aMets{i}; + + if oBabelInstalled + + % Obtain SMILES + command = ['obabel -imol ' molDir name ' -osmiles']; + [~, cmdout] = system(command); + cmdout = splitlines(cmdout); + cmdout = split(cmdout{end - 2}); + smiles = cmdout{1}; + SMILES{i, 1} = smiles; + + % Obtain inChIKey and InChI + % inChIKey + command = ['obabel -imol ' molDir name ' -oinchikey']; + [~, cmdout] = system(command); + cmdout = split(cmdout); + inchikeyIdx = find(cellfun(@numel, cmdout) == 27); + if ~isempty(inchikeyIdx) + InChIKey = ['InChIKey=' cmdout{inchikeyIdx}]; + InChIKeys{i, 1} = InChIKey; + else + InChIKey = ''; + InChIKeys{i, 1} = {''}; + end + % InChI + command = ['obabel -imol ' molDir name ' -oinchi']; + [~, cmdout] = system(command); + cmdout = split(cmdout); + if any(contains(cmdout,'InChI=1S')) + InChIs{i, 1} = cmdout{contains(cmdout,'InChI=1S')}; + fid2 = fopen('tmp', 'w'); + fprintf(fid2, '%s\n', cmdout{contains(cmdout,'InChI=1S')}); + fclose(fid2); + % Create an InChI based-MOL file + command = ['obabel -iinchi tmp -O ' standardisedMolFiles name ' --gen2D']; + [~, ~] = system(command); + delete('tmp') + else + InChIs{i, 1} = {''}; + fid2 = fopen('tmp', 'w'); + fprintf(fid2, '%s\n', smiles); + fclose(fid2); + command = ['obabel -ismiles tmp -O ' standardisedMolFiles name ' --gen2D']; + [~, ~] = system(command); + delete('tmp') + end + + % Adapt database + switch standardisationApproach + case 'explicitH' + command = ['obabel -imol ' standardisedMolFiles name ' -O ' standardisedMolFiles name ' -h']; + [~, ~] = system(command); + case 'implicitH' + % Delete explicit hydrogens + command = ['obabel -imol ' standardisedMolFiles name ' -O ' standardisedMolFiles name ' -d']; + [~, ~] = system(command); + case 'neutral' + % Neutralize molecule + command = ['obabel -imol ' standardisedMolFiles name ' -O ' standardisedMolFiles name ' –neutralize']; + [~, ~] = system(command); + end + else + + InChIKey = ''; + copyfile([molDir name], standardisedMolFiles) + + end + + % Rewrite headings + molFile = regexp(fileread([standardisedMolFiles name]), '\n', 'split')'; + molFile{1} = name(1:end-4); + molFile{2} = ['COBRA Toolbox v3.0 - ' standardisationApproach ' molecule - ' datestr(datetime)]; + molFile{3} = InChIKey; + fid2 = fopen([standardisedMolFiles name], 'w'); + fprintf(fid2, '%s\n', molFile{:}); + fclose(fid2); + % Generate images + if marvinInstalled + fdata = dir([standardisedMolFiles name]); + command = ['molconvert jpeg:w' num2str(fdata.bytes / 10) ',h' num2str(fdata.bytes / 10) ' ' standardisedMolFiles name ' -o ' standardisedImages name(1:end-4) '.jpeg']; + [~, ~] = system(command); + end + + % Save data and delete the non-standardised molecule + y = y + 1; + standardised{y, 1} = name(1:end - 4); + % delete([molDir name]) + +% catch +% +% % Save data in case it is not standardised +% n = n + 1; +% nonStandardised{n, 1} = name(1:end - 4); +% +% end +end + +% Prepare report +standardisationReport.standardisationApproach = standardisationApproach; +standardisationReport.standardised = standardised; +standardisationReport.nonStandardised = nonStandardised; +if exist('InChIs', 'var') + standardisationReport.InChIs = InChIs; +end +if exist('SMILES', 'var') + standardisationReport.SMILES = SMILES; +end +if exist('InChIKeys', 'var') + standardisationReport.InChIKeys = InChIKeys; +end + +end \ No newline at end of file diff --git a/src/dataIntegration/chemoInformatics/transportRxnAM.m b/src/dataIntegration/chemoInformatics/transportRxnAM.m new file mode 100644 index 0000000000..1cc36c0bbe --- /dev/null +++ b/src/dataIntegration/chemoInformatics/transportRxnAM.m @@ -0,0 +1,121 @@ +function mappedRxns = transportRxnAM(rxnDir, outputDir) +% This function atom maps the transport reactions for a given director in +% MDL RXN file format. +% +% USAGE: +% +% mappedRxns = transportRxnAM(rxnDir, outputDir) +% +% INPUTS: +% rxnDir: Path to directory that contains the RXN files +% (default: current directory). +% +% OPTIONAL INPUTS: +% outputDir: Path to directory that will contain the atom +% mapped transport reactions (default: current +% directory). +% +% OUTPUTS: +% mappedRxns: List of missing MOL files atom mapped transport +% reactions. + +rxnDir = [regexprep(rxnDir,'(/|\\)$',''), filesep]; % Make sure input path ends with directory separator +if nargin < 2 || isempty(outputDir) + outputDir = [pwd filesep]; +else + % Make sure input path ends with directory separator + outputDir = [regexprep(outputDir,'(/|\\)$',''), filesep]; +end + +% Create directory if it is missing +if exist(outputDir) ~= 7 + mkdir('transportRxnsAM') +end + +% Check if the directory is not empty +fnames = dir([rxnDir '*.rxn']); +assert(~isempty(fnames), '''rxnDir'' does not contain RXN files'); + +c = 0; +for i = 1:length(fnames) + + % Read the MOL file + rxnFile = regexp( fileread([rxnDir fnames(i).name]), '\n', 'split')'; + rxnFormula = rxnFile{4}; + assert(~isempty(rxnFormula), 'There is not a chemical formula.'); + % Check if it is a transport reaction + rxnFormula = split(rxnFormula, {' -> ', ' <=> '}); + substrates = split(rxnFormula{1}, ' + '); + substrates = expandMets(substrates); + products = split(rxnFormula{2}, ' + '); + products = expandMets(products); + if isequal(substrates, products) + + % Identify the corresponding metabolites in the substrates and + % products + begMol = strmatch('$MOL', rxnFile); + for j = 1:length(begMol) + if j <= numel(substrates) + metSubs{j} = regexprep((rxnFile{begMol(j) + 1}), '(\[\w\])', ''); + else + metProds{j - numel(substrates)} = regexprep((rxnFile{begMol(j) + 1}), '(\[\w\])', ''); + end + end + + % Atom map + atom = 0; + for j = 1:numel(metSubs) + nuOfAtoms = str2double(rxnFile{begMol(j) + 4}(1:3)); + productIdx = strmatch(metSubs{j}, metProds); + for k = 1:nuOfAtoms + atom = atom + 1; + switch length(num2str(atom)) + case 1 + data2print = [' ' num2str(atom) ' 0 0']; + case 2 + data2print = [' ' num2str(atom) ' 0 0']; + case 3 + data2print = [num2str(atom) ' 0 0']; + end + rxnFile{begMol(j) + 4 + k} = [rxnFile{begMol(j) + 4 + k}(1:60) data2print]; + rxnFile{begMol(productIdx(1) + numel(metSubs)) + 4 + k} = [rxnFile{begMol(productIdx(1) + numel(metSubs)) + 4 + k}(1:60) data2print]; + end + metProds(productIdx(1)) = {'done'}; + end + + % Write the file + fid2 = fopen([outputDir fnames(i).name], 'w'); + fprintf(fid2, '%s\n', rxnFile{:}); + fclose(fid2); + + c = c + 1; + mappedRxns{c} = regexprep(fnames(i).name, '.rxn', ''); + clear metSubs metProds + + end +end + +if ~exist('mappedRxns', 'var') + mappedRxns = []; +end +end + +function newMetList = expandMets(metList) + +% Check if a metabolite has an number to be expanded +idxsCheck = ~cellfun(@isempty, regexp(metList, ' ')); +if any(idxsCheck) + idx = find(idxsCheck); + % Add repeated metabolites + for i = 1:length(idx) + met2expand = split(metList(idx(i))); + metList = [metList; repelem(met2expand(2), str2double(met2expand(1)))']; + end + metList(idx) = []; +end + +% Create the new list with metabolites sorted and without a compartment +newMetList = metList; +newMetList = sort(regexprep(newMetList, '(\[\w\])', '')); + +end diff --git a/test/verifiedTests/analysis/testSampling/testSampleCbModel.m b/test/verifiedTests/analysis/testSampling/testSampleCbModel.m index 8283120503..88a4a9228b 100644 --- a/test/verifiedTests/analysis/testSampling/testSampleCbModel.m +++ b/test/verifiedTests/analysis/testSampling/testSampleCbModel.m @@ -17,7 +17,8 @@ cd(fileDir); % define the samplers samplers = {'CHRR','CHRR_EXP','ACHR'}; %'MFE' - +samplers = {'CHRR'}; + % create a parallel pool (if possible) try minWorkers = 2; diff --git a/test/verifiedTests/dataIntegration/testChemoInformatics/metaboliteIds.xlsx b/test/verifiedTests/dataIntegration/testChemoInformatics/metaboliteIds.xlsx new file mode 100644 index 0000000000..1b46cd9755 Binary files /dev/null and b/test/verifiedTests/dataIntegration/testChemoInformatics/metaboliteIds.xlsx differ diff --git a/test/verifiedTests/dataIntegration/testChemoInformatics/refData_generateChemicalDatabase.mat b/test/verifiedTests/dataIntegration/testChemoInformatics/refData_generateChemicalDatabase.mat new file mode 100644 index 0000000000..a3e0ee2354 Binary files /dev/null and b/test/verifiedTests/dataIntegration/testChemoInformatics/refData_generateChemicalDatabase.mat differ diff --git a/test/verifiedTests/dataIntegration/testChemoInformatics/testGenerateChemicalDatabase.m b/test/verifiedTests/dataIntegration/testChemoInformatics/testGenerateChemicalDatabase.m new file mode 100644 index 0000000000..5a62115bca --- /dev/null +++ b/test/verifiedTests/dataIntegration/testChemoInformatics/testGenerateChemicalDatabase.m @@ -0,0 +1,64 @@ +% The COBRAToolbox: testGenerateChemicalDatabase.m +% +% Purpose: +% - tests the generateChemicalDatabase function using the Citric Acid +% Cycle E. coli Core Model +% + +fprintf(' Testing generateChemicalDatabase ... \n' ); + +% Save the current path +currentDir = pwd; +mkdir([currentDir filesep 'tmpDB']) + +% Check external software +[cxcalcInstalled, ~] = system('cxcalc'); +cxcalcInstalled = ~cxcalcInstalled; +[oBabelInstalled, ~] = system('obabel'); +[javaInstalled, ~] = system('java'); + +% Load the E. coli Core Model TCA rxns +load ecoli_core_model.mat +model.mets = regexprep(model.mets, '\-', '\_'); +rxnsToExtract = {'AKGDH', 'CS', 'FUM', 'ICDHyr', 'MDH', 'SUCOAS'}; +model = extractSubNetwork(model, rxnsToExtract); + +% initialize the test +fileDir = fileparts(which('testGenerateChemicalDatabase.m')); + +% Load reference data +load('refData_generateChemicalDatabase.mat') + +%% Add external information in the model + +inputData = [fileDir filesep 'metaboliteIds.xlsx']; +replace = false; +[model, hasEffect] = addMetInfoInCBmodel(model, inputData, replace); + +assert(isequal(model, model1), 'The identifiers are different') +assert(hasEffect, 'The function addMetInfoInCBmodel din not have effect') + +%% Set optional variables according the software installed + +options.outputDir = [currentDir filesep 'tmpDB']; +options.printlevel = 0; + +if cxcalcInstalled && oBabelInstalled && javaInstalled + options.adjustToModelpH = true; + options.onlyUnmapped = false; +else + options.adjustToModelpH = false; + options.onlyUnmapped = true; +end + +[info, model] = generateChemicalDatabase(model, options); + +if cxcalcInstalled && oBabelInstalled && javaInstalled + assert(isequal(model, model2), 'The model ouput is different') + assert(isequal(info, info1), 'The database report is different') +else + assert(isequal(model, model3), 'The model ouput is different') + assert(isequal(info, info2), 'The database report is different') +end + +rmdir([currentDir filesep 'tmpDB'], 's') \ No newline at end of file