diff --git a/code/reasoningtool/QuestionAnswering/Q1Solution.py b/code/reasoningtool/QuestionAnswering/Q1Solution.py deleted file mode 100644 index 721b737b6..000000000 --- a/code/reasoningtool/QuestionAnswering/Q1Solution.py +++ /dev/null @@ -1,330 +0,0 @@ -# Solution to question 1, this assumes the neo4j network has already been populated with the relevant data -import numpy as np -np.warnings.filterwarnings('ignore') -from collections import namedtuple -#from neo4j.v1 import GraphDatabase, basic_auth -import os, sys -try: - import QueryNCBIeUtils -except ImportError: - sys.path.append(os.path.abspath(os.path.join(os.path.dirname(__file__), '../kg-construction'))) # Go up one level and look for it - import QueryNCBIeUtils -QueryNCBIeUtils =QueryNCBIeUtils.QueryNCBIeUtils() -#import Q1Utils -from neo4j.v1 import GraphDatabase, basic_auth -import argparse -import sys -import json -import ReasoningUtilities as RU -import FormatOutput -response = FormatOutput.FormatResponse(1) - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../") # code directory -from RTXConfiguration import RTXConfiguration -rtxConfig = RTXConfiguration() - -# Connection information for the neo4j server, populated with orangeboard -driver = GraphDatabase.driver(rtxConfig.neo4j_bolt, auth=basic_auth(rtxConfig.neo4j_username, rtxConfig.neo4j_password)) -session = driver.session() - -# Connection information for the ipython-cypher package -connection = "http://" + rtxConfig.neo4j_username + ":" + rtxConfig.neo4j_password + "@" + rtxConfig.neo4j_database -DEFAULT_CONFIGURABLE = { - "auto_limit": 0, - "style": 'DEFAULT', - "short_errors": True, - "data_contents": True, - "display_limit": 0, - "auto_pandas": False, - "auto_html": False, - "auto_networkx": False, - "rest": False, - "feedback": False, # turn off verbosity in ipython-cypher - "uri": connection, -} -DefaultConfigurable = namedtuple( - "DefaultConfigurable", - ", ".join([k for k in DEFAULT_CONFIGURABLE.keys()]) -) -defaults = DefaultConfigurable(**DEFAULT_CONFIGURABLE) - - - -######################################################################################## - -# TODO: the following two dictionaries would be relatively straightforward to programmatically create -# but given the time contraints, let's just hard code them now... - -# Dictionary converting disease to disease ID -# TODO: double check the DOID's, possibly add synonyms for the diseases -## seed all 21 diseases in the Orangeboard -q1_doid_to_disease = {'DOID:11476': 'osteoporosis', - 'DOID:526': 'HIV infectious disease', - 'DOID:1498': 'cholera', - 'DOID:4325': 'Ebola hemmorhagic fever', - 'DOID:12365': 'malaria', - 'DOID:10573': 'Osteomalacia', - 'DOID:13810': 'hypercholesterolemia', - 'DOID:9352': 'type 2 diabetes mellitus', - 'DOID:2841': 'asthma', - 'DOID:4989': 'pancreatitis', - 'DOID:10652': 'Alzheimer Disease', - 'DOID:5844': 'Myocardial Infarction', - 'DOID:11723': 'Duchenne Muscular Dystrophy', - 'DOID:0060728': 'NGLY1-deficiency', - 'DOID:0050741': 'Alcohol Dependence', - 'DOID:1470': 'major depressive disorder', - 'DOID:14504': 'Niemann-Pick disease', - 'DOID:12858': 'Huntington\'s Disease', - 'DOID:9270': 'Alkaptonuria', - 'DOID:10923': 'sickle cell anemia', - 'DOID:2055': 'post-traumatic stress disorder'} -q1_disease_to_doid = dict() -for key in q1_doid_to_disease.keys(): - q1_disease_to_doid[q1_doid_to_disease[key]] = key - -for key in q1_doid_to_disease.keys(): - q1_disease_to_doid[q1_doid_to_disease[key].lower()] = key - -for key in q1_doid_to_disease.keys(): - q1_disease_to_doid[q1_doid_to_disease[key].upper()] = key - -q1_doid_to_mesh = {'DOID:11476': 'Osteoporosis', - 'DOID:526': 'HIV Infections', - 'DOID:1498': 'Cholera', - 'DOID:4325': 'Ebola Infection', - 'DOID:12365': 'Malaria', - 'DOID:10573': 'Osteomalacia', - 'DOID:13810': 'Hypercholesterolemia', - 'DOID:9352': 'Diabetes Mellitus, Type 2', - 'DOID:2841': 'Asthma', - 'DOID:4989': 'Pancreatitis, Chronic', - 'DOID:10652': 'Alzheimer Disease', - 'DOID:5844': 'Myocardial Infarction', - 'DOID:11723': 'Muscular Dystrophy, Duchenne', - 'DOID:0060728': 'NGLY1 protein, human', - 'DOID:0050741': 'Alcoholism', - 'DOID:1470': 'Depressive Disorder, Major', - 'DOID:14504': 'Niemann-Pick Disease, Type C', - 'DOID:12858': 'Huntington Disease', - 'DOID:9270': 'Alkaptonuria', - 'DOID:10923': 'Anemia, Sickle Cell', - 'DOID:2055': 'Stress Disorders, Post-Traumatic'} - -# Get the genetic diseases of interest -genetic_condition_to_omim = dict() -genetic_condition_to_mesh = dict() -fid = open(os.path.abspath('../../../data/q1/Genetic_conditions_from_OMIM.txt'), 'r') -i = 0 -for line in fid.readlines(): - if i == 0: - i += 1 - continue - else: - i += 1 - line = line.strip() - condition_name = line.split('\t')[2] - mim_id = int(line.split('\t')[1]) - mesh = condition_name.split(';')[0].lower() - genetic_condition_to_omim[condition_name] = "OMIM:%d" % (mim_id) - genetic_condition_to_mesh[condition_name] = mesh -fid.close() - -omim_to_genetic_cond = dict() -omim_to_mesh = dict() -for condition in genetic_condition_to_omim.keys(): - omim_to_genetic_cond[genetic_condition_to_omim[condition]] = condition - omim_to_mesh[genetic_condition_to_omim[condition]] = genetic_condition_to_mesh[condition] - -# These are highly connected, complex diseases (so likely to have the paths we're looking for), but -# not very informative. Will need to further refine the Markov chain to exclude paths through these nodes -disease_ignore_list = [ -'OMIM:614389', -'OMIM:601367', -'OMIM:601665', -'OMIM:103780', -'OMIM:164230', -'OMIM:607154', -'OMIM:181500', -'OMIM:608516', -'OMIM:144700', -'OMIM:114480' -] -# May consider 'OMIM:617347', 'OMIM:238600' too - - - -################################################### -# Start input - -def answerQ1(doid, directed=True, max_path_len=3, verbose=False, use_json=False): # I'm thinking directed true is best - """ - Answers Q1. - :param doid: input disease (from the list) - :param directed: if true, treats the graph as directed and looks for short paths, if false, looks for nodes with - many paths from source to target - :param max_path_len: maximum path length to consider - :return: nothing, prints to screen - """ - #input_disease = 'cholera' # input disease - # Temp fix for input being doid, not description - #doid = input_disease - - # TODO: synonyms for diseases - #if doid not in q1_doid_to_disease: - # try: - # disease_description = RU.get_node_property(doid, 'description') - # except: - # disease_description = doid - # if not use_json: - # print("Sorry, the disease %s is not one of the Q1 diseases." % disease_description) - # return - # else: - # error_code = "NotInDiseaseList" - # error_message = "Sorry, the disease %s is not one of the Q1 diseases." % disease_description - # response.add_error_message(error_code, error_message) - # response.print() - # return - - # Getting nearby genetic diseases - #omims = Q1Utils.get_omims_connecting_to_fixed_doid(doid, directed=directed, max_path_len=max_path_len, verbose=verbose) - omims = RU.get_node_names_of_type_connected_to_target('disease', doid, 'disease', max_path_len=max_path_len, verbose=verbose, is_omim=True) - - if not omims: - if verbose and not use_json: - print("No nearby omims found. Please raise the max_path_len and try again.") - return 1 - - # NOTE: the following three can be mixed and matched in any order you please - - # get the ones that are nearby according to a random walk between source and target node - #omims = Q1Utils.refine_omims_graph_distance(omims, doid, directed=directed, max_path_len=max_path_len, verbose=verbose) - omims = RU.refine_omims_graph_distance(omims, 'disease', doid, 'disease', directed=False, max_path_len=max_path_len, verbose=verbose) - - omims_no_doid = [] - for omim in omims: - prefix = omim.split(':')[0] - if prefix == 'OMIM': - omims_no_doid.append(omim) - omims = omims_no_doid - - # get the ones that have high probability according to a Markov chain model - #omims, paths_dict, prob_dict = Q1Utils.refine_omims_Markov_chain(omims, doid, max_path_len=max_path_len, verbose=verbose) - omims, paths_dict, prob_dict = RU.refine_omims_Markov_chain(omims, doid, max_path_len=max_path_len, verbose=verbose) - - # get the ones that have low google distance (are "well studied") - #omims = Q1Utils.refine_omims_well_studied(omims, doid, verbose=verbose) - omims = RU.refine_omims_well_studied(omims, doid, omim_to_mesh, q1_doid_to_mesh, verbose=verbose) - - if not omims: - if verbose and not use_json: - print("No omims passed all refinements. Please raise the max_path_len and try again.") - return 1 - - # Get rid of the self-loops: - to_display_paths_dict = dict() - to_display_probs_dict = dict() - for omim in omims: - if omim in disease_ignore_list: - #or q1_doid_to_disease[doid].lower() in omim_to_genetic_cond[omim].lower()\ - #or omim_to_genetic_cond[omim].lower() in q1_doid_to_disease[doid].lower()\ - #or q1_doid_to_mesh[doid].split(',')[0].lower() in omim_to_genetic_cond[omim].lower(): - # do something with the deleted guys? - pass - else: - to_display_paths_dict[omim] = paths_dict[omim] - to_display_probs_dict[omim] = prob_dict[omim] - - if not to_display_probs_dict: - if verbose and not use_json: - print("No omims passed all refinements. Please raise the max_path_len and try again.") - return 1 - - # Order the results - keys = list(to_display_paths_dict.keys()) - probs = [to_display_probs_dict[key] for key in keys] - keys_sorted = [x for _, x in sorted(zip(probs, keys), key=lambda pair: pair[0], reverse=True)] - for key in keys_sorted: - path_pair = to_display_paths_dict[key] - temp_path_dict = dict() - temp_path_dict[key] = path_pair - node_rel_list = path_pair[0] - #results_text = Q1Utils.display_results_str(doid, temp_path_dict, probs=to_display_probs_dict) - results_text = RU.display_results_str(doid, temp_path_dict, probs=to_display_probs_dict) - for i, path in enumerate(node_rel_list): - node_list = path[0::2] - rel_list = path[1::2] - g = RU.return_exact_path(node_list, rel_list) - response.add_subgraph(g.nodes(data=True), g.edges(data=True), results_text, to_display_probs_dict[node_list[0]]) - - if not use_json: - #results_text = Q1Utils.display_results_str(doid, to_display_paths_dict, probs=to_display_probs_dict) - results_text = RU.display_results_str(doid, to_display_paths_dict, probs=to_display_probs_dict) - print(results_text) - else: - #ret_obj = Q1Utils.get_results_object_model(doid, to_display_paths_dict, omim_to_genetic_cond, q1_doid_to_disease, probs=to_display_probs_dict) - #ret_obj['text'] = results_text - #print(json.dumps(ret_obj)) - response.print() - return - - - -def main(): - parser = argparse.ArgumentParser(description="Runs the reasoning tool on Question 1", - formatter_class=argparse.ArgumentDefaultsHelpFormatter) - parser.add_argument('-i', '--input_disease', type=str, help="Input disease", default="DOID:12365") - parser.add_argument('-v', '--verbose', action="store_true", help="Flag to turn on verbosity", default=False) - parser.add_argument('-d', '--directed', action="store_true", help="To treat the graph as directed or not.", default=True) - parser.add_argument('-m', '--max_path_len', type=int, - help="Maximum graph path length for which to look for nearby omims", default=2) - parser.add_argument('-a', '--all', action="store_true", help="Flag indicating you want to run it on all Q1 diseases", - default=False) - parser.add_argument('-j', '--json', action='store_true', help='Flag specifying that results should be printed in JSON format (to stdout)', default=False) - - if '-h' in sys.argv or '--help' in sys.argv: - #Q1Utils.session.close() - RU.session.close() - #Q1Utils.driver.close() - RU.driver.close() - - # Parse and check args - args = parser.parse_args() - disease = args.input_disease - verbose = args.verbose - directed = args.directed - max_path_len = args.max_path_len - use_json = args.json - all_d = args.all - - if all_d: - for disease in q1_disease_to_doid.values(): - print("\n") - print(disease) - if disease == 'DOID:2841': # if we incrementally built it up, we'd be waiting all day (asthma) - answerQ1(disease, directed=True, max_path_len=5, verbose=True, use_json=use_json) - else: - for len in [2, 3, 4]: # start out with small path lengths, then expand outward until we find something - res = answerQ1(disease, directed=True, max_path_len=len, verbose=True, use_json=use_json) - if res != 1: - break - if res == 1: - print("Sorry, no results found for %s" % disease) - else: - res = answerQ1(disease, directed=directed, max_path_len=max_path_len, verbose=verbose, use_json=use_json) - if res == 1: - if not use_json: - print("Increasing path length and trying again...") - res = answerQ1(disease, directed=directed, max_path_len=max_path_len + 1, verbose=verbose, use_json=use_json) - if res == 1: - if not use_json: - print("Increasing path length and trying again...") - res = answerQ1(disease, directed=directed, max_path_len=max_path_len + 2, verbose=verbose, use_json=use_json) - if res == 1 and use_json: - error_code = "NoResultsFound" - error_message = "Sorry, no results found for %s" % disease - response.add_error_message(error_code, error_message) - response.print() - -if __name__ == "__main__": - main() diff --git a/code/reasoningtool/deprecated_modules/QueryPubMedNGD.py b/code/reasoningtool/deprecated_modules/QueryPubMedNGD.py deleted file mode 100644 index 2e06c007a..000000000 --- a/code/reasoningtool/deprecated_modules/QueryPubMedNGD.py +++ /dev/null @@ -1,55 +0,0 @@ -import requests -import urllib -import math - -__author__ = 'Stephen Ramsey' -__copyright__ = 'Oregon State University' -__credits__ = ['Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -class QueryPubMedNGD: - PUBMED_URL = 'https://eutils.ncbi.nlm.nih.gov/entrez/eutils/esearch.fcgi?db=pubmed&retmode=json&retmax=1000&term=' - - @staticmethod - def get_pubmed_hits_count(term_str): - term_str_encoded = urllib.parse.quote(term_str, safe='') - url_str = QueryPubMedNGD.PUBMED_URL + term_str_encoded - res = requests.get(url_str) - status_code = res.status_code - if status_code != 200: - print('HTTP response status code: ' + str(status_code) + ' for query term string {term}'.format(term=term_str)) - return None - return int(res.json()['esearchresult']['count']) - - @staticmethod - def normalized_google_distance(mesh1_str, mesh2_str): - '''returns the normalized Google distance for two MeSH terms - - :returns: NGD, as a float (or math.nan if any counts are zero, or None if HTTP error) - ''' - nij = QueryPubMedNGD.get_pubmed_hits_count('("{mesh1}"[MeSH Terms]) AND "{mesh2}"[MeSH Terms]'.format(mesh1=mesh1_str, - mesh2=mesh2_str)) - N = ngd_normalizer = 3.5e+7 * 20 # From PubMed home page there are 35 million articles (based on the information on https://pubmed.ncbi.nlm.nih.gov/ on 08/09/2023); avg 20 MeSH terms per article - ni = QueryPubMedNGD.get_pubmed_hits_count('"{mesh1}"[MeSH Terms]'.format(mesh1=mesh1_str)) - nj = QueryPubMedNGD.get_pubmed_hits_count('"{mesh2}"[MeSH Terms]'.format(mesh2=mesh2_str)) - if ni == 0 or nj == 0 or nij == 0: - return math.nan - numerator = max(math.log(ni), math.log(nj)) - math.log(nij) - denominator = math.log(N) - min(math.log(ni), math.log(nj)) - ngd = numerator/denominator - return ngd - - @staticmethod - def test_ngd(): - mesh1_str = 'Anemia, Sickle Cell' - mesh2_str = 'Malaria' - print(QueryPubMedNGD.normalized_google_distance(mesh1_str, mesh2_str)) - -if __name__ == '__main__': - QueryPubMedNGD.test_ngd() - - diff --git a/code/reasoningtool/deprecated_modules/ReasoningTool.py b/code/reasoningtool/deprecated_modules/ReasoningTool.py deleted file mode 100644 index f498ffcd4..000000000 --- a/code/reasoningtool/deprecated_modules/ReasoningTool.py +++ /dev/null @@ -1,507 +0,0 @@ -""" This module defines the ReasoningTool functions which carry out the expanding - process from all types of nodes. It can calculate the joint of specific rounds - of expanding. Moreover, it is responsible for connection with Neo4j database and - handle the node, relation pushing and configuration to Neo4j databse. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = [] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -import sys -import argparse -import requests_cache -import timeit -import os -import re -import os -from Orangeboard import Orangeboard -from QueryOMIM import QueryOMIM -from QueryMyGene import QueryMyGene -from QueryUniprot import QueryUniprot -from QueryReactome import QueryReactome -from QueryDisont import QueryDisont -from QueryDisGeNet import QueryDisGeNet -from QueryGeneProf import QueryGeneProf -from QueryBioLink import QueryBioLink -from QueryMiRGate import QueryMiRGate -from QueryMiRBase import QueryMiRBase -from QueryPharos import QueryPharos -## from QueryPC2 import QueryPC2 ## not currently using; so comment out until such time as we decide to use it - -from timeit import default_timer as timer - -## refuse to run in python version < 3.5 (in case accidentally invoked using "python" rather than "python3") -if sys.version_info[0] < 3 or sys.version_info[1] < 5: - print("This script requires Python version 3.5 or greater") - sys.exit(1) - -#requests_cache.install_cache('orangeboard') -# specifiy the path of orangeboard database -pathlist = os.path.realpath(__file__).split(os.path.sep) -RTXindex = pathlist.index("RTX") -dbpath = os.path.sep.join([*pathlist[:(RTXindex+1)],'data','orangeboard']) -requests_cache.install_cache(dbpath) - -query_omim_obj = QueryOMIM() -query_mygene_obj = QueryMyGene(debug=False) - -master_rel_is_directed = {'disease_affects': True, - 'is_member_of': True, - 'is_parent_of': True, - 'gene_assoc_with': True, - 'phenotype_assoc_with': True, - 'interacts_with': False, - 'controls_expression_of': True, - 'is_expressed_in': True, - 'targets': True} - -master_rel_ids_in_orangeboard = {'disease_affects': dict(), - 'is_member_of': dict()} - -master_node_ids_in_orangeboard = {'omim_disease': dict(), - 'disont_disease': dict(), - 'uniprot_protein': dict(), - 'reactome_pathway': dict(), - 'phenont_phenotype': dict(), - 'ncbigene_microrna': dict(), - 'anatont_anatomy': dict(), - 'pharos_drug': dict()} - - -def expand_pharos_drug(orangeboard, node): - drug_name = node.name - - targets = QueryPharos.query_drug_name_to_targets(drug_name) - for target in targets: - uniprot_id = QueryPharos.query_target_uniprot_accession(str(target["id"])) - - target_node = orangeboard.add_node('uniprot_protein', uniprot_id, desc=target["name"]) - orangeboard.add_rel('targets', 'Pharos', node, target_node) - - -def is_mir(gene_symbol): - return re.match('MIR\d.*', gene_symbol) is not None or re.match('MIRLET\d.*', gene_symbol) is not None - - -def expand_ncbigene_microrna(orangeboard, node): - ncbi_gene_id = node.name - assert 'NCBIGene:' in ncbi_gene_id - - anatomy_dict = QueryBioLink.get_anatomies_for_gene(ncbi_gene_id) - for anatomy_id, anatomy_desc in anatomy_dict.items(): - anatomy_node = orangeboard.add_node('anatont_anatomy', anatomy_id, desc=anatomy_desc) - orangeboard.add_rel('is_expressed_in', 'BioLink', node, anatomy_node) - - disease_ids_dict = QueryBioLink.get_diseases_for_gene_desc(ncbi_gene_id) - for disease_id in disease_ids_dict.keys(): - if 'OMIM:' in disease_id: - disease_node = orangeboard.add_node('omim_disease', disease_id, desc=disease_ids_dict[disease_id]) - orangeboard.add_rel('gene_assoc_with', 'BioLink', node, disease_node) - else: - if 'DOID:' in disease_id: - disease_node = orangeboard.add_node('disont_disease', disease_id, desc=disease_ids_dict[disease_id]) - orangeboard.add_rel('gene_assoc_with', 'BioLink', node, disease_node) - else: - print('Warning: unexpected disease ID: ' + disease_id) - - phenotype_ids_dict = QueryBioLink.get_phenotypes_for_gene_desc(ncbi_gene_id) - for phenotype_id in phenotype_ids_dict.keys(): - phenotype_node = orangeboard.add_node('phenont_phenotype', phenotype_id, desc=phenotype_ids_dict[phenotype_id]) - orangeboard.add_rel('gene_assoc_with', 'BioLink', node, phenotype_node) - - mirbase_ids = query_mygene_obj.convert_entrez_gene_ID_to_mirbase_ID(int(ncbi_gene_id.replace('NCBIGene:', ''))) - for mirbase_id in mirbase_ids: - mature_mir_ids = QueryMiRBase.convert_mirbase_id_to_mature_mir_ids(mirbase_id) - for mature_mir_id in mature_mir_ids: - target_gene_symbols = QueryMiRGate.get_gene_symbols_regulated_by_microrna(mature_mir_id) - for target_gene_symbol in target_gene_symbols: - uniprot_ids = query_mygene_obj.convert_gene_symbol_to_uniprot_id(target_gene_symbol) - - for uniprot_id in uniprot_ids: - target_prot_node = orangeboard.add_node('uniprot_protein', uniprot_id, desc=target_gene_symbol) - orangeboard.add_rel('controls_expression_of', 'miRGate', node, target_prot_node) - - if len(uniprot_ids) == 0: - if is_mir(target_gene_symbol): - target_ncbi_entrez_ids = query_mygene_obj.convert_gene_symbol_to_entrez_gene_ID( - target_gene_symbol) - for target_ncbi_entrez_id in target_ncbi_entrez_ids: - target_mir_node = orangeboard.add_node('ncbigene_microrna', - 'NCBIGene:' + str(target_ncbi_entrez_id), - desc=target_gene_symbol) - orangeboard.add_rel('controls_expression_of', 'miRGate', node, target_mir_node) - - -def expand_reactome_pathway(orangeboard, node): - reactome_id_str = node.name - uniprot_ids_from_reactome_dict = QueryReactome.query_reactome_pathway_id_to_uniprot_ids_desc(reactome_id_str) - rel_sourcedb_dict = dict.fromkeys(uniprot_ids_from_reactome_dict.keys(), 'reactome') - source_node = node - for uniprot_id in uniprot_ids_from_reactome_dict.keys(): - target_node = orangeboard.add_node('uniprot_protein', uniprot_id, - desc=uniprot_ids_from_reactome_dict[uniprot_id]) - orangeboard.add_rel('is_member_of', rel_sourcedb_dict[uniprot_id], target_node, source_node) - - -# uniprot_ids_from_pc2 = QueryPC2.pathway_id_to_uniprot_ids(reactome_id_str) ## very slow query - -def expand_anatont_anatomy(orangeboard, node): - pass - - -def expand_uniprot_protein(orangeboard, node): - uniprot_id_str = node.name - # pathways_set_from_pc2 = QueryPC2.uniprot_id_to_reactome_pathways(uniprot_id_str) ## suspect these pathways are too high-level and not useful - # pathways_set_from_uniprot = QueryUniprot.uniprot_id_to_reactome_pathways(uniprot_id_str) ## doesn't provide pathway descriptions; see if we can get away with not using it? - ## protein-pathway membership: - pathways_dict_from_reactome = QueryReactome.query_uniprot_id_to_reactome_pathway_ids_desc(uniprot_id_str) - pathways_dict_sourcedb = dict.fromkeys(pathways_dict_from_reactome.keys(), 'reactome_pathway') - node1 = node - for pathway_id in pathways_dict_from_reactome.keys(): - target_node = orangeboard.add_node('reactome_pathway', pathway_id, desc=pathways_dict_from_reactome[pathway_id]) - orangeboard.add_rel('is_member_of', pathways_dict_sourcedb[pathway_id], node1, target_node) - gene_symbols_set = query_mygene_obj.convert_uniprot_id_to_gene_symbol(uniprot_id_str) - for gene_symbol in gene_symbols_set: - ## protein-DNA (i.e., gene regulatory) interactions: - regulator_gene_symbols_set = QueryGeneProf.gene_symbol_to_transcription_factor_gene_symbols(gene_symbol) - for reg_gene_symbol in regulator_gene_symbols_set: - reg_uniprot_ids_set = query_mygene_obj.convert_gene_symbol_to_uniprot_id(reg_gene_symbol) - for reg_uniprot_id in reg_uniprot_ids_set: - node2 = orangeboard.add_node('uniprot_protein', reg_uniprot_id, desc=reg_gene_symbol) - if node2.uuid != node1.uuid: - orangeboard.add_rel('controls_expression_of', 'GeneProf', node2, node1) - ## microrna-gene interactions: - microrna_regulators = QueryMiRGate.get_microrna_ids_that_regulate_gene_symbol(gene_symbol) - for microrna_id in microrna_regulators: - mir_gene_symbol = QueryMiRBase.convert_mirbase_id_to_mir_gene_symbol(microrna_id) - if mir_gene_symbol is not None: - mir_entrez_gene_ids = query_mygene_obj.convert_gene_symbol_to_entrez_gene_ID(mir_gene_symbol) - if len(mir_entrez_gene_ids) > 0: - for mir_entrez_gene_id in mir_entrez_gene_ids: - mir_node = orangeboard.add_node('ncbigene_microrna', 'NCBIGene:' + str(mir_entrez_gene_id), - desc=mir_gene_symbol) - orangeboard.add_rel('controls_expression_of', 'miRGate', mir_node, node) - - entrez_gene_id = query_mygene_obj.convert_uniprot_id_to_entrez_gene_ID(uniprot_id_str) - if len(entrez_gene_id) > 0: - entrez_gene_id_str = 'NCBIGene:' + str(next(iter(entrez_gene_id))) - - ## protein-to-anatomy associations: - anatomy_dict = QueryBioLink.get_anatomies_for_gene(entrez_gene_id_str) - for anatomy_id, anatomy_desc in anatomy_dict.items(): - anatomy_node = orangeboard.add_node('anatont_anatomy', anatomy_id, desc=anatomy_desc) - orangeboard.add_rel('is_expressed_in', 'BioLink', node, anatomy_node) - - ## protein-disease associations: - disont_id_dict = QueryBioLink.get_diseases_for_gene_desc(entrez_gene_id_str) - for disont_id in disont_id_dict.keys(): - if 'DOID:' in disont_id: - node2 = orangeboard.add_node('disont_disease', disont_id, desc=disont_id_dict[disont_id]) - orangeboard.add_rel('gene_assoc_with', 'BioLink', node1, node2) - else: - if 'OMIM:' in disont_id: - node2 = orangeboard.add_node('omim_disease', disont_id, desc=disont_id_dict[disont_id]) - orangeboard.add_rel('gene_assoc_with', 'BioLink', node1, node2) - ## protein-phenotype associations: - phenotype_id_dict = QueryBioLink.get_phenotypes_for_gene_desc(entrez_gene_id_str) - for phenotype_id_str in phenotype_id_dict.keys(): - node2 = orangeboard.add_node('phenont_phenotype', phenotype_id_str, - desc=phenotype_id_dict[phenotype_id_str]) - orangeboard.add_rel('gene_assoc_with', 'BioLink', node1, node2) - ## protein-protein interactions: - int_dict = QueryReactome.query_uniprot_id_to_interacting_uniprot_ids(uniprot_id_str) - for int_uniprot_id in int_dict.keys(): - int_alias = int_dict[int_uniprot_id] - node2 = orangeboard.add_node('uniprot_protein', int_uniprot_id, desc=int_alias) - if node2.uuid != node1.uuid: - orangeboard.add_rel('interacts_with', 'reactome', node1, node2) - - -def expand_phenont_phenotype(orangeboard, node): - # EXPAND PHENOTYPE -> ANATOMY - phenotype_id = node.name - - anatomy_dict = QueryBioLink.get_anatomies_for_phenotype(phenotype_id) - for anatomy_id, anatomy_desc in anatomy_dict.items(): - anatomy_node = orangeboard.add_node('anatont_anatomy', anatomy_id, desc=anatomy_desc) - orangeboard.add_rel('phenotype_assoc_with', 'BioLink', node, anatomy_node) - - ## TODO: expand phenotype to child phenotypes, through the phenotype ontology as we do for disease ontology - - -def expand_omim_disease(orangeboard, node): - res_dict = query_omim_obj.disease_mim_to_gene_symbols_and_uniprot_ids(node.name) - uniprot_ids = res_dict['uniprot_ids'] - gene_symbols = res_dict['gene_symbols'] - if len(uniprot_ids) == 0 and len(gene_symbols) == 0: - return ## nothing else to do, for this MIM number - uniprot_ids_to_gene_symbols_dict = dict() - for gene_symbol in gene_symbols: - uniprot_ids = query_mygene_obj.convert_gene_symbol_to_uniprot_id(gene_symbol) - if len(uniprot_ids) == 0: - ## this might be a microRNA - if is_mir(gene_symbol): - entrez_gene_ids = query_mygene_obj.convert_gene_symbol_to_entrez_gene_ID(gene_symbol) - if len(entrez_gene_ids) > 0: - for entrez_gene_id in entrez_gene_ids: - curie_entrez_gene_id = 'NCBIGene:' + str(entrez_gene_id) - node2 = orangeboard.add_node('ncbigene_microrna', curie_entrez_gene_id, desc=gene_symbol) - orangeboard.add_rel('disease_affects', 'OMIM', node, node2) - for uniprot_id in uniprot_ids: - uniprot_ids_to_gene_symbols_dict[uniprot_id] = gene_symbol - for uniprot_id in uniprot_ids: - gene_symbol = query_mygene_obj.convert_uniprot_id_to_gene_symbol(uniprot_id) - if gene_symbol is not None: - gene_symbol_str = ';'.join(gene_symbol) - uniprot_ids_to_gene_symbols_dict[uniprot_id] = gene_symbol_str - source_node = node - for uniprot_id in uniprot_ids_to_gene_symbols_dict.keys(): - target_node = orangeboard.add_node('uniprot_protein', uniprot_id, - desc=uniprot_ids_to_gene_symbols_dict[uniprot_id]) - orangeboard.add_rel('disease_affects', 'OMIM', source_node, target_node) - - -def expand_disont_disease(orangeboard, node): - disont_id = node.name - child_disease_ids_dict = QueryDisont.query_disont_to_child_disonts_desc(disont_id) - for child_disease_id in child_disease_ids_dict.keys(): - target_node = orangeboard.add_node('disont_disease', child_disease_id, - desc=child_disease_ids_dict[child_disease_id]) - orangeboard.add_rel('is_parent_of', 'DiseaseOntology', node, target_node) - mesh_ids_set = QueryDisont.query_disont_to_mesh_id(disont_id) - for mesh_id in mesh_ids_set: - uniprot_ids_dict = QueryDisGeNet.query_mesh_id_to_uniprot_ids_desc(mesh_id) - for uniprot_id in uniprot_ids_dict.keys(): - source_node = orangeboard.add_node('uniprot_protein', uniprot_id, desc=uniprot_ids_dict[uniprot_id]) - orangeboard.add_rel('gene_assoc_with', 'DisGeNet', source_node, node) - ## query for phenotypes associated with this disease - phenotype_id_dict = QueryBioLink.get_phenotypes_for_disease_desc(disont_id) - for phenotype_id_str in phenotype_id_dict.keys(): - phenotype_node = orangeboard.add_node('phenont_phenotype', phenotype_id_str, - desc=phenotype_id_dict[phenotype_id_str]) - orangeboard.add_rel('phenotype_assoc_with', 'BioLink', phenotype_node, node) - - -def expand_node(orangeboard, node): - node_type = node.nodetype - method_name = 'expand_' + node_type - method_obj = globals()[method_name] ## dispatch to the correct function for expanding the node type - method_obj(orangeboard, node) - node.expanded = True - - -def expand_all_nodes(orangeboard): - nodes = orangeboard.get_all_nodes_for_current_seed_node() - for node in nodes: - if not node.expanded: - expand_node(orangeboard, node) - - -def bigtest(): - genetic_condition_mim_id = 'OMIM:603903' # sickle-cell anemia - target_disease_disont_id = 'DOID:12365' # malaria - ## cerebral malaria: 'DOID:014069' - - # genetic_condition_mim_id = 'OMIM:219700' # cystic fibrosis - # target_disease_disont_id = 'DOID:1498' # cholera - - # genetic_condition_mim_id = 'OMIM:305900' # glucose-6-phosphate dehydrogenase (G6PD) - # target_disease_disont_id = 'DOID:12365' # malaria - - # genetic_condition_mim_id = 'OMIM:607786' # proprotein convertase, subtilisin/kexin-type, 9 (PCSK9) - # target_disease_disont_id = 'DOID:13810' # familial hypercholesterolemia - - # genetic_condition_mim_id = 'OMIM:184745' # kit ligard - # target_disease_disont_id = 'DOID:2841' # asthma - - ob = Orangeboard(master_rel_is_directed, debug=True) - - ## add the initial target disease into the Orangeboard, as a 'disease ontology' node - disease_node = ob.add_node('disont_disease', target_disease_disont_id, desc='malaria', seed_node_bool=True) - - print('----------- first round of expansion ----------') - expand_all_nodes(ob) - - print('----------- second round of expansion ----------') - expand_all_nodes(ob) - - print('----------- third round of expansion ----------') - expand_all_nodes(ob) - - print('total number of nodes: ' + str(ob.count_nodes())) - print('total number of edges: ' + str(ob.count_rels())) - - ## add the initial genetic condition into the Orangeboard, as a 'MIM' node - mim_node = ob.add_node('omim_disease', genetic_condition_mim_id, desc='sickle-cell anemia', seed_node_bool=True) - - print('----------- first round of expansion ----------') - expand_all_nodes(ob) - - print('----------- second round of expansion ----------') - expand_all_nodes(ob) - - print('----------- third round of expansion ----------') - expand_all_nodes(ob) - - print('total number of nodes: ' + str(ob.count_nodes())) - print('total number of edges: ' + str(ob.count_rels())) - - # push the entire graph to neo4j - ob.neo4j_set_url() # use default url - ob.neo4j_set_auth() # use default username/password - ob.neo4j_push() - - # clear out the neo4j graph derived from the MIM seed node - # ob.neo4j_clear(mim_node) - - -def test_description_mim(): - ob = Orangeboard(master_rel_is_directed, debug=True) - node = ob.add_node('omim_disease', 'OMIM:603903', desc='sickle-cell anemia', seed_node_bool=True) - expand_omim_disease(ob, node) - ob.neo4j_set_url() # use default url - ob.neo4j_set_auth() # use default username/password - ob.neo4j_push() - - -def test_description_uniprot(): - ob = Orangeboard(master_rel_is_directed, debug=True) - node = ob.add_node('uniprot_protein', 'P68871', desc='HBB', seed_node_bool=True) - print(ob.__str__()) - expand_uniprot_protein(ob, node) - ob.neo4j_set_url() # use default url - ob.neo4j_set_auth() # use default username/password - ob.neo4j_push() - - -def test_description_disont(): - ob = Orangeboard(master_rel_is_directed, debug=True) - node = ob.add_node('disont_disease', 'DOID:12365', desc='malaria', seed_node_bool=True) - expand_disont_disease(ob, node) - ob.neo4j_set_url() # use default url - ob.neo4j_set_auth() # use default username/password - ob.neo4j_push() - - -def test_description_disont2(): - ob = Orangeboard(master_rel_is_directed, debug=True) - node = ob.add_node('disont_disease', 'DOID:9352', desc='foobar', seed_node_bool=True) - expand_disont_disease(ob, node) - ob.neo4j_set_url() # use default url - ob.neo4j_set_auth() # use default username/password - ob.neo4j_push() - - -def test_add_mim(): - ob = Orangeboard(master_rel_is_directed, debug=True) - node = ob.add_node('omim_disease', 'OMIM:603903', desc='sickle-cell anemia', seed_node_bool=True) - expand_omim_disease(ob, node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - -def test_issue2(): - ob = Orangeboard(master_rel_is_directed, debug=True) - node = ob.add_node('omim_disease', 'OMIM:603933', desc='sickle-cell anemia', seed_node_bool=True) - expand_omim_disease(ob, node) - - -def test_issue3(): - ob = Orangeboard(master_rel_is_directed, debug=True) - disease_node = ob.add_node('disont_disease', 'DOID:9352', desc='foo', seed_node_bool=True) - expand_all_nodes(ob) - expand_all_nodes(ob) - expand_all_nodes(ob) - - -def test_issue6(): - ob = Orangeboard(master_rel_is_directed, debug=True) - ob.add_node('omim_disease', 'OMIM:605027', desc='LYMPHOMA, NON-HODGKIN, FAMILIAL', seed_node_bool=True) - expand_all_nodes(ob) - expand_all_nodes(ob) - expand_all_nodes(ob) - - -def test_issue7(): - ob = Orangeboard(master_rel_is_directed, debug=True) - ob.add_node('omim_disease', 'OMIM:605275', desc='NOONAN SYNDROME 2; NS2', seed_node_bool=True) - expand_all_nodes(ob) - expand_all_nodes(ob) - expand_all_nodes(ob) - - -def test_issue9(): - ob = Orangeboard(master_rel_is_directed, debug=True) - node1 = ob.add_node('uniprot_protein', 'P16887', desc='HBB') - node2 = ob.add_node('uniprot_protein', 'P09601', desc='HMOX1') - ob.add_rel('interacts_with', 'reactome', node1, node2) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - -def test_microrna(): - ob = Orangeboard(master_rel_is_directed, debug=True) - ob.add_node('omim_disease', 'OMIM:613074', desc='deafness', seed_node_bool=True) - expand_all_nodes(ob) - expand_all_nodes(ob) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - -def test_anatomy_1(): - ob = Orangeboard(master_rel_is_directed, debug=True) - mir96 = ob.add_node('ncbigene_microrna', 'NCBIGene:407053', desc='MIR96', seed_node_bool=True) - - expand_ncbigene_microrna(ob, mir96) - ob.neo4j_set_url() # use default url - ob.neo4j_set_auth() # use default username/password - ob.neo4j_push() - - -def test_anatomy_2(): - ob = Orangeboard(master_rel_is_directed, debug=True) - hmox1 = ob.add_node('uniprot_protein', 'P09601', desc='HMOX1', seed_node_bool=True) - - expand_uniprot_protein(ob, hmox1) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - -def test_anatomy_3(): - ob = Orangeboard(master_rel_is_directed, debug=True) - mkd = ob.add_node('phenont_phenotype', 'HP:0000003', desc='Multicystic kidney dysplasia', seed_node_bool=True) - - expand_phenont_phenotype(ob, mkd) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - -def test_expand_pharos_drug(): - ob = Orangeboard(master_rel_is_directed, debug=True) - lovastatin = ob.add_node('pharos_drug', 'lovastatin', desc='lovastatin', seed_node_bool=True) - - expand_pharos_drug(ob, lovastatin) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - -if __name__ == '__main__': - parser = argparse.ArgumentParser(description='prototype reasoning tool for Q1, NCATS competition, 2017') - parser.add_argument('--test', dest='test_function_to_call') - args = parser.parse_args() - args_dict = vars(args) - if args_dict.get('test_function_to_call', None) is not None: - print('going to call function: ' + args_dict['test_function_to_call']) - print(timeit.timeit(lambda: globals()[args_dict['test_function_to_call']](), number=1)) diff --git a/code/reasoningtool/deprecated_modules/TestSet.py b/code/reasoningtool/deprecated_modules/TestSet.py deleted file mode 100644 index 7355abac8..000000000 --- a/code/reasoningtool/deprecated_modules/TestSet.py +++ /dev/null @@ -1,411 +0,0 @@ -''' This module defines all the unit tests and integration testing. - - NOTE: run this script with - python3 -u - in order to see print debugging statements as they are printed, if you - are redirecting stdout and stderr to a file. -''' - -__author__ = 'Yao Yao' -__copyright__ = 'Oregon State University' -__credits__ = ['Yao Yao', 'Zheng Liu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -import argparse -import timeit -import requests_cache -import sys -from Orangeboard import Orangeboard -from BioNetExpander import BioNetExpander -import pandas -import os -import re - -#requests_cache.install_cache('orangeboard') -# specifiy the path of orangeboard database -pathlist = os.path.realpath(__file__).split(os.path.sep) -RTXindex = pathlist.index("RTX") -dbpath = os.path.sep.join([*pathlist[:(RTXindex+1)],'data','orangeboard']) -requests_cache.install_cache(dbpath) - -ob = Orangeboard(debug=True) -ob.neo4j_set_url() -ob.neo4j_set_auth() - -bne = BioNetExpander(ob) - -q1_diseases_dict = {'DOID:11476': 'osteoporosis', - 'DOID:526': 'HIV infectious disease', - 'DOID:1498': 'cholera', - 'DOID:4325': 'Ebola hemmorhagic fever', - 'DOID:12365': 'malaria', - 'DOID:10573': 'Osteomalacia', - 'DOID:13810': 'hypercholesterolemia', - 'DOID:9352': 'type 2 diabetes mellitus', - 'DOID:2841': 'asthma', - 'DOID:4989': 'pancreatitis', - 'DOID:10652': 'Alzheimer Disease', - 'DOID:5844': 'Myocardial Infarction', - 'DOID:11723': 'Duchenne Muscular Dystrophy', - 'DOID:0060728': 'NGLY1-deficiency', - 'DOID:0050741': 'Alcohol Dependence', - 'DOID:1470': 'major depressive disorder', - 'DOID:14504': 'Niemann-Pick disease', - 'DOID:12858': 'Huntington\'s Disease', - 'DOID:9270': 'Alkaptonuria', - 'DOID:10923': 'sickle cell anemia', - 'DOID:2055': 'post-traumatic stress disorder'} - -def seed_kg_q1(): - ## seed all 21 diseases in the Orangeboard - ## set the seed node flag to True, for the first disease - seed_node_bool = True - for disont_id_str in q1_diseases_dict.keys(): - ob.add_node('disont_disease', disont_id_str, seed_node_bool) - ## for the rest of the diseases, do not set the seed-node flag - seed_node_bool = False - - ## triple-expand the knowledge graph - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - - omim_df = pandas.read_csv('../../q1/Genetic_conditions_from_OMIM.txt', - sep='\t')[['MIM_number','preferred_title']] - first_row = True - for index, row in omim_df.iterrows(): - ob.add_node('omim_disease', 'OMIM:' + str(row['MIM_number']), - desc=row['preferred_title'], - seed_node_bool=first_row) - if first_row: - first_row = False - - ## triple-expand the knowledge graph - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - -def seed_kg_q2(): - - drug_dis_df = pandas.read_csv('../../q2/q2-drugandcondition-list.txt', - sep='\t') - - first_row = True - for index, row in drug_dis_df.iterrows(): - ob.add_node('pharos_drug', row['Drug'].lower(), seed_node_bool=first_row) - if first_row: - first_row = False - - ## triple-expand the knowledge graph - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - -def make_master_kg(): - seed_kg_q1() - seed_kg_q2() - ob.neo4j_set_url('bolt://0.0.0.0:7687') - ob.neo4j_push() - print("count(Node) = {}".format(ob.count_nodes())) - print("count(Rel) = {}".format(ob.count_rels())) - -def make_q1_kg_and_save_as_csv(): - seed_kg_q1() - nodes_file = open('nodes.csv', 'w') - nodes_file.write(ob.simple_print_nodes()) - nodes_file.close() - rels_file = open('rels.csv', 'w') - rels_file.write(ob.simple_print_rels()) - rels_file.close() - -def test_omim_8k(): - omim_df = pandas.read_csv('../../genetic_conditions/Genetic_conditions_from_OMIM.txt', - sep='\t')[['MIM_number','preferred_title']] - first_row = True - for index, row in omim_df.iterrows(): - ob.add_node('omim_disease', 'OMIM:' + str(row['MIM_number']), seed_node_bool=first_row) - if first_row: - first_row = False - - ## expand the knowledge graph - bne.expand_all_nodes() - -def read_drug_dis(): - drug_dis_df = pandas.read_csv('../../q2/q2-drugandcondition-list.txt', - sep='\t') - for index, row in drug_dis_df.iterrows(): - print('add drug: ' + row['Drug'].lower()) - -def test_description_mim(): - node = ob.add_node('omim_disease', 'OMIM:603903', desc='sickle-cell anemia', seed_node_bool=True) - bne.expand_omim_disease(node) - ob.neo4j_push() - - -def test_description_uniprot(): - node = ob.add_node('uniprot_protein', 'P68871', desc='HBB', seed_node_bool=True) - print(ob) - bne.expand_uniprot_protein(node) - ob.neo4j_push() - - -def test_description_disont(): - node = ob.add_node('disont_disease', 'DOID:12365', desc='malaria', seed_node_bool=True) - bne.expand_disont_disease(node) - ob.neo4j_push() - - -def test_description_disont2(): - node = ob.add_node('disont_disease', 'DOID:9352', desc='foobar', seed_node_bool=True) - bne.expand_disont_disease(node) - ob.neo4j_push() - - -def test_add_mim(): - node = ob.add_node('omim_disease', 'OMIM:603903', desc='sickle-cell anemia', seed_node_bool=True) - bne.expand_omim_disease(node) - ob.neo4j_push() - - -def test_issue2(): - node = ob.add_node('omim_disease', 'OMIM:603933', desc='sickle-cell anemia', seed_node_bool=True) - bne.expand_omim_disease(node) - - -def test_issue3(): - disease_node = ob.add_node('disont_disease', 'DOID:9352', desc='foo', seed_node_bool=True) - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - - -def test_issue6(): - ob.add_node('omim_disease', 'OMIM:605027', desc='LYMPHOMA, NON-HODGKIN, FAMILIAL', seed_node_bool=True) - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - - -def test_issue7(): - ob.add_node('omim_disease', 'OMIM:605275', desc='NOONAN SYNDROME 2; NS2', seed_node_bool=True) - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - - -def test_issue9(): - node1 = ob.add_node('uniprot_protein', 'P16887', desc='HBB', seed_node_bool=True) - node2 = ob.add_node('uniprot_protein', 'P09601', desc='HMOX1') - ob.add_rel('interacts_with', 'reactome', node1, node2) - ob.neo4j_push() - - -def test_microrna(): - ob.add_node('omim_disease', 'OMIM:613074', desc='deafness', seed_node_bool=True) - bne.expand_all_nodes() - bne.expand_all_nodes() - ob.neo4j_push() - - -def test_anatomy_1(): - mir96 = ob.add_node('ncbigene_microrna', 'NCBIGene:407053', desc='MIR96', seed_node_bool=True) - - bne.expand_ncbigene_microrna(mir96) - ob.neo4j_push() - - -def test_anatomy_2(): - hmox1 = ob.add_node('uniprot_protein', 'P09601', desc='HMOX1', seed_node_bool=True) - - bne.expand_uniprot_protein(hmox1) - ob.neo4j_push() - - -def test_anatomy_3(): - mkd = ob.add_node('phenont_phenotype', 'HP:0000003', desc='Multicystic kidney dysplasia', seed_node_bool=True) - - bne.expand_phenont_phenotype(mkd) - ob.neo4j_push() - - -def test_expand_pharos_drug(): - lovastatin = ob.add_node('pharos_drug', 'lovastatin', desc='lovastatin', seed_node_bool=True) - - bne.expand_pharos_drug(lovastatin) - ob.neo4j_push() - -def lysine_test_1(): - ob.add_node('pharos_drug', 'acetaminophen', desc='acetaminophen', seed_node_bool=True) - - bne.expand_all_nodes() - ob.neo4j_push() - -def lysine_test_2(): - ob.add_node('pharos_drug', 'acetaminophen', desc='acetaminophen', seed_node_bool=True) - - bne.expand_all_nodes() - bne.expand_all_nodes() - ob.neo4j_push() - -def lysine_test_3(): - ob.add_node('pharos_drug', 'acetaminophen', desc='acetaminophen', seed_node_bool=True) - - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - ob.neo4j_push() - -def lysine_test_4(): - ob.add_node('disont_disease', 'DOID:1498', desc='cholera', seed_node_bool=True) - - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - ob.neo4j_push() - - print("[lysine_test_4] count(Node) = {}".format(ob.count_nodes())) - print("[lysine_test_4] count(Rel) = {}".format(ob.count_rels())) - -def lysine_test_5(): - ob.add_node('disont_disease', 'DOID:12365', desc='malaria', seed_node_bool=True) - ob.add_node('disont_disease', 'DOID:1498', desc='cholera', seed_node_bool=True) - - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - ob.neo4j_push() - - print("[lysine_test_5] count(Node) = {}".format(ob.count_nodes())) - print("[lysine_test_5] count(Rel) = {}".format(ob.count_rels())) - -def test_issue19(): - genetic_condition_mim_id = 'OMIM:219700' # cystic fibrosis - target_disease_disont_id = 'DOID:1498' # cholera - - disease_node = ob.add_node('disont_disease', target_disease_disont_id, desc='cholera', seed_node_bool=True) - - print('----------- first round of expansion ----------') - bne.expand_all_nodes() - - print('----------- second round of expansion ----------') - bne.expand_all_nodes() - - print('----------- third round of expansion ----------') - bne.expand_all_nodes() - -def test_q1_singleexpand(): - ## seed all 21 diseases in the Orangeboard - ## set the seed node flag to True, for the first disease - seed_node_bool = True - for disont_id_str in q1_diseases_dict.keys(): - ob.add_node('disont_disease', disont_id_str, seed_node_bool) - ## for the rest of the diseases, do not set the seed-node flag - seed_node_bool = False - - bne.expand_all_nodes() - - ob.neo4j_set_url('bolt://0.0.0.0:7687') - ob.neo4j_push() - - print("[Q1] count(Node) = {}".format(ob.count_nodes())) - print("[Q1] count(Rel) = {}".format(ob.count_rels())) - -def test_q1_no_push(): - ## seed all 21 diseases in the Orangeboard - ## set the seed node flag to True, for the first disease - seed_node_bool = True - for disont_id_str in q1_diseases_dict.keys(): - ob.add_node('disont_disease', disont_id_str, seed_node_bool) - ## for the rest of the diseases, do not set the seed-node flag - seed_node_bool = False - - ## triple-expand the knowledge graph - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - - ob.neo4j_set_url('bolt://0.0.0.0:7687') -# ob.neo4j_push() - - print("[Q1] count(Node) = {}".format(ob.count_nodes())) - print("[Q1] count(Rel) = {}".format(ob.count_rels())) - -def lysine_test_6(): - ob.add_node('disont_disease', 'DOID:12365', desc='malaria', seed_node_bool=True) - ob.add_node('disont_disease', 'DOID:1498', desc='cholera', seed_node_bool=True) - ob.add_node('disont_disease', 'DOID:2841', desc='asthma', seed_node_bool=True) - ob.add_node('disont_disease', 'DOID:526', desc='HIV', seed_node_bool=True) - - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - # ob.neo4j_push() - - print("[lysine_test_6] count(Node) = {}".format(ob.count_nodes())) - print("[lysine_test_6] count(Rel) = {}".format(ob.count_rels())) - -def test_ob_size(): - ob.add_node('phenont_phenotype', "HP:0000107", desc='Renal cyst', seed_node_bool=True) - bne.expand_all_nodes() - bne.expand_all_nodes() - print('size is: ' + str(ob.bytesize())) - -def test_expand_phenont_phenotype(): - ob.add_node('phenont_phenotype', "HP:0000107", desc='Renal cyst', seed_node_bool=True) - bne.expand_all_nodes() - ob.neo4j_push() - -def test_query_path_from_gc_to_disease(): - # this test should be conducted after bigtest or bigtest2 complete - # ob = Orangeboard(debug=False) - # master_rel_is_directed = {'disease_affects': True, - # 'is_member_of': True, - # 'is_parent_of': True, - # 'gene_assoc_with': True, - # 'phenotype_assoc_with': True, - # 'interacts_with': False, - # 'controls_expression_of': True, - # 'is_expressed_in': True, - # 'targets': True} - #ob.set_dict_reltype_dirs(master_rel_is_directed) - #ob.neo4j_set_url() - #ob.neo4j_set_auth() - # path = ob.neo4j_run_cypher_query("Match p=(a:omim_disease)<--(b)-->(c:uniprot_protein) " - # "RETURN p LIMIT 1").single()['p'] - - result = ob.neo4j_run_cypher_query("match p=(n)-[*..3]-(m) where n.name='OMIM:219700' and m.name='DOID:1498' return p, nodes(p), relationships(p)") - - for record in result: - print('path:') - nodes = record[1] - rels = record[2] - - for r in rels: - start_node_desc = [n for n in nodes if n.get('UUID') == r.get('source_node_uuid')][0].get('description') - end_node_desc = [n for n in nodes if n.get('UUID') == r.get('target_node_uuid')][0].get('description') - rel_desc = r.type - print(" ({}) ---- [{}] ---->({})".format(start_node_desc, rel_desc, end_node_desc)) - print("\n") - -def test_count_nodes_by_nodetype(): - num_nodes_by_nodetype = ob.count_nodes_by_nodetype() - print(num_nodes_by_nodetype) - -if __name__ == '__main__': - parser = argparse.ArgumentParser(description='Testing prototype for Q1, NCATS competition, 2017') - parser.add_argument('--test', dest='test_function_to_call') - args = parser.parse_args() - args_dict = vars(args) - if args_dict.get('test_function_to_call', None) is not None: - print('going to call function: ' + args_dict['test_function_to_call']) - test_function_name = args_dict['test_function_to_call'] - try: - test_function = globals()[test_function_name] - except KeyError: - sys.exit('Unable to find test function named: ' + test_function_name) - test_running_time = timeit.timeit(lambda: test_function(), number=1) - print('running time for test: ' + str(test_running_time)) diff --git a/code/reasoningtool/future/PathAnalyzer.py b/code/reasoningtool/future/PathAnalyzer.py deleted file mode 100644 index 49f514b4f..000000000 --- a/code/reasoningtool/future/PathAnalyzer.py +++ /dev/null @@ -1,131 +0,0 @@ -""" This module defines class PathAnalyzer which is written for analyzing path -via path's properties (e.g node counts, edge counts in specific path). -""" - -__author__ = "" -__copyright__ = "" -__credits__ = [] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from Orangeboard import Orangeboard - - - -class PathAnalyzer: - """ - We will need Python code (probably using Cypher via neo4j.v1) that can, given a path, - return the following information: - - (1) the relationship types of all edges in the path - (2) the directions of all edges in the path - (3) the node types of all nodes in the path - (4) the source database for all edges in the path (“sourcedeb” relationship property) - (5) the in-degree of all nodes in the path - (6) the out-degree of all nodes in the path - - Note— if you get the node sequence you can get items (1), (2), (3), (4) from Orangeboard and node or - relationship properties. - - For (5) and (6) you will have to use Cypher. - """ - def __init__(self, orangeboard): - self.orangeboard = orangeboard - - @staticmethod - def get_all_reltypes_in_path(path): - return list(map(lambda r: r.type, path.relationships)) - - @staticmethod - def get_all_dirs_in_path(path): - def __generate_dirs(path): - # There are (n+1) nodes and n relationships in a path of length n - # type(path.nodes) == tuple - # type(path.relationships) == tuple - for node, rel in zip(path.nodes[0:-1], path.relationships): - if node.id == rel.start: - yield "-->" - elif node.id == rel.end: - yield "<--" - else: - raise ValueError("Node {} is not within Rel {}".format(node.id, rel)) - - return list(__generate_dirs(path)) - - @staticmethod - def get_all_nodetypes_in_path(path): - def __exclude_base_type(node): - # type(node.labels) == set - # Assume that only 1 element exists in the difference - return next(iter((node.labels - set(['Base'])))) - - return list(map(__exclude_base_type, path.nodes)) - - @staticmethod - def get_all_rel_sourcedb_in_path(path): - return list(map(lambda r: r.properties['sourcedb'], path.relationships)) - - def get_all_in_degrees_in_path(self, path): - # `MATCH (s)<-[r]-() WHERE s.UUID IN $uuid_lst RETURN count(r)` does not preserve the order of $uuid_lst - # So here make a query for each node in the path - def __get_in_degree(node): - query = "MATCH (s)<-[r]-() WHERE s.UUID = $uuid RETURN count(r) AS in_degree" - stmt_resp = self.orangeboard.neo4j_run_cypher_query(query, parameters={'uuid': node.properties['UUID']}) - return stmt_resp.single()['in_degree'] - - return list(map(__get_in_degree, path.nodes)) - - def get_all_out_degrees_in_path(self, path): - # `MATCH (s)-[r]->() WHERE s.UUID IN $uuid_lst RETURN count(r)` does not preserve the order of $uuid_lst - # So here make a query for each node in the path - def __get_out_degree(node): - query = "MATCH (s)-[r]->() WHERE s.UUID = $uuid RETURN count(r) AS out_degree" - stmt_resp = self.orangeboard.neo4j_run_cypher_query(query, parameters={'uuid': node.properties['UUID']}) - return stmt_resp.single()['out_degree'] - - return list(map(__get_out_degree, path.nodes)) - - -if __name__ == '__main__': - ob = Orangeboard(debug=False) - - master_rel_is_directed = {'disease_affects': True, - 'is_member_of': True, - 'is_parent_of': True, - 'gene_assoc_with': True, - 'phenotype_assoc_with': True, - 'interacts_with': False, - 'controls_expression_of': True, - 'is_expressed_in': True, - 'targets': True} - - ob.set_dict_reltype_dirs(master_rel_is_directed) - ob.neo4j_set_url() - ob.neo4j_set_auth() - - ob.neo4j_clear() - - node1 = ob.add_node('uniprot_protein', 'P16887', desc='HBB', seed_node_bool=True) - node2 = ob.add_node('uniprot_protein', 'P09601', desc='HMOX1', seed_node_bool=True) - ob.add_rel('interacts_with', 'reactome', node1, node2) # bi-directional; actually 2 rels - - node3 = ob.add_node("omim_disease", "OMIM:603903", desc='sickle-cell anemia', seed_node_bool=True) - ob.add_rel('controls_expression_of', 'OMIM', node2, node3) - - ob.neo4j_push() - - # (OMIM:603903)<-[regulates]-(P09601)-[interacts_with]->(P16887) - path = ob.neo4j_run_cypher_query("Match p=(a:omim_disease)<--(b:uniprot_protein)-->(c:uniprot_protein) " - "RETURN p LIMIT 1").single()['p'] - - pa = PathAnalyzer(ob) - - print("[Rel Types] : {}".format(PathAnalyzer.get_all_reltypes_in_path(path))) - print("[Rel Directions]: {}".format(PathAnalyzer.get_all_dirs_in_path(path))) - print("[Node Types] : {}".format(PathAnalyzer.get_all_nodetypes_in_path(path))) - print("[Rel SourceDBs] : {}".format(PathAnalyzer.get_all_rel_sourcedb_in_path(path))) - print("[In-degrees] : {}".format(pa.get_all_in_degrees_in_path(path))) - print("[Out-degrees] : {}".format(pa.get_all_out_degrees_in_path(path))) diff --git a/code/reasoningtool/kg-construction/AddProtToGO.py b/code/reasoningtool/kg-construction/AddProtToGO.py deleted file mode 100644 index 21c364c8c..000000000 --- a/code/reasoningtool/kg-construction/AddProtToGO.py +++ /dev/null @@ -1,115 +0,0 @@ -''' This module defines the class UpdateNodesName. UpdateNodesName class is designed -to retrieve the node name and update the name on the Graphic model object. -The available methods include: - -* update_protein_names - - Description: retrieve names from Uniprot and update protein nodes - -How to run this module - $ cd [git repo]/code/reasoningtool/kg-construction - $ python3 UpdateNodesName.py -''' - -# BEGIN config.json format -# { -# "url":"bolt://localhost:7687" -# "username":"xxx", -# "password":"xxx" -# } -# END config.json format - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -from Neo4jConnection import Neo4jConnection -from QueryUniprotExtended import QueryUniprotExtended -import json -import sys -from time import time -from QueryMyGene import QueryMyGene -import requests_cache -import re, os - -# configure requests package to use the "orangeboard.sqlite" cache -#requests_cache.install_cache('orangeboard') -# specifiy the path of orangeboard database -pathlist = os.path.realpath(__file__).split(os.path.sep) -RTXindex = pathlist.index("RTX") -dbpath = os.path.sep.join([*pathlist[:(RTXindex+1)],'data','orangeboard']) -requests_cache.install_cache(dbpath) - -t = time() - -f = open('config.json', 'r') -config_data = f.read() -f.close() -config = json.loads(config_data) - -mg = QueryMyGene() - -conn = Neo4jConnection(config['url'], config['username'], config['password']) - - -def get_proteins(tx): - result = tx.run("MATCH (n:protein) return n.id, n.UUID") - return dict((record["n.id"], record["n.UUID"]) for record in result) - - -def get_molfunc(tx): - result = tx.run("MATCH (n:molecular_function) return n.id, n.UUID") - return dict((record["n.id"], record["n.UUID"]) for record in result) - - -def get_cellcomp(tx): - result = tx.run("MATCH (n:cellular_component) return n.id, n.UUID") - return dict((record["n.id"], record["n.UUID"]) for record in result) - - -def get_seed_node_uuid(tx): - return next(iter(tx.run("MATCH (n:protein) return n.seed_node_uuid limit 1")))["n.seed_node_uuid"] - - -protein_dict = conn._driver.session().read_transaction(get_proteins) - -molfunc_dict = conn._driver.session().read_transaction(get_molfunc) - -cellcomp_dict = conn._driver.session().read_transaction(get_cellcomp) - -seed_node_uuid = conn._driver.session().read_transaction(get_seed_node_uuid) - -i = 0 -for protein_curie_id, protein_uuid in protein_dict.items(): - protein_id = protein_curie_id.replace("UniProtKB:", "") - gene_ont_info_dict = mg.get_gene_ontology_ids_for_uniprot_id(protein_id) - for gene_ont_id, gene_ont_dict in gene_ont_info_dict.items(): - if gene_ont_dict['ont'] == 'molecular_function': - if gene_ont_id in molfunc_dict: - molfunc_uuid = molfunc_dict[gene_ont_id] - if i % 100 == 0: - print("have inserted: " + str(i) + " relationships") - i += 1 - cypher_query = "MATCH (a:protein),(b:molecular_function) WHERE a.id = \'" + protein_curie_id + "\' AND b.id=\'" + gene_ont_id + "\' CREATE (a)-[r:is_capable_of { is_defined_by: \'RTX\', predicate: \'is_capable_of\', provided_by: \'gene_ontology\', relation: \'is_capable_of\', seed_node_uuid: \'" + seed_node_uuid + "\', source_node_uuid: \'" + protein_uuid + "\', target_node_uuid: \'" + molfunc_uuid + "\'} ]->(b) RETURN type(r)" -# print(cypher_query) - conn._driver.session().write_transaction(lambda tx: tx.run(cypher_query)) -# print(cypher_query) - else: - if gene_ont_id in cellcomp_dict: - cellcomp_uuid = cellcomp_dict[gene_ont_id] - if i % 100 == 0: - print("have inserted: " + str(i) + " relationships") - i += 1 - cypher_query = "MATCH (a:protein),(b:cellular_component) WHERE a.id = \'" + protein_curie_id + "\' AND b.id=\'" + gene_ont_id + "\' CREATE (a)-[r:expressed_in { is_defined_by: \'RTX\', predicate: \'expressed_in\', provided_by: \'gene_ontology\', relation: \'expressed_in\', seed_node_uuid: \'" + seed_node_uuid + "\', source_node_uuid: \'" + protein_uuid + "\', target_node_uuid: \'" + cellcomp_uuid + "\'} ]->(b) RETURN type(r)" -# print(cypher_query) - conn._driver.session().write_transaction(lambda tx: tx.run(cypher_query)) -# print(cypher_query) - - -conn.close() - diff --git a/code/reasoningtool/kg-construction/BioNetExpander.py b/code/reasoningtool/kg-construction/BioNetExpander.py deleted file mode 100644 index 5b058fc60..000000000 --- a/code/reasoningtool/kg-construction/BioNetExpander.py +++ /dev/null @@ -1,775 +0,0 @@ -""" This is a module to define class BioNetExpander. -BioNetExpander carries the function of expanding objects to objects (two objects -can belong to distinct types or same type) from multiple online sources. -BioNetExpander is capable of expanding from nodes of various types, including: - * drug - * gene - * disease - * pathway - * anatomy - * protein - * phenotype -""" - -__author__ = 'Stephen Ramsey' -__copyright__ = 'Oregon State University', -__credits__ = ['Yao Yao', 'Stephen Ramsey', 'Zheng Liu'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -import re -from operator import methodcaller -import timeit -import argparse -import sys - -from Orangeboard import Orangeboard -from QueryOMIM import QueryOMIM -from QueryMyGene import QueryMyGene -from QueryReactome import QueryReactome -from QueryDisont import QueryDisont -from QueryDisGeNet import QueryDisGeNet -from QueryGeneProf import QueryGeneProf -from QueryBioLink import QueryBioLink -from QueryMiRGate import QueryMiRGate -from QueryMiRBase import QueryMiRBase -from QueryPharos import QueryPharos -from QuerySciGraph import QuerySciGraph -from QueryChEMBL import QueryChEMBL -# from QueryUniprotExtended import QueryUniprotExtended -from QueryKEGG import QueryKEGG -from QueryUniprot import QueryUniprot -from DrugMapper import DrugMapper - - -class BioNetExpander: - - CURIE_PREFIX_TO_IRI_PREFIX = {"OMIM": "http://purl.obolibrary.org/obo/OMIM_", - "UniProtKB": "http://identifiers.org/uniprot/", - "NCBIGene": "https://www.ncbi.nlm.nih.gov/gene/", - "HP": "http://purl.obolibrary.org/obo/HP_", - "DOID": "http://purl.obolibrary.org/obo/DOID_", - "REACT": "https://reactome.org/content/detail/", - "CHEMBL.COMPOUND": "https://www.ebi.ac.uk/chembl/compound/inspect/", - "UBERON": "http://purl.obolibrary.org/obo/UBERON_", - "GO": "http://purl.obolibrary.org/obo/GO_", - "CL": "http://purl.obolibrary.org/obo/CL_", - "KEGG": "http://www.genome.jp/dbget-bin/www_bget?"} - - NODE_SIMPLE_TYPE_TO_CURIE_PREFIX = {"chemical_substance": "CHEMBL.COMPOUND", - "protein": "UniProtKB", - "genetic_condition": "OMIM", - "anatomical_entity": "UBERON", - "microRNA": "NCBIGene", - "phenotypic_feature": "HP", - "disease": "DOID", - "pathway": "REACT", - "biological_process": "GO", - "cellular_component": "GO", - "molecular_function": "GO", - "metabolite": "KEGG"} - - MASTER_REL_IS_DIRECTED = {"subclass_of": True, - "gene_associated_with_condition": True, - "affects": True, - "regulates": True, - "expressed_in": True, - "physically_interacts_with": False, - "gene_mutations_contribute_to": True, - "participates_in": True, - "involved_in": True, - "has_phenotype": True, - "has_part": True, - "capable_of": True, - "indicated_for": True, - "contraindicated_for": True, - "causes_or_contributes_to": True, - 'positively_regulates': True, - 'negatively_regulates': True} - - GO_ONTOLOGY_TO_PREDICATE = {"biological_process": "involved_in", - "cellular_component": "expressed_in", - "molecular_function": "capable_of"} - - def __init__(self, orangeboard): - orangeboard.set_dict_reltype_dirs(self.MASTER_REL_IS_DIRECTED) - self.orangeboard = orangeboard - self.query_omim_obj = QueryOMIM('1337') - self.query_mygene_obj = QueryMyGene(debug=False) - self.gene_symbols_to_protein_nodes = dict() - - def add_node_smart(self, simple_node_type, name, seed_node_bool=False, desc=''): - if name.endswith("PHENOTYPE") or name.startswith("MP:"): - return None - - simple_node_type_fixed = simple_node_type - if simple_node_type == "disease" and "OMIM:" in name: - simple_node_type_fixed = "genetic_condition" - - curie_prefix = self.NODE_SIMPLE_TYPE_TO_CURIE_PREFIX[simple_node_type_fixed] - if name.startswith("CL:"): - curie_prefix = "CL" - - iri_prefix = self.CURIE_PREFIX_TO_IRI_PREFIX[curie_prefix] - if ":" not in name: - accession = name - curie_id = curie_prefix + ":" + name - iri = iri_prefix + name - else: - curie_id = name - accession = name.split(":")[1] - iri = iri_prefix + accession - - if simple_node_type == "protein" and desc == "": - gene_symbol = QueryUniprot.get_protein_gene_symbol(curie_id) - desc = gene_symbol - - node = None - - if simple_node_type == "protein": - gene_symbol = desc - if gene_symbol in self.gene_symbols_to_protein_nodes: - node = self.gene_symbols_to_protein_nodes[gene_symbol] - - if node is None: - if simple_node_type == "protein": - protein_name = self.query_mygene_obj.get_protein_name(name) - if protein_name == "None": - protein_name = desc - node = self.orangeboard.add_node(simple_node_type, - name, - seed_node_bool, - protein_name) - else: - node = self.orangeboard.add_node(simple_node_type, - name, - seed_node_bool, - desc) - - extra_props = {"uri": iri, - "id": curie_id, - "accession": accession} - - assert ":" in curie_id - - if simple_node_type == "protein" or simple_node_type == "microRNA": - extra_props["symbol"] = desc - - node.set_extra_props(extra_props) - - if simple_node_type == "protein": - gene_symbol = desc - self.gene_symbols_to_protein_nodes[gene_symbol] = node - - return node - - @staticmethod - def is_mir(gene_symbol): - return re.match('MIR\d.*', gene_symbol) is not None or re.match('MIRLET\d.*', gene_symbol) is not None - - def expand_metabolite(self, node): - assert node.nodetype == "metabolite" - metabolite_kegg_id = node.name - ec_ids = QueryKEGG.map_kegg_compound_to_enzyme_commission_ids(metabolite_kegg_id) - if len(ec_ids) > 0: - if len(ec_ids) > 300: - print("Warning: metabolite " + metabolite_kegg_id + " has a huge number of associated ECs: " + str(len(ec_ids)), - file=sys.stderr) - for ec_id in ec_ids: - uniprot_ids = QueryUniprot.map_enzyme_commission_id_to_uniprot_ids(ec_id) - if len(uniprot_ids) > 0: - for uniprot_id in uniprot_ids: - gene_symbols = self.query_mygene_obj.convert_uniprot_id_to_gene_symbol(uniprot_id) - if len(gene_symbols) > 0: - gene_symbol = ";".join(list(gene_symbols)) - prot_node = self.add_node_smart("protein", uniprot_id, desc=gene_symbol) - if prot_node is not None: - self.orangeboard.add_rel("physically_interacts_with", "KEGG;UniProtKB", node, prot_node, extended_reltype="physically_interacts_with") - - def expand_chemical_substance(self, node): - assert node.nodetype == "chemical_substance" - compound_desc = node.desc - target_uniprot_ids = QueryChEMBL.get_target_uniprot_ids_for_drug(compound_desc) - if target_uniprot_ids is not None: - for target_uniprot_id_curie in target_uniprot_ids.keys(): - target_uniprot_id = target_uniprot_id_curie.replace("UniProtKB:", "") - probability = target_uniprot_ids[target_uniprot_id] - gene_names = self.query_mygene_obj.convert_uniprot_id_to_gene_symbol(target_uniprot_id) - node_desc = ';'.join(list(gene_names)) - target_node = self.add_node_smart('protein', target_uniprot_id, desc=node_desc) - if target_node is not None: - self.orangeboard.add_rel('physically_interacts_with', 'ChEMBL', node, target_node, prob=probability, extended_reltype='targets') - - targets = QueryPharos.query_drug_name_to_targets(compound_desc) - if targets is not None: - for target in targets: - uniprot_id = QueryPharos.query_target_uniprot_accession(str(target["id"])) - assert '-' not in uniprot_id - gene_symbol = self.query_mygene_obj.convert_uniprot_id_to_gene_symbol(uniprot_id) - if gene_symbol is not None: - gene_symbol = ';'.join(list(gene_symbol)) - else: - gene_symbol = '' - target_node = self.add_node_smart('protein', uniprot_id, desc=gene_symbol) - if target_node is not None: - self.orangeboard.add_rel('physically_interacts_with', 'Pharos', node, target_node, extended_reltype="targets") - - res_dict = DrugMapper.map_drug_to_ontology(node.name) - res_indications_set = res_dict['indications'] - res_contraindications_set = res_dict['contraindications'] - - for ont_term in res_indications_set: - if ont_term.startswith('DOID:') or ont_term.startswith('OMIM:'): - ont_name = QueryBioLink.get_label_for_disease(ont_term) - ont_node = self.add_node_smart('disease', ont_term, desc=ont_name) - self.orangeboard.add_rel('indicated_for', 'MyChem.info', node, ont_node, extended_reltype='indicated_for') - elif ont_term.startswith('HP:'): - ont_name = QueryBioLink.get_label_for_phenotype(ont_term) - ont_node = self.add_node_smart('phenotypic_feature', ont_term, desc=ont_name) - self.orangeboard.add_rel('indicated_for', 'MyChem.info', node, ont_node, extended_reltype='indicated_for') - - for ont_term in res_contraindications_set: - if ont_term.startswith('DOID:') or ont_term.startswith('OMIM:'): - ont_name = QueryBioLink.get_label_for_disease(ont_term) - ont_node = self.add_node_smart('disease', ont_term, desc=ont_name) - self.orangeboard.add_rel('contraindicated_for', 'MyChem.info', node, ont_node, extended_reltype='contraindicated_for') - elif ont_term.startswith('HP:'): - ont_name = QueryBioLink.get_label_for_phenotype(ont_term) - ont_node = self.add_node_smart('phenotypic_feature', ont_term, desc=ont_name) - self.orangeboard.add_rel('contraindicated_for', 'MyChem.info', node, ont_node, extended_reltype='contraindicated_for') - - res_hp_set = DrugMapper.map_drug_to_hp_with_side_effects(node.name) - for hp_term in res_hp_set: - if hp_term.startswith('HP:'): - hp_name = QueryBioLink.get_label_for_phenotype(hp_term) - hp_node = self.add_node_smart('phenotypic_feature', hp_term, desc=hp_name) - self.orangeboard.add_rel('causes_or_contributes_to', 'SIDER', node, hp_node, extended_reltype="causes_or_contributes_to") - - - def expand_microRNA(self, node): - assert node.nodetype == "microRNA" - ncbi_gene_id = node.name - assert 'NCBIGene:' in ncbi_gene_id - - entrez_gene_id = int(ncbi_gene_id.replace("NCBIGene:", "")) - # microRNA-to-GO (biological process): - go_bp_dict = self.query_mygene_obj.get_gene_ontology_ids_bp_for_entrez_gene_id(entrez_gene_id) - for go_id, go_term in go_bp_dict.items(): - gene_ontology_category_and_term_dict = QuerySciGraph.query_get_ontology_node_category_and_term(go_id) - if len(gene_ontology_category_and_term_dict) > 0: - ontology_name_str = gene_ontology_category_and_term_dict["category"].replace(" ", "_") - node2 = self.add_node_smart(ontology_name_str, go_id, desc=go_term) - if node2 is not None: - predicate = self.GO_ONTOLOGY_TO_PREDICATE[ontology_name_str] - self.orangeboard.add_rel(predicate, - 'gene_ontology', node, node2, extended_reltype=predicate) - - anatomy_dict = QueryBioLink.get_anatomies_for_gene(ncbi_gene_id) - for anatomy_id, anatomy_desc in anatomy_dict.items(): - anatomy_node = self.add_node_smart("anatomical_entity", anatomy_id, desc=anatomy_desc) - if anatomy_node is not None: - self.orangeboard.add_rel('expressed_in', 'BioLink', node, anatomy_node, extended_reltype="expressed_in") - - disease_ids_dict = QueryBioLink.get_diseases_for_gene_desc(ncbi_gene_id) - for disease_id in disease_ids_dict.keys(): - if 'OMIM:' in disease_id: - disease_node = self.add_node_smart('disease', disease_id, desc=disease_ids_dict[disease_id]) - if disease_node is not None: - self.orangeboard.add_rel('gene_associated_with_condition', 'BioLink', node, disease_node, extended_reltype="associated_with_disease") - elif 'DOID:' in disease_id: - disease_node = self.add_node_smart('disease', disease_id, - desc=disease_ids_dict[disease_id]) - if disease_node is not None: - self.orangeboard.add_rel('gene_associated_with_condition', 'BioLink', node, disease_node, extended_reltype="associated_with_disease") - else: - print('Warning: unexpected disease ID: ' + disease_id) - - phenotype_ids_dict = QueryBioLink.get_phenotypes_for_gene_desc(ncbi_gene_id) - for phenotype_id in phenotype_ids_dict.keys(): - phenotype_node = self.add_node_smart("phenotypic_feature", phenotype_id, desc=phenotype_ids_dict[phenotype_id]) - if phenotype_node is not None: - self.orangeboard.add_rel('has_phenotype', 'BioLink', node, phenotype_node, extended_reltype="has_phenotype") - - mirbase_ids = self.query_mygene_obj.convert_entrez_gene_ID_to_mirbase_ID( - int(ncbi_gene_id.replace('NCBIGene:', ''))) - for mirbase_id in mirbase_ids: - mature_mir_ids = QueryMiRBase.convert_mirbase_id_to_mature_mir_ids(mirbase_id) - for mature_mir_id in mature_mir_ids: - target_gene_symbols = QueryMiRGate.get_gene_symbols_regulated_by_microrna(mature_mir_id) - for target_gene_symbol in target_gene_symbols: - uniprot_ids = self.query_mygene_obj.convert_gene_symbol_to_uniprot_id(target_gene_symbol) - for uniprot_id in uniprot_ids: - assert '-' not in uniprot_id - target_prot_node = self.add_node_smart('protein', uniprot_id, desc=target_gene_symbol) - if target_prot_node is not None: - self.orangeboard.add_rel('regulates', 'miRGate', node, target_prot_node, extended_reltype="regulates_expression_of") - if len(uniprot_ids) == 0: - if BioNetExpander.is_mir(target_gene_symbol): - target_ncbi_entrez_ids = self.query_mygene_obj.convert_gene_symbol_to_entrez_gene_ID( - target_gene_symbol) - for target_ncbi_entrez_id in target_ncbi_entrez_ids: - target_mir_node = self.add_node_smart('microRNA', - 'NCBIGene:' + str(target_ncbi_entrez_id), - desc=target_gene_symbol) - if target_mir_node is not None and target_mir_node != node: - self.orangeboard.add_rel('regulates', 'miRGate', node, target_mir_node, extended_reltype="regulates_expression_of") - - def expand_pathway(self, node): - assert node.nodetype == "pathway" - reactome_id_str = node.name - uniprot_ids_from_reactome_dict = QueryReactome.query_reactome_pathway_id_to_uniprot_ids_desc(reactome_id_str) - rel_sourcedb_dict = dict.fromkeys(uniprot_ids_from_reactome_dict.keys(), 'reactome') - source_node = node - for uniprot_id in uniprot_ids_from_reactome_dict.keys(): - assert '-' not in uniprot_id - target_node = self.add_node_smart('protein', uniprot_id, desc=uniprot_ids_from_reactome_dict[uniprot_id]) - if target_node is not None: - self.orangeboard.add_rel('participates_in', rel_sourcedb_dict[uniprot_id], target_node, source_node, extended_reltype="participates_in") - - def expand_anatomical_entity(self, node): - assert node.nodetype == "anatomical_entity" - anatomy_curie_id_str = node.name - if not anatomy_curie_id_str.startswith("UBERON:"): - print("Anatomy node does not start with UBERON: " + anatomy_curie_id_str, file=sys.stderr) -# assert anatomy_curie_id_str.startswith("UBERON:") - gene_ontology_dict = QuerySciGraph.get_gene_ontology_curie_ids_for_uberon_curie_id(anatomy_curie_id_str) - for gene_ontology_curie_id_str, gene_ontology_term_dict in gene_ontology_dict.items(): - gene_ontology_type_str = gene_ontology_term_dict["ontology"].replace(" ", "_") - target_node = self.add_node_smart(gene_ontology_type_str, gene_ontology_curie_id_str, - desc=gene_ontology_term_dict["name"]) - if target_node is not None: - predicate_str = gene_ontology_term_dict["predicate"].replace(" ", "_") - if gene_ontology_type_str == "cellular_component": - minimal_predicate_str = "has_part" - else: - minimal_predicate_str = "capable_of" - self.orangeboard.add_rel(minimal_predicate_str, "Monarch_SciGraph", node, target_node, extended_reltype=predicate_str) - - def expand_protein(self, node): - assert node.nodetype == "protein" - uniprot_id_str = node.name - - # # SAR: I suspect these pathways are too high-level and not useful: - # pathways_set_from_pc2 = QueryPC2.uniprot_id_to_reactome_pathways(uniprot_id_str) - # doesn't provide pathway descriptions; see if we can get away with not using it? - # pathways_set_from_uniprot = QueryUniprot.uniprot_id_to_reactome_pathways(uniprot_id_str) - - # protein-pathway membership: - pathways_dict_from_reactome = QueryReactome.query_uniprot_id_to_reactome_pathway_ids_desc(uniprot_id_str) - pathways_dict_sourcedb = dict.fromkeys(pathways_dict_from_reactome.keys(), 'reactome') - node1 = node - for pathway_id in pathways_dict_from_reactome.keys(): - target_node = self.add_node_smart('pathway', - "REACT:" + pathway_id, - desc=pathways_dict_from_reactome[pathway_id]) - if target_node is not None: - self.orangeboard.add_rel('participates_in', pathways_dict_sourcedb[pathway_id], node1, target_node, extended_reltype="participates_in") - gene_symbols_set = self.query_mygene_obj.convert_uniprot_id_to_gene_symbol(uniprot_id_str) - for gene_symbol in gene_symbols_set: - # protein-DNA (i.e., gene regulatory) interactions: - regulator_gene_symbols_set = QueryGeneProf.gene_symbol_to_transcription_factor_gene_symbols(gene_symbol) - for reg_gene_symbol in regulator_gene_symbols_set: - reg_uniprot_ids_set = self.query_mygene_obj.convert_gene_symbol_to_uniprot_id(reg_gene_symbol) - for reg_uniprot_id in reg_uniprot_ids_set: - assert '-' not in reg_uniprot_id - node2 = self.add_node_smart('protein', reg_uniprot_id, desc=reg_gene_symbol) - if node2 is not None and node2.uuid != node1.uuid: - self.orangeboard.add_rel('regulates', 'GeneProf', node2, node1, extended_reltype="regulates_expression_of") - - # microrna-gene interactions: - microrna_regulators = QueryMiRGate.get_microrna_ids_that_regulate_gene_symbol(gene_symbol) - for microrna_id in microrna_regulators: - mir_gene_symbol = QueryMiRBase.convert_mirbase_id_to_mir_gene_symbol(microrna_id) - if mir_gene_symbol is not None: - mir_entrez_gene_ids = self.query_mygene_obj.convert_gene_symbol_to_entrez_gene_ID(mir_gene_symbol) - if len(mir_entrez_gene_ids) > 0: - for mir_entrez_gene_id in mir_entrez_gene_ids: - mir_node = self.add_node_smart('microRNA', - 'NCBIGene:' + str(mir_entrez_gene_id), - desc=mir_gene_symbol) - if mir_node is not None: - self.orangeboard.add_rel('regulates', 'miRGate', mir_node, node, extended_reltype="regulates_expression_of") - - entrez_gene_id = self.query_mygene_obj.convert_uniprot_id_to_entrez_gene_ID(uniprot_id_str) - if len(entrez_gene_id) > 0: - entrez_gene_id_str = 'NCBIGene:' + str(next(iter(entrez_gene_id))) - - # protein-to-anatomy associations: - anatomy_dict = QueryBioLink.get_anatomies_for_gene(entrez_gene_id_str) - for anatomy_id, anatomy_desc in anatomy_dict.items(): - anatomy_node = self.add_node_smart("anatomical_entity", anatomy_id, desc=anatomy_desc) - if anatomy_node is not None: - self.orangeboard.add_rel('expressed_in', 'BioLink', node, anatomy_node, extended_reltype="expressed_in") - - # protein-disease associations: - disont_id_dict = QueryBioLink.get_diseases_for_gene_desc(entrez_gene_id_str) - for disont_id in disont_id_dict.keys(): - if 'DOID:' in disont_id: - node2 = self.add_node_smart('disease', disont_id, desc=disont_id_dict[disont_id]) - if node2 is not None: - self.orangeboard.add_rel('gene_associated_with_condition', 'BioLink', node1, node2, extended_reltype="associated_with_disease") - else: - if 'OMIM:' in disont_id: - node2 = self.add_node_smart('disease', disont_id, desc=disont_id_dict[disont_id]) - if node2 is not None: - self.orangeboard.add_rel('gene_associated_with_condition', 'BioLink', node1, node2, extended_reltype="associated_with_disease") - - # protein-phenotype associations: - phenotype_id_dict = QueryBioLink.get_phenotypes_for_gene_desc(entrez_gene_id_str) - for phenotype_id_str in phenotype_id_dict.keys(): - node2 = self.add_node_smart("phenotypic_feature", phenotype_id_str, - desc=phenotype_id_dict[phenotype_id_str]) - if node2 is not None: - self.orangeboard.add_rel('has_phenotype', 'BioLink', node1, node2, extended_reltype="has_phenotype") - - # protein-protein interactions: - int_dict = QueryReactome.query_uniprot_id_to_interacting_uniprot_ids_desc(uniprot_id_str) - for int_uniprot_id in int_dict.keys(): - if self.query_mygene_obj.uniprot_id_is_human(int_uniprot_id): - int_alias = int_dict[int_uniprot_id] - if 'BINDSGENE:' not in int_alias: - node2 = self.add_node_smart('protein', int_uniprot_id, desc=int_alias) - if node2 is not None and node2.uuid != node1.uuid: - self.orangeboard.add_rel('physically_interacts_with', 'reactome', node1, node2, extended_reltype="physically_interacts_with") - else: - target_gene_symbol = int_alias.split(':')[1] - target_uniprot_ids_set = self.query_mygene_obj.convert_gene_symbol_to_uniprot_id(target_gene_symbol) - for target_uniprot_id in target_uniprot_ids_set: - assert '-' not in target_uniprot_id - node2 = self.add_node_smart('protein', target_uniprot_id, desc=target_gene_symbol) - if node2 is not None and node2 != node1: - self.orangeboard.add_rel('regulates', 'Reactome', node1, node2, extended_reltype="regulates_expression_of") - - # protein-to-GO (biological process): - go_dict = self.query_mygene_obj.get_gene_ontology_ids_for_uniprot_id(uniprot_id_str) - for go_id, go_term_dict in go_dict.items(): - go_term = go_term_dict.get('term', None) - ontology_name_str = go_term_dict.get('ont', None) - if go_term is not None and ontology_name_str is not None: - node2 = self.add_node_smart(ontology_name_str, go_id, desc=go_term) - if node2 is not None: - predicate = self.GO_ONTOLOGY_TO_PREDICATE[ontology_name_str] - self.orangeboard.add_rel(predicate, - 'gene_ontology', node1, node2, extended_reltype=predicate) - - def expand_gene_ontology(self, node, gene_ontology_type_str): - node_go_id = node.name - child_go_ids_dict = QuerySciGraph.query_sub_ontology_terms_for_ontology_term(node_go_id) - if child_go_ids_dict is not None: - for child_go_id, child_go_term in child_go_ids_dict.items(): - child_node = self.add_node_smart(gene_ontology_type_str, child_go_id, desc=child_go_term) - if child_node is not None and child_node != node: - self.orangeboard.add_rel("subclass_of", 'gene_ontology', child_node, node, extended_reltype="subclass_of") - - def expand_molecular_function(self, node): - assert node.nodetype == "molecular_function" - self.expand_gene_ontology(node, "molecular_function") - - def expand_cellular_component(self, node): - assert node.nodetype == "cellular_component" - self.expand_gene_ontology(node, "cellular_component") - - def expand_biological_process(self, node): - assert node.nodetype == "biological_process" - self.expand_gene_ontology(node, "biological_process") - - def expand_phenotypic_feature(self, node): - assert node.nodetype == "phenotypic_feature" - # expand phenotype=>anatomy - phenotype_id = node.name - anatomy_dict = QueryBioLink.get_anatomies_for_phenotype(phenotype_id) - for anatomy_id, anatomy_desc in anatomy_dict.items(): - anatomy_node = self.add_node_smart("anatomical_entity", anatomy_id, desc=anatomy_desc) - if anatomy_node is not None: - self.orangeboard.add_rel("affects", 'BioLink', node, anatomy_node, extended_reltype="affects") - - sub_phe_dict = QuerySciGraph.query_sub_ontology_terms_for_ontology_term(phenotype_id) - for sub_phe_id, sub_phe_desc in sub_phe_dict.items(): - sub_phe_node = self.add_node_smart("phenotypic_feature", sub_phe_id, desc=sub_phe_desc) - if sub_phe_node is not None: - self.orangeboard.add_rel("subclass_of", 'Monarch_SciGraph', sub_phe_node, node, extended_reltype="subclass_of") - - def expand_genetic_condition(self, node): - assert node.name.startswith("OMIM:") - res_dict = self.query_omim_obj.disease_mim_to_gene_symbols_and_uniprot_ids(node.name) - uniprot_ids = res_dict['uniprot_ids'] - gene_symbols = res_dict['gene_symbols'] - if len(uniprot_ids) == 0 and len(gene_symbols) == 0: - return # nothing else to do, for this MIM number - uniprot_ids_to_gene_symbols_dict = dict() - for gene_symbol in gene_symbols: - uniprot_ids = self.query_mygene_obj.convert_gene_symbol_to_uniprot_id(gene_symbol) - if len(uniprot_ids) == 0: - # this might be a microRNA - if BioNetExpander.is_mir(gene_symbol): - entrez_gene_ids = self.query_mygene_obj.convert_gene_symbol_to_entrez_gene_ID(gene_symbol) - if len(entrez_gene_ids) > 0: - for entrez_gene_id in entrez_gene_ids: - curie_entrez_gene_id = 'NCBIGene:' + str(entrez_gene_id) - node2 = self.add_node_smart('microRNA', - curie_entrez_gene_id, - desc=gene_symbol) - if node2 is not None: - self.orangeboard.add_rel("gene_mutations_contribute_to", - "OMIM", node2, node, - extended_reltype="gene_mutations_contribute_to") - for uniprot_id in uniprot_ids: - uniprot_ids_to_gene_symbols_dict[uniprot_id] = gene_symbol - for uniprot_id in uniprot_ids: - gene_symbol = self.query_mygene_obj.convert_uniprot_id_to_gene_symbol(uniprot_id) - if gene_symbol is not None: - gene_symbol_str = ';'.join(gene_symbol) - uniprot_ids_to_gene_symbols_dict[uniprot_id] = gene_symbol_str - source_node = node - for uniprot_id in uniprot_ids_to_gene_symbols_dict.keys(): - assert '-' not in uniprot_id - target_node = self.add_node_smart('protein', uniprot_id, - desc=uniprot_ids_to_gene_symbols_dict[uniprot_id]) - if target_node is not None: - self.orangeboard.add_rel("gene_mutations_contribute_to", - "OMIM", target_node, source_node, - extended_reltype="gene_mutations_contribute_to") - - # query for phenotypes associated with this disease - phenotype_id_dict = QueryBioLink.get_phenotypes_for_disease_desc(node.name) - for phenotype_id_str in phenotype_id_dict.keys(): - phenotype_node = self.add_node_smart("phenotypic_feature", phenotype_id_str, desc=phenotype_id_dict[phenotype_id_str]) - if phenotype_node is not None: - self.orangeboard.add_rel("has_phenotype", 'BioLink', node, phenotype_node, extended_reltype="has_phenotype") - - def expand_mondo_disease(self, node): - genes_list = QueryBioLink.get_genes_for_disease_desc(node.name) - for hgnc_gene_id in genes_list: - if hgnc_gene_id.startswith("HGNC:"): - uniprot_id_set = self.query_mygene_obj.convert_hgnc_gene_id_to_uniprot_id(hgnc_gene_id) - if len(uniprot_id_set) > 0: - uniprot_id = next(iter(uniprot_id_set)) - gene_symbol_set = self.query_mygene_obj.convert_uniprot_id_to_gene_symbol(uniprot_id) - if len(gene_symbol_set) > 0: - protein_node = self.add_node_smart('protein', uniprot_id, - desc=next(iter(gene_symbol_set))) - self.orangeboard.add_rel("gene_associated_with_condition", - "BioLink", - protein_node, node, extended_reltype="associated_with_disease") - - def expand_disease(self, node): - assert node.nodetype == "disease" - disease_name = node.name - - gene_ontology_dict = QuerySciGraph.get_gene_ontology_curie_ids_for_disease_curie_id(disease_name) - for gene_ontology_curie_id_str, gene_ontology_term_dict in gene_ontology_dict.items(): - gene_ontology_type_str = gene_ontology_term_dict["ontology"].replace(" ", "_") - target_node = self.add_node_smart(gene_ontology_type_str, gene_ontology_curie_id_str, - desc=gene_ontology_term_dict["name"]) - if target_node is not None: - predicate_str = gene_ontology_term_dict["predicate"].replace(" ", "_") - self.orangeboard.add_rel("affects", "Monarch_SciGraph", node, target_node, extended_reltype=predicate_str) - - if "OMIM:" in disease_name: - self.expand_genetic_condition(node) - return - - if "MONDO:" in disease_name: - self.expand_mondo_disease(node) - return - - # if we get here, this is a Disease Ontology disease - disont_id = disease_name - - child_disease_ids_dict = QueryDisont.query_disont_to_child_disonts_desc(disont_id) - for child_disease_id in child_disease_ids_dict.keys(): - target_node = self.add_node_smart('disease', child_disease_id, - desc=child_disease_ids_dict[child_disease_id]) - if target_node is not None: - self.orangeboard.add_rel('subclass_of', 'DiseaseOntology', - target_node, node, extended_reltype="subclass_of") - - mesh_ids_set = QueryDisont.query_disont_to_mesh_id(disont_id) - for mesh_id in mesh_ids_set: - uniprot_ids_dict = QueryDisGeNet.query_mesh_id_to_uniprot_ids_desc(mesh_id) - for uniprot_id in uniprot_ids_dict.keys(): - assert '-' not in uniprot_id - source_node = self.add_node_smart('protein', uniprot_id, - desc=uniprot_ids_dict[uniprot_id]) - if source_node is not None: - self.orangeboard.add_rel("gene_associated_with_condition", "DisGeNet", source_node, - node, extended_reltype="gene_associated_with_condition") - - # query for phenotypes associated with this disease - phenotype_id_dict = QueryBioLink.get_phenotypes_for_disease_desc(disont_id) - for phenotype_id_str in phenotype_id_dict.keys(): - phenotype_node = self.add_node_smart("phenotypic_feature", phenotype_id_str, - desc=phenotype_id_dict[phenotype_id_str]) - if phenotype_node is not None: - self.orangeboard.add_rel("has_phenotype", 'BioLink', node, phenotype_node, extended_reltype="has_phenotype") - - def expand_node(self, node): - node_type = node.nodetype - - method_name = 'expand_' + node_type - # Find the corresponding method and feed a keyword argument `node` - expand_method = methodcaller(method_name, node=node) - # Call this method on the orangeboard instance - # Identical to `self.expand_xxx(node=node)` given `nodetype = "xxx"` - expand_method(self) - - node.expanded = True - - def expand_all_nodes(self): - nodes = self.orangeboard.get_all_nodes_for_current_seed_node() - num_nodes_to_expand = sum([not mynode.expanded for mynode in nodes]) - print('----------------------------------------------------') - print('Number of nodes to expand: ' + str(num_nodes_to_expand)) - print('----------------------------------------------------') - for node in nodes: - if not node.expanded: - self.expand_node(node) - num_nodes_to_expand -= 1 - if (num_nodes_to_expand % 100 == 0): - print('Number of nodes left to expand in this iteration: ' + str(num_nodes_to_expand)) - - def test_go_bp_protein(): - ob = Orangeboard(debug=False) - ob.set_dict_reltype_dirs({'targets': True}) - bne = BioNetExpander(ob) - protein_node = bne.add_node_smart('protein', 'Q75MH2', seed_node_bool=True, desc='IL6') - bne.expand_protein(protein_node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_go_bp_microrna(): - ob = Orangeboard(debug=False) - ob.set_dict_reltype_dirs({'targets': True}) - bne = BioNetExpander(ob) - microrna_node = bne.add_node_smart('microRNA', 'NCBIGene:406991', seed_node_bool=True, desc='test microrna') - bne.expand_microrna(microrna_node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_go_term(): - ob = Orangeboard(debug=False) - ob.set_dict_reltype_dirs({'targets': True}) - bne = BioNetExpander(ob) - go_node = bne.add_node_smart('biological_process', 'GO:1904685', seed_node_bool=True, desc='test biological process') - bne.expand_biological_process(go_node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_disease_to_go(): - ob = Orangeboard(debug=False) - ob.set_dict_reltype_dirs({'affects': True}) - bne = BioNetExpander(ob) - node = bne.add_node_smart('disease', 'DOID:906', seed_node_bool=True, desc='peroxisomal disease') - bne.expand_disease(node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_anatomy_to_go(): - ob = Orangeboard(debug=False) - ob.set_dict_reltype_dirs({'capable_of': True}) - bne = BioNetExpander(ob) - node = bne.add_node_smart('anatomical_entity', 'UBERON:0000171', seed_node_bool=True, desc='respiration organ') - bne.expand_disease(node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_metabolite_to_protein(): - ob = Orangeboard(debug=False) - ob.set_dict_reltype_dirs({'physically_interacts_with': True}) - bne = BioNetExpander(ob) - node = bne.add_node_smart('metabolite', 'KEGG:C00190', seed_node_bool=True, desc='UDP-D-xylose') - bne.expand_metabolite(node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_mondo_liver(): - ob = Orangeboard(debug=False) - ob.set_dict_reltype_dirs({'gene_associated_with_condition': True, - 'has_phenotype': True}) - bne = BioNetExpander(ob) - node = bne.add_node_smart('disease', 'MONDO:0005359', seed_node_bool=True, desc='drug-induced liver injury') - bne.expand_disease(node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_double_proteins(): - ob = Orangeboard(debug=False) - bne = BioNetExpander(ob) - bne.add_node_smart('protein', 'Q59F02', seed_node_bool=True, desc='PMM2') - bne.add_node_smart('protein', 'H3BV55', seed_node_bool=True, desc='PMM2') - bne.add_node_smart('protein', 'A0A0S2Z4J6', seed_node_bool=True, desc='PMM2') - bne.add_node_smart('protein', 'H3BV34', seed_node_bool=True, desc='PMM2') - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_issue_228(): - ob = Orangeboard(debug=False) - bne = BioNetExpander(ob) - bne.add_node_smart('disease', 'MONDO:0005359', seed_node_bool=True, desc='drug-induced liver injury') - bne.add_node_smart('protein', 'Q59F02', seed_node_bool=True, desc='PMM2') - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_issue_237(): - ob = Orangeboard(debug=False) - bne = BioNetExpander(ob) - chem_node = bne.add_node_smart('chemical_substance', - 'KWHRDNMACVLHCE-UHFFFAOYSA-N', seed_node_bool=True, - desc='ciprofloxacin') - bne.expand_chemical_substance(chem_node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_issue_235(): - ob = Orangeboard(debug=False) - bne = BioNetExpander(ob) - omim_node = bne.add_node_smart('disease', - 'OMIM:105150', seed_node_bool=True, - desc='CEREBRAL AMYLOID ANGIOPATHY, CST3-RELATED') - bne.expand_genetic_condition(omim_node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - def test_issue_269(): - ob = Orangeboard(debug=False) - bne = BioNetExpander(ob) - chem_node = bne.add_node_smart('chemical_substance', - 'CHEMBL521', seed_node_bool=True, - desc='Ibuprofen') - bne.expand_chemical_substance(chem_node) - ob.neo4j_set_url() - ob.neo4j_set_auth() - ob.neo4j_push() - - -if __name__ == '__main__': - parser = argparse.ArgumentParser(description='Builds the master knowledge graph') - parser.add_argument('--runfunc', dest='runfunc') - args = parser.parse_args() - args_dict = vars(args) - if args_dict.get('runfunc', None) is not None: - run_function_name = args_dict['runfunc'] - else: - sys.exit("must specify --runfunc") - run_method = getattr(BioNetExpander, run_function_name, None) - if run_method is None: - sys.exit("function not found: " + run_function_name) - - # print(QueryEBIOLSExtended.get_disease_description('DOID:0060185')) - running_time = timeit.timeit(lambda: run_method(), number=1) - print('running time for function: ' + str(running_time)) - diff --git a/code/reasoningtool/kg-construction/BuildMasterKG.py b/code/reasoningtool/kg-construction/BuildMasterKG.py deleted file mode 100644 index 54aea424c..000000000 --- a/code/reasoningtool/kg-construction/BuildMasterKG.py +++ /dev/null @@ -1,177 +0,0 @@ -'''Builds a master knowledge graph and pushes it to Neo4j. Uses BioNetExpander and Orangeboard. - - Usage: sh run_build_master_kg.sh -''' - -__author__ = 'Stephen Ramsey' -__copyright__ = 'Oregon State University' -__credits__ = ['Stephen Ramsey', 'Yao Yao', 'Zheng Liu'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -# import requests_cache -import sys -import pandas -import timeit -import argparse -import os - -from Orangeboard import Orangeboard -from BioNetExpander import BioNetExpander -from QueryDGIdb import QueryDGIdb - - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../") # code directory -from RTXConfiguration import RTXConfiguration - -# configure requests package to use the "orangeboard.sqlite" cache -# requests_cache.install_cache('orangeboard') - - -def add_pc2_to_kg(): - sif_data = pandas.read_csv('../../../data/pc2/PathwayCommons9.All.hgnc.sif', - sep='\t', names=['gene1', 'interaction_type', 'gene2']) - interaction_types = set(['interacts-with', - 'controls-expression-of', - 'controls-state-change-of', - 'controls-phosphorylation-of']) - sif_data = sif_data[sif_data.interaction_type.isin(interaction_types)] - genes = set(sif_data['gene1'].tolist() + sif_data['gene2'].tolist()) - genes_uniprot_dict = dict() - print('converting gene names') - for gene in genes: - genes_uniprot_dict[gene] = bne.query_mygene_obj.convert_gene_symbol_to_uniprot_id(gene) - print('testing interactions to see if nodes are in the orangeboard') - for index, row in sif_data.iterrows(): - interaction_type = row['interaction_type'] - gene1 = row['gene1'] - gene2 = row['gene2'] - uniprots1 = genes_uniprot_dict.get(gene1, None) - uniprots2 = genes_uniprot_dict.get(gene2, None) - if uniprots1 is not None and len(uniprots1) == 1 and \ - uniprots2 is not None and len(uniprots2) == 1: - uniprot1 = next(iter(uniprots1)) - uniprot2 = next(iter(uniprots2)) - node1 = ob.get_node('protein', uniprot1) - node2 = ob.get_node('protein', uniprot2) - if node1 is not None and node2 is not None and node1.uuid != node2.uuid: - if interaction_type == 'interacts-with': - ob.add_rel('physically_interacts_with', 'PC2', node1, node2, extended_reltype="physically_interacts_with") - else: - if interaction_type == 'controls-expression-of': - ob.add_rel("regulates", 'PC2', node1, node2, extended_reltype="regulates_expression_of") - else: - if interaction_type == 'controls-state-change-of' or \ - interaction_type == 'controls-phosphorylation-of': - ob.add_rel("regulates", 'PC2', node1, node2, extended_reltype="regulates_activity_of") - else: - assert False - - -def seed_nodes_from_master_tsv_file(): - seed_node_data = pandas.read_csv('../../../data/seed_nodes_filtered.tsv', - sep="\t", - names=['type', 'rtx_name', 'term', 'purpose'], - # header=1, - dtype={'rtx_name': str}) - first_row = True - for index, row in seed_node_data.iterrows(): - bne.add_node_smart(row['type'], row['rtx_name'], seed_node_bool=first_row, desc=row['term']) - if first_row: - first_row = False - - -def add_dgidb_to_kg(): - tuple_list = QueryDGIdb.read_interactions() - for tuple_dict in tuple_list: - drug_node = bne.add_node_smart('chemical_substance', tuple_dict['drug_chembl_id'], - seed_node_bool=True, - desc=tuple_dict['drug_name']) - prot_node = bne.add_node_smart('protein', tuple_dict['protein_uniprot_id'], - seed_node_bool=True, - desc=tuple_dict['protein_gene_symbol']) - pmids = tuple_dict['pmids'] - ob.add_rel(tuple_dict['predicate'], - ';'.join(['DGIdb', tuple_dict['sourcedb']]), - drug_node, - prot_node, - extended_reltype=tuple_dict['predicate_extended'].replace(' ', '_'), - publications=pmids) - - -def make_master_kg_dili(): - bne.add_node_smart("disease", "MONDO:0005359", seed_node_bool=True, desc="drug-induced liver injury") - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - # ob.neo4j_set_url("bolt://0.0.0.0:7687") - ob.neo4j_push() - print("count(Node) = {}".format(ob.count_nodes())) - print("count(Rel) = {}".format(ob.count_rels())) - - -def test_dgidb(): -# seed_nodes_from_master_tsv_file() - add_dgidb_to_kg() - ob.neo4j_push() - - -def make_master_kg(): - seed_nodes_from_master_tsv_file() - bne.expand_all_nodes() - bne.expand_all_nodes() - bne.expand_all_nodes() - add_pc2_to_kg() - add_dgidb_to_kg() - # ob.neo4j_set_url('bolt://0.0.0.0:7687') - ob.neo4j_push() - print("count(Node) = {}".format(ob.count_nodes())) - print("count(Rel) = {}".format(ob.count_rels())) - - -if __name__ == '__main__': - parser = argparse.ArgumentParser(description='Builds the master knowledge graph') - # parser.add_argument("-a", "--address", help="The bolt url and port used to connect to the neo4j instance. (default:" - # "bolt://localhost:7687)", - # default="bolt://localhost:7687") - # parser.add_argument("-u", "--username", help="The username used to connect to the neo4j instance. (default: )", - # default='') - # parser.add_argument("-p", "--password", help="The password used to connect to the neo4j instance. (default: )", - # default='') - parser.add_argument('--live', help="The container name, which can be one of the following: Production, KG2, rtxdev, " - "staging. (default: local)", default='local') - parser.add_argument('--runfunc', dest='runfunc') - args = parser.parse_args() - - # if args.username == '' or args.password == '': - # print('usage: BuildMasterKG.py [-h] [-a URL] [-u USERNAME] [-p PASSWORD] [--runfunc RUNFUNC]') - # print('BuildMasterKG.py: error: invalid username or password') - # exit(0) - - # create the RTXConfiguration object - rtxConfig = RTXConfiguration() - - # create an Orangeboard object - ob = Orangeboard(debug=True) - - # configure the Orangeboard for Neo4j connectivity - ob.neo4j_set_url(rtxConfig.neo4j_bolt) - ob.neo4j_set_auth(user=rtxConfig.neo4j_username, password=rtxConfig.neo4j_password) - ob.neo4j_connect() - - bne = BioNetExpander(ob) - - args_dict = vars(args) - if args_dict.get('runfunc', None) is not None: - run_function_name = args_dict['runfunc'] - else: - run_function_name = 'make_master_kg' - try: - run_function = globals()[run_function_name] - except KeyError: - sys.exit('In module BuildMasterKG.py, unable to find function named: ' + run_function_name) - running_time = timeit.timeit(lambda: run_function(), number=1) - print('running time for function: ' + str(running_time)) diff --git a/code/reasoningtool/kg-construction/BuildMeshCache.py b/code/reasoningtool/kg-construction/BuildMeshCache.py deleted file mode 100644 index 0424bfbc2..000000000 --- a/code/reasoningtool/kg-construction/BuildMeshCache.py +++ /dev/null @@ -1,12 +0,0 @@ -# import requests_cache -# import CachedMethods -from NormGoogleDistance import NormGoogleDistance -import time -import pandas -import csv - -df = pandas.read_csv('nodes_id_name.csv') - -for a in range(len(df['id'])): - b = NormGoogleDistance.get_mesh_term_for_all(df['id'][a],df['name'][a]) - diff --git a/code/reasoningtool/kg-construction/DrugMapper.py b/code/reasoningtool/kg-construction/DrugMapper.py deleted file mode 100644 index 19ba8edbe..000000000 --- a/code/reasoningtool/kg-construction/DrugMapper.py +++ /dev/null @@ -1,201 +0,0 @@ -from SynonymMapper import SynonymMapper -from QueryMyChem import QueryMyChem - -import os -import sys -import time -import networkx -import obonet -# import requests_cache - -try: - from QueryUMLSApi import QueryUMLSApi -except ImportError: - insert_dir = os.path.dirname(os.path.dirname(os.path.abspath(__file__)) + "/../SemMedDB/") - sys.path.insert(0, insert_dir) - from QueryUMLSApi import QueryUMLS - - -class DrugMapper: - graph = obonet.read_obo("https://raw.githubusercontent.com/obophenotype/human-phenotype-ontology/master/hp.obo") - - @staticmethod - def __map_umls_to_onto_id(umls_array): - """ - mapping between umls ids and ontology ids including omim, doid, and hp. - :param umls_array: - :return: a set of strings containing the found hp / omim / doid ids or empty set if none were found - """ - onto_set = set() - sm = SynonymMapper() - for umls_id in umls_array: - onto_ids = sm.get_all_from_oxo(umls_id, ['DOID', 'OMIM', 'HP']) - if onto_ids is not None: - for onto_id in onto_ids: - onto_set.add(onto_id) - return onto_set - - @staticmethod - def map_drug_to_hp_with_side_effects(chembl_id): - """ - mapping between a drug and human phenotypes corresponding to side effects - - :param chembl_id: The CHEMBL ID for a drug - - :return: A set of strings containing the found hp ids or empty set if none where found - """ - hp_set = set() -# global graph - if not isinstance(chembl_id, str): - return hp_set - umls_set = QueryMyChem.get_drug_side_effects(chembl_id) - meddra_set = QueryMyChem.get_meddra_codes_for_side_effects(chembl_id) - if len(umls_set) == 0 and len(meddra_set) == 0: - return hp_set - sm = SynonymMapper() - - for meddra_code in meddra_set: - hp_ids = DrugMapper.map_meddra_to_hp(meddra_code, DrugMapper.graph) - if len(hp_ids) > 0: - for hp_id in hp_ids: - hp_set.add(hp_id) - - for umls_id in umls_set: - hp_ids = sm.get_all_from_oxo(umls_id, 'HP') - if hp_ids is not None: - for hp_id in hp_ids: - hp_set.add(hp_id) - - return hp_set - - @staticmethod - def make_meddra_to_hp_map(graph): - res_dict = {} - for node_name in graph: - # get the node's properties - node_properties_dict = graph.node[node_name] - xref_list = node_properties_dict.get('xref', None) - if xref_list is not None: - for xref_curie in xref_list: - if xref_curie.startswith('MEDDRA:'): - res_dict[xref_curie[:15]] = node_name - return res_dict - - meddra_to_hp_map = make_meddra_to_hp_map.__func__(graph) - - @staticmethod - def map_meddra_to_hp(medra_curie, graph): - ret_hp_set = set() -# meddra_to_hp_map = DrugMapper.make_meddra_to_hp_map(graph) - hp_curie = DrugMapper.meddra_to_hp_map.get(medra_curie, None) - if hp_curie is not None: - ret_hp_set.add(hp_curie) - return ret_hp_set - - @staticmethod - def map_drug_to_UMLS(chembl_id): - """ - mapping between a drug and UMLS ids corresponding to indications and contraindications - - :param chembl_id: The CHEMBL ID for a drug - - :return: A dictionary with two fields ('indication' and 'contraindication'). Each field is a set of strings - containing the found UMLS ids or empty set if none were found - """ - indication_umls_set = set() - contraindication_umls_set = set() - if not isinstance(chembl_id, str): - return {'indications': indication_umls_set, "contraindications": contraindication_umls_set} - drug_use = QueryMyChem.get_drug_use(chembl_id) - indications = drug_use['indications'] - contraindications = drug_use['contraindications'] - - sm = SynonymMapper() - for indication in indications: - if 'snomed_id' in indication.keys(): - oxo_result = sm.get_all_from_oxo('SNOMEDCT:' + indication['snomed_id'], ['UMLS']) - if oxo_result is not None: - indication_umls_set.add(oxo_result[0]) - - for contraindication in contraindications: - if 'snomed_id' in contraindication.keys(): - oxo_result = sm.get_all_from_oxo('SNOMEDCT:' + contraindication['snomed_id'], ['UMLS']) - if oxo_result is not None: - contraindication_umls_set.add(oxo_result[0]) - - return {'indications': indication_umls_set, "contraindications": contraindication_umls_set} - - # tgt = QueryUMLS.get_ticket_gen() - # for indication in indications: - # if 'snomed_name' in indication.keys(): - # cui = QueryUMLS.get_cui_from_string_precision(indication['snomed_name'], tgt) - # if cui is None: - # print(indication['snomed_name']) - # else: - # print(cui) - # umls_set.add(cui) - # return umls_set - - @staticmethod - def map_drug_to_ontology(chembl_id): - """ - mapping between a drug and Disease Ontology IDs and/or Human Phenotype Ontology IDs corresponding to indications - - :param chembl_id: The CHEMBL ID for a drug - - :return: A dictionary with two fields ('indication' and 'contraindication'). Each field is a set of strings - containing the found hp / omim / doid ids or empty set if none were found - """ - indication_onto_set = set() - contraindication_onto_set = set() - if not isinstance(chembl_id, str): - return {'indications': indication_onto_set, "contraindications": contraindication_onto_set} - drug_use = QueryMyChem.get_drug_use(chembl_id) - indications = drug_use['indications'] - contraindications = drug_use['contraindications'] - sm = SynonymMapper() - for indication in indications: - if 'snomed_concept_id' in indication.keys(): - oxo_results = sm.get_all_from_oxo('SNOMEDCT:' + str(indication['snomed_concept_id']), ['DOID', 'OMIM', 'HP']) - if oxo_results is not None: - for oxo_result in oxo_results: - indication_onto_set.add(oxo_result) - for contraindication in contraindications: - if 'snomed_concept_id' in contraindication.keys(): - oxo_results = sm.get_all_from_oxo('SNOMEDCT:' + str(contraindication['snomed_concept_id']), ['DOID', 'OMIM', 'HP']) - if oxo_results is not None: - for oxo_result in oxo_results: - contraindication_onto_set.add(oxo_result) - return {'indications': indication_onto_set, "contraindications": contraindication_onto_set} - - -if __name__ == '__main__': - # requests_cache.install_cache('DrugMapper') - # hp_set = DrugMapper.map_drug_to_hp_with_side_effects("KWHRDNMACVLHCE-UHFFFAOYSA-N") - # print(hp_set) - # print(len(hp_set)) - - # start_time = time.time() - hp_set = DrugMapper.map_drug_to_hp_with_side_effects("CHEMBL1082") - print(hp_set) - hp_set = DrugMapper.map_drug_to_hp_with_side_effects("CHEMBL112") # acetaminophen - print(hp_set) - hp_set = DrugMapper.map_drug_to_hp_with_side_effects("CHEMBL521") # ibuprofen - print(hp_set) - hp_set = DrugMapper.map_drug_to_hp_with_side_effects("CHEMBL1431") # ibuprofen - print(hp_set) - # print(len(hp_set)) - # print("--- %s seconds ---" % (time.time() - start_time)) - - # umls_set = DrugMapper.map_drug_to_UMLS("CHEMBL1082") - # print(umls_set) - - # onto_set = DrugMapper.map_drug_to_ontology("CHEMBL:521") - # print(onto_set['contraindications']) - - # onto_set = DrugMapper.map_drug_to_ontology("CHEMBL2107884") - # print(onto_set) - - # onto_set = DrugMapper.map_drug_to_ontology("CHEMBL8") - # print(onto_set) - diff --git a/code/reasoningtool/kg-construction/DumpNeo4jToCSV.py b/code/reasoningtool/kg-construction/DumpNeo4jToCSV.py deleted file mode 100644 index a8e774c37..000000000 --- a/code/reasoningtool/kg-construction/DumpNeo4jToCSV.py +++ /dev/null @@ -1,90 +0,0 @@ -'''Dumps the knowledge graph from Neo4j to CSV or TSV format files - -''' - -__author__ = 'Stephen Ramsey' -__copyright__ = 'Oregon State University' -__credits__ = ['Stephen Ramsey', 'Yao Yao', 'Zheng Liu'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -import argparse -import neo4j.v1 -import sys, os - -from BioNetExpander import BioNetExpander -from Orangeboard import Orangeboard - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../") # code directory -from RTXConfiguration import RTXConfiguration - - -def run_cypher(query, parameters=None): - return driver.session().run(query, parameters) - - -def make_nodes_file(filename='nodes.csv', separator=','): - query_result = run_cypher('match (n) return n') - base_set = set('Base') - nodes_file = open(filename, 'w') - for record in query_result: - for result_tuple in record.items(): - node = result_tuple[1] - node_labels = node.labels - node_labels.remove('Base') - node_properties = node.properties - node_uuid = node_properties['UUID'] - nodetype = next(iter(node_labels)) - nodename = node_properties['name'] - nodes_file.write('node' + separator + node_uuid + separator + nodetype + separator + nodename + '\n') - nodes_file.close() - - -def make_rels_file(filename='rels.csv', separator=','): - assert ':' not in separator - query_result = run_cypher('match (n)-[r]-(m) return n.UUID, m.UUID, r LIMIT 10000') - rels_set = set() - rels_file = open(filename, 'w') - for record in query_result: - source_node_uuid = record[0] - target_node_uuid = record[1] - rel = record[2] - rel_properties = rel.properties - reltype = rel.type - reltype_dir = BioNetExpander.MASTER_REL_IS_DIRECTED[reltype] - sourcedb = rel_properties['provided_by'] - rel_key = Orangeboard.make_rel_dict_key(source_node_uuid, target_node_uuid, reltype_dir) - if rel_key not in rels_set: - rels_set.add(rel_key) - rels_file.write('rel' + separator + source_node_uuid + separator + target_node_uuid + separator + sourcedb + ':' + reltype + '\n') - rels_file.close() - - -if __name__ == '__main__': - - parser = argparse.ArgumentParser() - # parser.add_argument("-a", "--address", help="The bolt url and port used to connect to the neo4j instance. (default:" - # "bolt://localhost:7687)", - # default="bolt://localhost:7687") - # parser.add_argument("-u", "--username", help="The username used to connect to the neo4j instance. (default: )", - # default='') - # parser.add_argument("-p", "--password", help="The password used to connect to the neo4j instance. (default: )", - # default='') - parser.add_argument('--live', help="The container name, which can be one of the following: Production, KG2, rtxdev, " - "staging. (default: Production)", default='Production') - args = parser.parse_args() - - # if args.username == '' or args.password == '': - # print('usage: DumpNeo4jToCSV.py [-h] [-a URL] [-u USERNAME] [-p PASSWORD]') - # print('DumpNeo4jToCSV.py: error: invalid username or password') - # exit(0) - - # create the RTXConfiguration object - rtxConfig = RTXConfiguration() - - driver = neo4j.v1.GraphDatabase.driver(rtxConfig.neo4j_bolt, auth=(rtxConfig.neo4j_username, rtxConfig.neo4j_password)) - make_nodes_file() - make_rels_file() diff --git a/code/reasoningtool/kg-construction/GenerateMetabolitesTSV.py b/code/reasoningtool/kg-construction/GenerateMetabolitesTSV.py deleted file mode 100644 index 20336c59b..000000000 --- a/code/reasoningtool/kg-construction/GenerateMetabolitesTSV.py +++ /dev/null @@ -1,96 +0,0 @@ - -''' This module defines the class GenerateMetabolitesTSV. GenerateMetabolitesTSV class is designed -to generate the metabolites.tsv file. - -The format of the metabolites.tsv looks like the following: - -metabolite KEGG:C00022 Pyruvate generic - -''' - - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - - -# import requests -import sys -from cache_control_helper import CacheControlHelper - - -class GenerateMetabolitesTSV: - - FILE_NAME = 'metabolites.tsv' - URL = 'http://rest.kegg.jp/list/compound' - - @staticmethod - def __retrieve_entries_from_url(): - - # network request - requests = CacheControlHelper() - try: - res = requests.get(GenerateMetabolitesTSV.URL) - except requests.exceptions.Timeout: - print(GenerateMetabolitesTSV.URL, file=sys.stderr) - print("Timeout for URL: " + GenerateMetabolitesTSV.URL, file=sys.stderr) - return False - except BaseException as e: - print(GenerateMetabolitesTSV.URL, file=sys.stderr) - print('%s received in GenerateMetabolitesTSV for URL: %s' % (e, GenerateMetabolitesTSV.URL), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(GenerateMetabolitesTSV.URL, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + GenerateMetabolitesTSV.URL, file=sys.stderr) - return False - - # save content to file - with open(GenerateMetabolitesTSV.FILE_NAME, 'wb') as fd: - for chunk in res.iter_content(1024): - fd.write(chunk) - - return True - - @staticmethod - def __process_all_entries(): - content = '' - try: - rf = open(GenerateMetabolitesTSV.FILE_NAME, 'r+') - for line in rf.readlines(): - line = GenerateMetabolitesTSV.__process_line_content(line) - content += 'metabolite\t' + line + '\tgeneric\n' - rf.close() - except OSError as err: - print("reading file, OS error: {0}".format(err)) - - try: - wf = open(GenerateMetabolitesTSV.FILE_NAME, 'w+') - wf.write(content) - wf.close() - except OSError as err: - print("writing file, OS error: {0}".format(err)) - - @staticmethod - def __process_line_content(line): - line = line.replace('cpd', 'KEGG') - semicolon_pos = line.find(';') - if semicolon_pos == -1: - line = line[:len(line)-1] - else: - line = line[:semicolon_pos] - return line - - @staticmethod - def generate_metabolites_tsv(): - if GenerateMetabolitesTSV.__retrieve_entries_from_url(): - GenerateMetabolitesTSV.__process_all_entries() - - -if __name__ == '__main__': - GenerateMetabolitesTSV.generate_metabolites_tsv() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/Orangeboard.py b/code/reasoningtool/kg-construction/Orangeboard.py deleted file mode 100644 index b3dd7de99..000000000 --- a/code/reasoningtool/kg-construction/Orangeboard.py +++ /dev/null @@ -1,641 +0,0 @@ -'''This module defines class Node, class Rel, and class Orangeboard. The -Orangeboard class is responsible for connecting with the Neo4j database and -performing operations on a graph object model (e.g., add node, add relationship, -retrieve node information, and retrieve relationship information). Orangeboard -has a method for pushing the graph object model to the Neo4j database, using a -high-performance bulk upload operation. This class is intended to be used as a -singleton. - -''' - -__author__ = 'Stephen Ramsey' -__copyright__ = 'Oregon State University' -__credits__ = ['Stephen Ramsey', 'Yao Yao', 'Zheng Liu'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -import uuid -import itertools -import pprint -import neo4j.v1 -import sys, os -import timeit -import argparse - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../") # code directory -from RTXConfiguration import RTXConfiguration - -# NOTE to users: neo4j password hard-coded (see NEO4J_PASSWORD below) -# nodetype+name together uniquely define a node - - -class Node: - RESERVED_PROPS = {"UUID", "name", "seed_node_uuid", "expanded", "description"} - - def __init__(self, nodetype, name, seed_node): - self.nodetype = nodetype - self.name = name - if seed_node is not None: - self.seed_node = seed_node - else: - self.seed_node = self - new_uuid = str(uuid.uuid1()) - self.uuid = new_uuid -# self.out_rels = set() -# self.in_rels = set() - self.expanded = False - self.extra_props = {} - self.desc = '' - - def set_desc(self, desc): - self.desc = desc - - def set_extra_props(self, extra_props_dict): - assert 0 == len(extra_props_dict.keys() & self.RESERVED_PROPS) - self.extra_props = extra_props_dict - - def get_props(self): - basic_props = {'UUID': self.uuid, - 'rtx_name': self.name, - 'seed_node_uuid': self.seed_node.uuid, - 'expanded': self.expanded, - 'category': self.nodetype, - 'name': self.desc} - ret_dict = {**basic_props, **self.extra_props} - # for key, value in ret_dict.items(): - # if type(value) == str and any(i in value for i in ' '): - # ret_dict[key] = "`" + value + "`" - return ret_dict - - def get_labels(self): - return {'Base', self.nodetype} - - def __str__(self): - attr_list = ['nodetype', 'name', 'uuid', 'expanded', 'desc'] - attr_dict = {attr: str(self.__getattribute__(attr)) for attr in attr_list} - attr_dict['seed_node_uuid'] = self.seed_node.uuid - return pprint.pformat(attr_dict) - - def simple_print(self): - return 'node,' + self.uuid + ',' + self.nodetype + ',' + self.name - - -class Rel: - def __init__(self, reltype, sourcedb, source_node, target_node, seed_node, prob=None, extended_reltype=None, publications=None): - self.reltype = reltype - self.sourcedb = sourcedb - self.source_node = source_node - self.target_node = target_node - self.seed_node = seed_node - self.prob = prob - if extended_reltype is None: - extended_reltype = reltype - self.extended_reltype = extended_reltype - if publications is not None: - self.publications = publications - else: - self.publications = '' - - def get_props(self, reverse=False): - extended_reltype = self.extended_reltype - - if " " in extended_reltype: - quote_char = "`" - else: - quote_char = "" - - prop_dict = {'reltype': self.reltype, - 'sourcedb': self.sourcedb, - 'seed_node_uuid': self.seed_node.uuid, - 'prob': self.prob, - 'extended_reltype': quote_char + self.extended_reltype + quote_char, - 'publications': quote_char + self.publications + quote_char} - if not reverse: - prop_dict['source_node_uuid'] = self.source_node.uuid - prop_dict['target_node_uuid'] = self.target_node.uuid - else: - prop_dict['source_node_uuid'] = self.target_node.uuid - prop_dict['target_node_uuid'] = self.source_node.uuid - return prop_dict - - def __str__(self): - attr_list = ['reltype', 'sourcedb', 'source_node', 'target_node'] - attr_dict = {attr: str(self.__getattribute__(attr)) - for attr in attr_list} - - return pprint.pformat(attr_dict) - - def simple_print(self): - return 'rel,' + self.source_node.uuid + ',' + self.target_node.uuid + ',' + self.sourcedb + ':' + self.reltype - - -class Orangeboard: - DEBUG_COUNT_REPORT_GRANULARITY = 1000 - - def bytesize(self): - count = 0 - for uuid in self.dict_seed_uuid_to_list_nodes.keys(): - for node in self.dict_seed_uuid_to_list_nodes[uuid]: - count += sys.getsizeof(node) - for uuid in self.dict_seed_uuid_to_list_rels.keys(): - for rel in self.dict_seed_uuid_to_list_rels[uuid]: - count += sys.getsizeof(rel) - return count - - def __init__(self, debug=False): - self.dict_nodetype_to_dict_name_to_node = dict() - self.dict_reltype_to_dict_relkey_to_rel = dict() - self.dict_nodetype_count = dict() - self.dict_reltype_count = dict() - self.dict_seed_uuid_to_list_nodes = dict() - self.dict_seed_uuid_to_list_rels = dict() - self.debug = debug - self.seed_node = None - self.dict_reltype_dirs = None - self.driver = None - self.neo4j_url = None - self.neo4j_user = None - self.neo4j_password = None - if self.debug: - self.start_time = timeit.default_timer() - - def set_dict_reltype_dirs(self, dict_reltype_dirs): - self.dict_reltype_dirs = dict_reltype_dirs - - def neo4j_set_url(self, url='bolt://localhost:7687'): - self.neo4j_url = url - - # def neo4j_set_auth(self, user=NEO4J_USERNAME, password=NEO4J_PASSWORD): - def neo4j_set_auth(self, user, password): - self.neo4j_user = user - self.neo4j_password = password - - def simple_print_rels(self): - rel_list = itertools.chain.from_iterable(self.dict_seed_uuid_to_list_rels.values()) - rel_strings = [rel.simple_print() for rel in rel_list] - return '\n'.join(rel_strings) + '\n' - - def simple_print_nodes(self): - node_list = itertools.chain.from_iterable(self.dict_seed_uuid_to_list_nodes.values()) - node_strings = [node.simple_print() for node in node_list] - return '\n'.join(node_strings) + '\n' - - def __str__(self): - node_list = itertools.chain.from_iterable(self.dict_seed_uuid_to_list_nodes.values()) - node_strings = [str(node) for node in node_list] - - rel_list = itertools.chain.from_iterable(self.dict_seed_uuid_to_list_rels.values()) - rel_strings = [str(rel) for rel in rel_list] - - return '\n'.join(node_strings) + '\n' + '\n'.join(rel_strings) - - def count_rels_for_node_slow(self, node): - node_uuid = node.uuid - count = 0 - for subdict in self.dict_reltype_to_dict_relkey_to_rel.values(): - for rel in subdict.values(): - if rel.source_node.uuid == node_uuid or rel.target_node.uuid == node_uuid: - count += 1 - return count - - def count_nodes(self): - return sum(map(len, self.dict_seed_uuid_to_list_nodes.values())) - - def count_rels(self): - return sum(map(len, self.dict_seed_uuid_to_list_rels.values())) - - def count_nodes_by_nodetype(self): - # nodetypes = self.dict_nodetype_to_dict_name_to_node.keys() - # print(nodetypes) - # self.dict_nodetype_count = {str(nodetype): len(set(self.dict_nodetype_to_dict_name_to_node[nodetype].values())) for nodetype in self.dict_nodetype_to_dict_name_to_node.keys()} - # return self.dict_nodetype_count - - results_nodetype = self.neo4j_run_cypher_query("match (n) return distinct labels(n)") - nodetypes = [r[0][1] for r in results_nodetype] - for nt in nodetypes: - results_nodecount = self.neo4j_run_cypher_query("match (n:{}) return count(n)".format(nt)) - self.dict_nodetype_count[nt] = [r[0] for r in results_nodecount][0] - return self.dict_nodetype_count - - def count_rels_by_reltype(self): - results_reltype = self.neo4j_run_cypher_query("MATCH path=()-[r]-() RETURN distinct extract (rel in relationships(path) | type(rel) ) as types, count(*)") - #dict_reltype_count = dict() # defined on init - for res in results_reltype: - self.dict_reltype_count[res['types'][0]] = res['count(*)'] - return self.dict_reltype_count - - - def set_seed_node(self, seed_node): - self.seed_node = seed_node - - def get_node(self, nodetype, name): - subdict = self.dict_nodetype_to_dict_name_to_node.get(nodetype, None) - ret_node = None - if subdict is not None: - existing_node_match = subdict.get(name, None) - if existing_node_match is not None: - ## this node already exists, return the Node - ret_node = existing_node_match - return ret_node - - def get_all_nodes_for_seed_node_uuid(self, seed_node_uuid): - return set(self.dict_seed_uuid_to_list_nodes[seed_node_uuid]) - - def get_all_rels_for_seed_node_uuid(self, seed_node_uuid): - list_rels = self.dict_seed_uuid_to_list_rels.get(seed_node_uuid, None) - if list_rels is not None: - return set(list_rels) - else: - return set() - - def get_all_nodes_for_current_seed_node(self): - return self.get_all_nodes_for_seed_node_uuid(self.seed_node.uuid) - - def get_all_reltypes(self): - return self.dict_reltype_to_dict_relkey_to_rel.keys() - - def get_all_rels_for_reltype(self, reltype): - return set(self.dict_reltype_to_dict_relkey_to_rel[reltype].values()) - - def get_all_nodetypes(self): - return self.dict_nodetype_to_dict_name_to_node.keys() - - def get_all_nodes_for_nodetype(self, nodetype): - return set(self.dict_nodetype_to_dict_name_to_node[nodetype].values()) - - def add_node(self, nodetype, name, seed_node_bool=False, desc=''): - assert type(name) == str - assert not (nodetype == "microRNA" and " " in desc) - - if seed_node_bool: - # old_seed_node = self.seed_node - # if old_seed_node is not None: - # old_seed_node_uuid = old_seed_node.uuid - # else: - # old_seed_node_uuid = None - self.set_seed_node(None) - else: - if self.seed_node is None: - print('must set seed_node_bool=True for first call to add_node', file=sys.stderr) - exit(1) - existing_node = self.get_node(nodetype, name) - if existing_node is None: - # this is a new node we are adding - subdict = self.dict_nodetype_to_dict_name_to_node.get(nodetype, None) - if subdict is None: - self.dict_nodetype_to_dict_name_to_node[nodetype] = dict() - new_node = Node(nodetype, name, self.seed_node) - new_node.desc = desc - existing_node = new_node - if seed_node_bool: - self.set_seed_node(new_node) - self.dict_nodetype_to_dict_name_to_node[nodetype][name] = new_node - seed_node_uuid = self.seed_node.uuid - sublist = self.dict_seed_uuid_to_list_nodes.get(seed_node_uuid, None) - if sublist is None: - self.dict_seed_uuid_to_list_nodes[seed_node_uuid] = list() - self.dict_seed_uuid_to_list_nodes[seed_node_uuid].append(new_node) - if self.debug: - node_count = self.count_nodes() - if node_count % Orangeboard.DEBUG_COUNT_REPORT_GRANULARITY == 0: - print('Number of nodes: ' + str(node_count) + '; total elapsed time: ' + format(timeit.default_timer() - self.start_time, '.2f') + ' s') - else: - # node is already in the orangeboard - - # if the node object doesn't have a description but it is being - # given one now, add the description to the existing node object - if desc != '' and existing_node.desc == '': - existing_node.desc = desc - if nodetype == "protein" or nodetype == "microRNA": - existing_node.extra_props["symbol"] = desc - - # if seed_node_bool=True, this is a special case that must be handled - if seed_node_bool: - ## node is already in the orangeboard but we are updating its seed node - ## (1) get the UUID for the existing node - new_seed_node_uuid = existing_node.uuid - existing_node_previous_seed_node_uuid = existing_node.seed_node.uuid - ## (2) set the 'expanded' variable of the existing node to False - existing_node.expanded = False - ## (3) set the seed_node of the orangeboard to the existing_node - self.set_seed_node(existing_node) - ## (4) set the seed_node of the existing node to itself - existing_node.seed_node = existing_node - ## (5) add the existing node to the new seed-node-level list: - new_seed_node_list = self.dict_seed_uuid_to_list_nodes.get(new_seed_node_uuid, None) - if new_seed_node_list is None: - new_seed_node_list = [] - self.dict_seed_uuid_to_list_nodes[new_seed_node_uuid] = new_seed_node_list - new_seed_node_list.append(existing_node) - ## (6) remove the existing node from the old seed-node-level list: - assert existing_node_previous_seed_node_uuid is not None - self.dict_seed_uuid_to_list_nodes[existing_node_previous_seed_node_uuid].remove(existing_node) - return existing_node - - @staticmethod - def make_rel_dict_key(source_uuid, target_uuid, rel_dir): - if rel_dir or source_uuid < target_uuid: - rel_dict_key = source_uuid + '--' + target_uuid - else: - assert source_uuid > target_uuid - rel_dict_key = target_uuid + '--' + source_uuid - return rel_dict_key - - def get_rel(self, reltype, source_node, target_node): - dict_reltype_dirs = self.dict_reltype_dirs - if dict_reltype_dirs is None: - print('Must call Orangeboard.set_dict_reltype_dirs() before you call add_rel()', file=sys.stderr) - assert False - reltype_dir = dict_reltype_dirs.get(reltype, None) - if reltype_dir is None: - print('reltype passed to add_rel is not in dict_reltype_dirs; reltype=' + reltype, file=sys.stderr) - assert False - ret_rel = None - rel_dict_key = None - subdict = self.dict_reltype_to_dict_relkey_to_rel.get(reltype, None) - if subdict is not None: - rel_dict_key = Orangeboard.make_rel_dict_key(source_node.uuid, target_node.uuid, reltype_dir) - existing_rel = subdict.get(rel_dict_key, None) - if existing_rel is not None: - ret_rel = existing_rel - return [ret_rel, rel_dict_key] - - def add_rel(self, reltype, sourcedb, source_node, target_node, prob=None, extended_reltype=None, publications=None): - if source_node.uuid == target_node.uuid: - print('Attempt to add a relationship between a node and itself, for node: ' + str(node), file=sys.stderr) - assert False - dict_reltype_dirs = self.dict_reltype_dirs - if dict_reltype_dirs is None: - print('Must call Orangeboard.set_dict_reltype_dirs() before you call add_rel()', file=sys.stderr) - assert False - reltype_dir = dict_reltype_dirs.get(reltype, None) - if reltype_dir is None: - print('reltype passed to add_rel is not in dict_reltype_dirs; reltype=' + reltype, file=sys.stderr) - assert False - seed_node = self.seed_node - assert seed_node is not None - existing_rel_list = self.get_rel(reltype, source_node, target_node) - existing_rel = existing_rel_list[0] - if existing_rel is None: - subdict = self.dict_reltype_to_dict_relkey_to_rel.get(reltype, None) - if subdict is None: - self.dict_reltype_to_dict_relkey_to_rel[reltype] = dict() - subdict = self.dict_reltype_to_dict_relkey_to_rel.get(reltype, None) - new_rel = Rel(reltype, sourcedb, source_node, target_node, seed_node, prob, extended_reltype, publications) - existing_rel = new_rel - rel_dict_key = existing_rel_list[1] - if rel_dict_key is None: - rel_dict_key = Orangeboard.make_rel_dict_key(source_node.uuid, target_node.uuid, reltype_dir) - subdict[rel_dict_key] = new_rel - seed_node_uuid = seed_node.uuid - sublist = self.dict_seed_uuid_to_list_rels.get(seed_node_uuid, None) - if sublist is None: - self.dict_seed_uuid_to_list_rels[seed_node_uuid] = [] - self.dict_seed_uuid_to_list_rels[seed_node_uuid].append(new_rel) - if self.debug: - rel_count = self.count_rels() - if rel_count % Orangeboard.DEBUG_COUNT_REPORT_GRANULARITY == 0: - print('Number of rels: ' + str(rel_count) + '; total elapsed time: ' + format(timeit.default_timer() - self.start_time, '.2f') + ' s') - return existing_rel - - @staticmethod - def make_label_string_from_set(node_labels): - if len(node_labels) > 0: - return ':' + ':'.join(node_labels) - else: - return '' - - @staticmethod - def make_property_string_from_dict(property_info): - """takes a ``dict`` of property key-value pairs and converts it into a string in Neo4j format - - :param property_info: a ``dict`` of property key-value pairs - :returns: a string representaiotn of the property key-value pairs, in Neo4j format like this: - UUID:'97b47364-b9c2-11e7-ac88-a820660158fd', name:'prot1' - """ - return '{' + (', '.join('{!s}:{!r}'.format(key,val) for (key,val) in property_info.items())) + '}' if len(property_info) > 0 else '' - - def clear_from_seed_node_uuid(self, seed_node_uuid): - dict_reltype_to_dict_relkey_to_rel = self.dict_reltype_to_dict_relkey_to_rel - for reltype in dict_reltype_to_dict_relkey_to_rel.keys(): - dict_relkey_to_rel = dict_reltype_to_dict_relkey_to_rel[reltype] - for relkey in dict_relkey_to_rel.copy().keys(): - rel = dict_relkey_to_rel[relkey] - if rel.seed_node.uuid == seed_node_uuid: - rel.source_node = None - rel.target_node = None - del dict_relkey_to_rel[relkey] - del self.dict_seed_uuid_to_list_rels[seed_node_uuid][:] - del self.dict_seed_uuid_to_list_rels[seed_node_uuid] - dict_nodetype_to_dict_name_to_node = self.dict_nodetype_to_dict_name_to_node - for nodetype in dict_nodetype_to_dict_name_to_node.keys(): - dict_name_to_node = dict_nodetype_to_dict_name_to_node[nodetype] - for name in dict_name_to_node.copy().keys(): - node = dict_name_to_node[name] - if node.seed_node.uuid == seed_node_uuid: - del dict_name_to_node[name] - del self.dict_seed_uuid_to_list_nodes[seed_node_uuid][:] - del self.dict_seed_uuid_to_list_nodes[seed_node_uuid] - - def clear_from_seed_node(self, seed_node): - self.clear_from_seed_node_uuid(seed_node.uuid) - - def clear_all(self): - for seed_node_uuid in self.dict_seed_uuid_to_list_nodes.keys(): - self.clear_from_seed_node_uuid(seed_node_uuid) - self.seed_node = None - - def neo4j_connect(self): - assert self.neo4j_url is not None - assert self.neo4j_user is not None - assert self.neo4j_password is not None - - self.driver = neo4j.v1.GraphDatabase.driver(self.neo4j_url, - auth=(self.neo4j_user, - self.neo4j_password)) - # def neo4j_shutdown(self): - # """shuts down the Orangeboard by disconnecting from the Neo4j database - # - # :returns: nothing - # """ - # self.driver.close() - - def neo4j_run_cypher_query(self, query, parameters=None): - """runs a single cypher query in the neo4j database (without a transaction) and returns the result object - - :param query: a ``str`` object containing a single cypher query (without a semicolon) - :param parameters: a ``dict`` object containing parameters for this query - :returns: a `neo4j.v1.SessionResult` object resulting from executing the neo4j query - """ - if self.debug: - print(query) - assert ';' not in query - - # Lazily initialize the driver - if self.driver is None: - self.neo4j_connect() - - session = self.driver.session() - res = session.run(query, parameters) - session.close() - return res - - def neo4j_clear(self, seed_node=None): - """deletes all nodes and relationships in the orangeboard - - :returns: nothing - """ - if seed_node is not None: - seed_node_uuid = seed_node.uuid - cypher_query_middle = ':Base {seed_node_uuid: \'' + seed_node_uuid + '\'}' - else: - cypher_query_middle = '' - - cypher_query = 'MATCH (n' + \ - cypher_query_middle + \ - ') DETACH DELETE n' - - if self.debug: - print(cypher_query) - - self.neo4j_run_cypher_query(cypher_query) - - def neo4j_push(self, seed_node=None): - assert self.dict_reltype_dirs is not None - - self.neo4j_clear() - - nodetypes = self.get_all_nodetypes() - for nodetype in nodetypes: - if self.debug: - print('Pushing nodes to Neo4j for node type: ' + nodetype) - nodes = self.get_all_nodes_for_nodetype(nodetype) - if seed_node is not None: - nodes &= self.get_all_nodes_for_seed_node_uuid(seed_node.uuid) - query_params = {'props': [node.get_props() for node in nodes]} - node = next(iter(nodes)) - cypher_query_str = 'UNWIND $props as map\nCREATE (n' + \ - Orangeboard.make_label_string_from_set(node.get_labels()) + \ - ')\nSET n = map' - if self.debug: - print(cypher_query_str) - res = self.neo4j_run_cypher_query(cypher_query_str, query_params) - if self.debug: - print(res.summary().counters) - - try: - self.neo4j_run_cypher_query('CREATE INDEX ON :Base(UUID)') - self.neo4j_run_cypher_query('CREATE INDEX ON :Base(seed_node_uuid)') - except neo4j.exceptions.ClientError as e: - print(str(e), file=sys.stderr) - - reltypes = self.get_all_reltypes() - for reltype in reltypes: - if self.debug: - print('Pushing relationships to Neo4j for relationship type: ' + reltype) - reltype_dir = self.dict_reltype_dirs[reltype] - rels = self.get_all_rels_for_reltype(reltype) - if seed_node is not None: - rels &= self.get_all_rels_for_seed_node_uuid(seed_node.uuid) - reltype_rels_params_list = [rel.get_props() for rel in rels] - if not reltype_dir: - reltype_rels_params_list = reltype_rels_params_list + \ - [rel.get_props(reverse=True) for rel in rels] - query_params = {'rel_data_list': reltype_rels_params_list} - cypher_query_str = 'UNWIND $rel_data_list AS rel_data_map\n' + \ - 'MATCH (n1:Base {UUID: rel_data_map.source_node_uuid}),' + \ - '(n2:Base {UUID: rel_data_map.target_node_uuid})\n' + \ - 'CREATE (n1)-[:`' + reltype + \ - '` { source_node_uuid: rel_data_map.source_node_uuid,' + \ - ' target_node_uuid: rel_data_map.target_node_uuid,' + \ - ' is_defined_by: \'RTX\',' + \ - ' provided_by: rel_data_map.sourcedb,' + \ - ' predicate: \'' + reltype + '\',' + \ - ' seed_node_uuid: rel_data_map.seed_node_uuid,' + \ - ' probability: rel_data_map.prob,' + \ - ' publications: rel_data_map.publications,' + \ - ' relation: rel_data_map.extended_reltype' + \ - ' }]->(n2)' - res = self.neo4j_run_cypher_query(cypher_query_str, query_params) - if self.debug: - print(res.summary().counters) - - def test_issue_66(): - ob = Orangeboard(debug=True) - gnode = ob.add_node('footype', 'g', seed_node_bool=True) - xnode = ob.add_node('footype', 'x', seed_node_bool=False) - ynode = ob.add_node('footype', 'y', seed_node_bool=True) - znode = ob.add_node('footype', 'z', seed_node_bool=True) - ob.add_node('footype', 'g', seed_node_bool=True) -# print(ob) - - def test_issue_104(): - ob = Orangeboard(debug=True) - ob.set_dict_reltype_dirs({'interacts_with': False}) - node1 = ob.add_node('uniprot_protein', 'w', seed_node_bool=True) - node2 = ob.add_node('bartype', 'x', seed_node_bool=False) - ob.add_rel('interacts_with', 'PC2', node1, node2) - ob.add_rel('interacts_with', 'PC2', node2, node1) - rtxConfig = RTXConfiguration() - ob.neo4j_set_url(rtxConfig.neo4j_bolt) - ob.neo4j_set_auth(rtxConfig.neo4j_username, rtxConfig.neo4j_password) - ob.neo4j_push() - print(ob) - - def test_issue_120(): - ob = Orangeboard(debug=True) - ob.set_dict_reltype_dirs({'interacts_with': False}) - node1 = ob.add_node('uniprot_protein', 'w', seed_node_bool=True) - node2 = ob.add_node('bartype', 'x', seed_node_bool=False) - ob.add_rel('interacts_with', 'PC2', node1, node2) - ob.add_rel('interacts_with', 'PC2', node2, node1) - rtxConfig = RTXConfiguration() - ob.neo4j_set_url(rtxConfig.neo4j_bolt) - ob.neo4j_set_auth(rtxConfig.neo4j_username, rtxConfig.neo4j_password) - ob.neo4j_push() - print(ob) - - def test_issue_130(): - ob = Orangeboard(debug=True) - ob.set_dict_reltype_dirs({'targets': True}) - node1 = ob.add_node('drug', 'x', seed_node_bool=True) - node2 = ob.add_node('uniprot_protein', 'w', seed_node_bool=False) - ob.add_rel('targets', 'ChEMBL', node1, node2, prob=0.5) - rtxConfig = RTXConfiguration() - ob.neo4j_set_url(rtxConfig.neo4j_bolt) - ob.neo4j_set_auth(rtxConfig.neo4j_username, rtxConfig.neo4j_password) - ob.neo4j_push() - print(ob) - - def test_extended_reltype(): - ob = Orangeboard(debug=True) - ob.set_dict_reltype_dirs({'targets': True, 'targets2': True}) - node1 = ob.add_node('drug', 'x', seed_node_bool=True) - node2 = ob.add_node('uniprot_protein', 'w', seed_node_bool=False) - ob.add_rel('targets', 'ChEMBL', node1, node2, prob=0.5) - ob.add_rel('targets2', 'ChEMBL2', node1, node2, prob=0.5, extended_reltype="test") - rtxConfig = RTXConfiguration() - ob.neo4j_set_url(rtxConfig.neo4j_bolt) - ob.neo4j_set_auth(rtxConfig.neo4j_username, rtxConfig.neo4j_password) - ob.neo4j_push() - print(ob) - -if __name__ == '__main__': - parser = argparse.ArgumentParser(description='Builds the master knowledge graph') - parser.add_argument('--runfunc', dest='runfunc') - args = parser.parse_args() - args_dict = vars(args) - if args_dict.get('runfunc', None) is not None: - run_function_name = args_dict['runfunc'] - else: - sys.exit("must specify --runfunc") - run_method = getattr(Orangeboard, run_function_name, None) - if run_method is None: - sys.exit("function not found: " + run_function_name) - - running_time = timeit.timeit(lambda: run_method(), number=1) - print('running time for function: ' + str(running_time)) - diff --git a/code/reasoningtool/kg-construction/ParsePhenont.py b/code/reasoningtool/kg-construction/ParsePhenont.py deleted file mode 100644 index 4397f53a4..000000000 --- a/code/reasoningtool/kg-construction/ParsePhenont.py +++ /dev/null @@ -1,30 +0,0 @@ -'''Parse the human phenotype ontology - -''' - -__author__ = 'Stephen Ramsey' -__copyright__ = 'Oregon State University' -__credits__ = ['Stephen Ramsey', 'Zheng Liu', 'Yao Yao'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -import pronto -import json - -class ParsePhenont: - @staticmethod - def get_name_id_dict(hp_obo_file_name): - ont = pronto.Ontology(hp_obo_file_name) - phenont_json = json.loads(ont.json) - ret_dict = dict() - for phenont_id in phenont_json.keys(): - name = phenont_json[phenont_id]['name'] - ret_dict[name]=phenont_id - return ret_dict - -if __name__ == '__main__': - print(ParsePhenont.get_name_id_dict('../../hpo/hp.obo')) - diff --git a/code/reasoningtool/kg-construction/PatchKG.py b/code/reasoningtool/kg-construction/PatchKG.py deleted file mode 100644 index d8c2c78c2..000000000 --- a/code/reasoningtool/kg-construction/PatchKG.py +++ /dev/null @@ -1,119 +0,0 @@ -""" - -How to run this module -$ cd [git repo]/code/reasoningtool/kg-construction -$ python3 PatchKG.py -a # add_disease_has_phenotype_relations -$ python3 PatchKG.py -d # delete_duplicated_react_nodes -""" - - -# BEGIN config.json format -# { -# "url":"bolt://localhost:7687" -# "username":"xxx", -# "password":"xxx" -# } -# END config.json format - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -from QueryBioLink import QueryBioLink -from Neo4jConnection import Neo4jConnection -import json -import sys, getopt -import os - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../") # code directory -from RTXConfiguration import RTXConfiguration - -class PatchKG: - @staticmethod - def add_disease_has_phenotype_relations(): - - # create the RTXConfiguration object - rtxConfig = RTXConfiguration() - - conn = Neo4jConnection(rtxConfig.neo4j_bolt, rtxConfig.neo4j_username, rtxConfig.neo4j_password) - disease_nodes = conn.get_disease_nodes() - print("disease nodes count: " + str(len(disease_nodes))) - - from time import time - t = time() - - array = [] - for d_id in disease_nodes: - hp_array = QueryBioLink.map_disease_to_phenotype(d_id) - if hp_array: - for hp_id in hp_array: - array.append({'d_id': d_id, 'p_id': hp_id}) - - print("time for querying: %f" % (time() - t)) - t = time() - - print("relations count = " + str(len(array))) - nodes_nums = len(array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.create_disease_has_phenotype(array[start:end]) - - print("time for creating relations: %f" % (time() - t)) - t = time() - - # remove duplicated relations - conn.remove_duplicate_has_phenotype_relations() - print("time for remove duplicate relations: %f" % (time() - t)) - - conn.close() - - @staticmethod - def delete_duplicated_react_nodes(): - - # create the RTXConfiguration object - rtxConfig = RTXConfiguration() - - conn = Neo4jConnection(rtxConfig.neo4j_bolt, rtxConfig.neo4j_username, rtxConfig.neo4j_password) - - if conn.count_duplicated_nodes() != 0: - conn.remove_duplicated_react_nodes() - if conn.count_duplicated_nodes() != 0: - print("Delete duplicated reactom nodes unsuccessfully") - else: - print("Delete duplicated reactom nodes successfully") - else: - print("no duplicated reactom nodes") - - conn.close() - - -def main(argv): - try: - opts, args = getopt.getopt(argv, "had", ["add_has_phenotype_relations", "delete_duplicated_react_nodes"]) - except getopt.GetoptError: - print("Wrong parameter") - print("PatchKG.py -a -d ") - sys.exit(2) - if len(opts) == 0: - print("Need parameters") - print("PatchKG.py -a -d ") - for opt, arg in opts: - if opt == '-h': - print("PatchKG.py -a -d ") - sys.exit() - elif opt in ["-a", "--add_has_phenotype_relations"]: - PatchKG.add_disease_has_phenotype_relations() - elif opt in ["-d", "--delete_duplicated_react_nodes"]: - PatchKG.delete_duplicated_react_nodes() - - -if __name__ == '__main__': - main(sys.argv[1:]) diff --git a/code/reasoningtool/kg-construction/PatchKGDGIdb.py b/code/reasoningtool/kg-construction/PatchKGDGIdb.py deleted file mode 100644 index de5029c17..000000000 --- a/code/reasoningtool/kg-construction/PatchKGDGIdb.py +++ /dev/null @@ -1,76 +0,0 @@ -import requests_cache -import sys, os -import re -from QueryDGIdb import QueryDGIdb -from Neo4jConnection import Neo4jConnection -import re - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../") # code directory -from RTXConfiguration import RTXConfiguration - -#requests_cache.install_cache('orangeboard') -# specifiy the path of orangeboard database -pathlist = os.path.realpath(__file__).split(os.path.sep) -RTXindex = pathlist.index("RTX") -dbpath = os.path.sep.join([*pathlist[:(RTXindex+1)],'data','orangeboard']) -requests_cache.install_cache(dbpath) - -rtxConfig = RTXConfiguration() - -conn = Neo4jConnection(rtxConfig.neo4j_bolt, rtxConfig.neo4j_username, rtxConfig.neo4j_password) -disease_nodes = conn.get_disease_nodes() -drug_nodes = conn.get_chemical_substance_nodes() -protein_nodes = conn.get_protein_nodes() - - -def get_proteins(tx): - result = tx.run("MATCH (n:protein) return n.id, n.UUID") - return dict((record["n.id"], record["n.UUID"]) for record in result) - - -def get_drugs(tx): - result = tx.run("MATCH (n:chemical_substance) return n.id, n.UUID") - return dict((record["n.id"], record["n.UUID"]) for record in result) - - -def get_seed_node_uuid(tx): - return next(iter(tx.run("MATCH (n:protein) return n.seed_node_uuid limit 1")))["n.seed_node_uuid"] - - -protein_dict = conn._driver.session().read_transaction(get_proteins) - -drug_dict = conn._driver.session().read_transaction(get_drugs) - -seed_node_uuid = conn._driver.session().read_transaction(get_seed_node_uuid) - - -def patch_kg(): - tuple_list = QueryDGIdb.read_interactions() - for tuple_dict in tuple_list: - chembl_id = tuple_dict['drug_chembl_id'] - uniprot_id = tuple_dict['protein_uniprot_id'] - protein_curie_id = 'UniProtKB:' + uniprot_id - chembl_curie_id = 'CHEMBL.COMPOUND:' + chembl_id - if protein_curie_id in protein_dict and chembl_curie_id in drug_dict: - cypher_query = "MATCH (b:chemical_substance),(a:protein) WHERE a.id = \'" + \ - protein_curie_id + \ - "\' AND b.id=\'" + \ - chembl_curie_id + \ - "\' CREATE (b)-[r:" + \ - tuple_dict['predicate'] + \ - " { is_defined_by: \'RTX\', predicate: \'" + \ - tuple_dict['predicate'] + \ - "\', provided_by: \'DGIdb;" + \ - tuple_dict['sourcedb'] + \ - "\', relation: \'" + \ - tuple_dict['predicate_extended'] + \ - "\', seed_node_uuid: \'" + \ - seed_node_uuid + \ - "\', publications: \'" + \ - tuple_dict['pmids'] + \ - "\' } ]->(a) RETURN type(r)" - print(cypher_query) - conn._driver.session().write_transaction(lambda tx: tx.run(cypher_query)) - - -patch_kg() diff --git a/code/reasoningtool/kg-construction/QueryBioLink.py b/code/reasoningtool/kg-construction/QueryBioLink.py deleted file mode 100644 index 1d127252c..000000000 --- a/code/reasoningtool/kg-construction/QueryBioLink.py +++ /dev/null @@ -1,320 +0,0 @@ -''' This module defines the class QueryBioLink. QueryBioLink class is designed -to communicate with Monarch APIs and their corresponding data sources. The -available methods include: - * query phenotype for disease - * query disease for gene - * query gene for disease - * query phenotype for gene - * query gene for pathway - * query label for disease - * query label for phenotype - * query anatomy for gene - * query gene for anatomy - * query anatomy for phenotype -''' - -__author__ = 'Zheng Liu' -__copyright__ = 'Oregon State University' -__credits__ = ['Zheng Liu', 'Stephen Ramsey', 'Yao Yao'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -# import requests -# import requests_cache -import sys -import json -from cache_control_helper import CacheControlHelper - - -class QueryBioLink: - TIMEOUT_SEC = 120 - API_BASE_URL = 'https://api.monarchinitiative.org/api' - HANDLER_MAP = { - 'get_phenotypes_for_disease': 'bioentity/disease/{disease_id}/phenotypes', - 'get_diseases_for_gene': 'bioentity/gene/{gene_id}/diseases', - 'get_genes_for_disease': 'bioentity/disease/{disease_id}/genes', - 'get_phenotypes_for_gene': 'bioentity/gene/{gene_id}/phenotypes?exclude_automatic_assertions=true&unselect_evidence=true', - 'get_genes_for_pathway': 'bioentity/pathway/{pathway_id}/genes&unselect_evidence=true', - 'get_label_for_disease': 'bioentity/disease/{disease_id}', - 'get_label_for_phenotype': 'bioentity/phenotype/{phenotype_id}', - 'get_anatomies_for_gene': 'bioentity/gene/{gene_id}/expression/anatomy', - 'get_genes_for_anatomy': 'bioentity/anatomy/{anatomy_id}/genes', - 'get_anatomies_for_phenotype': 'bioentityphenotype/{phenotype_id}/anatomy', - 'get_synonyms_for_disease': 'bioentity/{disease_id}/associations', - 'get_anatomy': 'bioentity/anatomy/{id}', - 'get_phenotype': 'bioentity/phenotype/{id}', - 'get_disease': 'bioentity/disease/{id}', - 'get_bio_process': 'bioentity/{id}', - 'map_disease_to_phenotype': 'bioentity/disease/{disease_id}/phenotypes' - } - - @staticmethod - def __access_api(handler): - - requests = CacheControlHelper() - url = QueryBioLink.API_BASE_URL + '/' + handler - # print(url) - try: - res = requests.get(url, timeout=QueryBioLink.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print('Timeout in QueryBioLink for URL: ' + url, file=sys.stderr) - return None - except KeyboardInterrupt: - sys.exit(0) - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QueryBioLink for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - - return res.json() - - @staticmethod - def get_label_for_disease(disease_id): - handler = QueryBioLink.HANDLER_MAP['get_label_for_disease'].format(disease_id=disease_id) - results = QueryBioLink.__access_api(handler) - result_str = 'None' - if results is not None: - result_str = results['label'] - return result_str - - @staticmethod - def get_phenotypes_for_disease_desc(disease_id): - handler = QueryBioLink.HANDLER_MAP['get_phenotypes_for_disease'].format(disease_id=disease_id) - results = QueryBioLink.__access_api(handler) - ret_dict = dict() - if results is None: - return ret_dict - res_list = results['objects'] - if len(res_list) > 200: - print('Number of phenotypes found for disease: ' + disease_id + ' is: ' + str(len(res_list)), file=sys.stderr) - for phenotype_id_str in res_list: - if phenotype_id_str.startswith("AQTLTrait:"): - continue - phenotype_label_str = QueryBioLink.get_label_for_phenotype(phenotype_id_str) - ret_dict[phenotype_id_str] = phenotype_label_str - - return ret_dict - - @staticmethod - def get_diseases_for_gene_desc(gene_id): - '''for a given NCBI Entrez Gene ID, returns a ``set`` of DOI disease identifiers for the gene - - :returns: a ``set`` containing ``str`` disease ontology identifiers - ''' - handler = QueryBioLink.HANDLER_MAP['get_diseases_for_gene'].format(gene_id=gene_id) - results = QueryBioLink.__access_api(handler) - ret_data = dict() - if results is None: - return ret_data - - ret_list = results['objects'] - - if len(ret_list) > 200: - print('Number of diseases found for gene ' + gene_id + ' is: ' + str(len(ret_list)), file=sys.stderr) - - for disease_id in ret_list: - if 'DOID:' in disease_id or 'OMIM:' in disease_id: - ret_data[disease_id] = QueryBioLink.get_label_for_disease(disease_id) - - return ret_data - - @staticmethod - def get_genes_for_disease_desc(disease_id): - handler = QueryBioLink.HANDLER_MAP['get_genes_for_disease'].format(disease_id=disease_id) - - results = QueryBioLink.__access_api(handler) - ret_list = [] - if results is None: - return ret_list - ret_list = results['objects'] - - if len(ret_list) > 100: - print('number of genes found for disease ' + disease_id + ' is: ' + str(len(ret_list)), file=sys.stderr) - return ret_list - - @staticmethod - def get_label_for_phenotype(phenotype_id_str): - handler = QueryBioLink.HANDLER_MAP['get_label_for_phenotype'].format(phenotype_id=phenotype_id_str) - results = QueryBioLink.__access_api(handler) - result_str = 'None' - if results is not None: - result_str = results['label'] - return result_str - - @staticmethod - def get_phenotypes_for_gene(gene_id): - handler = QueryBioLink.HANDLER_MAP['get_phenotypes_for_gene'].format(gene_id=gene_id) - - results = QueryBioLink.__access_api(handler) - ret_list = [] - if results is None: - return ret_list - ret_list = results['objects'] - - if len(ret_list) > 200: - print('Warning, got ' + str(len(ret_list)) + ' phenotypes for gene ' + gene_id, file=sys.stderr) - - return ret_list - - @staticmethod - def get_phenotypes_for_gene_desc(ncbi_entrez_gene_id): - phenotype_id_set = QueryBioLink.get_phenotypes_for_gene(ncbi_entrez_gene_id) - ret_dict = dict() - for phenotype_id_str in phenotype_id_set: - phenotype_label_str = QueryBioLink.get_label_for_phenotype(phenotype_id_str) - if 'HP:' in phenotype_id_str: - ret_dict[phenotype_id_str] = phenotype_label_str - return ret_dict - - @staticmethod - def get_anatomies_for_gene(gene_id): - '''for a given NCBI Entrez Gene ID, returns a ``dict`` of Anatomy IDs and labels for the gene - - :returns: a ``dict`` of - ''' - handler = QueryBioLink.HANDLER_MAP['get_anatomies_for_gene'].format(gene_id=gene_id) - - results = QueryBioLink.__access_api(handler) - ret_dict = dict() - if results is None: - return ret_dict - res_dict = results['associations'] - ret_dict = dict(map(lambda r: (r['object']['id'], r['object']['label']), res_dict)) - - if len(ret_dict) > 200: - print('Warning, got {} anatomies for gene {}'.format(len(ret_dict), gene_id), file=sys.stderr) - - return ret_dict - - @staticmethod - def get_genes_for_anatomy(anatomy_id): - '''for a given Anatomy ID, returns a ``list`` of Gene ID for the anatomy - - :returns: a ``list`` of gene ID - ''' - handler = QueryBioLink.HANDLER_MAP['get_genes_for_anatomy'].format(anatomy_id=anatomy_id) - - results = QueryBioLink.__access_api(handler) - ret_list = [] - if results is None: - return ret_list - res_dict = results['associations'] - ret_list = list(map(lambda r: r['subject']['id'], res_dict)) - - if len(ret_list) > 200: - print('Warning, got {} genes for anatomy {}'.format(len(ret_list), anatomy_id), file=sys.stderr) - - return ret_list - - @staticmethod - def get_anatomies_for_phenotype(phenotype_id): - '''for a given phenotype ID, returns a ``dict`` of Anatomy IDs and labels for the phenotype - - :returns: a ``dict`` of - ''' - handler = QueryBioLink.HANDLER_MAP['get_anatomies_for_phenotype'].format(phenotype_id=phenotype_id) - - results = QueryBioLink.__access_api(handler) - ret_dict = dict() - if results is None: - return ret_dict - - ret_dict = dict(map(lambda r: (r['id'], r['label']), results)) - - if len(ret_dict) > 200: - print('Warning, got {} anatomies for phenotype {}'.format(len(ret_dict), phenotype_id), file=sys.stderr) - - return ret_dict - - @staticmethod - def __get_entity(entity_type, entity_id): - handler = QueryBioLink.HANDLER_MAP[entity_type].format(id=entity_id) - results = QueryBioLink.__access_api(handler) - result_str = 'None' - if results is not None: - # remove all \n characters using json api and convert the string to one line - result_str = json.dumps(results) - return result_str - - @staticmethod - def get_anatomy_entity(anatomy_id): - return QueryBioLink.__get_entity("get_anatomy", anatomy_id) - - @staticmethod - def get_phenotype_entity(phenotype_id): - return QueryBioLink.__get_entity("get_phenotype", phenotype_id) - - @staticmethod - def get_disease_entity(disease_id): - return QueryBioLink.__get_entity("get_disease", disease_id) - - @staticmethod - def get_bio_process_entity(bio_process_id): - return QueryBioLink.__get_entity("get_bio_process", bio_process_id) - - @staticmethod - def map_disease_to_phenotype(disease_id): - """ - Mapping a disease to a list of phenotypes - :param disease_id: The DOID / OMIM ID for a disease - :return: A list of phenotypes HP IDs, or an empty array if no HP IDs are found - """ - hp_array = [] - if not isinstance(disease_id, str) or (disease_id[:5] != "OMIM:" and disease_id[:5] != "DOID:"): - return hp_array - handler = QueryBioLink.HANDLER_MAP['map_disease_to_phenotype'].format(disease_id=disease_id) - results = QueryBioLink.__access_api(handler) - if results is not None: - if 'objects' in results.keys(): - hp_array = results['objects'] - return hp_array - - -if __name__ == '__main__': - # print(QueryBioLink.get_genes_for_disease_desc('MONDO:0005359')) - # print(QueryBioLink.get_phenotypes_for_disease_desc('MONDO:0005359')) - # print(QueryBioLink.get_phenotypes_for_disease_desc('OMIM:605543')) - # print(QueryBioLink.get_genes_for_disease_desc('OMIM:XXXXXX')) - # print(QueryBioLink.get_genes_for_disease_desc('OMIM:605543')) - # print(QueryBioLink.get_phenotypes_for_gene_desc('NCBIGene:1080')) # test for issue #22 - # print(QueryBioLink.get_diseases_for_gene_desc('NCBIGene:407053')) - # print(QueryBioLink.get_diseases_for_gene_desc('NCBIGene:100048912')) - # print(QueryBioLink.get_phenotypes_for_gene_desc('NCBIGene:4750')) - # print(QueryBioLink.get_phenotypes_for_gene('NCBIGene:4750')) - # print(QueryBioLink.get_diseases_for_gene_desc('NCBIGene:4750')) - # print(QueryBioLink.get_diseases_for_gene_desc('NCBIGene:1111111')) - # print(QueryBioLink.get_label_for_disease('DOID:1498')) - # print(QueryBioLink.get_label_for_disease('OMIM:605543')) - # print(QueryBioLink.get_label_for_phenotype('HP:0000003')) - # print(QueryBioLink.get_anatomies_for_gene('NCBIGene:407053')) - # print(QueryBioLink.get_genes_for_anatomy('UBERON:0000006')) - # print(QueryBioLink.get_anatomies_for_phenotype('HP:0000003')) - - def save_to_test_file(key, value): - f = open('tests/query_test_data.json', 'r+') - try: - json_data = json.load(f) - except ValueError: - json_data = {} - f.seek(0) - f.truncate() - json_data[key] = value - json.dump(json_data, f) - f.close() - - # save_to_test_file('UBERON:0004476', QueryBioLink.get_anatomy_entity('UBERON:0004476')) - # save_to_test_file('HP:0011515', QueryBioLink.get_phenotype_entity('HP:0011515')) - # save_to_test_file('DOID:3965', QueryBioLink.get_disease_entity('DOID:3965')) - # save_to_test_file('GO:0097289', QueryBioLink.get_bio_process_entity('GO:0097289')) - - # PARKINSON DISEASE 4 - print(QueryBioLink.map_disease_to_phenotype("OMIM:605543")) diff --git a/code/reasoningtool/kg-construction/QueryBioLinkExtended.py b/code/reasoningtool/kg-construction/QueryBioLinkExtended.py deleted file mode 100644 index 08b9a5740..000000000 --- a/code/reasoningtool/kg-construction/QueryBioLinkExtended.py +++ /dev/null @@ -1,104 +0,0 @@ - -''' This module defines the class QueryBioLinkExtended. QueryBioLinkExtended class is designed -to communicate with Monarch APIs and their corresponding data sources. The -available methods include: - * query anatomy entity by ID -''' - - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -# import requests -# import requests_cache -import sys -import json -from cache_control_helper import CacheControlHelper - - -class QueryBioLinkExtended: - TIMEOUT_SEC = 120 - API_BASE_URL = 'https://api.monarchinitiative.org/api/bioentity' - HANDLER_MAP = { - 'get_anatomy': 'anatomy/{id}', - 'get_phenotype': 'phenotype/{id}', - 'get_disease': 'disease/{id}', - 'get_bio_process': '{id}' - } - - @staticmethod - def __access_api(handler): - - requests = CacheControlHelper() - url = QueryBioLinkExtended.API_BASE_URL + '/' + handler - - try: - res = requests.get(url, timeout=QueryBioLinkExtended.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print('Timeout in QueryBioLink for URL: ' + url, file=sys.stderr) - return None - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QueryBioLink for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - - return res.text - - @staticmethod - def __get_entity(entity_type, entity_id): - handler = QueryBioLinkExtended.HANDLER_MAP[entity_type].format(id=entity_id) - results = QueryBioLinkExtended.__access_api(handler) - result_str = 'UNKNOWN' - if results is not None: - # remove all \n characters using json api and convert the string to one line - json_dict = json.loads(results) - result_str = json.dumps(json_dict) - return result_str - - @staticmethod - def get_anatomy_entity(anatomy_id): - return QueryBioLinkExtended.__get_entity("get_anatomy", anatomy_id) - - @staticmethod - def get_phenotype_entity(phenotype_id): - return QueryBioLinkExtended.__get_entity("get_phenotype", phenotype_id) - - @staticmethod - def get_disease_entity(disease_id): - return QueryBioLinkExtended.__get_entity("get_disease", disease_id) - - @staticmethod - def get_bio_process_entity(bio_process_id): - return QueryBioLinkExtended.__get_entity("get_bio_process", bio_process_id) - - -if __name__ == '__main__': - - def save_to_test_file(key, value): - f = open('tests/query_test_data.json', 'r+') - try: - json_data = json.load(f) - except ValueError: - json_data = {} - f.seek(0) - f.truncate() - json_data[key] = value - json.dump(json_data, f) - f.close() - - save_to_test_file('UBERON:0004476', QueryBioLinkExtended.get_anatomy_entity('UBERON:0004476')) - save_to_test_file('HP:0011515', QueryBioLinkExtended.get_phenotype_entity('HP:0011515')) - save_to_test_file('DOID:3965', QueryBioLinkExtended.get_disease_entity('DOID:3965')) - save_to_test_file('GO:0097289', QueryBioLinkExtended.get_bio_process_entity('GO:0097289')) diff --git a/code/reasoningtool/kg-construction/QueryDGIdb.py b/code/reasoningtool/kg-construction/QueryDGIdb.py deleted file mode 100644 index f57610c7f..000000000 --- a/code/reasoningtool/kg-construction/QueryDGIdb.py +++ /dev/null @@ -1,119 +0,0 @@ -"""This module defines the class QueryDGIdb which downloads and reads the -interactions.tsv file from the DGIdb database (http://www.dgidb.org/downloads) - -""" - -__author__ = "Stephen Ramsey" -__copyright__ = "" -__credits__ = ['Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = 'Stephen Ramsey' -__email__ = 'stephen.ramsey@oregonstate.edu' -__status__ = 'Prototype' - -import pandas -import sys -from QueryMyGene import QueryMyGene -from QueryPubChem import QueryPubChem -from QueryChEMBL import QueryChEMBL - - -class QueryDGIdb: - INTERACTIONS_TSV_URL = 'http://www.dgidb.org/data/interactions.tsv' - - mygene = QueryMyGene() - - predicate_map = {'inhibitor': 'negatively_regulates', - 'agonist': 'positively_regulates', - 'antagonist': 'negatively_regulates', - 'blocker': 'negatively_regulates', - 'positive allosteric modulator': 'positively_regulates', - 'channel blocker': 'negatively_regulates', - 'allosteric modulator': 'negatively_regulates', - 'activator': 'positively_regulates', - 'antibody': 'affects', - 'binder': 'affects', - 'modulator': 'negatively_regulates', - 'partial agonist': 'positively_regulates', - 'gating inhibitor': 'negatively_regulates', - 'antisense': 'negatively_regulates', - 'vaccine': 'negatively_regulates', - 'inverse agonist': 'negatively_regulates', - 'stimulator': 'positively_regulates', - 'antisense oligonucleotide': 'negatively_regulates', - 'cofactor': 'physically_interacts_with', - 'negative modulator': 'negatively_regulates', - 'inducer': 'positively_regulates', - 'suppressor': 'negatively_regulates', - 'inhibitory allosteric modulator': 'negatively_regulates', - 'affects': 'affects'} - - def read_interactions(): - int_data = pandas.read_csv(QueryDGIdb.INTERACTIONS_TSV_URL, sep='\t') - int_data.fillna('', inplace=True) - res_list = [] - for index, row in int_data.iterrows(): - pmids = row['PMIDs'] - gene_name = row['gene_name'] - gene_claim_name = row['gene_claim_name'] - if gene_name != '': - gene_symbol = gene_name - else: - if gene_claim_name != '': - gene_symbol = gene_claim_name - else: - continue - assert ',' not in gene_symbol - uniprot_ids_set = QueryDGIdb.mygene.convert_gene_symbol_to_uniprot_id(gene_symbol) - if len(uniprot_ids_set) == 0: - continue - - drug_chembl_id = row['drug_chembl_id'] - drug_name = row['drug_name'] - - if drug_chembl_id != '': - if type(drug_chembl_id) == float: - print(row) - assert ',' not in drug_chembl_id - drug_chembl_id_set = {drug_chembl_id} - if drug_name == '': - print("warning; ChEMBL compound has no drug name", file=sys.stderr) - else: - if drug_name != '': - assert ',' not in drug_name - drug_chembl_id_set = QueryPubChem.get_chembl_ids_for_drug(drug_name) - if len(drug_chembl_id_set) == 0: - drug_chembl_id_set = QueryChEMBL.get_chembl_ids_for_drug(drug_name) - if len(drug_chembl_id_set) == 0: - continue - else: - continue - - interaction_claim_source_field = row['interaction_claim_source'] - interaction_types_field = row['interaction_types'] - if interaction_types_field != '': - assert type(interaction_types_field) == str - predicate_list = interaction_types_field.split(',') - else: - predicate_list = ['affects'] - - for uniprot_id in uniprot_ids_set: - for predicate_str in predicate_list: - res_list.append({ - 'drug_chembl_id': drug_chembl_id, - 'drug_name': drug_name, - 'predicate': QueryDGIdb.predicate_map[predicate_str], - 'predicate_extended': predicate_str, - 'protein_uniprot_id': uniprot_id, - 'protein_gene_symbol': gene_symbol, - 'sourcedb': interaction_claim_source_field, - 'pmids': pmids}) -# print(drug_chembl_id + '\t' + predicate_str + '\t' + uniprot_id + '\t' + interaction_claim_source_field + '\t' + ','.join(pmids_list)) - return res_list - - -if __name__ == '__main__': - res_list = QueryDGIdb.read_interactions() - for tuple in res_list: - print(tuple) diff --git a/code/reasoningtool/kg-construction/QueryDisGeNet.py b/code/reasoningtool/kg-construction/QueryDisGeNet.py deleted file mode 100644 index 72c328239..000000000 --- a/code/reasoningtool/kg-construction/QueryDisGeNet.py +++ /dev/null @@ -1,117 +0,0 @@ -# Copyright [2010-2017] Integrative Biomedical Informatics Group, Research Programme on Biomedical Informatics (GRIB) IMIM-UPF -# http://ibi.imim.es/ -# Modified by Stephen Ramsey at Oregon State University -############################################################################### -""" This module defines the class QueryDisGeNet which is designed to query -descriptions according to the mesh ids. -""" - -__author__ = 'Stephen Ramsey' -__copyright__ = 'Oregon State University' -__credits__ = ['Stephen Ramsey', 'Yao Yao', 'Zheng Liu'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -import pandas -import io -import math -# import requests -from cache_control_helper import CacheControlHelper -import sys -import functools -import CachedMethods - -class QueryDisGeNet: - MAX_PROTS_FOR_GENE = 3 ## maybe we should make this a configurable class variable (SAR) - MAX_GENES_FOR_DISEASE = 20 ## maybe we should make this a configurable class variable (SAR) - SPARQL_ENDPOINT_URL = 'http://www.disgenet.org/oql' - TIMEOUT_SEC = 120 - - @staticmethod - @CachedMethods.register - @functools.lru_cache(maxsize=1024, typed=False) - def query_mesh_id_to_uniprot_ids_desc(mesh_id): - ent = 'disease' - id = 'mesh' - STR = "c1.MESH = '" - intfield = mesh_id - seq = ( """ - DEFINE - c0='/data/gene_disease_summary', - c1='/data/diseases', - c2='/data/genes', - c4='/data/sources' - ON - 'http://www.disgenet.org/web/DisGeNET' - SELECT - c1 (diseaseId, name, diseaseClassName, STY, MESH, OMIM, type ), - c2 (geneId, symbol, uniprotId, description, pantherName ), - c0 (score, EI, Npmids, Nsnps) - - FROM - c0 - WHERE - ( - """ + STR + mesh_id+"""' - AND - c4 = 'ALL' - ) - ORDER BY - c0.score DESC""" ); # - - binary_data = seq.encode('utf-8') - url_str = QueryDisGeNet.SPARQL_ENDPOINT_URL - requests = CacheControlHelper() - - try: - res = requests.post(url_str, data=binary_data, timeout=QueryDisGeNet.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print(url_str, sys.stderr) - print('Timeout in QueryDisGeNet for URL: ' + url_str, file=sys.stderr) - return dict() - except BaseException as e: - print(url_str, file=sys.stderr) - print('%s received in QueryDisGeNet for URL: %s' % (e, url_str), file=sys.stderr) - return None - - status_code = res.status_code - - if status_code != 200: - print(url_str, sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url_str, file=sys.stderr) - return dict() - - if len(res.content) == 0: - print(url_str, file=sys.stderr) - print('Empty response from URL!', file=sys.stderr) - return dict() - - ret_data_df = pandas.read_csv(io.StringIO(res.content.decode('utf-8')), sep='\t').head(QueryDisGeNet.MAX_GENES_FOR_DISEASE) - uniprot_ids_list = ret_data_df['c2.uniprotId'].tolist() - gene_names_list = ret_data_df['c2.symbol'].tolist() - ret_dict = dict(list(zip(uniprot_ids_list, gene_names_list))) - for prot in ret_dict.copy().keys(): - if type(prot)==str and prot != "null": - if '.' in prot or ';' in prot: - gene = ret_dict[prot] - del ret_dict[prot] - prot.replace('.', '') - prots_to_add = prot.split(';') - if len(prots_to_add) > QueryDisGeNet.MAX_PROTS_FOR_GENE: - prots_to_add = prots_to_add[0:QueryDisGeNet.MAX_PROTS_FOR_GENE] - dict_add = dict() - for prot_name in prots_to_add: - if type(prot_name) == str and prot_name != "null": - dict_add[prot_name] = gene - ret_dict.update(dict_add) - else: ## this is a math.nan - del ret_dict[prot] - return(ret_dict) - - -if __name__ == '__main__': - print(QueryDisGeNet.query_mesh_id_to_uniprot_ids_desc('D016779')) - print(QueryDisGeNet.query_mesh_id_to_uniprot_ids_desc('D004443')) diff --git a/code/reasoningtool/kg-construction/QueryEBIOLSExtended.py b/code/reasoningtool/kg-construction/QueryEBIOLSExtended.py deleted file mode 100644 index 9cdd9312c..000000000 --- a/code/reasoningtool/kg-construction/QueryEBIOLSExtended.py +++ /dev/null @@ -1,131 +0,0 @@ - -''' This module defines the class QueryBioLinkExtended. QueryBioLinkExtended class is designed -to communicate with Monarch APIs and their corresponding data sources. The -available methods include: - * query anatomy entity by ID -''' - - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -# import requests -# import requests_cache -from cache_control_helper import CacheControlHelper - -import urllib.parse -import sys -import json - - -class QueryEBIOLSExtended: - TIMEOUT_SEC = 120 - API_BASE_URL = 'https://www.ebi.ac.uk/ols/api/ontologies' - HANDLER_MAP = { - 'get_anatomy': '{ontology}/terms/{id}', - 'get_phenotype': '{ontology}/terms/{id}', - 'get_disease': '{ontology}/terms/{id}', - 'get_bio_process': '{ontology}/terms/{id}', - 'get_cellular_component': '{ontology}/terms/{id}', - 'get_molecular_function': '{ontology}/terms/{id}' - } - - @staticmethod - def __access_api(handler): - - requests = CacheControlHelper() - url = QueryEBIOLSExtended.API_BASE_URL + '/' + handler - # print(url) - try: - res = requests.get(url, timeout=QueryEBIOLSExtended.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print('Timeout in QueryEBIOLSExtended for URL: ' + url, file=sys.stderr) - return None - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QueryEBIOLSExtended for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - - return res.text - - @staticmethod - def __get_entity(entity_type, entity_id): - ontology_id = entity_id[:entity_id.find(":")] - iri = "http://purl.obolibrary.org/obo/" + entity_id.replace(":", "_") - iri_double_encoded = urllib.parse.quote_plus(urllib.parse.quote_plus(iri)) - handler = QueryEBIOLSExtended.HANDLER_MAP[entity_type].format(ontology=ontology_id.lower(), id=iri_double_encoded) - results = QueryEBIOLSExtended.__access_api(handler) - result_str = "None" - if results is not None: - res_json = json.loads(results) - # print(res_json) - res_description = res_json.get("description", None) - if res_description is not None: - if len(res_description) > 0: - result_str = res_description[0] - return result_str - - @staticmethod - def get_anatomy_description(anatomy_id): - return QueryEBIOLSExtended.__get_entity("get_anatomy", anatomy_id) - - @staticmethod - def get_bio_process_description(bio_process_id): - return QueryEBIOLSExtended.__get_entity("get_bio_process", bio_process_id) - - @staticmethod - def get_phenotype_description(phenotype_id): - return QueryEBIOLSExtended.__get_entity("get_phenotype", phenotype_id) - - @staticmethod - def get_disease_description(disease_id): - return QueryEBIOLSExtended.__get_entity("get_disease", disease_id) - - @staticmethod - def get_cellular_component_description(cc_id): - return QueryEBIOLSExtended.__get_entity("get_cellular_component", cc_id) - - @staticmethod - def get_molecular_function_description(mf_id): - return QueryEBIOLSExtended.__get_entity("get_molecular_function", mf_id) - -if __name__ == '__main__': - - def save_to_test_file(key, value): - f = open('tests/query_desc_test_data.json', 'r+') - try: - json_data = json.load(f) - except ValueError: - json_data = {} - f.seek(0) - f.truncate() - json_data[key] = value - json.dump(json_data, f) - f.close() - - save_to_test_file('UBERON:0004476', QueryEBIOLSExtended.get_anatomy_description('UBERON:0004476')) - save_to_test_file('UBERON:00044760', QueryEBIOLSExtended.get_anatomy_description('UBERON:00044760')) - save_to_test_file('CL:0000038', QueryEBIOLSExtended.get_anatomy_description('CL:0000038')) - save_to_test_file('CL:00000380', QueryEBIOLSExtended.get_anatomy_description('CL:00000380')) - save_to_test_file('GO:0042535', QueryEBIOLSExtended.get_bio_process_description('GO:0042535')) - save_to_test_file('GO:00425350', QueryEBIOLSExtended.get_bio_process_description('GO:00425350')) - save_to_test_file('HP:0011105', QueryEBIOLSExtended.get_phenotype_description('HP:0011105')) - save_to_test_file('HP:00111050', QueryEBIOLSExtended.get_phenotype_description('HP:00111050')) - save_to_test_file('GO:0005573', QueryEBIOLSExtended.get_cellular_component_description('GO:0005573')) - save_to_test_file('GO:00055730', QueryEBIOLSExtended.get_cellular_component_description('GO:00055730')) - save_to_test_file('GO:0004689', QueryEBIOLSExtended.get_molecular_function_description('GO:0004689')) - save_to_test_file('GO:00046890', QueryEBIOLSExtended.get_molecular_function_description('GO:00046890')) - save_to_test_file('OMIM:613573', QueryEBIOLSExtended.get_disease_description('OMIM:613573')) - save_to_test_file('OMIM:6135730', QueryEBIOLSExtended.get_disease_description('OMIM:6135730')) diff --git a/code/reasoningtool/kg-construction/QueryGeneProf.py b/code/reasoningtool/kg-construction/QueryGeneProf.py deleted file mode 100644 index c26d31787..000000000 --- a/code/reasoningtool/kg-construction/QueryGeneProf.py +++ /dev/null @@ -1,95 +0,0 @@ -""" This module defines the class QueryGeneProf. -QueryGeneProf is written to connect with geneprof.org, querying the functional -genomics data including transcription factor, gene symbol. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = [] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -import requests -import requests_cache -import sys -import re -import os - -# configure requests package to use the "QueryCOHD.sqlite" cache -#requests_cache.install_cache('orangeboard') -# specifiy the path of orangeboard database -pathlist = os.path.realpath(__file__).split(os.path.sep) -RTXindex = pathlist.index("RTX") -dbpath = os.path.sep.join([*pathlist[:(RTXindex+1)],'data','orangeboard']) -requests_cache.install_cache(dbpath) - -class QueryGeneProf: - API_BASE_URL = 'http://www.geneprof.org/GeneProf/api' - TIMEOUT_SEC = 120 - - @staticmethod - def send_query_get(handler, url_suffix): - url_str = QueryGeneProf.API_BASE_URL + "/" + handler + "/" + url_suffix -# print(url_str) - try: - res = requests.get(url_str, timeout=QueryGeneProf.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print("Timeout in QueryGeneProf for URL: " + url_str, file=sys.stderr) - return None - except BaseException as e: - print(url_str, file=sys.stderr) - print('%s received in QueryGeneProf for URL: %s' % (e, url_str), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print("HTTP response status code: " + str(status_code) + " for URL:\n" + url_str, file=sys.stderr) - res = None - return res - - @staticmethod - def gene_symbol_to_geneprof_ids(gene_symbol): - handler = 'gene.info/gp.id' - url_suffix = 'human/C_NAME/' + gene_symbol + '.json' - res = QueryGeneProf.send_query_get(handler, url_suffix) - ret_set = {} - if res is not None: - res_json = res.json() - if res_json is not None and len(res_json) > 0: - ret_set = set(res_json['ids']) - return ret_set - - @staticmethod - def geneprof_id_to_transcription_factor_gene_symbols(geneprof_id): - handler = 'gene.info/regulation/binary/by.target' - url_suffix = 'human/' + str(geneprof_id) + '.json?with-sample-info=true' - res = QueryGeneProf.send_query_get(handler, url_suffix) - tf_genes = set() - if res is not None: - res_json = res.json() - if res_json is not None: - sample_info_dict_list = [expt['sample'] for expt in res_json['values'] if expt['is_target']] - for sample_info in sample_info_dict_list: - gene_symbol = sample_info.get("Gene", None) - if gene_symbol is not None: - tf_genes.add(gene_symbol) - return tf_genes - - @staticmethod - def gene_symbol_to_transcription_factor_gene_symbols(gene_symbol): - geneprof_ids_set = QueryGeneProf.gene_symbol_to_geneprof_ids(gene_symbol) - tf_gene_symbols = set() - for geneprof_id in geneprof_ids_set: - if geneprof_id is not None: - tf_gene_symbols |= QueryGeneProf.geneprof_id_to_transcription_factor_gene_symbols(geneprof_id) - return tf_gene_symbols - - -if __name__ == '__main__': - QueryGeneProf.gene_symbol_to_geneprof_ids('xyzzy') - print(QueryGeneProf.gene_symbol_to_transcription_factor_gene_symbols('HMOX1')) - print(QueryGeneProf.gene_symbol_to_geneprof_ids('HMOX1')) -# print(next(iter(hmox1_geneprof_id))) -# print(QueryGeneProf.gene_symbol_to_transcription_factor_gene_symbols(str(next(iter(hmox1_geneprof_id))))) diff --git a/code/reasoningtool/kg-construction/QueryHMDB.py b/code/reasoningtool/kg-construction/QueryHMDB.py deleted file mode 100644 index fc864bc01..000000000 --- a/code/reasoningtool/kg-construction/QueryHMDB.py +++ /dev/null @@ -1,81 +0,0 @@ -''' This module defines the class QueryHMDB. QueryHMDB class is designed -to communicate with HMDB APIs (xml format) and their corresponding data sources. The -available methods include: - -* get_compound_desc(hmdb_url) - -''' - - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -# import requests -# import requests_cache -from cache_control_helper import CacheControlHelper - -import sys -import xmltodict - - -class QueryHMDB: - TIMEOUT_SEC = 120 - - @staticmethod - def __access_api(url): - - requests = CacheControlHelper() - url = url + '.xml' - - try: - res = requests.get(url, timeout=QueryHMDB.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print('Timeout in QueryHMDB for URL: ' + url, file=sys.stderr) - return None - except KeyboardInterrupt: - sys.exit(0) - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QueryHMDB for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - return res.text - - @staticmethod - def get_compound_desc(hmdb_url): - """ - Query the description of metabolite from HMDB - Args: - hmdb_url (str): the metabolite url of HMDB website - Returns: - res_desc (str): the description of metabolite - """ - res_desc = "None" - if not isinstance(hmdb_url, str): - return res_desc - results = QueryHMDB.__access_api(hmdb_url) - if results is not None and results[:5] == " 0: - result_id = res[tab_pos+9:len(res)-1] - return result_id - - @staticmethod - def map_kegg_compound_to_hmdb_id(kegg_id): - """ map kegg compond id to HMDB ids - - Args: - kegg_id (str): The ID of the kegg compound, e.g., "KEGG:C00022" - - Returns: - id (str): the HMDB ID, or None if no id is retrieved - """ - if not isinstance(kegg_id, str): - return None - kegg_id = kegg_id[5:] - handler = QueryKEGG.HANDLER_MAP['map_kegg_compound_to_hmdb_id'].format(id=kegg_id) - res = QueryKEGG.__access_api(handler, QueryKEGG.GENOME_API_BASE_URL) - if res is not None and res != '': - tab_pos = res.find('\t') - res = res[tab_pos + 6:] - tab_pos = res.find('\t') - res = res[:tab_pos] - if len(res) == 9: - res = res[:4] + "00" + res[4:] - return res - else: - return None - -if __name__ == '__main__': - print(QueryKEGG.map_kegg_compound_to_enzyme_commission_ids('KEGG:C00190')) - print(QueryKEGG.map_kegg_compound_to_enzyme_commission_ids('KEGG:C00022')) - print(QueryKEGG.map_kegg_compound_to_enzyme_commission_ids('KEGG:C00100')) - print(QueryKEGG.map_kegg_compound_to_enzyme_commission_ids('KEGG:C00200')) - print(QueryKEGG.map_kegg_compound_to_enzyme_commission_ids('GO:2342343')) - print(QueryKEGG.map_kegg_compound_to_enzyme_commission_ids(1000)) - - print(QueryKEGG.map_kegg_compound_to_pub_chem_id('KEGG:C00190')) - print(QueryKEGG.map_kegg_compound_to_pub_chem_id('KEGG:C00022')) - print(QueryKEGG.map_kegg_compound_to_pub_chem_id('KEGG:C00100')) - print(QueryKEGG.map_kegg_compound_to_pub_chem_id('KEGG:C00200')) - print(QueryKEGG.map_kegg_compound_to_pub_chem_id('GO:2342343')) - print(QueryKEGG.map_kegg_compound_to_pub_chem_id(1000)) - print(QueryKEGG.map_kegg_compound_to_pub_chem_id('KEGG:C00022')) - - print("test map_kegg_compound_to_hmdb_id") - print(QueryKEGG.map_kegg_compound_to_hmdb_id('KEGG:C00022')) - print(QueryKEGG.map_kegg_compound_to_hmdb_id('KEGG:C19033')) - print(QueryKEGG.map_kegg_compound_to_hmdb_id('KEGG:C11686')) - print(QueryKEGG.map_kegg_compound_to_hmdb_id('GO:2342343')) - print(QueryKEGG.map_kegg_compound_to_hmdb_id('43')) - print(QueryKEGG.map_kegg_compound_to_hmdb_id('C11686')) - print(QueryKEGG.map_kegg_compound_to_hmdb_id(10000)) diff --git a/code/reasoningtool/kg-construction/QueryMiRBase.py b/code/reasoningtool/kg-construction/QueryMiRBase.py deleted file mode 100644 index 4348261dc..000000000 --- a/code/reasoningtool/kg-construction/QueryMiRBase.py +++ /dev/null @@ -1,81 +0,0 @@ -""" This module is the definition of class QueryMiRBase. It is designed to connect -to a microRNA databse named miRBase. It can query miRBase for gene symbol, miRNA -ids etc. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = [] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -# import requests -from cache_control_helper import CacheControlHelper - -import lxml.html -import functools -import CachedMethods - -import sys - -class QueryMiRBase: - API_BASE_URL = 'http://www.mirbase.org/cgi-bin' - - @staticmethod - def send_query_get(handler, url_suffix): - - requests = CacheControlHelper() - url_str = QueryMiRBase.API_BASE_URL + "/" + handler + "?" + url_suffix -# print(url_str) - - try: - res = requests.get(url_str) - except requests.exceptions.Timeout: - print(url_str, file=sys.stderr) - print('Timeout in QueryMiRBase for URL: ' + url_str, file=sys.stderr) - return None - except KeyboardInterrupt: - sys.exit(0) - except BaseException as e: - print(url_str, file=sys.stderr) - print('%s received in QueryMiRBase for URL: %s' % (e, url), file=sys.stderr) - return None - - status_code = res.status_code - assert status_code == 200 - return res - - @staticmethod - @CachedMethods.register - def convert_mirbase_id_to_mir_gene_symbol(mirbase_id): - assert mirbase_id != '' - res = QueryMiRBase.send_query_get('mirna_entry.pl', 'acc=' + mirbase_id) - ret_ids = set() - res_tree = lxml.html.fromstring(res.content) - res_list = res_tree.xpath("//a[contains(text(), 'HGNC:')]") - res_symbol = None - if len(res_list) > 0: - res_symbol = res_list[0].text.replace('HGNC:','') - return res_symbol - - @staticmethod - @CachedMethods.register - def convert_mirbase_id_to_mature_mir_ids(mirbase_id): - assert mirbase_id != '' - res = QueryMiRBase.send_query_get('mirna_entry.pl', 'acc=' + mirbase_id) - ret_ids = set() - res_tree = lxml.html.fromstring(res.content) - ## Try to find a suitable REST API somewhere, to replace this brittle HTML page scraping: - hrefs = [x.get('href').split('=')[1] for x in res_tree.xpath("/html//table/tr/td/a[contains(@href, 'MIMAT')]")] - - return(set(hrefs)) - -if __name__ == '__main__': - print(QueryMiRBase.convert_mirbase_id_to_mature_mir_ids('MI0014240')) - print(QueryMiRBase.convert_mirbase_id_to_mature_mir_ids('MI0000098')) - print(QueryMiRBase.convert_mirbase_id_to_mature_mir_ids('MIMAT0027666')) - print(QueryMiRBase.convert_mirbase_id_to_mir_gene_symbol('MIMAT0027666')) - # print(QueryMiRBase.convert_mirbase_id_to_mir_gene_symbol('MIMAT0027666X')) diff --git a/code/reasoningtool/kg-construction/QueryMiRGate.py b/code/reasoningtool/kg-construction/QueryMiRGate.py deleted file mode 100644 index 05a7c60da..000000000 --- a/code/reasoningtool/kg-construction/QueryMiRGate.py +++ /dev/null @@ -1,87 +0,0 @@ -""" This module defines the class QueryMiRGate. -QueryMiRGate is written to connect with mirgate.bioinfo.cnio.es/ResT/API/human, -querying the information concerning regulation of microRNA. -""" - -__author__ = 'Stephen Ramsey' -__copyright__ = 'Oregon State University' -__credits__ = ['Stephen Ramsey', 'Yao Yao', 'Zheng Liu'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - - -# import requests -from cache_control_helper import CacheControlHelper - -import lxml.etree -import sys - - -class QueryMiRGate: - API_BASE_URL = 'http://mirgate.bioinfo.cnio.es/ResT/API/human' - TIMEOUT_SEC = 120 - - @staticmethod - def send_query_get(handler, url_suffix): - - requests = CacheControlHelper() - url_str = QueryMiRGate.API_BASE_URL + "/" + handler + "/" + url_suffix -# print(url_str) - try: - res = requests.get(url_str, timeout=QueryMiRGate.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print(url_str, file=sys.stderr) - print("Timeout in QueryMiRGate for URL: " + url_str, file=sys.stderr) - return None - except BaseException as e: - print(url_str, file=sys.stderr) - print('%s received in QueryMiRGate for URL: %s' % (e, url_str), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(url_str, file=sys.stderr) - print("Status code " + str(status_code) + " for url: " + url_str, file=sys.stderr) - return None - if len(res.content) == 0: - print(url_str, file=sys.stderr) - print("Empty response from URL!", file=sys.stderr) - res = None - return res - - @staticmethod - def get_microrna_ids_that_regulate_gene_symbol(gene_symbol): - res = QueryMiRGate.send_query_get('gene_predictions', gene_symbol) - if res is None: - return set() - root = lxml.etree.fromstring(res.content) - res_elements = set(root.xpath('/miRGate/search/results/result[@mature_miRNA and ./agreement_value[text() > 2]]')) - res_ids = set([res_element.xpath('@mature_miRNA')[0] for res_element in res_elements]) -# res_ids = set(root.xpath('/miRGate/search/results/result/@mature_miRNA')) - res_ids.discard('') - return res_ids - - @staticmethod - def get_gene_symbols_regulated_by_microrna(microrna_id): - '''returns the gene symbols that a given microrna (MIMAT ID) regulates - - ''' - assert 'MIMAT' in microrna_id - res = QueryMiRGate.send_query_get('miRNA_predictions', microrna_id) - if res is None: - return set() - root = lxml.etree.fromstring(res.content) -# res_ids = set(root.xpath('/miRGate/search/results/result/@HGNC')) - res_elements = root.xpath('/miRGate/search/results/result[@HGNC and ./agreement_value[text() > 2]]') - res_ids = set([res_element.xpath('@HGNC')[0] for res_element in res_elements]) - res_ids.discard('') - return res_ids - -if __name__ == '__main__': - print(QueryMiRGate.get_gene_symbols_regulated_by_microrna('MIMAT0022742')) # for issue #30 - print(QueryMiRGate.get_microrna_ids_that_regulate_gene_symbol('HMOX1')) - print(QueryMiRGate.get_gene_symbols_regulated_by_microrna('MIMAT0016853')) # for issue #25 - print(QueryMiRGate.get_gene_symbols_regulated_by_microrna('MIMAT0018979')) - print(QueryMiRGate.get_gene_symbols_regulated_by_microrna('MIMAT0019885')) diff --git a/code/reasoningtool/kg-construction/QueryMyGeneExtended.py b/code/reasoningtool/kg-construction/QueryMyGeneExtended.py deleted file mode 100644 index 011ce8af3..000000000 --- a/code/reasoningtool/kg-construction/QueryMyGeneExtended.py +++ /dev/null @@ -1,144 +0,0 @@ -''' This module defines the class QueryProteinEntity. QueryProteinEntity class is designed -to query protein entity from mygene library. The -available methods include: - - get_protein_entity : query protein properties by ID - get_microRNA_entity : query micro properties by ID - -''' - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -import mygene -# import requests_cache -import json -import sys - -from cache_control_helper import CacheControlHelper - -class QueryMyGeneExtended: - - TIMEOUT_SEC = 120 - API_BASE_URL = 'http://mygene.info/v3' - HANDLER_MAP = { - 'query': 'query', - 'gene': 'gene' - } - - @staticmethod - def __access_api(handler, url_suffix, params=None, return_raw=False): - - requests = CacheControlHelper() - if url_suffix: - url = QueryMyGeneExtended.API_BASE_URL + '/' + handler + '?' + url_suffix - else: - url = QueryMyGeneExtended.API_BASE_URL + '/' + handler - headers = {'user-agent': "mygene.py/%s python-requests/%s" % ("1.0.0", "1.0.0"), 'Accept': 'application/json'} - try: - res = requests.get(url, params=params, timeout=QueryMyGeneExtended.TIMEOUT_SEC, headers=headers) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print('Timeout in QueryMyGeneExtended for URL: ' + url, file=sys.stderr) - return None - except KeyboardInterrupt: - sys.exit(0) - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QueryMyGeneExtended for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - if return_raw: - return res.text - else: - return res.json() - - @staticmethod - def get_protein_entity(protein_id): - # mg = mygene.MyGeneInfo() - # results = str(mg.query(protein_id.replace('UniProtKB', 'UniProt'), fields='all', return_raw='True', verbose=False)) - - handler = QueryMyGeneExtended.HANDLER_MAP['query'] - # url_suffix = "q=" + protein_id.replace('UniProtKB', 'UniProt') + "&fields=all" - params = {'q': protein_id.replace('UniProtKB', 'UniProt'), 'fields': 'all'} - results = str(QueryMyGeneExtended.__access_api(handler, None, params=params, return_raw=True)) - - result_str = 'None' - if len(results) > 100: - json_dict = json.loads(results) - result_str = json.dumps(json_dict) - return result_str - - @staticmethod - def get_microRNA_entity(microrna_id): - # mg = mygene.MyGeneInfo() - # results = str(mg.query(microrna_id.replace('NCBIGene', 'entrezgene'), fields='all', return_raw='True', verbose=False)) - - handler = QueryMyGeneExtended.HANDLER_MAP['query'] - # url_suffix = "q=" + microrna_id.replace('NCBIGene', 'entrezgene') + "&fields=all" - params = {'q': microrna_id.replace('NCBIGene', 'entrezgene'), 'fields': 'all'} - results = str(QueryMyGeneExtended.__access_api(handler, None, params=params, return_raw=True)) - - result_str = 'None' - if len(results) > 100: - json_dict = json.loads(results) - result_str = json.dumps(json_dict) - return result_str - - @staticmethod - def get_protein_desc(protein_id): - result_str = QueryMyGeneExtended.get_protein_entity(protein_id) - desc = "None" - if result_str != "None": - result_dict = json.loads(result_str) - if "hits" in result_dict.keys(): - if len(result_dict["hits"]) > 0: - if "summary" in result_dict["hits"][0].keys(): - desc = result_dict["hits"][0]["summary"] - return desc - - @staticmethod - def get_microRNA_desc(protein_id): - result_str = QueryMyGeneExtended.get_microRNA_entity(protein_id) - desc = "None" - if result_str != "None": - result_dict = json.loads(result_str) - if "hits" in result_dict.keys(): - if len(result_dict["hits"]) > 0: - if "summary" in result_dict["hits"][0].keys(): - desc = result_dict["hits"][0]["summary"] - return desc - -if __name__ == '__main__': - - def save_to_test_file(filename, key, value): - f = open(filename, 'r+') - try: - json_data = json.load(f) - except ValueError: - json_data = {} - f.seek(0) - f.truncate() - json_data[key] = value - json.dump(json_data, f) - f.close() - - save_to_test_file('tests/query_test_data.json', 'UniProtKB:O60884', QueryMyGeneExtended.get_protein_entity("UniProtKB:O60884")) - save_to_test_file('tests/query_test_data.json', 'NCBIGene:100847086', QueryMyGeneExtended.get_microRNA_entity("NCBIGene: 100847086")) - save_to_test_file('tests/query_desc_test_data.json', 'UniProtKB:O60884', QueryMyGeneExtended.get_protein_desc("UniProtKB:O60884")) - save_to_test_file('tests/query_desc_test_data.json', 'UniProtKB:O608840', QueryMyGeneExtended.get_protein_desc("UniProtKB:O608840")) - save_to_test_file('tests/query_desc_test_data.json', 'NCBIGene:100847086', QueryMyGeneExtended.get_microRNA_desc("NCBIGene:100847086")) - save_to_test_file('tests/query_desc_test_data.json', 'NCBIGene:1008470860', QueryMyGeneExtended.get_microRNA_desc("NCBIGene:1008470860")) - # print(QueryMyGeneExtended.get_protein_desc("UniProtKB:O60884")) - # print(QueryMyGeneExtended.get_microRNA_desc("NCBIGene:100847086")) - print(QueryMyGeneExtended.get_protein_desc("P05451")) diff --git a/code/reasoningtool/kg-construction/QueryOMIM.py b/code/reasoningtool/kg-construction/QueryOMIM.py deleted file mode 100644 index c8941d327..000000000 --- a/code/reasoningtool/kg-construction/QueryOMIM.py +++ /dev/null @@ -1,143 +0,0 @@ -""" This module defines the class QueryOMIM. -It is written to connect to http://api.omim.org/api, which converts omim id to -gene symbol and uniprot id. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = [] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -import sys -# import requests -# import CachedMethods -# import requests_cache -from cache_control_helper import CacheControlHelper -import simplecrypt - - -class QueryOMIM: - ENCRYPTED_BYTES = b'sc\x00\x02\xcb@\xces\xda\xd6\xe4\xb4\xba\xd7&=qF\xfe(TB\xb8ax\xdd\xf3\xe4I\xc1\x94ivg\xdbY\x86\xbc\xba\x08\xd6\xee\xc9U\xe1\xf4X*\x8c\x86B.7\xa0qN\xd3\x1c\xe9\xd1\x98\xe6 \xd0\x9f\xb6t\xf9E\n\xaf\xac\x00\xad\xa3\xd5;\xcc]`}\xc6-\xab\x00\x11\xce\x12x\xfc' - API_BASE_URL = 'https://api.omim.org/api' - TIMEOUT_SEC = 120 - - def __init__(self, encryption_key): - requests = CacheControlHelper() - api_key = simplecrypt.decrypt(encryption_key, QueryOMIM.ENCRYPTED_BYTES) - url = QueryOMIM.API_BASE_URL + "/apiKey" - session_data = {'apiKey': api_key, - 'format': 'json'} - r = requests.post(url, data=session_data) - assert 200 == r.status_code - self.cookie = r.cookies - - def send_query_get(self, omim_handler, url_suffix): - requests = CacheControlHelper() - url = "{api_base_url}/{omim_handler}?{url_suffix}&format=json".format(api_base_url=QueryOMIM.API_BASE_URL, - omim_handler=omim_handler, - url_suffix=url_suffix) -# print(url) - try: - res = requests.get(url, cookies=self.cookie) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print("Timeout in QueryOMIM for URL: " + url, file=sys.stderr) - return None - except KeyboardInterrupt: - sys.exit(0) - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QueryOMIM for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print("Status code " + str(status_code) + " for URL: " + url, file=sys.stderr) - return None - return res - - # @CachedMethods.register - def disease_mim_to_gene_symbols_and_uniprot_ids(self, mim_id): - """for a given MIM ID for a genetic disease (as input), returns a dict of of gene symbols and UniProt IDs - {gene_symbols: [gene_symbol_list], uniprot_ids: [uniprot_ids_list]} - - :param mim_id: a string OMIMD ID (of the form 'OMIM:605543') - :returns: a ``dict`` with two keys; ``gene_symbols`` and ``uniprot_ids``; the entry for each of the - keys is a ``set`` containing the indicated identifiers (or an empty ``set`` if no such identifiers are available) - """ - # assert type(mim_id) == str - if not isinstance(mim_id, str): - return {'gene_symbols': set(), 'uniprot_ids': set()} - mim_num_str = mim_id.replace('OMIM:','') - omim_handler = "entry" - url_suffix = "mimNumber=" + mim_num_str + "&include=geneMap,externalLinks&exclude=text" - r = self.send_query_get(omim_handler, url_suffix) - if r is None: - return {'gene_symbols': set(), - 'uniprot_ids': set()} - result_dict = r.json() -# print(result_dict) - result_entry = result_dict["omim"]["entryList"][0]["entry"] - external_links = result_entry.get('externalLinks', None) - uniprot_ids = [] - gene_symbols = [] - if external_links is not None: - uniprot_ids_str = external_links.get("swissProtIDs", None) - if uniprot_ids_str is not None: - uniprot_ids = uniprot_ids_str.split(",") - else: - phenotype_map_list = result_entry.get("phenotypeMapList", None) - if phenotype_map_list is not None: - gene_symbols = [phenotype_map_list[i]["phenotypeMap"]["geneSymbols"].split(", ")[0] for i in - range(0, len(phenotype_map_list))] - return {'gene_symbols': set(gene_symbols), - 'uniprot_ids': set(uniprot_ids)} - - def disease_mim_to_description(self, mim_id): - # assert type(mim_id) == str - if not isinstance(mim_id, str): - return "None" - mim_num_str = mim_id.replace('OMIM:', '') - omim_handler = "entry" - url_suffix = "mimNumber=" + mim_num_str + "&include=text:description" - r = self.send_query_get(omim_handler, url_suffix) - if r is None: - return "None" - result_dict = r.json() - # print(result_dict) - result_entry = result_dict["omim"]["entryList"][0]["entry"] - res_description = "None" - text_section_list = result_entry.get('textSectionList', None) - if text_section_list is not None and len(text_section_list) > 0: - res_description_dict = text_section_list[0].get("textSection", None) - if res_description_dict is not None: - text_section_content = res_description_dict.get("textSectionContent", None) - if text_section_content is not None: - res_description = text_section_content - return res_description - -if __name__ == '__main__': - - qo = QueryOMIM('1337') - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:145270')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:601351')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:248260')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:608670')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:184400')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:100200')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:111360')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:250300')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:142700')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:312500')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:166710')) - print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:129905')) - print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:603903')) - print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:613074')) - print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:603918')) # test issue 1 - print(qo.disease_mim_to_description('OMIM:100100')) - print(qo.disease_mim_to_description('OMIM:614747')) # no textSectionContent field - print(qo.disease_mim_to_description('OMIM:61447')) # wrong ID - print(qo.disease_mim_to_description(614747)) diff --git a/code/reasoningtool/kg-construction/QueryOMIMExtended.py b/code/reasoningtool/kg-construction/QueryOMIMExtended.py deleted file mode 100644 index 5a7e726a7..000000000 --- a/code/reasoningtool/kg-construction/QueryOMIMExtended.py +++ /dev/null @@ -1,151 +0,0 @@ -""" This module defines the class QueryOMIM. -It is written to connect to http://api.omim.org/api, which converts omim id to -gene symbol and uniprot id. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = [] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -import sys -# import requests -# import CachedMethods -# import requests_cache -import json -from cache_control_helper import CacheControlHelper - - -class QueryOMIMExtended: - API_KEY = '' - API_BASE_URL = 'https://api.omim.org/api' - TIMEOUT_SEC = 120 - - def __init__(self): - requests = CacheControlHelper() - url = QueryOMIMExtended.API_BASE_URL + "/apiKey" - session_data = {'apiKey': QueryOMIMExtended.API_KEY, - 'format': 'json'} - r = requests.post(url, data=session_data) - assert 200 == r.status_code - self.cookie = r.cookies - - def send_query_get(self, omim_handler, url_suffix): - requests = CacheControlHelper() - url = "{api_base_url}/{omim_handler}?{url_suffix}&format=json".format(api_base_url=QueryOMIMExtended.API_BASE_URL, - omim_handler=omim_handler, - url_suffix=url_suffix) - #print(url) - try: - res = requests.get(url, cookies=self.cookie) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print("Timeout in QueryOMIM for URL: " + url, file=sys.stderr) - return None - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QueryOMIM for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print("Status code " + str(status_code) + " for URL: " + url, file=sys.stderr) - return None - return res - - # @CachedMethods.register - def disease_mim_to_gene_symbols_and_uniprot_ids(self, mim_id): - """for a given MIM ID for a genetic disease (as input), returns a dict of of gene symbols and UniProt IDs - {gene_symbols: [gene_symbol_list], uniprot_ids: [uniprot_ids_list]} - - :param mim_id: a string OMIMD ID (of the form 'OMIM:605543') - :returns: a ``dict`` with two keys; ``gene_symbols`` and ``uniprot_ids``; the entry for each of the - keys is a ``set`` containing the indicated identifiers (or an empty ``set`` if no such identifiers are available) - """ - assert type(mim_id) == str - mim_num_str = mim_id.replace('OMIM:','') - omim_handler = "entry" - url_suffix = "mimNumber=" + mim_num_str + "&include=geneMap,externalLinks&exclude=text" - r = self.send_query_get(omim_handler, url_suffix) - if r is None: - return {'gene_symbols': set(), 'uniprot_ids': set()} - result_dict = r.json() -# print(result_dict) - result_entry = result_dict["omim"]["entryList"][0]["entry"] - external_links = result_entry.get('externalLinks', None) - uniprot_ids = [] - gene_symbols = [] - if external_links is not None: - uniprot_ids_str = external_links.get("swissProtIDs", None) - if uniprot_ids_str is not None: - uniprot_ids = uniprot_ids_str.split(",") - else: - phenotype_map_list = result_entry.get("phenotypeMapList", None) - if phenotype_map_list is not None: - gene_symbols = [phenotype_map_list[i]["phenotypeMap"]["geneSymbols"].split(", ")[0] for i in - range(0, len(phenotype_map_list))] - return {'gene_symbols': set(gene_symbols), - 'uniprot_ids': set(uniprot_ids)} - - def disease_mim_to_description(self, mim_id): - assert type(mim_id) == str - mim_num_str = mim_id.replace('OMIM:', '') - omim_handler = "entry" - url_suffix = "mimNumber=" + mim_num_str + "&include=text:description" - r = self.send_query_get(omim_handler, url_suffix) - if r is None: - return "None" - result_dict = r.json() - # print(result_dict) - result_entry = result_dict["omim"]["entryList"][0]["entry"] - res_description = "None" - text_section_list = result_entry.get('textSectionList', None) - if text_section_list is not None and len(text_section_list) > 0: - res_description_dict = text_section_list[0].get("textSection", None) - if res_description_dict is not None: - text_section_content = res_description_dict.get("textSectionContent", None) - if text_section_content is not None: - res_description = text_section_content - return res_description - - -if __name__ == '__main__': - - def save_to_test_file(filename, key, value): - f = open(filename, 'r+') - try: - json_data = json.load(f) - except ValueError: - json_data = {} - f.seek(0) - f.truncate() - json_data[key] = value - json.dump(json_data, f) - f.close() - - qo = QueryOMIMExtended() - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:145270')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:601351')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:248260')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:608670')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:184400')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:100200')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:111360')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:250300')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:142700')) - # print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:312500')) - print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:166710')) - print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:129905')) - print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:603903')) - print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:613074')) - print(qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:603918')) # test issue 1 - print(qo.disease_mim_to_description('OMIM:100100')) - print(qo.disease_mim_to_description('OMIM:614747')) # no textSectionContent field - print(qo.disease_mim_to_description('OMIM:61447')) # wrong ID - save_to_test_file('tests/query_desc_test_data.json', 'OMIM:100100', qo.disease_mim_to_description('OMIM:100100')) - save_to_test_file('tests/query_desc_test_data.json', 'OMIM:614747', qo.disease_mim_to_description('OMIM:614747')) - save_to_test_file('tests/query_desc_test_data.json', 'OMIM:61447', qo.disease_mim_to_description('OMIM:61447')) - diff --git a/code/reasoningtool/kg-construction/QueryPC2.py b/code/reasoningtool/kg-construction/QueryPC2.py deleted file mode 100644 index 86808917b..000000000 --- a/code/reasoningtool/kg-construction/QueryPC2.py +++ /dev/null @@ -1,78 +0,0 @@ -""" This module defines the class QueryPC2. It is designed to connect to -http://www.pathwaycommons.org/pc2, querying uniprot id and pathway id mutually. -""" - -__author__ = 'Stephen Ramsey' -__copyright__ = 'Oregon State University' -__credits__ = ['Stephen Ramsey', 'Zheng Liu', 'Yao Yao'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -# import requests -import sys -from cache_control_helper import CacheControlHelper - - -class QueryPC2: - TIMEOUT_SEC = 120 - API_BASE_URL = 'http://www.pathwaycommons.org/pc2' - - @staticmethod - def send_query_get(handler, url_suffix): - requests = CacheControlHelper() - url_str = QueryPC2.API_BASE_URL + "/" + handler + "?" + url_suffix -# print(url_str) - try: - res = requests.get(url_str, timeout=QueryPC2.TIMEOUT_SEC) - except requests.exceptions.Timeout: - # print(url, file=sys.stderr) - # print('Timeout in QueryPC2 for URL: ' + url, file=sys.stderr) - return None - except BaseException as e: - print(url_str, file=sys.stderr) - print('%s received in QueryPC2 for URL: %s' % (e, url_str), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - # print(url, file=sys.stderr) - # print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - return res - - @staticmethod - def pathway_id_to_uniprot_ids(pathway_reactome_id): - query_str = "uri=http://identifiers.org/reactome/" + pathway_reactome_id + "&format=TXT" - res = QueryPC2.send_query_get("get", query_str) - res_set = set() - if res is not None: - start_capturing = False - res_text = res.text - for line_str in res_text.splitlines(): - if start_capturing: - unification_xref_str = line_str.split("\t")[3] - unification_xref_namevals = unification_xref_str.split(";") - for unification_xref_nameval in unification_xref_namevals: - unification_xref_nameval_fields = unification_xref_nameval.split(":") - if unification_xref_nameval_fields[0] == "uniprot knowledgebase": - res_set.add(unification_xref_nameval_fields[1]) - if line_str.split("\t")[0] == "PARTICIPANT": - start_capturing = True - return res_set - - @staticmethod - def uniprot_id_to_reactome_pathways(uniprot_id): - res = QueryPC2.send_query_get("search.json", "q=" + uniprot_id + "&type=pathway") - res_dict = res.json() - if res is not None: - search_hits = res_dict["searchHit"] - pathway_list = [item.split("http://identifiers.org/reactome/")[1] for i in range(0, len(search_hits)) for item - in search_hits[i]["pathway"]] - return set(pathway_list) - - -if __name__ == '__main__': - print(QueryPC2.uniprot_id_to_reactome_pathways("P68871")) - print(QueryPC2.pathway_id_to_uniprot_ids("R-HSA-2168880")) diff --git a/code/reasoningtool/kg-construction/QueryPharos.py b/code/reasoningtool/kg-construction/QueryPharos.py deleted file mode 100644 index 90a80ac5d..000000000 --- a/code/reasoningtool/kg-construction/QueryPharos.py +++ /dev/null @@ -1,255 +0,0 @@ -""" This module defines the class QueryPharos which connects to APIs at -https://pharos.ncats.io/idg/api/v1, querying information correspondances among -drugs, dieases, targets. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = [] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -# import requests -from cache_control_helper import CacheControlHelper -import CachedMethods -import sys - - -class QueryPharos: - - API_BASE_URL = 'https://pharos.ncats.io/idg/api/v1' - - @staticmethod - def send_query_get(entity, url_suffix): - requests = CacheControlHelper() - url_str = QueryPharos.API_BASE_URL + "/" + entity + url_suffix - #print(url_str) - - try: - res = requests.get(url_str) - except requests.exceptions.Timeout: - print(url_str, file=sys.stderr) - print('Timeout in QueryMiRBase for URL: ' + url_str, file=sys.stderr) - return None - except KeyboardInterrupt: - sys.exit(0) - except BaseException as e: - print(url_str, file=sys.stderr) - print('%s received in QueryMiRBase for URL: %s' % (e, url), file=sys.stderr) - return None - - status_code = res.status_code - #print("Status code="+str(status_code)) - assert status_code in [200, 404] - if status_code == 404: - res = None - return res - - - @staticmethod - @CachedMethods.register - def query_drug_name_to_targets(drug_name): - ret_ids = [] - res = QueryPharos.send_query_get("targets","/search?q="+drug_name+"&facet=IDG%20Development%20Level%2FTclin") - if res is not None: - res_json = res.json() - #print(res_json) - if type(res_json)==dict: - res_content = res_json['content'] - #print(res_content) - for content_entry in res_content: - ret_ids.append( { 'id': content_entry['id'], 'name': content_entry['name'] } ) - return ret_ids - - - @staticmethod - @CachedMethods.register - def query_target_to_diseases(target_id): - ret_ids = [] - res = QueryPharos.send_query_get("targets","("+target_id+")/links(kind=ix.idg.models.Disease)") - if res is not None: - res_json = res.json() - #print(res_json) - if type(res_json) == list: - for res_entry in res_json: - id = res_entry['refid'] - name = None - if res_entry['properties'] is not None: - #print(res_entry['properties']) - for res_property in res_entry['properties']: - if res_property['label'] == 'IDG Disease': - name = res_property['term'] - ret_ids.append( { 'id': id, 'name': name } ) - return ret_ids - - - @staticmethod - @CachedMethods.register - def query_target_to_drugs(target_id): - ret_ids = [] - res = QueryPharos.send_query_get("targets","("+target_id+")/links(kind=ix.idg.models.Ligand)") - if res is not None: - res_json = res.json() - #print(res_json) - if type(res_json)==list: - for res_entry in res_json: - if res_entry['properties'] is not None: - #print(res_entry['properties']) - name = None - action = None - id = None - for res_property in res_entry['properties']: - if res_property['label'] == 'IDG Ligand': - name = res_property['term'] - id = res_property['id'] - if res_property['label'] == 'Pharmalogical Action': - action = res_property['term'] - if name is not None and action is not None: - ret_ids.append( { 'id': id, 'name': name, 'action': action } ) - return ret_ids - - - @staticmethod - @CachedMethods.register - def query_drug_to_targets(drug_id): - ret_ids = [] - res = QueryPharos.send_query_get("ligands","("+drug_id+")/links(kind=ix.idg.models.Target)") - if res is not None: - res_json = res.json() - #print(res_json) - if type(res_json)==list: - for res_entry in res_json: - if res_entry['properties'] is not None: - #print(res_entry['properties']) - name = None - id = None - for res_property in res_entry['properties']: - if res_property['label'] == 'IDG Target': - name = res_property['term'] - id = res_property['id'] - if name is not None and id is not None: - ret_ids.append( { 'id': id, 'name': name } ) - if type(res_json)==dict: - if res_json['properties'] is not None: - #print(res_json['properties']) - name = None - id = None - for res_property in res_json['properties']: - if res_property['label'] == 'IDG Target': - name = res_property['term'] - id = res_property['id'] - if name is not None and id is not None: - ret_ids.append( { 'id': id, 'name': name } ) - return ret_ids - - - @staticmethod - @CachedMethods.register - def query_target_name(target_id): - res = QueryPharos.send_query_get("targets","("+target_id+")") - if res is not None: - res_json = res.json() - #print(res_json) - if type(res_json)==dict: - ret_value = res_json['name'] - else: - ret_value = None - else: - ret_value = None - return ret_value - - - @staticmethod - @CachedMethods.register - def query_target_uniprot_accession(target_id): - res = QueryPharos.send_query_get("targets","("+target_id+")/synonyms") - if res is not None: - res_json = res.json() - #print(res_json) - if type(res_json)==list: - for res_entry in res_json: - if res_entry['label'] == 'UniProt Accession': - return res_entry['term'] # return the first one of many - return None - - - @staticmethod - @CachedMethods.register - def query_disease_name(disease_id): - res = QueryPharos.send_query_get("diseases","("+disease_id+")") - if res is not None: - res_json = res.json() - #print(res_json) - if type(res_json)==dict: - ret_value = res_json['name'] - else: - ret_value = None - else: - ret_value = None - return ret_value - - - @staticmethod - @CachedMethods.register - def query_drug_name(ligand_id): - res = QueryPharos.send_query_get("ligands","("+ligand_id+")") - if res is not None: - res_json = res.json() - #print(res_json) - if type(res_json)==dict: - ret_value = res_json['name'] - else: - ret_value = None - else: - ret_value = None - return ret_value - - - @staticmethod - @CachedMethods.register - def query_drug_id_by_name(drug_name): - res = QueryPharos.send_query_get("ligands","/search?q="+drug_name) - if res is not None: - res_json = res.json() - #print(res_json) - ret_value = None - if type(res_json)==dict: - res_content = res_json['content'] - for content_entry in res_content: - #print(content_entry) - if content_entry['name'] == drug_name: - ret_value = content_entry['id'] - else: - ret_value = None - else: - ret_value = None - return ret_value - - - @staticmethod - @CachedMethods.register - def query_disease_id_by_name(disease_name): - res = QueryPharos.send_query_get("diseases","/search?q="+disease_name) - if res is not None: - res_json = res.json() - #print(res_json) - ret_value = None - if type(res_json)==dict: - res_content = res_json['content'] - for content_entry in res_content: - #print(content_entry) - if content_entry['name'] == disease_name: - ret_value = content_entry['id'] - return ret_value - -if __name__ == '__main__': - print(QueryPharos.query_drug_id_by_name('paclitaxel')) - print(QueryPharos.query_drug_name_to_targets('paclitaxel')) - print(QueryPharos.query_drug_to_targets("254599")) - print(QueryPharos.query_drug_id_by_name('clothiapine')) - print(QueryPharos.query_drug_id_by_name("lovastatin")) - print(QueryPharos.query_drug_to_targets("254599")) - print(QueryPharos.query_drug_name_to_targets("lovastatin")) diff --git a/code/reasoningtool/kg-construction/QueryReactome.py b/code/reasoningtool/kg-construction/QueryReactome.py deleted file mode 100644 index 7a4e1d576..000000000 --- a/code/reasoningtool/kg-construction/QueryReactome.py +++ /dev/null @@ -1,323 +0,0 @@ -""" This module defines the class QueryReactome. QueryReactome is written to -connect with APIs at https://reactome.org/ContentService, querying the pathway -information. -""" - -__author__ = 'Stephen Ramsey' -__copyright__ = 'Oregon State University' -__credits__ = ['Stephen Ramsey', 'Yao Yao', 'Zheng Liu'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -# import requests -import sys -import re -# import requests_cache -import json -from cache_control_helper import CacheControlHelper - - -class QueryReactome: - - API_BASE_URL = 'https://reactome.org/ContentService' - - TIMEOUT_SEC = 120 - - HANDLER_MAP = { - 'get_pathway': 'data/pathway/{id}/containedEvents', - 'get_pathway_desc': 'data/query/{id}' - } - - SPECIES_MNEMONICS = ['BOVIN', - 'ACAVI', - 'VACCW', - 'PLAVS', - 'CHICK', - 'ECOLI', - 'HORSE', - 'MAIZE', - 'MOUSE', - 'PEA', - 'PIG', - 'RABIT', - 'RAT', - 'SHEEP', - 'SOYBN', - 'TOBAC', - 'WHEAT', - 'YEAST', - 'HV1N5', - 'HV1H2', - 'DANRE', - 'XENLA', - 'MYCTU', - 'HHV8P', - 'HTLV2', - 'HHV1', - 'HPV16', - '9HIV1', - 'EBVB9', - 'PROBE', - 'HTL1C', - 'I72A2', - 'SV40', - 'HV1B1', - 'SCHPO', - 'RUBV', - 'MUS'] - - @staticmethod - def send_query_get(handler, url_suffix): - requests = CacheControlHelper() - url_str = QueryReactome.API_BASE_URL + '/' + handler + '/' + url_suffix -# print(url_str) - try: - res = requests.get(url_str, timeout=QueryReactome.TIMEOUT_SEC) - except KeyboardInterrupt: - sys.exit(0) - except BaseException as e: - print('%s received in QueryReactome for URL: %s' % (e, url_str), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print('Status code ' + str(status_code) + ' for url: ' + url_str, file=sys.stderr) - return None - return res - - @staticmethod - def __query_uniprot_to_reactome_entity_id(uniprot_id): - res = QueryReactome.send_query_get('data/complexes/UniProt', uniprot_id) - if res is not None: - res_json = res.json() - # print(res_json) - if type(res_json) == list: - ret_ids = set([res_entry['stId'] for res_entry in res_json]) - else: - ret_ids = set() - else: - ret_ids = set() - return ret_ids - - @staticmethod - def __query_uniprot_to_reactome_entity_id_desc(uniprot_id): - res = QueryReactome.send_query_get('data/complexes/UniProt', uniprot_id) - ret_ids = dict() - if res is not None: - res_json = res.json() - if type(res_json) == list: - for res_entry in res_json: - entity_id = res_entry['stId'] - if 'R-HSA-' in entity_id: - ret_ids[entity_id] = res_entry['displayName'] - else: - print('Non-human reactome entity ID: ' + entity_id + ' from Uniprot ID: ' + uniprot_id) - return ret_ids - - @staticmethod - def __query_reactome_entity_id_to_reactome_pathway_ids_desc(reactome_entity_id): - res = QueryReactome.send_query_get('data/pathways/low/diagram/entity', reactome_entity_id + '/allForms?species=9606') - reactome_ids_dict = dict() - if res is not None: - res_json = res.json() - for res_entry in res_json: - res_id = res_entry['stId'] - if 'R-HSA-' in res_id: - reactome_ids_dict[res_id] = res_entry['displayName'] - else: - print('Non-human Reactome pathway: ' + res_id + ' from reactome entity ID: ' + reactome_entity_id, file=sys.stderr) - else: - reactome_ids_dict = dict() - return reactome_ids_dict - - ## called from BioNetExpander - @staticmethod - def query_uniprot_id_to_reactome_pathway_ids_desc(uniprot_id): - reactome_entity_ids = QueryReactome.__query_uniprot_to_reactome_entity_id(uniprot_id) - res_dict = dict() - for reactome_entity_id in reactome_entity_ids: - if 'R-HSA-' in reactome_entity_id: - pathway_ids_dict = QueryReactome.__query_reactome_entity_id_to_reactome_pathway_ids_desc(reactome_entity_id) - if len(pathway_ids_dict) > 0: - res_dict.update(pathway_ids_dict) - else: - print('Non-human Reactome entity: ' + reactome_entity_id + ' from Uniprot ID: ' + uniprot_id, file=sys.stderr) - return res_dict - - ## called from BioNetExpander - @staticmethod - def query_reactome_pathway_id_to_uniprot_ids_desc(reactome_pathway_id): - res = QueryReactome.send_query_get('data/participants', reactome_pathway_id) - ret_dict = dict() - if res is not None: - res_json = res.json() - # print(res_json) - participant_ids_list = [refEntity['displayName'] for peDbEntry in res_json for refEntity in peDbEntry['refEntities']] - for participant_id in participant_ids_list: - if 'UniProt:' in participant_id: - uniprot_id = participant_id.split(' ')[0].split(':')[1] - if ' ' in participant_id: - prot_desc = participant_id.split(' ')[1] - else: - prot_desc = 'UNKNOWN' - if '-' in uniprot_id: - uniprot_id = uniprot_id.split('-')[0] - ret_dict[uniprot_id] = prot_desc -# uniprot_ids_list = [[id.split(' ')[0].split(':')[1], id.split(' ')[1]] for id in participant_ids_list if 'UniProt:' in id] - return ret_dict - - @staticmethod - def is_valid_uniprot_accession(accession_str): - return re.match("[OPQ][0-9][A-Z0-9]{3}[0-9]|[A-NR-Z][0-9]([A-Z][A-Z0-9]{2}[0-9]){1,2}", accession_str) is not None - - # called from BioNetExpander - @staticmethod - def query_uniprot_id_to_interacting_uniprot_ids_desc(uniprot_id): - res = QueryReactome.send_query_get('interactors/static/molecule', uniprot_id + '/details') - res_uniprot_ids = dict() - if res is not None: - res_json = res.json() -# print(res_json) - if res_json is not None: - res_entities = res_json.get('entities', None) - if res_entities is not None: - for res_entity in res_entities: - res_entity_interactors = res_entity.get('interactors', None) - if res_entity_interactors is not None: - for res_entity_interactor in res_entity_interactors: - int_uniprot_id = res_entity_interactor.get('acc', None) - if int_uniprot_id is not None: - if 'CHEBI:' not in int_uniprot_id: - if '-' in int_uniprot_id: - int_uniprot_id = int_uniprot_id.split('-')[0] - int_alias = res_entity_interactor.get('alias', '') - alt_species = None - if ' ' in int_alias: - int_alias_split = int_alias.split(' ') - int_alias = int_alias_split[0] - alt_species = int_alias_split[1] - if alt_species is None or (alt_species not in QueryReactome.SPECIES_MNEMONICS and \ - not (alt_species[0] == '9')): - if alt_species is not None: - if 'DNA' in int_alias_split or \ - 'DNA-PROBE' in int_alias_split or \ - 'DSDNA' in int_alias_split or \ - 'GENE' in int_alias_split or \ - 'PROMOTE' in int_alias_split or \ - 'PROMOTER' in int_alias_split or \ - any(['-SITE' in alias_element for alias_element in int_alias_split]) or \ - any(['BIND' in alias_element for alias_element in int_alias_split]): - target_gene_symbol = int_alias_split[0] - int_alias = 'BINDSGENE:' + int_alias_split[0] - else: - print('For query protein ' + uniprot_id + ' and interactant protein ' + int_uniprot_id + ', check for potential other species name in Reactome output: ' + alt_species, file=sys.stderr) - int_alias = None - if int_alias is not None and int_alias != "" and QueryReactome.is_valid_uniprot_accession(int_uniprot_id): - res_uniprot_ids[int_uniprot_id] = int_alias - return res_uniprot_ids - - @staticmethod - def __access_api(handler): - - requests = CacheControlHelper() - url = QueryReactome.API_BASE_URL + '/' + handler - - try: - res = requests.get(url, timeout=QueryReactome.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print('Timeout in QueryReactome for URL: ' + url, file=sys.stderr) - return None - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QueryReactome for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - - return res.text - - @staticmethod - def __get_entity(entity_type, entity_id): - handler = QueryReactome.HANDLER_MAP[entity_type].format(id=entity_id) - results = QueryReactome.__access_api(handler) - result_str = 'None' - if results is not None: - # remove all \n characters using json api and convert the string to one line - json_dict = json.loads(results) - result_str = json.dumps(json_dict) - return result_str - - @staticmethod - def __get_desc(entity_type, entity_id): - handler = QueryReactome.HANDLER_MAP[entity_type].format(id=entity_id) - results = QueryReactome.__access_api(handler) - result_str = 'None' - if results is not None: - # remove all \n characters using json api and convert the string to one line - json_dict = json.loads(results) - if 'summation' in json_dict.keys(): - summation = json_dict['summation'] - if len(summation) > 0: - if 'text' in summation[0].keys(): - result_str = summation[0]['text'] - return result_str - - @staticmethod - # example of pathway_id: REACT:R-HSA-70326 - def get_pathway_entity(pathway_id): - if not isinstance(pathway_id, str): - return 'None' - if pathway_id[:6] == "REACT:": - pathway_id = pathway_id[6:] - return QueryReactome.__get_entity("get_pathway", pathway_id) - - @staticmethod - # example of pathway_id: Reactome:R-HSA-70326 - def get_pathway_desc(pathway_id): - if not isinstance(pathway_id, str): - return 'None' - if pathway_id[:6] == "REACT:": - pathway_id = pathway_id[6:] - return QueryReactome.__get_desc("get_pathway_desc", pathway_id) - - @staticmethod - def test(): - print(QueryReactome.query_uniprot_id_to_interacting_uniprot_ids_desc("P62991")) - print(QueryReactome.is_valid_uniprot_accession("Q16665")) - print(QueryReactome.is_valid_uniprot_accession("EBI")) - print(QueryReactome.query_uniprot_id_to_interacting_uniprot_ids_desc("Q16665")) - print(QueryReactome.query_uniprot_id_to_interacting_uniprot_ids_desc('P04150')) - print(QueryReactome.query_uniprot_id_to_interacting_uniprot_ids_desc('Q06609')) - print(QueryReactome.query_uniprot_id_to_interacting_uniprot_ids_desc('Q13501')) - print(QueryReactome.query_uniprot_id_to_interacting_uniprot_ids_desc('P68871')) - print(QueryReactome.query_uniprot_id_to_interacting_uniprot_ids_desc('O75521-2')) - print(QueryReactome.query_reactome_pathway_id_to_uniprot_ids_desc('R-HSA-5423646')) - print(QueryReactome.query_uniprot_id_to_interacting_uniprot_ids_desc("P68871")) - print(QueryReactome.__query_uniprot_to_reactome_entity_id('O75521-2')) - print(QueryReactome.__query_reactome_entity_id_to_reactome_pathway_ids_desc('R-HSA-2230989')) - print(QueryReactome.__query_uniprot_to_reactome_entity_id_desc('P68871')) - - -if __name__ == '__main__': - QueryReactome.test() - - def save_to_test_file(filename, key, value): - f = open(filename, 'r+') - try: - json_data = json.load(f) - except ValueError: - json_data = {} - f.seek(0) - f.truncate() - json_data[key] = value - json.dump(json_data, f) - f.close() - - save_to_test_file('tests/query_test_data.json', 'REACT:R-HSA-70326', QueryReactome.get_pathway_entity('REACT:R-HSA-70326')) - print(QueryReactome.get_pathway_desc('REACT:R-HSA-70326')) diff --git a/code/reasoningtool/kg-construction/QueryReactomeExtended.py b/code/reasoningtool/kg-construction/QueryReactomeExtended.py deleted file mode 100644 index 2435f1466..000000000 --- a/code/reasoningtool/kg-construction/QueryReactomeExtended.py +++ /dev/null @@ -1,113 +0,0 @@ -''' This module defines the class QueryReactomeExtended. QueryReactomeExtended class is designed -to communicate with Reactome APIs and their corresponding data sources. The available methods include: - * query pathway entity by ID -''' - - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -# import requests -# import requests_cache -import sys -import json -from cache_control_helper import CacheControlHelper - - -class QueryReactomeExtended: - TIMEOUT_SEC = 120 - API_BASE_URL = 'https://reactome.org/ContentService' - HANDLER_MAP = { - 'get_pathway': 'data/pathway/{id}/containedEvents', - 'get_pathway_desc': 'data/query/{id}' - } - - @staticmethod - def __access_api(handler): - - requests = CacheControlHelper() - url = QueryReactomeExtended.API_BASE_URL + '/' + handler - - try: - res = requests.get(url, timeout=QueryReactomeExtended.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print('Timeout in QueryReactome for URL: ' + url, file=sys.stderr) - return None - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QueryReactome for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - - return res.text - - @staticmethod - def __get_entity(entity_type, entity_id): - handler = QueryReactomeExtended.HANDLER_MAP[entity_type].format(id=entity_id) - results = QueryReactomeExtended.__access_api(handler) - result_str = 'None' - if results is not None: - # remove all \n characters using json api and convert the string to one line - json_dict = json.loads(results) - result_str = json.dumps(json_dict) - return result_str - - @staticmethod - def __get_desc(entity_type, entity_id): - handler = QueryReactomeExtended.HANDLER_MAP[entity_type].format(id=entity_id) - results = QueryReactomeExtended.__access_api(handler) - result_str = 'None' - if results is not None: - # remove all \n characters using json api and convert the string to one line - json_dict = json.loads(results) - if 'summation' in json_dict.keys(): - summation = json_dict['summation'] - if len(summation) > 0: - if 'text' in summation[0].keys(): - result_str = summation[0]['text'] - return result_str - - @staticmethod - # example of pathway_id: REACT:R-HSA-70326 - def get_pathway_entity(pathway_id): - if pathway_id[:6] == "REACT:": - pathway_id = pathway_id[6:] - return QueryReactomeExtended.__get_entity("get_pathway", pathway_id) - - @staticmethod - # example of pathway_id: Reactome:R-HSA-70326 - def get_pathway_desc(pathway_id): - if pathway_id[:6] == "REACT:": - pathway_id = pathway_id[6:] - return QueryReactomeExtended.__get_desc("get_pathway_desc", pathway_id) - - -if __name__ == '__main__': - - def save_to_test_file(filename, key, value): - f = open(filename, 'r+') - try: - json_data = json.load(f) - except ValueError: - json_data = {} - f.seek(0) - f.truncate() - json_data[key] = value - json.dump(json_data, f) - f.close() - - save_to_test_file('tests/query_test_data.json', 'REACT:R-HSA-70326', QueryReactomeExtended.get_pathway_entity('REACT:R-HSA-70326')) - save_to_test_file('tests/query_desc_test_data.json', 'REACT:R-HSA-70326', QueryReactomeExtended.get_pathway_desc('REACT:R-HSA-70326')) - save_to_test_file('tests/query_desc_test_data.json', 'REACT:R-HSA-703260', QueryReactomeExtended.get_pathway_desc('REACT:R-HSA-703260')) - print(QueryReactomeExtended.get_pathway_desc('REACT:R-HSA-703260')) diff --git a/code/reasoningtool/kg-construction/QuerySciGraph.py b/code/reasoningtool/kg-construction/QuerySciGraph.py deleted file mode 100644 index 546d5bb86..000000000 --- a/code/reasoningtool/kg-construction/QuerySciGraph.py +++ /dev/null @@ -1,235 +0,0 @@ -""" This module defines the class QuerySciGraph which connects to APIs at -https://scigraph-ontology.monarchinitiative.org/scigraph/graph/neighbors/, -querying "sub phenotypes" for phenotypes. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = [] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -# import requests -import sys -from cache_control_helper import CacheControlHelper - - -class QuerySciGraph: - TIMEOUT_SEC=120 - API_BASE_URL = { - 'node_properties': 'https://scigraph-ontology.monarchinitiative.org/scigraph/graph/{node_id}', - 'graph_neighbors': 'https://scigraph-ontology.monarchinitiative.org/scigraph/graph/neighbors/{node_id}', - 'cypher_query': 'https://scigraph-ontology.monarchinitiative.org/scigraph/cypher/execute.json' - } - - @staticmethod - def __access_api(url, params=None, headers=None): -# print(url) - requests = CacheControlHelper() - try: - res = requests.get(url, params=params, timeout=QuerySciGraph.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print('Timeout in QuerySciGraph for URL: ' + url, file=sys.stderr) - return None - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QuerySciGraph for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + res.url, file=sys.stderr) - return None - - return res.json() - - @staticmethod - def get_gene_ontology_curie_ids_for_uberon_curie_id(uberon_curie_id_str): - results = QuerySciGraph.__access_api(QuerySciGraph.API_BASE_URL['graph_neighbors'].format(node_id=uberon_curie_id_str)) -# print(results) - go_curie_id_str_dict = dict() - if results is not None: - res_edges = results.get("edges", None) - if res_edges is not None: - assert type(res_edges) == list - for res_edge in res_edges: - object_curie_id = res_edge.get("obj", None) - if object_curie_id is not None: - if object_curie_id.startswith("GO:"): - edge_object_meta = res_edge.get("meta", None) - if edge_object_meta is not None: - assert type(edge_object_meta) == dict - edge_label = edge_object_meta.get("lbl", None) - if edge_label is not None: - assert type(edge_label) == list - go_dict = QuerySciGraph.query_get_ontology_node_category_and_term(object_curie_id) - if len(go_dict) > 0: - go_curie_id_str_dict.update({object_curie_id: {"predicate": edge_label[0], - "ontology": go_dict["category"], - "name": go_dict["name"]}}) - return go_curie_id_str_dict - - @staticmethod - def get_gene_ontology_curie_ids_for_disease_curie_id(disease_curie_id_str): - results = QuerySciGraph.__access_api(QuerySciGraph.API_BASE_URL['graph_neighbors'].format(node_id=disease_curie_id_str)) -# print(results) - go_curie_id_str_dict = dict() - mondo_curie_id_str = None - is_mondo_bool = disease_curie_id_str.startswith("MONDO:") - if results is not None: - res_edges = results.get("edges", None) - if res_edges is not None: - assert type(res_edges) == list - for res_edge in res_edges: - object_curie_id = res_edge.get("obj", None) - if object_curie_id is not None: - if object_curie_id.startswith("GO:"): - edge_object_meta = res_edge.get("meta", None) - if edge_object_meta is not None: - assert type(edge_object_meta) == dict - edge_label = edge_object_meta.get("lbl", None) - if edge_label is not None: - assert type(edge_label) == list - go_dict = QuerySciGraph.query_get_ontology_node_category_and_term(object_curie_id) - if len(go_dict) > 0: - go_curie_id_str_dict.update({object_curie_id: {"predicate": edge_label[0], - "ontology": go_dict["category"], - "name": go_dict["name"]}}) - else: - if (not is_mondo_bool) and object_curie_id.startswith("MONDO:"): - edge_pred = res_edge.get("pred", None) - if edge_pred is not None and edge_pred == "equivalentClass": - mondo_curie_id_str = object_curie_id - if (not is_mondo_bool) and mondo_curie_id_str is not None: - go_curie_id_str_dict.update(QuerySciGraph.get_gene_ontology_curie_ids_for_disease_curie_id(mondo_curie_id_str)) - return go_curie_id_str_dict - - - '''returns the disease ontology IDs (DOID:NNNNN) for a given mesh ID in CURIE format, 'MESH:D012345' - - :param mesh_id: str containing the MeSH ID in CURIE format, i.e., MESH:D003550 - :return: set(str) - ''' - @staticmethod - def get_disont_ids_for_mesh_id(mesh_id): - results = QuerySciGraph.__access_api(QuerySciGraph.API_BASE_URL['graph_neighbors'].format(node_id=mesh_id)) - disont_ids = set() - if results is not None: - res_nodes = results.get('nodes', None) - if res_nodes is not None: - # assert type(res_nodes) == listq - for res_node in res_nodes: - id = res_node.get('id', None) - if id is not None: - if 'DOID:' in id: - disont_ids.add(id) - else: - meta = res_node.get('meta', None) - if meta is not None: - dbxrefs = meta.get('http://www.geneontology.org/formats/oboInOwl#hasDbXref', None) - if dbxrefs is not None: - assert type(dbxrefs)==list - for dbxref in dbxrefs: - if 'DOID:' in dbxref: - disont_ids.add(dbxref) - else: - cypher_query = 'MATCH (dis:disease) WHERE ANY(item IN dis.`http://www.geneontology.org/formats/oboInOwl#hasDbXref` WHERE item = \'' + mesh_id + '\') RETURN dis.`http://www.geneontology.org/formats/oboInOwl#hasDbXref` as xref' - - url = QuerySciGraph.API_BASE_URL['cypher_query'] - results = QuerySciGraph.__access_api(url, params={'cypherQuery': cypher_query, 'limit': '10'}) - if results is not None: - if len(results) > 0: - results_xref = results[0].get('xref', None) - if results_xref is not None: - disont_ids = set([x for x in results_xref if 'DOID:' in x]) - return disont_ids - - @staticmethod - def query_get_ontology_node_category_and_term(ontology_term_id_str): - results = QuerySciGraph.__access_api(QuerySciGraph.API_BASE_URL["node_properties"].format(node_id=ontology_term_id_str)) - res_dict = dict() -# print(results) - if results is not None: - results_nodes = results.get("nodes", None) - if results_nodes is not None: - assert type(results_nodes) == list - for results_node in results_nodes: - assert type(results_node) == dict - results_node_meta = results_node.get("meta", None) - if results_node_meta is not None: - assert type(results_node_meta) == dict - results_category = results_node_meta.get("category", None) - if results_category is not None: - assert type(results_category) == list - category_str = results_category[0] - label = results_node.get("lbl", None) - if label is not None: - assert type(label) == str - res_dict.update({"name": label, - "category": category_str}) - return(res_dict) - - @staticmethod - def query_sub_ontology_terms_for_ontology_term(ontology_term_id): - """ - Return a dict of ``, where `id`s are all sub-phenotype of parameter `ontology_term_id`. - - E.g. input "HP:0000107" (Renal cyst), - '>>> QuerySciGraph.query_sub_phenotypes_for_phenotype("HP:0000107") - {'HP:0100877': 'Renal diverticulum', 'HP:0000108': 'Renal corticomedullary cysts', - 'HP:0000803': 'Renal cortical cysts', 'HP:0000003': 'Multicystic kidney dysplasia', - 'HP:0008659': 'Multiple small medullary renal cysts', 'HP:0005562': 'Multiple renal cysts', - 'HP:0000800': 'Cystic renal dysplasia', 'HP:0012581': 'Solitary renal cyst'} - """ - - curie_prefix = ontology_term_id.split(":")[0] - - params = { - # "depth": 1, - # "blankNodes": "false", - - # Suppose `ontology_term_id` is X - # If direction is INCOMING, find all Y that (sub {id: Y})-[:subClassOf]->(obj {id: X}) - # If direction is OUTGOING, find all Y that (sub {id: X})-[:subClassOf]->(obj {id: Y}) - "direction": "INCOMING", # "OUTGOING" / "BOTH" - "relationshipType": "subClassOf" - } - - # param_str = "&".join(["{}={}".format(key, value) for key, value in params.items()]) - url = QuerySciGraph.API_BASE_URL["graph_neighbors"].format(node_id=ontology_term_id) - json = QuerySciGraph.__access_api(url, params=params) - sub_nodes_with_labels = dict() - if json is not None: - sub_edges = json['edges'] # Get all INCOMING edges - sub_nodes = set(map(lambda e: e["sub"], sub_edges)) # Get all neighboring nodes (duplicates may exist; so set is used here) - sub_nodes = set(filter(lambda s: s.startswith(curie_prefix + ":"), sub_nodes)) # Keep human phenotypes only - - sub_nodes_with_labels = dict([(node["id"], node['lbl']) for node in json['nodes'] if node["id"] in sub_nodes]) - - if len(sub_nodes_with_labels) >= 200: - print("[Warning][SciGraph] Found {} sub phenotypes for {}".format(len(sub_nodes_with_labels), ontology_term_id), file=sys.stderr) - - return sub_nodes_with_labels - - -if __name__ == '__main__': - print(QuerySciGraph.query_get_ontology_node_category_and_term("GO:0005777")) - print(QuerySciGraph.get_gene_ontology_curie_ids_for_uberon_curie_id("UBERON:0000171")) - print(QuerySciGraph.query_get_ontology_node_category_and_term("GO:XXXXXXX")) - print(QuerySciGraph.get_gene_ontology_curie_ids_for_disease_curie_id("MONDO:0019053")) - print(QuerySciGraph.get_gene_ontology_curie_ids_for_disease_curie_id("DOID:906")) - print(QuerySciGraph.query_sub_ontology_terms_for_ontology_term("GO:0005777")) - print(QuerySciGraph.get_disont_ids_for_mesh_id('MESH:D005199')) - print(QuerySciGraph.get_disont_ids_for_mesh_id('MESH:D006937')) - print(QuerySciGraph.get_disont_ids_for_mesh_id('MESH:D000856')) - print(QuerySciGraph.query_sub_ontology_terms_for_ontology_term('HP:12072')) - print(QuerySciGraph.query_sub_ontology_terms_for_ontology_term('GO:1904685')) - print(QuerySciGraph.get_disont_ids_for_mesh_id('MESH:D015473')) - print(QuerySciGraph.query_sub_ontology_terms_for_ontology_term("HP:0000107")) # Renal cyst - print(QuerySciGraph.get_disont_ids_for_mesh_id('MESH:D015470')) - print(QuerySciGraph.query_sub_ontology_terms_for_ontology_term('GO:0062026')) - diff --git a/code/reasoningtool/kg-construction/QueryUniprotExtended.py b/code/reasoningtool/kg-construction/QueryUniprotExtended.py deleted file mode 100644 index 1e3859abb..000000000 --- a/code/reasoningtool/kg-construction/QueryUniprotExtended.py +++ /dev/null @@ -1,124 +0,0 @@ - -''' This module defines the class QueryUniprotExtended. QueryUniprotExtended class is designed -to communicate with Uniprot APIs and their corresponding data sources. The -available methods include: - -* get_protein_name(protein_id) - - Description: - search for protein name - - Args: - protein_id (str): The ID of the protein entity, e.g., "UniProt:P01358" - - Returns: - name (str): the name of the protein entity, or 'None' if no protein object can be obtained. -''' - - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -# import requests -# import requests_cache -from cache_control_helper import CacheControlHelper -import sys -import xmltodict - - -class QueryUniprotExtended: - TIMEOUT_SEC = 120 - API_BASE_URL = 'http://www.uniprot.org/uniprot' - HANDLER_MAP = { - 'get_protein': '{id}.xml' - } - - @staticmethod - def __access_api(handler): - - requests = CacheControlHelper() - url = QueryUniprotExtended.API_BASE_URL + '/' + handler - # print(url) - try: - res = requests.get(url, timeout=QueryUniprotExtended.TIMEOUT_SEC) - except requests.exceptions.Timeout: - print(url, file=sys.stderr) - print('Timeout in QueryUniprot for URL: ' + url, file=sys.stderr) - return None - except BaseException as e: - print(url, file=sys.stderr) - print('%s received in QueryUniprot for URL: %s' % (e, url), file=sys.stderr) - return None - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - - return res.text - - @staticmethod - def __get_entity(entity_type, entity_id): - if entity_id[:10] == 'UniProtKB:': - entity_id = entity_id[10:] - handler = QueryUniprotExtended.HANDLER_MAP[entity_type].format(id=entity_id) - results = QueryUniprotExtended.__access_api(handler) - entity = None - if results is not None: - obj = xmltodict.parse(results) - if 'uniprot' in obj.keys(): - if 'entry' in obj['uniprot'].keys(): - entity = obj['uniprot']['entry'] - return entity - - @staticmethod - def get_protein_gene_symbol(entity_id): - ret_symbol = "" - entity_obj = QueryUniprotExtended.__get_entity("get_protein", entity_id) - if entity_obj is not None: - if 'gene' in entity_obj.keys(): - if "name" in entity_obj["gene"].keys(): - gene_name_obj = entity_obj["gene"]["name"] - if not type(gene_name_obj) == list: - gene_name_obj = [ gene_name_obj ] - for name_dict in gene_name_obj: - # print(name_dict) - if "primary" in name_dict.values() and "#text" in name_dict.keys(): - ret_symbol = name_dict["#text"] - return ret_symbol - - @staticmethod - def __get_name(entity_type, entity_id): - entity_obj = QueryUniprotExtended.__get_entity(entity_type, entity_id) - name = "UNKNOWN" - if entity_obj is not None: - if 'protein' in entity_obj.keys(): - if 'recommendedName' in entity_obj['protein'].keys(): - if 'fullName' in entity_obj['protein']['recommendedName'].keys(): - name = entity_obj['protein']['recommendedName']['fullName'] - if isinstance(name, dict): - name = name['#text'] - return name - - @staticmethod - def get_protein_name(protein_id): - return QueryUniprotExtended.__get_name("get_protein", protein_id) - -if __name__ == '__main__': - print(QueryUniprotExtended.get_protein_gene_symbol('UniProtKB:P20848')) - print(QueryUniprotExtended.get_protein_gene_symbol("UniProtKB:P01358")) - print(QueryUniprotExtended.get_protein_gene_symbol("UniProtKB:Q96P88")) - print(QueryUniprotExtended.get_protein_name('UniProtKB:P01358')) - print(QueryUniprotExtended.get_protein_name('UniProtKB:P20848')) - print(QueryUniprotExtended.get_protein_name('UniProtKB:Q9Y471')) - print(QueryUniprotExtended.get_protein_name('UniProtKB:O60397')) - print(QueryUniprotExtended.get_protein_name('UniProtKB:Q8IZJ3')) - print(QueryUniprotExtended.get_protein_name('UniProtKB:Q7Z2Y8')) - print(QueryUniprotExtended.get_protein_name('UniProtKB:Q8IWN7')) - print(QueryUniprotExtended.get_protein_name('UniProtKB:Q156A1')) diff --git a/code/reasoningtool/kg-construction/README.md b/code/reasoningtool/kg-construction/README.md deleted file mode 100644 index df193b9dc..000000000 --- a/code/reasoningtool/kg-construction/README.md +++ /dev/null @@ -1,56 +0,0 @@ -# Instructions on how to build a new KG from scratch - -## Base requirements for using the RTX proof-of-concept reasoning tool software - -- Python 3.5 or newer. Specific packages that are required are listed for each - command-line script in the RTX POC software, in subsections below. For each - package requirement, a version number is indicated; that is the version number - of the package that we have tested with the RTX POC software. -- Neo4j Community Edition, version 3.3.0 (installed locally is recommended for - best performance). - -[NOTE: script-specific requirements are enumerated below] - -## Requirements for running `BuildMasterKG.py` - -### Python packages required -- `neo4j-driver` (version 1.5.0) -- `requests` (version 2.18.4) -- `requests-cache` (version 0.4.13) -- `pandas` (version 0.21.0) -- `mygene` (version 3.0.0) -- `lxml` (version 4.1.1) -- `CacheControl` (version 0.12.5) - -# Building a new KG - -## Using `BuildMasterKG.py` - -`BuildMasterKG.py` is the script that we use to build a knowledge graph seeded -with the 21 Q1 diseases, a set of 8,000 genetic conditions from OMIM, and the -1,000 pairs of drugs and conditions for Q2. Each of these entities is expanded -three steps in the knowledge graph, to make a Neo4j database with approximately -1.5M relationships and 46,000 nodes. To run `BuildMasterKG.py`, first, make -sure Neo4j is running and available on `bolt://localhost:7687`. Then run: - - python3 BuildMasterKG.py -u xxxx -p xxxx 1>stdout.log 2>stderr.log - -or equivalently: - - sh run_build_master_kg.sh - -## Using `UpdateNodesName.py` -`UpdateNodesName.py` is the script that retrieves names from Uniprot and update protein nodes - - python3 UpdateNodesName.py - -## Using `UpdateIndex.py` -`UpdateIndex.py` is the script that set all needed index - - python3 UpdateIndex.py -u xxxx -p xxxx - - -# Backing up KG -`neo4j-backup` is the script to dump the Neo4j database and transfer the backup file to http://rtxkgdump.saramsey.org/ - - sh neo4j-backup.sh diff --git a/code/reasoningtool/kg-construction/UpdateIndex.py b/code/reasoningtool/kg-construction/UpdateIndex.py deleted file mode 100644 index 6743efe9e..000000000 --- a/code/reasoningtool/kg-construction/UpdateIndex.py +++ /dev/null @@ -1,150 +0,0 @@ -import uuid -import itertools -import pprint -import neo4j.v1 -import sys -import timeit -import argparse -import os - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../") # code directory -from RTXConfiguration import RTXConfiguration - -parser = argparse.ArgumentParser() -# parser.add_argument("-u", "--user", type=str, help="The username used to connect to the neo4j instance", default='') -# parser.add_argument("-p", "--password", type=str, help="The password used to connect to the neo4j instance", default='') -# parser.add_argument("-a", "--url", type=str, help="The bolt url and port used to connect to the neo4j instance. (default:bolt://localhost:7687)", default="bolt://localhost:7687") -parser.add_argument('--live', help="The container name, which can be one of the following: Production, KG2, rtxdev, " - "staging. (default: Production)", default='Production') -args = parser.parse_args() - -class UpdateIndex(): - """ - This class connects to a neo4j instance with our KG in it - then can set/drop all needed indexes - - :param url: a string containing the bolt url of the neo4j instance, ``bolt://your.neo4j.url:7687`` - :param user: a string containing the username used to access the neo4j instance - :param password: a string containing the password used to access the neo4j instance - :param debug: a boolian indicating weither or not to use debug mode (will print out queries sent) - """ - - def __init__(self, user, password, url ='bolt://localhost:7687', debug = False): - self.debug = debug - self.neo4j_url = url - self.neo4j_user = user - self.neo4j_password = password - - self.driver = neo4j.v1.GraphDatabase.driver(self.neo4j_url, - auth=(self.neo4j_user, - self.neo4j_password)) - - def neo4j_shutdown(self): - """ - shuts down the Orangeboard by disconnecting from the Neo4j database - :returns: nothing - """ - self.driver.close() - - def neo4j_run_cypher_query(self, query, parameters=None): - """ - runs a single cypher query in the neo4j database (without a transaction) and returns the result object - :param query: a ``str`` object containing a single cypher query (without a semicolon) - :param parameters: a ``dict`` object containing parameters for this query - :returns: a `neo4j.v1.SessionResult` object resulting from executing the neo4j query - """ - if self.debug: - print(query) - assert ';' not in query - - # Lazily initialize the driver - if self.driver is None: - self.neo4j_connect() - - session = self.driver.session() - res = session.run(query, parameters) - session.close() - return res - - - def set_index(self): - """ - adds a hardcoded list on idexes and contraints to a neo4j instance - :return: nothing - """ - - # This gets a list of all labels on the KG then removes the Base label - res = self.neo4j_run_cypher_query('match (n) with distinct labels(n) as label_sets unwind(label_sets) as labels return distinct labels') - label_list = res.value() - label_list.remove('Base') - - - # These are the indexes and constraints on the base label - index_commands = [ - 'CREATE CONSTRAINT ON (n:Base) ASSERT n.id IS UNIQUE', - 'CREATE CONSTRAINT ON (n:Base) ASSERT n.UUID IS UNIQUE', - 'CREATE CONSTRAINT ON (n:Base) ASSERT n.uri IS UNIQUE', - 'CREATE INDEX ON :Base(name)', - 'CREATE INDEX ON :Base(seed_node_uuid)' - ] - - # These create label specific indexes and constraints - index_commands += ['CREATE CONSTRAINT ON (n:' + label + ') ASSERT n.id IS UNIQUE' for label in label_list] - index_commands += ['CREATE INDEX ON :' + label + '(name)' for label in label_list] - - for command in index_commands: - self.neo4j_run_cypher_query(command) - - - - def drop_index(self): - """ - requests lists of all contraints and idexes on the neo4j server then drops all of them. - :return: nothing - """ - - - res = self.neo4j_run_cypher_query('CALL db.constraints()') - constraints = res.value() - - index_commands = ['DROP ' + constraint for constraint in constraints] - - for command in index_commands: - self.neo4j_run_cypher_query(command) - - res = self.neo4j_run_cypher_query('CALL db.indexes()') - indexes = res.value() - - index_commands = ['DROP ' + index for index in indexes] - - for command in index_commands: - self.neo4j_run_cypher_query(command) - - def replace(self): - self.drop_index() - self.set_index() - - def set_test(self): - """ - Sets the idexes up to test for an error - """ - self.drop_index() - index_commands = [ - 'CREATE INDEX ON :Base(UUID)', - 'CREATE INDEX ON :Base(seed_node_uuid)', - 'CREATE CONSTRAINT ON (n:biological_process) ASSERT n.id IS UNIQUE', - 'CREATE CONSTRAINT ON (n:microRNA) ASSERT n.id IS UNIQUE', - 'CREATE CONSTRAINT ON (n:protein) ASSERT n.id IS UNIQUE' - ] - - for command in index_commands: - self.neo4j_run_cypher_query(command) - - -if __name__ == '__main__': - # create the RTXConfiguration object - rtxConfig = RTXConfiguration() - - ui = UpdateIndex(rtxConfig.neo4j_username, rtxConfig.neo4j_password, rtxConfig.neo4j_bolt) - ui.replace() - diff --git a/code/reasoningtool/kg-construction/UpdateNodesInfo.py b/code/reasoningtool/kg-construction/UpdateNodesInfo.py deleted file mode 100644 index 2f504c515..000000000 --- a/code/reasoningtool/kg-construction/UpdateNodesInfo.py +++ /dev/null @@ -1,541 +0,0 @@ -""" -This module defines the class UpdateNodesInfo. UpdateNodesInfo class is designed -to retrieve the node properties and update the properties on the Graphic model object. -The available methods include: - - update_anatomy_nodes : retrieve data from BioLink and update all anatomy nodes - update_phenotype_nodes : retrieve data from BioLink and update all phenotype nodes - update_microRNA_nodes : retrieve data from MyGene and update all microRNA nodes - update_pathway_nodes : retrieve data from Reactome and update all pathway nodes - update_protein_nodes : retrieve data from MyGene and update all protein nodes - update_disease_nodes : retrieve data from BioLink and update all disease nodes - - update_anatomy_nodes_desc : update the descriptions of anatomical_entity nodes - update_phenotype_nodes_desc : update the descriptions of phenotypic_feature nodes - update_disease_nodes_desc : update the descriptions of disease nodes - update_bio_process_nodes_desc : update the descriptions of biological_process nodes - update_microRNA_nodes_desc : update the descriptions of microRNA nodes - update_protein_nodes_desc : update the descriptions of protein nodes - update_chemical_substance_desc : update the descriptions of chemical_substance nodes - update_pathway_nodes_desc : update the descriptions of pathway nodes - update_cellular_component_nodes_desc : update the descriptions of cellular_component nodes - update_molecular_function_nodes_desc : update the descriptions of molecular_function nodes - update_metabolite_nodes_desc : update the descriptions of metabolite nodes - -Example of method name used from other packages. - example of get_nodes_mtd_name : get_anatomy_nodes - example of get_entity_mtd_name : get_anatomy_entity - example of update_nodes_mtd_name : update_anatomy_nodes - -How to run this module: -If you want to update the descriptions of all types of nodes, please use the default value of runfunc argument: - $ cd [git repo]/code/reasoningtool/kg-construction - $ python3 UpdateNodesInfo.py -u xxx -p xxx 1>stdout_desc.log 2>stderr_desc.log - -If you want to update the descriptions of the specified nodes, please use the runfunc argument to specify the method: - $ cd [git repo]/code/reasoningtool/kg-construction - $ python3 UpdateNodesInfo.py -u xxx -p xxx --runfunc=update_disease_nodes_desc 1>stdout_desc.log 2>stderr_desc.log -""" - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -import argparse -import sys -import os - -from Neo4jConnection import Neo4jConnection -from QueryEBIOLS import QueryEBIOLS -from QueryOMIM import QueryOMIM -from QueryMyGene import QueryMyGene -from QueryMyChem import QueryMyChem -from QueryReactome import QueryReactome -from QueryKEGG import QueryKEGG -from QueryHMDB import QueryHMDB - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../") # code directory -from RTXConfiguration import RTXConfiguration - -class UpdateNodesInfo: - - GET_QUERY_CLASS = { - 'anatomy': 'QueryBioLink', - 'phenotype': 'QueryBioLink', - 'microRNA': 'QueryMyGene', - 'pathway': 'QueryReactome', - 'protein': 'QueryMyGene', - 'disease': 'QueryBioLink', - 'chemical_substance': 'QueryMyChem', - 'bio_process': 'QueryBioLink' - } - - def __init__(self, user, password, url ='bolt://localhost:7687'): - self.neo4j_user = user - self.neo4j_password = password - self.neo4j_url = url - - def __update_nodes(self, node_type): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - get_nodes_mtd_name = "get_" + node_type + "_nodes" - get_nodes_mtd = getattr(conn, get_nodes_mtd_name) - nodes = get_nodes_mtd() - print(len(nodes)) - - from time import time - t = time() - - nodes_array = [] - query_class_name = UpdateNodesInfo.GET_QUERY_CLASS[node_type] - query_class = getattr(__import__(query_class_name), query_class_name) - get_entity_mtd_name = "get_" + node_type + "_entity" - get_entity_mtd = getattr(query_class, get_entity_mtd_name) - query_instance = query_class() - for i, node_id in enumerate(nodes): - node = dict() - node['node_id'] = node_id - if node_type == "protein" or node_type == "microRNA": - get_entity_mtd = getattr(query_instance, get_entity_mtd_name) - node['extended_info_json'] = get_entity_mtd(node_id) - nodes_array.append(node) - print(node_type + " node No. %d : %s" % (i, node_id)) - - print("api pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - update_nodes_mtd_name = "update_" + node_type + "_nodes" - update_nodes_mtd = getattr(conn, update_nodes_mtd_name) - update_nodes_mtd(nodes_array[start:end]) - - print("total time: %f" % (time() - t)) - - conn.close() - - def update_anatomy_nodes(self): - self.__update_nodes('anatomy') - - def update_phenotype_nodes(self): - self.__update_nodes('phenotype') - - def update_microRNA_nodes(self): - self.__update_nodes('microRNA') - - def update_pathway_nodes(self): - self.__update_nodes('pathway') - - def update_protein_nodes(self): - self.__update_nodes('protein') - - def update_disease_nodes(self): - self.__update_nodes('disease') - - def update_chemical_substance_nodes(self): - self.__update_nodes('chemical_substance') - - def update_bio_process_nodes(self): - self.__update_nodes('bio_process') - - def update_anatomy_nodes_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_anatomy_nodes() - print("the number of anatomy nodes: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - for i, node_id in enumerate(nodes): - node = dict() - node['node_id'] = node_id - node['desc'] = QueryEBIOLS.get_anatomy_description(node_id) - nodes_array.append(node) - - print("anatomy api pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_anatomy_nodes_desc(nodes_array[start:end]) - - print("anatomy total time: %f" % (time() - t)) - - conn.close() - - def update_phenotype_nodes_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_phenotype_nodes() - print("the number of phenotype nodes: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - for i, node_id in enumerate(nodes): - node = dict() - node['node_id'] = node_id - node['desc'] = QueryEBIOLS.get_phenotype_description(node_id) - nodes_array.append(node) - - print("phenotype api pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_phenotype_nodes_desc(nodes_array[start:end]) - - print("phenotype total time: %f" % (time() - t)) - - conn.close() - - def update_microRNA_nodes_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_microRNA_nodes() - print("the number of microRNA nodes: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - mg = QueryMyGene() - for i, node_id in enumerate(nodes): - node = dict() - node['node_id'] = node_id - node['desc'] = mg.get_microRNA_desc(node_id) - nodes_array.append(node) - - print("microRNA api pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_microRNA_nodes_desc(nodes_array[start:end]) - - print("microRNA total time: %f" % (time() - t)) - - conn.close() - - def update_pathway_nodes_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_pathway_nodes() - print("the number of pathway: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - for i, node_id in enumerate(nodes): - node = dict() - node['node_id'] = node_id - node['desc'] = QueryReactome.get_pathway_desc(node_id) - nodes_array.append(node) - - print("pathway api pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_pathway_nodes_desc(nodes_array[start:end]) - - print("pathway total time: %f" % (time() - t)) - - conn.close() - - def update_protein_nodes_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_protein_nodes() - print("the number of protein nodes: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - mg = QueryMyGene() - for i, node_id in enumerate(nodes): - node = dict() - node['node_id'] = node_id - node['desc'] = mg.get_protein_desc(node_id) - nodes_array.append(node) - - print("protein api pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_protein_nodes_desc(nodes_array[start:end]) - - print("protein total time: %f" % (time() - t)) - - conn.close() - - def update_disease_nodes_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_disease_nodes() - print("the number of disease nodes: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - qo = QueryOMIM() - for i, node_id in enumerate(nodes): - node = dict() - node['node_id'] = node_id - if node_id[:4] == "OMIM": - node['desc'] = qo.disease_mim_to_description(node_id) - elif node_id[:4] == "DOID": - node['desc'] = QueryEBIOLS.get_disease_description(node_id) - nodes_array.append(node) - - print("disease api pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_disease_nodes_desc(nodes_array[start:end]) - - print("disease total time: %f" % (time() - t)) - - conn.close() - - def update_chemical_substance_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_chemical_substance_nodes() - print("the number of chemical_substance nodes: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - for i, node_id in enumerate(nodes): - node = dict() - node['node_id'] = node_id - node['desc'] = QueryMyChem.get_chemical_substance_description(node_id) - nodes_array.append(node) - - print("chemical_substance pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_chemical_substance_nodes_desc(nodes_array[start:end]) - - print("chemical substance total time: %f" % (time() - t)) - - conn.close() - - def update_bio_process_nodes_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_bio_process_nodes() - print("the number of bio_process nodes: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - for i, node_id in enumerate(nodes): - node = dict() - node['node_id'] = node_id - node['desc'] = QueryEBIOLS.get_bio_process_description(node_id) - nodes_array.append(node) - - print("bio_process pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_bio_process_nodes_desc(nodes_array[start:end]) - - print("bio_process total time: %f" % (time() - t)) - - conn.close() - - def update_cellular_component_nodes_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_cellular_component_nodes() - print("the number of cellular_component nodes: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - for i, node_id in enumerate(nodes): - # print("no %d" % i) - node = dict() - node['node_id'] = node_id - node['desc'] = QueryEBIOLS.get_cellular_component_description(node_id) - nodes_array.append(node) - - print("cellular_component pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_cellular_component_nodes_desc(nodes_array[start:end]) - - print("cellular_component total time: %f" % (time() - t)) - - conn.close() - - def update_molecular_function_nodes_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_molecular_function_nodes() - print("the number of molecular_function nodes: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - for i, node_id in enumerate(nodes): - # print("no %d" % i) - node = dict() - node['node_id'] = node_id - node['desc'] = QueryEBIOLS.get_molecular_function_description(node_id) - nodes_array.append(node) - - print("molecular_function pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_molecular_function_nodes_desc(nodes_array[start:end]) - - print("molecular_function total time: %f" % (time() - t)) - - conn.close() - - def update_metabolite_nodes_desc(self): - conn = Neo4jConnection(self.neo4j_url, self.neo4j_user, self.neo4j_password) - nodes = conn.get_metabolite_nodes() - print("the number of metabolite nodes: %d" % len(nodes)) - - from time import time - t = time() - - success_count = 0 - nodes_array = [] - for i, node_id in enumerate(nodes): - # if i % 100 == 0: - # print("no %d" % i) - node = dict() - node['node_id'] = node_id - hmdb_id = QueryKEGG.map_kegg_compound_to_hmdb_id(node_id) - if hmdb_id: - hmdb_url = 'http://www.hmdb.ca/metabolites/' + hmdb_id - node['desc'] = QueryHMDB.get_compound_desc(hmdb_url) - if node['desc'] != "None": - success_count += 1 - else: - node['desc'] = 'None' - nodes_array.append(node) - print("success_count = " + str(success_count)) - print("metabolite pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_metabolite_nodes_desc(nodes_array[start:end]) - - print("metabolite total time: %f" % (time() - t)) - - conn.close() - - def update_all(self): - # UpdateNodesInfo.update_anatomy_nodes() - # UpdateNodesInfo.update_phenotype_nodes() - # UpdateNodesInfo.update_microRNA_nodes() - # UpdateNodesInfo.update_pathway_nodes() - # UpdateNodesInfo.update_protein_nodes() - # UpdateNodesInfo.update_disease_nodes() - # UpdateNodesInfo.update_chemical_substance_nodes() - # UpdateNodesInfo.update_bio_process_nodes() - self.update_anatomy_nodes_desc() - self.update_phenotype_nodes_desc() - self.update_disease_nodes_desc() - self.update_bio_process_nodes_desc() - self.update_microRNA_nodes_desc() - self.update_protein_nodes_desc() - self.update_chemical_substance_desc() - self.update_pathway_nodes_desc() - self.update_cellular_component_nodes_desc() - self.update_molecular_function_nodes_desc() - self.update_metabolite_nodes_desc() - - -if __name__ == '__main__': - - parser = argparse.ArgumentParser(description='update the descriptions of nodes in th knowledge graph') - # parser.add_argument("-a", "--address", help="The bolt url and port used to connect to the neo4j instance. (default:" - # "bolt://localhost:7687)", - # default="bolt://localhost:7687") - # parser.add_argument("-u", "--username", help="The username used to connect to the neo4j instance. (default: )", - # default='') - # parser.add_argument("-p", "--password", help="The password used to connect to the neo4j instance. (default: )", - # default='') - parser.add_argument('--live', help="The container name, which can be one of the following: Production, KG2, rtxdev, " - "staging. (default: Production)", default='Production') - - parser.add_argument('--runfunc', dest='runfunc') - args = parser.parse_args() - - # create the RTXConfiguration object - rtxConfig = RTXConfiguration() - - # create UpdateNodesInfo object - ui = UpdateNodesInfo(rtxConfig.neo4j_username, rtxConfig.neo4j_password, rtxConfig.neo4j_bolt) - - args_dict = vars(args) - if args_dict.get('runfunc', None) is not None: - run_function_name = args_dict['runfunc'] - else: - run_function_name = 'update_all' - - try: - run_function = getattr(ui, run_function_name) - except AttributeError: - sys.exit('In module UpdateNodesInfo.py, unable to find function named: ' + run_function_name) - - run_function() - diff --git a/code/reasoningtool/kg-construction/UpdateNodesName.py b/code/reasoningtool/kg-construction/UpdateNodesName.py deleted file mode 100644 index 9aa44b5aa..000000000 --- a/code/reasoningtool/kg-construction/UpdateNodesName.py +++ /dev/null @@ -1,107 +0,0 @@ -''' This module defines the class UpdateNodesName. UpdateNodesName class is designed -to retrieve the node name and update the name on the Graphic model object. -The available methods include: - -* update_protein_names - - Description: retrieve names from Uniprot and update protein nodes - -How to run this module - $ cd [git repo]/code/reasoningtool/kg-construction - $ python3 UpdateNodesName.py -''' - -# BEGIN config.json format -# { -# "url":"bolt://localhost:7687" -# "username":"xxx", -# "password":"xxx" -# } -# END config.json format - -__author__ = 'Deqing Qu' -__copyright__ = 'Oregon State University' -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = 'MIT' -__version__ = '0.1.0' -__maintainer__ = '' -__email__ = '' -__status__ = 'Prototype' - -from Neo4jConnection import Neo4jConnection -from QueryUniprot import QueryUniprot -from QueryMyGene import QueryMyGene -import json - - -class UpdateNodesName: - - @staticmethod - def update_protein_names_old(protein_ids): - - from time import time - t = time() - - nodes_array = [] - for protein_id in protein_ids: - node = dict() - node['node_id'] = protein_id - node['name'] = QueryUniprot.get_protein_name(protein_id) - nodes_array.append(node) - - print("Uniprot api pulling time: %f" % (time() - t)) - - f = open('config.json', 'r') - config_data = f.read() - f.close() - config = json.loads(config_data) - - conn = Neo4jConnection(config['url'], config['username'], config['password']) - conn.update_protein_nodes_name(nodes_array) - conn.close() - - print("total time: %f" % (time() - t)) - - @staticmethod - def update_protein_nodes_name(): - f = open('config.json', 'r') - config_data = f.read() - f.close() - config = json.loads(config_data) - - conn = Neo4jConnection(config['url'], config['username'], config['password']) - nodes = conn.get_protein_nodes() - print("the number of protein nodes: %d" % len(nodes)) - - from time import time - t = time() - - nodes_array = [] - mg = QueryMyGene() - for i, node_id in enumerate(nodes): - node = dict() - node['node_id'] = node_id - node['name'] = mg.get_protein_name(node_id) - nodes_array.append(node) - - print("protein api pulling time: %f" % (time() - t)) - - nodes_nums = len(nodes_array) - chunk_size = 10000 - group_nums = nodes_nums // chunk_size + 1 - for i in range(group_nums): - start = i * chunk_size - end = (i + 1) * chunk_size if (i + 1) * chunk_size < nodes_nums else nodes_nums - conn.update_protein_nodes_name(nodes_array[start:end]) - - print("protein total time: %f" % (time() - t)) - - conn.close() - - -if __name__ == '__main__': - # protein_nodes_ids = ['UniProtKB:P01358', 'UniProtKB:P20848', 'UniProtKB:Q9Y471', 'UniProtKB:O60397', - # 'UniProtKB:Q8IZJ3', 'UniProtKB:Q7Z2Y8', 'UniProtKB:Q8IWN7', 'UniProtKB:Q156A1'] - # UpdateNodesName.update_protein_names_old(protein_nodes_ids) - - UpdateNodesName.update_protein_nodes_name() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/backup_test.py b/code/reasoningtool/kg-construction/backup_test.py deleted file mode 100644 index 5e72de608..000000000 --- a/code/reasoningtool/kg-construction/backup_test.py +++ /dev/null @@ -1,67 +0,0 @@ -from neo4j.v1 import GraphDatabase -import json -import sys -import os - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../") # code directory -from RTXConfiguration import RTXConfiguration - -### BEGIN HOW TO RUN -# Function: The script is used to test the consistency of the dumped database file -# Instance: This python script needs to be run on both 'kgdump' container and the machine which is loaded the dumped -# file. If the outputs on both machines are the same, the test is passed -# how to load the dumped database file: -# tar -zxvf xxxx.tar.gz -# neo4j-admin load --from=xxxx.cypher --database=graph --force -# how to run the python script: -# python3 backup_test.py -# output example: -# nodes counter : 68800 -# relationships counter : 2508369 -### END HOW TO RUN - -### BEGIN user_pass.json format -# { -# "username":"xxx", -# "password":"xxx" -# } -### END user_pass.json format - -class TestBackup(object): - - def __init__(self, uri, user, password): - self._driver = GraphDatabase.driver(uri, auth=(user, password)) - - def close(self): - self._driver.close() - - def print_node_count(self): - with self._driver.session() as session: - counter = session.write_transaction(self._get_node_count) - print('nodes counter : %d' % counter) - - def print_relation_count(self): - with self._driver.session() as session: - counter = session.write_transaction(self._get_relation_count) - print('relationships counter : %d' % counter) - - @staticmethod - def _get_node_count(tx): - result = tx.run("START n=node(*) RETURN count(n)") - return result.single()[0] - - @staticmethod - def _get_relation_count(tx): - result = tx.run("START r=relationship(*) RETURN count(r)") - return result.single()[0] - - -if __name__ == '__main__': - - # create the RTXConfiguration object - rtxConfig = RTXConfiguration() - - obj = TestBackup(rtxConfig.neo4j_bolt, rtxConfig.neo4j_username, rtxConfig.neo4j_password) - obj.print_node_count() - obj.print_relation_count() - obj.close() diff --git a/code/reasoningtool/kg-construction/metabolites.tsv b/code/reasoningtool/kg-construction/metabolites.tsv deleted file mode 100644 index 0ac570c38..000000000 --- a/code/reasoningtool/kg-construction/metabolites.tsv +++ /dev/null @@ -1,18482 +0,0 @@ -metabolite KEGG:C00001 H2O generic -metabolite KEGG:C00002 ATP generic -metabolite KEGG:C00003 NAD+ generic -metabolite KEGG:C00004 NADH generic -metabolite KEGG:C00005 NADPH generic -metabolite KEGG:C00006 NADP+ generic -metabolite KEGG:C00007 Oxygen generic -metabolite KEGG:C00008 ADP generic -metabolite KEGG:C00009 Orthophosphate generic -metabolite KEGG:C00010 CoA generic -metabolite KEGG:C00011 CO2 generic -metabolite KEGG:C00012 Peptide generic -metabolite KEGG:C00013 Diphosphate generic -metabolite KEGG:C00014 Ammonia generic -metabolite KEGG:C00015 UDP generic -metabolite KEGG:C00016 FAD generic -metabolite KEGG:C00017 Protein generic -metabolite KEGG:C00018 Pyridoxal phosphate generic -metabolite KEGG:C00019 S-Adenosyl-L-methionine generic -metabolite KEGG:C00020 AMP generic -metabolite KEGG:C00021 S-Adenosyl-L-homocysteine generic -metabolite KEGG:C00022 Pyruvate generic -metabolite KEGG:C00023 Iron generic -metabolite KEGG:C00024 Acetyl-CoA generic -metabolite KEGG:C00025 L-Glutamate generic -metabolite KEGG:C00026 2-Oxoglutarate generic -metabolite KEGG:C00027 Hydrogen peroxide generic -metabolite KEGG:C00028 Acceptor generic -metabolite KEGG:C00029 UDP-glucose generic -metabolite KEGG:C00030 Reduced acceptor generic -metabolite KEGG:C00031 D-Glucose generic -metabolite KEGG:C00032 Heme generic -metabolite KEGG:C00033 Acetate generic -metabolite KEGG:C00034 Manganese generic -metabolite KEGG:C00035 GDP generic -metabolite KEGG:C00036 Oxaloacetate generic -metabolite KEGG:C00037 Glycine generic -metabolite KEGG:C00038 Zinc cation generic -metabolite KEGG:C00039 DNA generic -metabolite KEGG:C00040 Acyl-CoA generic -metabolite KEGG:C00041 L-Alanine generic -metabolite KEGG:C00042 Succinate generic -metabolite KEGG:C00043 UDP-N-acetyl-alpha-D-glucosamine generic -metabolite KEGG:C00044 GTP generic -metabolite KEGG:C00045 Amino acid generic -metabolite KEGG:C00046 RNA generic -metabolite KEGG:C00047 L-Lysine generic -metabolite KEGG:C00048 Glyoxylate generic -metabolite KEGG:C00049 L-Aspartate generic -metabolite KEGG:C00050 Metal generic -metabolite KEGG:C00051 Glutathione generic -metabolite KEGG:C00052 UDP-alpha-D-galactose generic -metabolite KEGG:C00053 3'-Phosphoadenylyl sulfate generic -metabolite KEGG:C00054 Adenosine 3',5'-bisphosphate generic -metabolite KEGG:C00055 CMP generic -metabolite KEGG:C00058 Formate generic -metabolite KEGG:C00059 Sulfate generic -metabolite KEGG:C00060 Carboxylate generic -metabolite KEGG:C00061 FMN generic -metabolite KEGG:C00062 L-Arginine generic -metabolite KEGG:C00063 CTP generic -metabolite KEGG:C00064 L-Glutamine generic -metabolite KEGG:C00065 L-Serine generic -metabolite KEGG:C00066 tRNA generic -metabolite KEGG:C00067 Formaldehyde generic -metabolite KEGG:C00068 Thiamin diphosphate generic -metabolite KEGG:C00069 Alcohol generic -metabolite KEGG:C00070 Copper generic -metabolite KEGG:C00071 Aldehyde generic -metabolite KEGG:C00072 Ascorbate generic -metabolite KEGG:C00073 L-Methionine generic -metabolite KEGG:C00074 Phosphoenolpyruvate generic -metabolite KEGG:C00075 UTP generic -metabolite KEGG:C00076 Calcium cation generic -metabolite KEGG:C00077 L-Ornithine generic -metabolite KEGG:C00078 L-Tryptophan generic -metabolite KEGG:C00079 L-Phenylalanine generic -metabolite KEGG:C00080 H+ generic -metabolite KEGG:C00081 ITP generic -metabolite KEGG:C00082 L-Tyrosine generic -metabolite KEGG:C00083 Malonyl-CoA generic -metabolite KEGG:C00084 Acetaldehyde generic -metabolite KEGG:C00085 D-Fructose 6-phosphate generic -metabolite KEGG:C00086 Urea generic -metabolite KEGG:C00087 Sulfur generic -metabolite KEGG:C00088 Nitrite generic -metabolite KEGG:C00089 Sucrose generic -metabolite KEGG:C00090 Catechol generic -metabolite KEGG:C00091 Succinyl-CoA generic -metabolite KEGG:C00092 D-Glucose 6-phosphate generic -metabolite KEGG:C00093 sn-Glycerol 3-phosphate generic -metabolite KEGG:C00094 Sulfite generic -metabolite KEGG:C00095 D-Fructose generic -metabolite KEGG:C00096 GDP-mannose generic -metabolite KEGG:C00097 L-Cysteine generic -metabolite KEGG:C00098 Oligopeptide generic -metabolite KEGG:C00099 beta-Alanine generic -metabolite KEGG:C00100 Propanoyl-CoA generic -metabolite KEGG:C00101 Tetrahydrofolate generic -metabolite KEGG:C00102 2,6-Dichloroindophenol generic -metabolite KEGG:C00103 D-Glucose 1-phosphate generic -metabolite KEGG:C00104 IDP generic -metabolite KEGG:C00105 UMP generic -metabolite KEGG:C00106 Uracil generic -metabolite KEGG:C00107 Dipeptide generic -metabolite KEGG:C00108 Anthranilate generic -metabolite KEGG:C00109 2-Oxobutanoate generic -metabolite KEGG:C00110 Dolichyl phosphate generic -metabolite KEGG:C00111 Glycerone phosphate generic -metabolite KEGG:C00112 CDP generic -metabolite KEGG:C00113 PQQ generic -metabolite KEGG:C00114 Choline generic -metabolite KEGG:C00116 Glycerol generic -metabolite KEGG:C00117 D-Ribose 5-phosphate generic -metabolite KEGG:C00118 D-Glyceraldehyde 3-phosphate generic -metabolite KEGG:C00119 5-Phospho-alpha-D-ribose 1-diphosphate generic -metabolite KEGG:C00120 Biotin generic -metabolite KEGG:C00121 D-Ribose generic -metabolite KEGG:C00122 Fumarate generic -metabolite KEGG:C00123 L-Leucine generic -metabolite KEGG:C00124 D-Galactose generic -metabolite KEGG:C00125 Ferricytochrome c generic -metabolite KEGG:C00126 Ferrocytochrome c generic -metabolite KEGG:C00127 Glutathione disulfide generic -metabolite KEGG:C00128 CMP-N-acetylneuraminate generic -metabolite KEGG:C00129 Isopentenyl diphosphate generic -metabolite KEGG:C00130 IMP generic -metabolite KEGG:C00131 dATP generic -metabolite KEGG:C00132 Methanol generic -metabolite KEGG:C00133 D-Alanine generic -metabolite KEGG:C00134 Putrescine generic -metabolite KEGG:C00135 L-Histidine generic -metabolite KEGG:C00136 Butanoyl-CoA generic -metabolite KEGG:C00137 myo-Inositol generic -metabolite KEGG:C00138 Reduced ferredoxin generic -metabolite KEGG:C00139 Oxidized ferredoxin generic -metabolite KEGG:C00140 N-Acetyl-D-glucosamine generic -metabolite KEGG:C00141 3-Methyl-2-oxobutanoic acid generic -metabolite KEGG:C00143 5,10-Methylenetetrahydrofolate generic -metabolite KEGG:C00144 GMP generic -metabolite KEGG:C00145 Thiol generic -metabolite KEGG:C00146 Phenol generic -metabolite KEGG:C00147 Adenine generic -metabolite KEGG:C00148 L-Proline generic -metabolite KEGG:C00149 (S)-Malate generic -metabolite KEGG:C00150 Molybdenum generic -metabolite KEGG:C00151 L-Amino acid generic -metabolite KEGG:C00152 L-Asparagine generic -metabolite KEGG:C00153 Nicotinamide generic -metabolite KEGG:C00154 Palmitoyl-CoA generic -metabolite KEGG:C00155 L-Homocysteine generic -metabolite KEGG:C00156 4-Hydroxybenzoate generic -metabolite KEGG:C00157 Phosphatidylcholine generic -metabolite KEGG:C00158 Citrate generic -metabolite KEGG:C00159 D-Mannose generic -metabolite KEGG:C00160 Glycolate generic -metabolite KEGG:C00161 2-Oxo acid generic -metabolite KEGG:C00162 Fatty acid generic -metabolite KEGG:C00163 Propanoate generic -metabolite KEGG:C00164 Acetoacetate generic -metabolite KEGG:C00165 Diacylglycerol generic -metabolite KEGG:C00166 Phenylpyruvate generic -metabolite KEGG:C00167 UDP-glucuronate generic -metabolite KEGG:C00168 Hydroxypyruvate generic -metabolite KEGG:C00169 Carbamoyl phosphate generic -metabolite KEGG:C00170 5'-Methylthioadenosine generic -metabolite KEGG:C00171 5'-Phosphomononucleotide generic -metabolite KEGG:C00172 3'-Phosphooligonucleotide generic -metabolite KEGG:C00173 Acyl-[acyl-carrier protein] generic -metabolite KEGG:C00174 Acid generic -metabolite KEGG:C00175 Cobalt ion generic -metabolite KEGG:C00176 Flavin generic -metabolite KEGG:C00177 Cyanide ion generic -metabolite KEGG:C00178 Thymine generic -metabolite KEGG:C00179 Agmatine generic -metabolite KEGG:C00180 Benzoate generic -metabolite KEGG:C00181 D-Xylose generic -metabolite KEGG:C00182 Glycogen generic -metabolite KEGG:C00183 L-Valine generic -metabolite KEGG:C00184 Glycerone generic -metabolite KEGG:C00185 Cellobiose generic -metabolite KEGG:C00186 (S)-Lactate generic -metabolite KEGG:C00187 Cholesterol generic -metabolite KEGG:C00188 L-Threonine generic -metabolite KEGG:C00189 Ethanolamine generic -metabolite KEGG:C00190 UDP-D-xylose generic -metabolite KEGG:C00191 D-Glucuronate generic -metabolite KEGG:C00192 Hydroxylamine generic -metabolite KEGG:C00193 Aromatic aldehyde generic -metabolite KEGG:C00194 Cobamide coenzyme generic -metabolite KEGG:C00195 N-Acylsphingosine generic -metabolite KEGG:C00196 2,3-Dihydroxybenzoate generic -metabolite KEGG:C00197 3-Phospho-D-glycerate generic -metabolite KEGG:C00198 D-Glucono-1,5-lactone generic -metabolite KEGG:C00199 D-Ribulose 5-phosphate generic -metabolite KEGG:C00200 Phenazine methosulfate generic -metabolite KEGG:C00201 Nucleoside triphosphate generic -metabolite KEGG:C00202 Isoflurophate generic -metabolite KEGG:C00203 UDP-N-acetyl-D-galactosamine generic -metabolite KEGG:C00204 2-Dehydro-3-deoxy-D-gluconate generic -metabolite KEGG:C00205 hn generic -metabolite KEGG:C00206 dADP generic -metabolite KEGG:C00207 Acetone generic -metabolite KEGG:C00208 Maltose generic -metabolite KEGG:C00209 Oxalate generic -metabolite KEGG:C00210 Cobamide generic -metabolite KEGG:C00211 Collagen generic -metabolite KEGG:C00212 Adenosine generic -metabolite KEGG:C00213 Sarcosine generic -metabolite KEGG:C00214 Thymidine generic -metabolite KEGG:C00215 Nucleotide generic -metabolite KEGG:C00216 D-Arabinose generic -metabolite KEGG:C00217 D-Glutamate generic -metabolite KEGG:C00218 Methylamine generic -metabolite KEGG:C00219 Arachidonate generic -metabolite KEGG:C00220 Methylene blue generic -metabolite KEGG:C00221 beta-D-Glucose generic -metabolite KEGG:C00222 3-Oxopropanoate generic -metabolite KEGG:C00223 p-Coumaroyl-CoA generic -metabolite KEGG:C00224 Adenylyl sulfate generic -metabolite KEGG:C00225 Methyl viologen generic -metabolite KEGG:C00226 Primary alcohol generic -metabolite KEGG:C00227 Acetyl phosphate generic -metabolite KEGG:C00229 Acyl-carrier protein generic -metabolite KEGG:C00230 3,4-Dihydroxybenzoate generic -metabolite KEGG:C00231 D-Xylulose 5-phosphate generic -metabolite KEGG:C00232 Succinate semialdehyde generic -metabolite KEGG:C00233 4-Methyl-2-oxopentanoate generic -metabolite KEGG:C00234 10-Formyltetrahydrofolate generic -metabolite KEGG:C00235 Dimethylallyl diphosphate generic -metabolite KEGG:C00236 3-Phospho-D-glyceroyl phosphate generic -metabolite KEGG:C00237 CO generic -metabolite KEGG:C00238 Potassium cation generic -metabolite KEGG:C00239 dCMP generic -metabolite KEGG:C00240 rRNA generic -metabolite KEGG:C00241 Amide generic -metabolite KEGG:C00242 Guanine generic -metabolite KEGG:C00243 Lactose generic -metabolite KEGG:C00244 Nitrate generic -metabolite KEGG:C00245 Taurine generic -metabolite KEGG:C00246 Butanoic acid generic -metabolite KEGG:C00247 L-Sorbose generic -metabolite KEGG:C00248 Lipoamide generic -metabolite KEGG:C00249 Hexadecanoic acid generic -metabolite KEGG:C00250 Pyridoxal generic -metabolite KEGG:C00251 Chorismate generic -metabolite KEGG:C00252 Isomaltose generic -metabolite KEGG:C00253 Nicotinate generic -metabolite KEGG:C00254 Prephenate generic -metabolite KEGG:C00255 Riboflavin generic -metabolite KEGG:C00256 (R)-Lactate generic -metabolite KEGG:C00257 D-Gluconic acid generic -metabolite KEGG:C00258 D-Glycerate generic -metabolite KEGG:C00259 L-Arabinose generic -metabolite KEGG:C00261 Benzaldehyde generic -metabolite KEGG:C00262 Hypoxanthine generic -metabolite KEGG:C00263 L-Homoserine generic -metabolite KEGG:C00264 3-Oxoacyl-CoA generic -metabolite KEGG:C00265 Dithiothreitol generic -metabolite KEGG:C00266 Glycolaldehyde generic -metabolite KEGG:C00267 alpha-D-Glucose generic -metabolite KEGG:C00268 Dihydrobiopterin generic -metabolite KEGG:C00269 CDP-diacylglycerol generic -metabolite KEGG:C00270 N-Acetylneuraminate generic -metabolite KEGG:C00272 Tetrahydrobiopterin generic -metabolite KEGG:C00273 5-Dehydro-D-fructose generic -metabolite KEGG:C00275 D-Mannose 6-phosphate generic -metabolite KEGG:C00279 D-Erythrose 4-phosphate generic -metabolite KEGG:C00280 Androstenedione generic -metabolite KEGG:C00282 Hydrogen generic -metabolite KEGG:C00283 Hydrogen sulfide generic -metabolite KEGG:C00284 EDTA generic -metabolite KEGG:C00286 dGTP generic -metabolite KEGG:C00288 HCO3- generic -metabolite KEGG:C00290 Fibrin generic -metabolite KEGG:C00291 Nickel generic -metabolite KEGG:C00292 Aniline generic -metabolite KEGG:C00294 Inosine generic -metabolite KEGG:C00295 Orotate generic -metabolite KEGG:C00296 Quinate generic -metabolite KEGG:C00297 Sulfide generic -metabolite KEGG:C00298 Trypsin generic -metabolite KEGG:C00299 Uridine generic -metabolite KEGG:C00300 Creatine generic -metabolite KEGG:C00301 ADP-ribose generic -metabolite KEGG:C00302 Glutamate generic -metabolite KEGG:C00303 Glutamine generic -metabolite KEGG:C00304 Kanamycin generic -metabolite KEGG:C00305 Magnesium cation generic -metabolite KEGG:C00306 Bradykinin generic -metabolite KEGG:C00307 CDP-choline generic -metabolite KEGG:C00308 Canavanine generic -metabolite KEGG:C00309 D-Ribulose generic -metabolite KEGG:C00310 D-Xylulose generic -metabolite KEGG:C00311 Isocitrate generic -metabolite KEGG:C00312 L-Xylulose generic -metabolite KEGG:C00313 Oxalyl-CoA generic -metabolite KEGG:C00314 Pyridoxine generic -metabolite KEGG:C00315 Spermidine generic -metabolite KEGG:C00317 Amylopectin generic -metabolite KEGG:C00318 L-Carnitine generic -metabolite KEGG:C00319 Sphingosine generic -metabolite KEGG:C00320 Thiosulfate generic -metabolite KEGG:C00322 2-Oxoadipate generic -metabolite KEGG:C00323 Caffeoyl-CoA generic -metabolite KEGG:C00324 Ferricyanide generic -metabolite KEGG:C00325 GDP-L-fucose generic -metabolite KEGG:C00326 Glycoprotein generic -metabolite KEGG:C00327 L-Citrulline generic -metabolite KEGG:C00328 L-Kynurenine generic -metabolite KEGG:C00329 D-Glucosamine generic -metabolite KEGG:C00330 Deoxyguanosine generic -metabolite KEGG:C00331 Indolepyruvate generic -metabolite KEGG:C00332 Acetoacetyl-CoA generic -metabolite KEGG:C00333 D-Galacturonate generic -metabolite KEGG:C00334 4-Aminobutanoate generic -metabolite KEGG:C00337 (S)-Dihydroorotate generic -metabolite KEGG:C00338 Lipopolysaccharide generic -metabolite KEGG:C00339 Long-chain alcohol generic -metabolite KEGG:C00340 Reduced rubredoxin generic -metabolite KEGG:C00341 Geranyl diphosphate generic -metabolite KEGG:C00342 Thioredoxin generic -metabolite KEGG:C00343 Thioredoxin disulfide generic -metabolite KEGG:C00344 Phosphatidylglycerol generic -metabolite KEGG:C00345 6-Phospho-D-gluconate generic -metabolite KEGG:C00346 Ethanolamine phosphate generic -metabolite KEGG:C00347 Long-chain carboxylate generic -metabolite KEGG:C00348 all-trans-Undecaprenyl phosphate generic -metabolite KEGG:C00349 2-Methyl-3-oxopropanoate generic -metabolite KEGG:C00350 Phosphatidylethanolamine generic -metabolite KEGG:C00351 5'-Phosphooligonucleotide generic -metabolite KEGG:C00352 D-Glucosamine 6-phosphate generic -metabolite KEGG:C00353 Geranylgeranyl diphosphate generic -metabolite KEGG:C00354 D-Fructose 1,6-bisphosphate generic -metabolite KEGG:C00355 3,4-Dihydroxy-L-phenylalanine generic -metabolite KEGG:C00356 (S)-3-Hydroxy-3-methylglutaryl-CoA generic -metabolite KEGG:C00357 N-Acetyl-D-glucosamine 6-phosphate generic -metabolite KEGG:C00360 dAMP generic -metabolite KEGG:C00361 dGDP generic -metabolite KEGG:C00362 dGMP generic -metabolite KEGG:C00363 dTDP generic -metabolite KEGG:C00364 dTMP generic -metabolite KEGG:C00365 dUMP generic -metabolite KEGG:C00366 Urate generic -metabolite KEGG:C00367 Casein generic -metabolite KEGG:C00369 Starch generic -metabolite KEGG:C00370 Sterol generic -metabolite KEGG:C00371 Zeatin generic -metabolite KEGG:C00372 Dextran generic -metabolite KEGG:C00373 Elastin generic -metabolite KEGG:C00374 Heparin generic -metabolite KEGG:C00375 RCH2NH2 generic -metabolite KEGG:C00376 Retinal generic -metabolite KEGG:C00377 Steroid generic -metabolite KEGG:C00378 Thiamine generic -metabolite KEGG:C00379 Xylitol generic -metabolite KEGG:C00380 Cytosine generic -metabolite KEGG:C00381 Dolichol generic -metabolite KEGG:C00383 Malonate generic -metabolite KEGG:C00384 Neomycin generic -metabolite KEGG:C00385 Xanthine generic -metabolite KEGG:C00386 Carnosine generic -metabolite KEGG:C00387 Guanosine generic -metabolite KEGG:C00388 Histamine generic -metabolite KEGG:C00389 Quercetin generic -metabolite KEGG:C00390 Ubiquinol generic -metabolite KEGG:C00391 Calmodulin generic -metabolite KEGG:C00392 Mannitol generic -metabolite KEGG:C00393 Fibrinogen generic -metabolite KEGG:C00394 GDP-glucose generic -metabolite KEGG:C00395 Penicillin generic -metabolite KEGG:C00396 Pyrimidine generic -metabolite KEGG:C00397 Tobramycin generic -metabolite KEGG:C00398 Tryptamine generic -metabolite KEGG:C00399 Ubiquinone generic -metabolite KEGG:C00400 (-)-Menthol generic -metabolite KEGG:C00401 Chondroitin generic -metabolite KEGG:C00402 D-Aspartate generic -metabolite KEGG:C00403 Polypeptide generic -metabolite KEGG:C00404 Polyphosphate generic -metabolite KEGG:C00405 D-Amino acid generic -metabolite KEGG:C00406 Feruloyl-CoA generic -metabolite KEGG:C00407 L-Isoleucine generic -metabolite KEGG:C00408 L-Pipecolate generic -metabolite KEGG:C00409 Methanethiol generic -metabolite KEGG:C00410 Progesterone generic -metabolite KEGG:C00411 Sinapoyl-CoA generic -metabolite KEGG:C00412 Stearoyl-CoA generic -metabolite KEGG:C00413 Streptomycin generic -metabolite KEGG:C00414 Cyclohexanone generic -metabolite KEGG:C00415 Dihydrofolate generic -metabolite KEGG:C00416 Phosphatidate generic -metabolite KEGG:C00417 cis-Aconitate generic -metabolite KEGG:C00418 (R)-Mevalonate generic -metabolite KEGG:C00419 Polynucleotide generic -metabolite KEGG:C00420 Polysaccharide generic -metabolite KEGG:C00422 Triacylglycerol generic -metabolite KEGG:C00423 trans-Cinnamate generic -metabolite KEGG:C00424 (S)-Lactaldehyde generic -metabolite KEGG:C00426 Dermatan sulfate generic -metabolite KEGG:C00427 Prostaglandin H2 generic -metabolite KEGG:C00429 5,6-Dihydrouracil generic -metabolite KEGG:C00430 5-Aminolevulinate generic -metabolite KEGG:C00431 5-Aminopentanoate generic -metabolite KEGG:C00433 2,5-Dioxopentanoate generic -metabolite KEGG:C00434 Double-stranded DNA generic -metabolite KEGG:C00435 Oxidized rubredoxin generic -metabolite KEGG:C00436 N-Carbamoylputrescine generic -metabolite KEGG:C00437 N-Acetylornithine generic -metabolite KEGG:C00438 N-Carbamoyl-L-aspartate generic -metabolite KEGG:C00439 N-Formimino-L-glutamate generic -metabolite KEGG:C00440 5-Methyltetrahydrofolate generic -metabolite KEGG:C00441 L-Aspartate 4-semialdehyde generic -metabolite KEGG:C00444 5'-Phosphooligoribonucleotide generic -metabolite KEGG:C00445 5,10-Methenyltetrahydrofolate generic -metabolite KEGG:C00446 alpha-D-Galactose 1-phosphate generic -metabolite KEGG:C00447 Sedoheptulose 1,7-bisphosphate generic -metabolite KEGG:C00448 trans,trans-Farnesyl diphosphate generic -metabolite KEGG:C00449 N6-(L-1,3-Dicarboxypropyl)-L-lysine generic -metabolite KEGG:C00450 (S)-2,3,4,5-Tetrahydropyridine-2-carboxylate generic -metabolite KEGG:C00451 (1R,2S)-1-Hydroxypropane-1,2,3-tricarboxylate generic -metabolite KEGG:C00454 NDP generic -metabolite KEGG:C00455 Nicotinamide D-ribonucleotide generic -metabolite KEGG:C00458 dCTP generic -metabolite KEGG:C00459 dTTP generic -metabolite KEGG:C00460 dUTP generic -metabolite KEGG:C00461 Chitin generic -metabolite KEGG:C00462 Halide generic -metabolite KEGG:C00463 Indole generic -metabolite KEGG:C00464 Mannan generic -metabolite KEGG:C00466 Acetoin generic -metabolite KEGG:C00468 Estrone generic -metabolite KEGG:C00469 Ethanol generic -metabolite KEGG:C00470 Pectate generic -metabolite KEGG:C00472 p-Benzoquinone generic -metabolite KEGG:C00473 Retinol generic -metabolite KEGG:C00474 Ribitol generic -metabolite KEGG:C00475 Cytidine generic -metabolite KEGG:C00476 D-Lyxose generic -metabolite KEGG:C00477 Ecdysone generic -metabolite KEGG:C00478 Lichenin generic -metabolite KEGG:C00479 Propanal generic -metabolite KEGG:C00480 Pullulan generic -metabolite KEGG:C00481 Pyrazole generic -metabolite KEGG:C00482 Sinapate generic -metabolite KEGG:C00483 Tyramine generic -metabolite KEGG:C00484 Arylamide generic -metabolite KEGG:C00486 Bilirubin generic -metabolite KEGG:C00487 Carnitine generic -metabolite KEGG:C00488 Formamide generic -metabolite KEGG:C00489 Glutarate generic -metabolite KEGG:C00490 Itaconate generic -metabolite KEGG:C00491 L-Cystine generic -metabolite KEGG:C00492 Raffinose generic -metabolite KEGG:C00493 Shikimate generic -metabolite KEGG:C00494 Sisomicin generic -metabolite KEGG:C00495 Sulochrin generic -metabolite KEGG:C00496 Ubiquitin generic -metabolite KEGG:C00497 (R)-Malate generic -metabolite KEGG:C00498 ADP-glucose generic -metabolite KEGG:C00499 Allantoate generic -metabolite KEGG:C00500 Biliverdin generic -metabolite KEGG:C00501 CDP-glucose generic -metabolite KEGG:C00502 D-Xylonate generic -metabolite KEGG:C00503 Erythritol generic -metabolite KEGG:C00504 Folate generic -metabolite KEGG:C00505 Gentamicin generic -metabolite KEGG:C00506 L-Cysteate generic -metabolite KEGG:C00507 L-Rhamnose generic -metabolite KEGG:C00508 L-Ribulose generic -metabolite KEGG:C00509 Naringenin generic -metabolite KEGG:C00510 Oleoyl-CoA generic -metabolite KEGG:C00511 Acrylic acid generic -metabolite KEGG:C00512 Benzoyl-CoA generic -metabolite KEGG:C00513 CDP-glycerol generic -metabolite KEGG:C00514 D-Mannonate generic -metabolite KEGG:C00515 D-Ornithine generic -metabolite KEGG:C00516 Fibronectin generic -metabolite KEGG:C00517 Hexadecanal generic -metabolite KEGG:C00518 Hyaluronate generic -metabolite KEGG:C00519 Hypotaurine generic -metabolite KEGG:C00521 (-)-Limonene generic -metabolite KEGG:C00522 (R)-Pantoate generic -metabolite KEGG:C00523 Androsterone generic -metabolite KEGG:C00524 Cytochrome c generic -metabolite KEGG:C00525 D-Tryptophan generic -metabolite KEGG:C00526 Deoxyuridine generic -metabolite KEGG:C00527 Glutaryl-CoA generic -metabolite KEGG:C00528 Glycopeptide generic -metabolite KEGG:C00530 Hydroquinone generic -metabolite KEGG:C00531 Itaconyl-CoA generic -metabolite KEGG:C00532 L-Arabitol generic -metabolite KEGG:C00533 Nitric oxide generic -metabolite KEGG:C00534 Pyridoxamine generic -metabolite KEGG:C00535 Testosterone generic -metabolite KEGG:C00536 Triphosphate generic -metabolite KEGG:C00538 2-Oxoaldehyde generic -metabolite KEGG:C00539 Aromatic acid generic -metabolite KEGG:C00540 Cinnamoyl-CoA generic -metabolite KEGG:C00541 Cob(II)alamin generic -metabolite KEGG:C00542 Cystathionine generic -metabolite KEGG:C00543 Dimethylamine generic -metabolite KEGG:C00544 Homogentisate generic -metabolite KEGG:C00545 L-Arabinonate generic -metabolite KEGG:C00546 Methylglyoxal generic -metabolite KEGG:C00547 L-Noradrenaline generic -metabolite KEGG:C00548 Phenyl acetate generic -metabolite KEGG:C00549 RNA (poly(U)) generic -metabolite KEGG:C00550 Sphingomyelin generic -metabolite KEGG:C00551 beta-D-Glucan generic -metabolite KEGG:C00552 meso-Tartaric acid generic -metabolite KEGG:C00553 (+)-Neomenthol generic -metabolite KEGG:C00555 4-Aminobutyraldehyde generic -metabolite KEGG:C00556 Benzyl alcohol generic -metabolite KEGG:C00557 Cyclopentanone generic -metabolite KEGG:C00558 D-Tagaturonate generic -metabolite KEGG:C00559 Deoxyadenosine generic -metabolite KEGG:C00561 Mandelonitrile generic -metabolite KEGG:C00562 Phosphoprotein generic -metabolite KEGG:C00563 Phosphoramidon generic -metabolite KEGG:C00565 Trimethylamine generic -metabolite KEGG:C00566 (3S)-Citryl-CoA generic -metabolite KEGG:C00568 4-Aminobenzoate generic -metabolite KEGG:C00569 Arabinogalactan generic -metabolite KEGG:C00570 CDP-ethanolamine generic -metabolite KEGG:C00571 Cyclohexylamine generic -metabolite KEGG:C00573 Keratan sulfate generic -metabolite KEGG:C00574 beta-D-Fucoside generic -metabolite KEGG:C00575 3',5'-Cyclic AMP generic -metabolite KEGG:C00576 Betaine aldehyde generic -metabolite KEGG:C00577 D-Glyceraldehyde generic -metabolite KEGG:C00579 Dihydrolipoamide generic -metabolite KEGG:C00580 Dimethyl sulfide generic -metabolite KEGG:C00581 Guanidinoacetate generic -metabolite KEGG:C00582 Phenylacetyl-CoA generic -metabolite KEGG:C00583 Propane-1,2-diol generic -metabolite KEGG:C00584 Prostaglandin E2 generic -metabolite KEGG:C00585 Protein tyrosine generic -metabolite KEGG:C00586 2-Deoxy-D-glucose generic -metabolite KEGG:C00587 3-Hydroxybenzoate generic -metabolite KEGG:C00588 Choline phosphate generic -metabolite KEGG:C00590 Coniferyl alcohol generic -metabolite KEGG:C00591 N-Acylneuraminate generic -metabolite KEGG:C00593 Sulfoacetaldehyde generic -metabolite KEGG:C00596 2-Hydroxy-2,4-pentadienoate generic -metabolite KEGG:C00597 Glycerate 3-phosphate generic -metabolite KEGG:C00599 Cholest-4-en-3-one generic -metabolite KEGG:C00601 Phenylacetaldehyde generic -metabolite KEGG:C00602 beta-D-Galactoside generic -metabolite KEGG:C00603 (S)-Ureidoglycolate generic -metabolite KEGG:C00604 1,10-Phenanthroline generic -metabolite KEGG:C00605 2,3-Dehydroacyl-CoA generic -metabolite KEGG:C00606 3-Sulfino-L-alanine generic -metabolite KEGG:C00607 Chondroitin sulfate generic -metabolite KEGG:C00608 Deoxyribonucleotide generic -metabolite KEGG:C00609 Long-chain aldehyde generic -metabolite KEGG:C00611 N-Acetyllactosamine generic -metabolite KEGG:C00612 N1-Acetylspermidine generic -metabolite KEGG:C00613 Protein-L-arginine generic -metabolite KEGG:C00614 Protein glutamate generic -metabolite KEGG:C00615 Protein histidine generic -metabolite KEGG:C00616 Quercetin 3-sulfate generic -metabolite KEGG:C00617 UDP-D-galacturonate generic -metabolite KEGG:C00618 3-Dehydro-L-gulonate generic -metabolite KEGG:C00619 3-Oxo-Delta4-steroid generic -metabolite KEGG:C00620 alpha-D-Ribose 1-phosphate generic -metabolite KEGG:C00621 Dolichyl diphosphate generic -metabolite KEGG:C00623 sn-Glycerol 1-phosphate generic -metabolite KEGG:C00624 N-Acetyl-L-glutamate generic -metabolite KEGG:C00625 N-Acyl-D-mannosamine generic -metabolite KEGG:C00627 Pyridoxine phosphate generic -metabolite KEGG:C00628 2,5-Dihydroxybenzoate generic -metabolite KEGG:C00630 2-Methylpropanoyl-CoA generic -metabolite KEGG:C00631 2-Phospho-D-glycerate generic -metabolite KEGG:C00632 3-Hydroxyanthranilate generic -metabolite KEGG:C00633 4-Hydroxybenzaldehyde generic -metabolite KEGG:C00634 Chondroitin 4-sulfate generic -metabolite KEGG:C00635 Chondroitin 6-sulfate generic -metabolite KEGG:C00636 D-Mannose 1-phosphate generic -metabolite KEGG:C00637 Indole-3-acetaldehyde generic -metabolite KEGG:C00638 Long-chain fatty acid generic -metabolite KEGG:C00639 Prostaglandin F2alpha generic -metabolite KEGG:C00640 (3S)-3-Hydroxyacyl-CoA generic -metabolite KEGG:C00641 1,2-Diacyl-sn-glycerol generic -metabolite KEGG:C00642 4-Hydroxyphenylacetate generic -metabolite KEGG:C00643 5-Hydroxy-L-tryptophan generic -metabolite KEGG:C00644 D-Mannitol 1-phosphate generic -metabolite KEGG:C00645 N-Acetyl-D-mannosamine generic -metabolite KEGG:C00647 Pyridoxamine phosphate generic -metabolite KEGG:C00650 4-Hydroxymandelonitrile generic -metabolite KEGG:C00651 4-Methylene-L-glutamate generic -metabolite KEGG:C00652 D-Arabinono-1,4-lactone generic -metabolite KEGG:C00653 Poly(ribitol phosphate) generic -metabolite KEGG:C00655 Xanthosine 5'-phosphate generic -metabolite KEGG:C00658 trans-2,3-Dehydroacyl-CoA generic -metabolite KEGG:C00659 2-Aceto-2-hydroxybutanoate generic -metabolite KEGG:C00661 Glyceraldehyde 3-phosphate generic -metabolite KEGG:C00662 Reduced adrenal ferredoxin generic -metabolite KEGG:C00663 beta-D-Glucose 1-phosphate generic -metabolite KEGG:C00664 5-Formiminotetrahydrofolate generic -metabolite KEGG:C00665 beta-D-Fructose 2,6-bisphosphate generic -metabolite KEGG:C00666 LL-2,6-Diaminoheptanedioate generic -metabolite KEGG:C00667 Oxidized adrenal ferredoxin generic -metabolite KEGG:C00668 alpha-D-Glucose 6-phosphate generic -metabolite KEGG:C00669 gamma-L-Glutamyl-L-cysteine generic -metabolite KEGG:C00670 sn-Glycero-3-phosphocholine generic -metabolite KEGG:C00671 (S)-3-Methyl-2-oxopentanoic acid generic -metabolite KEGG:C00672 2-Deoxy-D-ribose 1-phosphate generic -metabolite KEGG:C00673 2-Deoxy-D-ribose 5-phosphate generic -metabolite KEGG:C00674 5alpha-Androstane-3,17-dione generic -metabolite KEGG:C00675 Deoxynucleoside 3'-phosphate generic -metabolite KEGG:C00676 Deoxynucleoside 5'-phosphate generic -metabolite KEGG:C00677 Deoxynucleoside triphosphate generic -metabolite KEGG:C00679 5-Dehydro-4-deoxy-D-glucarate generic -metabolite KEGG:C00680 meso-2,6-Diaminoheptanedioate generic -metabolite KEGG:C00681 1-Acyl-sn-glycerol 3-phosphate generic -metabolite KEGG:C00682 2-Hydroxymuconate semialdehyde generic -metabolite KEGG:C00683 (S)-Methylmalonyl-CoA generic -metabolite KEGG:C00684 2-Dehydro-3-deoxy-L-arabinonate generic -metabolite KEGG:C00685 3-Oxoacyl-[acyl-carrier protein] generic -metabolite KEGG:C00686 N-Acyl-D-mannosamine 6-phosphate generic -metabolite KEGG:C00688 dTDP-4-dehydro-beta-L-rhamnose generic -metabolite KEGG:C00689 alpha,alpha'-Trehalose 6-phosphate generic -metabolite KEGG:C00691 2,4,6/3,5-Pentahydroxycyclohexanone generic -metabolite KEGG:C00692 UDP-N-acetylmuramoyl-L-alanyl-D-glutamate generic -metabolite KEGG:C00693 trans-2,3-Dehydroacyl-[acyl-carrier protein] generic -metabolite KEGG:C00694 beta-D-Galactosyl-(1->4)-N-acetyl-beta-D-glucosaminyl-R generic -metabolite KEGG:C00695 Cholic acid generic -metabolite KEGG:C00696 Prostaglandin D2 generic -metabolite KEGG:C00697 Nitrogen generic -metabolite KEGG:C00698 Cl- generic -metabolite KEGG:C00700 XTP generic -metabolite KEGG:C00701 Base generic -metabolite KEGG:C00703 Mercury(2+) generic -metabolite KEGG:C00704 O2.- generic -metabolite KEGG:C00705 dCDP generic -metabolite KEGG:C00706 Amine generic -metabolite KEGG:C00707 Xylan generic -metabolite KEGG:C00708 Iodide generic -metabolite KEGG:C00711 Malate generic -metabolite KEGG:C00712 (9Z)-Octadecenoic acid generic -metabolite KEGG:C00713 Panose generic -metabolite KEGG:C00714 Pectin generic -metabolite KEGG:C00715 Pterin generic -metabolite KEGG:C00716 Serine generic -metabolite KEGG:C00717 Alditol generic -metabolite KEGG:C00718 Amylose generic -metabolite KEGG:C00719 Betaine generic -metabolite KEGG:C00720 RBr generic -metabolite KEGG:C00721 Dextrin generic -metabolite KEGG:C00722 Epoxide generic -metabolite KEGG:C00723 Insulin generic -metabolite KEGG:C00725 Lipoate generic -metabolite KEGG:C00726 Nitrile generic -metabolite KEGG:C00727 Orcinol generic -metabolite KEGG:C00729 Tropine generic -metabolite KEGG:C00732 Ubenimex generic -metabolite KEGG:C00734 Chitosan generic -metabolite KEGG:C00735 Cortisol generic -metabolite KEGG:C00736 Cysteine generic -metabolite KEGG:C00737 D-Aldose generic -metabolite KEGG:C00738 D-Hexose generic -metabolite KEGG:C00739 D-Lysine generic -metabolite KEGG:C00740 D-Serine generic -metabolite KEGG:C00741 Diacetyl generic -metabolite KEGG:C00742 Fluoride generic -metabolite KEGG:C00744 Macrocin generic -metabolite KEGG:C00745 Nicotine generic -metabolite KEGG:C00746 Oxytocin generic -metabolite KEGG:C00747 Pyridine generic -metabolite KEGG:C00748 Siroheme generic -metabolite KEGG:C00750 Spermine generic -metabolite KEGG:C00751 Squalene generic -metabolite KEGG:C00752 Thrombin generic -metabolite KEGG:C00753 Tungsten generic -metabolite KEGG:C00755 4-Hydroxy-3-methoxy-benzaldehyde generic -metabolite KEGG:C00756 1-Octanol generic -metabolite KEGG:C00757 Berberine generic -metabolite KEGG:C00758 Bergaptol generic -metabolite KEGG:C00759 Caldesmon generic -metabolite KEGG:C00760 Cellulose generic -metabolite KEGG:C00761 Coniferin generic -metabolite KEGG:C00762 Cortisone generic -metabolite KEGG:C00763 D-Proline generic -metabolite KEGG:C00764 D-Sorbose generic -metabolite KEGG:C00765 Digitonin generic -metabolite KEGG:C00766 Flavanone generic -metabolite KEGG:C00768 Histidine generic -metabolite KEGG:C00770 L-Idonate generic -metabolite KEGG:C00771 Laminarin generic -metabolite KEGG:C00772 Mevaldate generic -metabolite KEGG:C00773 Pepstatin generic -metabolite KEGG:C00774 Phloretin generic -metabolite KEGG:C00775 Porphyran generic -metabolite KEGG:C00777 Retinoate generic -metabolite KEGG:C00778 Rhodopsin generic -metabolite KEGG:C00779 Scytalone generic -metabolite KEGG:C00780 Serotonin generic -metabolite KEGG:C00783 Tropinone generic -metabolite KEGG:C00785 Urocanate generic -metabolite KEGG:C00786 (-)-Vestitone generic -metabolite KEGG:C00787 tRNA(Tyr) generic -metabolite KEGG:C00788 L-Adrenaline generic -metabolite KEGG:C00789 CDP-ribitol generic -metabolite KEGG:C00791 Creatinine generic -metabolite KEGG:C00792 D-Arginine generic -metabolite KEGG:C00793 D-Cysteine generic -metabolite KEGG:C00794 D-Sorbitol generic -metabolite KEGG:C00795 D-Tagatose generic -metabolite KEGG:C00796 Dicumarol generic -metabolite KEGG:C00797 Ethylamine generic -metabolite KEGG:C00798 Formyl-CoA generic -metabolite KEGG:C00799 Isoflavone generic -metabolite KEGG:C00800 L-Gulonate generic -metabolite KEGG:C00801 Nucleoside generic -metabolite KEGG:C00802 Oxalureate generic -metabolite KEGG:C00803 Pentanoate generic -metabolite KEGG:C00804 Propynoate generic -metabolite KEGG:C00805 Salicylate generic -metabolite KEGG:C00806 Tryptophan generic -metabolite KEGG:C00807 Xyloglucan generic -metabolite KEGG:C00808 (+)-Camphor generic -metabolite KEGG:C00809 (-)-Camphor generic -metabolite KEGG:C00810 (R)-Acetoin generic -metabolite KEGG:C00811 4-Coumarate generic -metabolite KEGG:C00812 Alkyl thiol generic -metabolite KEGG:C00813 Barbiturate generic -metabolite KEGG:C00814 Biochanin A generic -metabolite KEGG:C00815 Citramalate generic -metabolite KEGG:C00816 Collagenase generic -metabolite KEGG:C00817 D-Altronate generic -metabolite KEGG:C00818 D-Glucarate generic -metabolite KEGG:C00819 D-Glutamine generic -metabolite KEGG:C00820 D-Threonine generic -metabolite KEGG:C00821 DNA adenine generic -metabolite KEGG:C00822 Dopaquinone generic -metabolite KEGG:C00823 1-Hexadecanol generic -metabolite KEGG:C00824 Iron-sulfur generic -metabolite KEGG:C00825 Kanamycin B generic -metabolite KEGG:C00826 L-Arogenate generic -metabolite KEGG:C00827 Lactoyl-CoA generic -metabolite KEGG:C00828 Menaquinone generic -metabolite KEGG:C00829 Naphthalene generic -metabolite KEGG:C00830 Oxomalonate generic -metabolite KEGG:C00831 Pantetheine generic -metabolite KEGG:C00832 Paromomycin generic -metabolite KEGG:C00835 Sepiapterin generic -metabolite KEGG:C00836 Sphinganine generic -metabolite KEGG:C00837 Streptidine generic -metabolite KEGG:C00839 Tropomyosin generic -metabolite KEGG:C00840 Vasopressin generic -metabolite KEGG:C00841 Xanthotoxol generic -metabolite KEGG:C00842 dTDP-glucose generic -metabolite KEGG:C00843 (-)-Menthone generic -metabolite KEGG:C00844 Prunasin generic -metabolite KEGG:C00845 2-Furoyl-CoA generic -metabolite KEGG:C00846 3-Oxoadipate generic -metabolite KEGG:C00847 4-Pyridoxate generic -metabolite KEGG:C00848 6-Oxocineole generic -metabolite KEGG:C00849 Ethyl acetate generic -metabolite KEGG:C00850 Aryl sulfate generic -metabolite KEGG:C00852 Chlorogenate generic -metabolite KEGG:C00853 Cob(I)alamin generic -metabolite KEGG:C00854 Cyclohexanol generic -metabolite KEGG:C00855 D-Methionine generic -metabolite KEGG:C00856 DNA cytosine generic -metabolite KEGG:C00857 Deamino-NAD+ generic -metabolite KEGG:C00858 Formononetin generic -metabolite KEGG:C00859 Gibberellin A1 generic -metabolite KEGG:C00860 L-Histidinol generic -metabolite KEGG:C00861 L-Rhamnulose generic -metabolite KEGG:C00862 Methanofuran generic -metabolite KEGG:C00863 Monoterpenol generic -metabolite KEGG:C00864 Pantothenate generic -metabolite KEGG:C00865 Phospholipid generic -metabolite KEGG:C00868 tRNA uridine generic -metabolite KEGG:C00869 2-Oxooctadecanoic acid generic -metabolite KEGG:C00870 4-Nitrophenol generic -metabolite KEGG:C00871 Alkylated DNA generic -metabolite KEGG:C00872 Aminomalonate generic -metabolite KEGG:C00873 Angiotensin I generic -metabolite KEGG:C00875 Cephalosporin generic -metabolite KEGG:C00876 Coenzyme F420 generic -metabolite KEGG:C00877 Crotonoyl-CoA generic -metabolite KEGG:C00878 D-Arabinonate generic -metabolite KEGG:C00879 D-Galactarate generic -metabolite KEGG:C00880 D-Galactonate generic -metabolite KEGG:C00881 Deoxycytidine generic -metabolite KEGG:C00882 Dephospho-CoA generic -metabolite KEGG:C00883 Galactomannan generic -metabolite KEGG:C00884 Homocarnosine generic -metabolite KEGG:C00885 Isochorismate generic -metabolite KEGG:C00886 L-Alanyl-tRNA generic -metabolite KEGG:C00887 Nitrous oxide generic -metabolite KEGG:C00888 Pentanoyl-CoA generic -metabolite KEGG:C00889 Peptidoglycan generic -metabolite KEGG:C00891 Pregnan-21-al generic -metabolite KEGG:C00892 Pregnan-21-ol generic -metabolite KEGG:C00893 Primary monoamine generic -metabolite KEGG:C00894 Propenoyl-CoA generic -metabolite KEGG:C00895 RNA (poly(A)) generic -metabolite KEGG:C00896 Tos-Lys-CH2Cl generic -metabolite KEGG:C00897 alpha-Maltose generic -metabolite KEGG:C00898 (R,R)-Tartaric acid generic -metabolite KEGG:C00899 11-cis-Retinol generic -metabolite KEGG:C00900 2-Acetolactate generic -metabolite KEGG:C00902 2-Oxohexanoic acid generic -metabolite KEGG:C00903 Cinnamaldehyde generic -metabolite KEGG:C00904 Citramalyl-CoA generic -metabolite KEGG:C00905 D-Fructuronate generic -metabolite KEGG:C00906 5,6-Dihydrothymine generic -metabolite KEGG:C00908 Gentamicin C1a generic -metabolite KEGG:C00909 Leukotriene A4 generic -metabolite KEGG:C00911 Ribonucleoside generic -metabolite KEGG:C00912 alpha-D-Glucan generic -metabolite KEGG:C00913 3-Methyladenine generic -metabolite KEGG:C00915 Benzyl viologen generic -metabolite KEGG:C00916 Cephalosporin C generic -metabolite KEGG:C00917 Chelating agent generic -metabolite KEGG:C00918 Chloramphenicol generic -metabolite KEGG:C00919 Choline sulfate generic -metabolite KEGG:C00920 CoA-glutathione generic -metabolite KEGG:C00921 Dihydropteroate generic -metabolite KEGG:C00922 2,3-Dimethylmaleate generic -metabolite KEGG:C00923 Ferricytochrome generic -metabolite KEGG:C00924 Ferrocytochrome generic -metabolite KEGG:C00925 Heparan sulfate generic -metabolite KEGG:C00927 Isonocardicin A generic -metabolite KEGG:C00928 Mercaptoethanol generic -metabolite KEGG:C00929 Oligonucleotide generic -metabolite KEGG:C00930 Oligosaccharide generic -metabolite KEGG:C00931 Porphobilinogen generic -metabolite KEGG:C00933 Sinapine generic -metabolite KEGG:C00934 Sugar phosphate generic -metabolite KEGG:C00935 UDP-L-arabinose generic -metabolite KEGG:C00936 alpha-D-Mannose generic -metabolite KEGG:C00937 (R)-Lactaldehyde generic -metabolite KEGG:C00938 1,3-beta-D-Xylan generic -metabolite KEGG:C00939 2-Aminoadenosine generic -metabolite KEGG:C00940 2-Oxoglutaramate generic -metabolite KEGG:C00941 3',5'-Cyclic CMP generic -metabolite KEGG:C00942 3',5'-Cyclic GMP generic -metabolite KEGG:C00943 3',5'-Cyclic IMP generic -metabolite KEGG:C00944 3-Dehydroquinate generic -metabolite KEGG:C00946 Adenosine 2'-phosphate generic -metabolite KEGG:C00949 Cytochrome c-552 generic -metabolite KEGG:C00950 Dithioerythritol generic -metabolite KEGG:C00951 Estradiol-17beta generic -metabolite KEGG:C00952 Fibrinopeptide A generic -metabolite KEGG:C00954 Indole-3-acetate generic -metabolite KEGG:C00955 Indole-3-ethanol generic -metabolite KEGG:C00956 L-2-Aminoadipate generic -metabolite KEGG:C00957 Mercaptopyruvate generic -metabolite KEGG:C00958 Plasmenylcholine generic -metabolite KEGG:C00959 Prostaglandin B1 generic -metabolite KEGG:C00960 RNA 5'-phosphate generic -metabolite KEGG:C00961 Sterigmatocystin generic -metabolite KEGG:C00962 beta-D-Galactose generic -metabolite KEGG:C00963 beta-D-Glucoside generic -metabolite KEGG:C00964 (-)-trans-Carveol generic -metabolite KEGG:C00965 1,3-beta-D-Glucan generic -metabolite KEGG:C00966 2-Dehydropantoate generic -metabolite KEGG:C00968 3',5'-Cyclic dAMP generic -metabolite KEGG:C00969 3-Hydroxypropanal generic -metabolite KEGG:C00971 4-Pyridoxolactone generic -metabolite KEGG:C00972 Aromatic oxo acid generic -metabolite KEGG:C00973 Cyclomaltodextrin generic -metabolite KEGG:C00974 Dihydrokaempferol generic -metabolite KEGG:C00975 Dihydroxyfumarate generic -metabolite KEGG:C00976 GDP-D-mannuronate generic -metabolite KEGG:C00977 L-Tryptophanamide generic -metabolite KEGG:C00978 N-Acetylserotonin generic -metabolite KEGG:C00979 O-Acetyl-L-serine generic -metabolite KEGG:C00980 Polyvinyl alcohol generic -metabolite KEGG:C00982 Renilla luciferin generic -metabolite KEGG:C00984 alpha-D-Galactose generic -metabolite KEGG:C00985 p-Mercuribenzoate generic -metabolite KEGG:C00986 1,3-Diaminopropane generic -metabolite KEGG:C00988 2-Phosphoglycolate generic -metabolite KEGG:C00989 4-Hydroxybutanoic acid generic -metabolite KEGG:C00990 5-Aminopentanamide generic -metabolite KEGG:C00991 alpha-D-Aldose 1-phosphate generic -metabolite KEGG:C00992 Aquacob(III)alamin generic -metabolite KEGG:C00993 D-Alanyl-D-alanine generic -metabolite KEGG:C00994 D-Prephenyllactate generic -metabolite KEGG:C00995 Ferricytochrome b1 generic -metabolite KEGG:C00996 Ferricytochrome b5 generic -metabolite KEGG:C00997 Ferricytochrome c2 generic -metabolite KEGG:C00998 Ferrocytochrome b1 generic -metabolite KEGG:C00999 Ferrocytochrome b5 generic -metabolite KEGG:C01000 Ferrocytochrome c2 generic -metabolite KEGG:C01001 Formylmethanofuran generic -metabolite KEGG:C01002 Hexose 1-phosphate generic -metabolite KEGG:C01003 Myosin light chain generic -metabolite KEGG:C01004 N-Methylnicotinate generic -metabolite KEGG:C01005 O-Phospho-L-serine generic -metabolite KEGG:C01007 Reduced riboflavin generic -metabolite KEGG:C01008 Trimethylsulfonium generic -metabolite KEGG:C01009 UDP-2-deoxyglucose generic -metabolite KEGG:C01010 Urea-1-carboxylate generic -metabolite KEGG:C01011 (3S)-Citramalyl-CoA generic -metabolite KEGG:C01012 (R)-Pantolactone generic -metabolite KEGG:C01013 3-Hydroxypropanoate generic -metabolite KEGG:C01014 3-Isopropylcatechol generic -metabolite KEGG:C01015 cis-4-Hydroxy-L-proline generic -metabolite KEGG:C01016 5'-Phosphomonoester generic -metabolite KEGG:C01017 5-Hydroxytryptophan generic -metabolite KEGG:C01018 6-Deoxy-D-galactose generic -metabolite KEGG:C01019 6-Deoxy-L-galactose generic -metabolite KEGG:C01020 6-Hydroxynicotinate generic -metabolite KEGG:C01021 Aromatic amino acid generic -metabolite KEGG:C01022 Caldesmon phosphate generic -metabolite KEGG:C01023 Dihydrostreptomycin generic -metabolite KEGG:C01024 Hydroxymethylbilane generic -metabolite KEGG:C01025 Lipid hydroperoxide generic -metabolite KEGG:C01026 N,N-Dimethylglycine generic -metabolite KEGG:C01028 N6-Hydroxy-L-lysine generic -metabolite KEGG:C01029 N8-Acetylspermidine generic -metabolite KEGG:C01031 S-Formylglutathione generic -metabolite KEGG:C01032 alpha-L-Arabinoside generic -metabolite KEGG:C01033 2-Methylbutanoyl-CoA generic -metabolite KEGG:C01034 3-Oxo-Delta5-steroid generic -metabolite KEGG:C01035 4-Guanidinobutanoate generic -metabolite KEGG:C01036 4-Maleylacetoacetate generic -metabolite KEGG:C01037 7,8-Diaminononanoate generic -metabolite KEGG:C01040 L-Gulono-1,4-lactone generic -metabolite KEGG:C01041 Monodehydroascorbate generic -metabolite KEGG:C01042 N-Acetyl-L-aspartate generic -metabolite KEGG:C01043 N-Carbamoylsarcosine generic -metabolite KEGG:C01044 N-Formyl-L-aspartate generic -metabolite KEGG:C01045 N-Formyl-L-glutamate generic -metabolite KEGG:C01046 N-Methyl-L-glutamate generic -metabolite KEGG:C01047 N5-Ethyl-L-glutamine generic -metabolite KEGG:C01048 Polyprenyl phosphate generic -metabolite KEGG:C01050 UDP-N-acetylmuramate generic -metabolite KEGG:C01051 Uroporphyrinogen III generic -metabolite KEGG:C01053 (R)-4-Dehydropantoate generic -metabolite KEGG:C01054 (S)-2,3-Epoxysqualene generic -metabolite KEGG:C01056 (S)-6-Hydroxynicotine generic -metabolite KEGG:C01058 11beta-Hydroxysteroid generic -metabolite KEGG:C01059 2,5-Dihydroxypyridine generic -metabolite KEGG:C01060 3,5-Diiodo-L-tyrosine generic -metabolite KEGG:C01061 4-Fumarylacetoacetate generic -metabolite KEGG:C01062 5-Dehydro-D-gluconate generic -metabolite KEGG:C01063 6-Carboxyhexanoyl-CoA generic -metabolite KEGG:C01064 CMP-N-acylneuraminate generic -metabolite KEGG:C01066 Cyclohexane-1,3-dione generic -metabolite KEGG:C01067 D-Galactose 6-sulfate generic -metabolite KEGG:C01068 D-Ribitol 5-phosphate generic -metabolite KEGG:C01069 Desulfoglucotropeolin generic -metabolite KEGG:C01070 Ferricytochrome c-553 generic -metabolite KEGG:C01071 Ferrocytochrome c-553 generic -metabolite KEGG:C01073 N-Acetyl-beta-alanine generic -metabolite KEGG:C01074 N-Acetylgalactosamine generic -metabolite KEGG:C01075 N-Sulfo-D-glucosamine generic -metabolite KEGG:C01076 N-Terminal amino acid generic -metabolite KEGG:C01077 O-Acetyl-L-homoserine generic -metabolite KEGG:C01078 Procollagen L-proline generic -metabolite KEGG:C01079 Protoporphyrinogen IX generic -metabolite KEGG:C01080 Reduced coenzyme F420 generic -metabolite KEGG:C01081 Thiamin monophosphate generic -metabolite KEGG:C01083 alpha,alpha-Trehalose generic -metabolite KEGG:C01086 (3R)-3-Hydroxyacyl-CoA generic -metabolite KEGG:C01087 (R)-2-Hydroxyglutarate generic -metabolite KEGG:C01088 (R)-3,3-Dimethylmalate generic -metabolite KEGG:C01089 (R)-3-Hydroxybutanoate generic -metabolite KEGG:C01090 16alpha-Hydroxysteroid generic -metabolite KEGG:C01091 Deacetylvindoline generic -metabolite KEGG:C01092 8-Amino-7-oxononanoate generic -metabolite KEGG:C01093 Cellobiono-1,5-lactone generic -metabolite KEGG:C01094 D-Fructose 1-phosphate generic -metabolite KEGG:C01095 D-Ribose 5-diphosphate generic -metabolite KEGG:C01096 Sorbitol 6-phosphate generic -metabolite KEGG:C01097 D-Tagatose 6-phosphate generic -metabolite KEGG:C01099 L-Fuculose 1-phosphate generic -metabolite KEGG:C01100 L-Histidinol phosphate generic -metabolite KEGG:C01101 L-Ribulose 5-phosphate generic -metabolite KEGG:C01102 O-Phospho-L-homoserine generic -metabolite KEGG:C01103 Orotidine 5'-phosphate generic -metabolite KEGG:C01104 Trimethylamine N-oxide generic -metabolite KEGG:C01107 (R)-5-Phosphomevalonate generic -metabolite KEGG:C01108 1,2,3-Trihydroxybenzene generic -metabolite KEGG:C01109 4-Methylene-L-glutamine generic -metabolite KEGG:C01110 5-Amino-2-oxopentanoic acid generic -metabolite KEGG:C01111 7,8-Dihydroxykynurenate generic -metabolite KEGG:C01112 D-Arabinose 5-phosphate generic -metabolite KEGG:C01113 D-Galactose 6-phosphate generic -metabolite KEGG:C01114 L-Arabinono-1,4-lactone generic -metabolite KEGG:C01115 L-Galactono-1,4-lactone generic -metabolite KEGG:C01117 Nucleoside 5'-phosphate generic -metabolite KEGG:C01118 O-Succinyl-L-homoserine generic -metabolite KEGG:C01119 Oxidized dithiothreitol generic -metabolite KEGG:C01120 Sphinganine 1-phosphate generic -metabolite KEGG:C01121 Streptidine 6-phosphate generic -metabolite KEGG:C01122 cis-2,3-Dehydroacyl-CoA generic -metabolite KEGG:C01123 (-)-trans-Isopiperitenol generic -metabolite KEGG:C01124 18-Hydroxycorticosterone generic -metabolite KEGG:C01125 Dihydro-4,4-dimethyl-2,3-furandione generic -metabolite KEGG:C01126 (2E,6E)-Farnesol generic -metabolite KEGG:C01127 4-Hydroxy-2-oxoglutarate generic -metabolite KEGG:C01131 L-Rhamnulose 1-phosphate generic -metabolite KEGG:C01132 N-Acetyl-D-galactosamine generic -metabolite KEGG:C01133 N-Acetyl-D-glucosaminate generic -metabolite KEGG:C01134 Pantetheine 4'-phosphate generic -metabolite KEGG:C01135 Phospho-beta-D-glucoside generic -metabolite KEGG:C01136 S-Acetyldihydrolipoamide generic -metabolite KEGG:C01137 S-Adenosylmethioninamine generic -metabolite KEGG:C01138 Streptomycin 6-phosphate generic -metabolite KEGG:C01139 [Acetyl-CoA carboxylase] generic -metabolite KEGG:C01140 alpha-D-Glucosyl-protein generic -metabolite KEGG:C01141 beta-Adrenergic receptor generic -metabolite KEGG:C01142 (3S)-3,6-Diaminohexanoate generic -metabolite KEGG:C01143 (R)-5-Diphosphomevalonate generic -metabolite KEGG:C01144 (S)-3-Hydroxybutanoyl-CoA generic -metabolite KEGG:C01146 2-Hydroxy-3-oxopropanoate generic -metabolite KEGG:C01147 2-Hydroxycyclohexan-1-one generic -metabolite KEGG:C01149 4-Trimethylammoniobutanal generic -metabolite KEGG:C01151 D-Ribose 1,5-bisphosphate generic -metabolite KEGG:C01152 N(pi)-Methyl-L-histidine generic -metabolite KEGG:C01153 Orthophosphoric monoester generic -metabolite KEGG:C01155 Quercetin 3,3'-bissulfate generic -metabolite KEGG:C01156 Quercetin 3,4'-bissulfate generic -metabolite KEGG:C01157 Hydroxyproline generic -metabolite KEGG:C01158 1-O-Galloyl-beta-D-glucose generic -metabolite KEGG:C01159 2,3-Bisphospho-D-glycerate generic -metabolite KEGG:C01161 3,4-Dihydroxyphenylacetate generic -metabolite KEGG:C01162 3-(Pyrazol-1-yl)-L-alanine generic -metabolite KEGG:C01163 3-Carboxy-cis,cis-muconate generic -metabolite KEGG:C01164 7-Dehydrocholesterol generic -metabolite KEGG:C01165 L-Glutamate 5-semialdehyde generic -metabolite KEGG:C01166 Oxidized polyvinyl alcohol generic -metabolite KEGG:C01167 Protein tyrosine phosphate generic -metabolite KEGG:C01168 Pseudouridine 5'-phosphate generic -metabolite KEGG:C01169 S-Succinyldihydrolipoamide generic -metabolite KEGG:C01170 UDP-N-acetyl-D-mannosamine generic -metabolite KEGG:C01171 alpha-D-Hexose 1-phosphate generic -metabolite KEGG:C01172 beta-D-Glucose 6-phosphate generic -metabolite KEGG:C01173 1,3,8-Naphthalenertriol generic -metabolite KEGG:C01175 1-O-Sinapoyl-beta-D-glucose generic -metabolite KEGG:C01176 17alpha-Hydroxyprogesterone generic -metabolite KEGG:C01177 Inositol 1-phosphate generic -metabolite KEGG:C01179 3-(4-Hydroxyphenyl)pyruvate generic -metabolite KEGG:C01180 4-Methylthio-2-oxobutanoic acid generic -metabolite KEGG:C01181 4-Trimethylammoniobutanoate generic -metabolite KEGG:C01182 D-Ribulose 1,5-bisphosphate generic -metabolite KEGG:C01183 N,N-Dimethylaniline N-oxide generic -metabolite KEGG:C01185 Nicotinate D-ribonucleotide generic -metabolite KEGG:C01186 (3S,5S)-3,5-Diaminohexanoate generic -metabolite KEGG:C01187 3-Deoxy-D-manno-octulosonate generic -metabolite KEGG:C01188 3-Hydroxy-2-methylpropanoate generic -metabolite KEGG:C01189 Lathosterol generic -metabolite KEGG:C01190 beta-D-Glucosyl-(1<->1)-ceramide generic -metabolite KEGG:C01191 Dolichyl D-xylosyl phosphate generic -metabolite KEGG:C01192 Palmitoylglycerone phosphate generic -metabolite KEGG:C01194 1-Phosphatidyl-D-myo-inositol generic -metabolite KEGG:C01196 3'-Hydroxyoligoribonucleotide generic -metabolite KEGG:C01197 Caffeate generic -metabolite KEGG:C01198 3-(2-Hydroxyphenyl)propanoate generic -metabolite KEGG:C01199 5'-Hydroxyoligoribonucleotide generic -metabolite KEGG:C01200 N-Acylneuraminate 9-phosphate generic -metabolite KEGG:C01201 N(omega)-(ADP-D-ribosyl)-L-arginine generic -metabolite KEGG:C01203 Oleoyl-[acyl-carrier protein] generic -metabolite KEGG:C01204 Phytic acid generic -metabolite KEGG:C01205 (R)-3-Amino-2-methylpropanoate generic -metabolite KEGG:C01207 3-(3,4-Dihydroxyphenyl)lactate generic -metabolite KEGG:C01209 Malonyl-[acyl-carrier protein] generic -metabolite KEGG:C01210 N-Methylethanolamine phosphate generic -metabolite KEGG:C01211 Procollagen 5-hydroxy-L-lysine generic -metabolite KEGG:C01212 UDP-N-acetylmuramoyl-L-alanine generic -metabolite KEGG:C01213 (R)-Methylmalonyl-CoA generic -metabolite KEGG:C01214 1-Amino-1-deoxy-scyllo-inositol generic -metabolite KEGG:C01215 2-(Acetamidomethylene)succinate generic -metabolite KEGG:C01216 2-Dehydro-3-deoxy-D-galactonate generic -metabolite KEGG:C01217 5,6,7,8-Tetrahydromethanopterin generic -metabolite KEGG:C01218 6-Phospho-2-dehydro-D-gluconate generic -metabolite KEGG:C01219 CDP-4-dehydro-6-deoxy-D-glucose generic -metabolite KEGG:C01220 1D-myo-Inositol 1,4-bisphosphate generic -metabolite KEGG:C01221 Dihydrostreptomycin 6-phosphate generic -metabolite KEGG:C01222 GDP-4-dehydro-6-deoxy-D-mannose generic -metabolite KEGG:C01223 Methyl 2-diazoacetamidohexonate generic -metabolite KEGG:C01225 sn-Glycero-3-phospho-1-inositol generic -metabolite KEGG:C01226 12-OPDA generic -metabolite KEGG:C01227 Dehydroepiandrosterone generic -metabolite KEGG:C01228 Guanosine 3',5'-bis(diphosphate) generic -metabolite KEGG:C01229 Phospholipid olefinic fatty acid generic -metabolite KEGG:C01230 all-trans-Hexaprenyl diphosphate generic -metabolite KEGG:C01231 alpha-D-Glucose 1,6-bisphosphate generic -metabolite KEGG:C01233 sn-Glycero-3-phosphoethanolamine generic -metabolite KEGG:C01234 1-Aminocyclopropane-1-carboxylate generic -metabolite KEGG:C01235 alpha-D-Galactosyl-(1->3)-1D-myo-inositol generic -metabolite KEGG:C01236 D-Glucono-1,5-lactone 6-phosphate generic -metabolite KEGG:C01239 N-Acetyl-beta-D-glucosaminylamine generic -metabolite KEGG:C01240 2',3'-Cyclic nucleotide generic -metabolite KEGG:C01241 Phosphatidyl-N-methylethanolamine generic -metabolite KEGG:C01242 S-Aminomethyldihydrolipoylprotein generic -metabolite KEGG:C01243 1D-myo-Inositol 1,3,4-trisphosphate generic -metabolite KEGG:C01244 3,5-Diiodo-4-hydroxyphenylpyruvate generic -metabolite KEGG:C01245 D-myo-Inositol 1,4,5-trisphosphate generic -metabolite KEGG:C01246 Dolichyl beta-D-glucosyl phosphate generic -metabolite KEGG:C01247 [Acetyl-CoA carboxylase] phosphate generic -metabolite KEGG:C01249 7,8-Dihydro-7,8-dihydroxykynurenate generic -metabolite KEGG:C01250 N-Acetyl-L-glutamate 5-semialdehyde generic -metabolite KEGG:C01251 (R)-2-Hydroxybutane-1,2,4-tricarboxylate generic -metabolite KEGG:C01252 4-(2-Aminophenyl)-2,4-dioxobutanoate generic -metabolite KEGG:C01253 ADP-D-ribosyl-[dinitrogen reductase] generic -metabolite KEGG:C01255 N-(6-Aminohexanoyl)-6-aminohexanoate generic -metabolite KEGG:C01256 [Pyruvate dehydrogenase (acetyl-transferring)] generic -metabolite KEGG:C01259 (3S)-3-Hydroxy-N6,N6,N6-trimethyl-L-lysine generic -metabolite KEGG:C01260 P1,P4-Bis(5'-adenosyl)tetraphosphate generic -metabolite KEGG:C01261 P1,P4-Bis(5'-guanosyl) tetraphosphate generic -metabolite KEGG:C01262 beta-Alanyl-N(pi)-methyl-L-histidine generic -metabolite KEGG:C01263 3,6,9-Trihydroxypterocarpan generic -metabolite KEGG:C01264 2-Acetyl-1-alkyl-sn-glycero-3-phosphate generic -metabolite KEGG:C01265 3,7-Di-O-methylquercetin generic -metabolite KEGG:C01266 3'-Deoxydihydrostreptomycin 6-phosphate generic -metabolite KEGG:C01267 3-(Imidazol-4-yl)-2-oxopropyl phosphate generic -metabolite KEGG:C01268 5-Amino-6-(5'-phosphoribosylamino)uracil generic -metabolite KEGG:C01269 5-O-(1-Carboxyvinyl)-3-phosphoshikimate generic -metabolite KEGG:C01270 3-Hydroxy-2-methylpyridine-5-carboxylate generic -metabolite KEGG:C01271 (3R)-3-Hydroxyacyl-[acyl-carrier protein] generic -metabolite KEGG:C01272 1D-myo-Inositol 1,3,4,5-tetrakisphosphate generic -metabolite KEGG:C01273 2-Hydroxy-6-oxo-6-phenylhexa-2,4-dienoate generic -metabolite KEGG:C01274 5-Formyl-5,6,7,8-tetrahydromethanopterin generic -metabolite KEGG:C01275 (3E)-4-(2-Carboxyphenyl)-2-oxobut-3-enoate generic -metabolite KEGG:C01277 1-Phosphatidyl-1D-myo-inositol 4-phosphate generic -metabolite KEGG:C01278 2-Carboxy-2,5-dihydro-5-oxofuran-2-acetate generic -metabolite KEGG:C01279 4-Amino-5-hydroxymethyl-2-methylpyrimidine generic -metabolite KEGG:C01280 Dihydrostreptomycin 3'alpha,6-bisphosphate generic -metabolite KEGG:C01281 [L-Glutamate:ammonia ligase (ADP-forming)] generic -metabolite KEGG:C01282 1-Acyl-2-oleoyl-sn-glycero-3-phosphocholine generic -metabolite KEGG:C01283 1-Amino-1-deoxy-scyllo-inositol 4-phosphate generic -metabolite KEGG:C01284 1D-myo-Inositol 1,3,4,5,6-pentakisphosphate generic -metabolite KEGG:C01285 2,6-Dichlorophenol-4-(2,3-dihydro-1,4-naphthoquinone imine) generic -metabolite KEGG:C01286 2-Dehydro-3-deoxy-6-phospho-D-galactonate generic -metabolite KEGG:C01288 N-Acetyl-D-glucosaminylphosphatidylinositol generic -metabolite KEGG:C01289 N-Acetyl-D-glucosaminyldiphosphoundecaprenol generic -metabolite KEGG:C01290 beta-D-Galactosyl-(1->4)-beta-D-glucosyl-(1<->1)-ceramide generic -metabolite KEGG:C01291 3-(4-Methylpent-3-en-1-yl)pent-2-enedioyl-CoA generic -metabolite KEGG:C01292 3alpha,7alpha-Dihydroxy-12-oxo-5beta-cholanate generic -metabolite KEGG:C01293 [Pyruvate dehydrogenase (acetyl-transferring)] phosphate generic -metabolite KEGG:C01294 1-Guanidino-1-deoxy-scyllo-inositol 4-phosphate generic -metabolite KEGG:C01295 2D-5-O-Methyl-2,3,5/4,6-pentahydroxycyclohexanone generic -metabolite KEGG:C01297 6-Hydroxypseudooxynicotine generic -metabolite KEGG:C01298 1D-1-Guanidino-3-amino-1,3-dideoxy-scyllo-inositol generic -metabolite KEGG:C01299 Adenylyl-[L-glutamate:ammonia ligase (ADP-forming)] generic -metabolite KEGG:C01300 6-(Hydroxymethyl)-7,8-dihydropterin generic -metabolite KEGG:C01301 3alpha,7alpha,12alpha-Trihydroxy-5beta-cholestan-26-al generic -metabolite KEGG:C01302 1-(2-Carboxyphenylamino)-1-deoxy-D-ribulose 5-phosphate generic -metabolite KEGG:C01304 2,5-Diamino-6-(5-phospho-D-ribosylamino)pyrimidin-4(3H)-one generic -metabolite KEGG:C01306 N-Acetyl-beta-D-glucosaminyl-(1->3)-N-acetyl-D-galactosaminyl-R generic -metabolite KEGG:C01308 [3-Methyl-2-oxobutanoate dehydrogenase (2-methylpropanoyl-transferring)] phosphate generic -metabolite KEGG:C01310 4-Deoxy-beta-D-gluc-4-enuronosyl-(1,3)-N-acetyl-D-galactosamine generic -metabolite KEGG:C01311 1,4-beta-D-Galactosyl-(alpha-1,3-L-fucosyl)-N-acetyl-D-glucosaminyl-R generic -metabolite KEGG:C01312 Prostaglandin I2 generic -metabolite KEGG:C01313 (S)-N-[3-(3,4-Methylenedioxyphenyl)-2-(mercaptomethyl)-1-oxoprolyl]glycine generic -metabolite KEGG:C01314 (S)-N-[3-(3,4-Methylenedioxyphenyl)-2-(mercaptomethyl)-1-oxoprolyl]-(S)-alanine generic -metabolite KEGG:C01315 (S)-N-[3-(3,4-Methylenedioxyphenyl)-2-(acetylthio)methyl-1-oxoprolyl]glycine benzyl ester generic -metabolite KEGG:C01316 (S)-N-[3-(3,4-Methylenedioxyphenyl)-2-(acetylthio)methyl-1-oxoprolyl]-(S)-alanine benzyl ester generic -metabolite KEGG:C01319 Hg generic -metabolite KEGG:C01321 RI generic -metabolite KEGG:C01322 RX generic -metabolite KEGG:C01324 Bromide generic -metabolite KEGG:C01326 Hydrogen cyanide generic -metabolite KEGG:C01327 Hydrochloric acid generic -metabolite KEGG:C01328 HO- generic -metabolite KEGG:C01329 Nucleoside phosphate generic -metabolite KEGG:C01330 Sodium cation generic -metabolite KEGG:C01334 RCl generic -metabolite KEGG:C01335 ROH generic -metabolite KEGG:C01336 Aryl thiol generic -metabolite KEGG:C01337 XDP generic -metabolite KEGG:C01341 E-64 generic -metabolite KEGG:C01342 NH4+ generic -metabolite KEGG:C01343 Alkylmercury generic -metabolite KEGG:C01344 dIDP generic -metabolite KEGG:C01345 dITP generic -metabolite KEGG:C01346 dUDP generic -metabolite KEGG:C01347 dXDP generic -metabolite KEGG:C01348 dXTP generic -metabolite KEGG:C01349 AA861 generic -metabolite KEGG:C01352 FADH2 generic -metabolite KEGG:C01353 Carbonic acid generic -metabolite KEGG:C01355 Fructan generic -metabolite KEGG:C01356 Lipid generic -metabolite KEGG:C01358 NH4OH generic -metabolite KEGG:C01359 PQQH2 generic -metabolite KEGG:C01362 Ricin generic -metabolite KEGG:C01365 X-Trp generic -metabolite KEGG:C01367 3'-AMP generic -metabolite KEGG:C01368 3'-UMP generic -metabolite KEGG:C01370 Aldose generic -metabolite KEGG:C01371 Alkane generic -metabolite KEGG:C01372 Alkene generic -metabolite KEGG:C01375 Tacrolimus generic -metabolite KEGG:C01378 Fustin generic -metabolite KEGG:C01380 Ethylene glycol generic -metabolite KEGG:C01382 Iodine generic -metabolite KEGG:C01384 Maleic acid generic -metabolite KEGG:C01386 NH2Mec generic -metabolite KEGG:C01387 Octane generic -metabolite KEGG:C01389 Phytol generic -metabolite KEGG:C01390 Prenol generic -metabolite KEGG:C01392 alpha-Tubulin generic -metabolite KEGG:C01394 Xylose generic -metabolite KEGG:C01397 Arachidonyltrifluoromethane generic -metabolite KEGG:C01398 Acyloin generic -metabolite KEGG:C01399 Agarose generic -metabolite KEGG:C01401 Alanine generic -metabolite KEGG:C01402 Anilide generic -metabolite KEGG:C01403 Anisole generic -metabolite KEGG:C01404 Arg-OEt generic -metabolite KEGG:C01405 Aspirin generic -metabolite KEGG:C01407 Benzene generic -metabolite KEGG:C01408 Benzoin generic -metabolite KEGG:C01410 Boc-Asn generic -metabolite KEGG:C01411 Borneol generic -metabolite KEGG:C01412 Butanal generic -metabolite KEGG:C01413 Cadmium generic -metabolite KEGG:C01414 Casbene generic -metabolite KEGG:C01416 Cocaine generic -metabolite KEGG:C01417 Cyanate generic -metabolite KEGG:C01418 Cycasin generic -metabolite KEGG:C01419 Cys-Gly generic -metabolite KEGG:C01420 Cystine generic -metabolite KEGG:C01421 Daphnin generic -metabolite KEGG:C01424 Gallate generic -metabolite KEGG:C01425 Glutamyl-glutamic acid generic -metabolite KEGG:C01432 Lactate generic -metabolite KEGG:C01433 Loganin generic -metabolite KEGG:C01438 Methane generic -metabolite KEGG:C01441 Neamine generic -metabolite KEGG:C01443 Ouabain generic -metabolite KEGG:C01444 Oxamate generic -metabolite KEGG:C01445 Poly(G) generic -metabolite KEGG:C01448 Questin generic -metabolite KEGG:C01449 Queuine generic -metabolite KEGG:C01450 Ketone generic -metabolite KEGG:C01451 Salicin generic -metabolite KEGG:C01452 Sorbose generic -metabolite KEGG:C01453 Tacrine generic -metabolite KEGG:C01454 Toluate generic -metabolite KEGG:C01455 Toluene generic -metabolite KEGG:C01456 Tropate generic -metabolite KEGG:C01457 Tylosin generic -metabolite KEGG:C01458 Tyr-OEt generic -metabolite KEGG:C01460 Vitexin generic -metabolite KEGG:C01464 Xanthan generic -metabolite KEGG:C01467 3-Cresol generic -metabolite KEGG:C01468 4-Cresol generic -metabolite KEGG:C01469 ADP-sugar generic -metabolite KEGG:C01470 Acacetin generic -metabolite KEGG:C01471 Acrolein generic -metabolite KEGG:C01474 Alizarin generic -metabolite KEGG:C01477 Apigenin generic -metabolite KEGG:C01478 Arsenic acid generic -metabolite KEGG:C01479 Atropine generic -metabolite KEGG:C01481 Caffeate generic -metabolite KEGG:C01484 Chalcone generic -metabolite KEGG:C01485 Chloric acid generic -metabolite KEGG:C01486 Chlorous acid generic -metabolite KEGG:C01487 D-Allose generic -metabolite KEGG:C01488 D-Apiose generic -metabolite KEGG:C01489 D-Iditol generic -metabolite KEGG:C01490 Dermatan generic -metabolite KEGG:C01491 Factor H generic -metabolite KEGG:C01493 Farnesol generic -metabolite KEGG:C01494 Ferulate generic -metabolite KEGG:C01495 Flavonol generic -metabolite KEGG:C01496 Fructose generic -metabolite KEGG:C01498 Gelatine generic -metabolite KEGG:C01499 Geranial generic -metabolite KEGG:C01500 Geraniol generic -metabolite KEGG:C01501 Glucagon generic -metabolite KEGG:C01502 o-Methoxyphenol generic -metabolite KEGG:C01504 Indanone generic -metabolite KEGG:C01505 Kallidin generic -metabolite KEGG:C01506 L-Glycol generic -metabolite KEGG:C01507 L-Iditol generic -metabolite KEGG:C01508 L-Lyxose generic -metabolite KEGG:C01510 L-Xylose generic -metabolite KEGG:C01512 Loganate generic -metabolite KEGG:C01513 Lupinate generic -metabolite KEGG:C01514 Luteolin generic -metabolite KEGG:C01516 Morphine generic -metabolite KEGG:C01517 Naproxen generic -metabolite KEGG:C01518 Nigerose generic -metabolite KEGG:C01520 Pachyman generic -metabolite KEGG:C01523 Pregnane generic -metabolite KEGG:C01525 R'C(R)SH generic -metabolite KEGG:C01526 Ricinine generic -metabolite KEGG:C01527 Scopolin generic -metabolite KEGG:C01528 Hydrogen selenide generic -metabolite KEGG:C01529 Selenium generic -metabolite KEGG:C01530 Octadecanoic acid generic -metabolite KEGG:C01531 Sulindac generic -metabolite KEGG:C01533 Syringin generic -metabolite KEGG:C01536 Tyrosine generic -metabolite KEGG:C01537 Urethane generic -metabolite KEGG:C01540 Viomycin generic -metabolite KEGG:C01541 Warfarin generic -metabolite KEGG:C01542 o-Cresol generic -metabolite KEGG:C01545 1-Octanal generic -metabolite KEGG:C01546 2-Furoate generic -metabolite KEGG:C01547 ADP-aldose generic -metabolite KEGG:C01548 Acetylene generic -metabolite KEGG:C01550 Agaritine generic -metabolite KEGG:C01551 Allantoin generic -metabolite KEGG:C01552 Amastatin generic -metabolite KEGG:C01553 Amsacrine generic -metabolite KEGG:C01554 5alpha-Androstane generic -metabolite KEGG:C01555 Apramycin generic -metabolite KEGG:C01557 Bergapten generic -metabolite KEGG:C01558 Bile salt generic -metabolite KEGG:C01559 Butirosin generic -metabolite KEGG:C01561 Calcidiol generic -metabolite KEGG:C01562 Calycosin generic -metabolite KEGG:C01563 Carbamate generic -metabolite KEGG:C01564 Cetraxate generic -metabolite KEGG:C01566 Cyanamide generic -metabolite KEGG:C01567 Cytomycin generic -metabolite KEGG:C01569 D-Apiitol generic -metabolite KEGG:C01570 D-Leucine generic -metabolite KEGG:C01571 Decanoic acid generic -metabolite KEGG:C01572 Digallate generic -metabolite KEGG:C01573 Peptide diphthine generic -metabolite KEGG:C01574 Dynorphin generic -metabolite KEGG:C01575 Ephedrine generic -metabolite KEGG:C01576 Etoposide generic -metabolite KEGG:C01579 Flavonoid generic -metabolite KEGG:C01581 GDPhexose generic -metabolite KEGG:C01582 Galactose generic -metabolite KEGG:C01585 Hexanoic acid generic -metabolite KEGG:C01586 Hippurate generic -metabolite KEGG:C01588 Ibuprofen generic -metabolite KEGG:C01589 Imidazole generic -metabolite KEGG:C01590 Kievitone generic -metabolite KEGG:C01591 Leupeptin generic -metabolite KEGG:C01592 Licodione generic -metabolite KEGG:C01593 Limonoate generic -metabolite KEGG:C01594 Linamarin generic -metabolite KEGG:C01595 Linoleate generic -metabolite KEGG:C01596 Maleamate generic -metabolite KEGG:C01598 Melatonin generic -metabolite KEGG:C01599 NDP-aldose generic -metabolite KEGG:C01600 NDP-hexose generic -metabolite KEGG:C01601 Nonanoic acid generic -metabolite KEGG:C01602 Ornithine generic -metabolite KEGG:C01604 Phlorizin generic -metabolite KEGG:C01606 Phthalate generic -metabolite KEGG:C01607 Phytanate generic -metabolite KEGG:C01608 Piroxicam generic -metabolite KEGG:C01609 Protamine generic -metabolite KEGG:C01610 Puromycin generic -metabolite KEGG:C01612 Secondary alcohol generic -metabolite KEGG:C01613 Stachyose generic -metabolite KEGG:C01614 Sulfamate generic -metabolite KEGG:C01615 Sulfinate generic -metabolite KEGG:C01616 Tauropine generic -metabolite KEGG:C01617 Taxifolin generic -metabolite KEGG:C01618 Testolate generic -metabolite KEGG:C01619 Thiorphan generic -metabolite KEGG:C01620 Threonate generic -metabolite KEGG:C01621 Tolrestat generic -metabolite KEGG:C01623 UDP-apiose generic -metabolite KEGG:C01624 Vermelone generic -metabolite KEGG:C01625 Vicianose generic -metabolite KEGG:C01626 Vindoline generic -metabolite KEGG:C01628 Vitamin K generic -metabolite KEGG:C01629 Wax ester generic -metabolite KEGG:C01630 Xylobiose generic -metabolite KEGG:C01632 N-Carbobenzoxyglycylproline generic -metabolite KEGG:C01633 1-Decanol generic -metabolite KEGG:C01635 tRNA(Ala) generic -metabolite KEGG:C01636 tRNA(Arg) generic -metabolite KEGG:C01637 tRNA(Asn) generic -metabolite KEGG:C01638 tRNA(Asp) generic -metabolite KEGG:C01639 tRNA(Cys) generic -metabolite KEGG:C01640 tRNA(Gln) generic -metabolite KEGG:C01641 tRNA(Glu) generic -metabolite KEGG:C01642 tRNA(Gly) generic -metabolite KEGG:C01643 tRNA(His) generic -metabolite KEGG:C01644 tRNA(Ile) generic -metabolite KEGG:C01645 tRNA(Leu) generic -metabolite KEGG:C01646 tRNA(Lys) generic -metabolite KEGG:C01647 tRNA(Met) generic -metabolite KEGG:C01648 tRNA(Phe) generic -metabolite KEGG:C01649 tRNA(Pro) generic -metabolite KEGG:C01650 tRNA(Ser) generic -metabolite KEGG:C01651 tRNA(Thr) generic -metabolite KEGG:C01652 tRNA(Trp) generic -metabolite KEGG:C01653 tRNA(Val) generic -metabolite KEGG:C01654 1,6-Mannan generic -metabolite KEGG:C01655 2-AminoAMP generic -metabolite KEGG:C01656 3-Oxo acid generic -metabolite KEGG:C01657 Ac-Tyr-OEt generic -metabolite KEGG:C01658 Acid amide generic -metabolite KEGG:C01659 Acrylamide generic -metabolite KEGG:C01661 Doxorubicin generic -metabolite KEGG:C01663 Alkylamide generic -metabolite KEGG:C01664 Alkylamine generic -metabolite KEGG:C01667 Bacitracin generic -metabolite KEGG:C01670 Bz-Arg-OEt generic -metabolite KEGG:C01672 Cadaverine generic -metabolite KEGG:C01673 Calcitriol generic -metabolite KEGG:C01674 Chitobiose generic -metabolite KEGG:C01675 Cilastatin generic -metabolite KEGG:C01677 Coformycin generic -metabolite KEGG:C01678 Cysteamine generic -metabolite KEGG:C01680 D-Fuconate generic -metabolite KEGG:C01682 Nopaline generic -metabolite KEGG:C01683 Ornaline generic -metabolite KEGG:C01684 D-Rhamnose generic -metabolite KEGG:C01685 D-Ribonate generic -metabolite KEGG:C01687 Tylosin B generic -metabolite KEGG:C01688 Destomysin generic -metabolite KEGG:C01690 Diclofenac generic -metabolite KEGG:C01691 Diflunisal generic -metabolite KEGG:C01692 Disulfiram generic -metabolite KEGG:C01693 L-Dopachrome generic -metabolite KEGG:C01694 Ergosterol generic -metabolite KEGG:C01695 Ferredoxin generic -metabolite KEGG:C01697 Galactitol generic -metabolite KEGG:C01698 Galactogen generic -metabolite KEGG:C01699 Gibberellin A3 generic -metabolite KEGG:C01700 Globomycin generic -metabolite KEGG:C01701 (-)-Glyceollin I generic -metabolite KEGG:C01702 Glycogenin generic -metabolite KEGG:C01705 Glyphosate generic -metabolite KEGG:C01706 Haloalkene generic -metabolite KEGG:C01707 Hemiacetal generic -metabolite KEGG:C01708 Hemoglobin generic -metabolite KEGG:C01709 Hesperetin generic -metabolite KEGG:C01710 Indan-1-ol generic -metabolite KEGG:C01711 Inulobiose generic -metabolite KEGG:C01712 (9E)-Octadecenoic acid generic -metabolite KEGG:C01714 Isovitexin generic -metabolite KEGG:C01715 Kallikrein generic -metabolite KEGG:C01716 Ketoprofen generic -metabolite KEGG:C01717 4-Hydroxy-2-quinolinecarboxylic acid generic -metabolite KEGG:C01718 Kynurenine generic -metabolite KEGG:C01719 L-Fructose generic -metabolite KEGG:C01720 L-Fuconate generic -metabolite KEGG:C01721 L-Fuculose generic -metabolite KEGG:C01722 L-Glucitol generic -metabolite KEGG:C01723 Lactenocin generic -metabolite KEGG:C01724 Lanosterol generic -metabolite KEGG:C01725 Levanbiose generic -metabolite KEGG:C01726 D-Lombricine generic -metabolite KEGG:C01727 Lumichrome generic -metabolite KEGG:C01728 Mannobiose generic -metabolite KEGG:C01729 (+)-Medicarpin generic -metabolite KEGG:C01731 Mercury mercaptide generic -metabolite KEGG:C01732 Mesaconate generic -metabolite KEGG:C01733 Methionine generic -metabolite KEGG:C01735 Morphinone generic -metabolite KEGG:C01736 Nebularine generic -metabolite KEGG:C01737 Neomycin B generic -metabolite KEGG:C01739 Nocardicin E generic -metabolite KEGG:C01740 Octylamine generic -metabolite KEGG:C01742 Palatinose generic -metabolite KEGG:C01743 Paromamine generic -metabolite KEGG:C01744 Phloretate generic -metabolite KEGG:C01745 Pinosylvin generic -metabolite KEGG:C01746 Piperidine generic -metabolite KEGG:C01747 Psychosine generic -metabolite KEGG:C01748 Pyocyanine generic -metabolite KEGG:C01750 Quercitrin generic -metabolite KEGG:C01751 Resorcinol generic -metabolite KEGG:C01752 Scopoletin generic -metabolite KEGG:C01753 beta-Sitosterol generic -metabolite KEGG:C01754 Spiramycin generic -metabolite KEGG:C01755 Thiocyanate generic -metabolite KEGG:C01756 Thiopurine generic -metabolite KEGG:C01757 Triacetate generic -metabolite KEGG:C01759 Ribostamycin generic -metabolite KEGG:C01760 (6S,9R)-Vomifoliol generic -metabolite KEGG:C01761 Vomilenine generic -metabolite KEGG:C01762 Xanthosine generic -metabolite KEGG:C01764 tRNA containing uridine at position 54 generic -metabolite KEGG:C01765 (+)-Borneol generic -metabolite KEGG:C01766 (-)-Borneol generic -metabolite KEGG:C01767 (-)-Carvone generic -metabolite KEGG:C01768 (Alginate)n generic -metabolite KEGG:C01769 (S)-Acetoin generic -metabolite KEGG:C01770 gamma-Butyrolactone generic -metabolite KEGG:C01771 2-Butenoate generic -metabolite KEGG:C01772 trans-2-Hydroxycinnamate generic -metabolite KEGG:C01775 Actinomycin generic -metabolite KEGG:C01776 Aculeacin A generic -metabolite KEGG:C01777 Acylcholine generic -metabolite KEGG:C01779 Albendazole generic -metabolite KEGG:C01780 Aldosterone generic -metabolite KEGG:C01782 Arene oxide generic -metabolite KEGG:C01783 Arylmercury generic -metabolite KEGG:C01784 Benzamidine generic -metabolite KEGG:C01785 Benzenediol generic -metabolite KEGG:C01788 CDP-abequose generic -metabolite KEGG:C01789 Campesterol generic -metabolite KEGG:C01790 Capreomycin generic -metabolite KEGG:C01792 Chlordecone generic -metabolite KEGG:C01793 Chlorophyll generic -metabolite KEGG:C01794 Choloyl-CoA generic -metabolite KEGG:C01795 Columbamine generic -metabolite KEGG:C01796 D-Erythrose generic -metabolite KEGG:C01798 D-Glucoside generic -metabolite KEGG:C01799 D-Norvaline generic -metabolite KEGG:C01800 Deazaflavin generic -metabolite KEGG:C01801 Deoxyribose generic -metabolite KEGG:C01802 Desmosterol generic -metabolite KEGG:C01804 Discadenine generic -metabolite KEGG:C01806 GTP-gamma-S generic -metabolite KEGG:C01810 Glucomannan generic -metabolite KEGG:C01812 Haloacetate generic -metabolite KEGG:C01813 Haloalcohol generic -metabolite KEGG:C01814 Haloperidol generic -metabolite KEGG:C01816 Heptadecane generic -metabolite KEGG:C01817 L-Homocystine generic -metabolite KEGG:C01818 Hyponitrite generic -metabolite KEGG:C01819 Indoleamine generic -metabolite KEGG:C01821 Isoorientin generic -metabolite KEGG:C01822 Kanamycin A generic -metabolite KEGG:C01823 Kanamycin C generic -metabolite KEGG:C01825 L-Galactose generic -metabolite KEGG:C01826 L-Norvaline generic -metabolite KEGG:C01829 Thyroxine generic -metabolite KEGG:C01832 Lauroyl-CoA generic -metabolite KEGG:C01833 Leu-Gly-Pro generic -metabolite KEGG:C01834 Lipoprotein generic -metabolite KEGG:C01835 Maltotriose generic -metabolite KEGG:C01836 Neurotensin generic -metabolite KEGG:C01837 Nitroethane generic -metabolite KEGG:C01838 Octadecanal generic -metabolite KEGG:C01839 Orsellinate generic -metabolite KEGG:C01841 Pentalenene generic -metabolite KEGG:C01842 Pentanamide generic -metabolite KEGG:C01843 Polyproline generic -metabolite KEGG:C01844 Pravastatin generic -metabolite KEGG:C01845 Propan-2-ol generic -metabolite KEGG:C01847 Reduced FMN generic -metabolite KEGG:C01848 Rifamycin B generic -metabolite KEGG:C01849 Rifamycin O generic -metabolite KEGG:C01850 Rosmarinate generic -metabolite KEGG:C01851 Scopolamine generic -metabolite KEGG:C01852 Secologanin generic -metabolite KEGG:C01853 Stipitatate generic -metabolite KEGG:C01854 Streptamine generic -metabolite KEGG:C01855 Taxiphyllin generic -metabolite KEGG:C01857 Thioacetate generic -metabolite KEGG:C01860 Trichodiene generic -metabolite KEGG:C01861 Trithionate generic -metabolite KEGG:C01863 Xanthoaphin generic -metabolite KEGG:C01864 Xanthotoxin generic -metabolite KEGG:C01865 Zopolrestat generic -metabolite KEGG:C01866 beta-Lactam generic -metabolite KEGG:C01867 tau-Protein generic -metabolite KEGG:C01868 (+)-Sabinone generic -metabolite KEGG:C01869 (-)-Sympatol generic -metabolite KEGG:C01870 Vicianin generic -metabolite KEGG:C01871 1,4-Dithiane generic -metabolite KEGG:C01872 1-Haloalkane generic -metabolite KEGG:C01874 2-Iodophenol generic -metabolite KEGG:C01875 2-Undecanone generic -metabolite KEGG:C01876 3-Oxosteroid generic -metabolite KEGG:C01877 4-Oxoproline generic -metabolite KEGG:C01879 5-Oxoproline generic -metabolite KEGG:C01880 epsilon-Caprolactone generic -metabolite KEGG:C01881 7-Oxosteroid generic -metabolite KEGG:C01882 ADP-D-ribose generic -metabolite KEGG:C01883 Acetic ester generic -metabolite KEGG:C01884 Acyldolichol generic -metabolite KEGG:C01885 1-Acylglycerol generic -metabolite KEGG:C01887 Alkylnitrile generic -metabolite KEGG:C01888 Aminoacetone generic -metabolite KEGG:C01889 Arabinoxylan generic -metabolite KEGG:C01890 Arylalkylamine generic -metabolite KEGG:C01892 Asparagusate generic -metabolite KEGG:C01893 Biotin amide generic -metabolite KEGG:C01894 Biotinyl-CoA generic -metabolite KEGG:C01895 Bleomycin B2 generic -metabolite KEGG:C01897 Camptothecin generic -metabolite KEGG:C01898 Cellodextrin generic -metabolite KEGG:C01901 Cucurbitacin generic -metabolite KEGG:C01902 Cycloartenol generic -metabolite KEGG:C01904 D-Arabitol generic -metabolite KEGG:C01905 D-Asparagine generic -metabolite KEGG:C01906 D-Hamamelose generic -metabolite KEGG:C01907 Daunorubicin generic -metabolite KEGG:C01909 Dethiobiotin generic -metabolite KEGG:C01910 Dinucleotide generic -metabolite KEGG:C01912 Erythromycin generic -metabolite KEGG:C01913 Ferrocyanide generic -metabolite KEGG:C01915 Galactolipid generic -metabolite KEGG:C01917 Gentamicin A generic -metabolite KEGG:C01918 Gentamicin C generic -metabolite KEGG:C01920 Geranoyl-CoA generic -metabolite KEGG:C01921 Glycocholate generic -metabolite KEGG:C01923 Heteroglycan generic -metabolite KEGG:C01924 Homoarginine generic -metabolite KEGG:C01925 Hygromycin B generic -metabolite KEGG:C01926 Indomethacin generic -metabolite KEGG:C01927 Isoflavanone generic -metabolite KEGG:C01928 Ketoaldehyde generic -metabolite KEGG:C01929 L-Histidinal generic -metabolite KEGG:C01930 L-Lysinamide generic -metabolite KEGG:C01931 L-Lysyl-tRNA generic -metabolite KEGG:C01933 L-Norleucine generic -metabolite KEGG:C01934 L-Rhamnonate generic -metabolite KEGG:C01935 Maltodextrin generic -metabolite KEGG:C01936 Maltohexaose generic -metabolite KEGG:C01937 Methotrexate generic -metabolite KEGG:C01938 Naphthazarin generic -metabolite KEGG:C01941 Nocardicin A generic -metabolite KEGG:C01942 Nonanoyl-CoA generic -metabolite KEGG:C01943 Obtusifoliol generic -metabolite KEGG:C01944 Octanoyl-CoA generic -metabolite KEGG:C01945 Okadaic acid generic -metabolite KEGG:C01946 Oleandomycin generic -metabolite KEGG:C01948 Pentadecanal generic -metabolite KEGG:C01949 Pentan-2-one generic -metabolite KEGG:C01950 Picolinamide generic -metabolite KEGG:C01951 Piperitenone generic -metabolite KEGG:C01952 Polyarginine generic -metabolite KEGG:C01953 Pregnenolone generic -metabolite KEGG:C01956 Pyrazinamide generic -metabolite KEGG:C01957 Secologanate generic -metabolite KEGG:C01958 Steryl ester generic -metabolite KEGG:C01959 Taurocyamine generic -metabolite KEGG:C01960 Tetrapeptide generic -metabolite KEGG:C01961 Thalassemine generic -metabolite KEGG:C01962 Thiocysteine generic -metabolite KEGG:C01963 Tolylacetate generic -metabolite KEGG:C01964 Tos-Ph-CH2Cl generic -metabolite KEGG:C01965 Trimethoprim generic -metabolite KEGG:C01967 Ubiquinone-9 generic -metabolite KEGG:C01968 Undecaprenol generic -metabolite KEGG:C01969 Xanthommatin generic -metabolite KEGG:C01970 beta-Lactose generic -metabolite KEGG:C01971 beta-Maltose generic -metabolite KEGG:C01972 m7G(5')pppAm-mRNA generic -metabolite KEGG:C01977 tRNA guanine generic -metabolite KEGG:C01978 tRNA queuine generic -metabolite KEGG:C01983 (R)-Mandelate generic -metabolite KEGG:C01984 (S)-Mandelate generic -metabolite KEGG:C01985 11-Oxosteroid generic -metabolite KEGG:C01986 16-Oxosteroid generic -metabolite KEGG:C01987 2-Aminophenol generic -metabolite KEGG:C01988 2-Nitrophenol generic -metabolite KEGG:C01989 3-Ethylmalate generic -metabolite KEGG:C01990 3-Oxalomalate generic -metabolite KEGG:C01991 4-Hydroxyacid generic -metabolite KEGG:C01993 5'-Oxoinosine generic -metabolite KEGG:C01995 Acetone oxime generic -metabolite KEGG:C01996 Acetylcholine generic -metabolite KEGG:C01997 Histone N6-acetyl-L-lysine generic -metabolite KEGG:C01998 Acrylonitrile generic -metabolite KEGG:C02000 Alkyl sulfate generic -metabolite KEGG:C02001 Allyl alcohol generic -metabolite KEGG:C02002 C3a anaphylatoxin generic -metabolite KEGG:C02003 Anthocyanidin generic -metabolite KEGG:C02004 Aristolochene generic -metabolite KEGG:C02006 Aspulvinone E generic -metabolite KEGG:C02007 Aspulvinone G generic -metabolite KEGG:C02008 Aspulvinone H generic -metabolite KEGG:C02009 Benzimidazole generic -metabolite KEGG:C02010 Blasticidin S generic -metabolite KEGG:C02012 Catecholamine generic -metabolite KEGG:C02013 Cellotetraose generic -metabolite KEGG:C02015 CoA-disulfide generic -metabolite KEGG:C02017 Corticotropin generic -metabolite KEGG:C02018 Cyanopyrazine generic -metabolite KEGG:C02020 Cyclopentanol generic -metabolite KEGG:C02021 Cytochrome c1 generic -metabolite KEGG:C02022 D-Erythrulose generic -metabolite KEGG:C02023 D-Galactoside generic -metabolite KEGG:C02024 D-Mannuronate generic -metabolite KEGG:C02026 Deoxycytosine generic -metabolite KEGG:C02027 Deoxylimonate generic -metabolite KEGG:C02028 Dicarboxylate generic -metabolite KEGG:C02029 Dihydrozeatin generic -metabolite KEGG:C02030 Farnesoyl-CoA generic -metabolite KEGG:C02031 G(5')pppPur-mRNA generic -metabolite KEGG:C02033 Gentamicin C2 generic -metabolite KEGG:C02034 Gibberellin A19 generic -metabolite KEGG:C02035 Gibberellin A20 generic -metabolite KEGG:C02037 Glycylglycine generic -metabolite KEGG:C02038 N-Terminal-glycyl-[protein] generic -metabolite KEGG:C02040 Hydroxyindole generic -metabolite KEGG:C02041 Eicosanoyl-CoA generic -metabolite KEGG:C02043 Indolelactate generic -metabolite KEGG:C02045 L-Erythrulose generic -metabolite KEGG:C02046 L-Hyoscyamine generic -metabolite KEGG:C02047 L-Leucyl-tRNA generic -metabolite KEGG:C02048 Laminaribiose generic -metabolite KEGG:C02049 Limit dextrin generic -metabolite KEGG:C02050 Linoleoyl-CoA generic -metabolite KEGG:C02051 Lipoylprotein generic -metabolite KEGG:C02052 Maltotetraose generic -metabolite KEGG:C02055 N-Acylglycine generic -metabolite KEGG:C02056 Peptidyl-tRNA generic -metabolite KEGG:C02057 Phenylalanine generic -metabolite KEGG:C02058 Phosphoramide generic -metabolite KEGG:C02059 Phylloquinone generic -metabolite KEGG:C02060 Phytanoyl-CoA generic -metabolite KEGG:C02061 Plastoquinone generic -metabolite KEGG:C02064 Prostanoic acid generic -metabolite KEGG:C02065 Protein alanine generic -metabolite KEGG:C02066 Pseudotropine generic -metabolite KEGG:C02067 Pseudouridine generic -metabolite KEGG:C02069 Putidaredoxin generic -metabolite KEGG:C02072 RNA (poly(C)) generic -metabolite KEGG:C02073 RNA(circular) generic -metabolite KEGG:C02074 Raucaffricine generic -metabolite KEGG:C02075 Retinyl ester generic -metabolite KEGG:C02076 Sedoheptulose generic -metabolite KEGG:C02077 Semicarbazide generic -metabolite KEGG:C02078 Spectinomycin generic -metabolite KEGG:C02079 Staurosporine generic -metabolite KEGG:C02080 Stipitatonate generic -metabolite KEGG:C02081 Streptonigrin generic -metabolite KEGG:C02083 Styrene oxide generic -metabolite KEGG:C02084 Tetrathionate generic -metabolite KEGG:C02085 Thioglucoside generic -metabolite KEGG:C02086 Thioglycolate generic -metabolite KEGG:C02087 Tos-Arg-CH2Cl generic -metabolite KEGG:C02088 Tos-Phe-CH2Cl generic -metabolite KEGG:C02089 O-Acyltropine generic -metabolite KEGG:C02090 Trypanothione generic -metabolite KEGG:C02091 (S)-Ureidoglycine generic -metabolite KEGG:C02094 beta-Carotene generic -metabolite KEGG:C02095 beta-D-Fucose generic -metabolite KEGG:C02096 beta-D-Xylose generic -metabolite KEGG:C02097 dTDP-galactose generic -metabolite KEGG:C02099 (2S)-Flavanone generic -metabolite KEGG:C02100 (5')ppPur-mRNA generic -metabolite KEGG:C02101 Glucomannan longer by one mannose unit generic -metabolite KEGG:C02103 (S)-2-Haloacid generic -metabolite KEGG:C02104 (S)-Mevalonate generic -metabolite KEGG:C02105 (S)-Reticuline generic -metabolite KEGG:C02106 (S)-Scoulerine generic -metabolite KEGG:C02107 (S,S)-Tartaric acid generic -metabolite KEGG:C02108 1,2-Campholide generic -metabolite KEGG:C02110 11-cis-Retinal generic -metabolite KEGG:C02111 2,4-Dioxo acid generic -metabolite KEGG:C02112 2-Acylglycerol generic -metabolite KEGG:C02115 2-Methylserine generic -metabolite KEGG:C02116 2-Nitropropane generic -metabolite KEGG:C02117 2-Oxophytanate generic -metabolite KEGG:C02118 3,5-Dioxo acid generic -metabolite KEGG:C02119 3-Acylpyruvate generic -metabolite KEGG:C02122 3-Oxohexanoic acid generic -metabolite KEGG:C02123 3-Propylmalate generic -metabolite KEGG:C02124 4-Chlorophenol generic -metabolite KEGG:C02125 4-Nitroanilide generic -metabolite KEGG:C02126 4-Nitroaniline generic -metabolite KEGG:C02128 5'-Phospho-DNA generic -metabolite KEGG:C02129 5-Oxohexanoic acid generic -metabolite KEGG:C02130 Acetyl-maltose generic -metabolite KEGG:C02131 Acetylagmatine generic -metabolite KEGG:C02132 Acetylpyruvate generic -metabolite KEGG:C02133 Acyl phosphate generic -metabolite KEGG:C02134 Allocryptopine generic -metabolite KEGG:C02135 Angiotensin II generic -metabolite KEGG:C02137 alpha-Oxo-benzeneacetic acid generic -metabolite KEGG:C02138 Boc-Asn-OPhNO2 generic -metabolite KEGG:C02139 Chlorophyllide generic -metabolite KEGG:C02140 Corticosterone generic -metabolite KEGG:C02141 Cycloeucalenol generic -metabolite KEGG:C02142 D-Ribosyl-base generic -metabolite KEGG:C02143 D-threo-Aldose generic -metabolite KEGG:C02144 Dehydropeptide generic -metabolite KEGG:C02146 Dialkyl ketone generic -metabolite KEGG:C02147 Dihydrolipoate generic -metabolite KEGG:C02150 Formylpyruvate generic -metabolite KEGG:C02151 Geissoschizine generic -metabolite KEGG:C02153 Glucotropaeolin generic -metabolite KEGG:C02154 Glyceraldehyde generic -metabolite KEGG:C02155 Glycyl-leucine generic -metabolite KEGG:C02159 Hydroxysteroid generic -metabolite KEGG:C02160 Isomaltotriose generic -metabolite KEGG:C02161 2-Aminophenoxazin-3-one generic -metabolite KEGG:C02162 Isopimpinellin generic -metabolite KEGG:C02163 L-Arginyl-tRNA(Arg) generic -metabolite KEGG:C02165 Leukotriene B4 generic -metabolite KEGG:C02166 Leukotriene C4 generic -metabolite KEGG:C02167 Maleylpyruvate generic -metabolite KEGG:C02168 Mefenamic acid generic -metabolite KEGG:C02170 Methylmalonate generic -metabolite KEGG:C02171 Mononucleotide generic -metabolite KEGG:C02172 N-Acetylisatin generic -metabolite KEGG:C02173 N-Acylmuramate generic -metabolite KEGG:C02174 Oligophosphate generic -metabolite KEGG:C02179 Peptidyl amide generic -metabolite KEGG:C02180 Phenylsulfate generic -metabolite KEGG:C02181 Phenoxyacetate generic -metabolite KEGG:C02183 Phloroglucinol generic -metabolite KEGG:C02185 Plastoquinol-1 generic -metabolite KEGG:C02186 Prolyl-peptide generic -metabolite KEGG:C02188 Protein lysine generic -metabolite KEGG:C02189 [Protein]-L-serine generic -metabolite KEGG:C02191 Protoporphyrin generic -metabolite KEGG:C02193 Pyruvate oxime generic -metabolite KEGG:C02195 Steryl sulfate generic -metabolite KEGG:C02196 Tertiary amine generic -metabolite KEGG:C02197 Testolactone generic -metabolite KEGG:C02198 Thromboxane A2 generic -metabolite KEGG:C02199 UDP-L-rhamnose generic -metabolite KEGG:C02200 UDP-glucosamine generic -metabolite KEGG:C02201 Veratraldehyde generic -metabolite KEGG:C02202 Z-Phe-Phe-CHN2 generic -metabolite KEGG:C02203 Z-Tyr-Leu-NHOH generic -metabolite KEGG:C02204 alpha-D-Lyxose generic -metabolite KEGG:C02205 alpha-D-Xylose generic -metabolite KEGG:C02206 alpha-Santonin generic -metabolite KEGG:C02207 beta-Alanopine generic -metabolite KEGG:C02209 beta-D-Mannose generic -metabolite KEGG:C02210 beta-Endorphin generic -metabolite KEGG:C02211 tRNA precursor generic -metabolite KEGG:C02213 (+)-cis-Sabinol generic -metabolite KEGG:C02214 (E)-Glutaconate generic -metabolite KEGG:C02216 1-Methyladenine generic -metabolite KEGG:C02217 10-Oxodecanoate generic -metabolite KEGG:C02218 Dehydroalanine generic -metabolite KEGG:C02220 2-Aminomuconate generic -metabolite KEGG:C02221 2-Cyanopyridine generic -metabolite KEGG:C02222 2-Maleylacetate generic -metabolite KEGG:C02223 2-Methylbutanal generic -metabolite KEGG:C02224 2-Methylcholine generic -metabolite KEGG:C02225 2-Methylcitrate generic -metabolite KEGG:C02226 2-Methylmaleate generic -metabolite KEGG:C02227 2-Naphthylamine generic -metabolite KEGG:C02230 3-Methylguanine generic -metabolite KEGG:C02231 3-Nitroacrylate generic -metabolite KEGG:C02232 3-Oxoadipyl-CoA generic -metabolite KEGG:C02233 3-Oxopentanoic acid generic -metabolite KEGG:C02234 4-Cyanopyridine generic -metabolite KEGG:C02235 4-Nitrocatechol generic -metabolite KEGG:C02236 4-Sulfobenzoate generic -metabolite KEGG:C02237 5-Oxo-D-proline generic -metabolite KEGG:C02240 5-Valerolactone generic -metabolite KEGG:C02241 7-Methyladenine generic -metabolite KEGG:C02242 7-Methylguanine generic -metabolite KEGG:C02243 8-Oxocoformycin generic -metabolite KEGG:C02244 Aliphatic amide generic -metabolite KEGG:C02245 Alkyl sulfenate generic -metabolite KEGG:C02246 Angiotensinogen generic -metabolite KEGG:C02247 Anthraniloyl-CoA generic -metabolite KEGG:C02248 Apocytochrome c generic -metabolite KEGG:C02249 Arachidonyl-CoA generic -metabolite KEGG:C02252 Arylhydroxamate generic -metabolite KEGG:C02253 Benzoylagmatine generic -metabolite KEGG:C02255 CDP-acylglycerol generic -metabolite KEGG:C02256 Castanospermine generic -metabolite KEGG:C02257 D-Glucan generic -metabolite KEGG:C02261 D-2-Aminobutyrate generic -metabolite KEGG:C02262 D-Galactosamine generic -metabolite KEGG:C02264 D-Glucose oxime generic -metabolite KEGG:C02265 D-Phenylalanine generic -metabolite KEGG:C02266 D-Xylonolactone generic -metabolite KEGG:C02267 Deoxycoformycin generic -metabolite KEGG:C02269 Deoxynucleoside generic -metabolite KEGG:C02270 Depurinated DNA generic -metabolite KEGG:C02271 Dichloromethane generic -metabolite KEGG:C02272 Diethyl sulfide generic -metabolite KEGG:C02273 Digalacturonate generic -metabolite KEGG:C02274 Dihydrocoumarin generic -metabolite KEGG:C02277 1-Dodecanol generic -metabolite KEGG:C02278 Dodecylaldehyde generic -metabolite KEGG:C02280 GDP-L-galactose generic -metabolite KEGG:C02282 Glutaminyl-tRNA generic -metabolite KEGG:C02283 Glycyrrhetinate generic -metabolite KEGG:C02284 Glycyrrhizinate generic -metabolite KEGG:C02287 Hydroxymalonate generic -metabolite KEGG:C02288 Reduced insulin generic -metabolite KEGG:C02289 Isopiperitenone generic -metabolite KEGG:C02290 L-Carnitinamide generic -metabolite KEGG:C02291 L-Cystathionine generic -metabolite KEGG:C02293 Latia luciferin generic -metabolite KEGG:C02294 Methylguanidine generic -metabolite KEGG:C02295 Methylitaconate generic -metabolite KEGG:C02297 N-Acetyldiamine generic -metabolite KEGG:C02298 N-Acetylindoxyl generic -metabolite KEGG:C02299 N-Methylaniline generic -metabolite KEGG:C02301 O-Acylcarnitine generic -metabolite KEGG:C02303 Peptidylglycine generic -metabolite KEGG:C02304 Phenylhydrazine generic -metabolite KEGG:C02305 Phosphocreatine generic -metabolite KEGG:C02306 Phosphoramidate generic -metabolite KEGG:C02307 Phosphorylase a generic -metabolite KEGG:C02308 Phosphorylase b generic -metabolite KEGG:C02311 Primary diamine generic -metabolite KEGG:C02314 Prostaglandin F2beta generic -metabolite KEGG:C02315 Protein dithiol generic -metabolite KEGG:C02318 R'C(R)S-S(R)CR' generic -metabolite KEGG:C02319 R-CHOH-CO-CH2OH generic -metabolite KEGG:C02320 R-S-Glutathione generic -metabolite KEGG:C02321 cis-1,4-Polyisoprene generic -metabolite KEGG:C02323 Salicyl alcohol generic -metabolite KEGG:C02324 Secondary amine generic -metabolite KEGG:C02325 Sinapyl alcohol generic -metabolite KEGG:C02327 Thiogalactoside generic -metabolite KEGG:C02328 Tolmetin sodium generic -metabolite KEGG:C02330 UDP-L-iduronate generic -metabolite KEGG:C02331 Vinylacetyl-CoA generic -metabolite KEGG:C02332 Vitamin A ester generic -metabolite KEGG:C02333 Xanthopterin-B2 generic -metabolite KEGG:C02334 Z-Arg-Arg-NHMec generic -metabolite KEGG:C02335 beta-Alanyl-CoA generic -metabolite KEGG:C02336 beta-D-Fructose generic -metabolite KEGG:C02337 beta-D-Xyloside generic -metabolite KEGG:C02338 beta-L-Rhamnose generic -metabolite KEGG:C02339 m7G(5')pppR-mRNA generic -metabolite KEGG:C02341 trans-Aconitate generic -metabolite KEGG:C02342 'Activated' tRNA generic -metabolite KEGG:C02343 (+)-Norephedrine generic -metabolite KEGG:C02344 (-)-endo-Fenchol generic -metabolite KEGG:C02345 (2S)-Flavan-4-ol generic -metabolite KEGG:C02347 Phosphomannan generic -metabolite KEGG:C02348 (R)(-)-Allantoin generic -metabolite KEGG:C02350 (S)-Allantoin generic -metabolite KEGG:C02351 o-Benzoquinone generic -metabolite KEGG:C02352 1,4-beta-D-Xylan generic -metabolite KEGG:C02353 2',3'-Cyclic AMP generic -metabolite KEGG:C02354 2',3'-Cyclic CMP generic -metabolite KEGG:C02355 2',3'-Cyclic UMP generic -metabolite KEGG:C02356 (S)-2-Aminobutanoate generic -metabolite KEGG:C02357 2-Chlorobenzoate generic -metabolite KEGG:C02359 2-Fluorobenzoate generic -metabolite KEGG:C02360 2-Hydroxyadipate generic -metabolite KEGG:C02362 2-Oxosuccinamate generic -metabolite KEGG:C02363 3-Ethoxybenzoate generic -metabolite KEGG:C02364 3-Fluorobenzoate generic -metabolite KEGG:C02366 3-Methyloxindole generic -metabolite KEGG:C02367 3-Oxododecanoic acid generic -metabolite KEGG:C02370 4-Chlorobenzoate generic -metabolite KEGG:C02371 4-Fluorobenzoate generic -metabolite KEGG:C02372 4-Hydroxyaniline generic -metabolite KEGG:C02373 4-Methylpentanal generic -metabolite KEGG:C02374 5'-Dephospho-DNA generic -metabolite KEGG:C02375 4-Chlorocatechol generic -metabolite KEGG:C02376 5-Methylcytosine generic -metabolite KEGG:C02377 5-Oxoprolyl-tRNA generic -metabolite KEGG:C02378 6-Aminohexanoate generic -metabolite KEGG:C02379 6-Hydroxymellein generic -metabolite KEGG:C02380 6-Mercaptopurine generic -metabolite KEGG:C02381 6-Methoxymellein generic -metabolite KEGG:C02385 Amino acid(Arg-) generic -metabolite KEGG:C02389 p-Benzosemiquinone generic -metabolite KEGG:C02390 Methylazoxymethanol generic -metabolite KEGG:C02391 Ester generic -metabolite KEGG:C02394 Cinnamyl alcohol generic -metabolite KEGG:C02395 Cyclohex-2-enone generic -metabolite KEGG:C02399 D-Xylosylprotein generic -metabolite KEGG:C02400 Demethylmacrocin generic -metabolite KEGG:C02401 Dialkylarylamine generic -metabolite KEGG:C02403 Fatty acid anion generic -metabolite KEGG:C02404 Fibrinopeptide B generic -metabolite KEGG:C02405 Formyl phosphate generic -metabolite KEGG:C02410 Glucosylated DNA generic -metabolite KEGG:C02411 Glutaconyl-1-CoA generic -metabolite KEGG:C02412 Glycyl-tRNA(Gly) generic -metabolite KEGG:C02413 Heptopyranosides generic -metabolite KEGG:C02415 Histone-L-lysine generic -metabolite KEGG:C02419 Hypotaurocyamine generic -metabolite KEGG:C02420 Isobutyronitrile generic -metabolite KEGG:C02421 Isonicotineamide generic -metabolite KEGG:C02424 L-Arginine ester generic -metabolite KEGG:C02426 L-Glyceraldehyde generic -metabolite KEGG:C02427 L-Homocitrulline generic -metabolite KEGG:C02429 L-Leucyl-protein generic -metabolite KEGG:C02430 L-Methionyl-tRNA generic -metabolite KEGG:C02431 L-Rhamnofuranose generic -metabolite KEGG:C02434 Long-chain ester generic -metabolite KEGG:C02436 Methylated amine generic -metabolite KEGG:C02440 N-Desulfoheparin generic -metabolite KEGG:C02441 N-Ethylmaleimide generic -metabolite KEGG:C02442 N-Methyltyramine generic -metabolite KEGG:C02444 N6-Acyl-L-lysine generic -metabolite KEGG:C02445 Nonane-4,6-dione generic -metabolite KEGG:C02446 O-Alkylglycerone generic -metabolite KEGG:C02447 O-Methylated RNA generic -metabolite KEGG:C02451 Pent-2-enoyl-CoA generic -metabolite KEGG:C02452 Perillyl alcohol generic -metabolite KEGG:C02453 Phenolic steroid generic -metabolite KEGG:C02454 Phenylenediamine generic -metabolite KEGG:C02455 1-Phenylethylamine generic -metabolite KEGG:C02456 Phosphorhodopsin generic -metabolite KEGG:C02457 Propane-1,3-diol generic -metabolite KEGG:C02461 Protein Cys-Cys generic -metabolite KEGG:C02462 Sabinene hydrate generic -metabolite KEGG:C02463 Precorrin 2 generic -metabolite KEGG:C02465 Triiodothyronine generic -metabolite KEGG:C02466 Trimetaphosphoric acid generic -metabolite KEGG:C02467 UDP-galactosamine generic -metabolite KEGG:C02469 Uroporphyrin III generic -metabolite KEGG:C02470 Xanthurenic acid generic -metabolite KEGG:C02471 [Glu(-Cys)]n-Gly generic -metabolite KEGG:C02472 alpha-D-Fucoside generic -metabolite KEGG:C02473 alpha-D-Lyxoside generic -metabolite KEGG:C02474 Arabinan generic -metabolite KEGG:C02475 alpha-L-Fucoside generic -metabolite KEGG:C02476 alpha-L-Rhamnose generic -metabolite KEGG:C02477 alpha-Tocopherol generic -metabolite KEGG:C02478 beta-D-Mannoside generic -metabolite KEGG:C02479 beta-L-Arabinose generic -metabolite KEGG:C02480 cis,cis-Muconate generic -metabolite KEGG:C02483 gamma-Tocopherol generic -metabolite KEGG:C02484 (+)-trans-Pulegol generic -metabolite KEGG:C02485 (-)-Isopiperitenone generic -metabolite KEGG:C02486 (3R)-beta-Leucine generic -metabolite KEGG:C02487 (Ac)2-L-Lys-D-Ala generic -metabolite KEGG:C02488 (R)-2-Ethylmalate generic -metabolite KEGG:C02489 (R)-2-Hydroxyacid generic -metabolite KEGG:C02490 1,2-beta-D-Glucan generic -metabolite KEGG:C02492 1,4-beta-D-Mannan generic -metabolite KEGG:C02493 1,6-beta-D-Glucan generic -metabolite KEGG:C02494 1-Methyladenosine generic -metabolite KEGG:C02495 2'-Hydroxydaidzein generic -metabolite KEGG:C02496 2,4-Dinitrophenol generic -metabolite KEGG:C02497 2-Butyne-1,4-diol generic -metabolite KEGG:C02498 2-Ethylhexan-1-ol generic -metabolite KEGG:C02499 2-Hydroxybiphenyl generic -metabolite KEGG:C02501 2-Hydroxymuconate generic -metabolite KEGG:C02502 2-Hydroxypyridine generic -metabolite KEGG:C02504 alpha-Isopropylmalate generic -metabolite KEGG:C02505 2-Phenylacetamide generic -metabolite KEGG:C02506 21-Hydroxysteroid generic -metabolite KEGG:C02507 3',5'-Cyclic dGMP generic -metabolite KEGG:C02508 3'-Ribonucleotide generic -metabolite KEGG:C02509 3-(ADP)-glycerate generic -metabolite KEGG:C02512 3-Cyano-L-alanine generic -metabolite KEGG:C02513 3-Dehydroecdysone generic -metabolite KEGG:C02514 3-Fumarylpyruvate generic -metabolite KEGG:C02515 3-Iodo-L-tyrosine generic -metabolite KEGG:C02517 3-Oxohexobarbital generic -metabolite KEGG:C02518 4-Aminosalicylate generic -metabolite KEGG:C02519 4-Methoxybenzoate generic -metabolite KEGG:C02520 5'-Ribonucleotide generic -metabolite KEGG:C02521 5S-rRNA precursor generic -metabolite KEGG:C02522 6-Deoxy-D-glucose generic -metabolite KEGG:C02525 Aliphatic alcohol generic -metabolite KEGG:C02526 Biphenyl-2,3-diol generic -metabolite KEGG:C02527 Butanoylphosphate generic -metabolite KEGG:C02528 Chenodeoxycholate generic -metabolite KEGG:C02530 Cholesterol ester generic -metabolite KEGG:C02532 O-Phospho-D-serine generic -metabolite KEGG:C02533 Dehydrovomifoliol generic -metabolite KEGG:C02534 Dialkyl phosphate generic -metabolite KEGG:C02535 Dimethyl selenide generic -metabolite KEGG:C02536 Dolichyl palmitate generic -metabolite KEGG:C02537 Estradiol-17alpha generic -metabolite KEGG:C02538 Estrone 3-sulfate generic -metabolite KEGG:C02539 Fenoprofen calcium generic -metabolite KEGG:C02543 Glycerone sulfate generic -metabolite KEGG:C02545 Glycosaminoglycan generic -metabolite KEGG:C02546 Glycyl amino acid generic -metabolite KEGG:C02548 2-(2-Aminoethyl)indole generic -metabolite KEGG:C02549 Kievitone hydrate generic -metabolite KEGG:C02553 L-Seryl-tRNA(Ser) generic -metabolite KEGG:C02554 L-Valyl-tRNA(Val) generic -metabolite KEGG:C02555 Luciferyl sulfate generic -metabolite KEGG:C02557 Methylmalonyl-CoA generic -metabolite KEGG:C02560 N-Acetylimidazole generic -metabolite KEGG:C02562 N-Acyl-L-arginine generic -metabolite KEGG:C02564 N-Feruloylglycine generic -metabolite KEGG:C02565 N-Methylhydantoin generic -metabolite KEGG:C02567 N1-Acetylspermine generic -metabolite KEGG:C02569 Neryl diphosphate generic -metabolite KEGG:C02571 O-Acetylcarnitine generic -metabolite KEGG:C02572 5-O-Feruloylquinic acid generic -metabolite KEGG:C02574 O-Phosphoviomycin generic -metabolite KEGG:C02575 Pentachlorophenol generic -metabolite KEGG:C02576 Perillyl aldehyde generic -metabolite KEGG:C02577 Phenoxyacetyl-CoA generic -metabolite KEGG:C02578 Phenylgalactoside generic -metabolite KEGG:C02579 Polygalacturonide generic -metabolite KEGG:C02581 Propanoylagmatine generic -metabolite KEGG:C02582 Protein disulfide generic -metabolite KEGG:C02583 Protein glutamine generic -metabolite KEGG:C02587 Pyrimidodiazepine generic -metabolite KEGG:C02588 Retinyl palmitate generic -metabolite KEGG:C02589 S-Acylglutathione generic -metabolite KEGG:C02590 Steroid O-sulfate generic -metabolite KEGG:C02591 Sucrose 6'-phosphate generic -metabolite KEGG:C02592 Taurolithocholate generic -metabolite KEGG:C02593 Tetradecanoyl-CoA generic -metabolite KEGG:C02595 Thien-2-ylacetate generic -metabolite KEGG:C02596 Tolylacetonitrile generic -metabolite KEGG:C02601 [Pyruvate kinase] generic -metabolite KEGG:C02603 alpha-D-Mannoside generic -metabolite KEGG:C02604 alpha-L-Arabinose generic -metabolite KEGG:C02605 beta-L-Rhamnoside generic -metabolite KEGG:C02607 kappa-Carrageenan generic -metabolite KEGG:C02611 (E,E)-Piperoyl-CoA generic -metabolite KEGG:C02612 (R)-2-Methylmalate generic -metabolite KEGG:C02614 (S)-2-Methylmalate generic -metabolite KEGG:C02615 (S)-Mandelonitrile generic -metabolite KEGG:C02616 1,3-alpha-D-Glucan generic -metabolite KEGG:C02617 1,4-Naphthoquinone generic -metabolite KEGG:C02621 13-Hydroxylupanine generic -metabolite KEGG:C02623 2,2-Dialkylglycine generic -metabolite KEGG:C02625 2,4-Dichlorophenol generic -metabolite KEGG:C02627 2-Deoxystreptamine generic -metabolite KEGG:C02628 2-Deoxystreptidine generic -metabolite KEGG:C02630 2-Hydroxyglutarate generic -metabolite KEGG:C02631 2-Isopropylmaleate generic -metabolite KEGG:C02632 2-Methylpropanoate generic -metabolite KEGG:C02633 20-Hydroxyecdysone generic -metabolite KEGG:C02634 3-Chloro-D-alanine generic -metabolite KEGG:C02635 3-Chloro-L-alanine generic -metabolite KEGG:C02636 3-Dehydrocarnitine generic -metabolite KEGG:C02637 3-Dehydroshikimate generic -metabolite KEGG:C02638 3-Fluoro-D-alanine generic -metabolite KEGG:C02639 3-Methoxytropolone generic -metabolite KEGG:C02640 3-Methylbutanamine generic -metabolite KEGG:C02642 3-Ureidopropionate generic -metabolite KEGG:C02645 4,5-Leukotriene A4 generic -metabolite KEGG:C02646 4-Coumaryl alcohol generic -metabolite KEGG:C02647 4-Guanidinobutanal generic -metabolite KEGG:C02648 4-Hydroxy-2-butynal generic -metabolite KEGG:C02652 5-Dehydroshikimate generic -metabolite KEGG:C02654 5-Substituted dCMP generic -metabolite KEGG:C02655 6-Acetyl-D-glucose generic -metabolite KEGG:C02656 Pimelate generic -metabolite KEGG:C02657 6-Methylsalicylate generic -metabolite KEGG:C02658 Aldoxime generic -metabolite KEGG:C02659 Acetone cyanohydrin generic -metabolite KEGG:C02660 Benzyl thiocyanate generic -metabolite KEGG:C02661 Bromochloromethane generic -metabolite KEGG:C02666 Coniferyl aldehyde generic -metabolite KEGG:C02669 D-Galactono-1,5-lactone generic -metabolite KEGG:C02670 D-Glucuronolactone generic -metabolite KEGG:C02671 D-Glutamyl-peptide generic -metabolite KEGG:C02672 D-Hexose phosphate generic -metabolite KEGG:C02673 Desacetoxyvindoline generic -metabolite KEGG:C02674 Deoxyribonolactone generic -metabolite KEGG:C02675 Dihydrobiochanin A generic -metabolite KEGG:C02677 Dimethyl telluride generic -metabolite KEGG:C02678 Dodecanedioic acid generic -metabolite KEGG:C02679 Dodecanoic acid generic -metabolite KEGG:C02681 Ecdysone palmitate generic -metabolite KEGG:C02682 Ferricytochrome c3 generic -metabolite KEGG:C02683 Ferrileghemoglobin generic -metabolite KEGG:C02684 Ferrocytochrome c3 generic -metabolite KEGG:C02685 Ferroleghemoglobin generic -metabolite KEGG:C02686 Galactosylceramide generic -metabolite KEGG:C02687 alpha-D-Glucosylglycogenin generic -metabolite KEGG:C02691 Heteropyrithiamine generic -metabolite KEGG:C02692 Hexose-1,5-lactone generic -metabolite KEGG:C02693 (Indol-3-yl)acetamide generic -metabolite KEGG:C02695 Isomaltosaccharide generic -metabolite KEGG:C02699 L-Citrulline ester generic -metabolite KEGG:C02700 L-Formylkynurenine generic -metabolite KEGG:C02702 L-Prolyl-tRNA(Pro) generic -metabolite KEGG:C02703 L-Serine O-sulfate generic -metabolite KEGG:C02704 Monomethyl sulfate generic -metabolite KEGG:C02705 Mucus glycoprotein generic -metabolite KEGG:C02706 Myelin proteolipid generic -metabolite KEGG:C02707 Myosin heavy chain generic -metabolite KEGG:C02709 N-(Acetyloxy)benzenamine generic -metabolite KEGG:C02710 N-Acetyl-L-leucine generic -metabolite KEGG:C02711 N-Acetylhexosamine generic -metabolite KEGG:C02712 N-Acetylmethionine generic -metabolite KEGG:C02713 N-Acetylmuramate generic -metabolite KEGG:C02714 N-Acetylputrescine generic -metabolite KEGG:C02715 N-Acyl-L-aspartate generic -metabolite KEGG:C02716 N-Acyl-L-glutamine generic -metabolite KEGG:C02717 N-Feruloyltyramine generic -metabolite KEGG:C02718 N-Formiminoglycine generic -metabolite KEGG:C02720 Hydroxylaminobenzene generic -metabolite KEGG:C02721 N-Methyl-L-alanine generic -metabolite KEGG:C02722 N-Methylhexanamide generic -metabolite KEGG:C02723 N-Methylputrescine generic -metabolite KEGG:C02724 N-Methylpyridinium generic -metabolite KEGG:C02725 N3'-Acetylneomycin generic -metabolite KEGG:C02726 Phosphoagmatine generic -metabolite KEGG:C02727 N6-Acetyl-L-lysine generic -metabolite KEGG:C02728 N6-Methyl-L-lysine generic -metabolite KEGG:C02729 O-Phosphoprotamine generic -metabolite KEGG:C02730 2-Succinylbenzoate generic -metabolite KEGG:C02732 Peptide tryptophan generic -metabolite KEGG:C02734 Phenolic phosphate generic -metabolite KEGG:C02735 Phenylethanolamine generic -metabolite KEGG:C02736 Phosphatidyl ester generic -metabolite KEGG:C02737 Phosphatidylserine generic -metabolite KEGG:C02739 1-(5-Phospho-D-ribosyl)-ATP generic -metabolite KEGG:C02740 Photinus luciferin generic -metabolite KEGG:C02741 Phosphoribosyl-AMP generic -metabolite KEGG:C02743 [Protein]-L-cysteine generic -metabolite KEGG:C02744 Psychosine sulfate generic -metabolite KEGG:C02745 Reduced flavodoxin generic -metabolite KEGG:C02749 S-Alkyl-L-cysteine generic -metabolite KEGG:C02750 Sinapoyltartronate generic -metabolite KEGG:C02752 Triacetate lactone generic -metabolite KEGG:C02753 D-Xylono-1,4-lactone generic -metabolite KEGG:C02755 [Glu(-Cys)]n+1-Gly generic -metabolite KEGG:C02756 [Xanthine oxidase] generic -metabolite KEGG:C02757 alpha-L-Rhamnoside generic -metabolite KEGG:C02758 alpha-Melanotropin generic -metabolite KEGG:C02759 alpha-Pinene-oxide generic -metabolite KEGG:C02761 beta-L-Arabinoside generic -metabolite KEGG:C02762 beta-Limit dextrin generic -metabolite KEGG:C02763 2-Hydroxy-3-phenylpropenoate generic -metabolite KEGG:C02764 tRNA pseudouridine generic -metabolite KEGG:C02765 (+)-Pseudoephedrine generic -metabolite KEGG:C02766 (R)-Ureidoglycolate generic -metabolite KEGG:C02768 (Glycerophosphate)n generic -metabolite KEGG:C02771 1,2-Dihydrosantonin generic -metabolite KEGG:C02773 1-Alkyl-sn-glycerol generic -metabolite KEGG:C02774 10-Hydroxydecanoic acid generic -metabolite KEGG:C02775 2,3-Dihydroxyindole generic -metabolite KEGG:C02777 2,5-Dioxopiperazine generic -metabolite KEGG:C02778 2-Acetamidofluorene generic -metabolite KEGG:C02779 2-Dehydro-D-glucose generic -metabolite KEGG:C02780 2,5-Didehydro-D-gluconate generic -metabolite KEGG:C02781 2-Deoxy-D-galactose generic -metabolite KEGG:C02782 2-Deoxy-D-gluconate generic -metabolite KEGG:C02783 2-Deoxy-L-arabinose generic -metabolite KEGG:C02784 2-Fluorobenzoyl-CoA generic -metabolite KEGG:C02785 3-Hydroxy-vitamin K generic -metabolite KEGG:C02787 2-Methylpropanamine generic -metabolite KEGG:C02789 3'-Extranucleotides generic -metabolite KEGG:C02790 3'-Hydroxyflavonoid generic -metabolite KEGG:C02791 3,4-Dichloroaniline generic -metabolite KEGG:C02792 3-Fluorobenzoyl-CoA generic -metabolite KEGG:C02793 2-Hydroxy-vitamin K generic -metabolite KEGG:C02794 3-Hydroxykynurenine generic -metabolite KEGG:C02796 3-Methyleneoxindole generic -metabolite KEGG:C02797 3-Oxo-5beta-steroid generic -metabolite KEGG:C02798 3-Phosphonopyruvate generic -metabolite KEGG:C02800 4,5-Dioxopentanoate generic -metabolite KEGG:C02801 4-Aminobutanoyl-CoA generic -metabolite KEGG:C02802 4-Fluorobenzoyl-CoA generic -metabolite KEGG:C02803 4-Nitroacetophenone generic -metabolite KEGG:C02804 5-Hydroxypentanoate generic -metabolite KEGG:C02805 5-Oxoprolyl-peptide generic -metabolite KEGG:C02806 8-Hydroxykaempferol generic -metabolite KEGG:C02807 Acenaphthenequinone generic -metabolite KEGG:C02808 Acetylblasticidin S generic -metabolite KEGG:C02809 Albendazole S-oxide generic -metabolite KEGG:C02810 Alditol 6-phosphate generic -metabolite KEGG:C02811 Anhydrotetracycline generic -metabolite KEGG:C02812 Ascorbate 2-sulfate generic -metabolite KEGG:C02814 Benzene-1,2,4-triol generic -metabolite KEGG:C02816 Calmodulin L-lysine generic -metabolite KEGG:C02817 Chlordecone alcohol generic -metabolite KEGG:C02821 Cortisol 21-acetate generic -metabolite KEGG:C02822 Cortisol 21-sulfate generic -metabolite KEGG:C02823 Cyanocobalamin generic -metabolite KEGG:C02824 Cyclohexylsulfamate generic -metabolite KEGG:C02825 Cypridina luciferin generic -metabolite KEGG:C02827 D-Glucose 6-sulfate generic -metabolite KEGG:C02828 D-Phe-Pro-Arg-CH2Cl generic -metabolite KEGG:C02834 Heparin-glucosamine generic -metabolite KEGG:C02835 Imidazole-4-acetate generic -metabolite KEGG:C02837 L-Lysine 1,6-lactam generic -metabolite KEGG:C02838 L-Octanoylcarnitine generic -metabolite KEGG:C02839 L-Tyrosyl-tRNA(Tyr) generic -metabolite KEGG:C02843 Long-chain acyl-CoA generic -metabolite KEGG:C02845 Methyl ethyl ketone generic -metabolite KEGG:C02846 N,N-Dimethylaniline generic -metabolite KEGG:C02847 N-Acetyl amino acid generic -metabolite KEGG:C02850 N-Acyl-L-amino acid generic -metabolite KEGG:C02851 N-Acyl-L-citrulline generic -metabolite KEGG:C02852 N-Ethylglycocyamine generic -metabolite KEGG:C02853 N-Formyl amino acid generic -metabolite KEGG:C02854 N-Furfurylformamide generic -metabolite KEGG:C02855 N-Phospho-D-lombricine generic -metabolite KEGG:C02856 N3'-Acetylapramycin generic -metabolite KEGG:C02857 N3'-Acetylkanamycin generic -metabolite KEGG:C02858 N5-Acyl-L-ornithine generic -metabolite KEGG:C02860 N6-Alkylaminopurine generic -metabolite KEGG:C02862 O-Butanoylcarnitine generic -metabolite KEGG:C02863 3-O-(alpha-D-Mannosyl)-L-serinyl-[protein] generic -metabolite KEGG:C02864 O-Demethylpuromycin generic -metabolite KEGG:C02866 O-Sinapoylglucarate generic -metabolite KEGG:C02867 Oligoribonucleotide generic -metabolite KEGG:C02868 Lecanoric acid generic -metabolite KEGG:C02869 Oxidized flavodoxin generic -metabolite KEGG:C02871 Peptide L-aspartate generic -metabolite KEGG:C02872 Peptide diphthamide generic -metabolite KEGG:C02876 Propanoyl phosphate generic -metabolite KEGG:C02879 Protoaphin aglucone generic -metabolite KEGG:C02880 Protochlorophyllide generic -metabolite KEGG:C02882 L-Cysteine-S-conjugate generic -metabolite KEGG:C02884 Ribose triphosphate generic -metabolite KEGG:C02885 S-Alkyl thiosulfate generic -metabolite KEGG:C02886 S-Hexyl-glutathione generic -metabolite KEGG:C02887 Sinapoyl malate generic -metabolite KEGG:C02888 Sorbose 1-phosphate generic -metabolite KEGG:C02890 Tetrahydropalmatine generic -metabolite KEGG:C02892 Thiamine acetic acid generic -metabolite KEGG:C02893 Unsaturated alcohol generic -metabolite KEGG:C02894 Watasenia luciferin generic -metabolite KEGG:C02895 Xylitol 5-phosphate generic -metabolite KEGG:C02896 alpha,omega-Diamine generic -metabolite KEGG:C02897 alpha-D-Arabinoside generic -metabolite KEGG:C02899 beta-Cyclopiazonate generic -metabolite KEGG:C02900 beta-D-Galactosyl-R generic -metabolite KEGG:C02903 omega-Aminoaldehyde generic -metabolite KEGG:C02904 p-Menthane-3,8-diol generic -metabolite KEGG:C02905 tRNA(Asp)-queuosine generic -metabolite KEGG:C02906 Dihydromyricetin generic -metabolite KEGG:C02909 (2-Naphthyl)methanol generic -metabolite KEGG:C02912 (R)-Propane-1,2-diol generic -metabolite KEGG:C02914 (S)-2-O-Sulfolactate generic -metabolite KEGG:C02915 (S)-cis-N-Methylcanadine generic -metabolite KEGG:C02916 (S)-Norlaudanosoline generic -metabolite KEGG:C02917 (S)-Propane-1,2-diol generic -metabolite KEGG:C02918 1-Methylnicotinamide generic -metabolite KEGG:C02919 4-O-beta-D-Glucosyl-sinapate generic -metabolite KEGG:C02920 2'-Hydroxyformononetin generic -metabolite KEGG:C02921 2'-Hydroxyisoflavone generic -metabolite KEGG:C02922 2'-O-Methyllicodione generic -metabolite KEGG:C02923 2,3-Dihydroxytoluene generic -metabolite KEGG:C02924 Dimercaprol generic -metabolite KEGG:C02926 Homoserine lactone generic -metabolite KEGG:C02927 2-Caffeoylisocitrate generic -metabolite KEGG:C02928 2-Dehydro-D-xylonate generic -metabolite KEGG:C02929 2-Hydroxy carboxylate generic -metabolite KEGG:C02930 2-Methyleneglutarate generic -metabolite KEGG:C02932 3,4-Dihydroxypyridine generic -metabolite KEGG:C02933 3,5-Dichlorocatechol generic -metabolite KEGG:C02934 3-Dehydrosphinganine generic -metabolite KEGG:C02937 Indole-3-acetaldehyde oxime generic -metabolite KEGG:C02938 3-Indoleacetonitrile generic -metabolite KEGG:C02939 3-Methylbutanoyl-CoA generic -metabolite KEGG:C02940 3-Oxo-5alpha-steroid generic -metabolite KEGG:C02941 3-Oxo-Delta1-steroid generic -metabolite KEGG:C02942 3-Oxo-hydroxysteroid generic -metabolite KEGG:C02943 3-Oxoglycyrrhetinate generic -metabolite KEGG:C02944 3-cis-Dodecenoyl-CoA generic -metabolite KEGG:C02945 3beta-Hydroxysteroid generic -metabolite KEGG:C02946 4-Acetamidobutanoate generic -metabolite KEGG:C02947 4-Coumaroylshikimate generic -metabolite KEGG:C02948 4-Hydroxyhexan-3-one generic -metabolite KEGG:C02949 4-Hydroxybenzoyl-CoA generic -metabolite KEGG:C02951 5-Hydroxyxanthotoxin generic -metabolite KEGG:C02952 5-Oxo-1,2-campholide generic -metabolite KEGG:C02953 7,8-Dihydrobiopterin generic -metabolite KEGG:C02954 6-Aminopenicillanate generic -metabolite KEGG:C02956 7beta-Hydroxysteroid generic -metabolite KEGG:C02957 8-Oxodeoxycoformycin generic -metabolite KEGG:C02960 Ceramide 1-phosphate generic -metabolite KEGG:C02961 Cytarabine generic -metabolite KEGG:C02962 D-Allose 6-phosphate generic -metabolite KEGG:C02964 4-O-beta-D-Glucopyranosyl-D-mannose generic -metabolite KEGG:C02965 D-Hexose 6-phosphate generic -metabolite KEGG:C02967 DNA 5-methylcytosine generic -metabolite KEGG:C02970 Decaprenol phosphate generic -metabolite KEGG:C02972 Dihydrolipoylprotein generic -metabolite KEGG:C02975 Ethyl 3-oxohexanoate generic -metabolite KEGG:C02977 GDP-6-deoxy-D-talose generic -metabolite KEGG:C02979 Glycerol 2-phosphate generic -metabolite KEGG:C02980 Hydroxyanthraquinone generic -metabolite KEGG:C02982 L-2-Hydroxyphytanate generic -metabolite KEGG:C02983 Abrine generic -metabolite KEGG:C02984 L-Aspartyl-tRNA(Asp) generic -metabolite KEGG:C02985 L-Fucose 1-phosphate generic -metabolite KEGG:C02986 L-Glutaminyl-peptide generic -metabolite KEGG:C02987 L-Glutamyl-tRNA(Glu) generic -metabolite KEGG:C02988 L-Histidyl-tRNA(His) generic -metabolite KEGG:C02989 L-Methionine S-oxide generic -metabolite KEGG:C02990 L-Palmitoylcarnitine generic -metabolite KEGG:C02991 L-Rhamnono-1,4-lactone generic -metabolite KEGG:C02992 L-Threonyl-tRNA(Thr) generic -metabolite KEGG:C02993 Kyotorphin generic -metabolite KEGG:C02994 L-Xylono-1,4-lactone generic -metabolite KEGG:C02995 Maltose 6'-phosphate generic -metabolite KEGG:C02996 Meclofenamate sodium generic -metabolite KEGG:C02997 N-Acetyl-L-histidine generic -metabolite KEGG:C02998 N-Acetylarylalkylamine generic -metabolite KEGG:C02999 N-Acetylmuramoyl-Ala generic -metabolite KEGG:C03000 N-Acyl-D-glucosamine generic -metabolite KEGG:C03001 N-Benzoyl-D-arginine generic -metabolite KEGG:C03002 N-Caffeoylputrescine generic -metabolite KEGG:C03003 N-Glucosylnicotinate generic -metabolite KEGG:C03004 N-Hydroxy-L-tyrosine generic -metabolite KEGG:C03005 N-Methylanthranilate generic -metabolite KEGG:C03007 1-(1-Oxopropyl)-1H-imidazole generic -metabolite KEGG:C03010 N3'-Acetyltobramycin generic -metabolite KEGG:C03011 Nalpha-Acetylpeptide generic -metabolite KEGG:C03012 Naphthalene-1,2-diol generic -metabolite KEGG:C03015 O-Carbamoyl-L-serine generic -metabolite KEGG:C03016 O-Phosphotropomyosin generic -metabolite KEGG:C03017 O-Propanoylcarnitine generic -metabolite KEGG:C03018 Oligoglycosylglucose generic -metabolite KEGG:C03019 Phorbol 13-butanoate generic -metabolite KEGG:C03021 Protein asparagine generic -metabolite KEGG:C03022 Protein L-citrulline generic -metabolite KEGG:C03023 Peptide-L-methionine generic -metabolite KEGG:C03024 [Reduced NADPH---hemoprotein reductase] generic -metabolite KEGG:C03025 Reduced plastocyanin generic -metabolite KEGG:C03027 Testosterone acetate generic -metabolite KEGG:C03028 Thiamin triphosphate generic -metabolite KEGG:C03029 Transferrin[Fe(II)]2 generic -metabolite KEGG:C03030 Uracil 5-carboxylate generic -metabolite KEGG:C03031 Uridine 2'-phosphate generic -metabolite KEGG:C03032 Cyclopiazonic acid generic -metabolite KEGG:C03033 beta-D-Glucuronoside generic -metabolite KEGG:C03034 dTDP-D-galacturonate generic -metabolite KEGG:C03035 gamma-Linolenoyl-CoA generic -metabolite KEGG:C03036 (+)-Bisdechlorogeodin generic -metabolite KEGG:C03037 (+)-Bornane-2,5-dione generic -metabolite KEGG:C03039 (+)-trans-Piperitenol generic -metabolite KEGG:C03040 (-)-Bisdechlorogeodin generic -metabolite KEGG:C03042 (R)-2-Hydroxystearate generic -metabolite KEGG:C03043 (R)-6-Hydroxynicotine generic -metabolite KEGG:C03044 (R,R)-Butane-2,3-diol generic -metabolite KEGG:C03045 (S)-2-Hydroxystearate generic -metabolite KEGG:C03046 (S,S)-Butane-2,3-diol generic -metabolite KEGG:C03047 Arcaine generic -metabolite KEGG:C03049 13-Hydroxydocosanoic acid generic -metabolite KEGG:C03050 16beta-Hydroxysteroid generic -metabolite KEGG:C03051 17beta-Hydroxysteroid generic -metabolite KEGG:C03052 2,3-Dihydrogossypetin generic -metabolite KEGG:C03056 2,6-Dihydroxypyridine generic -metabolite KEGG:C03057 2-Carboxybenzaldehyde generic -metabolite KEGG:C03058 2-Hydroxyglutaryl-CoA generic -metabolite KEGG:C03059 2-Hydroxymethylserine generic -metabolite KEGG:C03062 2-O-Caffeoylglucarate generic -metabolite KEGG:C03063 2-Oxohept-3-enedioate generic -metabolite KEGG:C03064 3-Dehydro-L-threonate generic -metabolite KEGG:C03065 3-Guanidinopropanoate generic -metabolite KEGG:C03066 3-Hydroxy-L-glutamate generic -metabolite KEGG:C03067 3-Hydroxybenzaldehyde generic -metabolite KEGG:C03068 3-Hydroxyhexobarbital generic -metabolite KEGG:C03069 3-Methylcrotonyl-CoA generic -metabolite KEGG:C03070 3-Oxo-5beta-cholanate generic -metabolite KEGG:C03071 3-aci-Nitropropanoate generic -metabolite KEGG:C03072 3alpha-Hydroxysteroid generic -metabolite KEGG:C03074 4'-O-Methylisoflavone generic -metabolite KEGG:C03076 4-Bromophenylacetate generic -metabolite KEGG:C03077 4-Chlorophenylacetate generic -metabolite KEGG:C03078 4-Guanidinobutanamide generic -metabolite KEGG:C03079 4-Hydroxy-L-glutamate generic -metabolite KEGG:C03080 4-Hydroxyhydratropate generic -metabolite KEGG:C03081 4-Methylumbelliferone generic -metabolite KEGG:C03082 4-Phospho-L-aspartate generic -metabolite KEGG:C03083 4-Substituted anilide generic -metabolite KEGG:C03084 4-Substituted aniline generic -metabolite KEGG:C03085 5'-Acylphosphoinosine generic -metabolite KEGG:C03086 5'-Acylphosphouridine generic -metabolite KEGG:C03087 5-Acetamidopentanoate generic -metabolite KEGG:C03088 5-Hydroxymethyluracil generic -metabolite KEGG:C03089 5-Methylthio-D-ribose generic -metabolite KEGG:C03090 5-Phosphoribosylamine generic -metabolite KEGG:C03091 5beta-Cholestan-3-one generic -metabolite KEGG:C03092 6-endo-Hydroxycineole generic -metabolite KEGG:C03093 7,8-Dihydroxycoumarin generic -metabolite KEGG:C03095 N-Aminoacyl-L-histidine generic -metabolite KEGG:C03097 Aryl beta-D-glucoside generic -metabolite KEGG:C03098 Benzyl isothiocyanate generic -metabolite KEGG:C03103 Cyclobutadipyrimidine generic -metabolite KEGG:C03104 Cytidine 2'-phosphate generic -metabolite KEGG:C03105 Cytochrome c L-lysine generic -metabolite KEGG:C03106 D-Galactosaminoglycan generic -metabolite KEGG:C03107 D-Glucono-1,4-lactone generic -metabolite KEGG:C03108 D-Glucosylsphingosine generic -metabolite KEGG:C03109 D-Threose 4-phosphate generic -metabolite KEGG:C03110 DNA N4-methylcytosine generic -metabolite KEGG:C03112 Deacetylcephalosporin C generic -metabolite KEGG:C03113 Diisopropyl phosphate generic -metabolite KEGG:C03114 Dimethylbenzimidazole generic -metabolite KEGG:C03115 Farnesyl triphosphate generic -metabolite KEGG:C03117 GDP-6-deoxy-D-mannose generic -metabolite KEGG:C03120 Glycerophosphodiester generic -metabolite KEGG:C03121 Glycoprotein inositol generic -metabolite KEGG:C03122 Haloaromatic compound generic -metabolite KEGG:C03124 beta-L-Aspartylhydroxamate generic -metabolite KEGG:C03125 L-Cysteinyl-tRNA(Cys) generic -metabolite KEGG:C03126 L-Iduronate 2-sulfate generic -metabolite KEGG:C03127 L-Isoleucyl-tRNA(Ile) generic -metabolite KEGG:C03129 Long-chain acid anion generic -metabolite KEGG:C03130 Lower primary alcohol generic -metabolite KEGG:C03134 N,N-Dimethylformamide generic -metabolite KEGG:C03135 N-Acetyl-D-amino acid generic -metabolite KEGG:C03136 N-Acetyl-D-hexosamine generic -metabolite KEGG:C03137 N-Acetyl-D-tryptophan generic -metabolite KEGG:C03139 N-Amidino-L-aspartate generic -metabolite KEGG:C03140 N-Amidino-L-glutamate generic -metabolite KEGG:C03141 N-Benzoylanthranilate generic -metabolite KEGG:C03142 N-D-Glucosylarylamine generic -metabolite KEGG:C03145 N-Formylmethionine generic -metabolite KEGG:C03146 N-Glycolyl-D-glucosamine generic -metabolite KEGG:C03147 N-Malonylanthranilate generic -metabolite KEGG:C03148 N-Methyl-L-amino acid generic -metabolite KEGG:C03149 N-Phosphotaurocyamine generic -metabolite KEGG:C03150 Nicotinamide-beta-riboside generic -metabolite KEGG:C03151 N2-Acylated Arg-CH2Cl generic -metabolite KEGG:C03152 N2-Acylated Lys-CH2Cl generic -metabolite KEGG:C03153 N5-Methyl-L-glutamine generic -metabolite KEGG:C03154 N6'-Acetylkanamycin-B generic -metabolite KEGG:C03156 O-Feruloylgalactarate generic -metabolite KEGG:C03157 O-Phospho-tau-protein generic -metabolite KEGG:C03160 2-Succinylbenzoyl-CoA generic -metabolite KEGG:C03161 [Oxidized NADPH---hemoprotein reductase] generic -metabolite KEGG:C03162 Oxidized plastocyanin generic -metabolite KEGG:C03164 Phenanthrene-3,4-diol generic -metabolite KEGG:C03166 Phosphoguanidinoacetate generic -metabolite KEGG:C03167 Phosphonoacetaldehyde generic -metabolite KEGG:C03168 Poly(D-galactosamine) generic -metabolite KEGG:C03169 Pyrimidine nucleoside generic -metabolite KEGG:C03170 Trypanothione disulfide generic -metabolite KEGG:C03172 S-Methyl-L-methionine generic -metabolite KEGG:C03173 S-Methylthioglycolate generic -metabolite KEGG:C03174 S-Succinylglutathione generic -metabolite KEGG:C03175 Shikimate 3-phosphate generic -metabolite KEGG:C03176 Steroid hydroperoxide generic -metabolite KEGG:C03177 Streptamine phosphate generic -metabolite KEGG:C03178 Tetrahydroxypteridine generic -metabolite KEGG:C03179 Transferrin[Fe(III)]2 generic -metabolite KEGG:C03183 Z-Gly-Pro-Leu-Gly-Pro generic -metabolite KEGG:C03184 Zinc protoporphyrin-9 generic -metabolite KEGG:C03185 [Glycogen-synthase D] generic -metabolite KEGG:C03186 [Glycogen-synthase I] generic -metabolite KEGG:C03187 dTDP-6-deoxy-beta-L-talose generic -metabolite KEGG:C03188 omega-Carboxyacyl-CoA generic -metabolite KEGG:C03189 DL-Glycerol 1-phosphate generic -metabolite KEGG:C03190 (+)-Bornyl diphosphate generic -metabolite KEGG:C03193 (5-L-Glutamyl)-peptide generic -metabolite KEGG:C03194 (R)-1-Aminopropan-2-ol generic -metabolite KEGG:C03195 (R)-10-Hydroxystearate generic -metabolite KEGG:C03196 (S)-2-Hydroxyglutarate generic -metabolite KEGG:C03197 (S)-3-Hydroxybutanoate generic -metabolite KEGG:C03198 (S)-4-Hydroxymandelate generic -metabolite KEGG:C03199 1,2-Didecanoylglycerol generic -metabolite KEGG:C03200 1,3-beta-D-Oligoglucan generic -metabolite KEGG:C03201 1-Alkyl-2-acylglycerol generic -metabolite KEGG:C03203 1-Hydroxy-2-naphthoate generic -metabolite KEGG:C03204 10-Formyldihydrofolate generic -metabolite KEGG:C03205 11-Deoxycorticosterone generic -metabolite KEGG:C03206 5a,11a-Dehydrotetracycline generic -metabolite KEGG:C03207 16-Dehydroprogesterone generic -metabolite KEGG:C03209 2,2'-Dihydroxybiphenyl generic -metabolite KEGG:C03210 Alanopine generic -metabolite KEGG:C03212 2,4-Dihydroxypteridine generic -metabolite KEGG:C03214 2-Amino-3-oxobutanoate generic -metabolite KEGG:C03215 2-Carboxy-D-arabinitol generic -metabolite KEGG:C03217 2-Hydroxy-3-oxoadipate generic -metabolite KEGG:C03218 2-Methylaminoadenosine generic -metabolite KEGG:C03219 (E)-2-Methylpropanal oxime generic -metabolite KEGG:C03220 (2Z,6E)-Farnesol generic -metabolite KEGG:C03221 2-trans-Dodecenoyl-CoA generic -metabolite KEGG:C03223 3,4-Dihydroxyphthalate generic -metabolite KEGG:C03224 3,5-Dibromo-L-tyrosine generic -metabolite KEGG:C03225 3,5-Dinitro-L-tyrosine generic -metabolite KEGG:C03226 3-Demethylubiquinone-9 generic -metabolite KEGG:C03227 3-Hydroxy-L-kynurenine generic -metabolite KEGG:C03228 3-Hydroxycyclohexanone generic -metabolite KEGG:C03230 (Indol-3-yl)glycolaldehyde generic -metabolite KEGG:C03231 3-Methylglutaconyl-CoA generic -metabolite KEGG:C03232 3-Phosphonooxypyruvate generic -metabolite KEGG:C03233 4,5-Dihydroxyphthalate generic -metabolite KEGG:C03235 4-Hydroxypheoxyacetate generic -metabolite KEGG:C03236 5'-Phosphodinucleotide generic -metabolite KEGG:C03237 5-Hydroxypentanoyl-CoA generic -metabolite KEGG:C03238 5alpha-Cholestan-3-one generic -metabolite KEGG:C03239 6-Amino-2-oxohexanoate generic -metabolite KEGG:C03240 6-Deoxyerythronolide B generic -metabolite KEGG:C03241 6-Hydroxyhexan-6-olide generic -metabolite KEGG:C03242 Dihomo-gamma-linolenate generic -metabolite KEGG:C03243 9,10-Phenanthroquinone generic -metabolite KEGG:C03245 ADP-D-ribosyl-acceptor generic -metabolite KEGG:C03246 ADPribose 2'-phosphate generic -metabolite KEGG:C03248 Acetylenedicarboxylate generic -metabolite KEGG:C03251 Aldohexose 6-phosphate generic -metabolite KEGG:C03254 Aryl dialkyl phosphate generic -metabolite KEGG:C03256 Cetraxate benzyl ester generic -metabolite KEGG:C03263 Coproporphyrinogen III generic -metabolite KEGG:C03264 (R)-2-Hydroxyisocaproate generic -metabolite KEGG:C03267 beta-D-Fructose 2-phosphate generic -metabolite KEGG:C03268 D-Mannosylglycoprotein generic -metabolite KEGG:C03269 D-galacto-Hexodialdose generic -metabolite KEGG:C03272 Globoside generic -metabolite KEGG:C03273 5-Oxopentanoate generic -metabolite KEGG:C03274 Glycerophosphoglycerol generic -metabolite KEGG:C03277 Imidazol-5-yl-pyruvate generic -metabolite KEGG:C03280 Inosine-5'-carboxylate generic -metabolite KEGG:C03281 Kanamycin A 3'-phosphate generic -metabolite KEGG:C03283 L-2,4-Diaminobutanoate generic -metabolite KEGG:C03284 L-3-Aminoisobutanoate generic -metabolite KEGG:C03287 L-Glutamyl 5-phosphate generic -metabolite KEGG:C03289 L-xylo-Hexulonolactone generic -metabolite KEGG:C03290 L-threo-3-Phenylserine generic -metabolite KEGG:C03291 L-Xylulose 5-phosphate generic -metabolite KEGG:C03292 Mercaptoacetyl-Phe-Leu generic -metabolite KEGG:C03294 N-Formylmethionyl-tRNA generic -metabolite KEGG:C03296 N2-Succinyl-L-arginine generic -metabolite KEGG:C03297 N3-Acetylgentamicin C generic -metabolite KEGG:C03298 Nalpha-Methylhistidine generic -metabolite KEGG:C03299 O-Decanoyl-L-carnitine generic -metabolite KEGG:C03300 O-beta-D-Xylosylzeatin generic -metabolite KEGG:C03302 Oxidized putidaredoxin generic -metabolite KEGG:C03303 Peptidylamidoglycolate generic -metabolite KEGG:C03305 Prolyl-2-naphthylamide generic -metabolite KEGG:C03306 Protein L-isoaspartate generic -metabolite KEGG:C03309 Strictosidine aglycone generic -metabolite KEGG:C03311 Thien-2-ylacetonitrile generic -metabolite KEGG:C03312 Urate D-ribonucleotide generic -metabolite KEGG:C03313 Phylloquinol generic -metabolite KEGG:C03314 Xanthine-8-carboxylate generic -metabolite KEGG:C03315 [Dinitrogen reductase] generic -metabolite KEGG:C03317 alpha-Amino acid ester generic -metabolite KEGG:C03318 [alpha-Tubulin]-L-lysine generic -metabolite KEGG:C03319 dTDP-L-rhamnose generic -metabolite KEGG:C03323 (2,1-beta-D-Fructosyl)n generic -metabolite KEGG:C03325 (6S)-Hydroxyhyoscyamine generic -metabolite KEGG:C03326 (Ac)2-L-Lys-D-Ala-D-Ala generic -metabolite KEGG:C03328 (R)-2-(n-Propyl)-malate generic -metabolite KEGG:C03329 (S)-Canadine generic -metabolite KEGG:C03330 (Ubiquitin)n-calmodulin generic -metabolite KEGG:C03336 17alpha-Hydroxysteroid generic -metabolite KEGG:C03338 2,3,5-Trihydroxytoluene generic -metabolite KEGG:C03339 2,3-Bisphosphoglycerate generic -metabolite KEGG:C03340 L-2,3-Dihydrodipicolinate generic -metabolite KEGG:C03341 2-Amino-4-oxopentanoic acid generic -metabolite KEGG:C03342 2-Dehydro-D-galactonate generic -metabolite KEGG:C03343 2-Ethylhexyl phthalate generic -metabolite KEGG:C03344 2-Methylacetoacetyl-CoA generic -metabolite KEGG:C03345 2-Methylbut-2-enoyl-CoA generic -metabolite KEGG:C03347 3,5-Dichloro-L-tyrosine generic -metabolite KEGG:C03348 3,6-Dideoxy-L-galactose generic -metabolite KEGG:C03349 3-Aminopropanesulfonate generic -metabolite KEGG:C03351 3-Hydroxybenzyl alcohol generic -metabolite KEGG:C03352 3-Methoxybenzyl alcohol generic -metabolite KEGG:C03354 3-Methylthiopropanamine generic -metabolite KEGG:C03356 3-Phospho-D-erythronate generic -metabolite KEGG:C03357 4-Acetamidobutanoyl-CoA generic -metabolite KEGG:C03359 4-Chloro-2-methylphenol generic -metabolite KEGG:C03360 4-Nitrophenyl phosphate generic -metabolite KEGG:C03361 5'-Acylphosphoadenosine generic -metabolite KEGG:C03363 5-L-Glutamyl amino acid generic -metabolite KEGG:C03365 5-O-Methyl-myo-inositol generic -metabolite KEGG:C03366 5-Phosphooxy-L-lysine generic -metabolite KEGG:C03367 6-alpha-Maltosylglucose generic -metabolite KEGG:C03368 7''-O-Phosphohygromycin generic -metabolite KEGG:C03371 [Protein]-S-(long-chain-acyl)-L-cysteine generic -metabolite KEGG:C03372 Acylglycerone phosphate generic -metabolite KEGG:C03373 Aminoimidazole ribotide generic -metabolite KEGG:C03374 Bilirubin-glucuronoside generic -metabolite KEGG:C03375 Norspermidine generic -metabolite KEGG:C03383 D-Galactono-1,4-lactone generic -metabolite KEGG:C03384 D-Galactose 1-phosphate generic -metabolite KEGG:C03387 D-Glucurono-6,2-lactone generic -metabolite KEGG:C03391 DNA 6-methylaminopurine generic -metabolite KEGG:C03392 Dimethylsulfonioacetate generic -metabolite KEGG:C03393 4-Phospho-D-erythronate generic -metabolite KEGG:C03394 Erythrulose 1-phosphate generic -metabolite KEGG:C03395 Fatty acid methyl ester generic -metabolite KEGG:C03400 Glycoside of aldohexose generic -metabolite KEGG:C03401 L-2,3-Diaminopropanoate generic -metabolite KEGG:C03402 L-Asparaginyl-tRNA(Asn) generic -metabolite KEGG:C03404 L-Tyrosine methyl ester generic -metabolite KEGG:C03405 Lactosylceramide sulfate generic -metabolite KEGG:C03406 N-(L-Arginino)succinate generic -metabolite KEGG:C03408 N-Acetylgalactosaminate generic -metabolite KEGG:C03409 N-Formimino-L-aspartate generic -metabolite KEGG:C03410 N-Glycoloyl-neuraminate generic -metabolite KEGG:C03411 N-Glycosyl-L-asparagine generic -metabolite KEGG:C03412 N-Palmitoylglycoprotein generic -metabolite KEGG:C03413 N1,N12-Diacetylspermine generic -metabolite KEGG:C03414 N2-Malonyl-D-tryptophan generic -metabolite KEGG:C03415 N2-Succinyl-L-ornithine generic -metabolite KEGG:C03416 N6,N6-Dimethyladenosine generic -metabolite KEGG:C03417 N(omega)-Nitro-L-arginine generic -metabolite KEGG:C03418 Nucleoside 2'-phosphate generic -metabolite KEGG:C03419 Nucleoside 3'-phosphate generic -metabolite KEGG:C03422 O-Palmitoylglycoprotein generic -metabolite KEGG:C03423 O-beta-D-Glucosylzeatin generic -metabolite KEGG:C03425 Oleic acid methyl ester generic -metabolite KEGG:C03427 Prephytoene diphosphate generic -metabolite KEGG:C03428 Presqualene diphosphate generic -metabolite KEGG:C03429 Protein 5-hydroxylysine generic -metabolite KEGG:C03431 S-Inosyl-L-homocysteine generic -metabolite KEGG:C03433 Streptamine 4-phosphate generic -metabolite KEGG:C03434 Tetrachlorohydroquinone generic -metabolite KEGG:C03437 beta-D-Fructofuranoside generic -metabolite KEGG:C03438 beta-Lactam antibiotics generic -metabolite KEGG:C03440 cis-4-Hydroxy-D-proline generic -metabolite KEGG:C03442 dTDP-L-dihydrostreptose generic -metabolite KEGG:C03444 p-Chloromercuribenzoate generic -metabolite KEGG:C03446 tRNA containing ribothymidine at position 54 generic -metabolite KEGG:C03448 (+)-exo-5-Hydroxycamphor generic -metabolite KEGG:C03450 (3-Arylcarbonyl)-alanine generic -metabolite KEGG:C03451 (R)-S-Lactoylglutathione generic -metabolite KEGG:C03453 gamma-Oxalocrotonate generic -metabolite KEGG:C03454 1-Alkenyl-2-acylglycerol generic -metabolite KEGG:C03455 11-cis-Retinyl palmitate generic -metabolite KEGG:C03456 2''-Nucleotidylkanamycin generic -metabolite KEGG:C03457 2''-Nucleotidylsisomicin generic -metabolite KEGG:C03458 2,3,6-Trihydroxypyridine generic -metabolite KEGG:C03459 2-Hydroxy-3-oxosuccinate generic -metabolite KEGG:C03460 2-Methylprop-2-enoyl-CoA generic -metabolite KEGG:C03461 2-trans,6-trans-Farnesal generic -metabolite KEGG:C03462 3''-Adenylylstreptomycin generic -metabolite KEGG:C03463 3'-Phosphopolynucleotide generic -metabolite KEGG:C03465 3-Methyl-2-oxopentanoate generic -metabolite KEGG:C03466 3-Methyl-vinylacetyl-CoA generic -metabolite KEGG:C03467 beta-Ketoisocaproate generic -metabolite KEGG:C03470 3-alpha(S)-Strictosidine generic -metabolite KEGG:C03473 1-(p-Hydroxyphenyl)ethylamine generic -metabolite KEGG:C03474 4-Nitroquinoline N-oxide generic -metabolite KEGG:C03475 5'-Phosphopolynucleotide generic -metabolite KEGG:C03476 5,12-Dihydroxanthommatin generic -metabolite KEGG:C03479 Folinic acid generic -metabolite KEGG:C03483 Adenosine tetraphosphate generic -metabolite KEGG:C03485 Aromatic primary alcohol generic -metabolite KEGG:C03486 CDP-N-methylethanolamine generic -metabolite KEGG:C03491 Cyclic alcohol generic -metabolite KEGG:C03492 D-4'-Phosphopantothenate generic -metabolite KEGG:C03493 D-4-Hydroxyphenylglycine generic -metabolite KEGG:C03494 D-Erythritol 4-phosphate generic -metabolite KEGG:C03495 Deoxy-5-methylcytidylate generic -metabolite KEGG:C03497 Ester of phosphinic acid generic -metabolite KEGG:C03498 Ester of phosphonic acid generic -metabolite KEGG:C03499 Ethyl (R)-3-hydroxybutanoate generic -metabolite KEGG:C03500 Ethyl 3-oxobutanoate generic -metabolite KEGG:C03502 Flavonol 3-O-D-galactoside generic -metabolite KEGG:C03503 Glucosyloxyanthraquinone generic -metabolite KEGG:C03505 Hydroxyacetone phosphate generic -metabolite KEGG:C03506 Indoleglycerol phosphate generic -metabolite KEGG:C03508 L-2-Amino-3-oxobutanoic acid generic -metabolite KEGG:C03509 L-Arabinitol 5-phosphate generic -metabolite KEGG:C03510 L-Methionine sulfoximine generic -metabolite KEGG:C03511 L-Phenylalanyl-tRNA(Phe) generic -metabolite KEGG:C03512 L-Tryptophanyl-tRNA(Trp) generic -metabolite KEGG:C03514 Limonin generic -metabolite KEGG:C03515 Luteolin 7-O-glucuronide generic -metabolite KEGG:C03516 Magnesium protoporphyrin generic -metabolite KEGG:C03517 Monoterpenyl diphosphate generic -metabolite KEGG:C03518 N-Acetyl-beta-D-glucosaminide generic -metabolite KEGG:C03519 N-Acetyl-L-phenylalanine generic -metabolite KEGG:C03521 Glycolyl-D-mannosamine generic -metabolite KEGG:C03522 N-Methyl-4-aminobenzoate generic -metabolite KEGG:C03523 N-Substituted amino acid generic -metabolite KEGG:C03524 N2'-Acetylgentamicin C1a generic -metabolite KEGG:C03525 O-Acetylneuraminic acid generic -metabolite KEGG:C03526 O-Sinapoylglucarolactone generic -metabolite KEGG:C03527 Oxidized Latia luciferin generic -metabolite KEGG:C03529 Peptide formylkynurenine generic -metabolite KEGG:C03531 [Protein]-(S)-2-amino-6-oxohexanoate generic -metabolite KEGG:C03535 Polysulfate of cellulose generic -metabolite KEGG:C03536 Pyrimidine 5'-nucleotide generic -metabolite KEGG:C03537 S-Acetylthioethanolamine generic -metabolite KEGG:C03539 S-Ribosyl-L-homocysteine generic -metabolite KEGG:C03541 THF-polyglutamate generic -metabolite KEGG:C03544 [Xanthine dehydrogenase] generic -metabolite KEGG:C03546 myo-Inositol 4-phosphate generic -metabolite KEGG:C03547 omega-Hydroxy fatty acid generic -metabolite KEGG:C03548 trans-2,3-Epoxysuccinate generic -metabolite KEGG:C03557 2-Aminoethylphosphonate generic -metabolite KEGG:C03561 (R)-3-Hydroxybutanoyl-CoA generic -metabolite KEGG:C03564 1-Pyrroline-2-carboxylate generic -metabolite KEGG:C03565 2''-Nucleotidylgentamicin generic -metabolite KEGG:C03566 2''-Nucleotidyltobramycin generic -metabolite KEGG:C03567 2'-Hydroxydihydrodaidzein generic -metabolite KEGG:C03568 2'-Phosphoadenylylsulfate generic -metabolite KEGG:C03569 2,2',3-Trihydroxybiphenyl generic -metabolite KEGG:C03570 D-Mannosamine generic -metabolite KEGG:C03571 2-Amino-2-methylbutanoate generic -metabolite KEGG:C03572 2-Chloro-cis,cis-muconate generic -metabolite KEGG:C03573 2-Deoxy-alpha-D-glucoside generic -metabolite KEGG:C03574 2-Formylaminobenzaldehyde generic -metabolite KEGG:C03575 2-Iodophenol methyl ether generic -metabolite KEGG:C03576 Coenzyme M generic -metabolite KEGG:C03577 20-Hydroxyleukotriene E4 generic -metabolite KEGG:C03579 Gibberellin A8 generic -metabolite KEGG:C03580 3''-Adenylylspectinomycin generic -metabolite KEGG:C03582 Resveratrol generic -metabolite KEGG:C03584 3-(Uracil-1-yl)-L-alanine generic -metabolite KEGG:C03585 3-Chloro-cis,cis-muconate generic -metabolite KEGG:C03586 2-Oxo-2,3-dihydrofuran-5-acetate generic -metabolite KEGG:C03587 3beta-Hydroxysteroid ester generic -metabolite KEGG:C03588 4,5alpha-Dihydrocortisone generic -metabolite KEGG:C03589 4-Hydroxy-2-oxopentanoate generic -metabolite KEGG:C03590 4-Hydroxyphenylglyoxylate generic -metabolite KEGG:C03591 5-Chloro-3-methylcatechol generic -metabolite KEGG:C03592 5-Methyl-2'-deoxycytidine generic -metabolite KEGG:C03594 7alpha-Hydroxycholesterol generic -metabolite KEGG:C03595 8,11,14-Eicosatrienoyl-CoA generic -metabolite KEGG:C03597 Actinomycinic monolactone generic -metabolite KEGG:C03598 CDP-3,6-dideoxy-D-glucose generic -metabolite KEGG:C03599 CDP-3,6-dideoxy-D-mannose generic -metabolite KEGG:C03600 Carboxymethyloxysuccinate generic -metabolite KEGG:C03601 Chloramphenicol 3-acetate generic -metabolite KEGG:C03604 D-Erythrulose 4-phosphate generic -metabolite KEGG:C03606 D-Hamamelose 2(1)-phosphate generic -metabolite KEGG:C03611 Galactose oligosaccharide generic -metabolite KEGG:C03614 Inosine 5'-tetraphosphate generic -metabolite KEGG:C03617 L-Methionylaminoacyl-tRNA generic -metabolite KEGG:C03618 L-threo-3-Methylaspartate generic -metabolite KEGG:C03619 Methyl beta-D-galactoside generic -metabolite KEGG:C03620 Monocarboxylic acid amide generic -metabolite KEGG:C03621 N-Acetoxy-4-aminobiphenyl generic -metabolite KEGG:C03622 N-Hydroxy-4-aminobiphenyl generic -metabolite KEGG:C03623 N-Methyl-2-oxoglutaramate generic -metabolite KEGG:C03624 N-Phosphohypotaurocyamine generic -metabolite KEGG:C03625 N5-Acyl-L-ornithine ester generic -metabolite KEGG:C03626 NG,NG-Dimethyl-L-arginine generic -metabolite KEGG:C03629 O-Phosphorylhydroxylamine generic -metabolite KEGG:C03630 Oleoylglycerone phosphate generic -metabolite KEGG:C03631 Oleoylphosphatidylcholine generic -metabolite KEGG:C03632 Oligosaccharide phosphate generic -metabolite KEGG:C03633 Peptidylproline (omega=0) generic -metabolite KEGG:C03634 Phorbol 12,13-dibutanoate generic -metabolite KEGG:C03635 Protein N-ubiquityllysine generic -metabolite KEGG:C03636 Protein N5-alkylglutamine generic -metabolite KEGG:C03637 Protein serine D-xyloside generic -metabolite KEGG:C03638 RNA 3'-terminal-phosphate generic -metabolite KEGG:C03640 Sphingosyl-phosphocholine generic -metabolite KEGG:C03641 Sterol 3-beta-D-glucoside generic -metabolite KEGG:C03642 Taurolithocholate sulfate generic -metabolite KEGG:C03643 [Tyrosine-3-monoxygenase] generic -metabolite KEGG:C03645 alpha-L-Arabinofuranoside generic -metabolite KEGG:C03646 Bis-gamma-glutamylcystine generic -metabolite KEGG:C03647 cis,trans-Hexadienedioate generic -metabolite KEGG:C03648 cis-3,4-Leucopelargonidin generic -metabolite KEGG:C03649 gamma-L-Glutamyl-acceptor generic -metabolite KEGG:C03651 trans-4-Hydroxy-D-proline generic -metabolite KEGG:C03652 (2R,3S)-2,3-Dimethylmalate generic -metabolite KEGG:C03654 (3S,4R)-Ketose 1-phosphate generic -metabolite KEGG:C03656 (S)-5-Amino-3-oxohexanoic acid generic -metabolite KEGG:C03657 1,4-Dihydroxy-2-naphthoate generic -metabolite KEGG:C03658 1-Hydroxyalkyl-sn-glycerol generic -metabolite KEGG:C03659 D-Bornesitol generic -metabolite KEGG:C03660 L-Bornesitol generic -metabolite KEGG:C03661 1F-beta-D-Fructosylsucrose generic -metabolite KEGG:C03662 2'-Hydroxypseudobaptigenin generic -metabolite KEGG:C03663 2',4'-Dihydroxyacetophenone generic -metabolite KEGG:C03664 2,4-Dichlorophenoxyacetate generic -metabolite KEGG:C03665 2-Amino-2-methylpropanoate generic -metabolite KEGG:C03666 2-Carboxy-cis,cis-muconate generic -metabolite KEGG:C03667 2-Hydroxycarbonyl compound generic -metabolite KEGG:C03668 2-Hydroxydicarboxylic acid generic -metabolite KEGG:C03671 2-Pyrone-4,6-dicarboxylate generic -metabolite KEGG:C03672 3-(4-Hydroxyphenyl)lactate generic -metabolite KEGG:C03673 3-(ADP)-2-phosphoglycerate generic -metabolite KEGG:C03674 3-Carbamoyloxymethylcephem generic -metabolite KEGG:C03676 3-Hydroxy-cis,cis-muconate generic -metabolite KEGG:C03677 4,21-Dehydrogeissoschizine generic -metabolite KEGG:C03678 4-Amino-3-hydroxybutanoate generic -metabolite KEGG:C03679 4-Chlorophenylacetonitrile generic -metabolite KEGG:C03680 4-Imidazolone-5-propanoate generic -metabolite KEGG:C03681 5alpha-Pregnane-3,20-dione generic -metabolite KEGG:C03682 6-Acetamido-3-oxohexanoate generic -metabolite KEGG:C03683 6-Demethylsterigmatocystin generic -metabolite KEGG:C03684 6-Pyruvoyltetrahydropterin generic -metabolite KEGG:C03685 7-Methyl-3-oxooctanoyl-CoA generic -metabolite KEGG:C03686 O-Methylsterigmatocystin generic -metabolite KEGG:C03687 Alkane-alpha,omega-diamine generic -metabolite KEGG:C03688 Apo-[acyl-carrier-protein] generic -metabolite KEGG:C03690 Bis(2-ethylhexyl)phthalate generic -metabolite KEGG:C03691 CMP-N-glycoloylneuraminate generic -metabolite KEGG:C03692 1,2-Diacyl-3-beta-D-galactosyl-sn-glycerol generic -metabolite KEGG:C03693 D-Mannose 1,6-bisphosphate generic -metabolite KEGG:C03701 Glycosyl-N-acylsphingosine generic -metabolite KEGG:C03702 Histone N6-methyl-L-lysine generic -metabolite KEGG:C03703 L-5-Carboxymethylhydantoin generic -metabolite KEGG:C03706 Lysosomal-enzyme D-mannose generic -metabolite KEGG:C03707 Monoterpenol acetate ester generic -metabolite KEGG:C03708 N-Acetyl-O-acetylneuraminate generic -metabolite KEGG:C03709 N-Adenylyl-L-phenylalanine generic -metabolite KEGG:C03710 N-Benzyloxycarbonylglycine generic -metabolite KEGG:C03711 N-Methylphenylethanolamine generic -metabolite KEGG:C03712 N2,N5-Dibenzoyl-L-ornithine generic -metabolite KEGG:C03715 O-Alkylglycerone phosphate generic -metabolite KEGG:C03716 Oxaloacetate 4-methyl ester generic -metabolite KEGG:C03717 Oxidized Renilla luciferin generic -metabolite KEGG:C03719 Phenylacetothiohydroximate generic -metabolite KEGG:C03721 Protein tyrosine-O-sulfate generic -metabolite KEGG:C03722 Quinolinate generic -metabolite KEGG:C03723 Ribonucleoside diphosphate generic -metabolite KEGG:C03724 S-(5-Hydroxy-2-furoyl)-CoA generic -metabolite KEGG:C03725 S-Acetylphosphopantetheine generic -metabolite KEGG:C03726 S-Alkyl-L-cysteine S-oxide generic -metabolite KEGG:C03727 S-Carboxymethyl-L-cysteine generic -metabolite KEGG:C03730 Single-stranded nucleotide generic -metabolite KEGG:C03731 Streptomycin 3''-phosphate generic -metabolite KEGG:C03733 UDP-alpha-D-galactofuranose generic -metabolite KEGG:C03734 alpha-D-Glutamyl phosphate generic -metabolite KEGG:C03735 alpha-D-Hexose 6-phosphate generic -metabolite KEGG:C03736 alpha-D-Ribose 5-phosphate generic -metabolite KEGG:C03737 alpha-D-Xylose 1-phosphate generic -metabolite KEGG:C03738 gamma-L-Glutamyl-D-alanine generic -metabolite KEGG:C03739 trans-1,2-Cyclohexanediol generic -metabolite KEGG:C03740 (5-L-Glutamyl)-L-amino acid generic -metabolite KEGG:C03741 (S)-4-Amino-5-oxopentanoate generic -metabolite KEGG:C03742 (S)-4-Hydroxymandelonitrile generic -metabolite KEGG:C03743 1,2,3,5-Tetrahydroxybenzene generic -metabolite KEGG:C03747 11alpha-Hydroxyprogesterone generic -metabolite KEGG:C03748 16alpha-Hydroxyprogesterone generic -metabolite KEGG:C03750 2,6-Dioxo-6-phenylhexanoate generic -metabolite KEGG:C03752 2-Amino-2-deoxy-D-gluconate generic -metabolite KEGG:C03753 2-Chloro-1,4-naphthoquinone generic -metabolite KEGG:C03754 2-Methylpropanoyl phosphate generic -metabolite KEGG:C03755 3'-Deoxydihydrostreptomycin generic -metabolite KEGG:C03757 3,4-Dihydroxymandelonitrile generic -metabolite KEGG:C03758 Dopamine generic -metabolite KEGG:C03761 3-Hydroxy-3-methylglutarate generic -metabolite KEGG:C03762 3-Imidazole-2-oxopropanoate generic -metabolite KEGG:C03764 para-(Dimethylamino)azobenzene generic -metabolite KEGG:C03765 4-Hydroxyphenylacetaldehyde generic -metabolite KEGG:C03766 4-Hydroxyphenylacetonitrile generic -metabolite KEGG:C03767 4-Oxocyclohexanecarboxylate generic -metabolite KEGG:C03768 4-Substituted phenylacetate generic -metabolite KEGG:C03771 5-Guanidino-2-oxopentanoate generic -metabolite KEGG:C03772 5beta-Androstane-3,17-dione generic -metabolite KEGG:C03773 6-Acetyl-beta-D-galactoside generic -metabolite KEGG:C03776 N-Acetyl-D-mannosaminolactone generic -metabolite KEGG:C03779 Bis(4-nitrophenyl)phosphate generic -metabolite KEGG:C03782 D-(1-Aminoethyl)phosphonate generic -metabolite KEGG:C03783 D-Galactosamine 1-phosphate generic -metabolite KEGG:C03785 D-Tagatose 1,6-bisphosphate generic -metabolite KEGG:C03788 Microsomal-membrane protein generic -metabolite KEGG:C03789 N,6-O-Disulfo-D-glucosamine generic -metabolite KEGG:C03790 N-(Carboxymethyl)-D-alanine generic -metabolite KEGG:C03792 N-Acyl-D-mannosaminolactone generic -metabolite KEGG:C03793 N6,N6,N6-Trimethyl-L-lysine generic -metabolite KEGG:C03794 N6-(1,2-Dicarboxyethyl)-AMP generic -metabolite KEGG:C03795 N6-Methyl-2'-deoxyadenosine generic -metabolite KEGG:C03796 Oleandomycin 2'-O-phosphate generic -metabolite KEGG:C03797 Oxidized Photinus luciferin generic -metabolite KEGG:C03798 Peptidylproline (omega=180) generic -metabolite KEGG:C03799 Polyprenylphosphate-glucose generic -metabolite KEGG:C03800 Protein S-methyl-L-cysteine generic -metabolite KEGG:C03801 Pteroylpoly-gamma-glutamate generic -metabolite KEGG:C03802 Ribonucleoside triphosphate generic -metabolite KEGG:C03803 Ribosomal-protein L-alanine generic -metabolite KEGG:C03804 S-Methyl-1-thio-D-glycerate generic -metabolite KEGG:C03805 Stearoylglycerone phosphate generic -metabolite KEGG:C03806 Substituted beta-amino acid generic -metabolite KEGG:C03808 [Pyruvate kinase] phosphate generic -metabolite KEGG:C03811 alpha-D-Glucose 3-phosphate generic -metabolite KEGG:C03817 (S)-3-(Imidazol-5-yl)lactate generic -metabolite KEGG:C03819 1-Acylglycerophosphoinositol generic -metabolite KEGG:C03820 1-Alkyl-2-acetyl-sn-glycerol generic -metabolite KEGG:C03822 2,6-Dichlorophenolindophenol sodium salt generic -metabolite KEGG:C03823 2-(2-Hydroxyacyl)sphingosine generic -metabolite KEGG:C03824 2-Aminomuconate semialdehyde generic -metabolite KEGG:C03826 2-Dehydro-3-deoxy-D-xylonate generic -metabolite KEGG:C03827 2-Dehydro-3-deoxy-L-fuconate generic -metabolite KEGG:C03828 2-Deoxystreptamine phospahte generic -metabolite KEGG:C03829 2S,5S-Methionine sulfoximine generic -metabolite KEGG:C03830 3,4-Dehydro-6-hydroxymellein generic -metabolite KEGG:C03832 3,5,3'-Triiodothyropyruvate generic -metabolite KEGG:C03834 3-Hydroxymonocarboxylic acid generic -metabolite KEGG:C03836 3beta-Hydroxy-Delta5-steroid generic -metabolite KEGG:C03837 4-Methylumbelliferyl acetate generic -metabolite KEGG:C03838 5'-Phosphoribosylglycinamide generic -metabolite KEGG:C03840 Juglone generic -metabolite KEGG:C03843 5-exo-Hydroxy-1,2-campholide generic -metabolite KEGG:C03844 D-Pinitol generic -metabolite KEGG:C03845 5alpha-Cholest-8-en-3beta-ol generic -metabolite KEGG:C03846 6-Acetamido-3-aminohexanoate generic -metabolite KEGG:C03847 6-Phospho-beta-D-galactoside generic -metabolite KEGG:C03848 6F-alpha-D-Galactosylsucrose generic -metabolite KEGG:C03849 Acyl-sn-glycerol 3-phosphate generic -metabolite KEGG:C03850 Adenosine 2',5'-bisphosphate generic -metabolite KEGG:C03851 Adenosine 5'-phosphoramidate generic -metabolite KEGG:C03852 Androstan-3alpha,17beta-diol generic -metabolite KEGG:C03853 Bis(glycerophospho)-glycerol generic -metabolite KEGG:C03855 Cholesteryl-beta-D-glucoside generic -metabolite KEGG:C03858 D-Glucosyldihydrosphingosine generic -metabolite KEGG:C03859 D-Glucosyllipopolysaccharide generic -metabolite KEGG:C03860 Deaminohydroxyblasticidin S generic -metabolite KEGG:C03861 Dibenzo[1,4]dioxin-2,3-dione generic -metabolite KEGG:C03862 Dolichyl phosphate D-mannose generic -metabolite KEGG:C03864 Ethyl (R)-3-hydroxyhexanoate generic -metabolite KEGG:C03865 Ethyl (S)-3-hydroxyhexanoate generic -metabolite KEGG:C03866 Glucuronoxylan D-glucuronate generic -metabolite KEGG:C03868 Indole-3-acetyl-myo-inositol generic -metabolite KEGG:C03870 Isoorientin 2''-O-rhamnoside generic -metabolite KEGG:C03871 L-2-Amino-6-oxoheptanedioate generic -metabolite KEGG:C03872 L-Serine-phosphoethanolamine generic -metabolite KEGG:C03873 Linoleoylphosphatidylcholine generic -metabolite KEGG:C03874 Myosin heavy-chain phosphate generic -metabolite KEGG:C03875 Myosin light chain phosphate generic -metabolite KEGG:C03878 N-Acetyl-beta-D-glucosamine generic -metabolite KEGG:C03879 N-Acetyl-beta-D-hexosaminide generic -metabolite KEGG:C03880 N-Substituted aminoacyl-tRNA generic -metabolite KEGG:C03881 N-Terminal-N-tetradecanoylglycyl-[protein] generic -metabolite KEGG:C03882 Piperine generic -metabolite KEGG:C03884 N(omega)-Methyl-L-arginine generic -metabolite KEGG:C03885 3-Nonaprenyl-4-hydroxybenzoate generic -metabolite KEGG:C03886 Nucleoside 5'-phosphoacylate generic -metabolite KEGG:C03887 Oxidized Cypridina luciferin generic -metabolite KEGG:C03888 Oxidized Watasenia luciferin generic -metabolite KEGG:C03889 Palmitoylphosphatidylcholine generic -metabolite KEGG:C03890 Peptide(N-Glu, Asp, Cystine) generic -metabolite KEGG:C03892 Phosphatidylglycerophosphate generic -metabolite KEGG:C03893 Poly(alpha-L-1,4-guluronate) generic -metabolite KEGG:C03894 Propane-1,2-diol 1-phosphate generic -metabolite KEGG:C03895 Peptide-L-methionine (S)-S-oxide generic -metabolite KEGG:C03897 Quercetin 3,3',7-trissulfate generic -metabolite KEGG:C03898 Quercetin 3,4',7-trissulfate generic -metabolite KEGG:C03899 S-(2-Hydroxyacyl)glutathione generic -metabolite KEGG:C03900 S-(4-Bromophenyl)-L-cysteine generic -metabolite KEGG:C03901 Thiomorpholine 3-carboxylate generic -metabolite KEGG:C03904 alpha-N-Peptidyl-L-glutamate generic -metabolite KEGG:C03905 alpha-N-Peptidyl-L-glutamine generic -metabolite KEGG:C03906 beta-L-Arabinose 1-phosphate generic -metabolite KEGG:C03910 (24R,24(1)R)-Fucosterol epoxide generic -metabolite KEGG:C03912 (S)-1-Pyrroline-5-carboxylate generic -metabolite KEGG:C03916 1-Oleoylglycerophosphocholine generic -metabolite KEGG:C03917 Dihydrotestosterone generic -metabolite KEGG:C03918 2,4-Dichloro-cis,cis-muconate generic -metabolite KEGG:C03920 2-(Methylthio)ethanesulfonate generic -metabolite KEGG:C03921 2-Dehydro-3-deoxy-D-glucarate generic -metabolite KEGG:C03922 2-Deoxystreptamine antibiotic generic -metabolite KEGG:C03924 3'-Phosphooligoribonucleotide generic -metabolite KEGG:C03925 3,5-Dibromo-4-hydroxybenzoate generic -metabolite KEGG:C03926 3-Dehydro-2-deoxy-D-gluconate generic -metabolite KEGG:C03927 3-Hydroxy-4H-pyrid-4-one generic -metabolite KEGG:C03928 3-Phosphoglycerol-glutathione generic -metabolite KEGG:C03929 3-tert-Butyl-5-methylcatechol generic -metabolite KEGG:C03930 3alpha-Hydroxyglycyrrhetinate generic -metabolite KEGG:C03933 5-D-Glutamyl-D-glutamyl-peptide generic -metabolite KEGG:C03935 6beta-Hydroxy-17beta-estradiol generic -metabolite KEGG:C03939 Acetyl-[acyl-carrier protein] generic -metabolite KEGG:C03941 Calmodulin N6-methyl-L-lysine generic -metabolite KEGG:C03942 D-Galactosylglycosaminoglycan generic -metabolite KEGG:C03943 (2R,4S)-2,4-Diaminopentanoate generic -metabolite KEGG:C03944 Dihydro-O-methylsterigmatocystin generic -metabolite KEGG:C03946 Flavonol 3-O-beta-D-glucoside generic -metabolite KEGG:C03947 Glycerol 1,2-cyclic phosphate generic -metabolite KEGG:C03948 N-Glycolyl-D-mannosaminolactone generic -metabolite KEGG:C03951 Luteolin 7-O-beta-D-glucoside generic -metabolite KEGG:C03953 N-Acetylglucosamine 4-sulfate generic -metabolite KEGG:C03954 N-Hydroxy-2-acetamidofluorene generic -metabolite KEGG:C03955 N6-Acetyl-N6-hydroxy-L-lysine generic -metabolite KEGG:C03956 Oligoglycosylglucosylceramide generic -metabolite KEGG:C03957 Peptide 3-hydroxy-L-aspartate generic -metabolite KEGG:C03958 Thyrotropin-releasing hormone generic -metabolite KEGG:C03959 [DNA-directed RNA polymerase] generic -metabolite KEGG:C03961 erythro-3-Hydroxy-Ls-aspartate generic -metabolite KEGG:C03962 (-)-Menthyl O-beta-D-glucoside generic -metabolite KEGG:C03963 Sarsasapogenin generic -metabolite KEGG:C03964 (R)-3-(4-Hydroxyphenyl)lactate generic -metabolite KEGG:C03968 1-Alkyl-sn-glycero-3-phosphate generic -metabolite KEGG:C03969 1-Aminocyclopentanecarboxylate generic -metabolite KEGG:C03972 2,3,4,5-Tetrahydrodipicolinate generic -metabolite KEGG:C03974 2-Acyl-sn-glycerol 3-phosphate generic -metabolite KEGG:C03975 Isoxanthopterin generic -metabolite KEGG:C03979 2-Dehydro-3-deoxy-L-rhamnonate generic -metabolite KEGG:C03980 2-Deoxystreptamine 4-phosphate generic -metabolite KEGG:C03981 2-Hydroxyethylenedicarboxylate generic -metabolite KEGG:C03982 2-Methylpropanal O-methyloxime generic -metabolite KEGG:C03983 3'-Hydroxyloligoribonucleotide generic -metabolite KEGG:C03985 Linalool generic -metabolite KEGG:C03986 3-Hydroxy-4-methylanthranilate generic -metabolite KEGG:C03987 3-Iodo-4-hydroxyphenylpyruvate generic -metabolite KEGG:C03989 Isolychnose generic -metabolite KEGG:C03990 Lithocholic acid generic -metabolite KEGG:C03993 4-(beta-D-Glucosyloxy)benzoate generic -metabolite KEGG:C03994 4-Hydroxymethylphenylhydrazine generic -metabolite KEGG:C03995 4-Nitrophenyl-3-ketovalidamine generic -metabolite KEGG:C03996 5'-O-beta-D-Glucosylpyridoxine generic -metabolite KEGG:C03997 5-Hydroxymethyldeoxycytidylate generic -metabolite KEGG:C03998 7-Methylguanosine 5'-phosphate generic -metabolite KEGG:C03999 Alanyl-poly(glycerolphosphate) generic -metabolite KEGG:C04000 Benzyl 2-methyl-3-oxobutanoate generic -metabolite KEGG:C04002 (Z)-But-1-ene-1,2,4-tricarboxylate generic -metabolite KEGG:C04006 1D-myo-Inositol 3-phosphate generic -metabolite KEGG:C04007 Flavanone 7-O-beta-D-glucoside generic -metabolite KEGG:C04010 Glycoprotein phospho-D-mannose generic -metabolite KEGG:C04013 Multi-methyl-branched acyl-CoA generic -metabolite KEGG:C04015 N-Acetyl-4-O-acetylneuraminate generic -metabolite KEGG:C04016 N-Acetyl-7-O-acetylneuraminate generic -metabolite KEGG:C04017 N-Acetyl-9-O-acetylneuraminate generic -metabolite KEGG:C04018 N-Acetyl-D-galactosaminoglycan generic -metabolite KEGG:C04019 N-Acetyl-alpha-D-glucosaminide generic -metabolite KEGG:C04020 D-Lysopine generic -metabolite KEGG:C04021 Phosphatidylinositol phosphate generic -metabolite KEGG:C04022 S,S-Dimethyl-beta-propiothetin generic -metabolite KEGG:C04024 Vitexin 2''-O-beta-D-glucoside generic -metabolite KEGG:C04025 alpha,omega-Dicarboxylic acid generic -metabolite KEGG:C04026 alpha-N-Substituted L-arginine generic -metabolite KEGG:C04030 (2,3-Dihydroxybenzoyl)adenylate generic -metabolite KEGG:C04031 (3S)-3-Hydroxyacyl-hydrolipoate generic -metabolite KEGG:C04033 1,3,6,8-Naphthalenetetrol generic -metabolite KEGG:C04034 (1->6)-beta-D-Galactosylgalactogen generic -metabolite KEGG:C04036 1-Palmitoylglycerol 3-phosphate generic -metabolite KEGG:C04037 1-Phospho-alpha-D-galacturonate generic -metabolite KEGG:C04039 2,3-Dihydroxy-3-methylbutanoate generic -metabolite KEGG:C04042 20alpha-Hydroxy-4-pregnen-3-one generic -metabolite KEGG:C04043 3,4-Dihydroxyphenylacetaldehyde generic -metabolite KEGG:C04044 3-(2,3-Dihydroxyphenyl)propanoate generic -metabolite KEGG:C04045 3-(3,4-Dihydroxyphenyl)pyruvate generic -metabolite KEGG:C04046 3-D-Glucosyl-1,2-diacylglycerol generic -metabolite KEGG:C04047 3-Hydroxy-2-methylpropanoyl-CoA generic -metabolite KEGG:C04049 4-Hydroxy-4-methyl-2-oxoadipate generic -metabolite KEGG:C04050 4-Hydroxyaminoquinoline N-oxide generic -metabolite KEGG:C04051 5-Amino-4-imidazolecarboxyamide generic -metabolite KEGG:C04052 5-Carboxy-2-oxohept-3-enedioate generic -metabolite KEGG:C04053 5-Dehydro-4-deoxy-D-glucuronate generic -metabolite KEGG:C04054 5-Hydroxybenzimidazolylcob(I)amide generic -metabolite KEGG:C04056 Rumenic acid generic -metabolite KEGG:C04058 Bis(5'-adenosyl) pentaphosphate generic -metabolite KEGG:C04061 Cytochrome c N6-methyl-L-lysine generic -metabolite KEGG:C04062 D-myo-Inositol 1,3-bisphosphate generic -metabolite KEGG:C04063 D-myo-Inositol 3,4-bisphosphate generic -metabolite KEGG:C04064 D-myo-Inositol 4,5-bisphosphate generic -metabolite KEGG:C04067 Diethyl 2-methyl-3-oxosuccinate generic -metabolite KEGG:C04068 Flavonol 3-O-D-xylosylglucoside generic -metabolite KEGG:C04069 Flavonol 3-O-D-xylosylglycoside generic -metabolite KEGG:C04070 Gibberellin 2-O-beta-D-glucoside generic -metabolite KEGG:C04071 Guanidinoethyl methyl phosphate generic -metabolite KEGG:C04072 Heparin-glucosamine 3-O-sulfate generic -metabolite KEGG:C04073 Heparosan-N-sulfate L-iduronate generic -metabolite KEGG:C04074 Isoflavone 7-O-beta-D-glucoside generic -metabolite KEGG:C04075 2-Amino-4-chloro-4-pentenoic acid generic -metabolite KEGG:C04076 L-2-Aminoadipate 6-semialdehyde generic -metabolite KEGG:C04078 Methylmethionine sulfonium salt generic -metabolite KEGG:C04079 N-((R)-Pantothenoyl)-L-cysteine generic -metabolite KEGG:C04080 N-(Long-chain-acyl)ethanolamine generic -metabolite KEGG:C04081 N-Hydroxy-4-acetylaminobiphenyl generic -metabolite KEGG:C04083 N6-(Delta2-Isopentenyl)-adenine generic -metabolite KEGG:C04084 Pregna-4,9(11)-diene-3,20-dione generic -metabolite KEGG:C04087 Protein N(tau)-methyl-L-histidine generic -metabolite KEGG:C04088 Octadecanoyl-[acyl-carrier protein] generic -metabolite KEGG:C04089 UDP-4-dehydro-6-deoxy-D-glucose generic -metabolite KEGG:C04090 Ubiquitin C-terminal thiolester generic -metabolite KEGG:C04091 cis-1,2-Dihydrobenzene-1,2-diol generic -metabolite KEGG:C04092 Delta1-Piperideine-2-carboxylate generic -metabolite KEGG:C04093 poly-cis-Polyprenyl diphosphate generic -metabolite KEGG:C04097 2-alpha-D-Mannosylheteroglycan generic -metabolite KEGG:C04098 3-alpha-D-Mannosylheteroglycan generic -metabolite KEGG:C04099 1,4-alpha-D-Glucooligosaccharide generic -metabolite KEGG:C04100 1-Linoleoylglycerophosphocholine generic -metabolite KEGG:C04101 1-O,6-O-Digalloyl-beta-D-glucose generic -metabolite KEGG:C04102 1-Palmitoylglycerophosphocholine generic -metabolite KEGG:C04103 13-beta-D-Glucosyloxydocosanoate generic -metabolite KEGG:C04104 2,3-Dihydroxy-3-methylpentanoate generic -metabolite KEGG:C04105 2,5-Dihydro-5-oxofuran-2-acetate generic -metabolite KEGG:C04106 2-(Hydroxymethyl)-4-oxobutanoate generic -metabolite KEGG:C04108 20-Hydroxy-3-oxopregn-4-en-21-al generic -metabolite KEGG:C04109 Gossypetin generic -metabolite KEGG:C04110 3,5-Dihydroxy-1,4-naphthoquinone generic -metabolite KEGG:C04111 3-(Phosphoacetylamido)-L-alanine generic -metabolite KEGG:C04112 3-Methyl-cis,cis-hexadienedioate generic -metabolite KEGG:C04114 (E)-4-(Trimethylammonio)but-2-enoate generic -metabolite KEGG:C04115 4-Carboxy-4-hydroxy-2-oxoadipate generic -metabolite KEGG:C04116 4-Substituted phenylacetonitrile generic -metabolite KEGG:C04117 5'-Phospho-RNA 3'-mononucleotide generic -metabolite KEGG:C04118 Isocorypalmine generic -metabolite KEGG:C04121 CMP-3-deoxy-D-manno-octulosonate generic -metabolite KEGG:C04122 D-1-Aminopropan-2-ol O-phosphate generic -metabolite KEGG:C04125 [Isocitrate dehydrogenase (NADP+)] generic -metabolite KEGG:C04126 L-1-Aminopropan-2-ol O-phosphate generic -metabolite KEGG:C04128 Low-density lipoprotein L-serine generic -metabolite KEGG:C04130 Methyl 2-diazoacetamidohexanoate generic -metabolite KEGG:C04131 Monoamide of dicarboxylate generic -metabolite KEGG:C04132 N-Acetyl-D-glucosamine 6-sulfate generic -metabolite KEGG:C04133 N-Acetyl-L-glutamate 5-phosphate generic -metabolite KEGG:C04134 N-Acetyl-alpha-D-galactosaminide generic -metabolite KEGG:C04135 N-Acetyl-beta-D-galactosaminyl-R generic -metabolite KEGG:C04136 N-Acyl-D-glucosamine 6-phosphate generic -metabolite KEGG:C04137 D-Octopine generic -metabolite KEGG:C04138 N(alpha)-gamma-L-Glutamylhistamine generic -metabolite KEGG:C04141 Phospho-beta-adrenergic receptor generic -metabolite KEGG:C04142 Protein glutamate methyl ester generic -metabolite KEGG:C04143 Protein N(omega)-methyl-L-arginine generic -metabolite KEGG:C04144 Tetrahydropteroyltri-L-glutamate generic -metabolite KEGG:C04145 all-trans-Nonaprenyl diphosphate generic -metabolite KEGG:C04146 all-trans-Octaprenyl diphosphate generic -metabolite KEGG:C04147 alpha-D-Glucosyl-(1,3)-D-mannose generic -metabolite KEGG:C04148 Phenylacetylglutamine generic -metabolite KEGG:C04149 [alpha-Tubulin]-N6-acetyl-L-lysine generic -metabolite KEGG:C04150 beta-D-Mannosylphosphodecaprenol generic -metabolite KEGG:C04152 rRNA containing N1-methylguanine generic -metabolite KEGG:C04153 rRNA containing N2-methylguanine generic -metabolite KEGG:C04154 rRNA containing N6-methyladenine generic -metabolite KEGG:C04155 tRNA containing 5-methylcytosine generic -metabolite KEGG:C04156 tRNA containing N1-methyladenine generic -metabolite KEGG:C04157 tRNA containing N1-methylguanine generic -metabolite KEGG:C04158 tRNA containing N2-methylguanine generic -metabolite KEGG:C04159 tRNA containing N6-methyladenine generic -metabolite KEGG:C04160 tRNA containing N7-methylguanine generic -metabolite KEGG:C04161 tRNA containing a thionucleotide generic -metabolite KEGG:C04164 trans-Cinnamoyl beta-D-glucoside generic -metabolite KEGG:C04165 (+)-Neomenthyl O-beta-D-glucoside generic -metabolite KEGG:C04166 (+/-)-6-Hydroxy-3-oxo-alpha-ionol generic -metabolite KEGG:C04167 (+/-)-trans-Acenaphthene-1,2-diol generic -metabolite KEGG:C04170 13-(2-Methylcrotonoyl)oxylupanine generic -metabolite KEGG:C04171 (2S,3S)-2,3-Dihydro-2,3-dihydroxybenzoate generic -metabolite KEGG:C04175 2-Deoxy-D-ribose 1,5-bisphosphate generic -metabolite KEGG:C04178 Bromoxynil generic -metabolite KEGG:C04180 cis-Dec-3-enoyl-[acp] generic -metabolite KEGG:C04181 3-Hydroxy-3-methyl-2-oxobutanoic acid generic -metabolite KEGG:C04185 5,6-Dihydroxyindole-2-carboxylate generic -metabolite KEGG:C04186 5-Carboxymethyl-2-hydroxymuconate generic -metabolite KEGG:C04187 5-Methyldeoxycytidine diphosphate generic -metabolite KEGG:C04188 S-Methyl-5-thio-D-ribose 1-phosphate generic -metabolite KEGG:C04191 Dihydrostreptomycin 3''-phosphate generic -metabolite KEGG:C04193 Flavonol 3-O-D-xylosylgalactoside generic -metabolite KEGG:C04194 Flavonol 3-O-[alpha-L-rhamnosyl-(1->6)-beta-D-glucoside] generic -metabolite KEGG:C04195 Glycoprotein phosphatidylinositol generic -metabolite KEGG:C04196 Heparosan-N-sulfate D-glucuronate generic -metabolite KEGG:C04197 Indole-3-acetyl-beta-1-D-glucoside generic -metabolite KEGG:C04199 Isovitexin 2''-O-beta-D-glucoside generic -metabolite KEGG:C04201 L-Tyrosine methyl ester 4-sulfate generic -metabolite KEGG:C04202 Long-chain-fatty-acyl ethyl ester generic -metabolite KEGG:C04203 N,N-Dimethyl-1,4-phenylenediamine generic -metabolite KEGG:C04204 N-(2,3-Dihydroxybenzoyl)-L-serine generic -metabolite KEGG:C04205 N-(3,4-Dichlorophenyl)-malonamate generic -metabolite KEGG:C04207 N-Benzoyl-4-hydroxyanthranilate generic -metabolite KEGG:C04208 N-Benzoyl-4-methoxyanthranilate generic -metabolite KEGG:C04209 3-(Carboxycarbonylamino)-L-alanine generic -metabolite KEGG:C04210 N5-(L-1-Carboxyethyl)-L-ornithine generic -metabolite KEGG:C04211 N(6)-[(Indol-3-yl)acetyl]-L-lysine generic -metabolite KEGG:C04212 3',5'-Cyclic nucleotide generic -metabolite KEGG:C04213 Dolichyl diphosphooligosaccharide generic -metabolite KEGG:C04214 Phospho-[tyrosine-3-monoxygenase] generic -metabolite KEGG:C04215 Phospholipid methylene fatty acid generic -metabolite KEGG:C04216 all-trans-Heptaprenyl diphosphate generic -metabolite KEGG:C04217 all-trans-Pentaprenyl diphosphate generic -metabolite KEGG:C04218 alpha,alpha'-Trehalose 6-mycolate generic -metabolite KEGG:C04219 alpha-D-Aldosyl beta-D-fructoside generic -metabolite KEGG:C04221 trans-1,2-Dihydrobenzene-1,2-diol generic -metabolite KEGG:C04223 (+/-)-6-Hydroxy-3-oxo-alpha-ionone generic -metabolite KEGG:C04225 (Z)-But-2-ene-1,2,3-tricarboxylate generic -metabolite KEGG:C04226 6-Oxo-1,4,5,6-tetrahydronicotinate generic -metabolite KEGG:C04227 Octopamine generic -metabolite KEGG:C04229 1-(Indol-3-yl)propanol 3-phosphate generic -metabolite KEGG:C04230 1-Acyl-sn-glycero-3-phosphocholine generic -metabolite KEGG:C04232 2'-Deoxyribonucleoside diphosphate generic -metabolite KEGG:C04233 2-Acyl-sn-glycero-3-phosphocholine generic -metabolite KEGG:C04234 2-Carboxy-D-arabinitol 1-phosphate generic -metabolite KEGG:C04235 3-Acetylenic fatty acyl thioesters generic -metabolite KEGG:C04236 (2S)-2-Isopropyl-3-oxosuccinate generic -metabolite KEGG:C04237 3-Hydroxy-3-methyl-2-oxopentanoic acid generic -metabolite KEGG:C04239 5'-Dephospho-RNA 3'-mononucleotide generic -metabolite KEGG:C04242 5-Fluorodeoxyuridine monophosphate generic -metabolite KEGG:C04244 6-Lactoyl-5,6,7,8-tetrahydropterin generic -metabolite KEGG:C04246 But-2-enoyl-[acyl-carrier protein] generic -metabolite KEGG:C04247 D-Galactosyl-(1->4)-beta-D-glucosyl-R generic -metabolite KEGG:C04248 6-(alpha-D-Glucosaminyl)-1-phosphatidyl-1D-myo-inositol generic -metabolite KEGG:C04250 DNA containing 6-O-methylguanine generic -metabolite KEGG:C04251 Deoxylimononic acid D-ring-lactone generic -metabolite KEGG:C04253 Electron-transferring flavoprotein generic -metabolite KEGG:C04255 N-Acetyl-D-galactosamine 6-sulfate generic -metabolite KEGG:C04256 N-Acetyl-D-glucosamine 1-phosphate generic -metabolite KEGG:C04257 N-Acetyl-D-mannosamine 6-phosphate generic -metabolite KEGG:C04258 N-Formyl-L-methionylaminoacyl-tRNA generic -metabolite KEGG:C04259 N,N-Dimethylhistidine generic -metabolite KEGG:C04260 O-D-Alanyl-poly(ribitol phosphate) generic -metabolite KEGG:C04261 Protein N(pi)-phospho-L-histidine generic -metabolite KEGG:C04262 Protein N(tau)-phospho-L-histidine generic -metabolite KEGG:C04264 S-(4-Bromophenyl)-mercaptopyruvate generic -metabolite KEGG:C04265 alpha,alpha'-Trehalose 6-palmitate generic -metabolite KEGG:C04266 alpha-D-Glucosyllipopolysaccharide generic -metabolite KEGG:C04268 dTDP-4-amino-4,6-dideoxy-D-glucose generic -metabolite KEGG:C04271 3,9-Dihydroxypterocarpan generic -metabolite KEGG:C04272 (R)-2,3-Dihydroxy-3-methylbutanoate generic -metabolite KEGG:C04273 (S)-Mandelonitrile beta-D-glucoside generic -metabolite KEGG:C04274 1,2-Epoxy-3-(p-Nitrophenoxy)propane generic -metabolite KEGG:C04275 1,2-Bis-O-sinapoyl-beta-D-glucose generic -metabolite KEGG:C04276 1,6-alpha-D-Mannosyloligosaccharide generic -metabolite KEGG:C04277 1,8-Diazacyclotetradecane-2,9-dione generic -metabolite KEGG:C04280 1-Guanidino-1-deoxy-scyllo-inositol generic -metabolite KEGG:C04281 L-1-Pyrroline-3-hydroxy-5-carboxylate generic -metabolite KEGG:C04282 1-Pyrroline-4-hydroxy-2-carboxylate generic -metabolite KEGG:C04284 2-Heptyl-4-hydroxyquinoline-N-oxide generic -metabolite KEGG:C04285 3,5-Dibromo-4-hydroxyphenylpyruvate generic -metabolite KEGG:C04286 3,5-Dinitro-4-hydroxyphenylpyruvate generic -metabolite KEGG:C04287 3D-3,5/4-Trihydroxycyclohexane-1,2-dione generic -metabolite KEGG:C04290 4-(3-Methylbut-2-enyl)-L-tryptophan generic -metabolite KEGG:C04291 4-(Dimethylamino)phenylazoxybenzene generic -metabolite KEGG:C04292 5'-Phosphonucleoside 3'-diphosphate generic -metabolite KEGG:C04293 Chrysoeriol generic -metabolite KEGG:C04294 5-(2-Hydroxyethyl)-4-methylthiazole generic -metabolite KEGG:C04295 Androstenediol generic -metabolite KEGG:C04297 CDP-4-dehydro-3,6-dideoxy-D-glucose generic -metabolite KEGG:C04298 Holo-[citrate (pro-3S)-lyase] generic -metabolite KEGG:C04299 D-myo-Inositol 1,2-cyclic phosphate generic -metabolite KEGG:C04300 Estradiol-17alpha 3-D-glucuronoside generic -metabolite KEGG:C04301 N(alpha)-t-Butoxycarbonyl-L-leucine generic -metabolite KEGG:C04302 N-(5-Phospho-D-ribosyl)anthranilate generic -metabolite KEGG:C04303 N-Benzoyl-D-arginine-4-nitroanilide generic -metabolite KEGG:C04305 N-Long-chain-fatty-acyl-L-glutamate generic -metabolite KEGG:C04307 P1,P2-Bis(5'-adenosyl) triphosphate generic -metabolite KEGG:C04308 Phosphatidyl-N-dimethylethanolamine generic -metabolite KEGG:C04309 Phosphoenol-4-deoxy-3-tetrulosonate generic -metabolite KEGG:C04311 Protein L-isoaspartate methyl ester generic -metabolite KEGG:C04312 RNA terminal-2',3'-cyclic-phosphate generic -metabolite KEGG:C04313 beta-Substituted alpha-L-amino acid generic -metabolite KEGG:C04314 cis-1,2-Dihydronaphthalene-1,2-diol generic -metabolite KEGG:C04315 2-Acyl-3-O-(beta-D-galactosyl)-sn-glycerol generic -metabolite KEGG:C04316 (1-Hydroxycyclohexan-1-yl)acetyl-CoA generic -metabolite KEGG:C04317 1-Organyl-2-lyso-sn-glycero-3-phosphocholine generic -metabolite KEGG:C04318 11-O-Demethyl-17-O-deacetylvindoline generic -metabolite KEGG:C04322 Delta1-Pyrroline-5-carboxylate generic -metabolite KEGG:C04323 3,5-Dichloro-4-hydroxyphenylpyruvate generic -metabolite KEGG:C04324 (1E,3E)-4-Hydroxybuta-1,3-diene-1,2,4-tricarboxylate generic -metabolite KEGG:C04327 4-Methyl-5-(2-phosphooxyethyl)thiazole generic -metabolite KEGG:C04328 5'-Phosphomonoester oligonucleotides generic -metabolite KEGG:C04330 5,10-Methenyltetrahydromethanopterin generic -metabolite KEGG:C04332 6,7-Dimethyl-8-(D-ribityl)lumazine generic -metabolite KEGG:C04333 Bis-D-fructose 2',1:2,1'-dianhydride generic -metabolite KEGG:C04334 Acetyl-[citrate (pro-3S)-lyase] generic -metabolite KEGG:C04335 N(alpha)-Benzyloxycarbonyl-L-leucine generic -metabolite KEGG:C04336 N-Glycolyl-D-mannosamine 6-phosphate generic -metabolite KEGG:C04337 N(omega)-Nitro-L-arginine methyl ester generic -metabolite KEGG:C04339 Peptide N-(ADP-D-ribosyl)diphthamide generic -metabolite KEGG:C04340 Phospholipid cyclopropane fatty acid generic -metabolite KEGG:C04341 Ribosomal-protein N-acetyl-L-alanine generic -metabolite KEGG:C04342 Soluble variant-surface-glycoprotein generic -metabolite KEGG:C04346 dTDP-4-amino-4,6-dideoxy-D-galactose generic -metabolite KEGG:C04347 (+)-2,3-Dienoyl fatty acyl thioesters generic -metabolite KEGG:C04348 L-Malyl-CoA generic -metabolite KEGG:C04349 (4S)-4,6-Dihydroxy-2,5-dioxohexanoate generic -metabolite KEGG:C04350 (E)-4-Hydroxyphenylacetaldehyde oxime generic -metabolite KEGG:C04351 (R)-2-Methylimino-1-phenylpropan-1-ol generic -metabolite KEGG:C04352 (R)-4'-Phosphopantothenoyl-L-cysteine generic -metabolite KEGG:C04353 (Z)-4-Hydroxyphenylacetaldehyde oxime generic -metabolite KEGG:C04354 1,2-beta-D-Glucuronosyl-D-glucuronate generic -metabolite KEGG:C04359 1-Deoxy-D-altro-heptulose 7-phosphate generic -metabolite KEGG:C04360 1-O,2-O,6-O-Trigalloyl-beta-D-glucose generic -metabolite KEGG:C04361 1-O-Alkyl-2-acetyl-3-acyl-sn-glycerol generic -metabolite KEGG:C04365 3'-Hydroxy-terminated oligonucleotide generic -metabolite KEGG:C04366 3-(2-Carboxyethenyl)-cis,cis-muconate generic -metabolite KEGG:C04367 3-(3,5-Diiodo-4-hydroxyphenyl)lactate generic -metabolite KEGG:C04368 3-Amino-3-(4-hydroxyphenyl)propanoate generic -metabolite KEGG:C04371 3-Mercapto-2-mercaptomethylpropanoate generic -metabolite KEGG:C04372 3-O-L-Alanyl-1-O-phosphatidylglycerol generic -metabolite KEGG:C04373 Etiocholanolone generic -metabolite KEGG:C04375 4-N-(N-Acetyl-D-glucosaminyl)-protein generic -metabolite KEGG:C04376 5'-Phosphoribosyl-N-formylglycinamide generic -metabolite KEGG:C04377 5,10-Methylenetetrahydromethanopterin generic -metabolite KEGG:C04378 7-alpha-D-Ribosyladenine 5'-phosphate generic -metabolite KEGG:C04379 9,11alpha-Epoxypregn-4-ene-3,20-dione generic -metabolite KEGG:C04381 DNA 4,6-diamino-5-formamidopyrimidine generic -metabolite KEGG:C04382 Dihydrostreptomycin 3'alpha-phosphate generic -metabolite KEGG:C04384 Heparan sulfate alpha-D-glucosaminide generic -metabolite KEGG:C04385 Flavonol 3-O-(6-O-malonyl-beta-D-glucoside) generic -metabolite KEGG:C04386 Myelin proteolipid O-palmitoylprotein generic -metabolite KEGG:C04387 N-Acetyl-alpha-D-galactosaminyl-polypeptide generic -metabolite KEGG:C04390 N6-Acetyl-LL-2,6-diaminoheptanedioate generic -metabolite KEGG:C04391 O-Phospho-microsomal-membrane protein generic -metabolite KEGG:C04392 P1,P4-Bis(5'-xanthosyl) tetraphosphate generic -metabolite KEGG:C04394 Peptidoglycan(N-acetyl-D-glucosamine) generic -metabolite KEGG:C04395 Phospho-[DNA-directed RNA polymerase] generic -metabolite KEGG:C04397 Procollagen trans-3-hydroxy-L-proline generic -metabolite KEGG:C04398 Procollagen trans-4-hydroxy-L-proline generic -metabolite KEGG:C04399 S-Methyl-3-phospho-1-thio-D-glycerate generic -metabolite KEGG:C04403 beta-D-Glucosyl-1-phosphoundecaprenol generic -metabolite KEGG:C04404 trans-4-Hydroxycyclohexanecarboxylate generic -metabolite KEGG:C04405 (2S,3S)-3-Hydroxy-2-methylbutanoyl-CoA generic -metabolite KEGG:C04409 2-Amino-3-carboxymuconate semialdehyde generic -metabolite KEGG:C04411 (2R,3S)-3-Isopropylmalate generic -metabolite KEGG:C04415 4-O-beta-D-Glucosyl-4-hydroxycinnamate generic -metabolite KEGG:C04416 5alpha-Ergosta-7,22-diene-3beta,5-diol generic -metabolite KEGG:C04417 6-alpha-D-(1,4-alpha-D-Glucano)-glucan generic -metabolite KEGG:C04418 N-Acetyl-L-phenylalanyl-L-diiodotyrosine generic -metabolite KEGG:C04419 Carboxybiotin-carboxyl-carrier protein generic -metabolite KEGG:C04420 D-Fructofuranose 1,2':2,3'-dianhydride generic -metabolite KEGG:C04421 N-Succinyl-LL-2,6-diaminoheptanedioate generic -metabolite KEGG:C04422 N6-Alkylaminopurine-7-beta-D-glucoside generic -metabolite KEGG:C04423 Nicotinamide hypoxanthine dinucleotide generic -metabolite KEGG:C04424 S-(2-Methylpropanoyl)-dihydrolipoamide generic -metabolite KEGG:C04425 S-Adenosyl-4-methylthio-2-oxobutanoate generic -metabolite KEGG:C04426 UDP-N-acetyl-D-galactosamine 4-sulfate generic -metabolite KEGG:C04428 alpha-D-Galactosyl-N-acetyllactosamine generic -metabolite KEGG:C04429 beta-D-Glucosylpoly(ribitol phosphate) generic -metabolite KEGG:C04431 cis-4-Carboxymethylenebut-2-en-4-olide generic -metabolite KEGG:C04432 tRNA containing 6-isopentenyladenosine generic -metabolite KEGG:C04433 (E)-3,7-Dimethylocta-1,6-diene-3,8-diol generic -metabolite KEGG:C04434 (1E)-4-Oxobut-1-ene-1,2,4-tricarboxylate generic -metabolite KEGG:C04435 (Z)-2-Methyl-5-isopropylhexa-2,5-dienal generic -metabolite KEGG:C04437 1-(5-Phosphoribosyl)imidazole-4-acetate generic -metabolite KEGG:C04438 1-Acyl-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C04441 Peptide 2-(3-carboxy-3-aminopropyl)-L-histidine generic -metabolite KEGG:C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate generic -metabolite KEGG:C04443 3-O-Methylquercetin generic -metabolite KEGG:C04444 3,7,4'-Tri-O-methylquercetin generic -metabolite KEGG:C04445 3,4-Dehydrothiomorpholine-3-carboxylate generic -metabolite KEGG:C04446 3-(3,4-Dihydroxypyridin-1-yl)-L-alanine generic -metabolite KEGG:C04447 3-Carboxy-4-methoxy-N-methyl-2-pyridone generic -metabolite KEGG:C04448 3-Hydroxymethyl ceph-3-em-4-carboxylate generic -metabolite KEGG:C04452 4-Nitrophenol-alpha-D-galactopyranoside generic -metabolite KEGG:C04453 4alpha-Methyl-5alpha-cholest-7-en-3-one generic -metabolite KEGG:C04454 5-Amino-6-(5'-phospho-D-ribitylamino)uracil generic -metabolite KEGG:C04457 D-Alanyl-alanyl-poly(glycerolphosphate) generic -metabolite KEGG:C04458 Dihydrostreptomycin 6,3''-bis-phosphate generic -metabolite KEGG:C04459 Glucuronoxylan 4-O-methyl-D-glucuronate generic -metabolite KEGG:C04461 N-Acetyl-D-glucosamine 1,6-bisphosphate generic -metabolite KEGG:C04462 N-Succinyl-2-L-amino-6-oxoheptanedioate generic -metabolite KEGG:C04465 alpha,alpha'-Trehalose 6,6'-bismycolate generic -metabolite KEGG:C04466 alpha-2,8-Linked polymer of sialic acid generic -metabolite KEGG:C04468 (+)-cis-3,4-Dihydrophenanthrene-3,4-diol generic -metabolite KEGG:C04469 (+/-)-2-(4'-Isobutylphenyl)propionitrile generic -metabolite KEGG:C04471 (4S,5S)-4,5-Dihydroxy-2,6-dioxohexanoate generic -metabolite KEGG:C04473 3-alpha-D-Galactosyl-[lipopolysaccharide glucose] generic -metabolite KEGG:C04475 1-Alkyl-2-acylglycerophosphoethanolamine generic -metabolite KEGG:C04476 1-Alkyl-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C04477 1D-myo-Inositol 1,3,4,6-tetrakisphosphate generic -metabolite KEGG:C04478 3-Deoxy-D-manno-octulosonate 8-phosphate generic -metabolite KEGG:C04479 2-Hydroxy-6-oxonona-2,4-diene-1,9-dioate generic -metabolite KEGG:C04480 3-Carboxy-2-hydroxymuconate semialdehyde generic -metabolite KEGG:C04482 3-O-L-Lysyl-1-O-phosphatidylglycerol generic -metabolite KEGG:C04483 Deoxycholic acid generic -metabolite KEGG:C04484 4-Carboxy-2-hydroxymuconate semialdehyde generic -metabolite KEGG:C04485 5-(4-Acetoxybut-1-ynyl)-2,2'-bithiophene generic -metabolite KEGG:C04486 5-(4-Hydroxybut-1-ynyl)-2,2'-bithiophene generic -metabolite KEGG:C04487 5-(D-Galactosyloxy)-L-lysine-procollagen generic -metabolite KEGG:C04488 5-Methyl-5,6,7,8-tetrahydromethanopterin generic -metabolite KEGG:C04489 5-Methyltetrahydropteroyltri-L-glutamate generic -metabolite KEGG:C04491 Cyanidin-3-rhamnoglucoside chloride generic -metabolite KEGG:C04494 Guanosine 3'-diphosphate 5'-triphosphate generic -metabolite KEGG:C04498 p-Coumaroylagmatine generic -metabolite KEGG:C04500 N-Acetyl-D-glucosaminyldiphosphodolichol generic -metabolite KEGG:C04501 N-Acetyl-alpha-D-glucosamine 1-phosphate generic -metabolite KEGG:C04502 N-Acetyl-beta-D-glucosaminyl-glycopeptide generic -metabolite KEGG:C04503 N'-Phosphoguanidinoethyl methyl phosphate generic -metabolite KEGG:C04504 N3-Acetyl-2-deoxystreptamine antibiotic generic -metabolite KEGG:C04505 Polysialic acid acetylated at O-7 generic -metabolite KEGG:C04506 Protein C-terminal S-farnesyl-L-cysteine generic -metabolite KEGG:C04507 alpha-D-Galactosyl-diphosphoundecaprenol generic -metabolite KEGG:C04508 alpha-D-Glucosylpoly(glycerol phosphate) generic -metabolite KEGG:C04509 di-trans,poly-cis-Decaprenyl diphosphate generic -metabolite KEGG:C04510 3-[(3S)-3-Amino-3-carboxypropyl]-uridine in tRNA generic -metabolite KEGG:C04511 tRNA(Asp)-O-5''-beta-D-mannosylqueuosine generic -metabolite KEGG:C04512 trans,trans-2,3,4,5-Tetradehydroacyl-CoA generic -metabolite KEGG:C04514 (1S,2S)-1,2-Dihydronaphthalene-1,2-diol generic -metabolite KEGG:C04515 (3S)-3-Hydroxyacyl-N-acylthioethanolamine generic -metabolite KEGG:C04516 1,2,3,6-Tetrakis-O-galloyl-beta-D-glucose generic -metabolite KEGG:C04517 1-(1-Alkenyl)-sn-glycero-3-phosphocholine generic -metabolite KEGG:C04518 17alpha,20alpha-Dihydroxypregn-4-en-3-one generic -metabolite KEGG:C04520 1D-myo-Inositol 3,4,5,6-tetrakisphosphate generic -metabolite KEGG:C04521 2,7-Anhydro-alpha-N-acetylneuraminic acid generic -metabolite KEGG:C04522 2-Chloro-2,5-dihydro-5-oxofuran-2-acetate generic -metabolite KEGG:C04524 2-Protocatechoylphloroglucinolcarboxylate generic -metabolite KEGG:C04525 Fecosterol generic -metabolite KEGG:C04526 3'-Deoxydihydrostreptomycin 3''-phosphate generic -metabolite KEGG:C04527 Corniculatusin generic -metabolite KEGG:C04529 (3S,4S)-3-Hydroxytetradecane-1,3,4-tricarboxylate generic -metabolite KEGG:C04530 4,4-Dimethyl-5alpha-cholest-7-en-3beta-ol generic -metabolite KEGG:C04534 6-Phospho-beta-D-glucosyl-(1,4)-D-glucose generic -metabolite KEGG:C04535 7-Methyl-2-hydroxy-6-oxoocta-2,4-dienoate generic -metabolite KEGG:C04536 Magnesium protoporphyrin monomethyl ester generic -metabolite KEGG:C04537 N,N'-Diacetylchitobiosyldiphosphodolichol generic -metabolite KEGG:C04539 N-Acetyl-D-glucosaminyllipopolysaccharide generic -metabolite KEGG:C04540 N4-(Acetyl-beta-D-glucosaminyl)asparagine generic -metabolite KEGG:C04541 N5-Dinitrophenyl-L-ornithine methyl ester generic -metabolite KEGG:C04542 Protein beta-D-galactosyl-L-hydroxylysine generic -metabolite KEGG:C04543 Buthionine sulfoximine generic -metabolite KEGG:C04544 gamma-L-Glutamyl-L-cysteinyl-beta-alanine generic -metabolite KEGG:C04545 tRNA containing 2'-O-methylguanosine generic -metabolite KEGG:C04546 (R)-3-((R)-3-Hydroxybutanoyloxy)butanoate generic -metabolite KEGG:C04547 1,2-Bis(4-hydroxy-3-methoxyphenyl)ethylene generic -metabolite KEGG:C04548 Synephrine generic -metabolite KEGG:C04549 1-Phosphatidyl-1D-myo-inositol 3-phosphate generic -metabolite KEGG:C04552 Chrysosplenol D generic -metabolite KEGG:C04553 3-Carboxy-2,5-dihydro-5-oxofuran-2-acetate generic -metabolite KEGG:C04554 3alpha,7alpha-Dihydroxy-5beta-cholestanate generic -metabolite KEGG:C04555 Dehydroepiandrosterone sulfate generic -metabolite KEGG:C04556 4-Amino-2-methyl-5-(phosphooxymethyl)pyrimidine generic -metabolite KEGG:C04558 3-Methylmuconolactone generic -metabolite KEGG:C04559 4-Methylmuconolactone generic -metabolite KEGG:C04561 Benzyl (2R,3S)-2-methyl-3-hydroxybutanoate generic -metabolite KEGG:C04562 Benzyl (2S,3S)-2-methyl-3-hydroxybutanoate generic -metabolite KEGG:C04563 D-myo-Inositol 1,2,4,5,6-pentakisphosphate generic -metabolite KEGG:C04564 [Isocitrate dehydrogenase (NADP+)] phosphate generic -metabolite KEGG:C04565 Low-density lipoprotein O-phospho-L-serine generic -metabolite KEGG:C04566 Membrane-derived-oligosaccharide D-glucose generic -metabolite KEGG:C04570 Reduced electron-transferring flavoprotein generic -metabolite KEGG:C04572 S-(N-Hydroxy-N-methylcarbamoyl)glutathione generic -metabolite KEGG:C04573 UDP-N-acetyl-2-amino-2-deoxy-D-glucuronate generic -metabolite KEGG:C04574 di-trans,poly-cis-Undecaprenyl diphosphate generic -metabolite KEGG:C04575 (4R,5S)-4,5,6-Trihydroxy-2,3-dioxohexanoate generic -metabolite KEGG:C04576 Pentagalloylglucose generic -metabolite KEGG:C04577 15-OxoETE generic -metabolite KEGG:C04578 16-Methoxy-2,3-dihydro-3-hydroxytabersonine generic -metabolite KEGG:C04579 Inositol 1,2,3,5,6-pentakisphosphate generic -metabolite KEGG:C04580 2-Deoxy-2,3-dehydro-N-acetylneuraminic acid generic -metabolite KEGG:C04581 Tomentin generic -metabolite KEGG:C04582 S-Methyl-5-thio-D-ribulose 1-phosphate generic -metabolite KEGG:C04583 6-Hydroxyl-1,6-dihydropurine ribonucleoside generic -metabolite KEGG:C04584 6-Imino-5-oxocyclohexa-1,3-dienecarboxylate generic -metabolite KEGG:C04586 Diethyl (2R,3R)-2-methyl-3-hydroxysuccinate generic -metabolite KEGG:C04587 Diethyl (2S,3R)-2-methyl-3-hydroxysuccinate generic -metabolite KEGG:C04589 UDP-N-acetyl-D-galactosamine 4,6-bissulfate generic -metabolite KEGG:C04590 3-(O-Geranylgeranyl)-sn-glycerol 1-phosphate generic -metabolite KEGG:C04592 Toluene-cis-dihydrodiol generic -metabolite KEGG:C04593 (2S,3R)-3-Hydroxybutane-1,2,3-tricarboxylate generic -metabolite KEGG:C04594 (9Z)-(13S)-12,13-Epoxyoctadeca-9,11-dienoic acid generic -metabolite KEGG:C04596 1,1-Dichloro-2,2-bis(4-chlorophenyl)ethylene generic -metabolite KEGG:C04597 1,2-Bis(3,4-dimethoxyphenyl)propane-1,3-diol generic -metabolite KEGG:C04598 2-Acetyl-1-alkyl-sn-glycero-3-phosphocholine generic -metabolite KEGG:C04599 1-Methyl-4-phenyl-1,2,3,6-tetrahydropyridine generic -metabolite KEGG:C04604 3-Hydroxy-2-methylpyridine-4,5-dicarboxylate generic -metabolite KEGG:C04606 5-(3,4-Diacetoxybut-1-ynyl)-2,2'-bithiophene generic -metabolite KEGG:C04608 Apigenin 7-O-beta-D-glucoside generic -metabolite KEGG:C04611 Indol-3-ylacetyl-myo-inositol L-arabinoside generic -metabolite KEGG:C04613 UDP-2-acetamido-4-dehydro-2,6-dideoxyglucose generic -metabolite KEGG:C04614 alpha-D-Mannosyl-1,3-(R1)-beta-D-mannosyl-R2 generic -metabolite KEGG:C04615 alpha-D-Mannosylchitobiosyldiphosphodolichol generic -metabolite KEGG:C04617 (1S,2S)-1-Hydroxypropane-1,2,3-tricarboxylate generic -metabolite KEGG:C04618 (3R)-3-Hydroxybutanoyl-[acyl-carrier protein] generic -metabolite KEGG:C04619 (3R)-3-Hydroxydecanoyl-[acyl-carrier protein] generic -metabolite KEGG:C04620 (3R)-3-Hydroxyoctanoyl-[acyl-carrier protein] generic -metabolite KEGG:C04621 (E)-2-(2-Furyl)-3-(5-nitro-2-furyl)acrylamide generic -metabolite KEGG:C04622 (Z)-2-(2-Furyl)-3-(5-nitro-2-furyl)acrylamide generic -metabolite KEGG:C04623 DDT generic -metabolite KEGG:C04625 2,4-Dichloro-2,5-dihydro-5-oxofuran-2-acetate generic -metabolite KEGG:C04627 D-Galactosyl-N-acetyl-alpha-D-galactosaminide generic -metabolite KEGG:C04628 Coenzyme B generic -metabolite KEGG:C04630 UDP-2-acetamido-4-amino-2,4,6-trideoxy-alpha-D-glucose generic -metabolite KEGG:C04631 UDP-N-acetyl-3-(1-carboxyvinyl)-D-glucosamine generic -metabolite KEGG:C04632 [Hydroxymethylglutaryl-CoA reductase (NADPH)] generic -metabolite KEGG:C04633 (3R)-3-Hydroxypalmitoyl-[acyl-carrier protein] generic -metabolite KEGG:C04634 1,6-Dihydroxycyclohexa-2,4-diene-1-carboxylate generic -metabolite KEGG:C04635 1-(1-Alkenyl)-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C04636 1-Acyl-2-linoleoyl-sn-glycero-3-phosphocholine generic -metabolite KEGG:C04637 1-Phosphatidyl-D-myo-inositol 4,5-bisphosphate generic -metabolite KEGG:C04638 2,3-Bis-O-(geranylgeranyl)glycerol 1-phosphate generic -metabolite KEGG:C04639 2,4-Dioxotetrahydropyrimidine D-ribonucleotide generic -metabolite KEGG:C04640 2-(Formamido)-N1-(5'-phosphoribosyl)acetamidine generic -metabolite KEGG:C04641 2-(alpha-D-Galactosyl)-sn-glycerol 3-phosphate generic -metabolite KEGG:C04642 2-Hydroxy-5-carboxymethylmuconate semialdehyde generic -metabolite KEGG:C04643 7-Oxodeoxycholate generic -metabolite KEGG:C04644 3alpha,7alpha-Dihydroxy-5beta-cholestanoyl-CoA generic -metabolite KEGG:C04645 6-(D-Glucose-1-phospho)-D-mannosylglycoprotein generic -metabolite KEGG:C04646 6-Thioinosine-5'-monophosphate generic -metabolite KEGG:C04648 alpha-L-Fucosyl-1,2-beta-D-galactoside generic -metabolite KEGG:C04649 Heparan sulfate N-acetyl-alpha-D-glucosaminide generic -metabolite KEGG:C04650 L-Phosphinothricin generic -metabolite KEGG:C04652 UDP-2,3-bis(3-hydroxytetradecanoyl)glucosamine generic -metabolite KEGG:C04654 (13E)-11alpha-Hydroxy-9,15-dioxoprost-13-enoate generic -metabolite KEGG:C04655 (2S,3S)-2-Hydroxytridecane-1,2,3-tricarboxylate generic -metabolite KEGG:C04656 1,3-beta-D-Galactosyl-N-acetyl-D-glucosaminyl-R generic -metabolite KEGG:C04657 1,4-beta-D-Galactosyl-N-acetyl-D-glucosaminyl-R generic -metabolite KEGG:C04660 3'-Deoxydihydrostreptomycin 6,3''-bis-phosphate generic -metabolite KEGG:C04661 3alpha,7alpha,12beta-Trihydroxy-5beta-cholanate generic -metabolite KEGG:C04662 4-Deoxy-alpha-L-erythro-hex-4-enopyranuronoside generic -metabolite KEGG:C04663 Acadesine generic -metabolite KEGG:C04665 Co-Methyl-5-hydroxybenzimidazolylcobamide generic -metabolite KEGG:C04666 D-erythro-1-(Imidazol-4-yl)glycerol 3-phosphate generic -metabolite KEGG:C04667 N-Acetyl-D-glucosaminyl-poly(ribitol phosphate) generic -metabolite KEGG:C04670 (1S,4S)-4-Hydroxy-3-oxocyclohexane-1-carboxylate generic -metabolite KEGG:C04671 (5Z)-(15S)-11alpha-Hydroxy-9,15-dioxoprostanoate generic -metabolite KEGG:C04672 (9Z,15Z)-(13S)-12,13-Epoxyoctadeca-9,11,15-trienoic acid generic -metabolite KEGG:C04673 1D-1-Guanidino-1-deoxy-3-dehydro-scyllo-inositol generic -metabolite KEGG:C04674 3-D-Glucuronosyl-N2,6-disulfo-beta-D-glucosamine generic -metabolite KEGG:C04675 3-Hydroxy-3-(4-methylpent-3-en-1-yl)glutaryl-CoA generic -metabolite KEGG:C04676 Testololactone generic -metabolite KEGG:C04677 1-(5'-Phosphoribosyl)-5-amino-4-imidazolecarboxamide generic -metabolite KEGG:C04678 Archaeal dolichyl N-acetyl-alpha-D-glucosaminyl phosphate generic -metabolite KEGG:C04679 Protein N6-[(R)-4-amino-2-hydroxybutyl]-L-lysine generic -metabolite KEGG:C04680 Retinyl-ester-(cellular-retinol-binding-protein) generic -metabolite KEGG:C04681 [Acetyl-CoA:carbon-dioxide ligase (ADP-forming)] generic -metabolite KEGG:C04682 [Methylmalonyl-CoA:pyruvate carboxytransferase] generic -metabolite KEGG:C04683 alpha-N-Acetylneuraminyl-2,3-beta-D-galactosyl-R generic -metabolite KEGG:C04684 m-Carboxyphenyl phenylacetamidomethylphosphonate generic -metabolite KEGG:C04685 (13E)-(15S)-15-Hydroxy-9-oxoprosta-10,13-dienoate generic -metabolite KEGG:C04686 (13E)-(15S)-15-Hydroxy-9-oxoprosta-11,13-dienoate generic -metabolite KEGG:C04687 (1S,3R,4S)-3,4-Dihydroxycyclohexane-1-carboxylate generic -metabolite KEGG:C04688 (3R)-3-Hydroxytetradecanoyl-[acyl-carrier protein] generic -metabolite KEGG:C04690 2-(Hydroxymethyl)-3-(acetamidomethylene)succinate generic -metabolite KEGG:C04691 2-Dehydro-3-deoxy-D-arabino-heptonate 7-phosphate generic -metabolite KEGG:C04692 Peptide 2-[3-carboxy-3-(methylammonio)propyl]-L-histidine generic -metabolite KEGG:C04695 5-O-(Indol-3-ylacetyl-myo-inositol) D-galactoside generic -metabolite KEGG:C04696 7-Methylguanosine 5'-triphospho-5'-oligonucleotide generic -metabolite KEGG:C04698 Methyl-2-alpha-L-fucopyranosyl-beta-D-galactoside generic -metabolite KEGG:C04700 UDP-N-acetylmuramoyl-L-alanyl-alpha-D-glutamyl-L-lysine generic -metabolite KEGG:C04702 UDPMurNAc(oyl-L-Ala-D-gamma-Glu-L-Lys-D-Ala-D-Ala) generic -metabolite KEGG:C04703 alpha-D-Galactosyl-(1,1')-sn-glycerol 3-phosphate generic -metabolite KEGG:C04706 cis-2-Chloro-4-carboxymethylenebut-2-en-1,4-olide generic -metabolite KEGG:C04707 (5Z,13E)-11alpha-Hydroxy-9,15-dioxoprost-13-enoate generic -metabolite KEGG:C04708 1-(beta-D-Galactosyl)-2-(2-hydroxyacyl)sphingosine generic -metabolite KEGG:C04709 3'-Deoxydihydrostreptomycin 3'alpha,6-bisphosphate generic -metabolite KEGG:C04711 5-(3-Hydroxy-4-acetoxybut-1-ynyl)-2,2'-bithiophene generic -metabolite KEGG:C04712 (7R)-7-(5-Carboxy-5-oxopentanoyl)aminocephalosporinate generic -metabolite KEGG:C04713 N6-(delta2-Isopentenyl)-adenosine 5'-monophosphate generic -metabolite KEGG:C04714 alpha-D-Galactosyl-beta-D-galactosyldiacylglycerol generic -metabolite KEGG:C04715 Nuatigenin generic -metabolite KEGG:C04717 (9Z,11E)-(13S)-13-Hydroperoxyoctadeca-9,11-dienoic acid generic -metabolite KEGG:C04718 1,6,6-Trimethyl-2,7-dioxabicyclo[3.2.2]nonan-3-one generic -metabolite KEGG:C04719 1-Hydroxy-2-(beta-D-glucosyloxy)-9,10-anthraquinone generic -metabolite KEGG:C04720 DIMBOA generic -metabolite KEGG:C04722 3alpha,7alpha,12alpha-Trihydroxy-5beta-cholestanoate generic -metabolite KEGG:C04724 D-Mannosyl-L-rhamnosyl-D-galactose-1-diphospholipid generic -metabolite KEGG:C04725 Oligosaccharide containing 6-methyl-D-glucose units generic -metabolite KEGG:C04726 [3-Methyl-2-oxobutanoate dehydrogenase (2-methylpropanoyl-transferring)] generic -metabolite KEGG:C04727 [Propionyl-CoA:carbon-dioxide ligase (ADP-forming)] generic -metabolite KEGG:C04728 tRNA containing 5-methylaminomethyl-2-thiouridylate generic -metabolite KEGG:C04729 trans-2-Chloro-4-carboxymethylenebut-2-en-1,4-olide generic -metabolite KEGG:C04730 GM3 generic -metabolite KEGG:C04731 1-Methyl-4-phenyl-1,2,3,6-tetrahydropyridine N-oxide generic -metabolite KEGG:C04732 5-Amino-6-(1-D-ribitylamino)uracil generic -metabolite KEGG:C04733 4-(4-Deoxy-beta-D-gluc-4-enuronosyl)-D-galacturonate generic -metabolite KEGG:C04734 1-(5'-Phosphoribosyl)-5-formamido-4-imidazolecarboxamide generic -metabolite KEGG:C04735 Apo-[acetyl-CoA:carbon-dioxide ligase (ADP-forming)] generic -metabolite KEGG:C04736 Apo-[methylmalonyl-CoA:pyruvate carboxytransferase] generic -metabolite KEGG:C04737 alpha-D-Galactosyl-(1->4)-beta-D-galactosyl-(1->4)-beta-D-glucosyl-(1<->1)-ceramide generic -metabolite KEGG:C04738 UDP-3-O-(3-hydroxytetradecanoyl)-N-acetylglucosamine generic -metabolite KEGG:C04739 UDP-N-acetyl-6-(alpha-D-galactose-1-phospho)-alpha-D-glucosamine generic -metabolite KEGG:C04740 alpha-N-Acetylneuraminyl-2,6-beta-galactosyl-1,4-beta-D-glucosylceramide generic -metabolite KEGG:C04741 Alprostadil generic -metabolite KEGG:C04742 (15S)-15-Hydroxy-5,8,11-cis-13-trans-eicosatetraenoate generic -metabolite KEGG:C04744 2,6-Diamino-4-hydroxy-5-(N-methyl)formamidopyrimidine generic -metabolite KEGG:C04746 3beta-Hydroxy-5alpha-cholest-7-ene-4alpha-carboxylate generic -metabolite KEGG:C04748 Protein C-terminal S-farnesyl-L-cysteine methyl ester generic -metabolite KEGG:C04749 [[Hydroxymethylglutaryl-CoA reductase (NADPH)]kinase] generic -metabolite KEGG:C04750 beta-D-Galactosyl-1,3-N-acetyl-alpha-D-galactosaminyl-R generic -metabolite KEGG:C04751 1-(5-Phospho-D-ribosyl)-5-amino-4-imidazolecarboxylate generic -metabolite KEGG:C04752 4-Amino-5-hydroxymethyl-2-methylpyrimidine diphosphate generic -metabolite KEGG:C04755 Glycoprotein N-acetyl-D-glucosaminyl-phospho-D-mannose generic -metabolite KEGG:C04756 O-1-Alk-1-enyl-2-acyl-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C04758 (5Z,13E)-9alpha-Hydroxy-11,15-dioxoprosta-5,13-dienoate generic -metabolite KEGG:C04759 1,2-D-Glucosyl-5-D-(galactosyloxy)-L-lysine-procollagen generic -metabolite KEGG:C04760 3alpha,7alpha,12alpha-Trihydroxy-5beta-cholestanoyl-CoA generic -metabolite KEGG:C04763 Apo-[propionyl-CoA:carbon-dioxide ligase (ADP-forming)] generic -metabolite KEGG:C04767 O-(1->4)-alpha-L-Dihydrostreptosyl-streptidine 6-phosphate generic -metabolite KEGG:C04768 [Hydroxymethylglutaryl-CoA reductase (NADPH)] phosphate generic -metabolite KEGG:C04771 L-Mimosine generic -metabolite KEGG:C04772 1,6-alpha-D-Mannosyl-1,6-alpha-D-mannosyloligosaccharide generic -metabolite KEGG:C04773 3-Hydroxy-4-hydroxymethyl-2-methylpyridine-5-carboxylate generic -metabolite KEGG:C04775 D-Galactosyl-(1->3)-beta-D-galactosyl-(1->4)-beta-D-glucosyl-R generic -metabolite KEGG:C04776 Peptide beta-D-galactosyl-(1->3)-N-acetyl-alpha-D-galactosaminyl-L-serine generic -metabolite KEGG:C04778 N1-(5-Phospho-alpha-D-ribosyl)-5,6-dimethylbenzimidazole generic -metabolite KEGG:C04779 rRNA containing a single residue of 2'-O-methyladenosine generic -metabolite KEGG:C04780 8-[(1R,2R)-3-Oxo-2-{(Z)-pent-2-enyl}cyclopentyl]octanoate generic -metabolite KEGG:C04783 cis-4,5-Dihydroxycyclohexa-1(6),2-diene-1,2-dicarboxylate generic -metabolite KEGG:C04785 13(S)-HPOT generic -metabolite KEGG:C04787 Cyanidin 3-rutinoside 5-glucoside chloride generic -metabolite KEGG:C04789 Lysosomal-enzyme N-acetyl-D-glucosaminyl-phospho-D-mannose generic -metabolite KEGG:C04790 N-Acetyl-beta-D-mannosaminouronosyl-1,4-lipopolysaccharide generic -metabolite KEGG:C04791 beta-D-Galactosyl-1,4-N-acetyl-D-glucosaminyl-glycoprotein generic -metabolite KEGG:C04792 1-Acyl-2-[(S)-12-hydroxyoleoyl]-sn-glycero-3-phosphocholine generic -metabolite KEGG:C04793 3,4-Dihydroxy-9,10-secoandrosta-1,3,5(10)-triene-9,17-dione generic -metabolite KEGG:C04794 3-(4-Deoxy-beta-D-gluc-4-enuronosyl)-N-acetyl-D-glucosamine generic -metabolite KEGG:C04796 4-(L-Alanin-3-yl)-2-hydroxy-cis,cis-muconate 6-semialdehyde generic -metabolite KEGG:C04797 5-(L-Alanin-3-yl)-2-hydroxy-cis,cis-muconate 6-semialdehyde generic -metabolite KEGG:C04798 5-Amino-4-chloro-2-(2,3-dihydroxyphenyl)-3(2H)-pyridazinone generic -metabolite KEGG:C04799 Colominic acid(non-reducing N- or O-acylneuraminyl residue) generic -metabolite KEGG:C04800 D-Glucuronyl-N-acetyl-1,3-beta-D-galactosaminylproteoglycan generic -metabolite KEGG:C04801 [3-Methylcrotonoyl-CoA:carbon-dioxide ligase (ADP-forming)] generic -metabolite KEGG:C04802 m7G(5')pppRm-mRNA generic -metabolite KEGG:C04804 UDP-N-acetylmuramoyl-L-alanyl-D-gamma-glutamyl-meso-2,6-diaminopimeloyl-D-alanine generic -metabolite KEGG:C04805 5(S)-HETE generic -metabolite KEGG:C04806 17alpha-(N-Acetyl-D-glucosaminyl)-estradiol 3-D-glucuronoside generic -metabolite KEGG:C04807 6-Hydroxymethyl-7,8-dihydropterin diphosphate generic -metabolite KEGG:C04808 D-Abequosyl-D-mannosyl-rhamnosyl-D-galactose-1-diphospholipid generic -metabolite KEGG:C04809 Membrane-derived-oligosaccharide 6-(glycerophospho)-D-glucose generic -metabolite KEGG:C04810 Oligosaccharide with 4-deoxy-alpha-D-gluc-4-enuronosyl group generic -metabolite KEGG:C04811 1-(5-Phosphoribosyl)-4-(N-succinocarboxamide)-5-aminoimidazole generic -metabolite KEGG:C04812 1D-1-Guanidino-3-amino-1,3-dideoxy-scyllo-inositol 4-phosphate generic -metabolite KEGG:C04814 4beta-Hydroxymethyl-4alpha-methyl-5alpha-cholest-7-en-3beta-ol generic -metabolite KEGG:C04815 5-D-(5/6)-5-C-(Hydroxymethyl)-2,6-dihydroxycyclohex-2-en-1-one generic -metabolite KEGG:C04816 Dephospho-[[hydroxymethylglutaryl-CoA reductase (NADPH)]kinase] generic -metabolite KEGG:C04817 Protein alpha-D-glucosyl-1,2-beta-D-galactosyl-L-hydroxylysine generic -metabolite KEGG:C04818 beta-D-Galactosyl-1,4-N-acetyl-beta-D-glucosaminylglycopeptide generic -metabolite KEGG:C04819 beta-D-Galactosyl-beta-1,4-N-acetyl-D-glucosaminylglycopeptide generic -metabolite KEGG:C04822 8(R)-HPETE generic -metabolite KEGG:C04823 1-(5'-Phosphoribosyl)-5-amino-4-(N-succinocarboxamide)-imidazole generic -metabolite KEGG:C04824 Lipid X generic -metabolite KEGG:C04825 3-beta-D-Galactosyl-4-beta-D-galactosyl-O-beta-D-xylosylprotein generic -metabolite KEGG:C04827 Apo-[3-methylcrotonoyl-CoA:carbon-dioxide ligase (ADP-forming)] generic -metabolite KEGG:C04830 beta-D-Glucosyl-1,4-N-acetyl-D-glucosaminyldiphosphoundecaprenol generic -metabolite KEGG:C04831 DIMBOA-glucoside generic -metabolite KEGG:C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide generic -metabolite KEGG:C04833 m7G(5')pppm6Am-mRNA generic -metabolite KEGG:C04834 Juvenile hormone II acid generic -metabolite KEGG:C04835 (5Z,13E)-6,9alpha-Epoxy-11alpha-hydroxy-15-oxoprosta-5,13-dienoate generic -metabolite KEGG:C04839 3-O-(3,6-Anhydro-alpha-D-galactopyranosyl)-D-galactose 4-O-sulfate generic -metabolite KEGG:C04840 3beta-Hydroxy-4beta-methyl-5alpha-cholest-7-ene-4alpha-carboxylate generic -metabolite KEGG:C04843 (5Z,9E,14Z)-(8xi,11xi,12S)-8,11,12-Trihydroxyicosa-5,9,14-trienoate generic -metabolite KEGG:C04844 3-Hydroxy-5,9,17-trioxo-4,5:9,10-disecoandrosta-1(10),2-dien-4-oate generic -metabolite KEGG:C04845 N-Acetyl-beta-D-glucosaminyl-(1->3)-beta-D-galactosyl-(1->4)-beta-D-glucosyl-(1<->1)-ceramide generic -metabolite KEGG:C04847 alpha-D-Galactosyl-1,3-beta-D-galactosyl-1,4-N-acetyl-D-glucosamine generic -metabolite KEGG:C04848 Variant-surface-glycoprotein 1,2-dimyristyl-sn-phosphatidylinositol generic -metabolite KEGG:C04849 (5Z,9E,14Z)-(8xi,11R,12S)-11,12-Epoxy-8-hydroxyicosa-5,9,14-trienoic acid generic -metabolite KEGG:C04850 1,3-beta-D-Galactosyl-(alpha-1,4-L-fucosyl)-N-acetyl-D-glucosaminyl-R generic -metabolite KEGG:C04851 MurAc(oyl-L-Ala-D-gamma-Glu-L-Lys-D-Ala-D-Ala)-diphospho-undecaprenol generic -metabolite KEGG:C04853 20-OH-Leukotriene B4 generic -metabolite KEGG:C04855 alpha-D-Galactosyl-1,3-beta-D-galactosyl-1,4-N-acetyl-D-glucosaminyl-R generic -metabolite KEGG:C04856 (6S)-6beta-Hydroxy-1,4,5,6-tetrahydronicotinamide-adenine dinucleotide generic -metabolite KEGG:C04858 Apigenin 7-O-[beta-D-apiosyl-(1->2)-beta-D-glucoside] generic -metabolite KEGG:C04859 (20S,22S,25S)-22,25-Epoxyfurost-5-ene-3beta,26-diol 3-O-beta-D-glucoside generic -metabolite KEGG:C04861 1,3-alpha-D-Mannosyl-1,2-alpha-D-mannosyl-1,2-alpha-D-mannosyl-D-mannose generic -metabolite KEGG:C04862 1-Hexadecylthio-1-deoxy-2-hexadecylphosphono-sn-glycero-3-phosphocholine generic -metabolite KEGG:C04864 4-Deoxy-beta-D-gluc-4-enuronosyl-(1,3)-N-acetyl-D-galactosamine 4-sulfate generic -metabolite KEGG:C04865 4-Deoxy-beta-D-gluc-4-enuronosyl-(1,3)-N-acetyl-D-galactosamine 6-sulfate generic -metabolite KEGG:C04866 alpha-D-Galactosyl-(1,3)-[alpha-L-fucosyl-(1,2)]-D-galactoside generic -metabolite KEGG:C04867 Juvenile hormone II generic -metabolite KEGG:C04871 Haloxyfop generic -metabolite KEGG:C04872 1,2-Diacyl-3-[3-(alpha-D-N-acetylneuraminyl)-beta-D-galactosyl]-sn-glycerol generic -metabolite KEGG:C04873 1-Hexadecylthio-2-hexadecanoylamino-1,2-dideoxy-sn-glycero-3-phosphocholine generic -metabolite KEGG:C04874 7,8-Dihydroneopterin generic -metabolite KEGG:C04875 (+/-)-5-[(tert-Butylamino)-2'-hydroxypropoxy]-1,2,3,4-tetrahydro-1-naphthol generic -metabolite KEGG:C04876 N-Acetyl-D-glucosaminyl-N-acetylmuramoyl-L-Ala-D-glutamyl-6-carboxy-L-lysine generic -metabolite KEGG:C04877 UDP-N-acetylmuramoyl-L-alanyl-gamma-D-glutamyl-meso-2,6-diaminopimelate generic -metabolite KEGG:C04880 N-Acetyl-beta-D-glucosaminyl-1,2-alpha-D-mannosyl-1,3-(R1)-beta-D-mannosyl-R2 generic -metabolite KEGG:C04881 N-Acetyl-beta-D-mannosaminyl-1,4-N-acetyl-D-glucosaminyldiphosphoundecaprenol generic -metabolite KEGG:C04882 UDP-N-acetylmuramoyl-L-alanyl-D-glutamyl-6-carboxy-L-lysyl-D-alanyl-D-alanine generic -metabolite KEGG:C04883 (+/-)-5-[(tert-Butylamino)-2'-hydroxypropoxy]-3,4-dihydro-1(2H)-naphthalenone generic -metabolite KEGG:C04884 N-Acetyl-D-galactosaminyl-(N-acetylneuraminyl)-D-galactosyl-D-glucosylceramide generic -metabolite KEGG:C04885 alpha-N-Acetylneuraminyl-2,3-beta-D-galactosyl-1,3-N-acetyl-D-galactosaminyl-R generic -metabolite KEGG:C04886 alpha-N-Acetylneuraminyl-2,6-beta-D-galactosyl-1,4-N-acetyl-beta-D-glucosamine generic -metabolite KEGG:C04887 alpha-N-Acetylneuraminyl-2,8-alpha-N-acetylneuraminyl-2,3-beta-D-galactosyl-R generic -metabolite KEGG:C04890 N-Acetyl-beta-D-glucosaminyl-1,3-beta-D-galactosyl-1,4-N-acetyl-D-glucosaminyl-R generic -metabolite KEGG:C04891 N-Acetyl-beta-D-glucosaminyl-1,6-beta-D-galactosyl-1,4-N-acetyl-D-glucosaminyl-R generic -metabolite KEGG:C04894 UDP-N-acetylmuramoyl-L-alanyl-gamma-D-glutamyl-N6-(L-alanyl)-L-lysyl-D-alanyl-D-alanine generic -metabolite KEGG:C04895 7,8-Dihydroneopterin 3'-triphosphate generic -metabolite KEGG:C04896 5-(5-Phospho-D-ribosylaminoformimino)-1-(5-phosphoribosyl)-imidazole-4-carboxamide generic -metabolite KEGG:C04898 Oligosaccharide with terminal 4-deoxy-6-methyl-alpha-D-galact-4-enuronosyl group generic -metabolite KEGG:C04899 (6S)-6beta-Hydroxy-1,4,5,6-tetrahydronicotinamide-adenine dinucleotide phosphate generic -metabolite KEGG:C04900 Luteolin 7-O-[beta-D-glucuronosyl-(1->2)-beta-D-glucuronide]-4'-O-beta-D-glucuronide generic -metabolite KEGG:C04901 alpha-N-Acetylneuraminyl-2,3-beta-D-galactosyl-1,3-N-acetyl-alpha-D-galactosaminyl-R generic -metabolite KEGG:C04902 beta-D-Galactosyl-1,3-(N-acetyl-beta-D-glucosaminyl-1,6)-N-acetyl-D-galactosaminyl-R generic -metabolite KEGG:C04903 3-beta-D-Glucuronosyl-3-beta-D-galactosyl-4-beta-D-galactosyl-O-beta-D-xylosylprotein generic -metabolite KEGG:C04904 N-Acetyl-D-glucosaminyl-N-acetylmuramoyl-L-Ala-D-glutamyl-6-carboxy-L-lysyl-D-alanine generic -metabolite KEGG:C04905 1-(4-Amino-2-methylpyrimid-5-ylmethyl)-3-(beta-hydroxyethyl)-2-methylpyridinium bromide generic -metabolite KEGG:C04906 N-Acetyl-beta-D-glucosaminyl-1,6-(N-acetyl-beta-D-glucosaminyl-1,2)-alpha-D-mannosyl-R generic -metabolite KEGG:C04907 alpha-N-Acetylneuraminyl-2,3-beta-D-galactosyl-1,4-N-acetyl-D-glucosaminyl-glycoprotein generic -metabolite KEGG:C04908 1-(4-Hydroxy-2-methylpyrimid-5-ylmethyl)-3-(beta-hydroxyethyl)-2-methylpyridinium bromide generic -metabolite KEGG:C04909 alpha-D-Glucosyl-1,6-alpha-D-glucosyl-1,6-alpha-D-glucosyl-1,3-1-O-alkyl-2-O-acylglycerol generic -metabolite KEGG:C04910 1,3-beta-D-Galactosyl-N-acetyl-D-glucosaminyl-1,3-beta-D-galactosyl-1,4-D-glucosylceramide generic -metabolite KEGG:C04911 D-Galactosyl-N-acetyl-D-galactosaminyl-(N-acetylneuraminyl)-D-galactosyl-D-glucosylceramide generic -metabolite KEGG:C04913 N-Acetyl-beta-D-galactosaminyl-1,4-beta-D-glucuronyl-N-acetyl-1,3-beta-D-galactosaminylproteoglycan generic -metabolite KEGG:C04914 alpha-D-Mannosyl-1,6-(N-acetyl-beta-D-glucosaminyl-1,2-alpha-D-mannosyl-1,3)-beta-D-mannosyl-R generic -metabolite KEGG:C04916 N-(5'-Phospho-D-1'-ribulosylformimino)-5-amino-1-(5''-phospho-D-ribosyl)-4-imidazolecarboxamide generic -metabolite KEGG:C04917 N-Acetyl-beta-D-glucosaminyl-(1->6)-[N-acetyl-beta-D-glucosaminyl-(1->3)]-N-acetyl-alpha-D-galactosaminyl-R generic -metabolite KEGG:C04919 2,3,2'3'-Tetrakis(3-hydroxytetradecanoyl)-D-glucosaminyl-1,6-beta-D-glucosamine 1,4'-bisphosphate generic -metabolite KEGG:C04920 6-Sulfo-alpha-D-glucosyl-1,6-alpha-D-glucosyl-1,6-alpha-D-glucosyl-1,3-1-O-alkyl-2-O-acylglycerol generic -metabolite KEGG:C04922 beta-D-Galactosyl-(1->4)-N-acetyl-beta-D-glucosaminyl-(1->3)-beta-D-galactosyl-(1->4)-beta-D-glucosyl-(1<->1)-ceramide generic -metabolite KEGG:C04923 1,3-alpha-D-Mannosyl-(1,2-N-acetyl-alpha-D-glucosaminyl)-1,2-alpha-D-mannosyl-1,2-alpha-D-mannosyl-D-mannose generic -metabolite KEGG:C04924 N-Acetyl-D-galactosaminyl-1,4-beta-N-acetylneuraminyl-2,3-alpha-D-galactosyl-1,4-beta-D-glucosylceramide generic -metabolite KEGG:C04925 N-Acetyl-D-galactosaminyl-N-Acetyl-D-galactosaminyl-1,3-D-galactosyl-1,4-D-galactosyl-1,4-D-glucosylceramide generic -metabolite KEGG:C04926 alpha-N-Acetylneuraminyl-2,3-beta-D-galactose-1,3-(alpha-N-acetylneuraminyl-2,6)-N-acetyl-D-galactosaminyl-R generic -metabolite KEGG:C04927 N-Acetylneuraminyl-D-galactosyl-N-acetyl-D-galactosaminyl-(N-acetylneuraminyl)-D-galactosyl-D-glucosylceramide generic -metabolite KEGG:C04930 N-Acetyl-beta-D-glucosaminyl-1,3-beta-D-galactosyl-1,3-(N-acetyl-beta-D-glucosaminyl-1,6)-N-acetyl-D-galactosaminyl-R generic -metabolite KEGG:C04931 Argatroban generic -metabolite KEGG:C04932 Lipid A disaccharide generic -metabolite KEGG:C04934 N-Acetyl-beta-D-glucosaminyl-1,6-(N-acetyl-beta-D-glucosaminyl-1,2)-(N-acetyl-beta-D-glucosaminyl-1,4)-alpha-D-mannosyl-R generic -metabolite KEGG:C04936 alpha-N-Acetylneuraminyl-2,3-beta-D-galactosyl-1,4-N-acetyl-beta-D-glucosaminyl-1,3-beta-D-galactosyl-1,4-D-glucosylceramide generic -metabolite KEGG:C04937 N-Acetyl-beta-D-glucosaminyl-1,2-alpha-D-mannosyl-1,6-(N-acetyl-beta-D-glucosaminyl-1,2-alpha-D-mannosyl-1,3)-beta-D-mannosyl-R generic -metabolite KEGG:C04938 N-Acetyl-D-glucosaminyl-1,3-beta-D-galactosyl-1,4-N-acetyl-beta-D-glucosaminyl-1,3-beta-D-galactosyl-1,4-beta-D-glucosylceramide generic -metabolite KEGG:C04939 N-Acetyl-D-glucosaminyl-1,6-beta-D-galactosyl-1,4-N-acetyl-beta-D-glucosaminyl-1,3-beta-D-galactosyl-1,4-beta-D-glucosylceramide generic -metabolite KEGG:C04940 (N-Acetyl-beta-D-glucosaminyl-1,2)-alpha-D-mannosyl-1,3-(beta-N-acetyl-D-glucosaminyl-1,2-alpha-D-mannosyl-1,6)-beta-D-mannosyl-R generic -metabolite KEGG:C04942 beta-D-Mannosyl-R generic -metabolite KEGG:C04943 N-Acetyl-beta-D-glucosaminyl-1,4-(N-acetyl-beta-D-glucosaminyl-1,2)-alpha-D-mannosyl-1,3-beta-D-mannosyl-R generic -metabolite KEGG:C04944 6-(2-[N-Acetyl-beta-D-glucosaminyl]-alpha-D-mannosyl)-beta-D-mannosyl-R generic -metabolite KEGG:C05001 Fructose 1-phosphate(pyranose) generic -metabolite KEGG:C05003 D-Fructose generic -metabolite KEGG:C05005 Glycolipid generic -metabolite KEGG:C05009 Heme-thiolate(P-450) generic -metabolite KEGG:C05010 Histidylleucine generic -metabolite KEGG:C05011 Hydroxytamoxifen generic -metabolite KEGG:C05016 L-Glutamate methylester generic -metabolite KEGG:C05021 N-Acetyl-beta-D-galactosamine generic -metabolite KEGG:C05026 N3-Metyladenine generic -metabolite KEGG:C05028 Norethindrone generic -metabolite KEGG:C05031 O6-Methyl-2'-deoxyguanosine generic -metabolite KEGG:C05042 Glufosinate generic -metabolite KEGG:C05052 Ribulose generic -metabolite KEGG:C05057 cis-3-Enoyl-CoA generic -metabolite KEGG:C05058 m-Aminophenol generic -metabolite KEGG:C05060 o-Benzosemiquinone generic -metabolite KEGG:C05067 trans-3-Enoyl-CoA generic -metabolite KEGG:C05071 Chlorsulfuron generic -metabolite KEGG:C05073 Coumermycin A1 generic -metabolite KEGG:C05076 Imazaquin generic -metabolite KEGG:C05079 Nalidixic acid generic -metabolite KEGG:C05080 Novobiocin generic -metabolite KEGG:C05086 Cyclosporin A generic -metabolite KEGG:C05100 3-Ureidoisobutyrate generic -metabolite KEGG:C05102 alpha-Hydroxy fatty acid generic -metabolite KEGG:C05103 4alpha-Methylzymosterol generic -metabolite KEGG:C05104 Delta7,24-Cholestadien-3beta-ol generic -metabolite KEGG:C05107 7-Dehydrodesmosterol generic -metabolite KEGG:C05108 14-Demethyllanosterol generic -metabolite KEGG:C05109 24,25-Dihydrolanosterol generic -metabolite KEGG:C05110 4alpha-Methylcholesta-8-en-3beta-ol generic -metabolite KEGG:C05111 Methostenol generic -metabolite KEGG:C05113 Porphyrin generic -metabolite KEGG:C05114 Mucopolysaccharide generic -metabolite KEGG:C05116 3-Hydroxybutanoyl-CoA generic -metabolite KEGG:C05117 3-Aminobutanoyl-CoA generic -metabolite KEGG:C05118 S-(2-Methylbutanoyl)-dihydrolipoamide generic -metabolite KEGG:C05119 S-(3-Methylbutanoyl)-dihydrolipoamide generic -metabolite KEGG:C05122 Taurocholate generic -metabolite KEGG:C05123 2-Hydroxyethanesulfonate generic -metabolite KEGG:C05125 2-(alpha-Hydroxyethyl)thiamine diphosphate generic -metabolite KEGG:C05126 Dimethyl citraconate generic -metabolite KEGG:C05127 N-Methylhistamine generic -metabolite KEGG:C05130 Imidazole-4-acetaldehyde generic -metabolite KEGG:C05131 (1-Ribosylimidazole)-4-acetate generic -metabolite KEGG:C05133 4-Imidazolone-5-acetate generic -metabolite KEGG:C05135 4-(beta-Acetylaminoethyl)imidazole generic -metabolite KEGG:C05136 GDP-3,6-dideoxy-D-galactose generic -metabolite KEGG:C05138 17alpha-Hydroxypregnenolone generic -metabolite KEGG:C05139 16alpha-Hydroxydehydroepiandrosterone generic -metabolite KEGG:C05140 16alpha-Hydroxyandrost-4-ene-3,17-dione generic -metabolite KEGG:C05141 Estriol generic -metabolite KEGG:C05143 Dhurrin generic -metabolite KEGG:C05144 (beta-D-Mannuronate)n generic -metabolite KEGG:C05145 3-Aminoisobutyric acid generic -metabolite KEGG:C05146 Hydantoin generic -metabolite KEGG:C05147 trans-3-Hydroxy-L-proline generic -metabolite KEGG:C05148 Debromoaplysiatoxin generic -metabolite KEGG:C05149 Bryostatin 1 generic -metabolite KEGG:C05150 Teleocidin B-1 generic -metabolite KEGG:C05151 12-O-Tetradecanoylphorbol 13-acetate generic -metabolite KEGG:C05155 5-Amino-4-chloro-2-(5-hydroxymuconoyl)-3(2H)-pyridazinone generic -metabolite KEGG:C05156 Aminoacyl-tRNA generic -metabolite KEGG:C05157 Peptidyl-aminoacyl-tRNA generic -metabolite KEGG:C05158 trans-beta-D-Glucosyl-2-hydroxycinnamate generic -metabolite KEGG:C05159 6-(2,6-Bis[N-acetyl-beta-D-glucosaminyl]-alpha-D-mannosyl)-beta-D-mannosyl-R generic -metabolite KEGG:C05161 (2R,5S)-2,5-Diaminohexanoate generic -metabolite KEGG:C05163 O-Methyl-scyllo-inositol generic -metabolite KEGG:C05165 2-Amino-5-oxocyclohex-1-enecarbonyl-CoA generic -metabolite KEGG:C05167 alpha-Amino acid generic -metabolite KEGG:C05172 Selenophosphoric acid generic -metabolite KEGG:C05174 (S)-Cheilanthifoline generic -metabolite KEGG:C05175 Stylopine generic -metabolite KEGG:C05176 (S)-N-Methylcoclaurine generic -metabolite KEGG:C05177 Berbamunine generic -metabolite KEGG:C05178 (R)-Reticuline generic -metabolite KEGG:C05179 Salutaridine generic -metabolite KEGG:C05183 Ferrocytochrome b-561 generic -metabolite KEGG:C05189 Protopine generic -metabolite KEGG:C05190 6-Hydroxyprotopine generic -metabolite KEGG:C05191 Dihydrosanguinarine generic -metabolite KEGG:C05193 12-Hydroxydihydrochelirubine generic -metabolite KEGG:C05194 Dihydrochelirubine generic -metabolite KEGG:C05195 3-Hydroxybenzoyl-CoA generic -metabolite KEGG:C05196 Dihydroflavodoxin generic -metabolite KEGG:C05197 Protein glycine generic -metabolite KEGG:C05198 5'-Deoxyadenosine generic -metabolite KEGG:C05199 Flavodoxin semiquinone generic -metabolite KEGG:C05200 3-Hexaprenyl-4,5-dihydroxybenzoate generic -metabolite KEGG:C05201 (R,S)-Tetrahydrobenzylisoquinoline generic -metabolite KEGG:C05202 3'-Hydroxy-N-methyl-(S)-coclaurine generic -metabolite KEGG:C05203 6-O-Methylnorlaudanosoline generic -metabolite KEGG:C05204 (S)-Tetrahydroprotoberberine generic -metabolite KEGG:C05205 [Cytochrome c] methionine generic -metabolite KEGG:C05206 Histone L-arginine generic -metabolite KEGG:C05207 [Myeline basic protein] L-arginine generic -metabolite KEGG:C05208 1-Alkyl-2-arachidonyl-sn-glycero-3-phosphocholine generic -metabolite KEGG:C05209 1-Alkyl-2-lyso-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C05210 1-Alkyl-2-arachidonyl-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C05212 1-Radyl-2-acyl-sn-glycero-3-phosphocholine generic -metabolite KEGG:C05217 1-Organyl-2-lyso-sn-glycero-3-phospholipid generic -metabolite KEGG:C05218 1-Radyl-2-acetyl-sn-glycero-3-phospholipid generic -metabolite KEGG:C05220 Salutaridinol generic -metabolite KEGG:C05223 Dodecanoyl-[acyl-carrier protein] generic -metabolite KEGG:C05226 N-Carbamoyl-D-amino acid generic -metabolite KEGG:C05227 UDP-sugar generic -metabolite KEGG:C05229 Phaseollidin hydrate generic -metabolite KEGG:C05230 Phaseollidin generic -metabolite KEGG:C05231 L-3-Aminobutyryl-CoA generic -metabolite KEGG:C05232 (2S)-2-Methylacyl-CoA generic -metabolite KEGG:C05234 Detyrosinated alpha-tubulin generic -metabolite KEGG:C05235 Hydroxyacetone generic -metabolite KEGG:C05239 5-Aminoimidazole generic -metabolite KEGG:C05243 (R)-N-Methylcoclaurine generic -metabolite KEGG:C05247 10-Hydroxydihydrosanguinarine generic -metabolite KEGG:C05250 [Protein-PII] generic -metabolite KEGG:C05252 2-Amino-4-oxo-4-alpha-hydroxy-6-(erythro-1',2',3'-Tri-hydroxypropyl)-5,6,7,8-tetrahydroxypterin generic -metabolite KEGG:C05253 2-Amino-4-oxo-6-(1',2',3'-trihydroxypropyl)-diquinoid-7,8-dihydroxypterin generic -metabolite KEGG:C05258 (S)-3-Hydroxyhexadecanoyl-CoA generic -metabolite KEGG:C05259 3-Oxopalmitoyl-CoA generic -metabolite KEGG:C05260 (S)-3-Hydroxytetradecanoyl-CoA generic -metabolite KEGG:C05261 3-Oxotetradecanoyl-CoA generic -metabolite KEGG:C05262 (S)-3-Hydroxydodecanoyl-CoA generic -metabolite KEGG:C05263 3-Oxododecanoyl-CoA generic -metabolite KEGG:C05264 (S)-Hydroxydecanoyl-CoA generic -metabolite KEGG:C05265 3-Oxodecanoyl-CoA generic -metabolite KEGG:C05266 (S)-3-Hydroxyoctanoyl-CoA generic -metabolite KEGG:C05267 3-Oxooctanoyl-CoA generic -metabolite KEGG:C05268 (S)-Hydroxyhexanoyl-CoA generic -metabolite KEGG:C05269 3-Oxohexanoyl-CoA generic -metabolite KEGG:C05270 Hexanoyl-CoA generic -metabolite KEGG:C05271 trans-Hex-2-enoyl-CoA generic -metabolite KEGG:C05272 trans-Hexadec-2-enoyl-CoA generic -metabolite KEGG:C05273 trans-Tetradec-2-enoyl-CoA generic -metabolite KEGG:C05274 Decanoyl-CoA generic -metabolite KEGG:C05275 trans-Dec-2-enoyl-CoA generic -metabolite KEGG:C05276 trans-Oct-2-enoyl-CoA generic -metabolite KEGG:C05278 (R)-3-Hydroxycapryloyl-CoA generic -metabolite KEGG:C05279 trans,cis-Lauro-2,6-dienoyl-CoA generic -metabolite KEGG:C05280 cis,cis-3,6-Dodecadienoyl-CoA generic -metabolite KEGG:C05281 5-Methylbarbiturate generic -metabolite KEGG:C05282 (5-L-Glutamyl)-L-glutamate generic -metabolite KEGG:C05283 (5-L-Glutamyl)-L-glutamine generic -metabolite KEGG:C05284 11beta-Hydroxyandrost-4-ene-3,17-dione generic -metabolite KEGG:C05285 Adrenosterone generic -metabolite KEGG:C05290 19-Hydroxyandrost-4-ene-3,17-dione generic -metabolite KEGG:C05291 7alpha-Hydroxytestosterone generic -metabolite KEGG:C05293 5beta-Dihydrotestosterone generic -metabolite KEGG:C05294 19-Hydroxytestosterone generic -metabolite KEGG:C05295 19-Oxotestosterone generic -metabolite KEGG:C05296 7alpha-Hydroxyandrost-4-ene-3,17-dione generic -metabolite KEGG:C05297 19-Oxoandrost-4-ene-3,17-dione generic -metabolite KEGG:C05298 2-Hydroxyestrone generic -metabolite KEGG:C05299 2-Methoxyestrone generic -metabolite KEGG:C05300 16alpha-Hydroxyestrone generic -metabolite KEGG:C05301 2-Hydroxyestradiol generic -metabolite KEGG:C05302 2-Methoxy-17beta-estradiol generic -metabolite KEGG:C05305 Ferricytochrome b-561 generic -metabolite KEGG:C05306 Chlorophyll a generic -metabolite KEGG:C05307 Chlorophyll b generic -metabolite KEGG:C05308 Linalyl diphosphate generic -metabolite KEGG:C05309 Semiquinone generic -metabolite KEGG:C05312 Protein glycin-2-yl radical generic -metabolite KEGG:C05313 3-Hexaprenyl-4-hydroxy-5-methoxybenzoate generic -metabolite KEGG:C05314 N-Methyl-(R,S)-tetrahydrobenzylisoquinoline generic -metabolite KEGG:C05315 Palmatine generic -metabolite KEGG:C05316 Dihydromacarpine generic -metabolite KEGG:C05317 Nororientaline generic -metabolite KEGG:C05318 cis-N-Methyl-(S)-7,8,13,14-tetrahydroprotoberberine generic -metabolite KEGG:C05319 [Cytochrome c] S-methylmethionine generic -metabolite KEGG:C05320 Histone N(omega)-methyl-L-arginine generic -metabolite KEGG:C05321 [Myeline basic protein] N(omega)-methyl-L-arginine generic -metabolite KEGG:C05322 7-O-Acetylsalutaridinol generic -metabolite KEGG:C05324 Nicotianamine generic -metabolite KEGG:C05325 Purine mononucleotide generic -metabolite KEGG:C05326 Uridylyl-[protein-PII] generic -metabolite KEGG:C05328 D-2-Aminohexano-6-lactam generic -metabolite KEGG:C05329 (2R)-2-Methylacyl-CoA generic -metabolite KEGG:C05330 Homocysteine generic -metabolite KEGG:C05332 Phenethylamine generic -metabolite KEGG:C05334 Isosakuranetin generic -metabolite KEGG:C05335 L-Selenomethionine generic -metabolite KEGG:C05336 Selenomethionyl-tRNA(Met) generic -metabolite KEGG:C05337 Chenodeoxycholoyl-CoA generic -metabolite KEGG:C05338 4-Hydroxyphenylacetyl-CoA generic -metabolite KEGG:C05339 Phosphinate generic -metabolite KEGG:C05340 beta-Alanyl-L-arginine generic -metabolite KEGG:C05341 beta-Alanyl-L-lysine generic -metabolite KEGG:C05342 Psicofuranine generic -metabolite KEGG:C05343 (R)-4-Hydroxymandelate generic -metabolite KEGG:C05344 GDP-4-dehydro-6-deoxy-L-mannose generic -metabolite KEGG:C05345 beta-D-Fructose 6-phosphate generic -metabolite KEGG:C05346 Allosamidine generic -metabolite KEGG:C05349 Ciprofloxacin generic -metabolite KEGG:C05350 2-Hydroxy-3-(4-hydroxyphenyl)propenoate generic -metabolite KEGG:C05353 TES generic -metabolite KEGG:C05354 Cyclopropylcarbinyl cation generic -metabolite KEGG:C05356 5(S)-HPETE generic -metabolite KEGG:C05357 Oxidized azurin generic -metabolite KEGG:C05358 Reduced azurin generic -metabolite KEGG:C05359 e- generic -metabolite KEGG:C05360 Diimine generic -metabolite KEGG:C05361 Hydrazine generic -metabolite KEGG:C05364 4-Carboxy-2-oxo-3-hexenedioate generic -metabolite KEGG:C05366 (+)-Pinoresinol generic -metabolite KEGG:C05370 Calyculin A generic -metabolite KEGG:C05371 Microcystin LR generic -metabolite KEGG:C05372 Tautomycin generic -metabolite KEGG:C05375 2-Hydroxy-2-hydropyrone-4,6-dicarboxylate generic -metabolite KEGG:C05376 Biochanin A-beta-D-glucoside generic -metabolite KEGG:C05377 Menadione generic -metabolite KEGG:C05378 beta-D-Fructose 1,6-bisphosphate generic -metabolite KEGG:C05379 Oxalosuccinate generic -metabolite KEGG:C05380 Nicotinurate generic -metabolite KEGG:C05381 3-Carboxy-1-hydroxypropyl-ThPP generic -metabolite KEGG:C05382 Sedoheptulose 7-phosphate generic -metabolite KEGG:C05383 Aminosugar generic -metabolite KEGG:C05385 D-Glucuronate 1-phosphate generic -metabolite KEGG:C05386 GDP-6-deoxy-L-mannose generic -metabolite KEGG:C05392 Oligouronide with 4-deoxy-alpha-L-erythro-hex-4-enopyranuronosyl group generic -metabolite KEGG:C05394 3-Keto-beta-D-galactose generic -metabolite KEGG:C05396 Lactose 6'-phosphate generic -metabolite KEGG:C05399 Melibiitol generic -metabolite KEGG:C05400 Epimelibiose generic -metabolite KEGG:C05401 3-beta-D-Galactosyl-sn-glycerol generic -metabolite KEGG:C05402 Melibiose generic -metabolite KEGG:C05403 3-Ketolactose generic -metabolite KEGG:C05404 D-Gal alpha 1->6D-Gal alpha 1->6D-Glucose generic -metabolite KEGG:C05405 L-Arabinono-1,5-lactone generic -metabolite KEGG:C05406 5-Hydroxy-2,4-dioxopentanoate generic -metabolite KEGG:C05410 Gulono-1,4-lactone generic -metabolite KEGG:C05411 L-Xylonate generic -metabolite KEGG:C05412 L-Lyxonate generic -metabolite KEGG:C05413 all-trans-Phytoene generic -metabolite KEGG:C05414 all-trans-Phytofluene generic -metabolite KEGG:C05416 5-Cholestene generic -metabolite KEGG:C05417 5,6beta-Epoxy-5beta-cholestane generic -metabolite KEGG:C05418 Cholesterol-5beta,6beta-epoxide generic -metabolite KEGG:C05421 15-cis-Phytoene generic -metabolite KEGG:C05422 Dehydroascorbate generic -metabolite KEGG:C05423 5,6alpha-Epoxy-5alpha-cholestane generic -metabolite KEGG:C05424 5alpha-Cholestan-5alpha,6beta-diol generic -metabolite KEGG:C05425 3beta,5alpha,6beta-Cholestanetriol generic -metabolite KEGG:C05427 Phytyl diphosphate generic -metabolite KEGG:C05430 all-trans-zeta-Carotene generic -metabolite KEGG:C05431 all-trans-Neurosporene generic -metabolite KEGG:C05432 Lycopene generic -metabolite KEGG:C05433 alpha-Carotene generic -metabolite KEGG:C05434 beta-Zeacarotene generic -metabolite KEGG:C05435 gamma-Carotene generic -metabolite KEGG:C05437 Zymosterol generic -metabolite KEGG:C05439 5alpha-Cholesta-7,24-dien-3beta-ol generic -metabolite KEGG:C05440 Ergosta-5,7,22,24(28)-tetraen-3beta-ol generic -metabolite KEGG:C05441 Vitamin D2 generic -metabolite KEGG:C05442 Stigmasterol generic -metabolite KEGG:C05443 Vitamin D3 generic -metabolite KEGG:C05444 3alpha,7alpha,26-Trihydroxy-5beta-cholestane generic -metabolite KEGG:C05445 3alpha,7alpha-Dihydroxy-5beta-cholestan-26-al generic -metabolite KEGG:C05446 3alpha,7alpha,12alpha,26-Tetrahydroxy-5beta-cholestane generic -metabolite KEGG:C05447 (24E)-3alpha,7alpha-Dihydroxy-5beta-cholest-24-enoyl-CoA generic -metabolite KEGG:C05448 (24R,25R)-3alpha,7alpha,24-Trihydroxy-5beta-cholestanoyl-CoA generic -metabolite KEGG:C05449 3alpha,7alpha-Dihydroxy-5beta-24-oxocholestanoyl-CoA generic -metabolite KEGG:C05450 3alpha,7alpha,12alpha,24-Tetrahydroxy-5beta-cholestanoyl-CoA generic -metabolite KEGG:C05451 7alpha-Hydroxy-5beta-cholestan-3-one generic -metabolite KEGG:C05452 3alpha,7alpha-Dihydroxy-5beta-cholestane generic -metabolite KEGG:C05453 7alpha,12alpha-Dihydroxy-5beta-cholestan-3-one generic -metabolite KEGG:C05454 3alpha,7alpha,12alpha-Trihydroxy-5beta-cholestane generic -metabolite KEGG:C05455 7alpha-Hydroxycholest-4-en-3-one generic -metabolite KEGG:C05458 7alpha,12alpha-Dihydroxy-5alpha-cholestan-3-one generic -metabolite KEGG:C05460 (24E)-3alpha,7alpha,12alpha-Trihydroxy-5beta-cholest-24-enoyl-CoA generic -metabolite KEGG:C05463 Taurodeoxycholate generic -metabolite KEGG:C05464 Glycodeoxycholate generic -metabolite KEGG:C05465 Taurochenodeoxycholate generic -metabolite KEGG:C05466 Glycochenodeoxycholate generic -metabolite KEGG:C05467 3alpha,7alpha,12alpha-Trihydroxy-5beta-24-oxocholestanoyl-CoA generic -metabolite KEGG:C05468 5beta-Cyprinolsulfate generic -metabolite KEGG:C05469 17alpha,21-Dihydroxy-5beta-pregnane-3,11,20-trione generic -metabolite KEGG:C05470 Tetrahydrocortisone generic -metabolite KEGG:C05471 11beta,17alpha,21-Trihydroxy-5beta-pregnane-3,20-dione generic -metabolite KEGG:C05472 Urocortisol generic -metabolite KEGG:C05473 11beta,21-Dihydroxy-3,20-oxo-5beta-pregnan-18-al generic -metabolite KEGG:C05474 3alpha,11beta,21-Trihydroxy-20-oxo-5beta-pregnan-18-al generic -metabolite KEGG:C05475 11beta,21-Dihydroxy-5beta-pregnane-3,20-dione generic -metabolite KEGG:C05476 Tetrahydrocorticosterone generic -metabolite KEGG:C05477 21-Hydroxy-5beta-pregnane-3,11,20-trione generic -metabolite KEGG:C05478 3alpha,21-Dihydroxy-5beta-pregnane-11,20-dione generic -metabolite KEGG:C05479 5beta-Pregnane-3,20-dione generic -metabolite KEGG:C05480 Pregnanolone generic -metabolite KEGG:C05481 Cortolone generic -metabolite KEGG:C05482 Cortol generic -metabolite KEGG:C05483 3alpha,20alpha,21-Trihydroxy-5beta-pregnan-11-one generic -metabolite KEGG:C05484 Pregnanediol generic -metabolite KEGG:C05485 21-Hydroxypregnenolone generic -metabolite KEGG:C05487 17alpha,21-Dihydroxypregnenolone generic -metabolite KEGG:C05488 11-Deoxycortisol generic -metabolite KEGG:C05489 11beta,17alpha,21-Trihydroxypregnenolone generic -metabolite KEGG:C05490 11-Dehydrocorticosterone generic -metabolite KEGG:C05497 21-Deoxycortisol generic -metabolite KEGG:C05498 11beta-Hydroxyprogesterone generic -metabolite KEGG:C05499 17alpha,20alpha-Dihydroxycholesterol generic -metabolite KEGG:C05500 20alpha-Hydroxycholesterol generic -metabolite KEGG:C05501 20alpha,22beta-Dihydroxycholesterol generic -metabolite KEGG:C05502 22(R)-Hydroxycholesterol generic -metabolite KEGG:C05503 Estradiol-17beta 3-glucuronide generic -metabolite KEGG:C05504 16-Glucuronide-estriol generic -metabolite KEGG:C05512 Deoxyinosine generic -metabolite KEGG:C05513 Urate-3-ribonucleoside generic -metabolite KEGG:C05515 5-Ureido-4-imidazole carboxylate generic -metabolite KEGG:C05516 5-Amino-4-imidazole carboxylate generic -metabolite KEGG:C05519 L-Allothreonine generic -metabolite KEGG:C05520 2-Amino-3-oxoadipate generic -metabolite KEGG:C05524 Aminoacyl-L-methionine generic -metabolite KEGG:C05526 S-Glutathionyl-L-cysteine generic -metabolite KEGG:C05527 3-Sulfinylpyruvate generic -metabolite KEGG:C05528 3-Sulfopyruvate generic -metabolite KEGG:C05529 Thiosulfuric acid generic -metabolite KEGG:C05533 Oxaloglutarate generic -metabolite KEGG:C05535 alpha-Aminoadipoyl-S-acyl enzyme generic -metabolite KEGG:C05537 N-Succinyl-2-amino-6-oxopimelate generic -metabolite KEGG:C05539 N-Acetyl-L-2-amino-6-oxopimelate generic -metabolite KEGG:C05544 Protein N6-methyl-L-lysine generic -metabolite KEGG:C05545 Protein N6,N6-dimethyl-L-lysine generic -metabolite KEGG:C05546 Protein N6,N6,N6-trimethyl-L-lysine generic -metabolite KEGG:C05548 6-Acetamido-2-oxohexanoate generic -metabolite KEGG:C05551 Penicillin G generic -metabolite KEGG:C05552 Biocytin generic -metabolite KEGG:C05554 Aerobactin generic -metabolite KEGG:C05556 delta-(L-2-Aminoadipyl)-L-cysteinyl-D-valine generic -metabolite KEGG:C05557 Isopenicillin N generic -metabolite KEGG:C05560 L-2-Aminoadipate adenylate generic -metabolite KEGG:C05562 1H-Imidazole-4-methanol generic -metabolite KEGG:C05565 Hydantoin-5-propionate generic -metabolite KEGG:C05568 Imidazole lactate generic -metabolite KEGG:C05570 Ergothioneine generic -metabolite KEGG:C05571 Thiourocanic acid generic -metabolite KEGG:C05572 4-Oxoglutaramate generic -metabolite KEGG:C05574 3-Aminopentanedioate generic -metabolite KEGG:C05575 Hercynine generic -metabolite KEGG:C05576 3,4-Dihydroxyphenylethyleneglycol generic -metabolite KEGG:C05577 3,4-Dihydroxymandelaldehyde generic -metabolite KEGG:C05578 5,6-Dihydroxyindole generic -metabolite KEGG:C05579 Indole-5,6-quinone generic -metabolite KEGG:C05580 3,4-Dihydroxymandelate generic -metabolite KEGG:C05581 3-Methoxy-4-hydroxyphenylacetaldehyde generic -metabolite KEGG:C05582 Homovanillate generic -metabolite KEGG:C05583 3-Methoxy-4-hydroxyphenylglycolaldehyde generic -metabolite KEGG:C05584 3-Methoxy-4-hydroxymandelate generic -metabolite KEGG:C05585 Gentisate aldehyde generic -metabolite KEGG:C05587 3-Methoxytyramine generic -metabolite KEGG:C05588 L-Metanephrine generic -metabolite KEGG:C05589 L-Normetanephrine generic -metabolite KEGG:C05590 Hydroiodic acid generic -metabolite KEGG:C05592 3-Carboxymethylmuconate generic -metabolite KEGG:C05593 3-Hydroxyphenylacetate generic -metabolite KEGG:C05594 3-Methoxy-4-hydroxyphenylethyleneglycol generic -metabolite KEGG:C05595 4-Hydroxyphenylacetylglutamic acid generic -metabolite KEGG:C05596 p-Hydroxyphenylacetylglycine generic -metabolite KEGG:C05598 Phenylacetylglycine generic -metabolite KEGG:C05600 2-Hydroxyhepta-2,4-dienedioate generic -metabolite KEGG:C05601 4-Hydroxy-2-oxo-heptanedioate generic -metabolite KEGG:C05604 2-Carboxy-2,3-dihydro-5,6-dihydroxyindole generic -metabolite KEGG:C05606 Melanin generic -metabolite KEGG:C05607 Phenyllactate generic -metabolite KEGG:C05608 4-Hydroxycinnamyl aldehyde generic -metabolite KEGG:C05610 Sinapoyl aldehyde generic -metabolite KEGG:C05613 Benzylformate generic -metabolite KEGG:C05615 Lignin generic -metabolite KEGG:C05616 3-O-Methylgallate generic -metabolite KEGG:C05618 3-Chlorocatechol generic -metabolite KEGG:C05619 5-Hydroxyferulic acid methyl ester generic -metabolite KEGG:C05620 N-Acetyl-D-phenylalanine generic -metabolite KEGG:C05622 Malonylapiin generic -metabolite KEGG:C05623 Quercetin 3-O-glucoside generic -metabolite KEGG:C05625 Rutin generic -metabolite KEGG:C05627 4-Hydroxystyrene generic -metabolite KEGG:C05629 Phenylpropanoate generic -metabolite KEGG:C05631 Eriodictyol generic -metabolite KEGG:C05634 5-Hydroxyindoleacetaldehyde generic -metabolite KEGG:C05635 5-Hydroxyindoleacetate generic -metabolite KEGG:C05636 3-Hydroxykynurenamine generic -metabolite KEGG:C05637 4,8-Dihydroxyquinoline generic -metabolite KEGG:C05638 5-Hydroxykynurenamine generic -metabolite KEGG:C05639 4,6-Dihydroxyquinoline generic -metabolite KEGG:C05640 Cinnavalininate generic -metabolite KEGG:C05641 5-(3'-Carboxy-3'-oxopropenyl)-4,6-dihydroxypicolinate generic -metabolite KEGG:C05642 Formyl-N-acetyl-5-methoxykynurenamine generic -metabolite KEGG:C05643 6-Hydroxymelatonin generic -metabolite KEGG:C05644 3-Methylindolepyruvate generic -metabolite KEGG:C05645 4-(2-Amino-3-hydroxyphenyl)-2,4-dioxobutanoate generic -metabolite KEGG:C05646 5-Hydroxyindolepyruvate generic -metabolite KEGG:C05647 Formyl-5-hydroxykynurenamine generic -metabolite KEGG:C05648 5-Hydroxy-N-formylkynurenine generic -metabolite KEGG:C05649 Dihydropteridine generic -metabolite KEGG:C05650 Tetrahydropteridine generic -metabolite KEGG:C05651 5-Hydroxykynurenine generic -metabolite KEGG:C05652 4-(2-Amino-5-hydroxyphenyl)-2,4-dioxobutanoate generic -metabolite KEGG:C05653 Formylanthranilate generic -metabolite KEGG:C05654 5-(2'-Formylethyl)-4,6-dihydroxypicolinate generic -metabolite KEGG:C05655 5-(2'-Carboxyethyl)-4,6-dihydroxypicolinate generic -metabolite KEGG:C05656 5-(3'-Carboxy-3'-oxopropyl)-4,6-dihydroxypicolinate generic -metabolite KEGG:C05657 6-Hydroxyindolelactate generic -metabolite KEGG:C05658 Indoxyl generic -metabolite KEGG:C05659 5-Methoxytryptamine generic -metabolite KEGG:C05660 5-Methoxyindoleacetate generic -metabolite KEGG:C05662 Homoisocitrate generic -metabolite KEGG:C05663 6-Hydroxykynurenate generic -metabolite KEGG:C05665 3-Aminopropanal generic -metabolite KEGG:C05668 3-Hydroxypropionyl-CoA generic -metabolite KEGG:C05669 beta-Nitropropanoate generic -metabolite KEGG:C05670 3-Aminopropiononitrile generic -metabolite KEGG:C05672 2-Amino-3-phosphonopropanoate generic -metabolite KEGG:C05673 CMP-2-aminoethylphosphonate generic -metabolite KEGG:C05674 CMP-N-trimethyl-2-aminoethylphosphonate generic -metabolite KEGG:C05675 Diacylglyceryl-2-aminoethylphosphonate generic -metabolite KEGG:C05676 Diacylglyceryl-N-trimethyl-2-aminoethylphosphonate generic -metabolite KEGG:C05677 Lipophosphonoglycan generic -metabolite KEGG:C05678 (2-Amino-1-hydroxyethyl)phosphonate generic -metabolite KEGG:C05679 N-Monomethyl-2-aminoethylphosphonate generic -metabolite KEGG:C05680 N-Dimethyl-2-aminoethylphosphonate generic -metabolite KEGG:C05681 Ceramide 2-aminoethylphosphonate generic -metabolite KEGG:C05682 Phosphonoacetate generic -metabolite KEGG:C05683 Ciliatocholate generic -metabolite KEGG:C05684 Selenite generic -metabolite KEGG:C05686 Adenylylselenate generic -metabolite KEGG:C05688 L-Selenocysteine generic -metabolite KEGG:C05689 Se-Methyl-L-selenocysteine generic -metabolite KEGG:C05690 Se-Methylselenomethionine generic -metabolite KEGG:C05691 Se-Adenosylselenomethionine generic -metabolite KEGG:C05692 Se-Adenosyl-L-selenohomocysteine generic -metabolite KEGG:C05693 R generic -metabolite KEGG:C05694 CH3-R generic -metabolite KEGG:C05695 gamma-Glutamyl-Se-methylselenocysteine generic -metabolite KEGG:C05696 3'-Phosphoadenylylselenate generic -metabolite KEGG:C05697 Selenate generic -metabolite KEGG:C05698 Selenohomocysteine generic -metabolite KEGG:C05699 L-Selenocystathionine generic -metabolite KEGG:C05702 O-Phosphorylhomoserine generic -metabolite KEGG:C05703 Methaneselenol generic -metabolite KEGG:C05704 Selenocystine generic -metabolite KEGG:C05705 Selenocysteine seleninic acid generic -metabolite KEGG:C05706 Se-Propenylselenocysteine Se-oxide generic -metabolite KEGG:C05707 Selenohomocystine generic -metabolite KEGG:C05708 Selenomethionine Se-oxide generic -metabolite KEGG:C05710 N-Hydroxy-amino acid generic -metabolite KEGG:C05711 gamma-Glutamyl-beta-cyanoalanine generic -metabolite KEGG:C05712 Cyanohydrin generic -metabolite KEGG:C05713 Cyanoglycoside generic -metabolite KEGG:C05714 alpha-Aminopropiononitrile generic -metabolite KEGG:C05715 gamma-Amino-gamma-cyanobutanoate generic -metabolite KEGG:C05717 alpha-Amino-gamma-cyanobutanoate generic -metabolite KEGG:C05718 2-Oxoacid oxime generic -metabolite KEGG:C05720 Reduced 2,6-Dichlorophenolindophenol generic -metabolite KEGG:C05721 Leucomethylene blue generic -metabolite KEGG:C05723 Poly-gamma-D-glutamate generic -metabolite KEGG:C05726 S-Substituted L-cysteine generic -metabolite KEGG:C05727 S-Substituted N-acetyl-L-cysteine generic -metabolite KEGG:C05729 R-S-Cysteinylglycine generic -metabolite KEGG:C05730 Glutathionylspermidine generic -metabolite KEGG:C05731 3-Ketosucrose generic -metabolite KEGG:C05737 Maltose 6-phosphate generic -metabolite KEGG:C05744 Acetoacetyl-[acp] generic -metabolite KEGG:C05745 Butyryl-[acp] generic -metabolite KEGG:C05746 3-Oxohexanoyl-[acp] generic -metabolite KEGG:C05747 (R)-3-Hydroxyhexanoyl-[acp] generic -metabolite KEGG:C05748 trans-Hex-2-enoyl-[acp] generic -metabolite KEGG:C05749 Hexanoyl-[acp] generic -metabolite KEGG:C05750 3-Oxooctanoyl-[acp] generic -metabolite KEGG:C05751 trans-Oct-2-enoyl-[acp] generic -metabolite KEGG:C05752 Octanoyl-[acp] generic -metabolite KEGG:C05753 3-Oxodecanoyl-[acp] generic -metabolite KEGG:C05754 trans-Dec-2-enoyl-[acp] generic -metabolite KEGG:C05755 Decanoyl-[acp] generic -metabolite KEGG:C05756 3-Oxododecanoyl-[acp] generic -metabolite KEGG:C05757 (R)-3-Hydroxydodecanoyl-[acp] generic -metabolite KEGG:C05758 trans-Dodec-2-enoyl-[acp] generic -metabolite KEGG:C05759 3-Oxotetradecanoyl-[acp] generic -metabolite KEGG:C05760 trans-Tetradec-2-enoyl-[acp] generic -metabolite KEGG:C05761 Tetradecanoyl-[acp] generic -metabolite KEGG:C05762 3-Oxohexadecanoyl-[acp] generic -metabolite KEGG:C05763 trans-Hexadec-2-enoyl-[acp] generic -metabolite KEGG:C05764 Hexadecanoyl-[acp] generic -metabolite KEGG:C05765 L-Glutamyl 1-phosphate generic -metabolite KEGG:C05766 Uroporphyrinogen I generic -metabolite KEGG:C05767 Uroporphyrin I generic -metabolite KEGG:C05768 Coproporphyrinogen I generic -metabolite KEGG:C05769 Coproporphyrin I generic -metabolite KEGG:C05770 Coproporphyrin III generic -metabolite KEGG:C05771 1-Aminopropan-2-ol generic -metabolite KEGG:C05772 Precorrin 3A generic -metabolite KEGG:C05773 Cobyrinate generic -metabolite KEGG:C05774 Cobinamide generic -metabolite KEGG:C05775 alpha-Ribazole generic -metabolite KEGG:C05776 Vitamin B12 generic -metabolite KEGG:C05777 Coenzyme F430 generic -metabolite KEGG:C05778 Sirohydrochlorin generic -metabolite KEGG:C05779 Apoferritin generic -metabolite KEGG:C05780 Apotransferrin generic -metabolite KEGG:C05781 Oxyhemoglobin generic -metabolite KEGG:C05782 Myoglobin generic -metabolite KEGG:C05783 Cytochrome a generic -metabolite KEGG:C05784 Catalase generic -metabolite KEGG:C05785 Peroxidase generic -metabolite KEGG:C05786 (3Z)-Phycocyanobilin generic -metabolite KEGG:C05787 Bilirubin beta-diglucuronide generic -metabolite KEGG:C05789 L-Urobilinogen generic -metabolite KEGG:C05790 I-Urobilinogen generic -metabolite KEGG:C05791 D-Urobilinogen generic -metabolite KEGG:C05793 L-Urobilin generic -metabolite KEGG:C05794 Urobilin generic -metabolite KEGG:C05795 D-Urobilin generic -metabolite KEGG:C05796 Galactan generic -metabolite KEGG:C05797 Pheophytin a generic -metabolite KEGG:C05798 Bacteriopheophytin generic -metabolite KEGG:C05799 Bacteriochlorophylls generic -metabolite KEGG:C05800 2-Hexaprenylphenol generic -metabolite KEGG:C05801 2-Hexaprenyl-6-hydroxyphenol generic -metabolite KEGG:C05802 2-Hexaprenyl-6-methoxyphenol generic -metabolite KEGG:C05803 2-Hexaprenyl-6-methoxy-1,4-benzoquinone generic -metabolite KEGG:C05804 2-Hexaprenyl-3-methyl-6-methoxy-1,4-benzoquinone generic -metabolite KEGG:C05805 2-Hexaprenyl-3-methyl-5-hydroxy-6-methoxy-1,4-benzoquinone generic -metabolite KEGG:C05807 2-Polyprenylphenol generic -metabolite KEGG:C05808 5-Hydroxy-2-polyprenylphenol generic -metabolite KEGG:C05809 3-Octaprenyl-4-hydroxybenzoate generic -metabolite KEGG:C05810 2-Octaprenylphenol generic -metabolite KEGG:C05811 2-Octaprenyl-6-hydroxyphenol generic -metabolite KEGG:C05812 2-Octaprenyl-6-methoxyphenol generic -metabolite KEGG:C05813 2-Octaprenyl-6-methoxy-1,4-benzoquinone generic -metabolite KEGG:C05814 2-Octaprenyl-3-methyl-6-methoxy-1,4-benzoquinone generic -metabolite KEGG:C05815 2-Octaprenyl-3-methyl-5-hydroxy-6-methoxy-1,4-benzoquinone generic -metabolite KEGG:C05817 (1R,6R)-6-Hydroxy-2-succinylcyclohexa-2,4-diene-1-carboxylate generic -metabolite KEGG:C05818 2-Demethylmenaquinone generic -metabolite KEGG:C05819 Menaquinol generic -metabolite KEGG:C05820 (L-Seryl)adenylate generic -metabolite KEGG:C05821 Enterochelin generic -metabolite KEGG:C05822 3'-CMP generic -metabolite KEGG:C05823 3-Mercaptolactate generic -metabolite KEGG:C05824 S-Sulfo-L-cysteine generic -metabolite KEGG:C05825 2-Amino-5-oxohexanoate generic -metabolite KEGG:C05827 Methylimidazole acetaldehyde generic -metabolite KEGG:C05828 Methylimidazoleacetic acid generic -metabolite KEGG:C05829 N-Carbamyl-L-glutamate generic -metabolite KEGG:C05830 8-Methoxykynurenate generic -metabolite KEGG:C05831 3-Methoxyanthranilate generic -metabolite KEGG:C05832 5-Hydroxyindoleacetylglycine generic -metabolite KEGG:C05834 3-Methyldioxyindole generic -metabolite KEGG:C05835 2-Formaminobenzoylacetate generic -metabolite KEGG:C05837 Glucobrassicin generic -metabolite KEGG:C05838 cis-2-Hydroxycinnamate generic -metabolite KEGG:C05839 cis-beta-D-Glucosyl-2-hydroxycinnamate generic -metabolite KEGG:C05840 Iminoaspartate generic -metabolite KEGG:C05841 Nicotinate D-ribonucleoside generic -metabolite KEGG:C05842 N1-Methyl-2-pyridone-5-carboxamide generic -metabolite KEGG:C05843 N1-Methyl-4-pyridone-5-carboxamide generic -metabolite KEGG:C05844 5-L-Glutamyl-taurine generic -metabolite KEGG:C05845 N-Acetyl-D-galactosaminyldiphosphoundecaprenol generic -metabolite KEGG:C05847 all-trans-Polyprenyl diphosphate generic -metabolite KEGG:C05848 4-Hydroxy-3-polyprenylbenzoate generic -metabolite KEGG:C05849 Vitamin K1 epoxide generic -metabolite KEGG:C05850 Reduced Vitamin K generic -metabolite KEGG:C05851 Coumarin generic -metabolite KEGG:C05852 2-Hydroxyphenylacetate generic -metabolite KEGG:C05853 Phenylethyl alcohol generic -metabolite KEGG:C05855 4-Hydroxycinnamyl alcohol 4-D-glucoside generic -metabolite KEGG:C05856 Thiamine aldehyde generic -metabolite KEGG:C05859 Dehydrodolichol diphosphate generic -metabolite KEGG:C05860 beta-D-Mannosyldiacetylchitobiosyldiphosphodolichol generic -metabolite KEGG:C05861 alpha-D-Mannosyl-beta-D-mannosyl-diacetylchitobiosyldiphosphodolichol generic -metabolite KEGG:C05864 (alpha-D-Mannosyl)4-beta-D-mannosyl-diacetylchitobiosyldiphosphodolichol generic -metabolite KEGG:C05868 (alpha-D-Mannosyl)8-beta-D-mannosyl-diacetylchitobiosyldiphosphodolichol generic -metabolite KEGG:C05869 (alpha-D-Mannosyl)9-beta-D-mannosyl-diacetylchitobiosyldiphosphodolichol generic -metabolite KEGG:C05892 UDP-N-acetylmuramoyl-L-alanyl-gamma-D-glutamyl-L-lysine generic -metabolite KEGG:C05893 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-gamma-D-glutamyl-L-lysyl-D-alanyl-D-alanine generic -metabolite KEGG:C05894 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-D-isoglutaminyl-L-lysyl-D-alanyl-D-alanine generic -metabolite KEGG:C05895 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-D-isoglutaminyl-L-lysyl-(glycyl)5-D-alanyl-D-alanine generic -metabolite KEGG:C05896 Crosslinked peptidoglycan generic -metabolite KEGG:C05897 Undecaprenyl-diphospho-N-acetylmuramoyl-L-alanyl-D-glutamyl-meso-2,6-diaminopimeloyl-D-alanyl-D-alanine generic -metabolite KEGG:C05898 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-D-glutamyl-meso-2,6-diaminopimeloyl-D-alanyl-D-alanine generic -metabolite KEGG:C05901 Piceatannol generic -metabolite KEGG:C05902 3-Methoxyapigenin generic -metabolite KEGG:C05903 Kaempferol generic -metabolite KEGG:C05904 Pelargonidin generic -metabolite KEGG:C05905 Cyanidin generic -metabolite KEGG:C05906 Leucocyanidin generic -metabolite KEGG:C05907 Luteoforol generic -metabolite KEGG:C05908 Delphinidin generic -metabolite KEGG:C05909 Leucodelphinidin generic -metabolite KEGG:C05911 Pentahydroxyflavanone generic -metabolite KEGG:C05912 (3Z)-Phycoerythrobilin generic -metabolite KEGG:C05913 (3Z)-Phytochromobilin generic -metabolite KEGG:C05914 Bathorhodopsin generic -metabolite KEGG:C05915 Lumirhodopsin generic -metabolite KEGG:C05916 Metarhodopsin generic -metabolite KEGG:C05917 Iodopsin generic -metabolite KEGG:C05918 all-trans-Dehydroretinal generic -metabolite KEGG:C05919 11-cis-Dehydroretinal generic -metabolite KEGG:C05920 Porphyropsin generic -metabolite KEGG:C05921 Biotinyl-5'-AMP generic -metabolite KEGG:C05922 Formamidopyrimidine nucleoside triphosphate generic -metabolite KEGG:C05923 2,5-Diaminopyrimidine nucleoside triphosphate generic -metabolite KEGG:C05924 Molybdopterin generic -metabolite KEGG:C05925 Dihydroneopterin phosphate generic -metabolite KEGG:C05926 Neopterin generic -metabolite KEGG:C05927 7,8-Dihydromethanopterin generic -metabolite KEGG:C05928 (6R)-10-Formyltetrahydropteroyldiglutamate generic -metabolite KEGG:C05929 10-Formyltetrahydrofolylpolyglutamate generic -metabolite KEGG:C05931 N-Succinyl-L-glutamate generic -metabolite KEGG:C05932 N-Succinyl-L-glutamate 5-semialdehyde generic -metabolite KEGG:C05933 N(omega)-Hydroxyarginine generic -metabolite KEGG:C05936 N4-Acetylaminobutanal generic -metabolite KEGG:C05938 L-4-Hydroxyglutamate semialdehyde generic -metabolite KEGG:C05939 Linatine generic -metabolite KEGG:C05941 2-Oxo-4-hydroxy-5-aminovalerate generic -metabolite KEGG:C05942 Pyrrole-2-carboxylate generic -metabolite KEGG:C05944 Pantothenol generic -metabolite KEGG:C05945 L-Arginine phosphate generic -metabolite KEGG:C05946 (4R)-4-Hydroxy-2-oxoglutarate generic -metabolite KEGG:C05947 L-erythro-4-Hydroxyglutamate generic -metabolite KEGG:C05949 12-Keto-leukotriene B4 generic -metabolite KEGG:C05950 20-COOH-Leukotriene B4 generic -metabolite KEGG:C05951 Leukotriene D4 generic -metabolite KEGG:C05952 Leukotriene E4 generic -metabolite KEGG:C05953 Prostaglandin A2 generic -metabolite KEGG:C05954 Prostaglandin B2 generic -metabolite KEGG:C05955 Prostaglandin C2 generic -metabolite KEGG:C05956 Prostaglandin G2 generic -metabolite KEGG:C05957 Prostaglandin J2 generic -metabolite KEGG:C05958 Delta-12-Prostaglandin J2 generic -metabolite KEGG:C05959 11-epi-Prostaglandin F2alpha generic -metabolite KEGG:C05960 15-Keto-prostaglandin F2alpha generic -metabolite KEGG:C05961 6-Keto-prostaglandin F1alpha generic -metabolite KEGG:C05962 6-Keto-prostaglandin E1 generic -metabolite KEGG:C05963 Thromboxane B2 generic -metabolite KEGG:C05964 11-Dehydro-thromboxane B2 generic -metabolite KEGG:C05965 12(S)-HPETE generic -metabolite KEGG:C05966 15(S)-HPETE generic -metabolite KEGG:C05973 2-Acyl-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C05974 2-Acyl-sn-glycero-3-phosphoserine generic -metabolite KEGG:C05976 Aminoacyl-phosphatidylglycerol generic -metabolite KEGG:C05977 2-Acyl-1-alkyl-sn-glycero-3-phosphate generic -metabolite KEGG:C05979 Propane-1-ol generic -metabolite KEGG:C05980 Cardiolipin generic -metabolite KEGG:C05981 Phosphatidylinositol-3,4,5-trisphosphate generic -metabolite KEGG:C05983 Propionyladenylate generic -metabolite KEGG:C05984 2-Hydroxybutanoic acid generic -metabolite KEGG:C05985 2-Propynal generic -metabolite KEGG:C05986 2-Propyn-1-ol generic -metabolite KEGG:C05989 3-Oxopropionyl-CoA generic -metabolite KEGG:C05990 Isoscoparine generic -metabolite KEGG:C05993 Acetyl adenylate generic -metabolite KEGG:C05994 2-Propylmalate generic -metabolite KEGG:C05995 7-Hydroxy-6-methyl-8-ribityllumazine generic -metabolite KEGG:C05996 Branched chain fatty acid generic -metabolite KEGG:C05998 3-Hydroxyisovaleryl-CoA generic -metabolite KEGG:C05999 Lactaldehyde generic -metabolite KEGG:C06000 (S)-3-Hydroxyisobutyryl-CoA generic -metabolite KEGG:C06001 (S)-3-Hydroxyisobutyrate generic -metabolite KEGG:C06002 (S)-Methylmalonate semialdehyde generic -metabolite KEGG:C06006 (S)-2-Aceto-2-hydroxybutanoate generic -metabolite KEGG:C06007 (R)-2,3-Dihydroxy-3-methylpentanoate generic -metabolite KEGG:C06008 (3R)-3-Methyl-2-oxopentanoic acid generic -metabolite KEGG:C06010 (S)-2-Acetolactate generic -metabolite KEGG:C06011 Benzenamine sulfate generic -metabolite KEGG:C06016 Pentosan generic -metabolite KEGG:C06017 dTDP-D-glucuronate generic -metabolite KEGG:C06018 dTDP-4-acetamido-4,6-dideoxy-D-glucose generic -metabolite KEGG:C06019 D-arabino-Hex-3-ulose 6-phosphate generic -metabolite KEGG:C06020 Methyl-Co(III) corrinoid protein generic -metabolite KEGG:C06021 Co(I) corrinoid protein generic -metabolite KEGG:C06022 UDP-3-O-(3-hydroxytetradecanoyl)-D-glucosamine generic -metabolite KEGG:C06023 D-Glucosaminide generic -metabolite KEGG:C06024 3-Deoxy-D-manno-octulosonyl-lipid IV(A) generic -metabolite KEGG:C06025 KDO2-lipid IVA generic -metabolite KEGG:C06026 KDO2-lipid A generic -metabolite KEGG:C06027 L-erythro-3-Methylmalyl-CoA generic -metabolite KEGG:C06028 2-Methylfumaryl-CoA generic -metabolite KEGG:C06029 L-threo-3-Methylmalate generic -metabolite KEGG:C06030 Methyloxaloacetate generic -metabolite KEGG:C06031 D-threo-3-Methylmalate generic -metabolite KEGG:C06032 D-erythro-3-Methylmalate generic -metabolite KEGG:C06033 Parapyruvate generic -metabolite KEGG:C06034 4-Hydroxy-4-methylglutamate generic -metabolite KEGG:C06035 4-Methylene-2-oxoglutarate generic -metabolite KEGG:C06036 Trigalactosyl-diacylglycerol generic -metabolite KEGG:C06037 Digalactosyl-diacylglycerol generic -metabolite KEGG:C06038 Acyl1-monogalactosyl-diacylglycerol generic -metabolite KEGG:C06040 Diglucosyldiacylglycerol generic -metabolite KEGG:C06041 Glycerophosphoglycoglycerolipid generic -metabolite KEGG:C06042 Lipoteichoic acid generic -metabolite KEGG:C06044 4-Hydroxyphenylethanol generic -metabolite KEGG:C06046 Salidroside generic -metabolite KEGG:C06047 Stizolobate generic -metabolite KEGG:C06048 Stizolobinate generic -metabolite KEGG:C06049 N-Formylderivatives generic -metabolite KEGG:C06050 2-Methyl-3-hydroxy-5-formylpyridine-4-carboxylate generic -metabolite KEGG:C06051 Isopyridoxal generic -metabolite KEGG:C06052 5-Pyridoxolactone generic -metabolite KEGG:C06054 2-Oxo-3-hydroxy-4-phosphobutanoate generic -metabolite KEGG:C06055 O-Phospho-4-hydroxy-L-threonine generic -metabolite KEGG:C06056 4-Hydroxy-L-threonine generic -metabolite KEGG:C06057 3-Aminopropane-1,2-diol generic -metabolite KEGG:C06058 Nitroalkane generic -metabolite KEGG:C06059 Cyclic amidine generic -metabolite KEGG:C06060 Amidine generic -metabolite KEGG:C06062 Ceramide phosphoethanolamine generic -metabolite KEGG:C06066 4,5-Dihydro-5,5-dimethyl-4-(3-oxobutyl)furan-2(3H)-one generic -metabolite KEGG:C06067 Dimethylallyltryptophan generic -metabolite KEGG:C06068 Elymoclavine generic -metabolite KEGG:C06069 Iridodial generic -metabolite KEGG:C06070 Iridotrial generic -metabolite KEGG:C06071 Deoxyloganin generic -metabolite KEGG:C06074 Myrcene generic -metabolite KEGG:C06075 Terpinolene generic -metabolite KEGG:C06076 Camphene generic -metabolite KEGG:C06077 Pinene generic -metabolite KEGG:C06078 Limonene generic -metabolite KEGG:C06079 PR-toxin generic -metabolite KEGG:C06080 Nivalenol generic -metabolite KEGG:C06081 Polyprenol generic -metabolite KEGG:C06082 Abscisate generic -metabolite KEGG:C06083 Tetrahymanol generic -metabolite KEGG:C06084 Hopanoid generic -metabolite KEGG:C06085 Triterpenoid generic -metabolite KEGG:C06086 Pimaradiene generic -metabolite KEGG:C06087 Abietate generic -metabolite KEGG:C06088 Aphidicolin generic -metabolite KEGG:C06089 ent-Copalyl diphosphate generic -metabolite KEGG:C06090 ent-Kaurene generic -metabolite KEGG:C06091 Aconitine generic -metabolite KEGG:C06092 Veatchine generic -metabolite KEGG:C06093 Gibberellin A12 aldehyde generic -metabolite KEGG:C06094 Gibberellin A53 generic -metabolite KEGG:C06095 Gibberellin A44 diacid generic -metabolite KEGG:C06096 Gibberellin A29 generic -metabolite KEGG:C06098 Zeaxanthin generic -metabolite KEGG:C06099 d-Limonene generic -metabolite KEGG:C06102 Adipate semialdehyde generic -metabolite KEGG:C06103 6-Hydroxyhexanoic acid generic -metabolite KEGG:C06104 Adipate generic -metabolite KEGG:C06105 Cyclohexane-1,2-dione generic -metabolite KEGG:C06108 Fluoroacetate generic -metabolite KEGG:C06109 Cytochrome P-450 oxidized form generic -metabolite KEGG:C06110 Cytochrome P-450 reduced form generic -metabolite KEGG:C06111 Nerolidyl diphosphate generic -metabolite KEGG:C06112 L-Glutamyl-tRNA(Gln) generic -metabolite KEGG:C06113 L-Aspartyl-tRNA(Asn) generic -metabolite KEGG:C06114 gamma-Glutamyl-beta-aminopropiononitrile generic -metabolite KEGG:C06115 L-Arabinofuranose generic -metabolite KEGG:C06118 4-(4-Deoxy-alpha-D-gluc-4-enuronosyl)-D-galacturonate generic -metabolite KEGG:C06121 3-Ketosphingosine generic -metabolite KEGG:C06123 Hexadecenal generic -metabolite KEGG:C06124 Sphingosine 1-phosphate generic -metabolite KEGG:C06125 Sulfatide generic -metabolite KEGG:C06126 Digalactosylceramide generic -metabolite KEGG:C06127 Digalactosylceramide sulfate generic -metabolite KEGG:C06128 GM4 generic -metabolite KEGG:C06129 Ceramidepentasaccharide generic -metabolite KEGG:C06130 Gal-alpha1->3(Fuc-alpha1->2)Gal-beta1->3GlcNAc-beta1->3LacCer generic -metabolite KEGG:C06131 Fuc-alpha1->2Gal-beta1->3GlcNAc-beta1->3Gal-beta1->4Glc-beta1-1'Cer generic -metabolite KEGG:C06132 Type A glycolipid generic -metabolite KEGG:C06133 GD3 generic -metabolite KEGG:C06134 GD2 generic -metabolite KEGG:C06135 GA2 generic -metabolite KEGG:C06136 GA1 generic -metabolite KEGG:C06138 GT1a generic -metabolite KEGG:C06139 GQ1 generic -metabolite KEGG:C06140 GT1b generic -metabolite KEGG:C06141 GD1b generic -metabolite KEGG:C06142 1-Butanol generic -metabolite KEGG:C06143 Poly-beta-hydroxybutyrate generic -metabolite KEGG:C06144 3-Butynoate generic -metabolite KEGG:C06145 3-Butyn-1-al generic -metabolite KEGG:C06146 3-Butyn-1-ol generic -metabolite KEGG:C06148 2,5-Diamino-6-(5'-triphosphoryl-3',4'-trihydroxy-2'-oxopentyl)-amino-4-oxopyrimidine generic -metabolite KEGG:C06149 6-(3'-Triphosphoryl-1'-methylglyceryl)-7-methyl-7,8-dihydrobiopterin generic -metabolite KEGG:C06151 1L-chiro-Inositol generic -metabolite KEGG:C06152 muco-Inositol generic -metabolite KEGG:C06153 scyllo-Inositol generic -metabolite KEGG:C06155 myo-Inositol 5-phosphate generic -metabolite KEGG:C06156 alpha-D-Glucosamine 1-phosphate generic -metabolite KEGG:C06157 [Dihydrolipoyllysine-residue succinyltransferase] S-glutaryldihydrolipoyllysine generic -metabolite KEGG:C06158 D-Fucono-1,4-lactone generic -metabolite KEGG:C06159 2-Dehydro-3-deoxy-D-fuconate generic -metabolite KEGG:C06160 (S)-Norcoclaurine generic -metabolite KEGG:C06161 (S)-Coclaurine generic -metabolite KEGG:C06162 Sanguinarine generic -metabolite KEGG:C06163 (S)-cis-N-Methylstylopine generic -metabolite KEGG:C06165 Macarpine generic -metabolite KEGG:C06167 1,2-Dehydroreticuline generic -metabolite KEGG:C06171 Codeinone generic -metabolite KEGG:C06172 Neopinone generic -metabolite KEGG:C06173 Thebaine generic -metabolite KEGG:C06174 Codeine generic -metabolite KEGG:C06175 Oripavine generic -metabolite KEGG:C06176 Senecionine generic -metabolite KEGG:C06177 Retronecine generic -metabolite KEGG:C06178 1-Methylpyrrolinium generic -metabolite KEGG:C06179 Hygrine generic -metabolite KEGG:C06180 Anabasine generic -metabolite KEGG:C06181 Piperideine generic -metabolite KEGG:C06182 Pelletierine generic -metabolite KEGG:C06183 L-(+)-Anaferine generic -metabolite KEGG:C06184 N-Methylpelletierine generic -metabolite KEGG:C06185 Slaframine generic -metabolite KEGG:C06186 Arbutin generic -metabolite KEGG:C06187 Arbutin 6-phosphate generic -metabolite KEGG:C06188 Salicin 6-phosphate generic -metabolite KEGG:C06189 Cyclic 2,3-bisphospho-D-glycerate generic -metabolite KEGG:C06192 ADP-mannose generic -metabolite KEGG:C06193 Guanosine 3'-phosphate generic -metabolite KEGG:C06194 2',3'-Cyclic GMP generic -metabolite KEGG:C06195 Imidazolone generic -metabolite KEGG:C06196 2'-Deoxyinosine 5'-phosphate generic -metabolite KEGG:C06197 P1,P3-Bis(5'-adenosyl) triphosphate generic -metabolite KEGG:C06198 P1,P4-Bis(5'-uridyl) tetraphosphate generic -metabolite KEGG:C06199 Hordenine generic -metabolite KEGG:C06201 2,4-Dihydroxyhept-2-enedioate generic -metabolite KEGG:C06202 Salicylaldehyde generic -metabolite KEGG:C06203 trans-o-Hydroxybenzylidenepyruvate generic -metabolite KEGG:C06204 2-Hydroxychromene-2-carboxylate generic -metabolite KEGG:C06205 1,2-Dihydronaphthalene-1,2-diol generic -metabolite KEGG:C06206 Benzoyl phosphate generic -metabolite KEGG:C06207 2,6-Dihydroxyphenylacetate generic -metabolite KEGG:C06210 2-Hydroxy-6-keto-2,4-heptadienoate generic -metabolite KEGG:C06212 N-Methylserotonin generic -metabolite KEGG:C06213 N-Methyltryptamine generic -metabolite KEGG:C06215 Levan generic -metabolite KEGG:C06216 Celloheptaose generic -metabolite KEGG:C06217 Cellohexaose generic -metabolite KEGG:C06218 Cellopentaose generic -metabolite KEGG:C06219 Cellotriose generic -metabolite KEGG:C06222 Sedoheptulose 1-phosphate generic -metabolite KEGG:C06224 3,4-Dihydroxystyrene generic -metabolite KEGG:C06227 Fe(III)hydroxamate generic -metabolite KEGG:C06228 Ferrichrome generic -metabolite KEGG:C06229 Fe(III)dicitrate generic -metabolite KEGG:C06230 Fe-enterobactin generic -metabolite KEGG:C06231 Ectoine generic -metabolite KEGG:C06232 Molybdate generic -metabolite KEGG:C06234 4-Methyl-L-glutamate generic -metabolite KEGG:C06238 L-Arabinose 1-phosphate generic -metabolite KEGG:C06239 alpha-L-Arabinose 1-phosphate generic -metabolite KEGG:C06240 UDP-N-acetyl-D-mannosaminouronate generic -metabolite KEGG:C06241 N-Acetylneuraminate 9-phosphate generic -metabolite KEGG:C06244 Acetamide generic -metabolite KEGG:C06246 Gla protein generic -metabolite KEGG:C06247 Gla protein precursor generic -metabolite KEGG:C06248 D-Ribose 1-diphosphate generic -metabolite KEGG:C06249 Apo-[carboxylase] generic -metabolite KEGG:C06250 Holo-[carboxylase] generic -metabolite KEGG:C06251 Lauroyl-KDO2-lipid IV(A) generic -metabolite KEGG:C06254 Lysophospholipid generic -metabolite KEGG:C06255 2-Oxopentanoic acid generic -metabolite KEGG:C06257 1-Deoxy-D-xylulose generic -metabolite KEGG:C06258 Globin generic -metabolite KEGG:C06259 Ferrocytochrome b generic -metabolite KEGG:C06260 Ferricytochrome b generic -metabolite KEGG:C06262 Phosphorus generic -metabolite KEGG:C06263 Silicon generic -metabolite KEGG:C06264 Aluminium generic -metabolite KEGG:C06265 Carbon generic -metabolite KEGG:C06266 Boron generic -metabolite KEGG:C06267 Vanadium generic -metabolite KEGG:C06268 Chromium generic -metabolite KEGG:C06269 Arsenic generic -metabolite KEGG:C06272 Gal-beta1->3GalNAc-beta1->3Gal-beta1->4Glc-beta1->1'Cer generic -metabolite KEGG:C06273 Gal-beta1->4GalNAc-beta1->3Gal-beta1->4Glc-beta1->1'Cer generic -metabolite KEGG:C06297 NeuGc-alpha2->8NeuGc2->3Gal-beta1->4Glc-beta1->1'Cer generic -metabolite KEGG:C06299 NeuAc-alpha2->8NeuAc-alpha2->8NeuAc2->3LacCer generic -metabolite KEGG:C06300 NeuGc-alpha2->8NeuGc-alpha2->8NeuGc2->3LacCer generic -metabolite KEGG:C06302 GalNAc-beta1->4(NeuGc-alpha2->8NeuGc2->3)LacCer generic -metabolite KEGG:C06304 (+)-Camphene generic -metabolite KEGG:C06305 (-)-Camphene generic -metabolite KEGG:C06306 (+)-alpha-Pinene generic -metabolite KEGG:C06307 (-)-beta-Pinene generic -metabolite KEGG:C06308 (-)-alpha-Pinene generic -metabolite KEGG:C06309 Diplopterol generic -metabolite KEGG:C06310 Diploptene generic -metabolite KEGG:C06311 Galactitol 1-phosphate generic -metabolite KEGG:C06312 L-Tagatose 6-phosphate generic -metabolite KEGG:C06313 Biopterin generic -metabolite KEGG:C06314 Lipoxin A4 generic -metabolite KEGG:C06315 Lipoxin B4 generic -metabolite KEGG:C06316 Dehydro-D-arabinono-1,4-lactone generic -metabolite KEGG:C06317 Vanillyl alcohol generic -metabolite KEGG:C06318 (3S,4R)-3,4-Dihydroxycyclohexa-1,5-diene-1,4-dicarboxylate generic -metabolite KEGG:C06319 Precorrin 6Y generic -metabolite KEGG:C06320 Precorrin 6X generic -metabolite KEGG:C06321 (1R,6S)-1,6-Dihydroxycyclohexa-2,4-diene-1-carboxylate generic -metabolite KEGG:C06322 Cyclohexa-1,5-diene-1-carbonyl-CoA generic -metabolite KEGG:C06323 Isoquinoline generic -metabolite KEGG:C06324 Isocarbostyril generic -metabolite KEGG:C06325 2-Quinolinecarboxylic acid generic -metabolite KEGG:C06326 (2S)-2-{[1-(R)-Carboxyethyl]amino}pentanoate generic -metabolite KEGG:C06327 Chelirubine generic -metabolite KEGG:C06328 6-Chlorobenzene-1,2,4-triol generic -metabolite KEGG:C06329 2-Chloromaleylacetate generic -metabolite KEGG:C06330 Quinoline-3,4-diol generic -metabolite KEGG:C06331 2-Methylquinoline-3,4-diol generic -metabolite KEGG:C06332 N-Acetylanthranilate generic -metabolite KEGG:C06333 2-Aminobenzenesulfonate generic -metabolite KEGG:C06334 Metanilic acid generic -metabolite KEGG:C06335 4-Aminobenzenesulfonate generic -metabolite KEGG:C06336 3-Sulfocatechol generic -metabolite KEGG:C06337 Terephthalate generic -metabolite KEGG:C06338 Quinolin-2-ol generic -metabolite KEGG:C06339 2,5,6-Trihydroxy-5,6-dihydroquinoline generic -metabolite KEGG:C06341 7alpha,27-Dihydroxycholesterol generic -metabolite KEGG:C06342 Quinolin-2,8-diol generic -metabolite KEGG:C06343 4-Hydroxyquinoline generic -metabolite KEGG:C06344 3-Methyl-quinolin-2,8-diol generic -metabolite KEGG:C06345 3-Methyl-quinolin-2-ol generic -metabolite KEGG:C06346 (R,S)-Norcoclaurine generic -metabolite KEGG:C06347 (R)-Norcoclaurine generic -metabolite KEGG:C06348 (R,S)-Coclaurine generic -metabolite KEGG:C06349 (R)-Coclaurine generic -metabolite KEGG:C06350 Tetrahydropapaveroline generic -metabolite KEGG:C06351 (R)-Norlaudanosoline generic -metabolite KEGG:C06352 4-O-Methyl-myo-inositol generic -metabolite KEGG:C06353 6-O-Methyl-myo-inositol generic -metabolite KEGG:C06354 Benzophenone generic -metabolite KEGG:C06355 2,3',4,6-Tetrahydroxybenzophenone generic -metabolite KEGG:C06356 2,4,6-Trihydroxybenzophenone generic -metabolite KEGG:C06357 Alkyl cinnamate generic -metabolite KEGG:C06358 Methyl cinnamate generic -metabolite KEGG:C06359 Ethyl cinnamate generic -metabolite KEGG:C06360 Propyl cinnamate generic -metabolite KEGG:C06361 Anthocyanidin-3,5-diglucoside generic -metabolite KEGG:C06362 Hydroxycinnamoyl-CoA generic -metabolite KEGG:C06363 Anthocyanidin 3-glucoside-5-hydroxycinnamoylglucoside generic -metabolite KEGG:C06364 1,2-Diacyl-3-alpha-D-glucosyl-sn-glycerol generic -metabolite KEGG:C06365 alpha-Kojibiosyldiacylglycerol generic -metabolite KEGG:C06366 sym-Homospermidine generic -metabolite KEGG:C06367 1-Carboxyvinyl carboxyphosphonate generic -metabolite KEGG:C06368 3-(Hydrohydroxyphosphoryl)pyruvate generic -metabolite KEGG:C06369 2-Deoxy-D-glucose 6-phosphate generic -metabolite KEGG:C06370 alpha-D-Glucuronoside generic -metabolite KEGG:C06371 Lacto-N-tetraose generic -metabolite KEGG:C06372 Lacto-N-biose generic -metabolite KEGG:C06374 Phthalylamide generic -metabolite KEGG:C06376 N-Acetyl-D-galactosamine 6-phosphate generic -metabolite KEGG:C06377 D-Galactosamine 6-phosphate generic -metabolite KEGG:C06378 N-Acyl-D-amino acid generic -metabolite KEGG:C06379 N-Acyl-D-glutamate generic -metabolite KEGG:C06380 N-Acyl-D-aspartate generic -metabolite KEGG:C06381 Methylenediurea generic -metabolite KEGG:C06382 N-(Carboxyaminomethyl)urea generic -metabolite KEGG:C06383 N-(Aminomethyl)urea generic -metabolite KEGG:C06384 N-(Hydroxymethyl)urea generic -metabolite KEGG:C06385 Dimethylenetriurea generic -metabolite KEGG:C06386 Trimethylenetetraurea generic -metabolite KEGG:C06387 4-Chlorobenzoyl-CoA generic -metabolite KEGG:C06388 2-Aryl-2-methylmalonate generic -metabolite KEGG:C06389 2-Arylpropionate generic -metabolite KEGG:C06390 16-alpha-Hydroxypregnenolone generic -metabolite KEGG:C06391 Algestone generic -metabolite KEGG:C06392 16,17-Didehydropregnenolone generic -metabolite KEGG:C06393 2,3-Diaminopropanoate generic -metabolite KEGG:C06394 delta-Cadinene generic -metabolite KEGG:C06395 omega-Agatoxin IVC generic -metabolite KEGG:C06396 omega-Agatoxin IVB generic -metabolite KEGG:C06397 ADP-D-glycero-beta-D-manno-heptose generic -metabolite KEGG:C06398 ADP-L-glycero-beta-D-manno-heptose generic -metabolite KEGG:C06399 Hydrogenobyrinate generic -metabolite KEGG:C06400 1-alpha-D-[(1->4)-alpha-D-Glucosyl](n-1)-alpha-D-glucopyranoside generic -metabolite KEGG:C06403 [Ribulose-1,5-bisphosphate carboxylase]-L-lysine generic -metabolite KEGG:C06404 [Ribulose-1,5-bisphosphate carboxylase]-N6,N6,N6-trimethyl-L-lysine generic -metabolite KEGG:C06406 Precorrin 3B generic -metabolite KEGG:C06407 Precorrin 4 generic -metabolite KEGG:C06408 Precorrin 8X generic -metabolite KEGG:C06409 [Methionine synthase]-cob(II)alamin generic -metabolite KEGG:C06410 [Methionine synthase]-methylcob(I)alamin generic -metabolite KEGG:C06412 Palmitoyl-protein generic -metabolite KEGG:C06413 Quinoline generic -metabolite KEGG:C06414 4-Quinolinecarboxylic acid generic -metabolite KEGG:C06415 2(1H)-Quinolinone generic -metabolite KEGG:C06416 Precorrin 5 generic -metabolite KEGG:C06417 D-Valine generic -metabolite KEGG:C06418 D-Isoleucine generic -metabolite KEGG:C06419 D-Histidine generic -metabolite KEGG:C06420 D-Tyrosine generic -metabolite KEGG:C06421 alpha-Cellobiose generic -metabolite KEGG:C06422 beta-Cellobiose generic -metabolite KEGG:C06423 Octanoic acid generic -metabolite KEGG:C06424 Tetradecanoic acid generic -metabolite KEGG:C06425 Icosanoic acid generic -metabolite KEGG:C06426 (6Z,9Z,12Z)-Octadecatrienoic acid generic -metabolite KEGG:C06427 (9Z,12Z,15Z)-Octadecatrienoic acid generic -metabolite KEGG:C06428 (5Z,8Z,11Z,14Z,17Z)-Icosapentaenoic acid generic -metabolite KEGG:C06429 (4Z,7Z,10Z,13Z,16Z,19Z)-Docosahexaenoic acid generic -metabolite KEGG:C06430 D-Galacturonolactone generic -metabolite KEGG:C06432 UDP-N-acetylmuramoyl-L-alanyl-D-glutamyl-L-lysyl-D-alanine generic -metabolite KEGG:C06433 5'-Benzoylphosphoadenosine generic -metabolite KEGG:C06435 5'-Butyrylphosphoinosine generic -metabolite KEGG:C06436 5'-Butyrylphosphouridine generic -metabolite KEGG:C06437 1,3-Diacylglycerol generic -metabolite KEGG:C06438 Prostaglandin D1 generic -metabolite KEGG:C06439 Prostaglandin E3 generic -metabolite KEGG:C06440 2-Dehydro-D-glucono-1,5-lactone generic -metabolite KEGG:C06441 L-Xylulose 1-phosphate generic -metabolite KEGG:C06442 N(gamma)-Acetyldiaminobutyrate generic -metabolite KEGG:C06443 Hydroxamate generic -metabolite KEGG:C06446 2-N,6-N-Bis(2,3-dihydroxybenzoyl)-L-lysine generic -metabolite KEGG:C06447 2-N,6-N-Bis(2,3-dihydroxybenzoyl)-L-lysine amide generic -metabolite KEGG:C06450 Myxochelin C generic -metabolite KEGG:C06451 2-Hydroxyethylphosphonate generic -metabolite KEGG:C06452 (S)-2-Hydroxypropylphosphonate generic -metabolite KEGG:C06453 Methylcobalamin generic -metabolite KEGG:C06454 Fosfomycin generic -metabolite KEGG:C06455 Hydroxymethylphosphonate generic -metabolite KEGG:C06456 Phosphonoformate generic -metabolite KEGG:C06457 Bialaphos generic -metabolite KEGG:C06459 N-Trimethyl-2-aminoethylphosphonate generic -metabolite KEGG:C06461 Hydroxyaldehyde generic -metabolite KEGG:C06462 Leukotriene F4 generic -metabolite KEGG:C06463 D-Threose generic -metabolite KEGG:C06464 D-Altrose generic -metabolite KEGG:C06465 D-Gulose generic -metabolite KEGG:C06466 D-Idose generic -metabolite KEGG:C06467 D-Talose generic -metabolite KEGG:C06468 D-Psicose generic -metabolite KEGG:C06469 Neuraminic acid generic -metabolite KEGG:C06470 Muramic acid generic -metabolite KEGG:C06471 Abequose generic -metabolite KEGG:C06472 L-Iduronic acid generic -metabolite KEGG:C06473 2-Keto-D-gluconic acid generic -metabolite KEGG:C06474 3,6-Anhydrogalactose generic -metabolite KEGG:C06475 Prostaglandin F1alpha generic -metabolite KEGG:C06476 Prostaglandin F3alpha generic -metabolite KEGG:C06477 L-Guluronic acid generic -metabolite KEGG:C06478 3,6-Anhydroglucose generic -metabolite KEGG:C06479 Ketosteroid generic -metabolite KEGG:C06481 L-Seryl-tRNA(Sec) generic -metabolite KEGG:C06482 L-Selenocysteinyl-tRNA(Sec) generic -metabolite KEGG:C06483 N-Acetyl-alpha-D-galactosaminyl-(1,3)-[alpha-L-fucosyl-(1,2)]-D-galactoside generic -metabolite KEGG:C06484 4,5-cis-Dihydroxy-1,2-dithiacyclohexane generic -metabolite KEGG:C06485 1,5-Anhydro-D-fructose generic -metabolite KEGG:C06488 XV638 generic -metabolite KEGG:C06489 Compound VII generic -metabolite KEGG:C06490 WIN VI generic -metabolite KEGG:C06491 Compound WIN VIII generic -metabolite KEGG:C06492 Compound II(R/S) generic -metabolite KEGG:C06493 WIN54954 generic -metabolite KEGG:C06494 Compound V(S) generic -metabolite KEGG:C06495 Compound III(S) generic -metabolite KEGG:C06496 Compound IV generic -metabolite KEGG:C06497 WIN I(S) generic -metabolite KEGG:C06499 WIN56291 generic -metabolite KEGG:C06500 5'-Guanylylmethylenebisphosphonate generic -metabolite KEGG:C06501 Phosphotyrosine generic -metabolite KEGG:C06502 4,6-Diamino-5-formamidopyrimidine generic -metabolite KEGG:C06503 Hydrogenobyrinate a,c diamide generic -metabolite KEGG:C06504 Cob(II)yrinate a,c diamide generic -metabolite KEGG:C06505 Cob(I)yrinate a,c diamide generic -metabolite KEGG:C06506 Adenosyl cobyrinate a,c diamide generic -metabolite KEGG:C06507 Adenosyl cobyrinate hexaamide generic -metabolite KEGG:C06508 Adenosyl cobinamide generic -metabolite KEGG:C06509 Adenosyl cobinamide phosphate generic -metabolite KEGG:C06510 Adenosine-GDP-cobinamide generic -metabolite KEGG:C06511 Guattegaumerine generic -metabolite KEGG:C06512 2'-Norberbamunine generic -metabolite KEGG:C06513 Obamegine generic -metabolite KEGG:C06514 Aromoline generic -metabolite KEGG:C06515 Magnoline generic -metabolite KEGG:C06516 (R)-Norreticuline generic -metabolite KEGG:C06517 (S)-6-O-Methylnorlaudanosoline generic -metabolite KEGG:C06518 (S)-Nororientaline generic -metabolite KEGG:C06520 (S)-Norreticuline generic -metabolite KEGG:C06521 Cuscohygrine generic -metabolite KEGG:C06522 Strychnine generic -metabolite KEGG:C06523 Coniine generic -metabolite KEGG:C06524 Nornicotine generic -metabolite KEGG:C06525 Gentianine generic -metabolite KEGG:C06526 Quinine generic -metabolite KEGG:C06527 Quinidine generic -metabolite KEGG:C06528 Cinchonine generic -metabolite KEGG:C06530 Cupreine generic -metabolite KEGG:C06531 alpha-Erythroidine generic -metabolite KEGG:C06532 beta-Erythroidine generic -metabolite KEGG:C06533 Papaverine generic -metabolite KEGG:C06534 Heroin generic -metabolite KEGG:C06535 Physostigmine generic -metabolite KEGG:C06536 Harmaline generic -metabolite KEGG:C06537 Harmalol generic -metabolite KEGG:C06538 Harmine generic -metabolite KEGG:C06539 Reserpine generic -metabolite KEGG:C06540 Rescinnamine generic -metabolite KEGG:C06541 Deserpidine generic -metabolite KEGG:C06542 Ajmaline generic -metabolite KEGG:C06543 Solanidine generic -metabolite KEGG:C06544 Veratridine generic -metabolite KEGG:C06545 Conessine generic -metabolite KEGG:C06546 Mescaline generic -metabolite KEGG:C06547 Ethylene generic -metabolite KEGG:C06548 Ethylene oxide generic -metabolite KEGG:C06550 Arsonoacetate generic -metabolite KEGG:C06551 Atrazine generic -metabolite KEGG:C06552 Hydroxyatrazine generic -metabolite KEGG:C06553 N-Isopropylammelide generic -metabolite KEGG:C06554 Cyanuric acid generic -metabolite KEGG:C06555 Biuret generic -metabolite KEGG:C06556 Deisopropylatrazine generic -metabolite KEGG:C06557 Deisopropylhydroxyatrazine generic -metabolite KEGG:C06558 N-Ethylammelide generic -metabolite KEGG:C06559 Deethylatrazine generic -metabolite KEGG:C06560 Deisopropyldeethylatrazine generic -metabolite KEGG:C06561 Naringenin chalcone generic -metabolite KEGG:C06562 (+)-Catechin generic -metabolite KEGG:C06563 Genistein generic -metabolite KEGG:C06564 Penicillin N generic -metabolite KEGG:C06565 Deacetoxycephalosporin C generic -metabolite KEGG:C06566 Cephamycin C generic -metabolite KEGG:C06567 Penicilloic acid generic -metabolite KEGG:C06568 O-Carbamoyl-deacetylcephalosporin C generic -metabolite KEGG:C06569 7a-Hydroxy-O-carbamoyl-deacetylcephalosporin C generic -metabolite KEGG:C06570 Tetracycline generic -metabolite KEGG:C06571 Chlortetracycline generic -metabolite KEGG:C06572 Nystatin generic -metabolite KEGG:C06573 Amphotericin B generic -metabolite KEGG:C06574 Ampicillin generic -metabolite KEGG:C06575 p-Cymene generic -metabolite KEGG:C06576 p-Cumic alcohol generic -metabolite KEGG:C06577 4-Isopropylbenzaldehyde generic -metabolite KEGG:C06578 p-Cumate generic -metabolite KEGG:C06579 cis-2,3-Dihydroxy-2,3-dihydro-p-cumate generic -metabolite KEGG:C06580 2,3-Dihydroxy-p-cumate generic -metabolite KEGG:C06581 2-Hydroxy-3-carboxy-6-oxo-7-methylocta-2,4-dienoate generic -metabolite KEGG:C06582 2-Hydroxy-6-oxo-7-methylocta-2,4-dienoate generic -metabolite KEGG:C06584 4-Chlorobiphenyl generic -metabolite KEGG:C06585 cis-2,3-Dihydro-2,3-dihydroxy-4'-chlorobiphenyl generic -metabolite KEGG:C06586 2,3-Dihydroxy-4'-chlorobiphenyl generic -metabolite KEGG:C06587 2-Hydroxy-6-oxo-6-(4'-chlorophenyl)-hexa-2,4-dienoate generic -metabolite KEGG:C06588 Biphenyl generic -metabolite KEGG:C06589 cis-2,3-Dihydro-2,3-dihydroxybiphenyl generic -metabolite KEGG:C06592 NDP-N-methyl-L-glucosamine generic -metabolite KEGG:C06593 epsilon-Caprolactam generic -metabolite KEGG:C06594 1,2,4-Trichlorobenzene generic -metabolite KEGG:C06596 gamma-Pentachlorocyclohexene generic -metabolite KEGG:C06597 1,3,4,6-Tetrachloro-1,4-cyclohexadiene generic -metabolite KEGG:C06598 2,4,5-Trichloro-2,5-cyclohexadiene-1-ol generic -metabolite KEGG:C06599 2,5-Dichloro-2,5-cyclohexadiene-1,4-diol generic -metabolite KEGG:C06600 2,5-Dichlorohydroquinone generic -metabolite KEGG:C06601 Chlorohydroquinone generic -metabolite KEGG:C06602 2,5-Dichlorophenol generic -metabolite KEGG:C06603 cis,cis-4-Hydroxymuconic semialdehyde generic -metabolite KEGG:C06604 Parathion generic -metabolite KEGG:C06605 Aminoparathion generic -metabolite KEGG:C06606 Paraoxon generic -metabolite KEGG:C06607 Diethylthiophosphoric acid generic -metabolite KEGG:C06608 Diethylphosphoric acid generic -metabolite KEGG:C06609 trans-1,3-Dichloropropene generic -metabolite KEGG:C06610 cis-1,3-Dichloropropene generic -metabolite KEGG:C06611 trans-3-Chloro-2-propene-1-ol generic -metabolite KEGG:C06612 cis-3-Chloro-2-propene-1-ol generic -metabolite KEGG:C06613 trans-3-Chloroallyl aldehyde generic -metabolite KEGG:C06614 trans-3-Chloroacrylic acid generic -metabolite KEGG:C06615 cis-3-Chloroacrylic acid generic -metabolite KEGG:C06616 Erythromycin C generic -metabolite KEGG:C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose generic -metabolite KEGG:C06622 dTDP-4-oxo-2,6-dideoxy-L-allose generic -metabolite KEGG:C06624 Oxytetracycline generic -metabolite KEGG:C06625 Malonamoyl-CoA generic -metabolite KEGG:C06626 4-Ketoanhydrochlortetracycline generic -metabolite KEGG:C06627 4-Keto-anhydrotetracycline generic -metabolite KEGG:C06628 4-Hydroxy-6-methylpretetramide generic -metabolite KEGG:C06629 6-Methylpretetramide generic -metabolite KEGG:C06630 3-O-alpha-Mycarosylerythronolide B generic -metabolite KEGG:C06633 Erythromycin D generic -metabolite KEGG:C06634 Erythromycin E generic -metabolite KEGG:C06635 Erythronolide B generic -metabolite KEGG:C06636 TDE generic -metabolite KEGG:C06637 1-Chloro-2,2-bis(4'-chlorophenyl)ethylene generic -metabolite KEGG:C06638 1-Chloro-2,2-bis(4'-chlorophenyl)ethane generic -metabolite KEGG:C06639 2,2-Bis(4'-chlorophenyl)ethanol generic -metabolite KEGG:C06640 Bis(4'-chlorophenyl)acetate generic -metabolite KEGG:C06641 Bis(4'-chlorophenyl)methane generic -metabolite KEGG:C06642 unsym-Bis(4'-chlorophenyl)ethylene generic -metabolite KEGG:C06643 4,4'-Dichlorobenzophenone generic -metabolite KEGG:C06644 1,1-Dichloro-2-(dihydroxy-4'-chlorophenyl)-2-(4'-chlorophenyl)ethylene generic -metabolite KEGG:C06645 6-Oxo-2-hydroxy-7-(4'-chlorophenyl)-3,8,8-trichloroocta-2E,4E,7E-trienoate generic -metabolite KEGG:C06646 2-(4'-Chlorophenyl)-3,3-dichloropropenoate generic -metabolite KEGG:C06647 4-Chloroacetophenone generic -metabolite KEGG:C06648 4-Chlorobenzaldehyde generic -metabolite KEGG:C06649 cis-2,3-Dihydrodiol 1,1,1-Trichloro-2,2-bis(4'-chlorophenyl)ethane generic -metabolite KEGG:C06650 2,3-Dihydroxy 1,1,1-Trichloro-2,2-bis(4'-chlorophenyl)ethane generic -metabolite KEGG:C06651 6-Oxo-2-hydroxy-7-(4'-chlorophenyl)-3,8,8,8-tetrachloroocta-2E,4E-dienoate generic -metabolite KEGG:C06653 Erythromycin B generic -metabolite KEGG:C06654 4-Amino-anhydrotetracycline generic -metabolite KEGG:C06655 L-N2-(2-Carboxyethyl)arginine generic -metabolite KEGG:C06656 Deoxyguanidinoproclavaminic acid generic -metabolite KEGG:C06657 Guanidinoproclavaminic acid generic -metabolite KEGG:C06658 Proclavaminic acid generic -metabolite KEGG:C06659 Dihydroclavaminic acid generic -metabolite KEGG:C06660 Clavaminic acid generic -metabolite KEGG:C06661 Clavulanate-9-aldehyde generic -metabolite KEGG:C06662 Clavulanic acid generic -metabolite KEGG:C06663 Olivanic acid generic -metabolite KEGG:C06664 Thienamycin generic -metabolite KEGG:C06665 Imipenem generic -metabolite KEGG:C06667 Clavamycin A generic -metabolite KEGG:C06668 Valclavam generic -metabolite KEGG:C06669 (5R)-Carbapen-2-em-3-carboxylate generic -metabolite KEGG:C06670 2,4-Dichlorobenzoate generic -metabolite KEGG:C06671 2,4-Dichlorobenzoyl-CoA generic -metabolite KEGG:C06672 Vanillate generic -metabolite KEGG:C06673 4-Carboxy-4'-sulfoazobenzene generic -metabolite KEGG:C06674 4-Sulfocatechol generic -metabolite KEGG:C06675 3-Sulfomuconate generic -metabolite KEGG:C06676 4-Sulfolactone generic -metabolite KEGG:C06677 Toluene-4-sulfonate generic -metabolite KEGG:C06678 4-Sulfobenzyl alcohol generic -metabolite KEGG:C06679 4-Sulfobenzaldehyde generic -metabolite KEGG:C06680 4-Hydroxyphthalate generic -metabolite KEGG:C06681 Mitomycin generic -metabolite KEGG:C06682 DL-Cycloserine generic -metabolite KEGG:C06683 Ceftriaxone generic -metabolite KEGG:C06684 Valinomycin generic -metabolite KEGG:C06685 Cycloheximide generic -metabolite KEGG:C06686 Griseofulvin generic -metabolite KEGG:C06687 Norfloxacin generic -metabolite KEGG:C06688 Rifampicin generic -metabolite KEGG:C06689 Vancomycin generic -metabolite KEGG:C06690 Candicidin D generic -metabolite KEGG:C06691 Actinorhodin generic -metabolite KEGG:C06692 Polyoxin B generic -metabolite KEGG:C06693 Monensin generic -metabolite KEGG:C06694 Fusidic acid generic -metabolite KEGG:C06695 2-Oxazolidinone generic -metabolite KEGG:C06696 Lead generic -metabolite KEGG:C06697 Arsenite generic -metabolite KEGG:C06701 Phosphonic acid generic -metabolite KEGG:C06702 Polyamine generic -metabolite KEGG:C06704 Iron chelate generic -metabolite KEGG:C06705 Capsular polysaccharide generic -metabolite KEGG:C06706 Lipo-oligosaccharide generic -metabolite KEGG:C06707 Teichoic acid generic -metabolite KEGG:C06710 Silver generic -metabolite KEGG:C06711 Fluoren-9-ol generic -metabolite KEGG:C06712 Fluoren-9-one generic -metabolite KEGG:C06714 3-Hydroxypimeloyl-CoA generic -metabolite KEGG:C06715 3-Oxopimeloyl-CoA generic -metabolite KEGG:C06717 Mycothiol generic -metabolite KEGG:C06718 S-Formylmycothiol generic -metabolite KEGG:C06719 Dihydrophloroglucinol generic -metabolite KEGG:C06720 1,6-Dihydroxy-5-methylcyclohexa-2,4-dienecarboxylate generic -metabolite KEGG:C06721 cis-1,2-Dihydroxy-1,2-dihydrodibenzothiophene generic -metabolite KEGG:C06722 1,2-Dihydroxydibenzothiophene generic -metabolite KEGG:C06723 6-Carboxyhex-2-enoyl-CoA generic -metabolite KEGG:C06725 5,6-Dihydroxy-3-methyl-2-oxo-1,2-dihydroquinoline generic -metabolite KEGG:C06726 5,6-Dihydroxy-3-methyl-2-oxo-1,2,5,6-tetrahydroquinoline generic -metabolite KEGG:C06727 cis-1,2-Dihydro-3-ethylcatechol generic -metabolite KEGG:C06728 3-Ethylcatechol generic -metabolite KEGG:C06729 cis-1,2-Dihydroxy-4-methylcyclohexa-3,5-diene-1-carboxylate generic -metabolite KEGG:C06730 4-Methylcatechol generic -metabolite KEGG:C06731 1,2-Dihydroxy-6-methylcyclohexa-3,5-dienecarboxylate generic -metabolite KEGG:C06732 alpha,beta-Didehydrotryptophan generic -metabolite KEGG:C06733 8'-apo-beta-Carotenol generic -metabolite KEGG:C06734 14'-apo-beta-Carotenal generic -metabolite KEGG:C06735 Aminoacetaldehyde generic -metabolite KEGG:C06736 (E)-11-Tetradecenoyl-CoA generic -metabolite KEGG:C06737 (Z)-11-Tetradecenoyl-CoA generic -metabolite KEGG:C06738 cis-p-Coumarate generic -metabolite KEGG:C06739 4'-O-beta-D-Glucosyl-cis-p-coumarate generic -metabolite KEGG:C06740 Glucosyl-limonin generic -metabolite KEGG:C06741 Feruloyl-polysaccharide generic -metabolite KEGG:C06742 2'-Hydroxybiphenyl-2-sulfinate generic -metabolite KEGG:C06743 Poly(ADPribose) generic -metabolite KEGG:C06744 3-Deoxyoctulosonyl-lipopolysaccharide generic -metabolite KEGG:C06746 N-(2-Phenylethyl)-acetamide generic -metabolite KEGG:C06747 Phenylmethanesulfonyl fluoride generic -metabolite KEGG:C06748 Isopropylamine generic -metabolite KEGG:C06749 6-Hydroxycyclohex-1-ene-1-carbonyl-CoA generic -metabolite KEGG:C06751 Prenyl-L-cysteine generic -metabolite KEGG:C06752 1,2-Dichloroethane generic -metabolite KEGG:C06753 2-Chloroethanol generic -metabolite KEGG:C06754 Chloroacetaldehyde generic -metabolite KEGG:C06755 Chloroacetic acid generic -metabolite KEGG:C06756 p-Xylene generic -metabolite KEGG:C06757 4-Methylbenzyl alcohol generic -metabolite KEGG:C06758 p-Tolualdehyde generic -metabolite KEGG:C06760 2-Hydroxy-5-methyl-cis,cis-muconic semialdehyde generic -metabolite KEGG:C06761 (4E)-2-Oxohexenoic acid generic -metabolite KEGG:C06762 4-Hydroxy-2-oxohexanoic acid generic -metabolite KEGG:C06763 Nojirimycin generic -metabolite KEGG:C06764 Tetranactin generic -metabolite KEGG:C06765 Flavomycin generic -metabolite KEGG:C06767 Hemine generic -metabolite KEGG:C06769 Vibriobactin generic -metabolite KEGG:C06770 Actinomycin D generic -metabolite KEGG:C06771 Triethanolamine generic -metabolite KEGG:C06772 Diethanolamine generic -metabolite KEGG:C06773 11-O-Demethylpradinone II generic -metabolite KEGG:C06774 11-O-Demethyl-7-methoxypradinone II generic -metabolite KEGG:C06775 11-O-Demethylpradinone I generic -metabolite KEGG:C06776 11-O-Demethylpradimicinone I generic -metabolite KEGG:C06777 Pradimicinone I generic -metabolite KEGG:C06778 11-O-Demethylpradimicinone II generic -metabolite KEGG:C06779 11-O-Demethyl-7-methoxypradimicinone II generic -metabolite KEGG:C06780 Pradimicinone II generic -metabolite KEGG:C06781 7-Methoxypradimicinone II generic -metabolite KEGG:C06782 7-Hydroxylpradimicin A generic -metabolite KEGG:C06783 Pradimicin B generic -metabolite KEGG:C06784 Pradimicin A generic -metabolite KEGG:C06785 Dexylosylpradimicin C generic -metabolite KEGG:C06786 Pradimicin C generic -metabolite KEGG:C06787 Dexylosylbenanomicin A generic -metabolite KEGG:C06788 Benanomicin A generic -metabolite KEGG:C06789 Tetrachloroethene generic -metabolite KEGG:C06790 Trichloroethene generic -metabolite KEGG:C06791 trans-1,2-Dichloroethene generic -metabolite KEGG:C06792 cis-1,2-Dichloroethene generic -metabolite KEGG:C06793 Vinyl chloride generic -metabolite KEGG:C06799 Granaticin generic -metabolite KEGG:C06800 Aflatoxin B1 generic -metabolite KEGG:C06801 Tetracenomycin C generic -metabolite KEGG:C06802 Acarbose generic -metabolite KEGG:C06803 Acebutolol generic -metabolite KEGG:C06804 Acetaminophen generic -metabolite KEGG:C06805 Acetazolamide generic -metabolite KEGG:C06806 Acetohexamide generic -metabolite KEGG:C06807 Acetophenazine generic -metabolite KEGG:C06808 Acetohydroxamic acid generic -metabolite KEGG:C06809 Acetylcysteine generic -metabolite KEGG:C06810 Aciclovir generic -metabolite KEGG:C06812 Lincomycin generic -metabolite KEGG:C06813 Nitrobenzene generic -metabolite KEGG:C06814 D-Xylose-5-phosphate generic -metabolite KEGG:C06817 Alprazolam generic -metabolite KEGG:C06818 Amantadine generic -metabolite KEGG:C06819 Amifostine generic -metabolite KEGG:C06820 Amikacin generic -metabolite KEGG:C06821 Amiloride generic -metabolite KEGG:C06823 Amiodarone generic -metabolite KEGG:C06824 Amitriptyline generic -metabolite KEGG:C06825 Amlodipine generic -metabolite KEGG:C06827 Amoxicillin generic -metabolite KEGG:C06830 Anisotropine methylbromide generic -metabolite KEGG:C06831 Dithranol generic -metabolite KEGG:C06832 Astemizole generic -metabolite KEGG:C06834 Atorvastatin generic -metabolite KEGG:C06835 Atovaquone generic -metabolite KEGG:C06837 Azathioprine generic -metabolite KEGG:C06838 Azithromycin generic -metabolite KEGG:C06839 Azlocillin generic -metabolite KEGG:C06840 Aztreonam generic -metabolite KEGG:C06842 Beclomethasone generic -metabolite KEGG:C06843 Benazepril generic -metabolite KEGG:C06846 Benztropine generic -metabolite KEGG:C06847 Bepridil generic -metabolite KEGG:C06848 Betamethasone generic -metabolite KEGG:C06849 Betaxolol generic -metabolite KEGG:C06850 Bethanechol generic -metabolite KEGG:C06852 Bisoprolol generic -metabolite KEGG:C06853 Bitolterol generic -metabolite KEGG:C06854 Bleomycin A2 generic -metabolite KEGG:C06855 Bretylium generic -metabolite KEGG:C06856 Bromocriptine generic -metabolite KEGG:C06857 Brompheniramine generic -metabolite KEGG:C06860 Bupropion generic -metabolite KEGG:C06861 Buspirone generic -metabolite KEGG:C06862 Busulfan generic -metabolite KEGG:C06863 Butorphanol generic -metabolite KEGG:C06865 Calcitonin generic -metabolite KEGG:C06866 Capsaicin generic -metabolite KEGG:C06867 Captopril generic -metabolite KEGG:C06868 Carbamazepine generic -metabolite KEGG:C06869 Carbenicillin generic -metabolite KEGG:C06870 Carbidopa-levodopa generic -metabolite KEGG:C06871 Carbinoxamine generic -metabolite KEGG:C06872 Carboprost generic -metabolite KEGG:C06873 Carmustine generic -metabolite KEGG:C06874 Carteolol generic -metabolite KEGG:C06875 Carvedilol generic -metabolite KEGG:C06876 Nitrosobenzene generic -metabolite KEGG:C06877 Cefaclor generic -metabolite KEGG:C06878 Cefadroxil generic -metabolite KEGG:C06879 Cefamandole generic -metabolite KEGG:C06880 Cefazolin generic -metabolite KEGG:C06881 Cefixime generic -metabolite KEGG:C06882 Cefonicid generic -metabolite KEGG:C06883 Cefoperazone generic -metabolite KEGG:C06884 Ceforanide generic -metabolite KEGG:C06885 Cefotaxime generic -metabolite KEGG:C06886 Cefotetan generic -metabolite KEGG:C06887 Cefoxitin generic -metabolite KEGG:C06888 Cefprozil generic -metabolite KEGG:C06889 Ceftazidime generic -metabolite KEGG:C06890 Ceftizoxime generic -metabolite KEGG:C06891 D-2,3-Diketo 4-deoxy-epi-inositol generic -metabolite KEGG:C06892 2-Deoxy-5-keto-D-gluconic acid generic -metabolite KEGG:C06893 2-Deoxy-5-keto-D-gluconic acid 6-phosphate generic -metabolite KEGG:C06894 Cefuroxime generic -metabolite KEGG:C06895 Cephalexin generic -metabolite KEGG:C06896 Cephapirin generic -metabolite KEGG:C06897 Cephradine generic -metabolite KEGG:C06899 Chloral hydrate generic -metabolite KEGG:C06900 Chlorambucil generic -metabolite KEGG:C06902 Chlorhexidine generic -metabolite KEGG:C06905 Chlorpheniramine generic -metabolite KEGG:C06906 Chlorpromazine generic -metabolite KEGG:C06909 Cidofovir generic -metabolite KEGG:C06910 Cisapride generic -metabolite KEGG:C06911 Cisplatin generic -metabolite KEGG:C06912 Clarithromycin generic -metabolite KEGG:C06913 Clemastine generic -metabolite KEGG:C06914 Clindamycin generic -metabolite KEGG:C06915 Clofazimine generic -metabolite KEGG:C06916 Clofibrate generic -metabolite KEGG:C06917 Clomiphene generic -metabolite KEGG:C06918 Clomipramine generic -metabolite KEGG:C06921 Clorazepate generic -metabolite KEGG:C06922 Clotrimazole generic -metabolite KEGG:C06923 Cloxacillin generic -metabolite KEGG:C06924 Clozapine generic -metabolite KEGG:C06925 Colestipol generic -metabolite KEGG:C06928 Cromolyn generic -metabolite KEGG:C06930 Cyclizine generic -metabolite KEGG:C06931 Cyclobenzaprine generic -metabolite KEGG:C06932 Cyclopentolate generic -metabolite KEGG:C06933 Cyclophosphamide generic -metabolite KEGG:C06935 Cyproheptadine generic -metabolite KEGG:C06936 Dacarbazine generic -metabolite KEGG:C06938 Danazol generic -metabolite KEGG:C06939 Dantrolene generic -metabolite KEGG:C06940 Deferoxamine generic -metabolite KEGG:C06941 Delavirdine generic -metabolite KEGG:C06943 Desipramine generic -metabolite KEGG:C06944 Desmopressin generic -metabolite KEGG:C06946 Dexchlorpheniramine generic -metabolite KEGG:C06947 Dextromethorphan generic -metabolite KEGG:C06948 Diazepam generic -metabolite KEGG:C06949 Diazoxide generic -metabolite KEGG:C06950 Dicloxacillin generic -metabolite KEGG:C06951 Dicyclomine generic -metabolite KEGG:C06952 Cimetidine generic -metabolite KEGG:C06953 Didanosine generic -metabolite KEGG:C06954 Diethylpropion generic -metabolite KEGG:C06955 Digitoxin generic -metabolite KEGG:C06956 Digoxin generic -metabolite KEGG:C06957 Dihydrotachysterol generic -metabolite KEGG:C06958 Diltiazem generic -metabolite KEGG:C06960 Diphenhydramine generic -metabolite KEGG:C06961 Diphenidol generic -metabolite KEGG:C06963 Dipivefrin generic -metabolite KEGG:C06965 Disopyramide generic -metabolite KEGG:C06967 Dobutamine generic -metabolite KEGG:C06969 Dorzolamide generic -metabolite KEGG:C06970 Doxazosin generic -metabolite KEGG:C06971 Doxepin generic -metabolite KEGG:C06972 Dronabinol generic -metabolite KEGG:C06973 Doxycycline generic -metabolite KEGG:C06975 Echothiophate generic -metabolite KEGG:C06976 Edrophonium generic -metabolite KEGG:C06977 Enalapril generic -metabolite KEGG:C06978 Encainide generic -metabolite KEGG:C06979 Enoxacin generic -metabolite KEGG:C06980 Esmolol generic -metabolite KEGG:C06981 Estazolam generic -metabolite KEGG:C06984 Ethambutol generic -metabolite KEGG:C06986 Spirodilactone generic -metabolite KEGG:C06988 beta-1,2,3,4,5,6-Hexachlorocyclohexane generic -metabolite KEGG:C06989 delta-3,4,5,6-Tetrachlorocyclohexene generic -metabolite KEGG:C06990 Chlorobenzene generic -metabolite KEGG:C06991 Etodolac generic -metabolite KEGG:C06996 Fenfluramine generic -metabolite KEGG:C06997 Fenoprofen generic -metabolite KEGG:C06999 Fexofenadine generic -metabolite KEGG:C07001 Flecainide generic -metabolite KEGG:C07002 Fluconazole generic -metabolite KEGG:C07004 Fludrocortisone generic -metabolite KEGG:C07005 Flunisolide generic -metabolite KEGG:C07006 Fluocinolone generic -metabolite KEGG:C07007 Fluocinonide generic -metabolite KEGG:C07010 Fluphenazine generic -metabolite KEGG:C07013 Flurbiprofen generic -metabolite KEGG:C07014 Fluvastatin generic -metabolite KEGG:C07016 Fosinopril generic -metabolite KEGG:C07017 Furosemide generic -metabolite KEGG:C07018 Gabapentin generic -metabolite KEGG:C07019 Ganciclovir generic -metabolite KEGG:C07020 Gemfibrozil generic -metabolite KEGG:C07022 Glyburide generic -metabolite KEGG:C07023 Granisetron generic -metabolite KEGG:C07024 3'-Keto-3'-deoxy-ATP generic -metabolite KEGG:C07025 3'-Keto-3'-deoxy-AMP generic -metabolite KEGG:C07026 3'-Amino-3'-deoxy-AMP generic -metabolite KEGG:C07027 N6,N6,O-Tridemethylpuromycin-5'-phosphate generic -metabolite KEGG:C07028 N-Acetyl-N6,N6,O-tridemethylpuromycin-5'-phosphate generic -metabolite KEGG:C07029 N-Acetyl-N6,O-didemethylpuromycin-5'-phosphate generic -metabolite KEGG:C07030 N-Acetyl-O-demethylpuromycin-5'-phosphate generic -metabolite KEGG:C07031 N-Acetyl-O-demethylpuromycin generic -metabolite KEGG:C07032 N-Acetylpuromycin generic -metabolite KEGG:C07034 Guanabenz generic -metabolite KEGG:C07035 Guanadrel generic -metabolite KEGG:C07036 Guanethidine generic -metabolite KEGG:C07037 Guanfacine generic -metabolite KEGG:C07040 Hydralazine generic -metabolite KEGG:C07041 Hydrochlorothiazide generic -metabolite KEGG:C07042 Hydromorphone generic -metabolite KEGG:C07043 Hydroxychloroquine generic -metabolite KEGG:C07044 Hydroxyurea generic -metabolite KEGG:C07045 Hydroxyzine generic -metabolite KEGG:C07047 Ifosfamide generic -metabolite KEGG:C07049 Imipramine generic -metabolite KEGG:C07051 Indinavir generic -metabolite KEGG:C07052 Ipratropium generic -metabolite KEGG:C07053 Isoetharine generic -metabolite KEGG:C07054 Isoniazid generic -metabolite KEGG:C07055 Isopropamide generic -metabolite KEGG:C07056 Isoproterenol generic -metabolite KEGG:C07058 13-cis-Retinoic acid generic -metabolite KEGG:C07062 Ketorolac generic -metabolite KEGG:C07063 Labetalol generic -metabolite KEGG:C07064 Lactulose generic -metabolite KEGG:C07065 Lamivudine generic -metabolite KEGG:C07069 Levallorphan generic -metabolite KEGG:C07070 Levamisole generic -metabolite KEGG:C07072 Losartan generic -metabolite KEGG:C07073 Lidocaine generic -metabolite KEGG:C07074 Lovastatin generic -metabolite KEGG:C07075 Lindane generic -metabolite KEGG:C07078 Lomefloxacin generic -metabolite KEGG:C07079 Lomustine generic -metabolite KEGG:C07080 Loperamide generic -metabolite KEGG:C07083 Styrene generic -metabolite KEGG:C07084 Styrene-cis-2,3-dihydrodiol generic -metabolite KEGG:C07085 3-Vinylcatechol generic -metabolite KEGG:C07086 Phenylacetic acid generic -metabolite KEGG:C07087 2-Hydroxy-6-oxoocta-2,4,7-trienoate generic -metabolite KEGG:C07088 4-Chlorophenoxyacetate generic -metabolite KEGG:C07089 5-Chloro-2-hydroxymuconic semialdehyde generic -metabolite KEGG:C07090 Protoanemonin generic -metabolite KEGG:C07091 cis-Acetylacrylate generic -metabolite KEGG:C07092 1,4-Dichlorobenzene generic -metabolite KEGG:C07093 3,6-Dichloro-cis-1,2-dihydroxycyclohexa-3,5-diene generic -metabolite KEGG:C07094 3,6-Dichlorocatechol generic -metabolite KEGG:C07095 2,5-Dichloro-cis,cis-muconate generic -metabolite KEGG:C07096 2,6-Dichlorophenol generic -metabolite KEGG:C07097 2,6-Dichlorohydroquinone generic -metabolite KEGG:C07098 2,4,6-Trichlorophenol generic -metabolite KEGG:C07099 2,3,6-Trichlorohydroquinone generic -metabolite KEGG:C07100 2,4,5-Trichlorophenoxyacetic acid generic -metabolite KEGG:C07101 2,4,5-Trichlorophenol generic -metabolite KEGG:C07102 5-Chloro-1,2,4-trihydroxybenzene generic -metabolite KEGG:C07103 2-Hydroxy-1,4-benzoquinone generic -metabolite KEGG:C07104 Loxapine generic -metabolite KEGG:C07105 Lys-vasopressin generic -metabolite KEGG:C07106 Mafenide generic -metabolite KEGG:C07107 Maprotiline generic -metabolite KEGG:C07108 Tamoxifen generic -metabolite KEGG:C07111 Ethylbenzene generic -metabolite KEGG:C07112 1-Phenylethanol generic -metabolite KEGG:C07113 Acetophenone generic -metabolite KEGG:C07114 3-Oxo-3-phenylpropanoate generic -metabolite KEGG:C07115 Nitrogen mustard generic -metabolite KEGG:C07116 Meclizine generic -metabolite KEGG:C07117 Meclofenamate generic -metabolite KEGG:C07118 Benzoylacetyl-CoA generic -metabolite KEGG:C07119 Medroxyprogesterone generic -metabolite KEGG:C07120 Megestrol generic -metabolite KEGG:C07122 Melphalan generic -metabolite KEGG:C07123 2-Hydroxy-6-oxo-octa-2,4-dienoate generic -metabolite KEGG:C07124 Tamsulosin generic -metabolite KEGG:C07125 Temazepam generic -metabolite KEGG:C07126 Menadiol generic -metabolite KEGG:C07127 Terazosin generic -metabolite KEGG:C07128 Meperidine generic -metabolite KEGG:C07129 Terbutaline generic -metabolite KEGG:C07130 Theophylline generic -metabolite KEGG:C07131 Thiabendazole generic -metabolite KEGG:C07132 Thiethylperazine generic -metabolite KEGG:C07138 5-Aminosalicylate generic -metabolite KEGG:C07139 Ticarcillin generic -metabolite KEGG:C07140 Ticlopidine generic -metabolite KEGG:C07141 Timolol generic -metabolite KEGG:C07142 Tocainide generic -metabolite KEGG:C07143 Mesoridazine generic -metabolite KEGG:C07144 Metaproterenol generic -metabolite KEGG:C07146 Metaraminol generic -metabolite KEGG:C07147 Tolazoline generic -metabolite KEGG:C07148 Tolbutamide generic -metabolite KEGG:C07149 Tolmetin generic -metabolite KEGG:C07151 Metformin generic -metabolite KEGG:C07153 Tramadol generic -metabolite KEGG:C07155 Tranylcypromine generic -metabolite KEGG:C07156 Trazodone generic -metabolite KEGG:C07159 2-Oxo-Delta3-4,5,5-trimethylcyclopentenylacetate generic -metabolite KEGG:C07160 [(1R)-2,2,3-Trimethyl-5-oxocyclopent-3-enyl]acetyl-CoA generic -metabolite KEGG:C07163 Methadone generic -metabolite KEGG:C07164 Methamphetamine generic -metabolite KEGG:C07165 Triclofos generic -metabolite KEGG:C07166 Trientine generic -metabolite KEGG:C07168 Trifluoperazine generic -metabolite KEGG:C07171 Trihexyphenidyl generic -metabolite KEGG:C07172 Trimeprazine generic -metabolite KEGG:C07174 Trimethaphan generic -metabolite KEGG:C07175 Methdilazine generic -metabolite KEGG:C07177 Methicillin generic -metabolite KEGG:C07178 Trimethobenzamide generic -metabolite KEGG:C07180 Tripelennamine generic -metabolite KEGG:C07182 Tromethamine generic -metabolite KEGG:C07184 Valacyclovir generic -metabolite KEGG:C07185 Valproic acid generic -metabolite KEGG:C07187 Venlafaxine generic -metabolite KEGG:C07188 Verapamil generic -metabolite KEGG:C07189 2-Hydroxyacetophenone generic -metabolite KEGG:C07190 Thiamazole generic -metabolite KEGG:C07192 Methotrimeprazine generic -metabolite KEGG:C07194 Methyldopa anhydrous generic -metabolite KEGG:C07195 Vidarabine generic -metabolite KEGG:C07196 Methylphenidate generic -metabolite KEGG:C07198 Methyltestosterone generic -metabolite KEGG:C07199 Methysergide generic -metabolite KEGG:C07201 Vinblastine generic -metabolite KEGG:C07202 Metoprolol generic -metabolite KEGG:C07203 Metronidazole generic -metabolite KEGG:C07204 Vincristine generic -metabolite KEGG:C07205 Metyrapone generic -metabolite KEGG:C07206 Zafirlukast generic -metabolite KEGG:C07207 Zalcitabine generic -metabolite KEGG:C07208 m-Xylene generic -metabolite KEGG:C07209 3-Methylbenzaldehyde generic -metabolite KEGG:C07210 Zidovudine generic -metabolite KEGG:C07211 m-Methylbenzoate generic -metabolite KEGG:C07212 o-Xylene generic -metabolite KEGG:C07213 2-Methylbenzyl alcohol generic -metabolite KEGG:C07214 2-Methylbenzaldehyde generic -metabolite KEGG:C07215 o-Toluate generic -metabolite KEGG:C07216 3-Methylbenzyl alcohol generic -metabolite KEGG:C07218 Zolmitriptan generic -metabolite KEGG:C07219 Zolpidem generic -metabolite KEGG:C07220 Mexiletine generic -metabolite KEGG:C07221 Mezlin generic -metabolite KEGG:C07222 Mibefradil generic -metabolite KEGG:C07224 Milrinone generic -metabolite KEGG:C07225 Minocycline generic -metabolite KEGG:C07228 Raloxifene generic -metabolite KEGG:C07230 Molindone generic -metabolite KEGG:C07231 Moxalactam generic -metabolite KEGG:C07235 Rifabutin generic -metabolite KEGG:C07236 Rimantadine generic -metabolite KEGG:C07239 Ritodrine generic -metabolite KEGG:C07240 Ritonavir generic -metabolite KEGG:C07241 Salmeterol generic -metabolite KEGG:C07245 Selegiline generic -metabolite KEGG:C07246 Sertraline generic -metabolite KEGG:C07247 Sibutramine generic -metabolite KEGG:C07250 Nafcillin generic -metabolite KEGG:C07251 Nalbuphine generic -metabolite KEGG:C07252 Naloxone generic -metabolite KEGG:C07253 Naltrexone generic -metabolite KEGG:C07254 Nandrolone generic -metabolite KEGG:C07255 Nedocromil generic -metabolite KEGG:C07256 Nefazodone generic -metabolite KEGG:C07257 Nelfinavir generic -metabolite KEGG:C07258 Neostigmine generic -metabolite KEGG:C07259 Sildenafil generic -metabolite KEGG:C07261 Octamethyltrisiloxane generic -metabolite KEGG:C07263 Nevirapine generic -metabolite KEGG:C07264 Nicardipine generic -metabolite KEGG:C07266 Nifedipine generic -metabolite KEGG:C07267 Nimodipine generic -metabolite KEGG:C07268 Nitrofurantoin generic -metabolite KEGG:C07269 Nitroprusside generic -metabolite KEGG:C07270 Nizatidine generic -metabolite KEGG:C07271 Limonene-1,2-epoxide generic -metabolite KEGG:C07272 Maleimide generic -metabolite KEGG:C07273 Succinimide generic -metabolite KEGG:C07274 Nortriptyline generic -metabolite KEGG:C07275 Glutarimide generic -metabolite KEGG:C07276 Limonene-1,2-diol generic -metabolite KEGG:C07277 dTDP-D-fucose generic -metabolite KEGG:C07278 beta-D-Galactosyl-(1->3)-N-acetyl-D-galactosamine generic -metabolite KEGG:C07279 2-Aminoethylarsonate generic -metabolite KEGG:C07280 Rhodanine generic -metabolite KEGG:C07281 [eIF5A-precursor]-lysine generic -metabolite KEGG:C07282 [eIF5A-precursor]-deoxyhypusine generic -metabolite KEGG:C07283 (1->3)-beta-D-Galactopyranans generic -metabolite KEGG:C07285 Arabino-galactose generic -metabolite KEGG:C07287 Sulcatone generic -metabolite KEGG:C07288 Sulcatol generic -metabolite KEGG:C07289 Crepenynate generic -metabolite KEGG:C07290 7-O-Methylluteone generic -metabolite KEGG:C07291 Dihydrofurano derivative generic -metabolite KEGG:C07292 Glutaredoxin generic -metabolite KEGG:C07293 Glutaredoxin disulfide generic -metabolite KEGG:C07294 Methylarsonate generic -metabolite KEGG:C07295 Methanearsonous acid generic -metabolite KEGG:C07296 4,8,12-Trimethyltridecanoyl-CoA generic -metabolite KEGG:C07297 3-Oxopristanoyl-CoA generic -metabolite KEGG:C07299 Cutin generic -metabolite KEGG:C07300 Cutin monomer generic -metabolite KEGG:C07301 (R)-Mandelamide generic -metabolite KEGG:C07302 3-Hydroxy-3-(3-hydroxy-4-methoxyphenyl)propionyl-CoA generic -metabolite KEGG:C07303 4-Hydroxy-3-methoxyphenyl-beta-hydroxypropanoyl-CoA generic -metabolite KEGG:C07304 Deacetylisoipecoside generic -metabolite KEGG:C07305 Products of ATP breakdown generic -metabolite KEGG:C07306 Octreotide generic -metabolite KEGG:C07307 Deacetylipecoside generic -metabolite KEGG:C07308 Cacodylate generic -metabolite KEGG:C07309 Sotalol generic -metabolite KEGG:C07310 Spironolactone generic -metabolite KEGG:C07311 Stanozolol generic -metabolite KEGG:C07312 Stavudine generic -metabolite KEGG:C07313 Streptozocin generic -metabolite KEGG:C07314 Sucralfate generic -metabolite KEGG:C07315 Sulfamethoxazole generic -metabolite KEGG:C07316 Sulfasalazine generic -metabolite KEGG:C07317 Sulfinpyrazone generic -metabolite KEGG:C07318 Sulfisoxazole generic -metabolite KEGG:C07319 Sumatriptan generic -metabolite KEGG:C07320 Suprofen generic -metabolite KEGG:C07321 Ofloxacin generic -metabolite KEGG:C07322 Olanzapine generic -metabolite KEGG:C07323 Olsalazine generic -metabolite KEGG:C07324 Omeprazole generic -metabolite KEGG:C07325 Ondansetron generic -metabolite KEGG:C07326 1,5-Anhydro-D-glucitol generic -metabolite KEGG:C07327 3-Pyridinaldehyde generic -metabolite KEGG:C07328 3-Methylbutanol generic -metabolite KEGG:C07329 3-Methylbutanal generic -metabolite KEGG:C07330 3-Methyl-2-butenal generic -metabolite KEGG:C07331 Carbonyl sulfide generic -metabolite KEGG:C07332 Dibenzylsuccinate generic -metabolite KEGG:C07334 Oxacillin generic -metabolite KEGG:C07335 2-Amino-3-oxo-4-phosphonooxybutyrate generic -metabolite KEGG:C07336 Quazepam generic -metabolite KEGG:C07338 (9Z,12Z)-(11S)-11-Hydroperoxyoctadeca-9,12-dienoic acid generic -metabolite KEGG:C07339 Quinacrine generic -metabolite KEGG:C07340 Quinapril hydrochloride generic -metabolite KEGG:C07341 Oxamniquine generic -metabolite KEGG:C07342 Quinethazone generic -metabolite KEGG:C07343 2-Hydroxyphytanoyl-CoA generic -metabolite KEGG:C07344 3-Hydroxyquinine generic -metabolite KEGG:C07345 Betaine aldehyde hydrate generic -metabolite KEGG:C07346 Oxandrolone generic -metabolite KEGG:C07347 Thiophene-2-carbonyl-CoA generic -metabolite KEGG:C07348 5-Hydroxythiophene-2-carbonyl-CoA generic -metabolite KEGG:C07349 3'-Demethylstaurosporine generic -metabolite KEGG:C07350 Phlorisovalerophenone generic -metabolite KEGG:C07351 Phlorisobutyrophenone generic -metabolite KEGG:C07354 (7S,8S)-DiHODE generic -metabolite KEGG:C07355 (9Z)-(7S,8S)-Dihydroxyoctadecenoic acid generic -metabolite KEGG:C07356 Oxaprozin generic -metabolite KEGG:C07357 (9Z,12Z,15Z)-(7S,8S)-Dihydroxyoctadeca-9,12,15-trienoic acid generic -metabolite KEGG:C07359 Oxazepam generic -metabolite KEGG:C07360 Oxybutynin generic -metabolite KEGG:C07361 Piperacillin sodium generic -metabolite KEGG:C07362 Pipobroman generic -metabolite KEGG:C07363 Oxymetazoline generic -metabolite KEGG:C07366 Prazepam generic -metabolite KEGG:C07367 Praziquantel generic -metabolite KEGG:C07368 Prazosin generic -metabolite KEGG:C07369 Prednisolone generic -metabolite KEGG:C07370 Prednisone generic -metabolite KEGG:C07371 Primidone generic -metabolite KEGG:C07372 Probenecid generic -metabolite KEGG:C07373 Probucol generic -metabolite KEGG:C07375 Procaine generic -metabolite KEGG:C07376 Procarbazine hydrochloride generic -metabolite KEGG:C07378 Procyclidine generic -metabolite KEGG:C07379 Promazine generic -metabolite KEGG:C07381 Propafenone generic -metabolite KEGG:C07383 Proparacaine generic -metabolite KEGG:C07384 Propiomazine hydrochloride generic -metabolite KEGG:C07389 Pyrantel pamoate generic -metabolite KEGG:C07391 Pyrimethamine generic -metabolite KEGG:C07393 Oxymetholone generic -metabolite KEGG:C07394 Paclitaxel generic -metabolite KEGG:C07395 Pamidronate generic -metabolite KEGG:C07397 Quetiapine generic -metabolite KEGG:C07398 Quinapril generic -metabolite KEGG:C07400 Pralidoxime generic -metabolite KEGG:C07401 Procainamide generic -metabolite KEGG:C07402 Procarbazine generic -metabolite KEGG:C07403 Prochlorperazine generic -metabolite KEGG:C07404 Promethazine generic -metabolite KEGG:C07405 Propiomazine generic -metabolite KEGG:C07406 Propoxyphene generic -metabolite KEGG:C07407 Propranolol generic -metabolite KEGG:C07408 Protriptyline generic -metabolite KEGG:C07409 Pyrantel generic -metabolite KEGG:C07410 Pyridostigmine generic -metabolite KEGG:C07411 Paramethadione generic -metabolite KEGG:C07412 Pyrvinium generic -metabolite KEGG:C07413 Paramethasone generic -metabolite KEGG:C07414 Pargyline generic -metabolite KEGG:C07415 Paroxetine generic -metabolite KEGG:C07416 Penbutolol generic -metabolite KEGG:C07417 Penciclovir generic -metabolite KEGG:C07418 Penicillamine generic -metabolite KEGG:C07420 Pentamidine generic -metabolite KEGG:C07421 Pentazocine generic -metabolite KEGG:C07422 Pentobarbital generic -metabolite KEGG:C07423 Pentobarbital sodium generic -metabolite KEGG:C07424 Pentoxifylline generic -metabolite KEGG:C07425 Pergolide generic -metabolite KEGG:C07427 Perphenazine generic -metabolite KEGG:C07428 Phenacemide generic -metabolite KEGG:C07429 Phenazopyridine generic -metabolite KEGG:C07430 Phenelzine generic -metabolite KEGG:C07431 Phenelzine sulfate generic -metabolite KEGG:C07432 Phenmetrazine generic -metabolite KEGG:C07434 Phenobarbital generic -metabolite KEGG:C07435 Phenoxybenzamine generic -metabolite KEGG:C07436 Phenoxybenzamine hydrochloride generic -metabolite KEGG:C07437 Phensuximide generic -metabolite KEGG:C07438 Phentermine generic -metabolite KEGG:C07440 Phenylbutazone generic -metabolite KEGG:C07441 Phenylephrine generic -metabolite KEGG:C07443 Phenytoin generic -metabolite KEGG:C07445 Pindolol generic -metabolite KEGG:C07446 Isonicotinic acid generic -metabolite KEGG:C07447 Acetylhydrazine generic -metabolite KEGG:C07448 Burimamide generic -metabolite KEGG:C07449 Metiamide generic -metabolite KEGG:C07450 Dexmedetomidine generic -metabolite KEGG:C07451 Moxonidine generic -metabolite KEGG:C07452 Tizanidine generic -metabolite KEGG:C07453 Epinine generic -metabolite KEGG:C07454 N-Guanylhistamine generic -metabolite KEGG:C07455 Nitroglycerin generic -metabolite KEGG:C07456 Isosorbide dinitrate generic -metabolite KEGG:C07457 Amyl nitrite generic -metabolite KEGG:C07458 Sulfanilamide generic -metabolite KEGG:C07459 Dichlorphenamide generic -metabolite KEGG:C07460 Chloraminophenamide generic -metabolite KEGG:C07461 Chlorothiazide generic -metabolite KEGG:C07463 Terfenadine generic -metabolite KEGG:C07464 Ketanserin generic -metabolite KEGG:C07465 Remikiren generic -metabolite KEGG:C07466 Enalkiren generic -metabolite KEGG:C07467 Eprosartan generic -metabolite KEGG:C07468 Candesartan generic -metabolite KEGG:C07469 Irbesartan generic -metabolite KEGG:C07471 Methacholine generic -metabolite KEGG:C07473 Muscarine generic -metabolite KEGG:C07474 Pilocarpine generic -metabolite KEGG:C07475 Lobeline generic -metabolite KEGG:C07478 2-Hydroxy-5-methyl-cis,cis-muconate generic -metabolite KEGG:C07479 2-Oxo-5-methyl-cis-muconate generic -metabolite KEGG:C07480 Theobromine generic -metabolite KEGG:C07481 Caffeine generic -metabolite KEGG:C07482 Montelukast generic -metabolite KEGG:C07484 Zaleplon generic -metabolite KEGG:C07485 Oxotremorine generic -metabolite KEGG:C07486 Nordazepam generic -metabolite KEGG:C07487 Nitrazepam generic -metabolite KEGG:C07488 DMPP generic -metabolite KEGG:C07489 Glutethimide generic -metabolite KEGG:C07490 Trichloroethanol generic -metabolite KEGG:C07491 Carbaryl generic -metabolite KEGG:C07492 Oxcarbazepine generic -metabolite KEGG:C07493 10-Hydroxycarbazepine generic -metabolite KEGG:C07494 Soman generic -metabolite KEGG:C07495 Dihydroxycarbazepine generic -metabolite KEGG:C07496 Carbamazepine-10,11-epoxide generic -metabolite KEGG:C07497 Malathion generic -metabolite KEGG:C07498 Malaoxon generic -metabolite KEGG:C07499 Phenylethylmalonamide generic -metabolite KEGG:C07500 Vigabatrin generic -metabolite KEGG:C07501 Felbamate generic -metabolite KEGG:C07502 Topiramate generic -metabolite KEGG:C07503 Tiagabine generic -metabolite KEGG:C07504 Zonisamide generic -metabolite KEGG:C07505 Ethosuximide generic -metabolite KEGG:C07506 Propantheline generic -metabolite KEGG:C07508 Pirenzepine generic -metabolite KEGG:C07509 Diacetylmonoxime generic -metabolite KEGG:C07510 Hexamethonium generic -metabolite KEGG:C07511 Mecamylamine generic -metabolite KEGG:C07512 Tetraethylammonium generic -metabolite KEGG:C07513 Methoxamine generic -metabolite KEGG:C07514 Amphetamine generic -metabolite KEGG:C07515 Halothane generic -metabolite KEGG:C07516 Enflurane generic -metabolite KEGG:C07517 Methoxyflurane generic -metabolite KEGG:C07518 Isoflurane generic -metabolite KEGG:C07519 Desflurane generic -metabolite KEGG:C07520 Sevoflurane generic -metabolite KEGG:C07521 Thiopental generic -metabolite KEGG:C07522 Etomidate generic -metabolite KEGG:C07523 Propofol generic -metabolite KEGG:C07524 Midazolam generic -metabolite KEGG:C07525 Ketamine generic -metabolite KEGG:C07526 Tetracaine generic -metabolite KEGG:C07527 Benzocaine generic -metabolite KEGG:C07528 Mepivacaine generic -metabolite KEGG:C07529 Bupivacaine generic -metabolite KEGG:C07530 Etidocaine generic -metabolite KEGG:C07531 Prilocaine generic -metabolite KEGG:C07532 Ropivacaine generic -metabolite KEGG:C07533 Prenalterol generic -metabolite KEGG:C07534 Ethynyl estradiol generic -metabolite KEGG:C07535 Benzo[a]pyrene generic -metabolite KEGG:C07536 Amobarbital generic -metabolite KEGG:C07537 Ethylmorphine generic -metabolite KEGG:C07538 Benzphetamine generic -metabolite KEGG:C07539 Aminopyrine generic -metabolite KEGG:C07540 6-Methylergoline generic -metabolite KEGG:C07541 Lysergic acid generic -metabolite KEGG:C07542 Lysergic acid diethylamide generic -metabolite KEGG:C07543 Ergonovine generic -metabolite KEGG:C07544 Ergotamine generic -metabolite KEGG:C07545 alpha-Ergocryptine generic -metabolite KEGG:C07546 Succinylcholine generic -metabolite KEGG:C07547 Tubocurarine generic -metabolite KEGG:C07548 Atracurium generic -metabolite KEGG:C07549 Doxacurium generic -metabolite KEGG:C07550 Mivacurium generic -metabolite KEGG:C07551 Pancuronium generic -metabolite KEGG:C07552 Aldrin generic -metabolite KEGG:C07553 Vecuronium generic -metabolite KEGG:C07554 Pipecuronium generic -metabolite KEGG:C07555 4-Nitroanisole generic -metabolite KEGG:C07556 Rocuronium generic -metabolite KEGG:C07557 2,3,7,8-Tetrachlorodibenzodioxin generic -metabolite KEGG:C07558 Methitural generic -metabolite KEGG:C07559 Chlorphentermine generic -metabolite KEGG:C07560 Methaqualone generic -metabolite KEGG:C07561 Carbon tetrachloride generic -metabolite KEGG:C07564 Ropinirole generic -metabolite KEGG:C07565 Acetanilide generic -metabolite KEGG:C07566 Pimozide generic -metabolite KEGG:C07567 Sertindole generic -metabolite KEGG:C07568 Ziprasidone generic -metabolite KEGG:C07569 Propylthiouracil generic -metabolite KEGG:C07570 Mirtazapine generic -metabolite KEGG:C07571 Fluvoxamine generic -metabolite KEGG:C07572 Citalopram generic -metabolite KEGG:C07573 Prontosil generic -metabolite KEGG:C07574 Tartrazine generic -metabolite KEGG:C07575 Phencyclidine generic -metabolite KEGG:C07576 Psilocybin generic -metabolite KEGG:C07577 3,4-Methylenedioxymethamphetamine generic -metabolite KEGG:C07578 Cannabidiol generic -metabolite KEGG:C07580 Cannabinol generic -metabolite KEGG:C07581 Pteridine generic -metabolite KEGG:C07582 Pteroic acid generic -metabolite KEGG:C07584 Phenindione generic -metabolite KEGG:C07585 N-Acetylisoniazid generic -metabolite KEGG:C07586 Fenofibrate generic -metabolite KEGG:C07587 Sodium salicylate generic -metabolite KEGG:C07588 Salicyluric acid generic -metabolite KEGG:C07589 Celecoxib generic -metabolite KEGG:C07590 Rofecoxib generic -metabolite KEGG:C07591 Phenacetin generic -metabolite KEGG:C07592 Colchicine generic -metabolite KEGG:C07593 Rotenone generic -metabolite KEGG:C07594 Pyrethrin I generic -metabolite KEGG:C07596 HLo7 generic -metabolite KEGG:C07597 Ferroxamine generic -metabolite KEGG:C07598 Succimer generic -metabolite KEGG:C07599 Alloxanthine generic -metabolite KEGG:C07600 Allicin generic -metabolite KEGG:C07601 Ginkgolide A generic -metabolite KEGG:C07602 Ginkgolide B generic -metabolite KEGG:C07603 Ginkgolide C generic -metabolite KEGG:C07604 Ginkgolide J generic -metabolite KEGG:C07605 Bilobalide generic -metabolite KEGG:C07606 Hypericin generic -metabolite KEGG:C07607 Gonadotropin-releasing hormone I generic -metabolite KEGG:C07608 Hyperforin generic -metabolite KEGG:C07609 Parthenolide generic -metabolite KEGG:C07610 Silymarin generic -metabolite KEGG:C07612 Leuprolide generic -metabolite KEGG:C07613 Nafarelin generic -metabolite KEGG:C07615 Carbimazole generic -metabolite KEGG:C07616 Amphenone B generic -metabolite KEGG:C07617 Aminoglutethimide generic -metabolite KEGG:C07618 Mestranol generic -metabolite KEGG:C07619 Quinestrol generic -metabolite KEGG:C07620 Diethylstilbestrol generic -metabolite KEGG:C07621 Methallenestril generic -metabolite KEGG:C07622 Voriconazole generic -metabolite KEGG:C07624 Abacavir generic -metabolite KEGG:C07625 Chloroquine generic -metabolite KEGG:C07626 Amodiaquine generic -metabolite KEGG:C07627 Primaquine generic -metabolite KEGG:C07628 Dimethisterone generic -metabolite KEGG:C07629 Desogestrel generic -metabolite KEGG:C07630 Sulfadoxine generic -metabolite KEGG:C07631 Proguanil generic -metabolite KEGG:C07632 Androstanediol generic -metabolite KEGG:C07633 Mefloquine generic -metabolite KEGG:C07634 Halofantrine generic -metabolite KEGG:C07635 Epiandrosterone generic -metabolite KEGG:C07636 Iodoquinol generic -metabolite KEGG:C07637 Diloxanide furoate generic -metabolite KEGG:C07638 Sodium stibogluconate generic -metabolite KEGG:C07639 3,3',5'-Triiodo-L-thyronine generic -metabolite KEGG:C07640 Semustine generic -metabolite KEGG:C07641 Thiotepa generic -metabolite KEGG:C07642 Triethylenemelamine generic -metabolite KEGG:C07643 4-Hydroxycyclophosphamide generic -metabolite KEGG:C07644 4-Ketocyclophosphamide generic -metabolite KEGG:C07645 Aldophosphamide generic -metabolite KEGG:C07646 Carboxyphosphamide generic -metabolite KEGG:C07647 Phosphoramide mustard generic -metabolite KEGG:C07648 Thioguanine generic -metabolite KEGG:C07649 5-FU generic -metabolite KEGG:C07650 Gemcitabine generic -metabolite KEGG:C07651 WR 1065 generic -metabolite KEGG:C07652 Mifepristone generic -metabolite KEGG:C07653 Flutamide generic -metabolite KEGG:C07654 Methacycline generic -metabolite KEGG:C07655 Streptobiosamine generic -metabolite KEGG:C07656 Gentamicin C1 generic -metabolite KEGG:C07657 Netilmicin generic -metabolite KEGG:C07658 Sulfadiazine generic -metabolite KEGG:C07659 Sulfathalidine generic -metabolite KEGG:C07660 Levofloxacin generic -metabolite KEGG:C07661 Gatifloxacin generic -metabolite KEGG:C07662 Sparfloxacin generic -metabolite KEGG:C07663 Moxifloxacin generic -metabolite KEGG:C07664 Trovafloxacin generic -metabolite KEGG:C07665 Ethionamide generic -metabolite KEGG:C07666 Dapsone generic -metabolite KEGG:C07667 Gossypol generic -metabolite KEGG:C07668 Apraclonidine generic -metabolite KEGG:C07669 Glimepiride generic -metabolite KEGG:C07670 Repaglinide generic -metabolite KEGG:C07671 Histrelin generic -metabolite KEGG:C07672 Biguanide generic -metabolite KEGG:C07673 Phenformin generic -metabolite KEGG:C07674 Buformin generic -metabolite KEGG:C07675 Pioglitazone generic -metabolite KEGG:C07677 Acebutolol hydrochloride generic -metabolite KEGG:C07693 Fenoldopam generic -metabolite KEGG:C07695 Sodium nitroprusside dihydrate generic -metabolite KEGG:C07699 Nisoldipine generic -metabolite KEGG:C07701 Benazepril hydrochloride generic -metabolite KEGG:C07704 Moexipril generic -metabolite KEGG:C07706 Perindopril generic -metabolite KEGG:C07707 Perindopril erbumine generic -metabolite KEGG:C07708 Miglitol generic -metabolite KEGG:C07709 Candesartan cilexetil generic -metabolite KEGG:C07710 Telmisartan generic -metabolite KEGG:C07711 Previtamin D(3) generic -metabolite KEGG:C07712 Secalciferol generic -metabolite KEGG:C07713 Nitrendipine generic -metabolite KEGG:C07714 Isosorbide mononitrate generic -metabolite KEGG:C07715 Fluorene generic -metabolite KEGG:C07717 3,4-Dihydroxyfluorene generic -metabolite KEGG:C07718 2-Hydroxy-4-(1-oxo-1,3-dihydro-2H-inden-2-ylidene)-but-2-enoic acid generic -metabolite KEGG:C07719 2-Formyl-1-indanone generic -metabolite KEGG:C07720 3-Hydroxy-1-indanone generic -metabolite KEGG:C07721 (+)-(3S,4R)-cis-3,4-Dihydroxy-3,4-dihydrofluorene generic -metabolite KEGG:C07722 3,4-Dihydroxy-3,4-dihydro-9-fluorenone generic -metabolite KEGG:C07723 4-Hydroxy-9-fluorenone generic -metabolite KEGG:C07724 1,2-Dihydroxyfluorene generic -metabolite KEGG:C07725 2-Hydroxy-4-(2-oxo-1,3-dihydro-2H-inden-1-ylidene)but-2-enoic acid generic -metabolite KEGG:C07726 1-Formyl-2-indanone generic -metabolite KEGG:C07727 2-Indanone generic -metabolite KEGG:C07728 3-Isochromanone generic -metabolite KEGG:C07729 Dibenzofuran generic -metabolite KEGG:C07731 2-Hydroxy-6-oxo-6-(2-hydroxyphenyl)-hexa-2,4-dienoate generic -metabolite KEGG:C07732 Dibenzo-p-dioxin generic -metabolite KEGG:C07733 2,2',3-Trihydroxydiphenylether generic -metabolite KEGG:C07734 2-Hydroxy-6-oxo-6-(2-hydroxyphenoxy)-hexa-2,4-dienoate generic -metabolite KEGG:C07736 Etidronic acid generic -metabolite KEGG:C07740 Disopyramide phosphate generic -metabolite KEGG:C07743 Moricizine generic -metabolite KEGG:C07750 Tolterodine generic -metabolite KEGG:C07751 Dofetilide generic -metabolite KEGG:C07752 Alendronic acid generic -metabolite KEGG:C07753 Ibutilide generic -metabolite KEGG:C07755 Magnesium chloride generic -metabolite KEGG:C07756 7-Aminocephalosporanic acid generic -metabolite KEGG:C07758 Bendroflumethiazide generic -metabolite KEGG:C07759 Benzthiazide generic -metabolite KEGG:C07760 Brinzolamide generic -metabolite KEGG:C07761 Cephalothin generic -metabolite KEGG:C07763 Hydroflumethiazide generic -metabolite KEGG:C07764 Methazolamide generic -metabolite KEGG:C07765 Methyclothiazide generic -metabolite KEGG:C07766 Polythiazide generic -metabolite KEGG:C07767 Trichlormethiazide generic -metabolite KEGG:C07768 Azelastine generic -metabolite KEGG:C07770 Sulbactam generic -metabolite KEGG:C07771 Tazobactam generic -metabolite KEGG:C07773 Ambenonium generic -metabolite KEGG:C07774 Azatadine generic -metabolite KEGG:C07777 Buclizine generic -metabolite KEGG:C07778 Cetirizine generic -metabolite KEGG:C07780 Chlorpheniramine maleate generic -metabolite KEGG:C07783 Dexchlorpheniramine maleate generic -metabolite KEGG:C07784 Diphenhydramine hydrochloride generic -metabolite KEGG:C07785 Emedastine generic -metabolite KEGG:C07789 Olopatadine generic -metabolite KEGG:C07790 Phenindamine generic -metabolite KEGG:C07792 Naratriptan generic -metabolite KEGG:C07798 Dihydroergotamine generic -metabolite KEGG:C07805 Formoterol generic -metabolite KEGG:C07807 Pirbuterol generic -metabolite KEGG:C07809 Flavoxate generic -metabolite KEGG:C07811 Hexocyclium generic -metabolite KEGG:C07813 Beclomethasone dipropionate generic -metabolite KEGG:C07814 Homatropine generic -metabolite KEGG:C07815 Fluticasone generic -metabolite KEGG:C07816 Mometasone generic -metabolite KEGG:C07817 Mometasone furoate generic -metabolite KEGG:C07818 Mepenzolate generic -metabolite KEGG:C07819 Dyphylline generic -metabolite KEGG:C07825 Flumazenil generic -metabolite KEGG:C07826 Aprobarbital generic -metabolite KEGG:C07827 Butabarbital generic -metabolite KEGG:C07829 Mephobarbital generic -metabolite KEGG:C07832 Ethinamate generic -metabolite KEGG:C07833 Ethchlorvynol generic -metabolite KEGG:C07834 Paraldehyde generic -metabolite KEGG:C07836 D-glycero-beta-D-manno-Heptose 7-phosphate generic -metabolite KEGG:C07837 Fomepizole generic -metabolite KEGG:C07838 D-glycero-beta-D-manno-Heptose 1-phosphate generic -metabolite KEGG:C07839 Ethotoin generic -metabolite KEGG:C07840 Fosphenytoin generic -metabolite KEGG:C07841 Levetiracetam generic -metabolite KEGG:C07843 Ketamine hydrochloride generic -metabolite KEGG:C07844 Methohexital generic -metabolite KEGG:C07846 Thiamylal generic -metabolite KEGG:C07849 Methantheline generic -metabolite KEGG:C07851 Oxyphencyclimine generic -metabolite KEGG:C07852 Propiverine generic -metabolite KEGG:C07853 Clidinium generic -metabolite KEGG:C07861 Tridihexethyl generic -metabolite KEGG:C07862 Tridihexethyl iodide generic -metabolite KEGG:C07864 Rabeprazole generic -metabolite KEGG:C07865 Rabeprazole sodium generic -metabolite KEGG:C07866 Dolasetron generic -metabolite KEGG:C07868 Metoclopramide generic -metabolite KEGG:C07870 Bismuth subsalicylate generic -metabolite KEGG:C07871 Difenoxin generic -metabolite KEGG:C07872 Diphenoxylate generic -metabolite KEGG:C07874 1,4-Bis(2-ethylhexyl) sulfosuccinate generic -metabolite KEGG:C07875 Butamben generic -metabolite KEGG:C07876 Magnesium hydroxide generic -metabolite KEGG:C07877 Chloroprocaine generic -metabolite KEGG:C07879 Dibucaine generic -metabolite KEGG:C07880 Ursodiol generic -metabolite KEGG:C07881 Dyclonine generic -metabolite KEGG:C07884 Dextroamphetamine generic -metabolite KEGG:C07886 Brimonidine generic -metabolite KEGG:C07887 L-(-)-1-Butyl-2',6'-pipecoloxylidide generic -metabolite KEGG:C07888 Cyclophosphamide generic -metabolite KEGG:C07889 Mephentermine generic -metabolite KEGG:C07890 Midodrine generic -metabolite KEGG:C07892 Pramoxine generic -metabolite KEGG:C07894 Procaine hydrochloride generic -metabolite KEGG:C07895 Propoxycaine generic -metabolite KEGG:C07897 Etanercept generic -metabolite KEGG:C07898 Naphazoline hydrochloride generic -metabolite KEGG:C07899 Pemoline generic -metabolite KEGG:C07903 Interleukin-2 generic -metabolite KEGG:C07904 Phendimetrazine generic -metabolite KEGG:C07905 Leflunomide generic -metabolite KEGG:C07906 Levamisole hydrochloride generic -metabolite KEGG:C07908 Mycophenolate mofetil generic -metabolite KEGG:C07909 Sirolimus generic -metabolite KEGG:C07910 Thalidomide generic -metabolite KEGG:C07911 Phenylpropanolamine generic -metabolite KEGG:C07912 Tetrahydrozoline generic -metabolite KEGG:C07913 Xylometazoline generic -metabolite KEGG:C07914 Levobunolol generic -metabolite KEGG:C07915 Metipranolol generic -metabolite KEGG:C07919 Metocurine generic -metabolite KEGG:C07921 Metyrosine generic -metabolite KEGG:C07927 Carisoprodol generic -metabolite KEGG:C07928 Chlorphenesin generic -metabolite KEGG:C07930 Chlorphenesin carbamate generic -metabolite KEGG:C07931 Chlorzoxazone generic -metabolite KEGG:C07933 Dantrolene sodium anhydrous generic -metabolite KEGG:C07934 Metaxalone generic -metabolite KEGG:C07935 Orphenadrine generic -metabolite KEGG:C07937 Riluzole generic -metabolite KEGG:C07939 Amantadine hydrochloride generic -metabolite KEGG:C07941 Biperiden generic -metabolite KEGG:C07943 Entacapone generic -metabolite KEGG:C07946 Botulinum toxin type A generic -metabolite KEGG:C07949 Tolcapone generic -metabolite KEGG:C07952 Chlorpromazine hydrochloride generic -metabolite KEGG:C07953 Chlorprothixene generic -metabolite KEGG:C07955 Fluphenazine enanthate generic -metabolite KEGG:C07956 Fluphenazine depot generic -metabolite KEGG:C07964 Lithium carbonate generic -metabolite KEGG:C07965 Tirofiban generic -metabolite KEGG:C07966 Cerivastatin generic -metabolite KEGG:C07967 Bithionol generic -metabolite KEGG:C07968 Diethylcarbamazine generic -metabolite KEGG:C07971 Metrifonate generic -metabolite KEGG:C07973 Piperazine generic -metabolite KEGG:C07974 Suramin generic -metabolite KEGG:C07982 Imipramine hydrochloride generic -metabolite KEGG:C07995 Magnesium salicylate generic -metabolite KEGG:C07996 Dehydroemetine generic -metabolite KEGG:C07997 Eflornithine generic -metabolite KEGG:C07999 Furazolidone generic -metabolite KEGG:C08001 Melarsoprol generic -metabolite KEGG:C08002 Nifurtimox generic -metabolite KEGG:C08005 Alfentanil generic -metabolite KEGG:C08007 Buprenorphine generic -metabolite KEGG:C08010 Dezocine generic -metabolite KEGG:C08012 Levomethadyl acetate generic -metabolite KEGG:C08014 Levorphanol generic -metabolite KEGG:C08018 Oxycodone generic -metabolite KEGG:C08019 Oxymorphone generic -metabolite KEGG:C08021 Remifentanil generic -metabolite KEGG:C08022 Sufentanil generic -metabolite KEGG:C08024 Hydrocodone generic -metabolite KEGG:C08026 Oxycodone hydrochloride generic -metabolite KEGG:C08027 Nalmefene generic -metabolite KEGG:C08029 Methacycline hydrochloride generic -metabolite KEGG:C08031 Erythromycin estolate generic -metabolite KEGG:C08032 Quinupristin generic -metabolite KEGG:C08033 Dalfopristin generic -metabolite KEGG:C08034 Quinupristin-dalfopristin generic -metabolite KEGG:C08037 Benzalkonium chloride generic -metabolite KEGG:C08038 Chlorhexidine gluconate generic -metabolite KEGG:C08039 Hexachlorophene generic -metabolite KEGG:C08040 Iodine aqueous generic -metabolite KEGG:C08042 Nitrofurazone generic -metabolite KEGG:C08043 Povidone-iodine generic -metabolite KEGG:C08046 Kanamycin sulfate generic -metabolite KEGG:C08050 Sulfamethizole generic -metabolite KEGG:C08051 Sulfacetamide sodium anhydrous generic -metabolite KEGG:C08052 Cinoxacin generic -metabolite KEGG:C08053 Lomefloxacin hydrochloride generic -metabolite KEGG:C08054 Moxifloxacin hydrochloride generic -metabolite KEGG:C08055 Aminosalicylate sodium anhydrous generic -metabolite KEGG:C08057 Cycloserine generic -metabolite KEGG:C08059 Rifapentine generic -metabolite KEGG:C08060 Carbazole generic -metabolite KEGG:C08061 2'-Aminobiphenyl-2,3-diol generic -metabolite KEGG:C08062 2-Hydroxy-6-oxo-(2'-aminophenyl)-hexa-2,4-dienoate generic -metabolite KEGG:C08063 1,4-Cyclohexanedione generic -metabolite KEGG:C08064 Saponarin generic -metabolite KEGG:C08065 Butoconazole generic -metabolite KEGG:C08066 Butoconazole nitrate generic -metabolite KEGG:C08067 Butenafine generic -metabolite KEGG:C08068 Econazole generic -metabolite KEGG:C08069 Econazole nitrate generic -metabolite KEGG:C08070 Miconazole nitrate generic -metabolite KEGG:C08071 Naftifine generic -metabolite KEGG:C08072 Naftifine hydrochloride generic -metabolite KEGG:C08073 Natamycin generic -metabolite KEGG:C08074 Oxiconazole generic -metabolite KEGG:C08075 Oxiconazole nitrate generic -metabolite KEGG:C08076 Sulconazole generic -metabolite KEGG:C08079 Terbinafine generic -metabolite KEGG:C08080 Terconazole generic -metabolite KEGG:C08082 Tioconazole generic -metabolite KEGG:C08086 Amprenavir generic -metabolite KEGG:C08087 Delavirdine mesylate generic -metabolite KEGG:C08088 Efavirenz generic -metabolite KEGG:C08089 Indinavir sulfate generic -metabolite KEGG:C08090 Dienestrol generic -metabolite KEGG:C08091 Nelfinavir mesylate generic -metabolite KEGG:C08092 Oseltamivir generic -metabolite KEGG:C08093 Oseltamivir phosphate generic -metabolite KEGG:C08094 Rimantadine hydrochloride generic -metabolite KEGG:C08095 Zanamivir generic -metabolite KEGG:C08098 Cefazolin sodium generic -metabolite KEGG:C08099 Cephalexin monohydrate generic -metabolite KEGG:C08100 Cephalothin sodium generic -metabolite KEGG:C08101 Cephapirin sodium generic -metabolite KEGG:C08102 Cefamandole nafate generic -metabolite KEGG:C08103 Cefmetazole generic -metabolite KEGG:C08104 Cefmetazole sodium generic -metabolite KEGG:C08105 Cefonicid sodium generic -metabolite KEGG:C08106 Cefoxitin sodium generic -metabolite KEGG:C08107 Cefuroxime axetil generic -metabolite KEGG:C08108 Cefuroxime sodium generic -metabolite KEGG:C08109 Loracarbef monohydrate generic -metabolite KEGG:C08110 Cefdinir generic -metabolite KEGG:C08111 Cefepime generic -metabolite KEGG:C08112 Cefoperazone sodium generic -metabolite KEGG:C08113 Cefotaxime sodium generic -metabolite KEGG:C08114 Cefpodoxime generic -metabolite KEGG:C08115 Cefpodoxime proxetil generic -metabolite KEGG:C08117 Ceftibuten generic -metabolite KEGG:C08118 Ceftizoxime sodium generic -metabolite KEGG:C08122 Bacampicillin generic -metabolite KEGG:C08123 Bacampicillin hydrochloride generic -metabolite KEGG:C08124 Nafcillin sodium generic -metabolite KEGG:C08126 Penicillin V generic -metabolite KEGG:C08127 Paricalcitol generic -metabolite KEGG:C08129 Calcium carbonate generic -metabolite KEGG:C08130 Calcium chloride anhydrous generic -metabolite KEGG:C08133 Calcium gluconate generic -metabolite KEGG:C08136 Tricalcium phosphate generic -metabolite KEGG:C08141 Tiludronic acid generic -metabolite KEGG:C08142 Sodium fluoride generic -metabolite KEGG:C08145 Diethylstilbestrol diphosphate generic -metabolite KEGG:C08146 Linezolid generic -metabolite KEGG:C08148 Hydroxyprogesterone caproate generic -metabolite KEGG:C08149 Levonorgestrel generic -metabolite KEGG:C08150 Medroxyprogesterone acetate generic -metabolite KEGG:C08151 Megestrol acetate generic -metabolite KEGG:C08152 Norethindrone acetate generic -metabolite KEGG:C08153 Norgestrel generic -metabolite KEGG:C08154 Nandrolone decanoate generic -metabolite KEGG:C08155 Nandrolone phenpropionate generic -metabolite KEGG:C08156 Testosterone cypionate generic -metabolite KEGG:C08157 Testosterone enanthate generic -metabolite KEGG:C08158 Testosterone propionate generic -metabolite KEGG:C08159 Anastrozole generic -metabolite KEGG:C08160 Bicalutamide generic -metabolite KEGG:C08161 Clomiphene citrate generic -metabolite KEGG:C08162 Exemestane generic -metabolite KEGG:C08163 Letrozole generic -metabolite KEGG:C08164 Nilutamide generic -metabolite KEGG:C08166 Toremifene generic -metabolite KEGG:C08169 Meloxicam generic -metabolite KEGG:C08171 Sodium thiosalicylate generic -metabolite KEGG:C08173 Cortisone acetate generic -metabolite KEGG:C08174 Dexamethasone acetate anhydrous generic -metabolite KEGG:C08175 Dexamethasone sodium phosphate generic -metabolite KEGG:C08176 Hydrocortisone cypionate generic -metabolite KEGG:C08178 Hydrocortisone sodium succinate generic -metabolite KEGG:C08179 Methylprednisolone acetate generic -metabolite KEGG:C08180 Prednisolone acetate generic -metabolite KEGG:C08182 Prednisolone tebutate generic -metabolite KEGG:C08183 Triamcinolone acetonide generic -metabolite KEGG:C08184 Triamcinolone diacetate generic -metabolite KEGG:C08185 Triamcinolone hexacetonide generic -metabolite KEGG:C08186 Fludrocortisone acetate generic -metabolite KEGG:C08187 Cabergoline generic -metabolite KEGG:C08193 Aurothioglucose generic -metabolite KEGG:C08195 Meclofenoxate generic -metabolite KEGG:C08197 Neostigmine bromide generic -metabolite KEGG:C08200 Neostigmine methylsulfate generic -metabolite KEGG:C08201 Acetylcholine chloride generic -metabolite KEGG:C08202 Bethanechol chloride generic -metabolite KEGG:C08211 Doxercalciferol generic -metabolite KEGG:C08212 Levothyroxine sodium anhydrous generic -metabolite KEGG:C08215 Thyroid generic -metabolite KEGG:C08217 Iopanoic acid generic -metabolite KEGG:C08219 Potassium iodide generic -metabolite KEGG:C08230 Hydroxocobalamin generic -metabolite KEGG:C08233 Risedronic acid generic -metabolite KEGG:C08234 beta-Cymaropyranose generic -metabolite KEGG:C08235 Digitalose generic -metabolite KEGG:C08236 alpha-D-Mannoheptulopyranose generic -metabolite KEGG:C08237 Oleandrose generic -metabolite KEGG:C08238 alpha-Galactosyl-(1-6)-alpha-galactosyl-(1-6)-alpha-galactosyl-(1-6)-alpha-galactosyl-(1-6)-alpha-glucosyl-(1-2)-beta-fructose generic -metabolite KEGG:C08239 Gentianose generic -metabolite KEGG:C08240 Gentiobiose generic -metabolite KEGG:C08241 Sodium 2-O-L-rhamnopyranosyl-4-deoxy-alpha-L-threo-hex-4-eno-pyranosiduronate generic -metabolite KEGG:C08242 Lychnose generic -metabolite KEGG:C08243 Melezitose generic -metabolite KEGG:C08244 2-O-alpha-L-Rhamnopyranosyl-D-glucopyranose generic -metabolite KEGG:C08245 6-O-beta-D-Xylopyranosyl-D-glucose generic -metabolite KEGG:C08246 Robinobiose generic -metabolite KEGG:C08247 Rutinose generic -metabolite KEGG:C08248 Sesamose generic -metabolite KEGG:C08249 Pyrimidine 5'-deoxynucleotide generic -metabolite KEGG:C08250 Sophorose generic -metabolite KEGG:C08251 Umbelliferose generic -metabolite KEGG:C08252 Verbascose generic -metabolite KEGG:C08253 Fucoidan generic -metabolite KEGG:C08254 Clusianose generic -metabolite KEGG:C08255 Perseitol generic -metabolite KEGG:C08257 (-)-Quebrachitol generic -metabolite KEGG:C08258 (+)-Quercitol generic -metabolite KEGG:C08259 (-)-Viburnitol generic -metabolite KEGG:C08260 Volemitol generic -metabolite KEGG:C08261 Azelaic acid generic -metabolite KEGG:C08262 3-Methylbutanoic acid generic -metabolite KEGG:C08263 beta-Alaninebetaine generic -metabolite KEGG:C08264 L-Albizziine generic -metabolite KEGG:C08265 Alliin generic -metabolite KEGG:C08266 L-alpha-Amino-gamma-oxalylaminobutyric acid generic -metabolite KEGG:C08267 L-Azetidine 2-carboxylic acid generic -metabolite KEGG:C08268 L-Baikiain generic -metabolite KEGG:C08269 (-)-Betonicine generic -metabolite KEGG:C08270 L-Canaline generic -metabolite KEGG:C08271 Coprine generic -metabolite KEGG:C08272 Kinetin generic -metabolite KEGG:C08273 2,5-Dihydrophenylalanine generic -metabolite KEGG:C08275 L-Djenkolic acid generic -metabolite KEGG:C08276 3-(Methylthio)propanoate generic -metabolite KEGG:C08277 Sebacic acid generic -metabolite KEGG:C08278 Suberic acid generic -metabolite KEGG:C08279 Tiglic acid generic -metabolite KEGG:C08280 Hypoglycin B generic -metabolite KEGG:C08281 Docosanoic acid generic -metabolite KEGG:C08282 Chaulmoogric acid generic -metabolite KEGG:C08283 Homostachydrine generic -metabolite KEGG:C08284 gamma-Hydroxy-L-arginine generic -metabolite KEGG:C08285 10,16-Dihydroxyhexadecanoic acid generic -metabolite KEGG:C08286 (+)-gamma-Hydroxy-L-homoarginine generic -metabolite KEGG:C08287 Hypoglycin generic -metabolite KEGG:C08288 Indospicine generic -metabolite KEGG:C08289 Isowillardiine generic -metabolite KEGG:C08290 Lathyrine generic -metabolite KEGG:C08291 3-Methylamino-L-alanine generic -metabolite KEGG:C08292 alpha-(Methylenecyclopropyl)glycine generic -metabolite KEGG:C08294 O-Oxalylhomoserine generic -metabolite KEGG:C08295 S-[(E)-Prop-1-enyl]-L-cysteine S-oxide generic -metabolite KEGG:C08296 Quisqualic acid generic -metabolite KEGG:C08298 Tricholomic acid generic -metabolite KEGG:C08299 Bufotenine generic -metabolite KEGG:C08300 D-Cathine generic -metabolite KEGG:C08301 D-Cathinone generic -metabolite KEGG:C08302 N,N-Dimethyltryptamine generic -metabolite KEGG:C08303 Galegine generic -metabolite KEGG:C08304 Gramine generic -metabolite KEGG:C08305 Gyromitrin generic -metabolite KEGG:C08306 Hexylamine generic -metabolite KEGG:C08307 Hordatine A generic -metabolite KEGG:C08308 Hordatine B generic -metabolite KEGG:C08309 N,N-Dimethyl-5-methoxytryptamine generic -metabolite KEGG:C08310 N-Methylmescaline generic -metabolite KEGG:C08311 Muscimol generic -metabolite KEGG:C08312 Psilocin generic -metabolite KEGG:C08313 Skatole generic -metabolite KEGG:C08314 (9R,10R)-Dihydroxyoctadecanoic acid generic -metabolite KEGG:C08315 (9Z,11E,13E)-Octadecatrienoic acid generic -metabolite KEGG:C08316 Erucic acid generic -metabolite KEGG:C08317 12-Hydroxydodecanoic acid generic -metabolite KEGG:C08318 (9Z,12Z)-(8R)-Hydroxyoctadeca-9,12-dienoic acid generic -metabolite KEGG:C08319 alpha-Licanic acid generic -metabolite KEGG:C08320 Tetracosanoic acid generic -metabolite KEGG:C08321 Malvalic acid generic -metabolite KEGG:C08322 Myristoleic acid generic -metabolite KEGG:C08323 (15Z)-Tetracosenoic acid generic -metabolite KEGG:C08324 Acalyphin generic -metabolite KEGG:C08325 Amygdalin generic -metabolite KEGG:C08326 Anthemis glycoside A generic -metabolite KEGG:C08327 Anthemis glycoside B generic -metabolite KEGG:C08328 Cardiospermin generic -metabolite KEGG:C08329 Deidaclin generic -metabolite KEGG:C08330 p-Glucosyloxymandelonitrile generic -metabolite KEGG:C08331 Gynocardin generic -metabolite KEGG:C08332 Heterodendrin generic -metabolite KEGG:C08333 Linustatin generic -metabolite KEGG:C08334 Lotaustralin generic -metabolite KEGG:C08335 Lucumin generic -metabolite KEGG:C08336 Neolinustatin generic -metabolite KEGG:C08337 Proacaciberin generic -metabolite KEGG:C08338 Proacacipetalin generic -metabolite KEGG:C08339 Proteacin generic -metabolite KEGG:C08340 Sarmentosin generic -metabolite KEGG:C08341 Sarmentosin epoxide generic -metabolite KEGG:C08342 Triglochinin generic -metabolite KEGG:C08344 Volkenin generic -metabolite KEGG:C08345 Zierin generic -metabolite KEGG:C08346 beta-D-Apiose generic -metabolite KEGG:C08347 2-Deoxy-alpha-D-ribopyranose generic -metabolite KEGG:C08348 Galacturonic acid generic -metabolite KEGG:C08349 beta-D-Glucosamine generic -metabolite KEGG:C08350 beta-D-Glucopyranuronic acid generic -metabolite KEGG:C08351 beta-D-Hamamelopyranose generic -metabolite KEGG:C08352 Quinovose generic -metabolite KEGG:C08353 beta-D-Ribopyranose generic -metabolite KEGG:C08354 alpha-D-Ribulose generic -metabolite KEGG:C08355 beta-D-Sedoheptulopyranose generic -metabolite KEGG:C08356 alpha-L-Sorbopyranose generic -metabolite KEGG:C08357 Estradiol-17beta 3-sulfate generic -metabolite KEGG:C08358 2-Methoxyestrone 3-sulfate generic -metabolite KEGG:C08359 2-Methoxyestradiol-17beta 3-sulfate generic -metabolite KEGG:C08362 (9Z)-Hexadecenoic acid generic -metabolite KEGG:C08363 (6Z)-Octadecenoic acid generic -metabolite KEGG:C08364 Punicic acid generic -metabolite KEGG:C08365 Ricinoleic acid generic -metabolite KEGG:C08366 Sterculic acid generic -metabolite KEGG:C08367 (11E)-Octadecenoic acid generic -metabolite KEGG:C08368 Vernolic acid generic -metabolite KEGG:C08369 Diallyl disulfide generic -metabolite KEGG:C08370 Diallyl sulfide generic -metabolite KEGG:C08371 Dimethyl disulfide generic -metabolite KEGG:C08372 Dimethyl trisulfide generic -metabolite KEGG:C08373 Dipropyl disulfide generic -metabolite KEGG:C08374 Dodecane generic -metabolite KEGG:C08375 (3Z,6Z,9Z)-3,6,9-Dodecatrien-1-ol generic -metabolite KEGG:C08376 Hentriacontane generic -metabolite KEGG:C08377 14,16-Hentriacontanedione generic -metabolite KEGG:C08378 Hentriacontan-1-ol generic -metabolite KEGG:C08379 Hentriacontan-16-one generic -metabolite KEGG:C08380 2-Heptanone generic -metabolite KEGG:C08381 Hexacosan-1-ol generic -metabolite KEGG:C08382 Lenthionine generic -metabolite KEGG:C08383 Methyl allyl disulfide generic -metabolite KEGG:C08384 Nonacosane generic -metabolite KEGG:C08385 (10S)-Nonacosan-10-ol generic -metabolite KEGG:C08386 Nonacosan-10-one generic -metabolite KEGG:C08387 Octacosan-1-ol generic -metabolite KEGG:C08388 Pentadecane generic -metabolite KEGG:C08389 Propanethial S-oxide generic -metabolite KEGG:C08390 Propane-1-thiol generic -metabolite KEGG:C08391 Propane-2-thiol generic -metabolite KEGG:C08392 Triacontan-1-ol generic -metabolite KEGG:C08393 Tritriacontane generic -metabolite KEGG:C08394 Tritriacontane-16,18-dione generic -metabolite KEGG:C08395 Aethusin generic -metabolite KEGG:C08396 Anacyclin generic -metabolite KEGG:C08397 5-(3-Buten-1-ynyl)-2,2'-bithiophene generic -metabolite KEGG:C08398 Capillin generic -metabolite KEGG:C08399 Carlina oxide generic -metabolite KEGG:C08400 Glucoalyssin generic -metabolite KEGG:C08401 Glucoberteroin generic -metabolite KEGG:C08402 Cicutoxin generic -metabolite KEGG:C08403 Glucobrassicanapin generic -metabolite KEGG:C08404 Glucocapparin generic -metabolite KEGG:C08405 Glucocheirolin generic -metabolite KEGG:C08406 Glucocleomin generic -metabolite KEGG:C08407 Glucocochlearin generic -metabolite KEGG:C08408 Glucoconringiin generic -metabolite KEGG:C08409 Glucoerucin generic -metabolite KEGG:C08410 Glucoerysolin generic -metabolite KEGG:C08411 Glucoiberin generic -metabolite KEGG:C08412 Glucoiberverin generic -metabolite KEGG:C08413 Glucolepidiin generic -metabolite KEGG:C08414 Glucolimnanthin generic -metabolite KEGG:C08415 Gluconapin generic -metabolite KEGG:C08416 Gluconapoleiferin generic -metabolite KEGG:C08417 Gluconasturtiin generic -metabolite KEGG:C08418 Glucoputranjivin generic -metabolite KEGG:C08419 Glucoraphanin generic -metabolite KEGG:C08420 Glucoraphenin generic -metabolite KEGG:C08422 4-Hydroxyglucobrassicin generic -metabolite KEGG:C08423 4-Methoxyglucobrassicin generic -metabolite KEGG:C08424 Neoglucobrassicin generic -metabolite KEGG:C08425 Progoitrin generic -metabolite KEGG:C08426 Sinalbin generic -metabolite KEGG:C08427 Sinigrin generic -metabolite KEGG:C08428 (N-Sulfoindol-3-yl)methylglucosinolate generic -metabolite KEGG:C08429 Clitidine 5'-phosphate generic -metabolite KEGG:C08430 Convicine generic -metabolite KEGG:C08431 Cordycepin generic -metabolite KEGG:C08432 Isoguanosine generic -metabolite KEGG:C08433 Amataine generic -metabolite KEGG:C08434 6-Methylaminopurine generic -metabolite KEGG:C08435 Triacanthine generic -metabolite KEGG:C08437 Vicine generic -metabolite KEGG:C08438 alpha-Amanitin generic -metabolite KEGG:C08439 Phalloidin generic -metabolite KEGG:C08440 Phaseolotoxin generic -metabolite KEGG:C08441 Tentoxin generic -metabolite KEGG:C08442 Ustiloxin generic -metabolite KEGG:C08443 Victorin C generic -metabolite KEGG:C08445 Dehydrofalcarinone generic -metabolite KEGG:C08446 Dehydromatricaria ester generic -metabolite KEGG:C08447 Dehydrosafynol generic -metabolite KEGG:C08448 Eutypine generic -metabolite KEGG:C08449 Falcarindiol generic -metabolite KEGG:C08450 Falcarinol generic -metabolite KEGG:C08451 Falcarinone generic -metabolite KEGG:C08452 Ichthyotherol generic -metabolite KEGG:C08453 Lachnophyllum ester generic -metabolite KEGG:C08454 (E,E,E)-N-(2-Methylpropyl)hexadeca-2,6,8-trien-10-ynamide generic -metabolite KEGG:C08455 Mycosinol generic -metabolite KEGG:C08456 Phenylheptatriyne generic -metabolite KEGG:C08457 1-Phenyl-5-heptene-1,3-diyne generic -metabolite KEGG:C08458 Safynol generic -metabolite KEGG:C08459 Stearolic acid generic -metabolite KEGG:C08460 alpha-Terthienyl generic -metabolite KEGG:C08461 Thiarubrine A generic -metabolite KEGG:C08462 Thiarubrine B generic -metabolite KEGG:C08463 Triacetylene generic -metabolite KEGG:C08464 1-Tridecene-3,5,7,9,11-pentayne generic -metabolite KEGG:C08465 Wyerone generic -metabolite KEGG:C08466 Wyerone acid generic -metabolite KEGG:C08467 Asimicin generic -metabolite KEGG:C08468 Acremoauxin A generic -metabolite KEGG:C08469 Aristolochic acid generic -metabolite KEGG:C08470 Bullatacinone generic -metabolite KEGG:C08471 Chalcogran generic -metabolite KEGG:C08472 Avenanthramide A generic -metabolite KEGG:C08473 Cibarian generic -metabolite KEGG:C08474 Coronarian generic -metabolite KEGG:C08475 Cucumopine generic -metabolite KEGG:C08476 Chelidonic acid generic -metabolite KEGG:C08477 Dianthalexin generic -metabolite KEGG:C08478 Dianthramine generic -metabolite KEGG:C08480 6-Hydroxykynurenic acid generic -metabolite KEGG:C08481 Indican generic -metabolite KEGG:C08482 Cucurbic acid generic -metabolite KEGG:C08483 14-Dihydroxycornestin generic -metabolite KEGG:C08484 Epoxymurin-A generic -metabolite KEGG:C08485 2-(4-Methoxyphenethyl)chromone generic -metabolite KEGG:C08486 Ethyl(E,Z)-decadienoate generic -metabolite KEGG:C08487 Ethyl tiglate generic -metabolite KEGG:C08488 Giganin generic -metabolite KEGG:C08489 (Z)-3,5-Hexadienyl butyrate generic -metabolite KEGG:C08490 Jasmone generic -metabolite KEGG:C08491 (-)-Jasmonic acid generic -metabolite KEGG:C08492 3-Hexenol generic -metabolite KEGG:C08493 Indole-3-carboxaldehyde generic -metabolite KEGG:C08494 Isotan B generic -metabolite KEGG:C08495 Karakin generic -metabolite KEGG:C08496 Lycomarasmine B generic -metabolite KEGG:C08497 (E)-2-Hexenal generic -metabolite KEGG:C08498 Lilac aldehyde generic -metabolite KEGG:C08499 Nona-2,6-dienal generic -metabolite KEGG:C08501 gamma-Nonalactone generic -metabolite KEGG:C08502 Parasorbic acid generic -metabolite KEGG:C08503 Pinolidoxin generic -metabolite KEGG:C08504 Macrozamin generic -metabolite KEGG:C08505 Purpureacin-1 generic -metabolite KEGG:C08506 Methoxybrassinin generic -metabolite KEGG:C08507 Miserotoxin generic -metabolite KEGG:C08509 Putaminoxin generic -metabolite KEGG:C08510 Ruscopine generic -metabolite KEGG:C08511 Tenuazonic acid generic -metabolite KEGG:C08512 Ranunculin generic -metabolite KEGG:C08513 Acetylcaranine generic -metabolite KEGG:C08514 3-Acetylnerbowdine generic -metabolite KEGG:C08515 Albomaculine generic -metabolite KEGG:C08516 Amaryllisine generic -metabolite KEGG:C08517 Ambelline generic -metabolite KEGG:C08518 Belladine generic -metabolite KEGG:C08519 Brunsvigine generic -metabolite KEGG:C08520 Candimine generic -metabolite KEGG:C08521 Caranine generic -metabolite KEGG:C08522 Caribine generic -metabolite KEGG:C08523 Carinatine generic -metabolite KEGG:C08524 Cavinine generic -metabolite KEGG:C08525 Crinamine generic -metabolite KEGG:C08526 Galanthamine generic -metabolite KEGG:C08527 Haemanthamine generic -metabolite KEGG:C08528 Hippeastrine generic -metabolite KEGG:C08529 Kalbreclasine generic -metabolite KEGG:C08530 Lycorenine generic -metabolite KEGG:C08531 Lycoricidine generic -metabolite KEGG:C08532 Lycorine generic -metabolite KEGG:C08533 Narciclasine generic -metabolite KEGG:C08534 Narwedine generic -metabolite KEGG:C08535 Pancratistatin generic -metabolite KEGG:C08536 Pretazettine generic -metabolite KEGG:C08537 Amaranthin generic -metabolite KEGG:C08538 Betalamic acid generic -metabolite KEGG:C08539 Betanidin generic -metabolite KEGG:C08540 Betanin generic -metabolite KEGG:C08541 Bougainvillein-r-I generic -metabolite KEGG:C08542 Celosianin II generic -metabolite KEGG:C08543 Dopaxanthin generic -metabolite KEGG:C08544 Gomphrenin-I generic -metabolite KEGG:C08545 Squamocin generic -metabolite KEGG:C08546 Tiglyl tiglate generic -metabolite KEGG:C08547 Gomphrenin-V generic -metabolite KEGG:C08548 Humilixanthin generic -metabolite KEGG:C08549 Indicaxanthin generic -metabolite KEGG:C08550 Iresinin I generic -metabolite KEGG:C08551 Isobetanin generic -metabolite KEGG:C08552 Lampranthin II generic -metabolite KEGG:C08553 PM-Toxin A generic -metabolite KEGG:C08554 Miraxanthin-I generic -metabolite KEGG:C08555 Miraxanthin-II generic -metabolite KEGG:C08556 Miraxanthin-III generic -metabolite KEGG:C08557 Miraxanthin-V generic -metabolite KEGG:C08558 Tuberonic acid glucoside generic -metabolite KEGG:C08559 Musca-aurin-I generic -metabolite KEGG:C08560 Musca-aurin-II generic -metabolite KEGG:C08561 Tuliposide A generic -metabolite KEGG:C08562 Musca-aurin-VII generic -metabolite KEGG:C08563 Muscapurpurin generic -metabolite KEGG:C08564 Portulacaxanthin I generic -metabolite KEGG:C08565 Portulacaxanthin II generic -metabolite KEGG:C08566 Portulacaxanthin III generic -metabolite KEGG:C08567 Prebetanin generic -metabolite KEGG:C08568 Vulgaxanthin-I generic -metabolite KEGG:C08569 Vulgaxanthin-II generic -metabolite KEGG:C08570 Tuliposide B generic -metabolite KEGG:C08571 gamma-Undecalactone generic -metabolite KEGG:C08572 Uvaricin generic -metabolite KEGG:C08573 Abyssinone VI generic -metabolite KEGG:C08574 Apigeninidin generic -metabolite KEGG:C08575 Aurantinidin generic -metabolite KEGG:C08576 Aureusidin generic -metabolite KEGG:C08577 Bracteatin generic -metabolite KEGG:C08578 Butein generic -metabolite KEGG:C08579 Antheraxanthin generic -metabolite KEGG:C08580 Astaxanthin generic -metabolite KEGG:C08581 Azafrin generic -metabolite KEGG:C08582 Bixin generic -metabolite KEGG:C08583 Canthaxanthin generic -metabolite KEGG:C08584 Capsanthin generic -metabolite KEGG:C08585 Capsorubin generic -metabolite KEGG:C08586 delta-Carotene generic -metabolite KEGG:C08587 beta-Carotene 5,6-epoxide generic -metabolite KEGG:C08588 Crocetin generic -metabolite KEGG:C08589 Crocin generic -metabolite KEGG:C08590 Zeinoxanthin generic -metabolite KEGG:C08591 beta-Cryptoxanthin generic -metabolite KEGG:C08592 Echinenone generic -metabolite KEGG:C08593 Eschscholtzxanthin generic -metabolite KEGG:C08594 Flavoxanthin generic -metabolite KEGG:C08595 Capensinidin generic -metabolite KEGG:C08596 Fucoxanthin generic -metabolite KEGG:C08597 Helenien generic -metabolite KEGG:C08598 Carthamone generic -metabolite KEGG:C08599 Lactucaxanthin generic -metabolite KEGG:C08600 Silandrin generic -metabolite KEGG:C08601 Lutein generic -metabolite KEGG:C08602 Lutein 5,6-epoxide generic -metabolite KEGG:C08603 Lycoxanthin generic -metabolite KEGG:C08604 Chrysanthemin generic -metabolite KEGG:C08605 Citroxanthin generic -metabolite KEGG:C08606 Neoxanthin generic -metabolite KEGG:C08607 Neurosporaxanthin generic -metabolite KEGG:C08608 Norbixin generic -metabolite KEGG:C08609 Physalien generic -metabolite KEGG:C08610 Rhodoxanthin generic -metabolite KEGG:C08611 Rubixanthin generic -metabolite KEGG:C08612 Cyanidin 3-O-(6''-glucosyl-2''-xylosylgalactoside) generic -metabolite KEGG:C08613 Torulene generic -metabolite KEGG:C08614 Violaxanthin generic -metabolite KEGG:C08615 alpha-Amyrin generic -metabolite KEGG:C08616 beta-Amyrin generic -metabolite KEGG:C08617 Asiatic acid generic -metabolite KEGG:C08618 Betulin generic -metabolite KEGG:C08619 Betulinic acid generic -metabolite KEGG:C08620 Cyanidin 3-O-rutinoside generic -metabolite KEGG:C08621 Dammarenediol-I generic -metabolite KEGG:C08622 Dipterocarpol generic -metabolite KEGG:C08623 alpha-Elemolic acid generic -metabolite KEGG:C08624 Euphol generic -metabolite KEGG:C08625 Fernene generic -metabolite KEGG:C08626 Friedelin generic -metabolite KEGG:C08627 Hopane-29-acetate generic -metabolite KEGG:C08628 Lupeol generic -metabolite KEGG:C08629 Cyanidin 3,5,3'-tri-O-glucoside generic -metabolite KEGG:C08630 Lupeol acetate generic -metabolite KEGG:C08631 Messagenin generic -metabolite KEGG:C08632 Papyriferic acid generic -metabolite KEGG:C08633 Pristimerin generic -metabolite KEGG:C08634 Sapelin A generic -metabolite KEGG:C08635 Taccalonolide A generic -metabolite KEGG:C08636 Taraxasterol generic -metabolite KEGG:C08637 Taraxerol generic -metabolite KEGG:C08638 Tingenone generic -metabolite KEGG:C08639 Cyanin generic -metabolite KEGG:C08640 Delphinidin 3,3',5'-tri-O-glucoside generic -metabolite KEGG:C08641 Gentiodelphin generic -metabolite KEGG:C08642 Heavenly blue anthocyanin generic -metabolite KEGG:C08643 Hirsutidin generic -metabolite KEGG:C08644 Hispidol generic -metabolite KEGG:C08646 6-Hydroxycyanidin generic -metabolite KEGG:C08647 Cyanidin 3-O-galactoside generic -metabolite KEGG:C08648 Isobavachalcone generic -metabolite KEGG:C08649 Isobutrin generic -metabolite KEGG:C08650 Isoliquiritigenin generic -metabolite KEGG:C08651 Leptosidin generic -metabolite KEGG:C08652 Luteolinidin generic -metabolite KEGG:C08653 Malonylawobanin generic -metabolite KEGG:C08654 Acetylbrowniine generic -metabolite KEGG:C08655 Aconifine generic -metabolite KEGG:C08656 Ajaconine generic -metabolite KEGG:C08657 Anhwiedelphinine generic -metabolite KEGG:C08658 Anopterine generic -metabolite KEGG:C08659 Inuline generic -metabolite KEGG:C08660 Atisine generic -metabolite KEGG:C08661 Avadharidine generic -metabolite KEGG:C08662 Barbinine generic -metabolite KEGG:C08663 Beiwutine generic -metabolite KEGG:C08664 Bikhaconitine generic -metabolite KEGG:C08665 Browniine generic -metabolite KEGG:C08666 Cammaconine generic -metabolite KEGG:C08667 Cardiopetalidine generic -metabolite KEGG:C08668 Septentriodine generic -metabolite KEGG:C08669 Cassaidine generic -metabolite KEGG:C08670 Cassaine generic -metabolite KEGG:C08671 Condelphine generic -metabolite KEGG:C08672 Cuauchichicine generic -metabolite KEGG:C08673 14-Deacetylnudicauline generic -metabolite KEGG:C08674 Delavaine A generic -metabolite KEGG:C08675 Delcorine generic -metabolite KEGG:C08676 Delcosine generic -metabolite KEGG:C08677 Delphinine generic -metabolite KEGG:C08678 Delsoline generic -metabolite KEGG:C08679 Deltaline generic -metabolite KEGG:C08680 Denudatine generic -metabolite KEGG:C08681 Elatine generic -metabolite KEGG:C08682 Erythrophleguine generic -metabolite KEGG:C08683 Falaconitine generic -metabolite KEGG:C08684 Finaconitine generic -metabolite KEGG:C08685 Garryine generic -metabolite KEGG:C08686 Heteratisine generic -metabolite KEGG:C08687 Hetisine generic -metabolite KEGG:C08688 Hypaconitine generic -metabolite KEGG:C08689 Icaceine generic -metabolite KEGG:C08690 Icacine generic -metabolite KEGG:C08691 Indaconitine generic -metabolite KEGG:C08692 Jesaconitine generic -metabolite KEGG:C08693 Karakoline generic -metabolite KEGG:C08694 Lappaconitine generic -metabolite KEGG:C08695 Lindheimerine generic -metabolite KEGG:C08696 Lycaconitine generic -metabolite KEGG:C08697 Lycoctonine generic -metabolite KEGG:C08698 Mesaconitine generic -metabolite KEGG:C08699 Methyllycaconitine generic -metabolite KEGG:C08700 Napelline generic -metabolite KEGG:C08701 Norerythrostachaldine generic -metabolite KEGG:C08702 Nudicauline generic -metabolite KEGG:C08703 Ovatine generic -metabolite KEGG:C08704 Pseudoaconitine generic -metabolite KEGG:C08705 Ryanodine generic -metabolite KEGG:C08706 Septentrionine generic -metabolite KEGG:C08707 Songorine generic -metabolite KEGG:C08708 Spiradine A generic -metabolite KEGG:C08709 Spiramine A generic -metabolite KEGG:C08710 Spirasine I generic -metabolite KEGG:C08711 Spiredine generic -metabolite KEGG:C08712 Staphidine generic -metabolite KEGG:C08713 Talatizamine generic -metabolite KEGG:C08714 Thalicsessine generic -metabolite KEGG:C08715 Tricornine generic -metabolite KEGG:C08716 Malvidin generic -metabolite KEGG:C08717 Silychristin generic -metabolite KEGG:C08718 Malvin generic -metabolite KEGG:C08719 Sophoranone generic -metabolite KEGG:C08720 Maritimetin generic -metabolite KEGG:C08721 Polysialic acid acetylated at O-9 generic -metabolite KEGG:C08722 4,5-Methylenedioxy-6-hydroxyaurone generic -metabolite KEGG:C08723 Monardaein generic -metabolite KEGG:C08724 Okanin generic -metabolite KEGG:C08725 Pelargonin generic -metabolite KEGG:C08726 Peonidin generic -metabolite KEGG:C08727 Petunidin generic -metabolite KEGG:C08728 Riccionidin A generic -metabolite KEGG:C08729 Rosinidin generic -metabolite KEGG:C08730 Sulphuretin generic -metabolite KEGG:C08731 Xenognosin A generic -metabolite KEGG:C08732 Albafuran A generic -metabolite KEGG:C08733 Ammeline generic -metabolite KEGG:C08734 Ammelide generic -metabolite KEGG:C08735 2-Chloro-4-hydroxy-6-amino-1,3,5-triazine generic -metabolite KEGG:C08736 6-Chloro-1,3,5-triazine-2,4(1H,3H)-dione generic -metabolite KEGG:C08737 Melamine generic -metabolite KEGG:C08738 Albanol A generic -metabolite KEGG:C08739 alpha-Cotonefuran generic -metabolite KEGG:C08740 beta-Cotonefuran generic -metabolite KEGG:C08741 Dehydrotremetone generic -metabolite KEGG:C08742 2,8-Dihydroxy-3,4,7-trimethoxydibenzofuran generic -metabolite KEGG:C08743 Eriobofuran generic -metabolite KEGG:C08744 Dihydroeuparin generic -metabolite KEGG:C08745 Lithospermic acid generic -metabolite KEGG:C08746 Ailanthinone generic -metabolite KEGG:C08747 Ailanthone generic -metabolite KEGG:C08748 Azadirachtin A generic -metabolite KEGG:C08749 Bruceantin generic -metabolite KEGG:C08750 Bruceantinol generic -metabolite KEGG:C08751 Bruceine B generic -metabolite KEGG:C08752 Bruceine D generic -metabolite KEGG:C08753 Bruceoside A generic -metabolite KEGG:C08754 Brusatol generic -metabolite KEGG:C08755 Castelanone generic -metabolite KEGG:C08756 Chaparrin generic -metabolite KEGG:C08757 Chaparrinone generic -metabolite KEGG:C08758 Chaparrolide generic -metabolite KEGG:C08759 Eurycomalactone generic -metabolite KEGG:C08760 Glaucarubin generic -metabolite KEGG:C08761 6-Methoxy-alpha-pyrufuran generic -metabolite KEGG:C08762 6-O-Methyleuparin generic -metabolite KEGG:C08763 Glaucarubinone generic -metabolite KEGG:C08764 Glaucarubolone generic -metabolite KEGG:C08765 Glycinoeclepin A generic -metabolite KEGG:C08766 Harrisonin generic -metabolite KEGG:C08767 12alpha-Hydroxyamoorstatin generic -metabolite KEGG:C08768 Ichangin generic -metabolite KEGG:C08769 Isobrucein A generic -metabolite KEGG:C08770 Isobrucein B generic -metabolite KEGG:C08771 Neoquassin generic -metabolite KEGG:C08772 Nigakihemiacetal A generic -metabolite KEGG:C08773 Nomilin generic -metabolite KEGG:C08774 (Z)-2-Decene-4,6,8-triynoic acid methylester generic -metabolite KEGG:C08775 Obacunone generic -metabolite KEGG:C08776 Picrasin C generic -metabolite KEGG:C08777 Quassimarin generic -metabolite KEGG:C08778 Quassin generic -metabolite KEGG:C08779 Rutaevin generic -metabolite KEGG:C08780 Salannin generic -metabolite KEGG:C08781 Samaderin A generic -metabolite KEGG:C08782 Sergeolide generic -metabolite KEGG:C08783 Simalikilactone D generic -metabolite KEGG:C08784 Soularubinone generic -metabolite KEGG:C08785 Toonacilin generic -metabolite KEGG:C08786 Trichilin A generic -metabolite KEGG:C08787 Undulatone generic -metabolite KEGG:C08788 Zapoterin generic -metabolite KEGG:C08789 Bryodulcosigenin generic -metabolite KEGG:C08790 Carnosifloside I generic -metabolite KEGG:C08791 Carnosifloside III generic -metabolite KEGG:C08792 Carnosifloside VI generic -metabolite KEGG:C08793 Cucurbitacin A generic -metabolite KEGG:C08794 Cucurbitacin B generic -metabolite KEGG:C08795 Cucurbitacin C generic -metabolite KEGG:C08796 Cucurbitacin D generic -metabolite KEGG:C08797 Cucurbitacin E generic -metabolite KEGG:C08798 Cucurbitacin F generic -metabolite KEGG:C08799 Cucurbitacin H generic -metabolite KEGG:C08800 Cucurbitacin I generic -metabolite KEGG:C08801 Cucurbitacin J generic -metabolite KEGG:C08802 Cucurbitacin L generic -metabolite KEGG:C08803 Cucurbitacin O generic -metabolite KEGG:C08804 Cucurbitacin P generic -metabolite KEGG:C08805 Cucurbitacin Q generic -metabolite KEGG:C08806 Cucurbitacin S generic -metabolite KEGG:C08807 11-Deoxocucurbitacin I generic -metabolite KEGG:C08808 Gratiogenin generic -metabolite KEGG:C08809 Spinoside A generic -metabolite KEGG:C08810 Ajugalactone generic -metabolite KEGG:C08811 Ajugasterone C generic -metabolite KEGG:C08813 Brassicasterol generic -metabolite KEGG:C08814 Brassinolide generic -metabolite KEGG:C08815 Agar generic -metabolite KEGG:C08816 Cyasterone generic -metabolite KEGG:C08817 Fucosterol generic -metabolite KEGG:C08818 Carrageenan generic -metabolite KEGG:C08819 Inokosterone generic -metabolite KEGG:C08821 Isofucosterol generic -metabolite KEGG:C08822 Gum arabic generic -metabolite KEGG:C08823 Lichesterol generic -metabolite KEGG:C08825 Lophenol generic -metabolite KEGG:C08827 Gum tragacanth generic -metabolite KEGG:C08829 Makisterone B generic -metabolite KEGG:C08830 24-Methylenecycloartanol generic -metabolite KEGG:C08831 Miroestrol generic -metabolite KEGG:C08832 Podecdysone B generic -metabolite KEGG:C08833 Pollinastanol generic -metabolite KEGG:C08834 Polypodine B generic -metabolite KEGG:C08835 Ponasterone A generic -metabolite KEGG:C08836 Poriferasterol generic -metabolite KEGG:C08837 Poststerone generic -metabolite KEGG:C08838 Pterosterone generic -metabolite KEGG:C08839 Schottenol generic -metabolite KEGG:C08840 alpha-Spinasterol generic -metabolite KEGG:C08841 Withaferin A generic -metabolite KEGG:C08842 Withanolide D generic -metabolite KEGG:C08843 Adonitoxin generic -metabolite KEGG:C08844 Moracin A generic -metabolite KEGG:C08845 Adynerin generic -metabolite KEGG:C08846 Mulberrofuran A generic -metabolite KEGG:C08847 alpha-Antiarin generic -metabolite KEGG:C08848 Antioside generic -metabolite KEGG:C08849 Asclepin generic -metabolite KEGG:C08850 Aspecioside generic -metabolite KEGG:C08851 Bipindoside generic -metabolite KEGG:C08852 Bryophyllin A generic -metabolite KEGG:C08853 Bryotoxin A generic -metabolite KEGG:C08854 Calactin generic -metabolite KEGG:C08855 Calotropin generic -metabolite KEGG:C08856 Thevetin B generic -metabolite KEGG:C08857 Cerbertin generic -metabolite KEGG:C08858 Convallatoxin generic -metabolite KEGG:C08859 Cymarin generic -metabolite KEGG:C08860 Decoside generic -metabolite KEGG:C08861 Diginatin generic -metabolite KEGG:C08862 Digitalin generic -metabolite KEGG:C08863 Divaricoside generic -metabolite KEGG:C08864 Divostroside generic -metabolite KEGG:C08865 Eriocarpin generic -metabolite KEGG:C08866 Gitoxin generic -metabolite KEGG:C08867 Hellebrigenin 3-acetate generic -metabolite KEGG:C08868 Hellebrin generic -metabolite KEGG:C08869 Helveticoside generic -metabolite KEGG:C08870 Labriformidin generic -metabolite KEGG:C08871 Labriformin generic -metabolite KEGG:C08872 Lanceotoxin A generic -metabolite KEGG:C08873 Lanceotoxin B generic -metabolite KEGG:C08874 Lokundjoside generic -metabolite KEGG:C08875 Musaroside generic -metabolite KEGG:C08876 Neriifolin generic -metabolite KEGG:C08877 Rhodexin A generic -metabolite KEGG:C08878 Sarmentoloside generic -metabolite KEGG:C08879 Scillaren A generic -metabolite KEGG:C08880 Scilliroside generic -metabolite KEGG:C08881 k-Strophanthoside generic -metabolite KEGG:C08882 Thevetin A generic -metabolite KEGG:C08883 Uscharidin generic -metabolite KEGG:C08884 Vernadigin generic -metabolite KEGG:C08885 Agavoside A generic -metabolite KEGG:C08886 Asparagoside A generic -metabolite KEGG:C08887 Avenacoside A generic -metabolite KEGG:C08888 Avenacoside B generic -metabolite KEGG:C08889 Capsicoside A generic -metabolite KEGG:C08890 Convallagenin A generic -metabolite KEGG:C08891 Convallamarogenin generic -metabolite KEGG:C08892 Convallamaroside generic -metabolite KEGG:C08893 Convallasaponin A generic -metabolite KEGG:C08894 Deltonin generic -metabolite KEGG:C08895 Deltoside generic -metabolite KEGG:C08896 Digitogenin generic -metabolite KEGG:C08897 Dioscin generic -metabolite KEGG:C08898 Diosgenin generic -metabolite KEGG:C08899 Gitogenin generic -metabolite KEGG:C08900 Gitonin generic -metabolite KEGG:C08901 Gracillin generic -metabolite KEGG:C08902 Hecogenin generic -metabolite KEGG:C08904 Officinalisnin I generic -metabolite KEGG:C08905 Osladin generic -metabolite KEGG:C08906 Parillin generic -metabolite KEGG:C08907 Protodioscin generic -metabolite KEGG:C08908 Protogracillin generic -metabolite KEGG:C08909 Ruscogenin generic -metabolite KEGG:C08910 Ruscoside generic -metabolite KEGG:C08911 Sarsaparilloside generic -metabolite KEGG:C08912 Sarsasapogenin 3-O-4G-rhamnosylsophoroside generic -metabolite KEGG:C08913 Smilagenin generic -metabolite KEGG:C08914 Tigogenin generic -metabolite KEGG:C08915 Tigonin generic -metabolite KEGG:C08916 Tokoronin generic -metabolite KEGG:C08917 Trigonelloside C generic -metabolite KEGG:C08918 Yamogenin generic -metabolite KEGG:C08919 Yamogenin 3-O-neohesperidoside generic -metabolite KEGG:C08920 Abrusoside A generic -metabolite KEGG:C08921 Aescin generic -metabolite KEGG:C08922 Aridanin generic -metabolite KEGG:C08923 Arvensoside A generic -metabolite KEGG:C08924 Astragaloside III generic -metabolite KEGG:C08925 Astrasieversianin XVI generic -metabolite KEGG:C08926 Avenacin A-1 generic -metabolite KEGG:C08927 Avenacin B-2 generic -metabolite KEGG:C08928 Mulberrofuran C generic -metabolite KEGG:C08929 alpha-Pyrufuran generic -metabolite KEGG:C08930 Azukisaponin III generic -metabolite KEGG:C08931 Barringtogenol C generic -metabolite KEGG:C08932 Bayogenin 3-O-cellobioside generic -metabolite KEGG:C08933 Camellidin I generic -metabolite KEGG:C08934 Camellidin II generic -metabolite KEGG:C08935 Cimicifugoside generic -metabolite KEGG:C08936 Colubrin generic -metabolite KEGG:C08937 Colubrinoside generic -metabolite KEGG:C08938 Cyclamin generic -metabolite KEGG:C08939 Cyclofoetoside B generic -metabolite KEGG:C08940 Desglucomusennin generic -metabolite KEGG:C08941 Dianoside A generic -metabolite KEGG:C08942 Echinocystic acid generic -metabolite KEGG:C08943 Flaccidin B generic -metabolite KEGG:C08944 Ginsenoside Re generic -metabolite KEGG:C08945 Ginsenoside Rf generic -metabolite KEGG:C08946 Ginsenoside Rg1 generic -metabolite KEGG:C08947 Gymnemic acid I generic -metabolite KEGG:C08948 beta-Pyrufuran generic -metabolite KEGG:C08949 Gypenoside XXV generic -metabolite KEGG:C08950 Gypsogenin generic -metabolite KEGG:C08951 Pseudorhodomyrtoxin generic -metabolite KEGG:C08952 Gypsogenin 3-O-rhamnosylglucuronide generic -metabolite KEGG:C08953 Hederagenin 3-O-arabinoside generic -metabolite KEGG:C08954 alpha-Hederin generic -metabolite KEGG:C08955 beta-Hederin generic -metabolite KEGG:C08956 Helianthoside A generic -metabolite KEGG:C08957 Ilexolide A generic -metabolite KEGG:C08958 Lemmatoxin generic -metabolite KEGG:C08959 Medicagenic acid 3-O-triglucoside generic -metabolite KEGG:C08960 Musennin generic -metabolite KEGG:C08961 Notoginsenoside R1 generic -metabolite KEGG:C08962 Olaxoside generic -metabolite KEGG:C08963 Oleanoglycotoxin-A generic -metabolite KEGG:C08964 Oleanoic acid 3-O-glucuronide generic -metabolite KEGG:C08965 Pfaffic acid generic -metabolite KEGG:C08966 Pfaffoside A generic -metabolite KEGG:C08967 Phaseoloside D generic -metabolite KEGG:C08968 Phytolaccoside B generic -metabolite KEGG:C08969 Pittoside A generic -metabolite KEGG:C08970 Primulasaponin generic -metabolite KEGG:C08971 Propapyriogenin A2 generic -metabolite KEGG:C08972 Quillaic acid generic -metabolite KEGG:C08973 Rotundioside B generic -metabolite KEGG:C08974 Sainfuran generic -metabolite KEGG:C08975 Saikosaponin A generic -metabolite KEGG:C08976 Saikosaponin BK1 generic -metabolite KEGG:C08977 Saponoside D generic -metabolite KEGG:C08978 Senegin II generic -metabolite KEGG:C08979 Toxol generic -metabolite KEGG:C08980 Soyasapogenol B generic -metabolite KEGG:C08981 Toxyl angelate generic -metabolite KEGG:C08982 Soyasaponin A1 generic -metabolite KEGG:C08983 Soyasaponin I generic -metabolite KEGG:C08984 Spinasaponin A generic -metabolite KEGG:C08985 Thalicoside A generic -metabolite KEGG:C08986 Theasaponin generic -metabolite KEGG:C08987 Tubeimoside I generic -metabolite KEGG:C08988 Ursolic acid generic -metabolite KEGG:C08989 Virgaureasaponin I generic -metabolite KEGG:C08990 Yiamoloside B generic -metabolite KEGG:C08991 Ziziphin generic -metabolite KEGG:C08992 Tremetone generic -metabolite KEGG:C08993 Vignafuran generic -metabolite KEGG:C08994 Aloesin generic -metabolite KEGG:C08995 Aurasperone D generic -metabolite KEGG:C08996 Biflorin generic -metabolite KEGG:C08997 Butyrylmallotochromene generic -metabolite KEGG:C08998 Cannabichromene generic -metabolite KEGG:C08999 Capillarisin generic -metabolite KEGG:C09000 Cimifugin generic -metabolite KEGG:C09001 5,7-Dihydroxychromone generic -metabolite KEGG:C09002 8-(3,3-Dimethylallyl)spatheliachromene generic -metabolite KEGG:C09003 2,2-Dimethyl-8-prenylchromene 6-carboxylic acid generic -metabolite KEGG:C09004 Drummondin A generic -metabolite KEGG:C09005 Encecalin generic -metabolite KEGG:C09006 Eupatoriochromene generic -metabolite KEGG:C09007 Flindersiachromone generic -metabolite KEGG:C09008 Frutinone A generic -metabolite KEGG:C09009 Isobutyrylmallotochromene generic -metabolite KEGG:C09010 Khellin generic -metabolite KEGG:C09011 Khellol glucoside generic -metabolite KEGG:C09012 Lathodoratin generic -metabolite KEGG:C09013 Mallotochromene generic -metabolite KEGG:C09014 5-O-Methylalloptaeroxylin generic -metabolite KEGG:C09015 Methylripariochromene A generic -metabolite KEGG:C09016 5-O-Methylvisamminol generic -metabolite KEGG:C09017 Precocene I generic -metabolite KEGG:C09018 Precocene II generic -metabolite KEGG:C09019 1-Acetylaspidoalbidine generic -metabolite KEGG:C09020 Adifoline generic -metabolite KEGG:C09021 Affinine generic -metabolite KEGG:C09022 Affinisine generic -metabolite KEGG:C09023 Agroclavine generic -metabolite KEGG:C09024 Ajmalicine generic -metabolite KEGG:C09025 Akuammicine generic -metabolite KEGG:C09026 Akuammidine generic -metabolite KEGG:C09027 Akuammine generic -metabolite KEGG:C09028 Alstonine generic -metabolite KEGG:C09029 Ptaerochromenol generic -metabolite KEGG:C09030 Ptaeroglycol generic -metabolite KEGG:C09031 Pulverochromenol generic -metabolite KEGG:C09032 Angustine generic -metabolite KEGG:C09033 Antirhine generic -metabolite KEGG:C09034 Apodine generic -metabolite KEGG:C09035 Apovincamine generic -metabolite KEGG:C09036 (-)-Apparicine generic -metabolite KEGG:C09037 Aricine generic -metabolite KEGG:C09038 Aspidoalbine generic -metabolite KEGG:C09039 Aspidodasycarpine generic -metabolite KEGG:C09040 Aspidofractine generic -metabolite KEGG:C09041 Aspidospermatine generic -metabolite KEGG:C09042 Aspidospermine generic -metabolite KEGG:C09043 Auricularine generic -metabolite KEGG:C09044 Quinquangulin generic -metabolite KEGG:C09045 Baloxine generic -metabolite KEGG:C09046 Bleekerine generic -metabolite KEGG:C09047 Rubrofusarin generic -metabolite KEGG:C09048 Spathelia bischromene generic -metabolite KEGG:C09049 Visnagin generic -metabolite KEGG:C09050 Bonafousine generic -metabolite KEGG:C09051 Borrecapine generic -metabolite KEGG:C09052 Borreline generic -metabolite KEGG:C09053 Alloimperatorin generic -metabolite KEGG:C09054 Borrerine generic -metabolite KEGG:C09055 6-Acetylpicropolin generic -metabolite KEGG:C09056 Ammoresinol generic -metabolite KEGG:C09057 Acutilol A generic -metabolite KEGG:C09058 Ajugarin I generic -metabolite KEGG:C09059 Alectrol generic -metabolite KEGG:C09060 Angelicin generic -metabolite KEGG:C09061 Allogibberic acid generic -metabolite KEGG:C09062 Antheridic acid generic -metabolite KEGG:C09063 Asebotoxin II generic -metabolite KEGG:C09064 Atractyloside generic -metabolite KEGG:C09065 Baliospermin generic -metabolite KEGG:C09066 Cafestol generic -metabolite KEGG:C09067 Callicarpone generic -metabolite KEGG:C09068 Candletoxin A generic -metabolite KEGG:C09069 Carnosol generic -metabolite KEGG:C09070 Caryoptin generic -metabolite KEGG:C09071 Cascarillin generic -metabolite KEGG:C09072 2,7,11-Cembratrien-4,6-diol generic -metabolite KEGG:C09073 Chasmanthin generic -metabolite KEGG:C09074 Clerodendrin A generic -metabolite KEGG:C09075 Clerodin generic -metabolite KEGG:C09076 Coleonol generic -metabolite KEGG:C09077 Columbin generic -metabolite KEGG:C09078 Cotylenin F generic -metabolite KEGG:C09079 Cyathin A3 generic -metabolite KEGG:C09080 Daphnetoxin generic -metabolite KEGG:C09081 7beta,12alpha-Dihydroxykaurenolide generic -metabolite KEGG:C09082 Borreverine generic -metabolite KEGG:C09083 Brevicolline generic -metabolite KEGG:C09084 Brucine generic -metabolite KEGG:C09085 Calebassone generic -metabolite KEGG:C09086 Diterpenoid EF-D generic -metabolite KEGG:C09087 Diterpenoid SP-II generic -metabolite KEGG:C09088 Callichiline generic -metabolite KEGG:C09089 Calligonine generic -metabolite KEGG:C09090 Enmein generic -metabolite KEGG:C09091 Euphorbia factor Ti2 generic -metabolite KEGG:C09092 Ferruginol generic -metabolite KEGG:C09093 Fusicoccin H generic -metabolite KEGG:C09094 Geranylgeraniol generic -metabolite KEGG:C09095 Gnidicin generic -metabolite KEGG:C09096 Gnididin generic -metabolite KEGG:C09097 Calycanthidine generic -metabolite KEGG:C09098 Canthin-6-one generic -metabolite KEGG:C09099 Naringenin 7-O-beta-D-glucoside generic -metabolite KEGG:C09100 Caracurine V generic -metabolite KEGG:C09101 Gnididilatin generic -metabolite KEGG:C09102 Gniditrin generic -metabolite KEGG:C09103 Grayanotoxin I generic -metabolite KEGG:C09104 Hallactone A generic -metabolite KEGG:C09105 Hallactone B generic -metabolite KEGG:C09106 Carapanaubine generic -metabolite KEGG:C09107 Catharanthine generic -metabolite KEGG:C09108 Huratoxin generic -metabolite KEGG:C09109 Hymatoxin A generic -metabolite KEGG:C09110 Ineketone generic -metabolite KEGG:C09111 Inflexin generic -metabolite KEGG:C09112 Ingenol generic -metabolite KEGG:C09113 Ingenol 3,20-dibenzoate generic -metabolite KEGG:C09114 Inumakilactone A glycoside generic -metabolite KEGG:C09115 Isodomedin generic -metabolite KEGG:C09116 Archangelicin generic -metabolite KEGG:C09117 Isodonal generic -metabolite KEGG:C09118 Isopimaric acid generic -metabolite KEGG:C09119 Jatrophatrione generic -metabolite KEGG:C09120 Jatrophone generic -metabolite KEGG:C09121 Jodrellin A generic -metabolite KEGG:C09122 Kansuinine B generic -metabolite KEGG:C09123 Athamantin generic -metabolite KEGG:C09124 2-Ketoepimanool generic -metabolite KEGG:C09125 Lathyrol generic -metabolite KEGG:C09126 Genistein 7-O-beta-D-glucoside generic -metabolite KEGG:C09127 Mancinellin generic -metabolite KEGG:C09128 Marrubiin generic -metabolite KEGG:C09129 Catharine generic -metabolite KEGG:C09130 Ceceline generic -metabolite KEGG:C09131 Chanoclavine-I generic -metabolite KEGG:C09132 Mascaroside generic -metabolite KEGG:C09133 (-)-Chimonanthine generic -metabolite KEGG:C09134 Mezerein generic -metabolite KEGG:C09135 Montanin generic -metabolite KEGG:C09136 Montanin A generic -metabolite KEGG:C09137 Montanol generic -metabolite KEGG:C09138 Nagilactone C generic -metabolite KEGG:C09139 Coronaridine generic -metabolite KEGG:C09140 Neocembrene generic -metabolite KEGG:C09141 Byakangelicin generic -metabolite KEGG:C09142 Cryptolepine generic -metabolite KEGG:C09143 Pedilstatin generic -metabolite KEGG:C09144 C-Curarine generic -metabolite KEGG:C09145 Ophiobolin A generic -metabolite KEGG:C09146 Eburnamine generic -metabolite KEGG:C09147 Calanolide A generic -metabolite KEGG:C09148 Oryzalexin A generic -metabolite KEGG:C09149 Eburnamonine generic -metabolite KEGG:C09150 17-Oxogrindelic acid generic -metabolite KEGG:C09151 Palmarin generic -metabolite KEGG:C09152 Echitamine generic -metabolite KEGG:C09153 12-O-Palmitoyl-16-hydroxyphorbol 13-acetate generic -metabolite KEGG:C09154 Ellipticine generic -metabolite KEGG:C09155 Phorbol generic -metabolite KEGG:C09156 Epivoacorine generic -metabolite KEGG:C09157 Phorbol 12-tiglate 13-decanoate generic -metabolite KEGG:C09158 Calophyllolide generic -metabolite KEGG:C09159 (+)-Pimaric acid generic -metabolite KEGG:C09160 Ergine generic -metabolite KEGG:C09161 Pimelea factor P2 generic -metabolite KEGG:C09162 Ergocornine generic -metabolite KEGG:C09163 Pisiferic acid generic -metabolite KEGG:C09164 Ergocristine generic -metabolite KEGG:C09165 Chalepensin generic -metabolite KEGG:C09166 Plaunol B generic -metabolite KEGG:C09167 Ergosine generic -metabolite KEGG:C09168 Plaunol D generic -metabolite KEGG:C09169 Pleuromutilin generic -metabolite KEGG:C09170 Eseramine generic -metabolite KEGG:C09171 Podocarpic acid generic -metabolite KEGG:C09172 Podolactone B generic -metabolite KEGG:C09173 Podolide generic -metabolite KEGG:C09174 Ponalactone A generic -metabolite KEGG:C09175 Portulal generic -metabolite KEGG:C09176 Eseridine generic -metabolite KEGG:C09177 Premarrubiin generic -metabolite KEGG:C09178 Resiniferonol generic -metabolite KEGG:C09179 Resiniferatoxin generic -metabolite KEGG:C09180 Rhodojaponin IV generic -metabolite KEGG:C09181 Chartreusin generic -metabolite KEGG:C09182 Royleanone generic -metabolite KEGG:C09183 Sclareol generic -metabolite KEGG:C09184 Shikodonin generic -metabolite KEGG:C09185 Simplexin generic -metabolite KEGG:C09186 Sorgolactone generic -metabolite KEGG:C09187 Evodiamine generic -metabolite KEGG:C09188 Spruceanol generic -metabolite KEGG:C09189 Stevioside generic -metabolite KEGG:C09190 Strigol generic -metabolite KEGG:C09191 Fruticosonine generic -metabolite KEGG:C09192 Synaptolepis factor K1 generic -metabolite KEGG:C09193 Gabunamine generic -metabolite KEGG:C09194 Taxodione generic -metabolite KEGG:C09195 Gabunine generic -metabolite KEGG:C09196 Taxodone generic -metabolite KEGG:C09197 Geissoschizoline generic -metabolite KEGG:C09198 Terpenoid EA-I generic -metabolite KEGG:C09200 Geissospermine generic -metabolite KEGG:C09201 Tinyatoxin generic -metabolite KEGG:C09202 Tripdiolide generic -metabolite KEGG:C09203 Gelsemicine generic -metabolite KEGG:C09204 Triptolide generic -metabolite KEGG:C09205 Zoapatanol generic -metabolite KEGG:C09206 Cichoriin generic -metabolite KEGG:C09207 Gelsemine generic -metabolite KEGG:C09208 Haplophytine generic -metabolite KEGG:C09209 Harman generic -metabolite KEGG:C09210 (-)-Columbianetin generic -metabolite KEGG:C09211 Hodgkinsine generic -metabolite KEGG:C09212 11-Hydroxycanthin-6-one generic -metabolite KEGG:C09213 Hypaphorine generic -metabolite KEGG:C09214 Ibogaine generic -metabolite KEGG:C09215 Ibogamine generic -metabolite KEGG:C09216 Daphnoretin generic -metabolite KEGG:C09217 Isoajmaline generic -metabolite KEGG:C09218 Leurosidine generic -metabolite KEGG:C09219 Leurosine generic -metabolite KEGG:C09220 Mahanimbine generic -metabolite KEGG:C09221 Melosatin A generic -metabolite KEGG:C09222 Melosatin B generic -metabolite KEGG:C09223 Mesembrenone generic -metabolite KEGG:C09224 Mesembrine generic -metabolite KEGG:C09225 Mesembrinol generic -metabolite KEGG:C09226 Mitragynine generic -metabolite KEGG:C09227 Mitraphylline generic -metabolite KEGG:C09228 Murrayanine generic -metabolite KEGG:C09229 Ochrolifuanine A generic -metabolite KEGG:C09230 Olivacine generic -metabolite KEGG:C09231 Perlolyrine generic -metabolite KEGG:C09232 Physovenine generic -metabolite KEGG:C09233 Psychotridine generic -metabolite KEGG:C09234 Quadrigemine A generic -metabolite KEGG:C09235 (-)-Quebrachamine generic -metabolite KEGG:C09236 Rhyncophylline generic -metabolite KEGG:C09237 Roxburghine B generic -metabolite KEGG:C09238 Rutaecarpine generic -metabolite KEGG:C09239 Sarpagine generic -metabolite KEGG:C09240 Sempervirine generic -metabolite KEGG:C09241 Serpentine generic -metabolite KEGG:C09242 Tabernamine generic -metabolite KEGG:C09243 Tetrahydroharmine generic -metabolite KEGG:C09244 Tabersonine generic -metabolite KEGG:C09245 Thienodolin generic -metabolite KEGG:C09246 C-Toxiferine I generic -metabolite KEGG:C09247 Trichotomine generic -metabolite KEGG:C09248 Tubulosine generic -metabolite KEGG:C09249 Usambarensine generic -metabolite KEGG:C09250 Usambarine generic -metabolite KEGG:C09251 Vincamine generic -metabolite KEGG:C09252 Voacamine generic -metabolite KEGG:C09253 Vobasine generic -metabolite KEGG:C09254 Vobtusine generic -metabolite KEGG:C09255 Vomicine generic -metabolite KEGG:C09256 Yohimbine generic -metabolite KEGG:C09257 Decuroside III generic -metabolite KEGG:C09258 Decursin generic -metabolite KEGG:C09259 Decursinol generic -metabolite KEGG:C09260 Dihydrosamidin generic -metabolite KEGG:C09261 Disenecionyl cis-khellactone generic -metabolite KEGG:C09262 (3'R,4'R)-3'-Epoxyangeloyloxy-4'-acetoxy-3',4'-dihydroseselin generic -metabolite KEGG:C09263 Esculetin generic -metabolite KEGG:C09264 Esculin generic -metabolite KEGG:C09265 Fraxetin generic -metabolite KEGG:C09266 Fraxin generic -metabolite KEGG:C09267 Heliettin generic -metabolite KEGG:C09268 Herniarin generic -metabolite KEGG:C09269 Imperatorin generic -metabolite KEGG:C09270 Isosamidin generic -metabolite KEGG:C09271 Leptodactylone generic -metabolite KEGG:C09272 Libanorin generic -metabolite KEGG:C09273 Luvangetin generic -metabolite KEGG:C09274 Tabernanthine generic -metabolite KEGG:C09275 Mammeisin generic -metabolite KEGG:C09276 Marmesin generic -metabolite KEGG:C09277 Micromelin generic -metabolite KEGG:C09278 Nodakenetin generic -metabolite KEGG:C09279 Nodakenin generic -metabolite KEGG:C09280 Osthol generic -metabolite KEGG:C09281 Ostruthin generic -metabolite KEGG:C09282 Oxypeucedanin generic -metabolite KEGG:C09283 Peucedanin generic -metabolite KEGG:C09284 Peucenidin generic -metabolite KEGG:C09285 Pimpinellin generic -metabolite KEGG:C09286 Absinthin generic -metabolite KEGG:C09287 Achillin generic -metabolite KEGG:C09288 Acroptilin generic -metabolite KEGG:C09289 Alantolactone generic -metabolite KEGG:C09290 Alatolide generic -metabolite KEGG:C09291 Amaralin generic -metabolite KEGG:C09292 Ambrosin generic -metabolite KEGG:C09293 Angustibalin generic -metabolite KEGG:C09294 Anisatin generic -metabolite KEGG:C09295 Arbusculin A generic -metabolite KEGG:C09296 Archangelolide generic -metabolite KEGG:C09297 Arctiopicrin generic -metabolite KEGG:C09298 Arctolide generic -metabolite KEGG:C09299 Arnicolide A generic -metabolite KEGG:C09300 Aromaticin generic -metabolite KEGG:C09301 Artabsin generic -metabolite KEGG:C09302 Artecanin generic -metabolite KEGG:C09303 Arteglasin A generic -metabolite KEGG:C09304 Artemisiifolin generic -metabolite KEGG:C09305 Psoralen generic -metabolite KEGG:C09306 Sulfur dioxide generic -metabolite KEGG:C09307 Pteryxin generic -metabolite KEGG:C09308 Rutamarin generic -metabolite KEGG:C09309 Rutarin generic -metabolite KEGG:C09310 Samidin generic -metabolite KEGG:C09311 Scoparone generic -metabolite KEGG:C09312 Seselin generic -metabolite KEGG:C09313 5,6,7-Trimethoxycoumarin generic -metabolite KEGG:C09314 Trioxsalen generic -metabolite KEGG:C09315 Umbelliferone generic -metabolite KEGG:C09316 Visnadin generic -metabolite KEGG:C09317 Xanthyletin generic -metabolite KEGG:C09318 Abyssinone I generic -metabolite KEGG:C09319 Abyssinone V generic -metabolite KEGG:C09320 Afzelechin generic -metabolite KEGG:C09321 2'-Hydroxychalcone generic -metabolite KEGG:C09322 Actinodaphnine generic -metabolite KEGG:C09323 Adiantifoline generic -metabolite KEGG:C09324 (+)-Adlumine generic -metabolite KEGG:C09325 Aknadicine generic -metabolite KEGG:C09326 Alamarine generic -metabolite KEGG:C09327 Alangicine generic -metabolite KEGG:C09328 Alangimarckine generic -metabolite KEGG:C09329 Alangimarine generic -metabolite KEGG:C09330 Alangiside generic -metabolite KEGG:C09331 Alpinine generic -metabolite KEGG:C09332 THF-L-glutamate generic -metabolite KEGG:C09333 Amurensine generic -metabolite KEGG:C09334 Amurine generic -metabolite KEGG:C09335 Ancistrocladine generic -metabolite KEGG:C09336 Angoline generic -metabolite KEGG:C09337 Ankorine generic -metabolite KEGG:C09338 Annolobine generic -metabolite KEGG:C09339 (-)-Annonaine generic -metabolite KEGG:C09340 (-)-Apoglaziovine generic -metabolite KEGG:C09341 (-)-Argemonine generic -metabolite KEGG:C09342 Armepavine generic -metabolite KEGG:C09343 Atheroline generic -metabolite KEGG:C09344 Artemisin generic -metabolite KEGG:C09345 Artemorin generic -metabolite KEGG:C09346 Autumnolide generic -metabolite KEGG:C09347 Atherospermidine generic -metabolite KEGG:C09348 6,7-Dimethoxyisoquinoline generic -metabolite KEGG:C09349 Baileyin generic -metabolite KEGG:C09350 Bakkenolide A generic -metabolite KEGG:C09351 Budlein A generic -metabolite KEGG:C09352 (+)-Bebeerine generic -metabolite KEGG:C09353 Calaxin generic -metabolite KEGG:C09354 Canin generic -metabolite KEGG:C09355 Chamissonin generic -metabolite KEGG:C09356 Chamissonin diacetate generic -metabolite KEGG:C09357 Berbamine generic -metabolite KEGG:C09358 Chlorochrymorin generic -metabolite KEGG:C09359 Chlorohyssopifolin A generic -metabolite KEGG:C09360 Berberastine generic -metabolite KEGG:C09361 Chromolaenide generic -metabolite KEGG:C09362 Cnicin generic -metabolite KEGG:C09363 Conchosin A generic -metabolite KEGG:C09364 Bicuculline generic -metabolite KEGG:C09365 Boldine generic -metabolite KEGG:C09366 Bracteoline generic -metabolite KEGG:C09367 Bulbocapnine generic -metabolite KEGG:C09368 (-)-Caaverine generic -metabolite KEGG:C09369 Calafatimine generic -metabolite KEGG:C09370 Cancentrine generic -metabolite KEGG:C09371 Capaurine generic -metabolite KEGG:C09372 Capnoidine generic -metabolite KEGG:C09373 Conchosin B generic -metabolite KEGG:C09374 Confertiflorin generic -metabolite KEGG:C09375 (+-)-Carnegine generic -metabolite KEGG:C09376 Confertifolin generic -metabolite KEGG:C09377 Caseadine generic -metabolite KEGG:C09378 Confertin generic -metabolite KEGG:C09379 Coriamyrtin generic -metabolite KEGG:C09380 Cassythine generic -metabolite KEGG:C09381 Coronopilin generic -metabolite KEGG:C09382 Costunolide generic -metabolite KEGG:C09383 alpha-Cyclocostunolide generic -metabolite KEGG:C09384 beta-Cyclocostunolide generic -metabolite KEGG:C09385 Cynaropicrin generic -metabolite KEGG:C09386 Damsin generic -metabolite KEGG:C09387 Dehydrocostus lactone generic -metabolite KEGG:C09388 Deoxyelephantopin generic -metabolite KEGG:C09389 (+)-Cassythicine generic -metabolite KEGG:C09390 Cephaeline generic -metabolite KEGG:C09391 Cepharanthine generic -metabolite KEGG:C09392 8-Deoxylactucin generic -metabolite KEGG:C09393 Corpaine generic -metabolite KEGG:C09394 Desacetoxymatricarin generic -metabolite KEGG:C09395 Deacetyleupaserrin generic -metabolite KEGG:C09396 Dihydrogriesenin generic -metabolite KEGG:C09397 Dihydromikanolide generic -metabolite KEGG:C09398 Cularicine generic -metabolite KEGG:C09399 Drimenin generic -metabolite KEGG:C09400 Cularidine generic -metabolite KEGG:C09401 Eleganin generic -metabolite KEGG:C09402 Elephantin generic -metabolite KEGG:C09403 Elephantopin generic -metabolite KEGG:C09404 Encelin generic -metabolite KEGG:C09405 Enhydrin generic -metabolite KEGG:C09406 Eremanthin generic -metabolite KEGG:C09407 Eremantholide A generic -metabolite KEGG:C09408 Eremofrullanolide generic -metabolite KEGG:C09409 Eremophilenolide generic -metabolite KEGG:C09410 Cularimine generic -metabolite KEGG:C09411 Cularine generic -metabolite KEGG:C09412 Erioflorin acetate generic -metabolite KEGG:C09413 Erioflorin methacrylate generic -metabolite KEGG:C09414 Eriolangin generic -metabolite KEGG:C09415 Daphnandrine generic -metabolite KEGG:C09416 Eupachlorin generic -metabolite KEGG:C09417 Eupachlorin acetate generic -metabolite KEGG:C09418 Daphnoline generic -metabolite KEGG:C09419 Dauricine generic -metabolite KEGG:C09420 Emetamine generic -metabolite KEGG:C09421 Emetine generic -metabolite KEGG:C09422 Erysonine generic -metabolite KEGG:C09423 Erysotrine generic -metabolite KEGG:C09424 Erythratidine generic -metabolite KEGG:C09425 Eupachloroxin generic -metabolite KEGG:C09426 Eschscholtzidine generic -metabolite KEGG:C09427 Eupacunin generic -metabolite KEGG:C09428 Eupacunolin generic -metabolite KEGG:C09429 Eupacunoxin generic -metabolite KEGG:C09430 Fagaridine generic -metabolite KEGG:C09431 Eupaformonin generic -metabolite KEGG:C09432 Eupaformosanin generic -metabolite KEGG:C09433 Eupahyssopin generic -metabolite KEGG:C09434 Euparotin generic -metabolite KEGG:C09435 Euparotin acetate generic -metabolite KEGG:C09436 Eupaserrin generic -metabolite KEGG:C09437 Eupatocunin generic -metabolite KEGG:C09438 Fagaronine generic -metabolite KEGG:C09439 Eupatocunoxin generic -metabolite KEGG:C09440 Eupatolide generic -metabolite KEGG:C09441 Fetidine generic -metabolite KEGG:C09442 Eupatoriopicrin generic -metabolite KEGG:C09443 Eupatoroxin generic -metabolite KEGG:C09444 Fumaricine generic -metabolite KEGG:C09445 Gigantine generic -metabolite KEGG:C09446 Glaucine generic -metabolite KEGG:C09447 10-epi-Eupatoroxin generic -metabolite KEGG:C09448 Eupatundin generic -metabolite KEGG:C09449 Euponin generic -metabolite KEGG:C09450 Farinosin generic -metabolite KEGG:C09451 Fastigilin B generic -metabolite KEGG:C09452 Fastigilin C generic -metabolite KEGG:C09453 Florilenalin generic -metabolite KEGG:C09454 Frullanolide generic -metabolite KEGG:C09455 Gaillardin generic -metabolite KEGG:C09456 Geigerin generic -metabolite KEGG:C09457 Glaziovine generic -metabolite KEGG:C09458 Gyrocarpine generic -metabolite KEGG:C09459 Hasubanonine generic -metabolite KEGG:C09460 Heliamine generic -metabolite KEGG:C09461 Hernandezine generic -metabolite KEGG:C09462 (-)-alpha-Hydrastine generic -metabolite KEGG:C09463 Glaucolide A generic -metabolite KEGG:C09464 Ipecoside generic -metabolite KEGG:C09465 Glaucolide B generic -metabolite KEGG:C09466 Glechomanolide generic -metabolite KEGG:C09467 Goyazensolide generic -metabolite KEGG:C09468 Gradolide generic -metabolite KEGG:C09469 Graminiliatrin generic -metabolite KEGG:C09470 Granilin generic -metabolite KEGG:C09471 Asebogenin generic -metabolite KEGG:C09472 Grosshemin generic -metabolite KEGG:C09473 Helenalin generic -metabolite KEGG:C09474 Heliangin generic -metabolite KEGG:C09475 Hiyodorilactone A generic -metabolite KEGG:C09476 7alpha-Hydroxydehydrocostus lactone generic -metabolite KEGG:C09477 Hydroxyvernolide generic -metabolite KEGG:C09478 Auriculoside generic -metabolite KEGG:C09479 Betagarin generic -metabolite KEGG:C09480 Hymenoflorin generic -metabolite KEGG:C09481 Hymenolin generic -metabolite KEGG:C09482 Hymenoxon generic -metabolite KEGG:C09483 Inulicin generic -metabolite KEGG:C09484 Isoalantolactone generic -metabolite KEGG:C09485 Isohelenol generic -metabolite KEGG:C09486 Isomontanolide generic -metabolite KEGG:C09487 Isotenulin generic -metabolite KEGG:C09488 Ivalin generic -metabolite KEGG:C09489 Lactucin generic -metabolite KEGG:C09490 Lactupicrin generic -metabolite KEGG:C09491 Laserolide generic -metabolite KEGG:C09492 Laurenobiolide generic -metabolite KEGG:C09493 Liatrin generic -metabolite KEGG:C09494 Ligulatin B generic -metabolite KEGG:C09495 Linderane generic -metabolite KEGG:C09496 Linifolin A generic -metabolite KEGG:C09497 Lipiferolide generic -metabolite KEGG:C09498 Ludovicin A generic -metabolite KEGG:C09499 Matricin generic -metabolite KEGG:C09500 Melampodin A generic -metabolite KEGG:C09501 Melampodinin generic -metabolite KEGG:C09502 Mellitoxin generic -metabolite KEGG:C09503 Mexicanin E generic -metabolite KEGG:C09504 Mexicanin I generic -metabolite KEGG:C09505 Broussin generic -metabolite KEGG:C09506 Michelenolide generic -metabolite KEGG:C09507 Micheliolide generic -metabolite KEGG:C09508 Microhelenin A generic -metabolite KEGG:C09509 Microhelenin C generic -metabolite KEGG:C09510 Microlenin generic -metabolite KEGG:C09511 Mikanolide generic -metabolite KEGG:C09512 Molephantin generic -metabolite KEGG:C09513 Molephantinin generic -metabolite KEGG:C09514 Multigilin generic -metabolite KEGG:C09515 Multiradiatin generic -metabolite KEGG:C09516 Multistatin generic -metabolite KEGG:C09517 Niveusin C generic -metabolite KEGG:C09518 Nobilin generic -metabolite KEGG:C09519 Oblongolide generic -metabolite KEGG:C09520 Onopordopicrin generic -metabolite KEGG:C09521 Orizabin generic -metabolite KEGG:C09522 Ovatifolin generic -metabolite KEGG:C09523 Parthenin generic -metabolite KEGG:C09524 Broussonin C generic -metabolite KEGG:C09525 Paucin generic -metabolite KEGG:C09526 1-Peroxyferolide generic -metabolite KEGG:C09527 Phantomolin generic -metabolite KEGG:C09528 Picrotin generic -metabolite KEGG:C09529 Picrotoxinin generic -metabolite KEGG:C09530 Pleniradin generic -metabolite KEGG:C09531 Plenolin generic -metabolite KEGG:C09532 Polhovolide generic -metabolite KEGG:C09533 Provincialin generic -metabolite KEGG:C09534 Pseudoivalin generic -metabolite KEGG:C09535 Pycnolide generic -metabolite KEGG:C09536 Pyrethrosin generic -metabolite KEGG:C09537 Quadrone generic -metabolite KEGG:C09538 Qing Hau Sau generic -metabolite KEGG:C09539 Radiatin generic -metabolite KEGG:C09540 Ridentin generic -metabolite KEGG:C09541 (S)-Isoboldine generic -metabolite KEGG:C09542 Salonitenolide generic -metabolite KEGG:C09543 Isochondrodendrine generic -metabolite KEGG:C09544 Santamarin generic -metabolite KEGG:C09545 beta-Santonin generic -metabolite KEGG:C09546 Isococculidine generic -metabolite KEGG:C09547 Saupirin generic -metabolite KEGG:C09548 Scorpioidin generic -metabolite KEGG:C09549 Isocorydine generic -metabolite KEGG:C09550 Isothebaine generic -metabolite KEGG:C09551 Spicatin generic -metabolite KEGG:C09552 Stramonin B generic -metabolite KEGG:C09553 Jatrorrhizine generic -metabolite KEGG:C09554 Tagitinin F generic -metabolite KEGG:C09555 (-)-Laudanidine generic -metabolite KEGG:C09556 Tamaulipin A generic -metabolite KEGG:C09557 Tenulin generic -metabolite KEGG:C09558 Laudanosine generic -metabolite KEGG:C09559 Tetraneurin A generic -metabolite KEGG:C09560 Tetraneurin E generic -metabolite KEGG:C09561 Thapsigargin generic -metabolite KEGG:C09562 Tomentosin generic -metabolite KEGG:C09563 Trilobolide generic -metabolite KEGG:C09564 Tulipinolide generic -metabolite KEGG:C09565 Laurifine generic -metabolite KEGG:C09566 epi-Tulipinolide generic -metabolite KEGG:C09567 Liriodenine generic -metabolite KEGG:C09568 epi-Tulipinolide diepoxide generic -metabolite KEGG:C09569 Longifolonine generic -metabolite KEGG:C09570 Tutin generic -metabolite KEGG:C09571 Lophocerine generic -metabolite KEGG:C09572 Ursiniolide A generic -metabolite KEGG:C09573 Lophophorine generic -metabolite KEGG:C09574 Vermeerin generic -metabolite KEGG:C09575 (+)-Luguine generic -metabolite KEGG:C09576 Vernodalin generic -metabolite KEGG:C09577 Vernodalol generic -metabolite KEGG:C09578 Vernoflexin generic -metabolite KEGG:C09579 Vernoflexuoside generic -metabolite KEGG:C09580 Macoline generic -metabolite KEGG:C09581 Magnoflorine generic -metabolite KEGG:C09582 Vernolepin generic -metabolite KEGG:C09583 Vernolide generic -metabolite KEGG:C09584 Vernomenin generic -metabolite KEGG:C09585 Vernomygdin generic -metabolite KEGG:C09586 Viguiestenin generic -metabolite KEGG:C09587 Viscidulin B generic -metabolite KEGG:C09588 Mecambrine generic -metabolite KEGG:C09589 (+)-Mecambroline generic -metabolite KEGG:C09590 Thalmidine generic -metabolite KEGG:C09591 Narceine generic -metabolite KEGG:C09592 alpha-Narcotine generic -metabolite KEGG:C09593 Narcotoline generic -metabolite KEGG:C09594 Neopine generic -metabolite KEGG:C09595 Nitidine generic -metabolite KEGG:C09596 Obaberine generic -metabolite KEGG:C09597 Ochotensine generic -metabolite KEGG:C09598 Oxyacanthine generic -metabolite KEGG:C09599 Parfumine generic -metabolite KEGG:C09600 Vulgarin generic -metabolite KEGG:C09601 Xanthatin generic -metabolite KEGG:C09602 Xanthinin generic -metabolite KEGG:C09603 Xanthumin generic -metabolite KEGG:C09604 (-)-Pellotine generic -metabolite KEGG:C09605 Xerantholide generic -metabolite KEGG:C09606 Zaluzanin C generic -metabolite KEGG:C09607 Zexbrevin B generic -metabolite KEGG:C09608 Phaeantharine generic -metabolite KEGG:C09609 Pilocereine generic -metabolite KEGG:C09610 Polycarpine generic -metabolite KEGG:C09611 (+)-Pronuciferine generic -metabolite KEGG:C09612 Psychotrine generic -metabolite KEGG:C09613 Pukateine generic -metabolite KEGG:C09614 Butin generic -metabolite KEGG:C09615 Pycnamine generic -metabolite KEGG:C09616 Butrin generic -metabolite KEGG:C09617 Catechin 7-O-beta-D-xyloside generic -metabolite KEGG:C09618 Davidigenin generic -metabolite KEGG:C09619 Rhoeadine generic -metabolite KEGG:C09621 (-)-alpha-Bisabolol generic -metabolite KEGG:C09622 Botrydial generic -metabolite KEGG:C09623 Buddledin A generic -metabolite KEGG:C09624 Rodiasine generic -metabolite KEGG:C09625 beta-Cadinene generic -metabolite KEGG:C09626 Canellal generic -metabolite KEGG:C09627 Capsidiol generic -metabolite KEGG:C09628 Carotol generic -metabolite KEGG:C09629 beta-Caryophyllene generic -metabolite KEGG:C09630 alpha-Cedrene generic -metabolite KEGG:C09631 alpha-Cedrol generic -metabolite KEGG:C09632 Centarol generic -metabolite KEGG:C09633 Chamazulene generic -metabolite KEGG:C09634 Rugosinone generic -metabolite KEGG:C09635 alpha-Chamigrene generic -metabolite KEGG:C09636 Diffutin generic -metabolite KEGG:C09637 beta-Chamigrene generic -metabolite KEGG:C09638 Cinnamodial generic -metabolite KEGG:C09639 alpha-Copaene generic -metabolite KEGG:C09640 (-)-Salsoline generic -metabolite KEGG:C09641 7,4'-Dihydroxyflavan generic -metabolite KEGG:C09642 (-)-Salsolinol generic -metabolite KEGG:C09643 Sinomenine generic -metabolite KEGG:C09644 2',6'-Dihydroxy-4'-methoxydihydrochalcone generic -metabolite KEGG:C09645 Cuauhtemone generic -metabolite KEGG:C09646 7,3'-Dihydroxy-4'-methoxy-8-methylflavan generic -metabolite KEGG:C09647 alpha-Cubebene generic -metabolite KEGG:C09648 beta-Cubebene generic -metabolite KEGG:C09649 alpha-Curcumene generic -metabolite KEGG:C09650 7,4'-Dihydroxy-8-methylflavan generic -metabolite KEGG:C09651 Cycloeudesmol generic -metabolite KEGG:C09652 Daucol generic -metabolite KEGG:C09653 Debneyol generic -metabolite KEGG:C09654 (+)-Tetrandrine generic -metabolite KEGG:C09655 Thalicarpine generic -metabolite KEGG:C09656 Thalidasine generic -metabolite KEGG:C09657 Dehydrojuvabione generic -metabolite KEGG:C09658 Dehydromyodesmone generic -metabolite KEGG:C09659 Thalmine generic -metabolite KEGG:C09660 Dehydrongaione generic -metabolite KEGG:C09661 Thalsimine generic -metabolite KEGG:C09662 Diacetoxyscirpenol generic -metabolite KEGG:C09663 alpha-Eudesmol generic -metabolite KEGG:C09664 beta-Eudesmol generic -metabolite KEGG:C09665 alpha-Farnesene generic -metabolite KEGG:C09666 beta-Farnesene generic -metabolite KEGG:C09667 Tiliacorine generic -metabolite KEGG:C09668 Fumagillin generic -metabolite KEGG:C09669 Trilobine generic -metabolite KEGG:C09670 Xylopine generic -metabolite KEGG:C09671 Xylopinine generic -metabolite KEGG:C09672 Germacrene B generic -metabolite KEGG:C09673 Glutinosone generic -metabolite KEGG:C09674 Graphinone generic -metabolite KEGG:C09675 Guaiazulene generic -metabolite KEGG:C09676 Guaiol generic -metabolite KEGG:C09677 Helminthosporal generic -metabolite KEGG:C09678 Helminthosporol generic -metabolite KEGG:C09679 Helminthosporoside A generic -metabolite KEGG:C09680 Hemigossypol generic -metabolite KEGG:C09681 Hernandulcin generic -metabolite KEGG:C09682 Himachalol generic -metabolite KEGG:C09683 Hirsutic acid C generic -metabolite KEGG:C09684 Humulene generic -metabolite KEGG:C09685 10beta-Hydroxy-6beta-isobutyrylfuranoeremophilane generic -metabolite KEGG:C09686 Hydroxyisopatchoulenone generic -metabolite KEGG:C09687 Illudin M generic -metabolite KEGG:C09688 Illudin S generic -metabolite KEGG:C09689 Ipomeamarone generic -metabolite KEGG:C09690 alpha-Irone generic -metabolite KEGG:C09691 Isocaryophyllene generic -metabolite KEGG:C09692 Isovelleral generic -metabolite KEGG:C09693 Juvabione generic -metabolite KEGG:C09694 Juvenile hormone III generic -metabolite KEGG:C09695 Lacinilene C 7-methyl ether generic -metabolite KEGG:C09696 Lactaroviolin generic -metabolite KEGG:C09697 Laserpitin generic -metabolite KEGG:C09698 Ledol generic -metabolite KEGG:C09699 Longifolene generic -metabolite KEGG:C09700 Lubimin generic -metabolite KEGG:C09701 Marasmic acid generic -metabolite KEGG:C09702 Mukaadial generic -metabolite KEGG:C09704 Nerolidol generic -metabolite KEGG:C09705 Patchouli alcohol generic -metabolite KEGG:C09706 Petasin generic -metabolite KEGG:C09707 Phaseic acid generic -metabolite KEGG:C09708 Phomenone generic -metabolite KEGG:C09709 Phytuberin generic -metabolite KEGG:C09710 Pinguisone generic -metabolite KEGG:C09711 Piperdial generic -metabolite KEGG:C09712 Polygodial generic -metabolite KEGG:C09714 Rhipocephalin generic -metabolite KEGG:C09715 Rishitin generic -metabolite KEGG:C09716 Roridin A generic -metabolite KEGG:C09717 Rugosal A generic -metabolite KEGG:C09718 beta-Santalene generic -metabolite KEGG:C09719 alpha-Santalol generic -metabolite KEGG:C09720 beta-Santalol generic -metabolite KEGG:C09721 Sclerosporin generic -metabolite KEGG:C09722 Seiricardine A generic -metabolite KEGG:C09723 beta-Selinene generic -metabolite KEGG:C09724 Lonchocarpol A generic -metabolite KEGG:C09725 Shiromodiol diacetate generic -metabolite KEGG:C09726 Dracorubin generic -metabolite KEGG:C09727 (-)-Epicatechin generic -metabolite KEGG:C09728 (+)-Epicatechin generic -metabolite KEGG:C09729 alpha-Sinensal generic -metabolite KEGG:C09730 beta-Sinensal generic -metabolite KEGG:C09731 Epigallocatechin 3-gallate generic -metabolite KEGG:C09732 Eriocitrin generic -metabolite KEGG:C09733 Sirenin generic -metabolite KEGG:C09734 Farrerol generic -metabolite KEGG:C09735 Fisetinidol generic -metabolite KEGG:C09736 Fisetinidol-4beta-ol generic -metabolite KEGG:C09737 Solavetivone generic -metabolite KEGG:C09738 T-2 Toxin generic -metabolite KEGG:C09739 Tetradymol generic -metabolite KEGG:C09740 Thujopsene generic -metabolite KEGG:C09741 Trichodermin generic -metabolite KEGG:C09742 Trichothecin generic -metabolite KEGG:C09743 Valerenic acid generic -metabolite KEGG:C09744 alpha-Vetivone generic -metabolite KEGG:C09745 beta-Vetivone generic -metabolite KEGG:C09746 Verrucarin A generic -metabolite KEGG:C09747 Vomitoxin generic -metabolite KEGG:C09748 Warburganal generic -metabolite KEGG:C09749 alpha-Ylangene generic -metabolite KEGG:C09750 Zingiberene generic -metabolite KEGG:C09751 Garbanzol generic -metabolite KEGG:C09752 Glabranin generic -metabolite KEGG:C09753 Glepidotin B generic -metabolite KEGG:C09754 Glycyphyllin generic -metabolite KEGG:C09755 Hesperidin generic -metabolite KEGG:C09756 Homoeriodictyol generic -metabolite KEGG:C09757 7-Hydroxyflavan generic -metabolite KEGG:C09758 Isochamaejasmin generic -metabolite KEGG:C09759 Isouvaretin generic -metabolite KEGG:C09760 Kazinol A generic -metabolite KEGG:C09761 Kolaflavanone generic -metabolite KEGG:C09762 Liquiritigenin generic -metabolite KEGG:C09763 Manniflavanone generic -metabolite KEGG:C09764 6-Methoxyaromadendrin 3-O-acetate generic -metabolite KEGG:C09765 Agnuside generic -metabolite KEGG:C09766 Allamandin generic -metabolite KEGG:C09767 Amarogentin generic -metabolite KEGG:C09768 Antirrhinoside generic -metabolite KEGG:C09769 Asperuloside generic -metabolite KEGG:C09770 6-Methoxytaxifolin generic -metabolite KEGG:C09771 Aucubin generic -metabolite KEGG:C09772 Boschnialactone generic -metabolite KEGG:C09773 Catalpol generic -metabolite KEGG:C09774 2'-O-Methylodoratol generic -metabolite KEGG:C09775 Catalposide generic -metabolite KEGG:C09776 Didrovaltratum generic -metabolite KEGG:C09777 Dolichodial generic -metabolite KEGG:C09778 Fulvoplumierin generic -metabolite KEGG:C09779 Gardenoside generic -metabolite KEGG:C09780 Genipin generic -metabolite KEGG:C09781 Geniposide generic -metabolite KEGG:C09782 Gentiopicrin generic -metabolite KEGG:C09783 Harpagoside generic -metabolite KEGG:C09784 Ipolamiide generic -metabolite KEGG:C09785 (+)-Iridodial generic -metabolite KEGG:C09786 Iridomyrmecin generic -metabolite KEGG:C09787 Isoplumericin generic -metabolite KEGG:C09788 Monotropein generic -metabolite KEGG:C09789 Naringin generic -metabolite KEGG:C09790 (+)-Neomatatabiol generic -metabolite KEGG:C09791 Nepetalactone cis-trans-form generic -metabolite KEGG:C09792 Nepetalactone trans-cis-form generic -metabolite KEGG:C09793 Narirutin generic -metabolite KEGG:C09794 Oleuropein generic -metabolite KEGG:C09795 Paederoside generic -metabolite KEGG:C09796 Plumericin generic -metabolite KEGG:C09797 Plumieride generic -metabolite KEGG:C09798 Scandoside methyl ester generic -metabolite KEGG:C09799 Specionin generic -metabolite KEGG:C09800 Swertiamarin generic -metabolite KEGG:C09801 Valtratum generic -metabolite KEGG:C09802 Verbenalin generic -metabolite KEGG:C09803 Neoastilbin generic -metabolite KEGG:C09804 cis-trans-Nepetalactol generic -metabolite KEGG:C09805 Neoeriocitrin generic -metabolite KEGG:C09806 Neohesperidin generic -metabolite KEGG:C09807 Odoratol generic -metabolite KEGG:C09808 Phellamurin generic -metabolite KEGG:C09809 Cyclohex-2,5-diene-1-carboxyl-CoA generic -metabolite KEGG:C09810 Cyclohex-1,4-diene-1-carboxyl-CoA generic -metabolite KEGG:C09811 Cyclohex-1-ene-1-carboxyl-CoA generic -metabolite KEGG:C09812 2-Hydroxycyclohexane-1-carboxyl-CoA generic -metabolite KEGG:C09813 2-Ketocyclohexane-1-carboxyl-CoA generic -metabolite KEGG:C09814 Benzonitrile generic -metabolite KEGG:C09815 Benzamide generic -metabolite KEGG:C09816 Benzylsuccinate generic -metabolite KEGG:C09817 Benzylsuccinyl-CoA generic -metabolite KEGG:C09818 E-Phenylitaconyl-CoA generic -metabolite KEGG:C09819 (Hydroxymethylphenyl)succinyl-CoA generic -metabolite KEGG:C09820 Benzoylsuccinyl-CoA generic -metabolite KEGG:C09821 6-Oxocyclohex-1-ene-1-carbonyl-CoA generic -metabolite KEGG:C09822 Cyclohexane-1-carboxylate generic -metabolite KEGG:C09823 Cyclohexane-1-carboxyl-CoA generic -metabolite KEGG:C09824 2,6-Dihydroxycyclohexane-1-carboxyl-CoA generic -metabolite KEGG:C09825 2-Hydroxy-6-oxocyclohexane-1-carbonyl-CoA generic -metabolite KEGG:C09826 Pinobanksin generic -metabolite KEGG:C09827 Pinocembrin generic -metabolite KEGG:C09828 Pinocembrin 7-rhamnosylglucoside generic -metabolite KEGG:C09829 Piperaduncin B generic -metabolite KEGG:C09830 Poncirin generic -metabolite KEGG:C09831 5'-Prenylhomoeriodictyol generic -metabolite KEGG:C09832 6-Prenylnaringenin generic -metabolite KEGG:C09833 Sakuranetin generic -metabolite KEGG:C09834 Sanggenon C generic -metabolite KEGG:C09835 Sanggenon D generic -metabolite KEGG:C09836 Ascaridole generic -metabolite KEGG:C09837 (1S,2R,4S)-(-)-Bornyl acetate generic -metabolite KEGG:C09839 Car-3-ene generic -metabolite KEGG:C09840 Carvacrol generic -metabolite KEGG:C09841 Carvone oxide generic -metabolite KEGG:C09842 Chrysanthemic acid generic -metabolite KEGG:C09843 Chrysanthenone generic -metabolite KEGG:C09844 1,8-Cineole generic -metabolite KEGG:C09845 Cinerin I generic -metabolite KEGG:C09846 Cinerin II generic -metabolite KEGG:C09847 cis-Citral generic -metabolite KEGG:C09848 (R)-(+)-Citronellal generic -metabolite KEGG:C09849 beta-Citronellol generic -metabolite KEGG:C09850 Acrifoline generic -metabolite KEGG:C09851 Annofoline generic -metabolite KEGG:C09852 Annotine generic -metabolite KEGG:C09853 1,2-Dihydroxymint lactone generic -metabolite KEGG:C09854 Diosphenol generic -metabolite KEGG:C09855 Annotinine generic -metabolite KEGG:C09856 Carolinianine generic -metabolite KEGG:C09858 Evodone generic -metabolite KEGG:C09859 Fenchone generic -metabolite KEGG:C09860 Cernuine generic -metabolite KEGG:C09861 Geranyl acetate generic -metabolite KEGG:C09862 Fawcettidine generic -metabolite KEGG:C09863 Linalyl acetate generic -metabolite KEGG:C09864 Fawcettimine generic -metabolite KEGG:C09865 Flabellidine generic -metabolite KEGG:C09866 Huperzine B generic -metabolite KEGG:C09867 Inundatine generic -metabolite KEGG:C09868 Menthofuran generic -metabolite KEGG:C09869 Lucidine B generic -metabolite KEGG:C09870 (-)-Menthyl acetate generic -metabolite KEGG:C09871 Nerol generic -metabolite KEGG:C09872 Luciduline generic -metabolite KEGG:C09873 (E)-beta-Ocimene generic -metabolite KEGG:C09874 Lycocernuine generic -metabolite KEGG:C09875 (R)-(-)-alpha-Phellandrene generic -metabolite KEGG:C09876 Lycodine generic -metabolite KEGG:C09877 (+)-beta-Phellandrene generic -metabolite KEGG:C09878 Lycofawcine generic -metabolite KEGG:C09879 Lycoflexine generic -metabolite KEGG:C09880 alpha-Pinene generic -metabolite KEGG:C09881 Lyconnotine generic -metabolite KEGG:C09882 beta-Pinene generic -metabolite KEGG:C09883 Lycopodine generic -metabolite KEGG:C09884 Pinocarvone generic -metabolite KEGG:C09885 (+)-Piperitone generic -metabolite KEGG:C09886 Magellanine generic -metabolite KEGG:C09887 Piquerol A generic -metabolite KEGG:C09888 Megastachine generic -metabolite KEGG:C09889 alpha-Obscurine generic -metabolite KEGG:C09890 beta-Obscurine generic -metabolite KEGG:C09891 Oxolucidine B generic -metabolite KEGG:C09892 Phlegmarine generic -metabolite KEGG:C09893 Pulegone generic -metabolite KEGG:C09894 Pyrethrin II generic -metabolite KEGG:C09895 Sauroxine generic -metabolite KEGG:C09896 Rotundifolone generic -metabolite KEGG:C09897 Selagine generic -metabolite KEGG:C09898 alpha-Terpinene generic -metabolite KEGG:C09899 Serratanidine generic -metabolite KEGG:C09900 gamma-Terpinene generic -metabolite KEGG:C09901 Serratine generic -metabolite KEGG:C09902 (R)-(+)-alpha-Terpineol generic -metabolite KEGG:C09903 Spirolucidine generic -metabolite KEGG:C09904 beta-Thujaplicin generic -metabolite KEGG:C09905 gamma-Thujaplicin generic -metabolite KEGG:C09906 Thujone generic -metabolite KEGG:C09907 Acanthicifoline generic -metabolite KEGG:C09908 Thymol generic -metabolite KEGG:C09909 Thymyl acetate generic -metabolite KEGG:C09910 Actinidine generic -metabolite KEGG:C09911 Umbellulone generic -metabolite KEGG:C09912 Arenaine generic -metabolite KEGG:C09913 Verbenone generic -metabolite KEGG:C09914 Bakankoside generic -metabolite KEGG:C09915 Boschniakine generic -metabolite KEGG:C09916 Acrovestone generic -metabolite KEGG:C09917 Arnebinol generic -metabolite KEGG:C09918 Aucuparin generic -metabolite KEGG:C09919 Bergenin generic -metabolite KEGG:C09920 Brazilin generic -metabolite KEGG:C09921 3-Butylidene-7-hydroxyphthalide generic -metabolite KEGG:C09922 Cleomiscosin A generic -metabolite KEGG:C09923 Cyperine generic -metabolite KEGG:C09924 Daphneticin generic -metabolite KEGG:C09925 5,6-Dehydrokawain generic -metabolite KEGG:C09926 Dihydromethysticin generic -metabolite KEGG:C09927 Euglobal-Ia1 generic -metabolite KEGG:C09928 Flossonol generic -metabolite KEGG:C09929 Garcinol generic -metabolite KEGG:C09930 Goniothalenol generic -metabolite KEGG:C09931 Haematoxylin generic -metabolite KEGG:C09932 Haemocorin generic -metabolite KEGG:C09933 Cantleyine generic -metabolite KEGG:C09934 Cassinine generic -metabolite KEGG:C09935 Catheduline E2 generic -metabolite KEGG:C09936 Heritonin generic -metabolite KEGG:C09937 Celapanine generic -metabolite KEGG:C09938 (+)-8-Hydroxycalamenene generic -metabolite KEGG:C09939 Strobopinin generic -metabolite KEGG:C09940 Chaksine generic -metabolite KEGG:C09941 Hypercalin B generic -metabolite KEGG:C09942 Karwinaphthol B generic -metabolite KEGG:C09943 Dendrobine generic -metabolite KEGG:C09944 Karwinskione generic -metabolite KEGG:C09945 Deoxynupharidine generic -metabolite KEGG:C09946 Enicoflavine generic -metabolite KEGG:C09947 Kawain generic -metabolite KEGG:C09948 Kolanone generic -metabolite KEGG:C09949 Fabianine generic -metabolite KEGG:C09950 Lapachenole generic -metabolite KEGG:C09951 Maclurin generic -metabolite KEGG:C09952 Methysticin generic -metabolite KEGG:C09953 Monocerin generic -metabolite KEGG:C09954 Nepodin generic -metabolite KEGG:C09955 Ochratoxin A generic -metabolite KEGG:C09956 Ohioensin-A generic -metabolite KEGG:C09957 Gentianadine generic -metabolite KEGG:C09958 Orthosporin generic -metabolite KEGG:C09959 Paeoniflorin generic -metabolite KEGG:C09960 Gentianaine generic -metabolite KEGG:C09961 Gentianamine generic -metabolite KEGG:C09962 Gentioflavine generic -metabolite KEGG:C09963 Polygonolide generic -metabolite KEGG:C09964 Purpurogallin generic -metabolite KEGG:C09965 Rhododendrin generic -metabolite KEGG:C09966 Robustadial A generic -metabolite KEGG:C09967 Taxifolin 3-O-acetate generic -metabolite KEGG:C09968 Robustaol A generic -metabolite KEGG:C09969 Sarothralin generic -metabolite KEGG:C09970 Tephrowatsin A generic -metabolite KEGG:C09971 Stypandrol generic -metabolite KEGG:C09972 Theasinensin A generic -metabolite KEGG:C09973 Tremulacin generic -metabolite KEGG:C09974 2,4,8-Trihydroxy-1-tetralone generic -metabolite KEGG:C09975 2',4',6'-Trihydroxy-3'-formyldihydrochalcone generic -metabolite KEGG:C09976 Uncinatone generic -metabolite KEGG:C09977 Vismione D generic -metabolite KEGG:C09978 Uvaretin generic -metabolite KEGG:C09979 Xanthochymol generic -metabolite KEGG:C09980 Yangonin generic -metabolite KEGG:C09981 Zearalenone generic -metabolite KEGG:C09982 Acerosin generic -metabolite KEGG:C09983 Zinnolide generic -metabolite KEGG:C09984 N-(p-Hydroxyphenethyl)actinidine generic -metabolite KEGG:C09985 Jasminine generic -metabolite KEGG:C09986 Rhexifoline generic -metabolite KEGG:C09987 beta-Skytanthine generic -metabolite KEGG:C09988 Tecomine generic -metabolite KEGG:C09989 Tecostanine generic -metabolite KEGG:C09990 Thiobinupharidine generic -metabolite KEGG:C09991 Valerianine generic -metabolite KEGG:C09992 Wilfordine generic -metabolite KEGG:C09993 Adouetine X generic -metabolite KEGG:C09994 Adouetine Y generic -metabolite KEGG:C09995 Adouetine Z generic -metabolite KEGG:C09996 Americine generic -metabolite KEGG:C09997 Amphibine A generic -metabolite KEGG:C09998 Amphibine B generic -metabolite KEGG:C09999 Aralionine A generic -metabolite KEGG:C10000 Canthiumine generic -metabolite KEGG:C10001 Ceanothine B generic -metabolite KEGG:C10002 Crenatine A generic -metabolite KEGG:C10003 Frangulanine generic -metabolite KEGG:C10004 Hymenocardine generic -metabolite KEGG:C10005 Integerrenine generic -metabolite KEGG:C10006 Integerressine generic -metabolite KEGG:C10007 Integerrine generic -metabolite KEGG:C10008 Lasiodine A generic -metabolite KEGG:C10009 Mucronine A generic -metabolite KEGG:C10010 Mucronine B generic -metabolite KEGG:C10011 Nummularine F generic -metabolite KEGG:C10012 Pandamine generic -metabolite KEGG:C10013 Sativanine B generic -metabolite KEGG:C10014 Scutianine F generic -metabolite KEGG:C10015 Zizyphine A generic -metabolite KEGG:C10016 Zizyphine F generic -metabolite KEGG:C10017 Agathisflavone generic -metabolite KEGG:C10018 Amentoflavone generic -metabolite KEGG:C10019 Apigenin 7,4'-dimethyl ether generic -metabolite KEGG:C10020 Apigenin 7-(6''-malonylglucoside) generic -metabolite KEGG:C10021 Axillarin generic -metabolite KEGG:C10022 Azaleatin generic -metabolite KEGG:C10023 Baicalein generic -metabolite KEGG:C10024 Baicalein 5,6,7-trimethyl ether generic -metabolite KEGG:C10025 Baicalin generic -metabolite KEGG:C10026 Carlinoside generic -metabolite KEGG:C10027 Chlorflavonin generic -metabolite KEGG:C10028 Chrysin generic -metabolite KEGG:C10029 5,7-Dimethoxyflavone generic -metabolite KEGG:C10030 Chrysosplenetin generic -metabolite KEGG:C10031 Chrysosplenol C generic -metabolite KEGG:C10032 Cirsilineol generic -metabolite KEGG:C10033 Cirsiliol generic -metabolite KEGG:C10034 Cupressuflavone generic -metabolite KEGG:C10035 Dasytrichone generic -metabolite KEGG:C10036 Datiscetin generic -metabolite KEGG:C10037 Resokaempherol generic -metabolite KEGG:C10038 Diosmetin generic -metabolite KEGG:C10039 Diosmin generic -metabolite KEGG:C10040 Eupatilin generic -metabolite KEGG:C10041 Fisetin generic -metabolite KEGG:C10042 Fisetin 8-C-glucoside generic -metabolite KEGG:C10043 Flavone generic -metabolite KEGG:C10044 Galangin generic -metabolite KEGG:C10045 3,5,7-Trimethoxyflavone generic -metabolite KEGG:C10046 Genkwanin generic -metabolite KEGG:C10047 Geraldone generic -metabolite KEGG:C10048 Ginkgetin generic -metabolite KEGG:C10049 Glepidotin A generic -metabolite KEGG:C10050 Gossypetin 8-rhamnoside generic -metabolite KEGG:C10051 Gossypin generic -metabolite KEGG:C10052 Athyriol generic -metabolite KEGG:C10053 Bellidifolin generic -metabolite KEGG:C10054 Calophyllin B generic -metabolite KEGG:C10055 Dehydrocycloguanandin generic -metabolite KEGG:C10056 Demethylbellidifolin generic -metabolite KEGG:C10057 Hinokiflavone generic -metabolite KEGG:C10058 Hispidulin generic -metabolite KEGG:C10059 6-Deoxyjacareubin generic -metabolite KEGG:C10060 3,5-Dimethoxy-1,6-dihydroxyxanthone generic -metabolite KEGG:C10061 Euxanthone generic -metabolite KEGG:C10062 Gambogic acid generic -metabolite KEGG:C10063 Gartanin generic -metabolite KEGG:C10064 Gentiacaulein generic -metabolite KEGG:C10065 Gentisein generic -metabolite KEGG:C10066 Gentisin generic -metabolite KEGG:C10067 Irisxanthone generic -metabolite KEGG:C10068 6-Hydroxykaempferol generic -metabolite KEGG:C10069 Isoathyriol generic -metabolite KEGG:C10070 Isogentisin generic -metabolite KEGG:C10071 1-Isomangostin generic -metabolite KEGG:C10072 6-Hydroxyluteolin generic -metabolite KEGG:C10073 Hyperin generic -metabolite KEGG:C10074 Jacareubin generic -metabolite KEGG:C10075 Lancerin generic -metabolite KEGG:C10076 Macluraxanthone generic -metabolite KEGG:C10077 Mangiferin generic -metabolite KEGG:C10078 Hypolaetin generic -metabolite KEGG:C10079 Isoetin generic -metabolite KEGG:C10080 Mangostin generic -metabolite KEGG:C10081 Mesuaxanthone A generic -metabolite KEGG:C10082 Mesuaxanthone B generic -metabolite KEGG:C10083 2-O-Methylswertianin generic -metabolite KEGG:C10084 Isorhamnetin generic -metabolite KEGG:C10085 Morellin generic -metabolite KEGG:C10086 Norathyriol generic -metabolite KEGG:C10087 Norlichexanthone generic -metabolite KEGG:C10088 Norswertianin generic -metabolite KEGG:C10089 Norswertianolin generic -metabolite KEGG:C10090 Psorospermin generic -metabolite KEGG:C10091 Swerchirin generic -metabolite KEGG:C10092 Swertianin generic -metabolite KEGG:C10093 Swertianolin generic -metabolite KEGG:C10094 1,3,5-Trihydroxyxanthone generic -metabolite KEGG:C10095 Tripteroside generic -metabolite KEGG:C10097 Isoscutellarein generic -metabolite KEGG:C10098 Kaempferide generic -metabolite KEGG:C10099 Kuwanone G generic -metabolite KEGG:C10100 Kuwanone H generic -metabolite KEGG:C10101 (-)-Usnic acid generic -metabolite KEGG:C10102 Lucenin-2 generic -metabolite KEGG:C10103 Luteolin 7-O-(6''-malonylglucoside) generic -metabolite KEGG:C10104 6-Methoxyluteolin 7-rhamnoside generic -metabolite KEGG:C10105 Morin generic -metabolite KEGG:C10106 Morusin generic -metabolite KEGG:C10107 Myricetin generic -metabolite KEGG:C10108 Myricitrin generic -metabolite KEGG:C10109 Neocarlinoside generic -metabolite KEGG:C10110 Neoschaftoside generic -metabolite KEGG:C10111 Nevadensin generic -metabolite KEGG:C10112 Nobiletin generic -metabolite KEGG:C10113 Norwogonin generic -metabolite KEGG:C10114 Orientin generic -metabolite KEGG:C10115 Oxyanin A generic -metabolite KEGG:C10116 Oxyanin B generic -metabolite KEGG:C10117 Pachypodol generic -metabolite KEGG:C10118 Patuletin generic -metabolite KEGG:C10119 Pedalitin generic -metabolite KEGG:C10120 Pinoquercetin generic -metabolite KEGG:C10121 Primetin generic -metabolite KEGG:C10122 Quercetagetin generic -metabolite KEGG:C10123 Adenocarpine generic -metabolite KEGG:C10124 Alexine generic -metabolite KEGG:C10125 Ammodendrine generic -metabolite KEGG:C10126 Anatabine generic -metabolite KEGG:C10127 Anibine generic -metabolite KEGG:C10128 Arecaidine generic -metabolite KEGG:C10129 Arecoline generic -metabolite KEGG:C10130 Astrocasine generic -metabolite KEGG:C10131 Astrophylline generic -metabolite KEGG:C10132 Australine generic -metabolite KEGG:C10133 Brunfelsamidine generic -metabolite KEGG:C10134 Buchananine generic -metabolite KEGG:C10135 Carpaine generic -metabolite KEGG:C10136 Cassine generic -metabolite KEGG:C10137 Codonopsine generic -metabolite KEGG:C10138 gamma-Coniceine generic -metabolite KEGG:C10139 Cryptophorine generic -metabolite KEGG:C10140 Cucurbitine generic -metabolite KEGG:C10141 Deoxymannojirimycin generic -metabolite KEGG:C10142 Dioscorine generic -metabolite KEGG:C10143 DMDP generic -metabolite KEGG:C10144 Fagomine generic -metabolite KEGG:C10145 Funebrine generic -metabolite KEGG:C10146 Fusaric acid generic -metabolite KEGG:C10147 Gerrardine generic -metabolite KEGG:C10148 Girgensonine generic -metabolite KEGG:C10149 Guvacine generic -metabolite KEGG:C10150 Harzianopyridone generic -metabolite KEGG:C10151 3-Hydroxystachydrine generic -metabolite KEGG:C10152 (-)-Hygroline generic -metabolite KEGG:C10153 Isolobinine generic -metabolite KEGG:C10154 Juliflorine generic -metabolite KEGG:C10155 Lentiginosine generic -metabolite KEGG:C10156 Lobelanidine generic -metabolite KEGG:C10157 Lobelanine generic -metabolite KEGG:C10158 Mearsine generic -metabolite KEGG:C10159 Methylconiine generic -metabolite KEGG:C10160 Myosmine generic -metabolite KEGG:C10161 Nicotyrine generic -metabolite KEGG:C10162 Nigrifactin generic -metabolite KEGG:C10163 Nitramine generic -metabolite KEGG:C10164 Picolinic acid generic -metabolite KEGG:C10165 Pinidine generic -metabolite KEGG:C10166 Piplartine generic -metabolite KEGG:C10167 (+)-Prosopinine generic -metabolite KEGG:C10168 Pseudoconhydrine generic -metabolite KEGG:C10169 Ruspolinone generic -metabolite KEGG:C10170 Santiaguine generic -metabolite KEGG:C10171 (-)-Sedamine generic -metabolite KEGG:C10172 Stachydrine generic -metabolite KEGG:C10173 Swainsonine generic -metabolite KEGG:C10174 Piperyline generic -metabolite KEGG:C10175 Quercetin 3-(2G-xylosylrutinoside) generic -metabolite KEGG:C10176 Rhamnetin generic -metabolite KEGG:C10177 Robinetin generic -metabolite KEGG:C10178 Robinin generic -metabolite KEGG:C10179 Robustaflavone generic -metabolite KEGG:C10180 Santin generic -metabolite KEGG:C10181 Schaftoside generic -metabolite KEGG:C10182 Sciadopitysin generic -metabolite KEGG:C10183 Scullcapflavone II generic -metabolite KEGG:C10184 Scutellarein generic -metabolite KEGG:C10185 Sexangularetin generic -metabolite KEGG:C10186 Sinensetin generic -metabolite KEGG:C10187 Swertiajaponin generic -metabolite KEGG:C10188 Tamarixetin generic -metabolite KEGG:C10189 Tambulin generic -metabolite KEGG:C10190 Tangeretin generic -metabolite KEGG:C10191 Thymonin generic -metabolite KEGG:C10192 Tricetin generic -metabolite KEGG:C10193 Tricin generic -metabolite KEGG:C10194 Velloquercetin generic -metabolite KEGG:C10195 Vicenin-2 generic -metabolite KEGG:C10196 Violanthin generic -metabolite KEGG:C10197 Wogonin generic -metabolite KEGG:C10198 (-)-Acanthocarpan generic -metabolite KEGG:C10199 Afrormosin generic -metabolite KEGG:C10200 Anhydroglycinol generic -metabolite KEGG:C10201 Betavulgarin generic -metabolite KEGG:C10202 Bowdichione generic -metabolite KEGG:C10203 Cajanin generic -metabolite KEGG:C10204 Cajanol generic -metabolite KEGG:C10205 Coumestrol generic -metabolite KEGG:C10206 Cristacarpin generic -metabolite KEGG:C10207 Cyclokievitone generic -metabolite KEGG:C10208 Daidzein generic -metabolite KEGG:C10209 Afzelechin-(4alpha->8)-afzelechin generic -metabolite KEGG:C10210 Agrimoniin generic -metabolite KEGG:C10211 Alnusiin generic -metabolite KEGG:C10212 Casuarictin generic -metabolite KEGG:C10213 Casuarinin generic -metabolite KEGG:C10214 Chebulagic acid generic -metabolite KEGG:C10215 Chebulinic acid generic -metabolite KEGG:C10216 Daidzin generic -metabolite KEGG:C10217 Cinchonain 1a generic -metabolite KEGG:C10218 Coriariin A generic -metabolite KEGG:C10219 Corilagin generic -metabolite KEGG:C10220 3,5-Di-O-galloyl-4-O-digalloylquinic acid generic -metabolite KEGG:C10221 Epicatechin-(4beta->8)-ent-epicatechin generic -metabolite KEGG:C10222 Cinnamtannin A4 generic -metabolite KEGG:C10223 Epigallocatechin-(4beta->8)-epicatechin-3-O-gallate ester generic -metabolite KEGG:C10224 Eugeniin generic -metabolite KEGG:C10225 ent-Fisetinidol-(4beta->8)-catechin-(6->4beta)-ent-fisetinidol generic -metabolite KEGG:C10226 Fucofuroeckol B generic -metabolite KEGG:C10227 Gallocatechin-(4alpha->8)-epigallocatechin generic -metabolite KEGG:C10228 Gambiriin C generic -metabolite KEGG:C10229 Gemin A generic -metabolite KEGG:C10230 Geraniin generic -metabolite KEGG:C10231 Guibourtinidol-(4alpha->6)-catechin generic -metabolite KEGG:C10232 Isoterchebin generic -metabolite KEGG:C10233 Kandelin A-1 generic -metabolite KEGG:C10234 Mahuannin D generic -metabolite KEGG:C10235 Mallotusinic acid generic -metabolite KEGG:C10236 Pedunculagin generic -metabolite KEGG:C10237 Proanthocyanidin A2 generic -metabolite KEGG:C10238 Procyanidin B4 generic -metabolite KEGG:C10239 Robinetinidol-(4alpha->8)-catechin-(6->4alpha)-robinetinidol generic -metabolite KEGG:C10240 Rugosin D generic -metabolite KEGG:C10241 Tellimagrandin I generic -metabolite KEGG:C10242 Terminalin generic -metabolite KEGG:C10243 1,2,3,4-Tetragalloyl-alpha-D-glucose generic -metabolite KEGG:C10244 Agrostophyllin generic -metabolite KEGG:C10245 Astringin generic -metabolite KEGG:C10246 Batatasin I generic -metabolite KEGG:C10247 Batatasin IV generic -metabolite KEGG:C10248 Blestriarene B generic -metabolite KEGG:C10249 Canaliculatol generic -metabolite KEGG:C10250 Chlorophorin generic -metabolite KEGG:C10251 Coelogin generic -metabolite KEGG:C10252 Copalliferol B generic -metabolite KEGG:C10253 Demethylbatatasin IV generic -metabolite KEGG:C10254 Dihydropinosylvin generic -metabolite KEGG:C10255 Dihydroresveratrol generic -metabolite KEGG:C10256 4,4'-Dihydroxy-3,5-dimethoxydihydrostilbene generic -metabolite KEGG:C10257 4,7-Dihydroxy-2-methoxy-9,10-dihydrophenanthrene generic -metabolite KEGG:C10258 Flavidin generic -metabolite KEGG:C10259 Glepidotin C generic -metabolite KEGG:C10260 Gnetin A generic -metabolite KEGG:C10261 Hircinol generic -metabolite KEGG:C10262 Hydrangenol generic -metabolite KEGG:C10263 Amabiline generic -metabolite KEGG:C10264 3-Hydroxy-5-methoxy-6-prenylstilbene-2-carboxylic acid generic -metabolite KEGG:C10265 Isobatatasin I generic -metabolite KEGG:C10266 Isorhapontin generic -metabolite KEGG:C10267 Loroglossol generic -metabolite KEGG:C10268 Lunularic acid generic -metabolite KEGG:C10269 Lunularin generic -metabolite KEGG:C10270 Marchantin A generic -metabolite KEGG:C10271 3'-O-Methylbatatasin III generic -metabolite KEGG:C10272 Orchinol generic -metabolite KEGG:C10273 Oxyresveratrol generic -metabolite KEGG:C10274 Phyllodulcin generic -metabolite KEGG:C10275 Piceid generic -metabolite KEGG:C10276 Pinosylvin methyl ether generic -metabolite KEGG:C10277 Anacrotine generic -metabolite KEGG:C10278 O-7-Angelylheliotridine generic -metabolite KEGG:C10279 Angularine generic -metabolite KEGG:C10280 Auriculine generic -metabolite KEGG:C10281 4-Prenyldihydropinosylvin generic -metabolite KEGG:C10282 Clivoline generic -metabolite KEGG:C10283 4'-Prenyloxyresveratrol generic -metabolite KEGG:C10284 Crotanecine generic -metabolite KEGG:C10285 4-Prenylresveratrol generic -metabolite KEGG:C10286 Doronine generic -metabolite KEGG:C10287 Pterostilbene generic -metabolite KEGG:C10288 Rhaponticin generic -metabolite KEGG:C10289 epsilon-Viniferin generic -metabolite KEGG:C10290 Acamelin generic -metabolite KEGG:C10291 Alizarin 2-methyl ether generic -metabolite KEGG:C10292 Alkannin generic -metabolite KEGG:C10293 Alkannin beta,beta-dimethylacrylate generic -metabolite KEGG:C10294 Aloe-emodin generic -metabolite KEGG:C10295 Alteichin generic -metabolite KEGG:C10296 Altersolanol A generic -metabolite KEGG:C10297 Anthragallol generic -metabolite KEGG:C10298 Ardisianone generic -metabolite KEGG:C10299 Echimidine generic -metabolite KEGG:C10300 Aristolindiquinone generic -metabolite KEGG:C10301 Europine generic -metabolite KEGG:C10302 Arnebinone generic -metabolite KEGG:C10303 Aurantio-obtusin beta-D-glucoside generic -metabolite KEGG:C10304 Fulvine generic -metabolite KEGG:C10305 Barbaloin generic -metabolite KEGG:C10306 Bikaverin generic -metabolite KEGG:C10307 Cascaroside A generic -metabolite KEGG:C10308 Cassiamin C generic -metabolite KEGG:C10309 Cercosporin generic -metabolite KEGG:C10310 Chimaphylin generic -metabolite KEGG:C10311 7-Chloroemodin generic -metabolite KEGG:C10312 Danthron generic -metabolite KEGG:C10313 Chryso-obtusin glucoside generic -metabolite KEGG:C10314 Chrysophanic acid 9-anthrone generic -metabolite KEGG:C10315 Chrysophanol generic -metabolite KEGG:C10316 Chrysophanol 8-O-beta-D-glucoside generic -metabolite KEGG:C10317 Coleone A generic -metabolite KEGG:C10318 Conocurvone generic -metabolite KEGG:C10319 Heliosupine generic -metabolite KEGG:C10320 Cornudentanone generic -metabolite KEGG:C10321 Heliotridine generic -metabolite KEGG:C10322 Cyperaquinone generic -metabolite KEGG:C10323 Cypripedin generic -metabolite KEGG:C10324 Heliotrine generic -metabolite KEGG:C10325 Deoxylapachol generic -metabolite KEGG:C10326 Indicine generic -metabolite KEGG:C10327 Digiferrugineol generic -metabolite KEGG:C10328 Integerrimine generic -metabolite KEGG:C10329 1,4-Dihydroxy-2-methylanthraquinone generic -metabolite KEGG:C10330 Intermedine generic -metabolite KEGG:C10331 2,6-Dimethoxybenzoquinone generic -metabolite KEGG:C10332 Diospyrin generic -metabolite KEGG:C10333 Isatidine generic -metabolite KEGG:C10334 Dothistromin generic -metabolite KEGG:C10335 Droserone generic -metabolite KEGG:C10336 Isolycopsamine generic -metabolite KEGG:C10337 Dunnione generic -metabolite KEGG:C10338 Echinone generic -metabolite KEGG:C10339 Jacobine generic -metabolite KEGG:C10340 Eleutherin generic -metabolite KEGG:C10341 Lasiocarpine generic -metabolite KEGG:C10342 Embelin generic -metabolite KEGG:C10343 Emodin generic -metabolite KEGG:C10344 Latifoline generic -metabolite KEGG:C10345 Emodin 8-glucoside generic -metabolite KEGG:C10346 Frangulin A generic -metabolite KEGG:C10347 Lycopsamine generic -metabolite KEGG:C10348 Macrophylline generic -metabolite KEGG:C10349 Frangulin B generic -metabolite KEGG:C10350 Monocrotaline generic -metabolite KEGG:C10351 Geranylbenzoquinone generic -metabolite KEGG:C10352 Hibiscoquinone A generic -metabolite KEGG:C10353 Nemorensine generic -metabolite KEGG:C10354 2-Hydroxymethylanthraquinone generic -metabolite KEGG:C10355 Hypoxylone generic -metabolite KEGG:C10356 Otonecine generic -metabolite KEGG:C10357 Parsonsine generic -metabolite KEGG:C10358 Isodiospyrin generic -metabolite KEGG:C10359 Petasitenine generic -metabolite KEGG:C10360 2-Isoprenylemodin generic -metabolite KEGG:C10361 Phalaenopsine T generic -metabolite KEGG:C10362 Kigelinone generic -metabolite KEGG:C10363 Platyphylline generic -metabolite KEGG:C10364 Retrorsine generic -metabolite KEGG:C10365 Knipholone generic -metabolite KEGG:C10366 Lapachol generic -metabolite KEGG:C10367 beta-Lapachone generic -metabolite KEGG:C10368 Lawsone generic -metabolite KEGG:C10369 Lucidin generic -metabolite KEGG:C10370 Lucidin omega-methyl ether generic -metabolite KEGG:C10371 Mansonone C generic -metabolite KEGG:C10372 9-Methoxy-alpha-lapachone generic -metabolite KEGG:C10373 5-O-Methylembelin generic -metabolite KEGG:C10374 Morindaparvin A generic -metabolite KEGG:C10375 Riddelline generic -metabolite KEGG:C10376 Morindone generic -metabolite KEGG:C10377 Nanafrocin generic -metabolite KEGG:C10378 Rinderine generic -metabolite KEGG:C10379 Norobtusifolin generic -metabolite KEGG:C10380 Rosmarinine generic -metabolite KEGG:C10381 Obtusifolin 2-glucoside generic -metabolite KEGG:C10382 Physcion 8-gentiobioside generic -metabolite KEGG:C10383 Sarracine generic -metabolite KEGG:C10384 Physcion 8-glucoside generic -metabolite KEGG:C10385 Plastoquinone-9 generic -metabolite KEGG:C10386 Senaetnine generic -metabolite KEGG:C10387 Plumbagin generic -metabolite KEGG:C10388 Senampeline A generic -metabolite KEGG:C10389 Prenylbenzoquinone generic -metabolite KEGG:C10390 Primin generic -metabolite KEGG:C10391 Seneciphylline generic -metabolite KEGG:C10392 Pseudohypericin generic -metabolite KEGG:C10393 Senecivernine generic -metabolite KEGG:C10394 Pseudopurpurin generic -metabolite KEGG:C10395 Purpurin generic -metabolite KEGG:C10396 Senkirkine generic -metabolite KEGG:C10397 Purpurin 1-methyl ether generic -metabolite KEGG:C10398 Ramentaceone generic -metabolite KEGG:C10399 Rapanone generic -metabolite KEGG:C10400 Supinidine generic -metabolite KEGG:C10401 Rhein generic -metabolite KEGG:C10402 Rubiadin generic -metabolite KEGG:C10403 Supinine generic -metabolite KEGG:C10404 Sennoside A generic -metabolite KEGG:C10405 Tectoquinone generic -metabolite KEGG:C10406 Tricrozarin A generic -metabolite KEGG:C10407 Ventinone A generic -metabolite KEGG:C10408 Symlandine generic -metabolite KEGG:C10409 Symphytine generic -metabolite KEGG:C10410 Triangularine generic -metabolite KEGG:C10411 Tussilagine generic -metabolite KEGG:C10412 Uplandicine generic -metabolite KEGG:C10413 Usaramine generic -metabolite KEGG:C10414 Dalbergin generic -metabolite KEGG:C10415 (+-)-Dalbergioidin generic -metabolite KEGG:C10416 Dalpanin generic -metabolite KEGG:C10417 Deguelin generic -metabolite KEGG:C10418 5-Deoxykievitone generic -metabolite KEGG:C10419 Ferreirin generic -metabolite KEGG:C10420 Genistein 8-C-glucoside generic -metabolite KEGG:C10421 Glabridin generic -metabolite KEGG:C10422 (-)-Glyceollin II generic -metabolite KEGG:C10424 Hildecarpin generic -metabolite KEGG:C10425 Hispaglabridin A generic -metabolite KEGG:C10426 1'-Acetoxychavicol acetate generic -metabolite KEGG:C10427 1'-Acetoxyeugenol acetate generic -metabolite KEGG:C10428 Anethole generic -metabolite KEGG:C10429 Apiole generic -metabolite KEGG:C10430 beta-Asarone generic -metabolite KEGG:C10431 Caffeic acid 3-glucoside generic -metabolite KEGG:C10432 1-Caffeoyl-4-deoxyquinic acid generic -metabolite KEGG:C10433 1-Caffeoyl-beta-D-glucose generic -metabolite KEGG:C10434 5-O-Caffeoylshikimic acid generic -metabolite KEGG:C10435 Carpacin generic -metabolite KEGG:C10436 Centrolobine generic -metabolite KEGG:C10437 Chicoric acid generic -metabolite KEGG:C10438 Cinnamic acid generic -metabolite KEGG:C10439 4'-Cinnamoylmussatioside generic -metabolite KEGG:C10441 4-p-Coumaroylquinic acid generic -metabolite KEGG:C10443 Curcumin generic -metabolite KEGG:C10444 3'-Demethoxypiplartine generic -metabolite KEGG:C10445 1,3-Dicaffeoylquinic acid generic -metabolite KEGG:C10446 Diferulic acid generic -metabolite KEGG:C10447 3,4-Dihydroxyphenylpropanoate generic -metabolite KEGG:C10448 Dihydroconiferyl alcohol generic -metabolite KEGG:C10449 Dillapiole generic -metabolite KEGG:C10450 Echinacoside generic -metabolite KEGG:C10451 Elemicin generic -metabolite KEGG:C10452 Estragole generic -metabolite KEGG:C10453 Eugenol generic -metabolite KEGG:C10454 Methyleugenol generic -metabolite KEGG:C10455 Fagaramide generic -metabolite KEGG:C10456 Forsythiaside generic -metabolite KEGG:C10457 Homoferreirin generic -metabolite KEGG:C10458 Furcatin generic -metabolite KEGG:C10459 Gingerdione generic -metabolite KEGG:C10460 Gingerenone A generic -metabolite KEGG:C10461 4-Hydroxyhomopterocarpin generic -metabolite KEGG:C10462 [6]-Gingerol generic -metabolite KEGG:C10463 Grandidentatin generic -metabolite KEGG:C10464 12a-Hydroxyrotenone generic -metabolite KEGG:C10465 Iridin generic -metabolite KEGG:C10466 Hellicoside generic -metabolite KEGG:C10467 Irilone generic -metabolite KEGG:C10468 Isochlorogenic acid b generic -metabolite KEGG:C10469 Isoeugenol generic -metabolite KEGG:C10470 Isoferulic acid generic -metabolite KEGG:C10471 Irisolidone generic -metabolite KEGG:C10472 Isosafrole generic -metabolite KEGG:C10473 Jionoside B1 generic -metabolite KEGG:C10474 Lusitanicoside generic -metabolite KEGG:C10475 p-Methoxycinnamaldehyde generic -metabolite KEGG:C10476 p-Methoxycinnamic acid ethyl ester generic -metabolite KEGG:C10477 Methyl caffeate generic -metabolite KEGG:C10478 Methylisoeugenol generic -metabolite KEGG:C10479 Myricoside generic -metabolite KEGG:C10480 Myristicin generic -metabolite KEGG:C10481 Orobanchoside generic -metabolite KEGG:C10482 6-Paradol generic -metabolite KEGG:C10483 Phaseolic acid generic -metabolite KEGG:C10484 Phenethyl caffeate generic -metabolite KEGG:C10485 Plantamajoside generic -metabolite KEGG:C10486 Licoisoflavone A generic -metabolite KEGG:C10487 Prenyl caffeate generic -metabolite KEGG:C10488 Purpureaside C generic -metabolite KEGG:C10490 Safrole generic -metabolite KEGG:C10491 Lonchocarpenin generic -metabolite KEGG:C10492 Salvianolic acid A generic -metabolite KEGG:C10493 Sarisan generic -metabolite KEGG:C10494 [6]-Shogaol generic -metabolite KEGG:C10495 Lotisoflavan generic -metabolite KEGG:C10496 Sphagnum acid generic -metabolite KEGG:C10497 Feruloylputrescine generic -metabolite KEGG:C10498 Luteone generic -metabolite KEGG:C10499 Suspensaside generic -metabolite KEGG:C10500 1,3,4,5-Tetracaffeoylquinic acid generic -metabolite KEGG:C10501 Verbascoside generic -metabolite KEGG:C10502 (-)-Maackiain generic -metabolite KEGG:C10503 Medicarpin generic -metabolite KEGG:C10504 Melannin generic -metabolite KEGG:C10505 (R)-4-Methoxydalbergione generic -metabolite KEGG:C10506 Millettone generic -metabolite KEGG:C10507 Mucronulatol generic -metabolite KEGG:C10508 (-)-Nissolin generic -metabolite KEGG:C10509 Ononin generic -metabolite KEGG:C10510 Orobol generic -metabolite KEGG:C10511 Osajin generic -metabolite KEGG:C10512 Pachyrrhizone generic -metabolite KEGG:C10513 Paniculatin generic -metabolite KEGG:C10514 (-)-Phaseollin generic -metabolite KEGG:C10515 (-)-Phaseollinisoflavan generic -metabolite KEGG:C10516 Pisatin generic -metabolite KEGG:C10517 2-(alpha-D-Glucosyl)-sn-glycerol 3-phosphate generic -metabolite KEGG:C10518 Piscerythramine generic -metabolite KEGG:C10519 Pomiferin generic -metabolite KEGG:C10520 Pratensein generic -metabolite KEGG:C10521 Prunetin generic -metabolite KEGG:C10522 Pseudobaptigenin generic -metabolite KEGG:C10523 Psoralidin generic -metabolite KEGG:C10524 Puerarin generic -metabolite KEGG:C10525 Rotenonone generic -metabolite KEGG:C10526 (-)-Sativan generic -metabolite KEGG:C10527 Sayanedine generic -metabolite KEGG:C10529 Sojagol generic -metabolite KEGG:C10530 Sophoraisoflavanone A generic -metabolite KEGG:C10531 (-)-Sparticarpin generic -metabolite KEGG:C10532 Sumatrol generic -metabolite KEGG:C10533 Tectoridin generic -metabolite KEGG:C10534 Tectorigenin generic -metabolite KEGG:C10535 Tephrosin generic -metabolite KEGG:C10536 Texasin generic -metabolite KEGG:C10537 Toxicarol generic -metabolite KEGG:C10538 Trifolirhizin generic -metabolite KEGG:C10539 (-)-Variabilin generic -metabolite KEGG:C10540 Vestitol generic -metabolite KEGG:C10541 Wedelolactone generic -metabolite KEGG:C10542 Wighteone generic -metabolite KEGG:C10543 Acanthoside D generic -metabolite KEGG:C10544 1-Acetoxypinoresinol generic -metabolite KEGG:C10545 Arctigenin generic -metabolite KEGG:C10546 Austrobailignan 1 generic -metabolite KEGG:C10547 Burseran generic -metabolite KEGG:C10548 Cleistanthin A generic -metabolite KEGG:C10549 Cubebin generic -metabolite KEGG:C10550 Dehydrodieugenol generic -metabolite KEGG:C10551 Morelensin generic -metabolite KEGG:C10552 4'-Demethyldeoxypodophyllotoxin generic -metabolite KEGG:C10553 4'-Demethylpodophyllotoxin generic -metabolite KEGG:C10554 Denudatin B generic -metabolite KEGG:C10555 Deoxygomisin A generic -metabolite KEGG:C10556 Deoxypodophyllotoxin generic -metabolite KEGG:C10557 Dihydroanhydropodorhizol generic -metabolite KEGG:C10558 Dihydrocubebin generic -metabolite KEGG:C10559 Diphyllin generic -metabolite KEGG:C10560 Eucommin A generic -metabolite KEGG:C10561 (+)-Eudesmin generic -metabolite KEGG:C10562 Eudesobovatol A generic -metabolite KEGG:C10563 Fargesone A generic -metabolite KEGG:C10564 O-Acetylcypholophine generic -metabolite KEGG:C10565 Acutumidine generic -metabolite KEGG:C10566 Alchorneine generic -metabolite KEGG:C10567 Alchornine generic -metabolite KEGG:C10568 Anantine generic -metabolite KEGG:C10569 Androcymbine generic -metabolite KEGG:C10570 Annuloline generic -metabolite KEGG:C10571 Aspergillic acid generic -metabolite KEGG:C10572 Balsoxine generic -metabolite KEGG:C10573 Calycanthine generic -metabolite KEGG:C10574 Futoquinol generic -metabolite KEGG:C10575 Candicine generic -metabolite KEGG:C10576 Cannabisativine generic -metabolite KEGG:C10577 Casimiroedine generic -metabolite KEGG:C10578 Celabenzine generic -metabolite KEGG:C10579 Cephalomannine generic -metabolite KEGG:C10580 Cephalotaxine generic -metabolite KEGG:C10581 Cichorine generic -metabolite KEGG:C10582 Codonocarpine generic -metabolite KEGG:C10583 Crinasiadine generic -metabolite KEGG:C10584 Crinasiatine generic -metabolite KEGG:C10585 Cryogenine generic -metabolite KEGG:C10586 Cryptopleurine generic -metabolite KEGG:C10587 Cynometrine generic -metabolite KEGG:C10588 Damascenine generic -metabolite KEGG:C10589 Decaline generic -metabolite KEGG:C10590 Elaeocarpidine generic -metabolite KEGG:C10591 (+)-Elaeocarpine generic -metabolite KEGG:C10592 Elaeokanine C generic -metabolite KEGG:C10593 Exserohilone generic -metabolite KEGG:C10594 Ficine generic -metabolite KEGG:C10595 Gliotoxin generic -metabolite KEGG:C10596 Halfordinol generic -metabolite KEGG:C10597 Harringtonine generic -metabolite KEGG:C10598 Himbacine generic -metabolite KEGG:C10599 Homaline generic -metabolite KEGG:C10600 Ibotenic acid generic -metabolite KEGG:C10601 Isoficine generic -metabolite KEGG:C10602 Lilaline generic -metabolite KEGG:C10603 Lunarine generic -metabolite KEGG:C10604 Lythramine generic -metabolite KEGG:C10605 Maculosin generic -metabolite KEGG:C10606 Maytansine generic -metabolite KEGG:C10607 Mycosporine generic -metabolite KEGG:C10608 Palustrine generic -metabolite KEGG:C10609 Phyllospadine generic -metabolite KEGG:C10610 Pilosine generic -metabolite KEGG:C10611 Pithecolobine generic -metabolite KEGG:C10612 Pleurostyline generic -metabolite KEGG:C10613 Porritoxin generic -metabolite KEGG:C10614 Securinine generic -metabolite KEGG:C10615 Shihunine generic -metabolite KEGG:C10616 (+)-Galbacin generic -metabolite KEGG:C10617 Sirodesmin H generic -metabolite KEGG:C10618 Sporidesmin generic -metabolite KEGG:C10619 Taxine A generic -metabolite KEGG:C10620 (-)-Tylocrebrine generic -metabolite KEGG:C10621 Gomisin L1 methyl ether generic -metabolite KEGG:C10622 Grandisin generic -metabolite KEGG:C10623 Tylophorine generic -metabolite KEGG:C10624 Verruculotoxin generic -metabolite KEGG:C10625 Withasomnine generic -metabolite KEGG:C10626 Zinnimidine generic -metabolite KEGG:C10627 Hinokinin generic -metabolite KEGG:C10628 cis-Hinokiresinol generic -metabolite KEGG:C10629 Acronidine generic -metabolite KEGG:C10630 Honokiol generic -metabolite KEGG:C10631 Acronycidine generic -metabolite KEGG:C10632 Acronycine generic -metabolite KEGG:C10633 Justicidin A generic -metabolite KEGG:C10634 Acrophylline generic -metabolite KEGG:C10635 Aniflorine generic -metabolite KEGG:C10636 Justicidin B generic -metabolite KEGG:C10637 Anisessine generic -metabolite KEGG:C10638 Kadsurenone generic -metabolite KEGG:C10639 Anisotine generic -metabolite KEGG:C10640 Kadsurin A generic -metabolite KEGG:C10641 Aurachin D generic -metabolite KEGG:C10642 Arborine generic -metabolite KEGG:C10643 Arborinine generic -metabolite KEGG:C10644 Atalanine generic -metabolite KEGG:C10645 Atalaphylline generic -metabolite KEGG:C10646 Lariciresinol generic -metabolite KEGG:C10647 Balfourodine generic -metabolite KEGG:C10648 Balfourodinium generic -metabolite KEGG:C10649 Bucharaine generic -metabolite KEGG:C10650 Licarin A generic -metabolite KEGG:C10651 Magnolol generic -metabolite KEGG:C10652 Bucharidine generic -metabolite KEGG:C10653 Buntanine generic -metabolite KEGG:C10654 Casimiroin generic -metabolite KEGG:C10655 Cusparine generic -metabolite KEGG:C10656 Deoxypeganine generic -metabolite KEGG:C10657 Magnosalicin generic -metabolite KEGG:C10658 Magnoshinin generic -metabolite KEGG:C10659 Deoxyvasicinone generic -metabolite KEGG:C10660 Dictamnine generic -metabolite KEGG:C10661 Dubamine generic -metabolite KEGG:C10662 Dubinidine generic -metabolite KEGG:C10663 Echinopsine generic -metabolite KEGG:C10664 Acetosyringone generic -metabolite KEGG:C10665 Echinorine generic -metabolite KEGG:C10666 Evoprenine generic -metabolite KEGG:C10667 3-Acetyl-6-methoxybenzaldehyde generic -metabolite KEGG:C10668 Evoxanthidine generic -metabolite KEGG:C10669 Agrimol C generic -metabolite KEGG:C10670 Evoxine generic -metabolite KEGG:C10671 Agrimophol generic -metabolite KEGG:C10672 Aspidin generic -metabolite KEGG:C10673 Aspidinol generic -metabolite KEGG:C10674 Danielone generic -metabolite KEGG:C10675 3',4'-Dihydroxyacetophenone generic -metabolite KEGG:C10676 gamma-Fagarine generic -metabolite KEGG:C10677 Febrifugine generic -metabolite KEGG:C10678 Flindersiamine generic -metabolite KEGG:C10679 Flindersine generic -metabolite KEGG:C10680 2',6'-Dihydroxy-4'-methoxyacetophenone generic -metabolite KEGG:C10681 Furofoline I generic -metabolite KEGG:C10682 Matairesinol generic -metabolite KEGG:C10683 Galipine generic -metabolite KEGG:C10684 2',6'-Dimethoxy-4'-hydroxyacetophenone generic -metabolite KEGG:C10685 Glycobismine A generic -metabolite KEGG:C10686 Glycoperine generic -metabolite KEGG:C10687 Glycophymoline generic -metabolite KEGG:C10688 Glycosminine generic -metabolite KEGG:C10689 Graveoline generic -metabolite KEGG:C10690 Megaphone generic -metabolite KEGG:C10691 Haplodimerine generic -metabolite KEGG:C10692 Haplophyllidine generic -metabolite KEGG:C10693 Filicin generic -metabolite KEGG:C10694 Haplopine generic -metabolite KEGG:C10695 Humulone generic -metabolite KEGG:C10696 Hydroquinidine generic -metabolite KEGG:C10697 Isodictamnine generic -metabolite KEGG:C10698 Isofebrifugine generic -metabolite KEGG:C10699 Japonine generic -metabolite KEGG:C10700 4'-Hydroxyacetophenone generic -metabolite KEGG:C10701 Kokusaginine generic -metabolite KEGG:C10702 4'-Hydroxy-3'-prenylacetophenone generic -metabolite KEGG:C10703 Leiokinine A generic -metabolite KEGG:C10704 alpha-Kosin generic -metabolite KEGG:C10705 Lemobiline generic -metabolite KEGG:C10706 Lupulone generic -metabolite KEGG:C10707 Neoisostegane generic -metabolite KEGG:C10708 Mallotophenone generic -metabolite KEGG:C10709 Multifidol generic -metabolite KEGG:C10710 Lunacridine generic -metabolite KEGG:C10711 Lunacrine generic -metabolite KEGG:C10712 Paeonol generic -metabolite KEGG:C10713 Lunamarine generic -metabolite KEGG:C10714 Maculine generic -metabolite KEGG:C10715 Paeonolide generic -metabolite KEGG:C10716 Maculosidine generic -metabolite KEGG:C10717 Paeonoside generic -metabolite KEGG:C10718 Maculosine generic -metabolite KEGG:C10719 Nordihydroguaiaretic acid generic -metabolite KEGG:C10720 Picein generic -metabolite KEGG:C10721 Rottlerin generic -metabolite KEGG:C10722 Melicopicine generic -metabolite KEGG:C10723 Tricyclodehydroisohumulone generic -metabolite KEGG:C10724 Melicopine generic -metabolite KEGG:C10725 Nortrachelogenin generic -metabolite KEGG:C10726 Xanthoxylin generic -metabolite KEGG:C10727 Melochinone generic -metabolite KEGG:C10728 Otobain generic -metabolite KEGG:C10729 alpha-Peltatin generic -metabolite KEGG:C10730 beta-Peltatin A methyl ether generic -metabolite KEGG:C10731 N-Methylflindersine generic -metabolite KEGG:C10732 O-Methylptelefolonium generic -metabolite KEGG:C10733 Peganine generic -metabolite KEGG:C10734 Pteleatine generic -metabolite KEGG:C10735 Ribalinium generic -metabolite KEGG:C10736 Robustine generic -metabolite KEGG:C10737 Phrymarolin I generic -metabolite KEGG:C10738 Rutacridone generic -metabolite KEGG:C10739 Rutacridone epoxide generic -metabolite KEGG:C10740 Skimmianine generic -metabolite KEGG:C10741 Swietenidin B generic -metabolite KEGG:C10742 Tryptanthrine generic -metabolite KEGG:C10743 Vasicinol generic -metabolite KEGG:C10744 Vasicinone generic -metabolite KEGG:C10745 Veprisinium generic -metabolite KEGG:C10746 Phyllanthin generic -metabolite KEGG:C10747 Albine generic -metabolite KEGG:C10748 Aloperine generic -metabolite KEGG:C10749 Ammothamnine generic -metabolite KEGG:C10750 Anagyrine generic -metabolite KEGG:C10751 Angustifoline generic -metabolite KEGG:C10752 Aphylline generic -metabolite KEGG:C10753 Argentine generic -metabolite KEGG:C10754 Argyrolobine generic -metabolite KEGG:C10755 Baptifoline generic -metabolite KEGG:C10756 Cadiamine generic -metabolite KEGG:C10757 Calpurnine generic -metabolite KEGG:C10758 Camoensine generic -metabolite KEGG:C10759 6-Pentadecylsalicylic acid generic -metabolite KEGG:C10760 Caulophylline generic -metabolite KEGG:C10761 p-Anisaldehyde generic -metabolite KEGG:C10762 Cinegalline generic -metabolite KEGG:C10763 Cytisine generic -metabolite KEGG:C10764 5,6-Dehydrolupanine generic -metabolite KEGG:C10765 Antiarol generic -metabolite KEGG:C10766 Ascosalitoxin generic -metabolite KEGG:C10767 Dimethamine generic -metabolite KEGG:C10768 (-)-Jamine generic -metabolite KEGG:C10769 Lamprolobine generic -metabolite KEGG:C10770 Bilobol generic -metabolite KEGG:C10771 Leontiformine generic -metabolite KEGG:C10772 Lupanine generic -metabolite KEGG:C10773 Lupinine generic -metabolite KEGG:C10774 Matrine generic -metabolite KEGG:C10775 Multiflorine generic -metabolite KEGG:C10776 Nuttalline generic -metabolite KEGG:C10777 (-)-Ormosanine generic -metabolite KEGG:C10778 Panamine generic -metabolite KEGG:C10779 Piptanthine generic -metabolite KEGG:C10780 Retamine generic -metabolite KEGG:C10781 Rhombifoline generic -metabolite KEGG:C10782 Sophoramine generic -metabolite KEGG:C10783 (-)-Sparteine generic -metabolite KEGG:C10784 Cannabidiolic acid generic -metabolite KEGG:C10785 (15:1)-Cardanol generic -metabolite KEGG:C10786 Templetine generic -metabolite KEGG:C10787 2,6-Dimethoxyphenol generic -metabolite KEGG:C10788 Ellagic acid generic -metabolite KEGG:C10789 Thermospine generic -metabolite KEGG:C10790 Tinctorine generic -metabolite KEGG:C10791 Tsukushinamine A generic -metabolite KEGG:C10792 Gentisyl alcohol generic -metabolite KEGG:C10793 Geranylhydroquinone generic -metabolite KEGG:C10794 Ginkgoic acid generic -metabolite KEGG:C10795 Buxamine E generic -metabolite KEGG:C10796 alpha-Chaconine generic -metabolite KEGG:C10797 Cyclobuxine D generic -metabolite KEGG:C10798 Cyclopamine generic -metabolite KEGG:C10799 Cycloprotobuxine C generic -metabolite KEGG:C10800 Grevillol generic -metabolite KEGG:C10801 Cyclovirobuxine C generic -metabolite KEGG:C10802 5-(Heptadec-12-enyl)resorcinol generic -metabolite KEGG:C10803 Demissine generic -metabolite KEGG:C10804 2-(Hydroxymethyl)benzoic acid generic -metabolite KEGG:C10805 Leiocarposide generic -metabolite KEGG:C10806 Funtumine generic -metabolite KEGG:C10807 Germine generic -metabolite KEGG:C10808 Imperialine generic -metabolite KEGG:C10809 5-Pentadecylresorcinol generic -metabolite KEGG:C10810 Irehine generic -metabolite KEGG:C10811 Jervine generic -metabolite KEGG:C10812 Piperonal generic -metabolite KEGG:C10813 Kurchessine generic -metabolite KEGG:C10814 Paravallarine generic -metabolite KEGG:C10815 Protoveratrine A generic -metabolite KEGG:C10816 Protoveratrine B generic -metabolite KEGG:C10817 Protoverine generic -metabolite KEGG:C10818 Solacapine generic -metabolite KEGG:C10819 Solamargine generic -metabolite KEGG:C10820 Solanine generic -metabolite KEGG:C10821 Solanocapsine generic -metabolite KEGG:C10822 Solasodine generic -metabolite KEGG:C10823 Populin generic -metabolite KEGG:C10824 Solasonine generic -metabolite KEGG:C10825 Terminaline generic -metabolite KEGG:C10826 Tomatidine generic -metabolite KEGG:C10827 Tomatine generic -metabolite KEGG:C10828 Veracevine generic -metabolite KEGG:C10829 Veratramine generic -metabolite KEGG:C10830 Peimine generic -metabolite KEGG:C10831 Zygadenine generic -metabolite KEGG:C10832 Sesamol generic -metabolite KEGG:C10833 Syringic acid generic -metabolite KEGG:C10834 Theogallin generic -metabolite KEGG:C10835 Trichocarpin generic -metabolite KEGG:C10836 3,4,3'-Tri-O-methylellagic acid generic -metabolite KEGG:C10837 Turgorin generic -metabolite KEGG:C10838 Turricolol E generic -metabolite KEGG:C10839 Urushiol III generic -metabolite KEGG:C10840 Zinniol generic -metabolite KEGG:C10841 Anatoxin a generic -metabolite KEGG:C10842 Anisodamine generic -metabolite KEGG:C10843 Apoatropine generic -metabolite KEGG:C10844 Apohyoscine generic -metabolite KEGG:C10845 Belladonnine generic -metabolite KEGG:C10846 Bellendine generic -metabolite KEGG:C10847 Benzoylecgonine generic -metabolite KEGG:C10848 Tropacocaine generic -metabolite KEGG:C10849 Brugine generic -metabolite KEGG:C10850 Calystegin A3 generic -metabolite KEGG:C10851 Calystegin B2 generic -metabolite KEGG:C10852 Cinnamoylcocaine generic -metabolite KEGG:C10853 Cochlearine generic -metabolite KEGG:C10854 Convolamine generic -metabolite KEGG:C10855 Convoline generic -metabolite KEGG:C10856 Convolvine generic -metabolite KEGG:C10857 Darlingine generic -metabolite KEGG:C10858 Ecgonine generic -metabolite KEGG:C10859 Knightinol generic -metabolite KEGG:C10860 Littorine generic -metabolite KEGG:C10861 Meteloidine generic -metabolite KEGG:C10862 Norhyoscyamine generic -metabolite KEGG:C10863 Phyllalbine generic -metabolite KEGG:C10864 Physoperuvine generic -metabolite KEGG:C10865 Pseudopelletierine generic -metabolite KEGG:C10866 Scopoline generic -metabolite KEGG:C10867 Strobamine generic -metabolite KEGG:C10868 Tigloidine generic -metabolite KEGG:C10869 Valeroidine generic -metabolite KEGG:C10870 Phyllanthostatin A generic -metabolite KEGG:C10871 Picropodophyllin generic -metabolite KEGG:C10873 Plicatic acid generic -metabolite KEGG:C10874 Podophyllotoxin generic -metabolite KEGG:C10875 Podophyllotoxone generic -metabolite KEGG:C10876 Podorhizol beta-D-glucoside generic -metabolite KEGG:C10877 Prostalidin A generic -metabolite KEGG:C10878 Randainol generic -metabolite KEGG:C10879 Saucernetin generic -metabolite KEGG:C10880 Savinin generic -metabolite KEGG:C10881 Schisantherin A generic -metabolite KEGG:C10882 Sesamin generic -metabolite KEGG:C10883 Sesamolinol generic -metabolite KEGG:C10884 Sesartemin generic -metabolite KEGG:C10885 Simplexoside generic -metabolite KEGG:C10886 Steganacin generic -metabolite KEGG:C10887 Styraxin generic -metabolite KEGG:C10888 Surinamensin generic -metabolite KEGG:C10889 (+)-Syringaresinol generic -metabolite KEGG:C10890 (+)-Syringaresinol O-beta-D-glucoside generic -metabolite KEGG:C10891 Trachelogenin generic -metabolite KEGG:C10892 (+)-Veraguensin generic -metabolite KEGG:C10893 Schizandrin C generic -metabolite KEGG:C10894 Yangambin generic -metabolite KEGG:C10895 Azafenidin generic -metabolite KEGG:C10896 Benomyl generic -metabolite KEGG:C10897 Carbendazim generic -metabolite KEGG:C10898 2-Benzimidazolylguanidine generic -metabolite KEGG:C10899 Allophanic acid methyl ester generic -metabolite KEGG:C10900 Methyl oxalate generic -metabolite KEGG:C10901 2-Aminobenzimidazole generic -metabolite KEGG:C10902 Methyl 5-hydroxy-2-benzimidazole carbamate generic -metabolite KEGG:C10903 Cinmethylin generic -metabolite KEGG:C10904 Cabucine generic -metabolite KEGG:C10905 Activated methyl group generic -metabolite KEGG:C10906 D-Fructose generic -metabolite KEGG:C10907 Cloransulam-methyl generic -metabolite KEGG:C10908 Fluthiacet-methyl generic -metabolite KEGG:C10909 Methabenzthiazuron generic -metabolite KEGG:C10910 2-Methylthiobenzothiazole generic -metabolite KEGG:C10911 Bromacil generic -metabolite KEGG:C10912 Buprofezin generic -metabolite KEGG:C10913 Cycloxydim generic -metabolite KEGG:C10914 Cyprodinil generic -metabolite KEGG:C10915 Bispyribac generic -metabolite KEGG:C10916 2-Dimethylamino-5,6-dimethylpyrimidin-4-ol generic -metabolite KEGG:C10917 7-N,N-Dimethylamino-1,2,3,4,5-pentathiocyclooctane generic -metabolite KEGG:C10918 Indeloxazine generic -metabolite KEGG:C10919 Mepanipyrim generic -metabolite KEGG:C10920 Glycidol generic -metabolite KEGG:C10921 Butyl acrylate generic -metabolite KEGG:C10922 2,3-Dimercaptopropane-1-sulfonic acid generic -metabolite KEGG:C10923 2-Nitrofluorene generic -metabolite KEGG:C10924 9-Hydroxy-2-nitrofluorene generic -metabolite KEGG:C10925 Acetochlor generic -metabolite KEGG:C10926 Hexazinone generic -metabolite KEGG:C10927 Cybutryne generic -metabolite KEGG:C10928 Alachlor generic -metabolite KEGG:C10929 Benalaxyl generic -metabolite KEGG:C10930 Metamitron generic -metabolite KEGG:C10931 Butachlor generic -metabolite KEGG:C10932 Carpropamid generic -metabolite KEGG:C10933 Amidosulfuron generic -metabolite KEGG:C10934 2,6-Dichlorobenzamide generic -metabolite KEGG:C10935 N,N-Diethyl-m-toluamide generic -metabolite KEGG:C10936 N-(2,6-Dimethylphenyl)-4-[[(diethylamino)acetyl]amino]benzamide generic -metabolite KEGG:C10937 Bensulfuron-methyl generic -metabolite KEGG:C10938 N,N-Diethylphenylacetamide generic -metabolite KEGG:C10939 Flumetover generic -metabolite KEGG:C10940 Epicainide generic -metabolite KEGG:C10941 Furalaxyl generic -metabolite KEGG:C10942 Inabenfide generic -metabolite KEGG:C10943 Chlorimuron-ethyl generic -metabolite KEGG:C10944 Isobutylphendienamide generic -metabolite KEGG:C10945 Caffeic aldehyde generic -metabolite KEGG:C10946 Metsulfuron-methyl generic -metabolite KEGG:C10947 Metalaxyl generic -metabolite KEGG:C10948 Metazachlor generic -metabolite KEGG:C10949 Nicosulfuron generic -metabolite KEGG:C10950 Prosulfuron generic -metabolite KEGG:C10951 N-(4-Chloro-3-methyl-5-isothiazolyl)-N-methyl-2-[p-[(alpha,alpha,alpha-trifluoro-p-tolyl)oxy]phenyl]acetamide generic -metabolite KEGG:C10952 Rimsulfuron generic -metabolite KEGG:C10953 Metolachlor generic -metabolite KEGG:C10954 Naproanilide generic -metabolite KEGG:C10955 Sulfometuron methyl generic -metabolite KEGG:C10956 Oxycarboxin generic -metabolite KEGG:C10957 Thifensulfuron-methyl generic -metabolite KEGG:C10958 Prinomide generic -metabolite KEGG:C10959 Thenylchlor generic -metabolite KEGG:C10960 Triforine generic -metabolite KEGG:C10961 Triasulfuron generic -metabolite KEGG:C10962 Tribenuron methyl generic -metabolite KEGG:C10963 Terbacil generic -metabolite KEGG:C10964 Benoxacor generic -metabolite KEGG:C10965 Bentazone generic -metabolite KEGG:C10966 Chlorpromazine N-oxide generic -metabolite KEGG:C10967 Fluperlapine generic -metabolite KEGG:C10968 Idazoxan generic -metabolite KEGG:C10969 SC-1271 generic -metabolite KEGG:C10970 Benalfocin generic -metabolite KEGG:C10971 Isoimide generic -metabolite KEGG:C10972 Imide generic -metabolite KEGG:C10973 Thiadiazolidinone generic -metabolite KEGG:C10974 4-Methylaminobutanal generic -metabolite KEGG:C10975 Triazolidinonethione generic -metabolite KEGG:C10976 1-Oxa-2-oxo-3-methylcycloheptane generic -metabolite KEGG:C10977 Thiadiazolidinethione generic -metabolite KEGG:C10978 Triazolidinedithione generic -metabolite KEGG:C10979 Chlozolinate generic -metabolite KEGG:C10980 Bifenthrin generic -metabolite KEGG:C10981 Vinclozolin generic -metabolite KEGG:C10982 Cyfluthrin generic -metabolite KEGG:C10983 Cyhalothrin generic -metabolite KEGG:C10984 Cypermethrin generic -metabolite KEGG:C10985 Deltamethrin generic -metabolite KEGG:C10986 Procymidone generic -metabolite KEGG:C10987 N-(3,5-Dichlorophenyl)succinimide generic -metabolite KEGG:C10988 Fenvalerate generic -metabolite KEGG:C10989 Fluvalinate generic -metabolite KEGG:C10990 Flumiclorac pentyl generic -metabolite KEGG:C10991 Resmethrin generic -metabolite KEGG:C10992 Tefluthrin generic -metabolite KEGG:C10993 Flumipropyn generic -metabolite KEGG:C10994 Hydramethylnon generic -metabolite KEGG:C10995 Amitraz generic -metabolite KEGG:C10996 Daminozide generic -metabolite KEGG:C10997 Guazatine generic -metabolite KEGG:C10998 4-Aminobiphenyl generic -metabolite KEGG:C10999 4,4'-Methylene-bis-(2-chloroaniline) generic -metabolite KEGG:C11000 Dichloran generic -metabolite KEGG:C11001 2,6-Diethylaniline generic -metabolite KEGG:C11002 Isofenphos generic -metabolite KEGG:C11003 2,4-Xylidine generic -metabolite KEGG:C11004 2,6-Dimethylaniline generic -metabolite KEGG:C11005 Isoproturon generic -metabolite KEGG:C11006 2,4-Dinitrotoluene generic -metabolite KEGG:C11007 Linuron generic -metabolite KEGG:C11008 2,6-Dinitrotoluene generic -metabolite KEGG:C11009 Chlorbromuron generic -metabolite KEGG:C11010 2-Fluoroaniline generic -metabolite KEGG:C11011 Metoxuron generic -metabolite KEGG:C11012 Pencycuron generic -metabolite KEGG:C11013 3-Fluoroaniline generic -metabolite KEGG:C11014 4-Fluoroaniline generic -metabolite KEGG:C11015 Aldicarb generic -metabolite KEGG:C11016 Diphenylamine generic -metabolite KEGG:C11017 Kresoxim-methyl generic -metabolite KEGG:C11018 Azinphos-methyl generic -metabolite KEGG:C11019 Pendimethalin generic -metabolite KEGG:C11020 2,4-DP generic -metabolite KEGG:C11021 Diclofop methyl generic -metabolite KEGG:C11022 Butamifos generic -metabolite KEGG:C11023 O-Ethyl-O-(5-methyl-4-nitrophenyl)(1-methylpropyl)phosphoramidothioate generic -metabolite KEGG:C11024 Fenoxaprop-ethyl generic -metabolite KEGG:C11025 Coumaphos generic -metabolite KEGG:C11026 Coumaphos anti-dimer generic -metabolite KEGG:C11027 Coumaphos syn-dimer generic -metabolite KEGG:C11028 Phosalone generic -metabolite KEGG:C11029 Fluazifop butyl generic -metabolite KEGG:C11030 Quinalphos generic -metabolite KEGG:C11031 Haloxyfop methyl generic -metabolite KEGG:C11032 Trichlopyr generic -metabolite KEGG:C11033 1-Aminomethylphosphonic acid generic -metabolite KEGG:C11034 MK-129 generic -metabolite KEGG:C11035 Flumioxazin generic -metabolite KEGG:C11036 Bromobenzene generic -metabolite KEGG:C11037 Chlorothalonil generic -metabolite KEGG:C11038 2'-Deoxy-5-hydroxymethylcytidine-5'-diphosphate generic -metabolite KEGG:C11039 2'-Deoxy-5-hydroxymethylcytidine-5'-triphosphate generic -metabolite KEGG:C11040 Dichlobenil generic -metabolite KEGG:C11041 Chlorthiamid generic -metabolite KEGG:C11042 Hexachlorobenzene generic -metabolite KEGG:C11043 Methoxychlor generic -metabolite KEGG:C11044 2,2',4,4',5-Pentachlorodiphenyl ether generic -metabolite KEGG:C11045 Aspartame generic -metabolite KEGG:C11047 Azadirachtinin generic -metabolite KEGG:C11048 Brassicanal A generic -metabolite KEGG:C11049 24-epi-Brassinolide generic -metabolite KEGG:C11050 25-Hydroxy-24-epi-brassinolide generic -metabolite KEGG:C11051 26-Hydroxy-24-epi-brassinolide generic -metabolite KEGG:C11052 7-Ethoxycoumarin generic -metabolite KEGG:C11053 9,10-Dihydrokadsurenone generic -metabolite KEGG:C11054 Spinosyn A generic -metabolite KEGG:C11055 Spinosyn B generic -metabolite KEGG:C11056 Spinosyn D generic -metabolite KEGG:C11057 3,4,3',4'-Tetrachlorobiphenyl generic -metabolite KEGG:C11058 1,2,3,4-Tetrachlorodibenzodioxin generic -metabolite KEGG:C11059 1,3,6,8-Tetrachlorodibenzo-p-dioxin generic -metabolite KEGG:C11060 (-)-Abscisic acid generic -metabolite KEGG:C11061 all-trans-Retinoyl-beta-glucuronide generic -metabolite KEGG:C11062 4-Hydroxybutyryl-CoA generic -metabolite KEGG:C11063 Chlornitrofen generic -metabolite KEGG:C11064 Fluorodifen generic -metabolite KEGG:C11065 Nitrofen generic -metabolite KEGG:C11066 Bifenox generic -metabolite KEGG:C11067 MC-3761 generic -metabolite KEGG:C11068 MC-5127 generic -metabolite KEGG:C11069 MC-6063 generic -metabolite KEGG:C11070 MC-7181 generic -metabolite KEGG:C11071 Aminocarb generic -metabolite KEGG:C11072 THTA generic -metabolite KEGG:C11073 Benfuracarb generic -metabolite KEGG:C11074 THTC generic -metabolite KEGG:C11075 Carbetamide generic -metabolite KEGG:C11076 2-N-Dodecyltetrahydrothiophene generic -metabolite KEGG:C11077 Diethofencarb generic -metabolite KEGG:C11078 Fenoxycarb generic -metabolite KEGG:C11079 Pirimicarb generic -metabolite KEGG:C11080 Cartap generic -metabolite KEGG:C11081 EPTC generic -metabolite KEGG:C11082 2-N-Undecyltetrahydrothiophene generic -metabolite KEGG:C11083 Assert generic -metabolite KEGG:C11084 Fenothiocarb generic -metabolite KEGG:C11085 Fenothiocarb sulfoxide generic -metabolite KEGG:C11086 Molinate generic -metabolite KEGG:C11087 Orbencarb generic -metabolite KEGG:C11088 1,2-Dibromoethane generic -metabolite KEGG:C11089 Dichloroacetylene generic -metabolite KEGG:C11090 Endosulfan generic -metabolite KEGG:C11091 Hexachloro-1,3-butadiene generic -metabolite KEGG:C11092 Azocyclotin generic -metabolite KEGG:C11093 Cyhexatin generic -metabolite KEGG:C11094 Carfentrazone-ethyl generic -metabolite KEGG:C11095 Clomazone generic -metabolite KEGG:C11096 Croconazole generic -metabolite KEGG:C11097 F5231 generic -metabolite KEGG:C11098 Fenpyroximate generic -metabolite KEGG:C11099 Fipronil generic -metabolite KEGG:C11100 Flurochloridone generic -metabolite KEGG:C11101 5-Hydroxymethyl-2-furaldehyde generic -metabolite KEGG:C11102 Hymexazol O-glucoside generic -metabolite KEGG:C11103 Hymexazol generic -metabolite KEGG:C11104 Hymexazol N-glucoside generic -metabolite KEGG:C11105 5-Methyl-3-isoxazolyl sulfate generic -metabolite KEGG:C11106 3-Oxobutanamide generic -metabolite KEGG:C11107 3-beta-D-Glucopyranuronosyloxy-5-methylisoxazole generic -metabolite KEGG:C11108 (-)-erythro-(2R,3R)-Dihydroxybutylamide generic -metabolite KEGG:C11109 HBA generic -metabolite KEGG:C11110 Imidacloprid generic -metabolite KEGG:C11111 Isoprothiolane generic -metabolite KEGG:C11112 Isoprothiolane sulfoxide generic -metabolite KEGG:C11113 Methaphenilene generic -metabolite KEGG:C11114 Methapyrilene generic -metabolite KEGG:C11115 5-Methyl-2-furaldehyde generic -metabolite KEGG:C11116 1-Methylparabanic acid generic -metabolite KEGG:C11117 5-N-Methyloxaluric acid generic -metabolite KEGG:C11118 N-Methyl-2-pyrrolidinone generic -metabolite KEGG:C11119 3-Nitrosothiazolidine generic -metabolite KEGG:C11120 Rilmenidine generic -metabolite KEGG:C11121 Propiconazole generic -metabolite KEGG:C11122 DTP generic -metabolite KEGG:C11123 Pyrazolate generic -metabolite KEGG:C11124 Spiroxamine generic -metabolite KEGG:C11125 Sulfentrazone generic -metabolite KEGG:C11126 Tebufenpyrad generic -metabolite KEGG:C11127 Triadimenol generic -metabolite KEGG:C11128 2,4,5-Tribromo-1-(4-chlorobenzoyl)imidazole generic -metabolite KEGG:C11129 Isatin generic -metabolite KEGG:C11130 3-Hydroxyindolin-2-one generic -metabolite KEGG:C11131 2-Methoxy-estradiol-17beta 3-glucuronide generic -metabolite KEGG:C11132 2-Methoxyestrone 3-glucuronide generic -metabolite KEGG:C11133 Estrone glucuronide generic -metabolite KEGG:C11134 Testosterone glucuronide generic -metabolite KEGG:C11135 Androsterone glucuronide generic -metabolite KEGG:C11136 Etiocholan-3alpha-ol-17-one 3-glucuronide generic -metabolite KEGG:C11141 (+)-Atherospermoline generic -metabolite KEGG:C11142 Dimethyl sulfone generic -metabolite KEGG:C11143 Dimethyl sulfoxide generic -metabolite KEGG:C11144 Dimethyl ether generic -metabolite KEGG:C11145 Methanesulfonic acid generic -metabolite KEGG:C11146 Methylmercury chloride generic -metabolite KEGG:C11147 Fluoromethane generic -metabolite KEGG:C11148 TCE epoxide generic -metabolite KEGG:C11149 Dichloroacetate generic -metabolite KEGG:C11150 Trichloroacetate generic -metabolite KEGG:C11151 Phenylmercury acetate generic -metabolite KEGG:C11152 Tetraphenylphosphonium generic -metabolite KEGG:C11153 Teniposide generic -metabolite KEGG:C11154 Trimetrexate generic -metabolite KEGG:C11155 n-Propyl gallate generic -metabolite KEGG:C11156 Triadimefon generic -metabolite KEGG:C11158 Topotecan generic -metabolite KEGG:C11159 Tiron generic -metabolite KEGG:C11160 Thiram generic -metabolite KEGG:C11161 Ethidium bromide generic -metabolite KEGG:C11162 5'-Methoxyhydnocarpin-D generic -metabolite KEGG:C11163 N-(2-Methoxyphenyl)-N'-(2-naphtyl)urea generic -metabolite KEGG:C11164 CCCP generic -metabolite KEGG:C11165 Thiolactomycin generic -metabolite KEGG:C11166 SDS generic -metabolite KEGG:C11168 Tetrabenazine generic -metabolite KEGG:C11169 Sulfathiazole generic -metabolite KEGG:C11170 Sulbenicillin generic -metabolite KEGG:C11171 Sodium deoxycholate generic -metabolite KEGG:C11172 Simazine generic -metabolite KEGG:C11173 SN-38 generic -metabolite KEGG:C11174 1-Diphosinositol pentakisphosphate generic -metabolite KEGG:C11175 S-(2,4-Dinitrophenyl)glutathione generic -metabolite KEGG:C11177 Rhodamine 6G generic -metabolite KEGG:C11178 Resazurin generic -metabolite KEGG:C11179 Pyronine Y generic -metabolite KEGG:C11180 Pyrimethanil generic -metabolite KEGG:C11181 Proflavine generic -metabolite KEGG:C11182 Prochloraz generic -metabolite KEGG:C11184 PMEG generic -metabolite KEGG:C11185 Nuarimol generic -metabolite KEGG:C11186 Nonactin generic -metabolite KEGG:C11188 Neburon generic -metabolite KEGG:C11189 Hoechst 33342 generic -metabolite KEGG:C11190 Rhodamine 123 generic -metabolite KEGG:C11191 cis-(Z)-Flupenthixol generic -metabolite KEGG:C11193 R (+)-Propanolol generic -metabolite KEGG:C11194 Morfamquat generic -metabolite KEGG:C11195 Mitoxantrone generic -metabolite KEGG:C11196 Methomyl generic -metabolite KEGG:C11198 Melitten generic -metabolite KEGG:C11199 Cefpirome generic -metabolite KEGG:C11200 Lenacil generic -metabolite KEGG:C11201 Isometamidium chloride generic -metabolite KEGG:C11202 Cefclidin generic -metabolite KEGG:C11203 Cefozopran generic -metabolite KEGG:C11205 Hexadimethrine bromide generic -metabolite KEGG:C11206 p-Methylaminophenol sulfate generic -metabolite KEGG:C11207 Fenapanil generic -metabolite KEGG:C11208 Iprodione generic -metabolite KEGG:C11210 Cefoselis generic -metabolite KEGG:C11212 NIK250 generic -metabolite KEGG:C11213 SDZ PSC 833 generic -metabolite KEGG:C11214 Thiocarbohydrazide generic -metabolite KEGG:C11215 Arsenate ion generic -metabolite KEGG:C11216 Zwittergent 3-14 generic -metabolite KEGG:C11217 p-Fluorophenylalanine generic -metabolite KEGG:C11218 Gramicidin S generic -metabolite KEGG:C11219 Imazalil nitrate generic -metabolite KEGG:C11221 Formylmethionyl-leucyl-phenylalanine methyl ester generic -metabolite KEGG:C11222 Geldanamycin generic -metabolite KEGG:C11223 Ferbam generic -metabolite KEGG:C11224 Fenuron generic -metabolite KEGG:C11225 Herbimycin generic -metabolite KEGG:C11226 Fenarimol generic -metabolite KEGG:C11227 Ethionine generic -metabolite KEGG:C11228 Estramustine generic -metabolite KEGG:C11229 Epoxiconazole generic -metabolite KEGG:C11230 Epirubicin generic -metabolite KEGG:C11231 Docetaxel anhydrous generic -metabolite KEGG:C11232 Diphenylcarbazide generic -metabolite KEGG:C11233 Dimethyl phthalate generic -metabolite KEGG:C11234 Difloxacin generic -metabolite KEGG:C11235 Diclobutrazol generic -metabolite KEGG:C11236 Niguldipine generic -metabolite KEGG:C11237 17beta-Estradiol 17-(beta-D-glucuronide) generic -metabolite KEGG:C11238 GF 109203X generic -metabolite KEGG:C11239 MK 571 generic -metabolite KEGG:C11240 Rufloxacin generic -metabolite KEGG:C11242 Bacteriochlorophyll a generic -metabolite KEGG:C11243 Bacteriochlorophyll b generic -metabolite KEGG:C11244 Bacterio-chlorophyll c generic -metabolite KEGG:C11245 Glucuronosyletoposide generic -metabolite KEGG:C11246 6alpha-Glucuronosylhyodeoxycholate generic -metabolite KEGG:C11248 DU-6859 generic -metabolite KEGG:C11249 Cyclohexane generic -metabolite KEGG:C11250 Demecolcine generic -metabolite KEGG:C11251 Cholesteryl palmitate generic -metabolite KEGG:C11252 Chloroneb generic -metabolite KEGG:C11253 Cefsulodin generic -metabolite KEGG:C11254 Carmine generic -metabolite KEGG:C11255 Carboxin generic -metabolite KEGG:C11256 Calpeptin generic -metabolite KEGG:C11257 Calcein AM generic -metabolite KEGG:C11258 Bitertanol generic -metabolite KEGG:C11259 Bicozamycin generic -metabolite KEGG:C11260 2-Amino-2-methyl-1,3-propandiol generic -metabolite KEGG:C11261 Amitrole generic -metabolite KEGG:C11262 5-Azacytidine generic -metabolite KEGG:C11263 6-Benzylaminopurine generic -metabolite KEGG:C11264 7-Hydroxyflavone generic -metabolite KEGG:C11265 8-Azaadenosine generic -metabolite KEGG:C11266 8-Bromoadenosine generic -metabolite KEGG:C11268 Biapenem generic -metabolite KEGG:C11269 Virginiamycin S1 generic -metabolite KEGG:C11271 n-Hexane generic -metabolite KEGG:C11272 Fluorobenzene generic -metabolite KEGG:C11273 Acriflavine generic -metabolite KEGG:C11274 Tetrachlorosalicylanilide generic -metabolite KEGG:C11275 Cetyltrimethylammonium bromide generic -metabolite KEGG:C11276 Nimustine hydrochloride generic -metabolite KEGG:C11277 Adefovir generic -metabolite KEGG:C11278 Aflatoxin B1exo-8,9-epoxide-GSH generic -metabolite KEGG:C11279 Myristyltrimethylaminium bromide generic -metabolite KEGG:C11280 Dolastatin 10 generic -metabolite KEGG:C11281 Anisomycin generic -metabolite KEGG:C11282 Azidopine generic -metabolite KEGG:C11283 2,4-Dinitrophenylhydrazine generic -metabolite KEGG:C11284 Indolebutyric acid generic -metabolite KEGG:C11285 Tridemorph generic -metabolite KEGG:C11288 16alpha,17beta-Estriol 3-(beta-D-glucuronide) generic -metabolite KEGG:C11289 17beta-Estradiol 3-sulfate-17-(beta-D-glucuronide) generic -metabolite KEGG:C11290 3-Chlorosalicylanilide generic -metabolite KEGG:C11292 N-Acetylleucyl-leucyl-methioninal generic -metabolite KEGG:C11293 Etaconazole generic -metabolite KEGG:C11295 N-Acetyl-leu-leu-leu-leu-tyr-amide generic -metabolite KEGG:C11296 N-Acetyl-leu-leu-leu-tyr-amide generic -metabolite KEGG:C11297 N-Acetyl-leu-leu-tyr-amide generic -metabolite KEGG:C11298 N-Formyl-norleucyl-leucyl-phenylalanyl-methylester generic -metabolite KEGG:C11299 Virginiamycin M1 generic -metabolite KEGG:C11300 Soraphen A generic -metabolite KEGG:C11301 Sulfoglycolithocholate generic -metabolite KEGG:C11302 S-Octyl GSH generic -metabolite KEGG:C11303 S-Decyl GSH generic -metabolite KEGG:C11304 S-(PGA1)-glutathione generic -metabolite KEGG:C11305 Triphenyltetrazolium chloride generic -metabolite KEGG:C11306 Acetylleucyl-leucyl-norleucinal generic -metabolite KEGG:C11307 Cetylpyridinium chloride generic -metabolite KEGG:C11308 Chymostatin generic -metabolite KEGG:C11309 Calcimycin generic -metabolite KEGG:C11310 1-Methyl-4-phenylpyridinium generic -metabolite KEGG:C11311 Oligomycin A generic -metabolite KEGG:C11312 Oligomycin B generic -metabolite KEGG:C11313 Oligomycin C generic -metabolite KEGG:C11314 Oligomycin D generic -metabolite KEGG:C11315 S-(4-Azidophenacyl)glutathione generic -metabolite KEGG:C11316 Tetraphenylarsonium generic -metabolite KEGG:C11317 Solutol HS 15 generic -metabolite KEGG:C11318 DAMGO generic -metabolite KEGG:C11319 3,5-Dinitrosalicylic acid generic -metabolite KEGG:C11320 D-Ornithine hydrochloride generic -metabolite KEGG:C11321 3-((3-Cholamidopropyl)dimethylammonium)-1-propanesulfonate generic -metabolite KEGG:C11322 4,5,6,7-Tetrachloro-2-trifluoromethylbenzimidazole generic -metabolite KEGG:C11323 Chromotropic acid generic -metabolite KEGG:C11324 6-(3,3-Dimethylallyl)chrysin generic -metabolite KEGG:C11325 8-(3,3-Dimethylallyl)chrysin generic -metabolite KEGG:C11326 8-Anilino-1-naphthalene sulfonic acid generic -metabolite KEGG:C11327 2-Pyridyl hydroxymethane sulfonic acid generic -metabolite KEGG:C11328 Leucyl-leucyl-norleucine generic -metabolite KEGG:C11329 N-Acetyl-ala-ala-ala-methylester generic -metabolite KEGG:C11330 N-Acetyl-leu-leu-tyr generic -metabolite KEGG:C11331 Leu-leu-tyr generic -metabolite KEGG:C11332 Leucyl-leucine generic -metabolite KEGG:C11333 N-Acetyl-leucyl-leucine generic -metabolite KEGG:C11334 Gentamicin sulfate generic -metabolite KEGG:C11335 N,N,N-Trimethylmethanaminium chloride generic -metabolite KEGG:C11336 Mersalyl acid generic -metabolite KEGG:C11337 Tetramisole hydrochloride generic -metabolite KEGG:C11338 Bornyl acetate generic -metabolite KEGG:C11339 Antimycin A1 generic -metabolite KEGG:C11340 Antimony potassium tartrate generic -metabolite KEGG:C11341 N-Acetylphenylalanine beta-naphthyl ester generic -metabolite KEGG:C11342 Oxolinic acid generic -metabolite KEGG:C11343 Salicylhydroxamic acid generic -metabolite KEGG:C11344 Methyl tert-butyl ether generic -metabolite KEGG:C11345 1,2,4-Triazole-3-alanine generic -metabolite KEGG:C11346 16alpha,17beta-Estriol 17-(beta-D-glucuronide) generic -metabolite KEGG:C11347 S-Methyl GSH generic -metabolite KEGG:C11348 (S)-1-Phenylethanol generic -metabolite KEGG:C11349 Amino group donor generic -metabolite KEGG:C11350 (+)-trans-alpha-Irone generic -metabolite KEGG:C11351 N1-Amidinostreptamine 6-phosphate generic -metabolite KEGG:C11352 5,6-Dichloro-1,3-cyclohexadiene generic -metabolite KEGG:C11353 2-Hydroxy-3-chloropenta-2,4-dienoate generic -metabolite KEGG:C11354 2-Hydroxy-cis-hex-2,4-dienoate generic -metabolite KEGG:C11355 4-Amino-4-deoxychorismate generic -metabolite KEGG:C11356 trans,trans,cis-Geranylgeranyl diphosphate generic -metabolite KEGG:C11357 (-)-Anabasine generic -metabolite KEGG:C11358 D-(-)-Anaferine generic -metabolite KEGG:C11359 (-)-Hygrine generic -metabolite KEGG:C11360 (+)-Nornicotine generic -metabolite KEGG:C11361 N-Acetylleukotriene E4 generic -metabolite KEGG:C11362 BQ 485 generic -metabolite KEGG:C11363 Sulfobromophthalein generic -metabolite KEGG:C11365 Irinotecan carboxylate generic -metabolite KEGG:C11366 SN-38 carboxylate form generic -metabolite KEGG:C11367 GSH-prostaglandin A1 generic -metabolite KEGG:C11368 Grepafloxacin generic -metabolite KEGG:C11369 Fluo-3 generic -metabolite KEGG:C11370 N-Ethylmaleimide-S-glutathione generic -metabolite KEGG:C11371 Nafenopin generic -metabolite KEGG:C11372 ICI D1694 generic -metabolite KEGG:C11373 Temocaprilat generic -metabolite KEGG:C11374 GW1843 generic -metabolite KEGG:C11375 SN38 glucuronide carboxylate form generic -metabolite KEGG:C11376 SN38 glucuronide generic -metabolite KEGG:C11377 alpha-N-Acetylneuraminyl-2,6-beta-D-galactosyl-1,4-N-acetyl-D-glucosaminyl-glycoprotein generic -metabolite KEGG:C11378 Ubiquinone-10 generic -metabolite KEGG:C11379 Cinchonidine generic -metabolite KEGG:C11380 Apocynin generic -metabolite KEGG:C11381 Benzoyltropein generic -metabolite KEGG:C11382 (+)-3-Carene generic -metabolite KEGG:C11383 (+)-(S)-Carvone generic -metabolite KEGG:C11384 (S)-(-)-Citronellal generic -metabolite KEGG:C11385 Globotetraosylceramide generic -metabolite KEGG:C11386 (-)-Citronellol generic -metabolite KEGG:C11387 (1S,4R)-(+)-Fenchone generic -metabolite KEGG:C11388 (-)-Linalool generic -metabolite KEGG:C11389 (+)-Linalool generic -metabolite KEGG:C11390 (+)-Menthone generic -metabolite KEGG:C11391 (S)-(+)-alpha-Phellandrene generic -metabolite KEGG:C11392 (-)-beta-Phellandrene generic -metabolite KEGG:C11393 (-)-alpha-Terpineol generic -metabolite KEGG:C11394 (+)-Chrysanthenone generic -metabolite KEGG:C11395 (4R,6R)-cis-Carveol generic -metabolite KEGG:C11396 (1R,2R,4R)-Dihydrocarveol generic -metabolite KEGG:C11397 (1R,2S,4R)-Neo-dihydrocarveol generic -metabolite KEGG:C11398 (1R,4R)-Dihydrocarvone generic -metabolite KEGG:C11399 (1S,2S,4R)-Iso-dihydrocarveol generic -metabolite KEGG:C11400 (1S,2R,4R)-Neoiso-dihydrocarveol generic -metabolite KEGG:C11401 (1S,4R)-Iso-dihydrocarvone generic -metabolite KEGG:C11402 (4R,7R)-4-Isopropenyl-7-methyl-2-oxo-oxepanone generic -metabolite KEGG:C11403 (3S,6R)-6-Isopropenyl-3-methyl-2-oxo-oxepanone generic -metabolite KEGG:C11404 (3R)-6-Hydroxy-3-isopropenyl-heptanoate generic -metabolite KEGG:C11405 (3R)-3-Isopropenyl-6-oxoheptanoate generic -metabolite KEGG:C11406 (5R)-6-Hydroxy-5-isopropenyl-2-methylhexanoate generic -metabolite KEGG:C11407 (3R)-3-Isopropenyl-6-oxoheptanoyl-CoA generic -metabolite KEGG:C11408 (4S,6S)-cis-Carveol generic -metabolite KEGG:C11409 (+)-trans-Carveol generic -metabolite KEGG:C11410 (1R,2S,4S)- Neoiso-dihydrocarveol generic -metabolite KEGG:C11411 (1R,2R,4S)-Iso-dihydrocarveol generic -metabolite KEGG:C11412 (1R,4S)-Iso-dihydrocarvone generic -metabolite KEGG:C11413 (1S,2S,4S)-Dihydrocarveol generic -metabolite KEGG:C11414 (4S,7R)-4-Isopropenyl-7-methyl-2-oxo-oxepanone generic -metabolite KEGG:C11415 (1S,4S)-Dihydrocarvone generic -metabolite KEGG:C11416 (1S,2R,4S)-Neo-dihydrocarveol generic -metabolite KEGG:C11417 (3S)-6-Hydroxy-3-isopropenyl-heptanoate generic -metabolite KEGG:C11418 (3S,6S)-6-Isopropenyl-3-methyl-2-oxo-oxepanone generic -metabolite KEGG:C11419 (3S)-3-Isopropenyl-6-oxoheptanoate generic -metabolite KEGG:C11420 (5S)-6-Hydroxy-5-isopropenyl-2-methylhexanoate generic -metabolite KEGG:C11421 (3S)-3-Isopropenyl-6-oxoheptanoyl-CoA generic -metabolite KEGG:C11422 Phenanthrene generic -metabolite KEGG:C11425 2-Hydroxy-2H-benzo[h]chromene-2-carboxylate generic -metabolite KEGG:C11426 cis-4-(1'-Hydroxynaphth-2'-yl)-2-oxobut-3-enoate generic -metabolite KEGG:C11427 1-Hydroxy-2-naphthaldehyde generic -metabolite KEGG:C11428 trans-9(S),10(S)-Dihydrodiolphenanthrene generic -metabolite KEGG:C11429 Phenanthrene-9,10-oxide generic -metabolite KEGG:C11430 9-Hydroxyphenanthrene generic -metabolite KEGG:C11431 Phenanthrene-1,2-oxide generic -metabolite KEGG:C11432 1-Phenanthrol generic -metabolite KEGG:C11433 1-Methoxyphenanthrene generic -metabolite KEGG:C11434 2-C-Methyl-D-erythritol 4-phosphate generic -metabolite KEGG:C11435 4-(Cytidine 5'-diphospho)-2-C-methyl-D-erythritol generic -metabolite KEGG:C11436 2-Phospho-4-(cytidine 5'-diphospho)-2-C-methyl-D-erythritol generic -metabolite KEGG:C11437 1-Deoxy-D-xylulose 5-phosphate generic -metabolite KEGG:C11438 C-1027 Chromophore generic -metabolite KEGG:C11439 Formyl-L-methionyl peptide generic -metabolite KEGG:C11440 Methionyl peptide generic -metabolite KEGG:C11441 Deshydroxy-C-1027 chromophore generic -metabolite KEGG:C11442 Aromatized C-1027 chromophore generic -metabolite KEGG:C11443 Aromatized deshydroxy-C-1027 chromophore generic -metabolite KEGG:C11445 4-(1,2-Epoxyethyl)-8,9-epoxy-enediyne generic -metabolite KEGG:C11446 4-Dihydroxyethyl-8,9-epoxy-enediyne generic -metabolite KEGG:C11447 dTDP-4-dimethylamino-4,6-dideoxy-5-C-methyl-D-allose generic -metabolite KEGG:C11448 3,4-Dihydro-7-methoxy-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carbonyl-CoA generic -metabolite KEGG:C11449 (S)-3-Chloro-4,5-dihydroxy-beta-phenylalanyl-[pcp] generic -metabolite KEGG:C11453 2-C-Methyl-D-erythritol 2,4-cyclodiphosphate generic -metabolite KEGG:C11455 4,4-Dimethyl-5alpha-cholesta-8,14,24-trien-3beta-ol generic -metabolite KEGG:C11456 cis-3-(1-Carboxy-ethyl)-3,5-cyclo-hexadiene-1,2-diol generic -metabolite KEGG:C11457 3-(3-Hydroxyphenyl)propanoic acid generic -metabolite KEGG:C11460 dTDP-4-oxo-5-C-methyl-L-rhamnose generic -metabolite KEGG:C11461 dTDP-4-amino-4,6-dideoxy-5-C-methyl-D-allose generic -metabolite KEGG:C11462 3-Hydroxy-L-tyrosyl-AMP generic -metabolite KEGG:C11465 3,5-Dihydroxyanthranilate generic -metabolite KEGG:C11466 5-Methoxy-3-hydroxyanthranilate generic -metabolite KEGG:C11467 N-Pyruvoyl-5-methoxy-3-hydroxyanthranilate generic -metabolite KEGG:C11468 3,4-Dihydro-7-methoxy-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carboxylic acid generic -metabolite KEGG:C11469 Calicheamicin gamma(1)I generic -metabolite KEGG:C11471 Dynemicin A generic -metabolite KEGG:C11472 D-glycero-beta-D-manno-Heptose 1,7-bisphosphate generic -metabolite KEGG:C11473 Thiocyclam generic -metabolite KEGG:C11474 Nereistoxin generic -metabolite KEGG:C11475 DNA containing guanine generic -metabolite KEGG:C11476 L-Arabinose generic -metabolite KEGG:C11477 Sugar generic -metabolite KEGG:C11478 tRNA containing 5-aminomethyl-2-thiouridine generic -metabolite KEGG:C11480 2-Methyl-6-oxohepta-2,4-dienal generic -metabolite KEGG:C11481 HSO3- generic -metabolite KEGG:C11482 Holo-Lys2 generic -metabolite KEGG:C11483 MEGA generic -metabolite KEGG:C11484 GA generic -metabolite KEGG:C11485 LY201116 generic -metabolite KEGG:C11486 NAC generic -metabolite KEGG:C11487 EPA generic -metabolite KEGG:C11488 HMMF generic -metabolite KEGG:C11489 NMF generic -metabolite KEGG:C11490 AMCC generic -metabolite KEGG:C11491 NOP generic -metabolite KEGG:C11492 NOPM generic -metabolite KEGG:C11493 Carfentrazone generic -metabolite KEGG:C11494 Methyl 2-(4-isopropyl-4-methyl-5-oxo-2-imidazolin-2-yl)-p-toluate generic -metabolite KEGG:C11495 Methyl 6-(4-isopropyl-4-methyl-5-oxo-2-imidazolin-2-yl)-m-toluate generic -metabolite KEGG:C11496 (R)-2-Hydroxypropyl-CoM generic -metabolite KEGG:C11497 2-Oxopropyl-CoM generic -metabolite KEGG:C11498 (S)-2-Hydroxypropyl-CoM generic -metabolite KEGG:C11499 (S)-3-Sulfolactate generic -metabolite KEGG:C11500 5'-Dehydroadenosine generic -metabolite KEGG:C11501 9-Riburonosyladenine generic -metabolite KEGG:C11502 Mycothione generic -metabolite KEGG:C11503 3-Hydroxy-1H-quinolin-4-one generic -metabolite KEGG:C11504 3-Hydroxy-2-methyl-1H-quinolin-4-one generic -metabolite KEGG:C11505 Propylene generic -metabolite KEGG:C11506 (2R)-1,2-Epoxypropane generic -metabolite KEGG:C11507 (S)-1,2-Epoxypropane generic -metabolite KEGG:C11508 4alpha-Methyl-5alpha-ergosta-8,14,24(28)-trien-3beta-ol generic -metabolite KEGG:C11509 3beta-Hydroxy-4beta-methyl-5alpha-cholest-7-ene-4alpha-carbaldehyde generic -metabolite KEGG:C11510 2,4.6-Trichloroanisole generic -metabolite KEGG:C11511 threo-3-Hydroxy-L-aspartate generic -metabolite KEGG:C11512 Methyl jasmonate generic -metabolite KEGG:C11513 (24R)-24-Methylcycloarta-25-en-3-beta-ol generic -metabolite KEGG:C11514 (E)-3-(Methoxycarbonyl)pent-2-enedioate generic -metabolite KEGG:C11515 (E)-2-(Methoxycarbonylmethyl)butenedioate generic -metabolite KEGG:C11516 2-(alpha-D-Mannosyl)-3-phosphoglycerate generic -metabolite KEGG:C11519 N-Cyclohexylformamide generic -metabolite KEGG:C11520 Cyclohexyl isocyanide generic -metabolite KEGG:C11521 UDP-6-sulfoquinovose generic -metabolite KEGG:C11522 24-Methylenelophenol generic -metabolite KEGG:C11523 24-Ethylidenelophenol generic -metabolite KEGG:C11524 Diphospho-myo-inositol polyphosphate generic -metabolite KEGG:C11525 myo-Inositol polyphosphate generic -metabolite KEGG:C11526 5-PP-InsP5 generic -metabolite KEGG:C11527 4-Hydroxymandelate generic -metabolite KEGG:C11529 N-Carbamoyl-L-amino acid generic -metabolite KEGG:C11531 6-O-(beta-D-Xylopyranosyl)-beta-D-glucopyranoside generic -metabolite KEGG:C11535 6-O-(beta-D-Xylopyranosyl)-beta-D-glucopyranose generic -metabolite KEGG:C11536 (2R)-O-Phospho-3-sulfolactate generic -metabolite KEGG:C11537 (2R)-3-Sulfolactate generic -metabolite KEGG:C11538 Cobalt-sirohydrochlorin generic -metabolite KEGG:C11539 Cobalt-precorrin 3 generic -metabolite KEGG:C11540 Cobalt-precorrin 4 generic -metabolite KEGG:C11541 Cobalt-precorrin 5 generic -metabolite KEGG:C11542 Cobalt-precorrin 6 generic -metabolite KEGG:C11543 Cobalt-dihydro-precorrin 6 generic -metabolite KEGG:C11544 2-O-(alpha-D-Mannosyl)-D-glycerate generic -metabolite KEGG:C11545 Cobalt-precorrin 8 generic -metabolite KEGG:C11546 2-O-(alpha-D-Glucopyranosyl)glycerol generic -metabolite KEGG:C11547 3-(Acyloxy)acyl group of bacterial toxin generic -metabolite KEGG:C11548 3-Hydroxyacyl group of bacterial toxin generic -metabolite KEGG:C11549 Poly[(R)-3-hydroxyoctanoate]n generic -metabolite KEGG:C11550 Poly[(R)-3-hydroxyoctanoate]x generic -metabolite KEGG:C11551 Poly[(R)-3-hydroxybutanoate]n-x generic -metabolite KEGG:C11552 Poly[(R)-3-hydroxybutanoate]x generic -metabolite KEGG:C11553 [Heparan sulfate]-glucosamine 3-sulfate generic -metabolite KEGG:C11554 1-Phosphatidyl-1D-myo-inositol 3,4-bisphosphate generic -metabolite KEGG:C11555 1D-myo-Inositol 1,4,5,6-tetrakisphosphate generic -metabolite KEGG:C11556 1-Phosphatidyl-1D-myo-inositol 3,5-bisphosphate generic -metabolite KEGG:C11557 1-Phosphatidyl-1D-myo-inositol 5-phosphate generic -metabolite KEGG:C11560 1-Carbazol-9-yl-3-(3,5-dimethylpyrazol-1-yl)-propan-2-ol generic -metabolite KEGG:C11561 2-(4-Chloro-3,5-dimethylphenoxy)-N-(2-phenyl-2H-benzotriazol-5-yl)-acetamide generic -metabolite KEGG:C11562 N-[2-(4-Chloro-phenyl)-acetyl]-N'-(4,7-dimethyl-quinazolin-2-yl)-guanidine generic -metabolite KEGG:C11563 1-Benzyl-7,8-dimethoxy-3-phenyl-3H-pyrazolo[3,4-c]isoquinoline generic -metabolite KEGG:C11564 N-(3-Benzooxazol-2-yl-4-hydroxy-phenyl)-2-p-tolyloxyacetamide generic -metabolite KEGG:C11565 8-Allyl-2-phenyl-8H-1,3a,8-triaza-cyclopenta[a]indene generic -metabolite KEGG:C11566 3-(4-Chloro-benzyl)-5-(2-methoxy-phenyl)-[1,2,4]oxadiazole generic -metabolite KEGG:C11567 2-Phenethylsulfanyl-5,6,7,8-tetrahydro-benzo[4,5]thieno[2,3-d]pyrimidin-4-ylamine generic -metabolite KEGG:C11568 (5,12,13-Triaza-indeno[1,2-b]anthracen-13-yl)-acetic acid ethyl ester generic -metabolite KEGG:C11569 2,2'-(1-Phenyl-1H-1,2,4-triazole-3,5-diyl)bis-phenol generic -metabolite KEGG:C11570 2-(2-Chloro-phenyl)-5-(5-methylthiophen-2-yl)-[1,3,4]oxadiazole generic -metabolite KEGG:C11571 2-p-Tolyl-5,6,7,8-tetrahydrobenzo[d]imidazo[2,1-b]thiazole generic -metabolite KEGG:C11572 Glycoprotein with the oligosaccharide chain attached by N-glycosyl linkage to protein L-asparagine generic -metabolite KEGG:C11573 6,8-Di-DMA-chrysin generic -metabolite KEGG:C11574 6-Geranylchrysin generic -metabolite KEGG:C11575 8-Geranylchrysin generic -metabolite KEGG:C11576 6-(3,3-DMA)galangin generic -metabolite KEGG:C11577 3-Methylgalangin generic -metabolite KEGG:C11578 8-(3,3-Dimethylallyl)-3-methylgalangin generic -metabolite KEGG:C11579 8-(1,1-Dimethylallyl)-3-methylgalangin generic -metabolite KEGG:C11580 8-(1,1-DMA)kaempferide generic -metabolite KEGG:C11581 8-(1,1-Dimethylallyl)galangin generic -metabolite KEGG:C11582 2-Chlorophenylhydrazine hydrochloride generic -metabolite KEGG:C11583 4-Glutathionyl cyclophosphamide generic -metabolite KEGG:C11584 4-Methylumbelliferone glucuronide generic -metabolite KEGG:C11585 4-Methylumbelliferone sulfate generic -metabolite KEGG:C11586 alpha-Naphthyl-beta-D-glucuronide generic -metabolite KEGG:C11587 BQ 123 generic -metabolite KEGG:C11588 cis-3-(Carboxy-ethyl)-3,5-cyclo-hexadiene-1,2-diol generic -metabolite KEGG:C11589 BQ 518 generic -metabolite KEGG:C11590 Beauvericin generic -metabolite KEGG:C11591 DIDS generic -metabolite KEGG:C11592 Diethyl pyrocarbonate generic -metabolite KEGG:C11593 E3040 generic -metabolite KEGG:C11594 E3040 sulfate generic -metabolite KEGG:C11595 E3040 glucuronide generic -metabolite KEGG:C11596 FMLP generic -metabolite KEGG:C11597 Grepafloxacin glucuronide generic -metabolite KEGG:C11598 Hydroxylamine hydrochloride generic -metabolite KEGG:C11599 IAARh123 generic -metabolite KEGG:C11600 IACI generic -metabolite KEGG:C11601 LDS-751 generic -metabolite KEGG:C11602 MC-207,110 generic -metabolite KEGG:C11603 Monochloro-monoglutathionyl melphalan generic -metabolite KEGG:C11604 N-tert-Butyloxycarbonyl-deacetyl-leupeptin generic -metabolite KEGG:C11605 NAc-DNP-Cys generic -metabolite KEGG:C11606 NAc-FnorLRF-amide generic -metabolite KEGG:C11607 N-Acetyl-leu-leu-leu-leu-leu-tyr-amide generic -metabolite KEGG:C11608 Nafenopin glucuronide generic -metabolite KEGG:C11609 Nigericin generic -metabolite KEGG:C11610 Pepsinostreptin generic -metabolite KEGG:C11611 Phenyl beta-D-glucopyranoside generic -metabolite KEGG:C11612 Polymyxin B generic -metabolite KEGG:C11613 Polymyxin B sulfate generic -metabolite KEGG:C11615 Pristinamycin IA generic -metabolite KEGG:C11616 Pristinamycin IB generic -metabolite KEGG:C11617 Pristinamycin IC generic -metabolite KEGG:C11618 Puromycin dihydrochloride generic -metabolite KEGG:C11619 Spectinomycin dihydrochloride generic -metabolite KEGG:C11620 Syringetin generic -metabolite KEGG:C11621 Tectochrysin generic -metabolite KEGG:C11622 Tetramethylrosamine generic -metabolite KEGG:C11623 Triton X-100 generic -metabolite KEGG:C11624 Tween 20 generic -metabolite KEGG:C11625 Tween 80 generic -metabolite KEGG:C11626 Vinblastine sulfate generic -metabolite KEGG:C11627 ortho-Vanadate generic -metabolite KEGG:C11628 p-Aminobenzamidine dihydrochloride generic -metabolite KEGG:C11629 omega-Carboxy-N-acetyl-LTE4 generic -metabolite KEGG:C11630 15,16-Dihydrobiliverdin generic -metabolite KEGG:C11631 9-Riburonosylhypoxanthine generic -metabolite KEGG:C11632 Polyneuridine aldehyde generic -metabolite KEGG:C11633 16-Epivellosimine generic -metabolite KEGG:C11634 Vellosimine generic -metabolite KEGG:C11635 10-Deoxysarpagine generic -metabolite KEGG:C11636 7-Deoxyloganate generic -metabolite KEGG:C11637 3alpha,12alpha-Dihydroxy-5beta-chol-6-enoate generic -metabolite KEGG:C11638 3-Amino-2-oxopropyl phosphate generic -metabolite KEGG:C11639 Geniposide pentaacetate generic -metabolite KEGG:C11640 Patrinoside generic -metabolite KEGG:C11641 3',4'-Anhydrovinblastine generic -metabolite KEGG:C11642 19-Hydroxytabersonine generic -metabolite KEGG:C11643 16-Hydroxytabersonine generic -metabolite KEGG:C11644 Lamiide generic -metabolite KEGG:C11645 Lamioside generic -metabolite KEGG:C11646 Deoxyloganin tetraacetate generic -metabolite KEGG:C11647 Deoxyloganic acid tetraacetate generic -metabolite KEGG:C11648 8-Epideoxyloganin generic -metabolite KEGG:C11649 8-Epideoxyloganic acid generic -metabolite KEGG:C11650 8-Epideoxyloganin tetraacetate generic -metabolite KEGG:C11651 8-Epiiridodial generic -metabolite KEGG:C11652 8-Epiiridotrial glucoside generic -metabolite KEGG:C11653 Iridotrial glucoside generic -metabolite KEGG:C11654 Tarennoside generic -metabolite KEGG:C11655 Asperuloside tetraacetate generic -metabolite KEGG:C11656 8-Epiiridodial glucoside generic -metabolite KEGG:C11657 Iridodial glucoside tetraacetate generic -metabolite KEGG:C11658 8-Epiiridodial glucoside tetraacetate generic -metabolite KEGG:C11659 10-Hydroxyloganin generic -metabolite KEGG:C11660 10-Hydroxymorroniside generic -metabolite KEGG:C11661 7-Epiloganic acid generic -metabolite KEGG:C11662 7-Epiloganin tetraacetate generic -metabolite KEGG:C11663 Loganin pentaacetate generic -metabolite KEGG:C11664 10-Deoxygeniposide tetraacetate generic -metabolite KEGG:C11665 7-Deoxygardoside metyl ester tetraacetate generic -metabolite KEGG:C11666 11-Hydroxyiridodial glucoside pentaacetate generic -metabolite KEGG:C11667 8-epi-11-Hydroxyiridodial glucoside pentaacetate generic -metabolite KEGG:C11668 7-Dehydrologanin tetraacetate generic -metabolite KEGG:C11669 Deutzioside pentaacetate generic -metabolite KEGG:C11670 Iridodial glucoside generic -metabolite KEGG:C11671 Deutzioside generic -metabolite KEGG:C11672 10-Deoxygeniposidic acid generic -metabolite KEGG:C11673 Geniposidic acid generic -metabolite KEGG:C11674 Secogalioside generic -metabolite KEGG:C11675 16-Methoxytabersonine generic -metabolite KEGG:C11676 Lochnericine generic -metabolite KEGG:C11677 Horhammericine generic -metabolite KEGG:C11678 Dialdehyde generic -metabolite KEGG:C11679 4,21-Dehydrocorynantheine aldehyde generic -metabolite KEGG:C11680 Cathenamine generic -metabolite KEGG:C11681 19-epi-Cathenamine generic -metabolite KEGG:C11682 Tetrahydroalstonine generic -metabolite KEGG:C11683 19-epi-Ajmalicine generic -metabolite KEGG:C11684 MET-enkephalin generic -metabolite KEGG:C11685 Clorgyline generic -metabolite KEGG:C11686 Uracil mustard generic -metabolite KEGG:C11687 Aziridine generic -metabolite KEGG:C11688 Asperlicin generic -metabolite KEGG:C11689 Curacin A generic -metabolite KEGG:C11690 Epibatidine generic -metabolite KEGG:C11691 Stemmadenine generic -metabolite KEGG:C11692 Tetrodotoxin generic -metabolite KEGG:C11694 Quinoline-3-carboxamides generic -metabolite KEGG:C11695 Anandamide generic -metabolite KEGG:C11696 Practolol generic -metabolite KEGG:C11697 Levcromakalim generic -metabolite KEGG:C11698 UH-301 generic -metabolite KEGG:C11699 Glenvastatin generic -metabolite KEGG:C11700 10-Deacetylbaccatin III generic -metabolite KEGG:C11701 UK-47265 generic -metabolite KEGG:C11702 Tienilic acid generic -metabolite KEGG:C11703 L-Isoprenaline generic -metabolite KEGG:C11704 DuP 697 generic -metabolite KEGG:C11705 SC-58125 generic -metabolite KEGG:C11706 SC-57666 generic -metabolite KEGG:C11707 Pronethalol generic -metabolite KEGG:C11708 Sultopride generic -metabolite KEGG:C11709 DU 122290 generic -metabolite KEGG:C11710 Devazepide generic -metabolite KEGG:C11711 Succinylproline generic -metabolite KEGG:C11712 Teprotide generic -metabolite KEGG:C11713 2-Naphthol generic -metabolite KEGG:C11714 1-Naphthol generic -metabolite KEGG:C11715 Lucanthone generic -metabolite KEGG:C11716 Mirasan generic -metabolite KEGG:C11717 D1927 generic -metabolite KEGG:C11718 L791456 generic -metabolite KEGG:C11719 L787257 generic -metabolite KEGG:C11720 Enalaprilat generic -metabolite KEGG:C11721 Candoxatrilat generic -metabolite KEGG:C11723 Hexobarbitone generic -metabolite KEGG:C11724 Cycloguanil pamoate generic -metabolite KEGG:C11725 Avizafone generic -metabolite KEGG:C11726 Chloramphenicol palmitate generic -metabolite KEGG:C11727 Chloramphenicol succinate generic -metabolite KEGG:C11728 Clindamycin phosphate generic -metabolite KEGG:C11729 Hetacillin generic -metabolite KEGG:C11730 Temoporfin generic -metabolite KEGG:C11731 m-Chlorobenzamide generic -metabolite KEGG:C11732 Diethyl phenyl phosphate generic -metabolite KEGG:C11733 Decamethonium generic -metabolite KEGG:C11734 Altanserin generic -metabolite KEGG:C11735 N-Ethylglycine generic -metabolite KEGG:C11736 5-Fluorodeoxyuridine generic -metabolite KEGG:C11737 CB3717 generic -metabolite KEGG:C11738 m-Chlorophenylpiperazine generic -metabolite KEGG:C11739 SB 200646 generic -metabolite KEGG:C11740 SB 206553 generic -metabolite KEGG:C11741 SB 221284 generic -metabolite KEGG:C11742 SB 228357 generic -metabolite KEGG:C11743 SB 243213 generic -metabolite KEGG:C11744 Salvarsan generic -metabolite KEGG:C11745 Succinyl sulfathiazole generic -metabolite KEGG:C11746 Penillic acid generic -metabolite KEGG:C11747 Penicillenic acid generic -metabolite KEGG:C11748 Flucloxacillin generic -metabolite KEGG:C11749 (p-Aminobenzyl)penicillin generic -metabolite KEGG:C11750 Pivampicillin generic -metabolite KEGG:C11751 Talampicillin generic -metabolite KEGG:C11752 Carfecillin generic -metabolite KEGG:C11754 Cephaloridine generic -metabolite KEGG:C11755 Epithienamycin E generic -metabolite KEGG:C11756 6-Methylpenicillin generic -metabolite KEGG:C11757 Acyl-D-Ala-D-Ala generic -metabolite KEGG:C11758 Mupirocin generic -metabolite KEGG:C11760 Amprotropine generic -metabolite KEGG:C11761 Tridihexethyl bromide generic -metabolite KEGG:C11762 Propantheline chloride generic -metabolite KEGG:C11763 Miotine generic -metabolite KEGG:C11764 Sarin generic -metabolite KEGG:C11765 1-Methyl-1,6-dihydropyridine-2-carbaldoxime generic -metabolite KEGG:C11766 Rivastigmine generic -metabolite KEGG:C11767 Xanomeline generic -metabolite KEGG:C11768 Levonordefrin generic -metabolite KEGG:C11769 R-Soterenol generic -metabolite KEGG:C11770 R-Salbutamol generic -metabolite KEGG:C11771 Salmefamol generic -metabolite KEGG:C11772 DCI generic -metabolite KEGG:C11773 Epanolol generic -metabolite KEGG:C11774 Primidolol generic -metabolite KEGG:C11775 Xamoterol generic -metabolite KEGG:C11776 alpha-Methyl-m-tyramine generic -metabolite KEGG:C11777 Iproniazid generic -metabolite KEGG:C11778 3-Acetylmorphine generic -metabolite KEGG:C11779 Heterocodeine generic -metabolite KEGG:C11780 6-Ethylmorphine generic -metabolite KEGG:C11781 6-Acetylmorphine generic -metabolite KEGG:C11782 Dihydromorphine generic -metabolite KEGG:C11783 Minovincinine generic -metabolite KEGG:C11784 Echitovenine generic -metabolite KEGG:C11785 Normorphine generic -metabolite KEGG:C11786 Morphine N-oxide generic -metabolite KEGG:C11787 Nalorphine generic -metabolite KEGG:C11788 17-Methylmorphinan generic -metabolite KEGG:C11789 Metazocine generic -metabolite KEGG:C11790 Phenazocine generic -metabolite KEGG:C11791 Bremazocine generic -metabolite KEGG:C11792 Ketobemidone generic -metabolite KEGG:C11793 Etorphine generic -metabolite KEGG:C11794 Diprenorphine generic -metabolite KEGG:C11795 Ethylketocyclazocine generic -metabolite KEGG:C11796 U50488 generic -metabolite KEGG:C11797 Tifluadom generic -metabolite KEGG:C11798 Mepyramine generic -metabolite KEGG:C11799 SK&F 91581 generic -metabolite KEGG:C11800 Thiaburimamide generic -metabolite KEGG:C11801 4-Methylburimamide generic -metabolite KEGG:C11802 Oxaburimamide generic -metabolite KEGG:C11803 Oxmetidine generic -metabolite KEGG:C11804 Lamtidine generic -metabolite KEGG:C11805 Loxtidine generic -metabolite KEGG:C11806 Pantoprazole generic -metabolite KEGG:C11807 Vinorine generic -metabolite KEGG:C11808 1,2-Dihydrovomilenine generic -metabolite KEGG:C11809 17-O-Acetylnorajmaline generic -metabolite KEGG:C11810 Norajmaline generic -metabolite KEGG:C11811 1-Hydroxy-2-methyl-2-butenyl 4-diphosphate generic -metabolite KEGG:C11812 Lochnerinine generic -metabolite KEGG:C11813 Demethylalangiside generic -metabolite KEGG:C11814 Demethylisoalangiside generic -metabolite KEGG:C11815 Isoalangiside generic -metabolite KEGG:C11816 Protoemetine generic -metabolite KEGG:C11817 Deoxytubulosine generic -metabolite KEGG:C11818 (R)-Canadine generic -metabolite KEGG:C11819 Cromakalim generic -metabolite KEGG:C11820 alpha-Methyl-m-tyrosine generic -metabolite KEGG:C11821 5-Hydroxyisourate generic -metabolite KEGG:C11822 2-Aminomalonate semialdehyde generic -metabolite KEGG:C11823 2,3-Ene acid generic -metabolite KEGG:C11824 Cyclic amide generic -metabolite KEGG:C11825 3beta-Hydroxy-5beta-pregnane-20-one generic -metabolite KEGG:C11826 [GlcNAc-(1->4)-Mur2Ac(oyl-L-Ala-g-D-Glu-L-Lys-D-Ala-D-Ala)]n-diphosphoundecaprenol generic -metabolite KEGG:C11827 [GlcNAc-(1->4)-Mur2Ac(oyl-L-Ala-g-D-Glu-A2pm-D-Ala-D-Ala)]n-diphosphoundecaprenol generic -metabolite KEGG:C11829 13(1)-Hydroxy-magnesium-protoporphyrin IX 13-monomethyl ester generic -metabolite KEGG:C11830 13(1)-Oxo-magnesium-protoporphyrin IX 13-monomethyl ester generic -metabolite KEGG:C11831 Divinylprotochlorophyllide generic -metabolite KEGG:C11832 Divinyl chlorophyllide a generic -metabolite KEGG:C11833 Isoclavulanic acid generic -metabolite KEGG:C11834 4-Benzyloxybenzyl alcohol generic -metabolite KEGG:C11837 N-Butyryl-L-homoserine lactone generic -metabolite KEGG:C11838 (S)-4,5-Dihydroxypentane-2,3-dione generic -metabolite KEGG:C11839 N-(3-Oxohexanoyl)homoserine lactone generic -metabolite KEGG:C11840 N-(3-Oxododecanoyl)homoserine lactone generic -metabolite KEGG:C11841 N-(3-Oxooctanoyl)homoserine lactone generic -metabolite KEGG:C11842 N-(3-(S)-Hydroxybutyryl)homoserine lactone generic -metabolite KEGG:C11843 2 -(Butylamido)-4-hydroxybutanoic acid generic -metabolite KEGG:C11844 N-Heptanoylhomoserine lactone generic -metabolite KEGG:C11845 N-(3-Hydroxy-7-cis-tetradecenoyl)homoserine lactone generic -metabolite KEGG:C11846 Cyclo(deltaAla-L-Val) generic -metabolite KEGG:C11847 Cyclo(L-Phe-L-Pro) generic -metabolite KEGG:C11848 2-Heptyl-3-hydroxy-quinolone generic -metabolite KEGG:C11849 3-Hydroxy-palmitic acid methyl ester generic -metabolite KEGG:C11850 Divinylchlorophyll a generic -metabolite KEGG:C11851 Zn-Bacteriochlorophyll a generic -metabolite KEGG:C11853 Gibberellin A14 aldehyde generic -metabolite KEGG:C11854 Gibberellin A51-catabolite generic -metabolite KEGG:C11855 Gibberellin A29-catabolite generic -metabolite KEGG:C11856 Gibberellin A6 generic -metabolite KEGG:C11857 Gibberellin A12 generic -metabolite KEGG:C11858 Gibberellin A14 generic -metabolite KEGG:C11859 Gibberellin A37 open lactone generic -metabolite KEGG:C11860 Gibberellin A15 open lactone generic -metabolite KEGG:C11861 Gibberellin A24 generic -metabolite KEGG:C11862 Gibberellin A36 generic -metabolite KEGG:C11863 Gibberellin A9 generic -metabolite KEGG:C11864 Gibberellin A4 generic -metabolite KEGG:C11865 Gibberellin A51 generic -metabolite KEGG:C11866 2,3-Dehydro-gibberellin A9 generic -metabolite KEGG:C11867 Gibberellin A7 generic -metabolite KEGG:C11868 Gibberellin A34 generic -metabolite KEGG:C11869 Gibberellin A34-catabolite generic -metabolite KEGG:C11870 Gibberellin A8-catabolite generic -metabolite KEGG:C11871 Gibberellin A5 generic -metabolite KEGG:C11872 Kaur-16-en-18-ol generic -metabolite KEGG:C11873 Kaur-16-en-18-al generic -metabolite KEGG:C11874 Kaur-16-en-18-oic acid generic -metabolite KEGG:C11875 ent-7alpha-Hydroxykaur-16-en-19-oic acid generic -metabolite KEGG:C11876 6beta,7beta-Dihydroxykaurenoic acid generic -metabolite KEGG:C11877 (+)-Sandaracopimaradiene generic -metabolite KEGG:C11878 (-)-Abietadiene generic -metabolite KEGG:C11879 Levopimaradiene generic -metabolite KEGG:C11880 Neoabietadiene generic -metabolite KEGG:C11881 Palustradiene generic -metabolite KEGG:C11882 Abietinol generic -metabolite KEGG:C11883 Levopimarinol generic -metabolite KEGG:C11884 Neoabietinol generic -metabolite KEGG:C11885 Neoabietal generic -metabolite KEGG:C11886 Levopimarinal generic -metabolite KEGG:C11887 Abietal generic -metabolite KEGG:C11888 Levopimaric acid generic -metabolite KEGG:C11889 Neoabietic acid generic -metabolite KEGG:C11890 Aphidicolan-16beta-ol generic -metabolite KEGG:C11891 Aphidicol-16-ene generic -metabolite KEGG:C11892 Aphidicol-15-ene generic -metabolite KEGG:C11893 Cembrene generic -metabolite KEGG:C11894 Taxa-4(5),11(12)-diene generic -metabolite KEGG:C11895 Taxa-4(20),11(12)-dien-5alpha-ol generic -metabolite KEGG:C11896 Taxa-4(20),11(12)-dien-5alpha-yl acetate generic -metabolite KEGG:C11897 Taxa-4(20),11(12)-dien-5alpha,13alpha-diol generic -metabolite KEGG:C11898 Taxa-4(20),11(12)-dien-5alpha-acetoxy-10beta-ol generic -metabolite KEGG:C11899 10-Deacetyl-2-debenzoylbaccatin III generic -metabolite KEGG:C11900 Baccatin III generic -metabolite KEGG:C11901 Copalyl diphosphate generic -metabolite KEGG:C11902 9alpha-Copalyl diphosphate generic -metabolite KEGG:C11903 Methanophenazine generic -metabolite KEGG:C11904 Dihydromethanophenazine generic -metabolite KEGG:C11905 Gibberellin A53 aldehyde generic -metabolite KEGG:C11906 Sodium arsenite generic -metabolite KEGG:C11907 dTDP-4-oxo-6-deoxy-D-glucose generic -metabolite KEGG:C11908 3,6-Dideoxy-3-oxo-dTDP-D-glucose generic -metabolite KEGG:C11909 dTDP-3-oxo-4,6-dideoxy-D-glucose generic -metabolite KEGG:C11910 dTDP-3-amino-3,4,6-trideoxy-D-glucose generic -metabolite KEGG:C11911 dTDP-D-desosamine generic -metabolite KEGG:C11912 dTDP-6-deoxy-D-allose generic -metabolite KEGG:C11913 D-Mycinose generic -metabolite KEGG:C11915 dTDP-3-methyl-4-oxo-2,6-dideoxy-L-allose generic -metabolite KEGG:C11916 dTDP-L-mycarose generic -metabolite KEGG:C11917 L-Cladinose generic -metabolite KEGG:C11918 Maltol generic -metabolite KEGG:C11919 dTDP-L-megosamine generic -metabolite KEGG:C11920 dTDP-L-olivose generic -metabolite KEGG:C11921 dTDP-L-oleandrose generic -metabolite KEGG:C11922 dTDP-4-oxo-2,6-dideoxy-D-glucose generic -metabolite KEGG:C11923 dTDP-D-olivose generic -metabolite KEGG:C11924 Perillic acid generic -metabolite KEGG:C11925 dTDP-3-amino-3,6-dideoxy-D-glucose generic -metabolite KEGG:C11926 dTDP-4-oxo-6-deoxy-D-allose generic -metabolite KEGG:C11927 dTDP-4-oxo-2,6-dideoxy-L-mannose generic -metabolite KEGG:C11928 dTDP-4-oxo-2,6-dideoxy-D-allose generic -metabolite KEGG:C11929 Perillyl-CoA generic -metabolite KEGG:C11930 dTDP-2,6-dideoxy-D-glycero-hex-2-enos-4-ulose generic -metabolite KEGG:C11931 dTDP-2,6-dideoxy-L-glycero-hex-2-enos-4-ulose generic -metabolite KEGG:C11932 dTDP-2,6-dideoxy-L-erythro-hexos-3-ulose generic -metabolite KEGG:C11933 dTDP-D-mycaminose generic -metabolite KEGG:C11934 2-Hydroxy-4-isopropenylcyclohexane-1-carboxyl-CoA generic -metabolite KEGG:C11935 4-Isopropenyl-2-oxy-cyclohexanecarboxyl-CoA generic -metabolite KEGG:C11936 3-Isopropenylpimelyl-CoA generic -metabolite KEGG:C11937 (1S,4R)-1-Hydroxy-2-oxolimonene generic -metabolite KEGG:C11938 Myrtenol generic -metabolite KEGG:C11939 Myrtenal generic -metabolite KEGG:C11940 Myrtenic acid generic -metabolite KEGG:C11941 Pinocarveol generic -metabolite KEGG:C11942 trans-2-Methyl-5-isopropylhexa-2,5-dienal generic -metabolite KEGG:C11943 trans-2-Methyl-5-isopropylhexa-2,5-dienoic acid generic -metabolite KEGG:C11944 cis-2-Methyl-5-isopropylhexa-2,5-dienoic acid generic -metabolite KEGG:C11945 trans-2-Methyl-5-isopropylhexa-2,5-dienoyl-CoA generic -metabolite KEGG:C11946 cis-2-Methyl-5-isopropylhexa-2,5-dienoyl-CoA generic -metabolite KEGG:C11947 3-Hydroxy-2,6-dimethyl-5-methylene-heptanoyl-CoA generic -metabolite KEGG:C11948 2,6-Dimethyl-5-methylene-3-oxo-heptanoyl-CoA generic -metabolite KEGG:C11949 3-Isopropylbut-3-enoyl-CoA generic -metabolite KEGG:C11950 3-Isopropyl-3-butenoic acid generic -metabolite KEGG:C11951 (+)-cis-Isopulegone generic -metabolite KEGG:C11952 (+)-Isomenthone generic -metabolite KEGG:C11953 6,8a-Seco-6,8a-deoxy-5-oxoavermectin ''2b'' aglycone generic -metabolite KEGG:C11954 5-Oxoavermectin ''2b'' aglycone generic -metabolite KEGG:C11955 Avermectin B2b aglycone generic -metabolite KEGG:C11956 Avermectin A2b aglycone generic -metabolite KEGG:C11957 Avermectin B2b monosaccharide generic -metabolite KEGG:C11958 Avermectin A2b monosaccharide generic -metabolite KEGG:C11959 Avermectin B2b generic -metabolite KEGG:C11960 Avermectin A2b generic -metabolite KEGG:C11961 6,8a-Seco-6,8a-deoxy-5-oxoavermectin ''1b'' aglycone generic -metabolite KEGG:C11962 5-Oxoavermectin ''1b'' aglycone generic -metabolite KEGG:C11963 Avermectin B1b aglycone generic -metabolite KEGG:C11964 Avermectin A1b aglycone generic -metabolite KEGG:C11965 Avermectin B1b monosaccharide generic -metabolite KEGG:C11966 Avermectin A1b monosaccharide generic -metabolite KEGG:C11967 Avermectin B1b generic -metabolite KEGG:C11968 Avermectin A1b generic -metabolite KEGG:C11969 6,8a-Seco-6,8a-deoxy-5-oxoavermectin ''2a'' aglycone generic -metabolite KEGG:C11970 5-Oxoavermectin ''2a'' aglycone generic -metabolite KEGG:C11971 Avermectin B2a aglycone generic -metabolite KEGG:C11972 Avermectin A2a aglycone generic -metabolite KEGG:C11973 Avermectin B2a monosaccharide generic -metabolite KEGG:C11974 Avermectin A2a monosaccharide generic -metabolite KEGG:C11975 Avermectin B2a generic -metabolite KEGG:C11976 Avermectin A2a generic -metabolite KEGG:C11977 6,8a-Seco-6,8a-deoxy-5-oxoavermectin ''1a'' aglycone generic -metabolite KEGG:C11978 5-Oxoavermectin ''1a'' aglycone generic -metabolite KEGG:C11979 Avermectin B1a aglycone generic -metabolite KEGG:C11980 Avermectin A1a aglycone generic -metabolite KEGG:C11981 Avermectin B1a monosaccharide generic -metabolite KEGG:C11982 Avermectin A1a monosaccharide generic -metabolite KEGG:C11983 Avermectin B1a generic -metabolite KEGG:C11984 Avermectin A1a generic -metabolite KEGG:C11985 Megalomicin A generic -metabolite KEGG:C11986 Megalomicin B generic -metabolite KEGG:C11987 Megalomicin C1 generic -metabolite KEGG:C11988 Megalomicin C2 generic -metabolite KEGG:C11989 8,8a-Deoxyoleandolide generic -metabolite KEGG:C11990 Oleandolide generic -metabolite KEGG:C11991 L-Olivosyl-oleandolide generic -metabolite KEGG:C11992 L-Oleandrosyl-oleandolide generic -metabolite KEGG:C11993 10-Deoxymethynolide generic -metabolite KEGG:C11994 10-Deoxymethymycin generic -metabolite KEGG:C11995 Neomethymycin generic -metabolite KEGG:C11996 Methymycin generic -metabolite KEGG:C11997 Narbonolide generic -metabolite KEGG:C11998 Narbomycin generic -metabolite KEGG:C11999 Pikromycin generic -metabolite KEGG:C12000 Tylactone generic -metabolite KEGG:C12001 5-O-beta-D-Mycaminosyltylactone generic -metabolite KEGG:C12002 5-O-beta-D-Mycaminosyltylonolide generic -metabolite KEGG:C12003 Demethyllactenocin generic -metabolite KEGG:C12006 Liposidomycin B generic -metabolite KEGG:C12007 Mureidomycin A generic -metabolite KEGG:C12008 Ramoplanin A2 generic -metabolite KEGG:C12009 Telithromycin generic -metabolite KEGG:C12011 DMG-MINO generic -metabolite KEGG:C12012 Tigecycline generic -metabolite KEGG:C12013 Daptomycin generic -metabolite KEGG:C12014 Chloroeremomycin generic -metabolite KEGG:C12016 A47934 generic -metabolite KEGG:C12017 MK826 generic -metabolite KEGG:C12018 SM-17466 generic -metabolite KEGG:C12019 2-(Biaryl)carbapenems generic -metabolite KEGG:C12020 Cethromycin generic -metabolite KEGG:C12021 Alanylphosphate generic -metabolite KEGG:C12022 Phosphophosphinate generic -metabolite KEGG:C12023 Undecylprodigiosin generic -metabolite KEGG:C12024 Calcium-dependent antibiotic generic -metabolite KEGG:C12025 2,6-Diamino-7-hydroxy-azelaic acid generic -metabolite KEGG:C12026 3,5-Dihydroxy-phenylglycine generic -metabolite KEGG:C12027 2-Amino-9,10-epoxy-8-oxodecanoic acid generic -metabolite KEGG:C12029 (E)-2-Butenyl-4-methyl-threonine generic -metabolite KEGG:C12030 Mycosubtilin generic -metabolite KEGG:C12032 Clorobiocin generic -metabolite KEGG:C12033 4-Aminophenylalanine generic -metabolite KEGG:C12034 Chlorobiphenyl-chloroeremomycin generic -metabolite KEGG:C12035 Chlorobiphenyl-vancomycin generic -metabolite KEGG:C12036 Chlorobiphenyl-desleucyl-vancomycin generic -metabolite KEGG:C12037 Pyochelin generic -metabolite KEGG:C12038 Yersiniabactin generic -metabolite KEGG:C12039 Epothilone D generic -metabolite KEGG:C12040 Telomestatin generic -metabolite KEGG:C12041 Tyrocidine generic -metabolite KEGG:C12042 Fengycin generic -metabolite KEGG:C12043 Surfactin generic -metabolite KEGG:C12044 Rifamycin generic -metabolite KEGG:C12045 Ansamitocin P-3 generic -metabolite KEGG:C12046 Teicoplanin A2-2 generic -metabolite KEGG:C12047 Nanchangmycin generic -metabolite KEGG:C12048 Griseorhodin A generic -metabolite KEGG:C12049 Neocarzinostatin chromophore generic -metabolite KEGG:C12050 Everninomycin generic -metabolite KEGG:C12051 Micrococcin generic -metabolite KEGG:C12052 Thiocillin generic -metabolite KEGG:C12053 Nosiheptide generic -metabolite KEGG:C12054 Thiostrepton generic -metabolite KEGG:C12055 Sulfamycin B generic -metabolite KEGG:C12056 Actinonin generic -metabolite KEGG:C12057 Cyclothialidine generic -metabolite KEGG:C12058 Cerulenin generic -metabolite KEGG:C12059 Triclosan generic -metabolite KEGG:C12062 Naphthyl dipeptide generic -metabolite KEGG:C12063 Tunicamycin generic -metabolite KEGG:C12064 Resorcinol monoacetate generic -metabolite KEGG:C12065 Tiamulin generic -metabolite KEGG:C12066 Valnemulin generic -metabolite KEGG:C12067 2-Deoxy-2-dimethylamino-alpha-D-Glucose generic -metabolite KEGG:C12068 GE2270A generic -metabolite KEGG:C12069 3-Hydroxypropenoate generic -metabolite KEGG:C12070 Pulvomycin generic -metabolite KEGG:C12072 Gardneral generic -metabolite KEGG:C12073 11-Methoxy-vinorine generic -metabolite KEGG:C12075 Tetraphyllicine generic -metabolite KEGG:C12076 Deoxyanisatin generic -metabolite KEGG:C12077 Palustric acid generic -metabolite KEGG:C12078 Dehydroabietic acid generic -metabolite KEGG:C12079 alpha-Arbutin generic -metabolite KEGG:C12080 Resistomycin generic -metabolite KEGG:C12081 Soyasaponin II generic -metabolite KEGG:C12082 alpha-L-Rhamnopyranosyl-(1->2)-beta-D-galactopyranosyl-(1->2)-beta-D-glucuronopyranoside generic -metabolite KEGG:C12083 (5Z,7E,9E,14Z,17Z)-Icosapentaenoate generic -metabolite KEGG:C12085 Bis-noryangonin generic -metabolite KEGG:C12087 p-Coumaroyltriacetic acid lactone generic -metabolite KEGG:C12088 4-Hydroxycinnamoylmethane generic -metabolite KEGG:C12089 NAC-Diketide generic -metabolite KEGG:C12090 Methylstyrylpyron generic -metabolite KEGG:C12091 Cerberoside generic -metabolite KEGG:C12092 N-Methylanthraniloyl-CoA generic -metabolite KEGG:C12093 1,3-Dihydroxy-N-methylacridone generic -metabolite KEGG:C12095 Cyanidin 3-O-(6-O-p-coumaroyl)glucoside generic -metabolite KEGG:C12096 Cyanidin 3-O-(6-O-p-coumaroyl)glucoside-5-O-glucoside generic -metabolite KEGG:C12098 Ansatrienin A generic -metabolite KEGG:C12099 Asukamycin generic -metabolite KEGG:C12100 omega-Cyclohexylundecanoic acid generic -metabolite KEGG:C12101 1-Cyclohexenecarboxylic acid generic -metabolite KEGG:C12102 Immunomycin generic -metabolite KEGG:C12103 omega-Cycloheptylundecanoic acid generic -metabolite KEGG:C12104 Cycloheptanecarboxylic acid generic -metabolite KEGG:C12105 Thiotropocin generic -metabolite KEGG:C12106 AminoDAHP generic -metabolite KEGG:C12107 3-Amino-5-hydroxybenzoate generic -metabolite KEGG:C12108 5-Amino-5-deoxy-3-dehydroshikimate generic -metabolite KEGG:C12109 AminoDHQ generic -metabolite KEGG:C12110 Gabaculine generic -metabolite KEGG:C12111 Manumycin A generic -metabolite KEGG:C12112 Validamycin A generic -metabolite KEGG:C12113 Valiolone generic -metabolite KEGG:C12114 4-Hydroxy-3-nitrosobenzamide generic -metabolite KEGG:C12115 3-Amino-4-hydroxybenzoate generic -metabolite KEGG:C12116 Esmeraldic acid generic -metabolite KEGG:C12117 Saphenic acid generic -metabolite KEGG:C12118 Saphenic acid methyl ester generic -metabolite KEGG:C12119 Phenazine-1,6-dicarboxylic acid generic -metabolite KEGG:C12120 6-Acetophenazine-1-carboxylic acid generic -metabolite KEGG:C12121 5-Deoxy-5-aminoshikimic acid generic -metabolite KEGG:C12122 Luteoliflavan generic -metabolite KEGG:C12123 7,4'-Dihydroxyflavone generic -metabolite KEGG:C12124 Apiforol generic -metabolite KEGG:C12125 Isoformononetin generic -metabolite KEGG:C12126 Dihydroceramide generic -metabolite KEGG:C12127 (+)-Gallocatechin generic -metabolite KEGG:C12128 (-)-Epiafzelechin generic -metabolite KEGG:C12129 Anemone purple anthocyanin 1 generic -metabolite KEGG:C12130 Anemone blue anthocyanin 1 generic -metabolite KEGG:C12131 Anemone blue anthocyanin 2 generic -metabolite KEGG:C12132 Anemone blue anthocyanin 3 generic -metabolite KEGG:C12133 Anemone blue anthocyanin 4 generic -metabolite KEGG:C12134 2'-Hydroxygenistein generic -metabolite KEGG:C12135 2'-Hydroxybiochanin A generic -metabolite KEGG:C12136 (-)-Epigallocatechin generic -metabolite KEGG:C12137 Pelargonidin 3-O-glucoside generic -metabolite KEGG:C12138 Delphinidin 3-O-glucoside generic -metabolite KEGG:C12139 Petunidin 3-O-glucoside generic -metabolite KEGG:C12140 Malvidin 3-O-glucoside generic -metabolite KEGG:C12141 Peonidin 3-O-glucoside generic -metabolite KEGG:C12142 Vetispiradiene generic -metabolite KEGG:C12143 2-Aminoacridone generic -metabolite KEGG:C12144 Phytosphingosine generic -metabolite KEGG:C12145 Phytoceramide generic -metabolite KEGG:C12146 C26-CoA generic -metabolite KEGG:C12147 L-Threonine O-3-phosphate generic -metabolite KEGG:C12148 Stigmatellin A generic -metabolite KEGG:C12149 Stigmatellin X generic -metabolite KEGG:C12150 Stigmatellin Y generic -metabolite KEGG:C12151 Mycolactone generic -metabolite KEGG:C12152 Niddamycin generic -metabolite KEGG:C12153 Epothilone A generic -metabolite KEGG:C12154 Epothilone B generic -metabolite KEGG:C12155 Nystatin A1 generic -metabolite KEGG:C12156 Nystatin A3 generic -metabolite KEGG:C12157 Myxalamid S generic -metabolite KEGG:C12158 Myxalamid A generic -metabolite KEGG:C12159 Myxalamid B generic -metabolite KEGG:C12160 Myxalamid C generic -metabolite KEGG:C12161 Myxalamid D generic -metabolite KEGG:C12162 Crinine generic -metabolite KEGG:C12163 Powelline generic -metabolite KEGG:C12164 Hamayne generic -metabolite KEGG:C12165 3-O-Acetylhamayne generic -metabolite KEGG:C12166 1-O-Acetyllycorine generic -metabolite KEGG:C12167 Cherylline generic -metabolite KEGG:C12168 Crinamidine generic -metabolite KEGG:C12169 1-Epideacetylbowdensine generic -metabolite KEGG:C12170 Zephyranthine generic -metabolite KEGG:C12171 1,2-O-Diacetylzephyranthine generic -metabolite KEGG:C12172 11alpha-Hydroxygalanthamine generic -metabolite KEGG:C12173 Norgalanthamine generic -metabolite KEGG:C12174 Haemanthidine generic -metabolite KEGG:C12176 Proansamycin X generic -metabolite KEGG:C12177 Proansamitocin generic -metabolite KEGG:C12178 3-Epimacronine generic -metabolite KEGG:C12179 Tazettine generic -metabolite KEGG:C12180 (-)-8-Demethylmaritidine generic -metabolite KEGG:C12181 Ismine generic -metabolite KEGG:C12182 Trisphaeridine generic -metabolite KEGG:C12183 Obliquine generic -metabolite KEGG:C12184 Narcissidine generic -metabolite KEGG:C12185 Nangustine generic -metabolite KEGG:C12186 Pancracine generic -metabolite KEGG:C12187 Pseudolycorine generic -metabolite KEGG:C12188 Vasconine generic -metabolite KEGG:C12189 Ungeremine generic -metabolite KEGG:C12190 9-O-Demethylhomolycorine generic -metabolite KEGG:C12191 ent-6beta-Hydroxybuphanisine generic -metabolite KEGG:C12192 ent-6alpha-Hydroxybuphanisine generic -metabolite KEGG:C12193 Vittatine generic -metabolite KEGG:C12194 11-Hydroxyvittatine generic -metabolite KEGG:C12195 Zephyramine generic -metabolite KEGG:C12196 Bocconarborine A generic -metabolite KEGG:C12197 (+/-)-Bocconarborine B generic -metabolite KEGG:C12198 6-(2-Hydroxyethyl)-5,6-dihydrosanguinarine generic -metabolite KEGG:C12199 3-Methoxy-8,9-methylenedioxy-3,4-dihydrophenanthridine generic -metabolite KEGG:C12200 (+/-)-6-Acetonyldihydrochelerythrine generic -metabolite KEGG:C12201 (+/-)-6-Acetonyldihydrosanguinarine generic -metabolite KEGG:C12202 Platenolide A generic -metabolite KEGG:C12203 5-Hydroxyferuloyl-CoA generic -metabolite KEGG:C12204 5-Hydroxyconiferaldehyde generic -metabolite KEGG:C12205 5-Hydroxyconiferyl alcohol generic -metabolite KEGG:C12206 Caffeyl alcohol generic -metabolite KEGG:C12208 p-Coumaroyl quinic acid generic -metabolite KEGG:C12210 UDP-3-ketoglucose generic -metabolite KEGG:C12211 UDP-kanosamine generic -metabolite KEGG:C12212 Kanosamine generic -metabolite KEGG:C12213 Kanosamine 6-phosphate generic -metabolite KEGG:C12214 Aminofructose 6-phosphate generic -metabolite KEGG:C12215 Iminoerythrose 4-phosphate generic -metabolite KEGG:C12216 Mycobactin S generic -metabolite KEGG:C12217 Fe(CN)3 generic -metabolite KEGG:C12218 Fe(CN)2 generic -metabolite KEGG:C12219 Corynebactin generic -metabolite KEGG:C12220 Myxochelin A generic -metabolite KEGG:C12221 Myxochelin B generic -metabolite KEGG:C12222 Hydroxysanguinarine generic -metabolite KEGG:C12223 N-Methyl-2,3,7,8-tetramethoxy-5,6-dihydrobenzophenathridine-6-ethanoic acid generic -metabolite KEGG:C12224 N-Methyl-2,3,7,8-tetramethoxybenzophenanthridine-6(5H)-one generic -metabolite KEGG:C12225 6-Oxochelerythrine generic -metabolite KEGG:C12226 Norchelerythrine generic -metabolite KEGG:C12227 Chelerythrine generic -metabolite KEGG:C12228 Sanguilutine generic -metabolite KEGG:C12229 Chelilutine generic -metabolite KEGG:C12230 Sanguirubine generic -metabolite KEGG:C12231 Anhalamine generic -metabolite KEGG:C12232 Sanguinine generic -metabolite KEGG:C12233 Lycoramine generic -metabolite KEGG:C12234 Epinorlycoramine generic -metabolite KEGG:C12235 Assoanine generic -metabolite KEGG:C12236 Oxoassoanine generic -metabolite KEGG:C12237 2-O-Acetylpseudolycorine generic -metabolite KEGG:C12238 Papyramine generic -metabolite KEGG:C12239 9-O-Demethyl-2alpha-hydroxyhomolycorine generic -metabolite KEGG:C12240 Dubiusine generic -metabolite KEGG:C12241 O-Methyllycorenine generic -metabolite KEGG:C12242 Chelidonine generic -metabolite KEGG:C12243 (+/-)-gamma-Lycorane generic -metabolite KEGG:C12244 3-Buten-1-amine generic -metabolite KEGG:C12245 Methyl5-(but-3-en-1-yl)amino-1,3,4-oxadiazole-2-carboxylate generic -metabolite KEGG:C12246 Protorifamycin I generic -metabolite KEGG:C12247 Rifamycin W generic -metabolite KEGG:C12248 5-Hydroxy-2-oxo-4-ureido-2,5-dihydro-1H-imidazole-5-carboxylate generic -metabolite KEGG:C12249 Kaempferol 3-O-glucoside generic -metabolite KEGG:C12250 Anhydrolycorinone generic -metabolite KEGG:C12251 2-Iodo-6-methoxyphenol generic -metabolite KEGG:C12252 2-Bromo-5-hydroxy-N-[2-(4-hydroxyphenyl)ethyl]-4-methoxy-N-methylbenzamide generic -metabolite KEGG:C12253 Norsanguinine generic -metabolite KEGG:C12254 (+)-Plicamine generic -metabolite KEGG:C12255 7-Deoxypancratistatin generic -metabolite KEGG:C12256 (+)-2,7-Dideoxypancratistatin generic -metabolite KEGG:C12257 Homochelidonine generic -metabolite KEGG:C12258 Arnottin II generic -metabolite KEGG:C12259 (+)-Sceletium A4 generic -metabolite KEGG:C12260 (-)-Tortuosamine generic -metabolite KEGG:C12261 2,3,4-Trioxycyclopentanone generic -metabolite KEGG:C12262 4,4-Disubstituted cyclohexenone generic -metabolite KEGG:C12263 1,2-Dimethoxy-4-[2-(2-propenyloxy)ethenyl]-benzene generic -metabolite KEGG:C12264 6-(2-Methoxyvinyl)benzo[1,3]dioxole-5-carboxylic acid generic -metabolite KEGG:C12265 Lichenysin D generic -metabolite KEGG:C12266 Iturin A generic -metabolite KEGG:C12267 Bacillomycin D generic -metabolite KEGG:C12268 Syringomycin generic -metabolite KEGG:C12269 N-Methyl-D-aspartic acid generic -metabolite KEGG:C12270 N-Acetylaspartylglutamate generic -metabolite KEGG:C12271 N-Arachidonyl dopamine generic -metabolite KEGG:C12272 N-Oleoyl dopamine generic -metabolite KEGG:C12276 Calcium pantothenate generic -metabolite KEGG:C12277 Calcium hydroxide generic -metabolite KEGG:C12278 Copper gluconate generic -metabolite KEGG:C12280 Methyl acetyl ricinoleate generic -metabolite KEGG:C12282 Polyvinyl acetate generic -metabolite KEGG:C12283 Saccharin generic -metabolite KEGG:C12284 Saccharin sodium anhydrous generic -metabolite KEGG:C12285 Sucralose generic -metabolite KEGG:C12286 alpha-Ionone generic -metabolite KEGG:C12287 beta-Ionone generic -metabolite KEGG:C12288 alpha-Amylcinnamaldehyde generic -metabolite KEGG:C12289 Isoamyl isovalerate generic -metabolite KEGG:C12290 Ethyl isovalerate generic -metabolite KEGG:C12292 Ethyl octanoate generic -metabolite KEGG:C12293 Isoamyl formate generic -metabolite KEGG:C12294 Geranyl formate generic -metabolite KEGG:C12295 Citronellyl formate generic -metabolite KEGG:C12296 Isoamyl acetate generic -metabolite KEGG:C12297 Cyclohexyl acetate generic -metabolite KEGG:C12298 Citronellyl acetate generic -metabolite KEGG:C12299 Cinnamyl acetate generic -metabolite KEGG:C12300 alpha-Terpinyl acetate generic -metabolite KEGG:C12301 beta-Terpinyl acetate generic -metabolite KEGG:C12302 gamma-Terpinyl acetate generic -metabolite KEGG:C12303 Phenethyl acetate generic -metabolite KEGG:C12304 Butyl acetate generic -metabolite KEGG:C12305 Methyl salicylate generic -metabolite KEGG:C12306 Allyl cyclohexylpropionate generic -metabolite KEGG:C12307 Decanal generic -metabolite KEGG:C12308 Gibberellin A44 generic -metabolite KEGG:C12309 Esmeraldin A generic -metabolite KEGG:C12310 Esmeraldin B generic -metabolite KEGG:C12311 Saphenamycin generic -metabolite KEGG:C12312 Indolin-2-one generic -metabolite KEGG:C12313 cis-1,2-Cyclohexanediol generic -metabolite KEGG:C12314 1-Oxa-2-oxo-3-hydroxycycloheptane generic -metabolite KEGG:C12316 cis-Dihydroquercetin generic -metabolite KEGG:C12317 D-Allothreonine generic -metabolite KEGG:C12318 dTDP-3-amino-2,3,6-trideoxy-4-keto-D-glucose generic -metabolite KEGG:C12319 dTDP-3-amino-2,3,6-trideoxy-C-methyl-D-erythro-hexopyranos-4-ulose generic -metabolite KEGG:C12320 dTDP-L-4-oxovancosamine generic -metabolite KEGG:C12321 dTDP-L-epivancosamine generic -metabolite KEGG:C12322 dTDP-L-vancosamine generic -metabolite KEGG:C12323 L-4-Hydroxyphenylglycine generic -metabolite KEGG:C12324 3,5-Dihydroxyphenylacetyl-CoA generic -metabolite KEGG:C12325 3,5-Dihydroxyphenylglyoxylate generic -metabolite KEGG:C12326 (R,S)-Scoulerine generic -metabolite KEGG:C12327 Laudanosoline generic -metabolite KEGG:C12328 Reticuline generic -metabolite KEGG:C12329 (R,S)-Norreticuline generic -metabolite KEGG:C12330 2,3,9,10-Tetrahydroxyberbine generic -metabolite KEGG:C12331 2,3,9,10-Tetrahydroxyberberine generic -metabolite KEGG:C12332 Militarinone D generic -metabolite KEGG:C12333 Militarinone A generic -metabolite KEGG:C12334 Militarinone B generic -metabolite KEGG:C12335 Militarinone C generic -metabolite KEGG:C12336 Dioncophylline A generic -metabolite KEGG:C12337 Dioncophylline C generic -metabolite KEGG:C12338 Korupensamine A generic -metabolite KEGG:C12339 Dioncopeltine A generic -metabolite KEGG:C12340 Ancistrotectorine generic -metabolite KEGG:C12341 Dioncophyllinol B generic -metabolite KEGG:C12342 Ancistrobrevine A generic -metabolite KEGG:C12343 Isoshinanolone generic -metabolite KEGG:C12344 1,8-Dihydroxy-3-methylnaphthalene generic -metabolite KEGG:C12345 1,3-Dimethyl-6,8-isoquinolinediol generic -metabolite KEGG:C12346 1,3-Dimethyl-8-isoquinolinol generic -metabolite KEGG:C12347 Deoxyribose triphosphate generic -metabolite KEGG:C12348 3,5,7,9,11,13,15-Heptaoxo-hexadecanoyl-[acp] generic -metabolite KEGG:C12349 3,5,7,9,11,13,15-Heptaoxo-heptadecanoyl-[acp] generic -metabolite KEGG:C12350 3,5,7,9,11,13,15-Heptaoxo-octadecanoyl-[acp] generic -metabolite KEGG:C12351 3,5,7,9,11,13,15,17-Octaoxo-octadecanoyl-[acp] generic -metabolite KEGG:C12352 3,5,7,9,11,13,15,17-Octaoxo-nonadecanoyl-[acp] generic -metabolite KEGG:C12353 3,5,7,9,11,13,15,17-Octaoxo-eicosanoyl-[acp] generic -metabolite KEGG:C12354 3,5,7,9,11,13,15,17,19-Nonaoxo-eicosanoyl-[acp] generic -metabolite KEGG:C12355 3,5,7,9,11,13,15,17,19-Nonaoxo-henicosanoyl-[acp] generic -metabolite KEGG:C12356 3,5,7,9,11,13,15,17,19-Nonaoxo-docosanoyl-[acp] generic -metabolite KEGG:C12357 3,5,7,11,13,15-Heptaoxo-9-hydroxy-hexadecanoyl-[acp] generic -metabolite KEGG:C12358 3,5,7,11,13,15-Heptaoxo-9-hydroxy-heptadecanoyl-[acp] generic -metabolite KEGG:C12359 3,5,7,11,13,15-Heptaoxo-9-hydroxy-octadecanoyl-[acp] generic -metabolite KEGG:C12360 9-Hydroxy-3,5,7,11,13,15,17-octaoxo-octadecanoyl-[acp] generic -metabolite KEGG:C12361 9-Hydroxy-3,5,7,11,13,15,17-octaoxo-nonadecanoyl-[acp] generic -metabolite KEGG:C12362 9-Hydroxy-3,5,7,11,13,15,17-octaoxo-eicosanoyl-[acp] generic -metabolite KEGG:C12363 9-Hydroxy-3,5,7,11,13,15,17,19-nonaoxo-eicosanoyl-[acp] generic -metabolite KEGG:C12364 9-Hydroxy-3,5,7,11,13,15,17,19-nonaoxo-henicosanoyl-[acp] generic -metabolite KEGG:C12365 9-Hydroxy-3,5,7,11,13,15,17,19-nonaoxo-docosanoyl-[acp] generic -metabolite KEGG:C12366 Tetracenomycin F2 generic -metabolite KEGG:C12367 Tetracenomycin F1 generic -metabolite KEGG:C12368 Tetracenomycin D3 generic -metabolite KEGG:C12369 Tetracenomycin B3 generic -metabolite KEGG:C12370 Tetracenomycin E generic -metabolite KEGG:C12371 Tetracenomycin A2 generic -metabolite KEGG:C12372 Tetracenomycin M generic -metabolite KEGG:C12373 Tetracenomycin F1 methylester generic -metabolite KEGG:C12374 Decarboxytetracenomycin F1 generic -metabolite KEGG:C12375 Tetracenomycin D3 methylester generic -metabolite KEGG:C12376 Tetracenomycin D1 generic -metabolite KEGG:C12377 Tetracenomycin B1 generic -metabolite KEGG:C12378 Tetracenomycin B2 generic -metabolite KEGG:C12379 8-Demethyltetracenomycin C generic -metabolite KEGG:C12380 Tetracenomycin X generic -metabolite KEGG:C12381 Elloramycin A generic -metabolite KEGG:C12382 4-Demethylpremithramycinone generic -metabolite KEGG:C12383 Premithramycinone generic -metabolite KEGG:C12384 Premithramycin A1 generic -metabolite KEGG:C12385 Premithramycin A2' generic -metabolite KEGG:C12386 Premithramycin A3' generic -metabolite KEGG:C12387 Premithramycin A3 generic -metabolite KEGG:C12388 Premithramycin B generic -metabolite KEGG:C12389 Mithramycin generic -metabolite KEGG:C12390 Dehydrorabelomycin generic -metabolite KEGG:C12391 Kinobscurinone generic -metabolite KEGG:C12392 Stealthin C generic -metabolite KEGG:C12393 Prekinamycin generic -metabolite KEGG:C12394 Kinamycin D generic -metabolite KEGG:C12395 Jadomycin B generic -metabolite KEGG:C12396 Tetrangomycin generic -metabolite KEGG:C12397 Tetrangulol generic -metabolite KEGG:C12398 8-O-Methyltetrangulol generic -metabolite KEGG:C12399 19-Hydroxytetrangulol generic -metabolite KEGG:C12400 19-Hydroxy-8-O-methyltetrangulol generic -metabolite KEGG:C12401 PD116740 generic -metabolite KEGG:C12402 Rabelomycin generic -metabolite KEGG:C12403 104-1 generic -metabolite KEGG:C12404 Urdamycinone B generic -metabolite KEGG:C12405 100-1 generic -metabolite KEGG:C12406 Urdamycin B generic -metabolite KEGG:C12407 104-2 generic -metabolite KEGG:C12408 100-2 generic -metabolite KEGG:C12409 124-1 generic -metabolite KEGG:C12410 Urdamycinone F generic -metabolite KEGG:C12411 Urdamycin F generic -metabolite KEGG:C12412 Aquayamycin generic -metabolite KEGG:C12413 Urdamycin A generic -metabolite KEGG:C12414 Urdamycin G generic -metabolite KEGG:C12415 Methyl nogalonate generic -metabolite KEGG:C12416 Nogalonate generic -metabolite KEGG:C12417 Auraviketone generic -metabolite KEGG:C12418 Dihydro-NAME generic -metabolite KEGG:C12419 Auramycinone generic -metabolite KEGG:C12420 12-Deoxyaklanonic acid generic -metabolite KEGG:C12421 Aklanonate generic -metabolite KEGG:C12422 Methyl aklanonate generic -metabolite KEGG:C12423 Aklaviketone generic -metabolite KEGG:C12424 Aklavinone generic -metabolite KEGG:C12425 epsilon-Rhodomycinone generic -metabolite KEGG:C12426 Rhodomycin D generic -metabolite KEGG:C12427 10-Carboxy-13-deoxycarminomycin generic -metabolite KEGG:C12428 13-Deoxycarminomycin generic -metabolite KEGG:C12429 13-Deoxydaunorubicin generic -metabolite KEGG:C12430 13-Dihydrodaunorubicin generic -metabolite KEGG:C12431 13-Dihydrocarminomycin generic -metabolite KEGG:C12432 Carminomycin generic -metabolite KEGG:C12433 (13S)-13-Dihydrodaunorubicin generic -metabolite KEGG:C12434 (S)-DNPA generic -metabolite KEGG:C12435 6-Deoxydihydrokalafungin generic -metabolite KEGG:C12436 Dihydrokalafungin generic -metabolite KEGG:C12437 Medermycin generic -metabolite KEGG:C12439 Phenanthroviridone aglycon generic -metabolite KEGG:C12440 Trachelanthamidine generic -metabolite KEGG:C12441 18-Carbamoyl-3,5,7,9,11,13,15,17-octaoxooctadecanoyl-[acp] generic -metabolite KEGG:C12442 C-9 Reduced nonaketamide generic -metabolite KEGG:C12443 dTDP-beta-L-daunosamine generic -metabolite KEGG:C12444 dTDP-D-mycarose generic -metabolite KEGG:C12446 dTDP-D-oliose generic -metabolite KEGG:C12447 dTDP-beta-L-rhodinose generic -metabolite KEGG:C12448 Ecgonine methyl ester generic -metabolite KEGG:C12449 Pseudoecgonine generic -metabolite KEGG:C12450 Pseudoecgonyl-CoA generic -metabolite KEGG:C12451 Fridamycin E generic -metabolite KEGG:C12452 Acetyltropine generic -metabolite KEGG:C12453 Acetylpseudotropine generic -metabolite KEGG:C12454 Anatalline generic -metabolite KEGG:C12455 5-Aminopentanal generic -metabolite KEGG:C12456 3-Dimethylallyl-4-hydroxyphenylpyruvate generic -metabolite KEGG:C12457 3-Dimethylallyl-4-hydroxymandelic acid generic -metabolite KEGG:C12458 3-Dimethylallyl-4-hydroxybenzoate generic -metabolite KEGG:C12459 3-Dimethylallyl-4-hydroxybenzaldehyde generic -metabolite KEGG:C12460 3-Dimethylallyl-beta-hydroxy-L-tyrosyl-[pcp] generic -metabolite KEGG:C12461 L-Tyrosyl-[pcp] generic -metabolite KEGG:C12462 beta-Hydroxy-L-tyrosyl-[pcp] generic -metabolite KEGG:C12463 beta-Keto-L-tyrosyl-[pcp] generic -metabolite KEGG:C12464 3-Methyl-beta-keto-L-tyrosyl-[pcp] generic -metabolite KEGG:C12465 2-Hydroxy-3-methyl-beta-keto-L-tyrosyl-[pcp] generic -metabolite KEGG:C12466 3-Amino-4,7-dihydroxy-8-methylcoumarin generic -metabolite KEGG:C12467 2-Hydroxy-beta-keto-L-tyrosyl-[pcp] generic -metabolite KEGG:C12468 3-Amino-4,7-dihydroxycoumarin generic -metabolite KEGG:C12469 3-Amino-4,7-dihydroxy-8-chlorocoumarin generic -metabolite KEGG:C12470 L-Prolyl-[pcp] generic -metabolite KEGG:C12471 Chlorobiocic acid generic -metabolite KEGG:C12472 Novclobiocin 105 generic -metabolite KEGG:C12473 Novclobiocin 104 generic -metabolite KEGG:C12474 Novobiocic acid generic -metabolite KEGG:C12475 Demethyldecarbamoylnovobiocin generic -metabolite KEGG:C12476 Decarbamoylnovobiocin generic -metabolite KEGG:C12477 3-Methylpyrrole-2,4-dicarboxylic acid generic -metabolite KEGG:C12478 Coumeroic acid generic -metabolite KEGG:C12479 Coumermic acid generic -metabolite KEGG:C12480 Coumermycin D generic -metabolite KEGG:C12481 dTDP-5-dimethyl-L-lyxose generic -metabolite KEGG:C12483 Pyrrole-2-carbonyl-[pcp] generic -metabolite KEGG:C12484 5-Methyl-pyrrole-2-carboxyl-[pcp] generic -metabolite KEGG:C12486 Boric acid generic -metabolite KEGG:C12490 Butenafine hydrochloride generic -metabolite KEGG:C12491 Pyrrolnitrin generic -metabolite KEGG:C12505 Magnesium sulfate generic -metabolite KEGG:C12508 Nateglinide generic -metabolite KEGG:C12512 Eplerenone generic -metabolite KEGG:C12518 Glutaral generic -metabolite KEGG:C12525 5alpha-Androstan-3beta,17beta-diol generic -metabolite KEGG:C12531 Tazarotene generic -metabolite KEGG:C12535 Tranexamic acid generic -metabolite KEGG:C12537 Benzyl benzoate generic -metabolite KEGG:C12538 Ammonium chloride generic -metabolite KEGG:C12539 Benzethonium chloride generic -metabolite KEGG:C12540 Sulfamonomethoxine generic -metabolite KEGG:C12552 Oxethazaine generic -metabolite KEGG:C12554 Potassium acetate generic -metabolite KEGG:C12557 Cefepime hydrochloride generic -metabolite KEGG:C12560 Saquinavir mesylate generic -metabolite KEGG:C12564 Aripiprazole generic -metabolite KEGG:C12567 Magnesium oxide generic -metabolite KEGG:C12568 Potassium hydroxide generic -metabolite KEGG:C12569 Sodium hydroxide generic -metabolite KEGG:C12570 Zinc oxide generic -metabolite KEGG:C12574 Pheniramine maleate generic -metabolite KEGG:C12580 Trilostane generic -metabolite KEGG:C12590 Pheneturide generic -metabolite KEGG:C12599 Emtricitabine generic -metabolite KEGG:C12600 Phenolsulfonphthalein generic -metabolite KEGG:C12603 Sodium bicarbonate generic -metabolite KEGG:C12609 Novobiocin sodium generic -metabolite KEGG:C12616 Sulfamethopyrazine generic -metabolite KEGG:C12621 trans-3-Hydroxycinnamate generic -metabolite KEGG:C12622 cis-3-(3-Carboxyethenyl)-3,5-cyclohexadiene-1,2-diol generic -metabolite KEGG:C12623 trans-2,3-Dihydroxycinnamate generic -metabolite KEGG:C12624 2-Hydroxy-6-ketononatrienedioate generic -metabolite KEGG:C12625 Biochanin A 7-O-(6-O-malonyl-beta-D-glucoside) generic -metabolite KEGG:C12626 Kaempferol-3-O-galactoside generic -metabolite KEGG:C12627 Apigenin 7-O-neohesperidoside generic -metabolite KEGG:C12628 Vitexin 2''-O-beta-L-rhamnoside generic -metabolite KEGG:C12629 Isoswertisin 2''-rhamnoside generic -metabolite KEGG:C12630 Scolymoside generic -metabolite KEGG:C12631 2-Hydroxy-2,3-dihydrogenistein generic -metabolite KEGG:C12632 Luteolin 7-O-[beta-D-glucuronosyl-(1->2)-beta-D-glucuronide] generic -metabolite KEGG:C12633 Laricitrin generic -metabolite KEGG:C12634 Kaempferol 3-O-beta-D-glucosyl-(1->2)-beta-D-glucoside generic -metabolite KEGG:C12635 Kaempferol 3-sophorotrioside generic -metabolite KEGG:C12636 Kaempferol 3-O-[6-(4-coumaroyl)-beta-D-glucosyl-(1->2)-beta-D-glucosyl-(1->2)-beta-D-glucoside] generic -metabolite KEGG:C12637 Quercetin 3-O-[beta-D-xylosyl-(1->2)-beta-D-glucoside] generic -metabolite KEGG:C12638 Quercetin 3-O-(6-O-malonyl-beta-D-glucoside) generic -metabolite KEGG:C12639 Quercimeritrin generic -metabolite KEGG:C12640 Pelargonidin 3-O-(6-caffeoyl-beta-D-glucoside) 5-O-beta-D-glucoside generic -metabolite KEGG:C12641 4'''-Demalonylsalvianin generic -metabolite KEGG:C12642 Pelargonidin 3-O-(6-O-malonyl-beta-D-glucoside) generic -metabolite KEGG:C12643 Cyanidin 3-O-(6-O-malonyl-beta-D-glucoside) generic -metabolite KEGG:C12644 Pelargonidin 3-O-rutinoside generic -metabolite KEGG:C12645 Pelargonidin 3-O-rutinoside 5-O-beta-D-glucoside generic -metabolite KEGG:C12646 Cyanidin 3-O-rutinoside 5-O-beta-D-glucoside generic -metabolite KEGG:C12647 Salvianin generic -metabolite KEGG:C12649 Citric acid monohydrate generic -metabolite KEGG:C12650 Capecitabine generic -metabolite KEGG:C12656 Paramethasone acetate generic -metabolite KEGG:C12661 Pantethine generic -metabolite KEGG:C12662 Josamycin generic -metabolite KEGG:C12666 Prednisolone sodium succinate generic -metabolite KEGG:C12667 Quercetin 3-O-beta-D-glucosyl-(1->2)-beta-D-glucoside generic -metabolite KEGG:C12668 Quercetin 3-O-beta-D-glucosyl-(1->2)-beta-D-glucosyl-(1->2)-beta-D-glucoside generic -metabolite KEGG:C12673 Tegafur generic -metabolite KEGG:C12675 Benzylhydrochlorothiazide generic -metabolite KEGG:C12677 Acrinol generic -metabolite KEGG:C12679 Berberine chloride generic -metabolite KEGG:C12685 Cyclothiazide generic -metabolite KEGG:C12691 Cefacetrile sodium generic -metabolite KEGG:C12694 Epitiostanol generic -metabolite KEGG:C12695 Difluprednate generic -metabolite KEGG:C12712 Carindacillin sodium generic -metabolite KEGG:C12717 Dimefline hydrochloride generic -metabolite KEGG:C12724 Ethynodiol diacetate generic -metabolite KEGG:C12729 Chlormadinone acetate generic -metabolite KEGG:C12739 5'-Deoxy-5-fluorouridine generic -metabolite KEGG:C12750 Bisibuthiamine generic -metabolite KEGG:C12753 Troleandomycin generic -metabolite KEGG:C12755 Mequitazine generic -metabolite KEGG:C12766 Cyclacillin generic -metabolite KEGG:C12767 Dibenzthion generic -metabolite KEGG:C12768 Timepidium bromide generic -metabolite KEGG:C12786 Dinoprost tromethamine generic -metabolite KEGG:C12796 Erythromycin ethylsuccinate generic -metabolite KEGG:C12798 Tulobuterol hydrochloride generic -metabolite KEGG:C12811 Allylestrenol generic -metabolite KEGG:C12814 Prifinium bromide generic -metabolite KEGG:C12816 Proscillaridin generic -metabolite KEGG:C12819 Kainic acid generic -metabolite KEGG:C12829 Bromisovalum generic -metabolite KEGG:C12831 3,4,6-Trichlorocatechol generic -metabolite KEGG:C12832 3,4,6-Trichloro-cis-1,2-dihydroxycyclohexa-3,5-diene generic -metabolite KEGG:C12833 2,3,5-Trichloro-cis,cis-muconate generic -metabolite KEGG:C12834 2,5-Dichloro-carboxymethylenebut-2-en-4-olide generic -metabolite KEGG:C12835 2,5-Dichloro-4-oxohex-2-enedioate generic -metabolite KEGG:C12836 2-Chloro-3-oxoadipate generic -metabolite KEGG:C12837 3-Chloro-cis-1,2-dihydroxycyclohexa-3,5-diene generic -metabolite KEGG:C12838 trans-4-Carboxymethylenebut-2-en-4-olide generic -metabolite KEGG:C12839 Piperazine phosphate generic -metabolite KEGG:C12842 Pyricarbate generic -metabolite KEGG:C12849 p-Phenolsulfonic acid generic -metabolite KEGG:C12853 Thiamphenicol generic -metabolite KEGG:C12859 Estradiol valerate generic -metabolite KEGG:C12861 Cefotiam hexetil generic -metabolite KEGG:C12862 Nedaplatin generic -metabolite KEGG:C12864 Tamibarotene generic -metabolite KEGG:C12865 Benzyl nicotinate generic -metabolite KEGG:C12869 Suplatast generic -metabolite KEGG:C12871 Lopinavir generic -metabolite KEGG:C12876 Tiopronin generic -metabolite KEGG:C12886 Dialicor generic -metabolite KEGG:C12888 Hydrocortisone succinate generic -metabolite KEGG:C12889 n-Decanohydroxamic acid generic -metabolite KEGG:C12891 Acetylspiramycin generic -metabolite KEGG:C12893 Magnesium carbonate generic -metabolite KEGG:C12896 Carpipramine maleate generic -metabolite KEGG:C12905 Variotin generic -metabolite KEGG:C12915 Nemonapride generic -metabolite KEGG:C12919 1-alpha,24(R)-Dihydroxyvitamin D3 generic -metabolite KEGG:C12933 Rolitetracycline nitrate generic -metabolite KEGG:C12935 Calcium glycerophosphate generic -metabolite KEGG:C12937 Clocapramine dihydrochloride generic -metabolite KEGG:C12942 Paraformaldehyde generic -metabolite KEGG:C12946 Butoctamide hydrogen succinate generic -metabolite KEGG:C12948 Mazaticol hydrochloride generic -metabolite KEGG:C12954 Dilazep dihydrochloride generic -metabolite KEGG:C12958 Phenylacetylglycine dimethylamide generic -metabolite KEGG:C12959 Dimetacrine tartrate generic -metabolite KEGG:C12961 Dexamethazone metasulfobenzoate sodium generic -metabolite KEGG:C12962 Cyphenothrin generic -metabolite KEGG:C12967 Tocoretinate generic -metabolite KEGG:C12978 Epidihydrocholesterin generic -metabolite KEGG:C12979 Cefroxadine generic -metabolite KEGG:C12981 dl-alpha-Tocopherol nicotinate generic -metabolite KEGG:C12986 N2-Acetyl-L-aminoadipate generic -metabolite KEGG:C12987 N2-Acetyl-L-aminoadipyl-delta-phosphate generic -metabolite KEGG:C12988 N2-Acetyl-L-aminoadipate semialdehyde generic -metabolite KEGG:C12989 N2-Acetyl-L-lysine generic -metabolite KEGG:C13008 Edaravone generic -metabolite KEGG:C13014 1-Naphthylacetic acid generic -metabolite KEGG:C13016 Carumonam sodium generic -metabolite KEGG:C13024 Cefpimizole sodium generic -metabolite KEGG:C13031 Estramustine phosphate sodium generic -metabolite KEGG:C13034 Bronopol generic -metabolite KEGG:C13037 Lynestrenol generic -metabolite KEGG:C13038 Flufenamic acid generic -metabolite KEGG:C13044 Tricaprilin generic -metabolite KEGG:C13048 p-Nitrophenyl-O-ethyl ethylphosphonate generic -metabolite KEGG:C13050 Cyclic ADP-ribose generic -metabolite KEGG:C13051 Nicotinic acid adenine dinucleotide phosphate generic -metabolite KEGG:C13055 Oxytetracycline hydrochloride generic -metabolite KEGG:C13058 Calcium L-aspartate generic -metabolite KEGG:C13061 Acetylsulfamethoxazole generic -metabolite KEGG:C13072 Sodium picosulfate generic -metabolite KEGG:C13074 Acetylkitasamycin generic -metabolite KEGG:C13077 Estradiol dipropionate generic -metabolite KEGG:C13085 Sodium glucuronate generic -metabolite KEGG:C13086 Propagermanium generic -metabolite KEGG:C13089 Cefetamet pivoxil hydrochloride generic -metabolite KEGG:C13101 Hexestrol generic -metabolite KEGG:C13102 Bismuth subnitrate generic -metabolite KEGG:C13103 Leucomycin V generic -metabolite KEGG:C13104 Aluminoparaaminosalicylate calcium generic -metabolite KEGG:C13106 Gadodiamide hydrate generic -metabolite KEGG:C13109 Hyoscyamine methylbromide generic -metabolite KEGG:C13110 Propicillin potassium generic -metabolite KEGG:C13112 Ancitabin hydrochloride generic -metabolite KEGG:C13127 Bropirimine generic -metabolite KEGG:C13129 Sultamicillin tosilate generic -metabolite KEGG:C13138 beta-Butoxyethyl nicotinate generic -metabolite KEGG:C13140 Calcium oxide generic -metabolite KEGG:C13141 Cefcapene pivoxil generic -metabolite KEGG:C13142 Cefovecin sodium generic -metabolite KEGG:C13143 Ceftiofur sodium generic -metabolite KEGG:C13144 Ozagrel hydrochloride generic -metabolite KEGG:C13154 Dehydrocholic acid generic -metabolite KEGG:C13156 Lentinan generic -metabolite KEGG:C13167 Dihydro-alpha-ergocryptine mesylate generic -metabolite KEGG:C13168 Dihydroergocristine mesylate generic -metabolite KEGG:C13173 Roxithromycin generic -metabolite KEGG:C13179 Fleroxacin generic -metabolite KEGG:C13182 Benexate hydrochloride generic -metabolite KEGG:C13183 beta-Cyclodextrin generic -metabolite KEGG:C13189 Calcium bromide generic -metabolite KEGG:C13192 Potassium sulfate generic -metabolite KEGG:C13194 Calcium sulfate generic -metabolite KEGG:C13197 Potassium dibasic phosphate generic -metabolite KEGG:C13198 Potassium bromide generic -metabolite KEGG:C13199 Sodium sulfate generic -metabolite KEGG:C13202 alpha-Tocopherol acetate generic -metabolite KEGG:C13229 Sulpyrine generic -metabolite KEGG:C13235 Procaterol hydrochloride generic -metabolite KEGG:C13240 Ether generic -metabolite KEGG:C13244 Antipyrine generic -metabolite KEGG:C13249 Sodium citrate generic -metabolite KEGG:C13252 Carmofur generic -metabolite KEGG:C13254 Mebhydrolin napadisilate generic -metabolite KEGG:C13269 Aspoxicillin generic -metabolite KEGG:C13273 Plaunotol generic -metabolite KEGG:C13280 Nicorandil generic -metabolite KEGG:C13297 Geranylgeranylacetone generic -metabolite KEGG:C13299 Fungichromin generic -metabolite KEGG:C13301 Buserelin acetate generic -metabolite KEGG:C13309 2-Phytyl-1,4-naphthoquinone generic -metabolite KEGG:C13310 Faropenem sodium generic -metabolite KEGG:C13311 Fasoracetam generic -metabolite KEGG:C13326 Kad 1229 generic -metabolite KEGG:C13334 Pitavastatin generic -metabolite KEGG:C13342 p-Hydroxypropiophenone generic -metabolite KEGG:C13355 Aniracetam generic -metabolite KEGG:C13358 Hydrocortisone butyrate propionate generic -metabolite KEGG:C13364 Ethyl icosapentate generic -metabolite KEGG:C13373 Xenon generic -metabolite KEGG:C13376 Cefpiramide sodium generic -metabolite KEGG:C13377 Mercuric chloride generic -metabolite KEGG:C13378 alpha,beta-Dihydroxyethyl-TPP generic -metabolite KEGG:C13383 Iodoform generic -metabolite KEGG:C13391 Aluminum hydroxide generic -metabolite KEGG:C13392 Azulene generic -metabolite KEGG:C13400 Bufferin generic -metabolite KEGG:C13403 Sodium caffeine benzoate generic -metabolite KEGG:C13409 Titanium dioxide generic -metabolite KEGG:C13410 Transfluthrin generic -metabolite KEGG:C13414 Sodium 3-ethyl-7-isopropyl-1-azulenesulfonate generic -metabolite KEGG:C13415 n-Butyl-2-cyanoacrylate generic -metabolite KEGG:C13416 Sodium equilin sulfate generic -metabolite KEGG:C13422 Hydrocortisone caproate generic -metabolite KEGG:C13424 Zanapezil fumarate generic -metabolite KEGG:C13425 3-Hexaprenyl-4-hydroxybenzoate generic -metabolite KEGG:C13426 I-123 BMIPP generic -metabolite KEGG:C13427 Pyrithione zinc generic -metabolite KEGG:C13429 Meglumine sodium amidotrizoate generic -metabolite KEGG:C13431 9'-cis-Neoxanthin generic -metabolite KEGG:C13433 9-cis-Violaxanthin generic -metabolite KEGG:C13440 Cefaloglycin generic -metabolite KEGG:C13441 Dimethylaminoethyl reserpilinate dihydrochloride generic -metabolite KEGG:C13444 Estradiol benzoate generic -metabolite KEGG:C13450 Trichomycin A generic -metabolite KEGG:C13451 Trichomycin B generic -metabolite KEGG:C13452 Tannic acid generic -metabolite KEGG:C13453 Xanthoxin generic -metabolite KEGG:C13454 Xanthoxic acid generic -metabolite KEGG:C13455 Abscisic aldehyde generic -metabolite KEGG:C13456 Abscisic alcohol generic -metabolite KEGG:C13478 Luliconazole generic -metabolite KEGG:C13480 Tenofovir disoproxil generic -metabolite KEGG:C13482 Phosphodimethylethanolamine generic -metabolite KEGG:C13487 Metofluthrin generic -metabolite KEGG:C13493 Polidocanol generic -metabolite KEGG:C13494 Mosapride citrate hydrate generic -metabolite KEGG:C13500 Kitasamycin tartrate generic -metabolite KEGG:C13503 Nitro blue tetrazolium generic -metabolite KEGG:C13505 Cefsulodin sodium generic -metabolite KEGG:C13508 Sulfoquinovosyldiacylglycerol generic -metabolite KEGG:C13511 Ferric gluconate generic -metabolite KEGG:C13515 Rubidium hydroxide generic -metabolite KEGG:C13522 Mitobronitol generic -metabolite KEGG:C13523 Secretin generic -metabolite KEGG:C13524 Prochlorperazine mesylate generic -metabolite KEGG:C13526 Sennoside B generic -metabolite KEGG:C13534 Hydrocotarnine hydrochloride generic -metabolite KEGG:C13540 Perphenazine maleate generic -metabolite KEGG:C13542 Lactitol dihydrate generic -metabolite KEGG:C13546 Olprinone hydrochloride generic -metabolite KEGG:C13547 Norcholestenol iodomethyl (131 I) generic -metabolite KEGG:C13548 Alprostadil alfadex generic -metabolite KEGG:C13550 Cerebrosterol generic -metabolite KEGG:C13553 Colistin sodium methanesulfonate generic -metabolite KEGG:C13554 Prednisolone 21-all-cis-farnesylate generic -metabolite KEGG:C13556 Monobasic calcium phosphate generic -metabolite KEGG:C13557 Potassium nitrate generic -metabolite KEGG:C13558 Dibasic sodium phosphate generic -metabolite KEGG:C13563 Sodium chloride generic -metabolite KEGG:C13569 Chromomycin A3 generic -metabolite KEGG:C13587 Teicoplanin A2-1 generic -metabolite KEGG:C13588 Teicoplanin A2-3 generic -metabolite KEGG:C13591 Metipranolol hydrochloride generic -metabolite KEGG:C13610 Teicoplanin A2-4 generic -metabolite KEGG:C13612 Teicoplanin A2-5 generic -metabolite KEGG:C13613 Teicoplanin A3-1 generic -metabolite KEGG:C13619 Arsenous oxide generic -metabolite KEGG:C13620 Tetrabromobisphenol A generic -metabolite KEGG:C13621 Tribromobisphenol A generic -metabolite KEGG:C13622 Dibromobisphenol A generic -metabolite KEGG:C13623 Monobromobisphenol A generic -metabolite KEGG:C13624 Bisphenol A generic -metabolite KEGG:C13625 4-Methyl-2,4-bis-(p-hydroxyphenyl)pent-1-ene generic -metabolite KEGG:C13626 5-Hydroxybisphenol A generic -metabolite KEGG:C13628 4,5-Bisphenol-o-quinone generic -metabolite KEGG:C13629 1,2-Bis(4-hydroxyphenyl)-2-propanol generic -metabolite KEGG:C13630 7-Ethoxyresorufin generic -metabolite KEGG:C13631 2,2-Bis(4-hydroxyphenyl)-1-propanol generic -metabolite KEGG:C13632 4,4'-Dihydroxy-alpha-methylstilbene generic -metabolite KEGG:C13633 2,2-Bis(4-hydroxyphenyl)-propanoic acid generic -metabolite KEGG:C13634 2,3-Bis(4-hydroxyphenyl)-1,2-propanediol generic -metabolite KEGG:C13635 4-Hydroxyphenacyl alcohol generic -metabolite KEGG:C13636 4-Hydroxyphenyl acetate generic -metabolite KEGG:C13637 4-Ethylphenol generic -metabolite KEGG:C13638 1-(4'-Hydroxyphenyl)ethanol generic -metabolite KEGG:C13639 dl-Methylephedrine hydrochloride generic -metabolite KEGG:C13645 Hydrobromic acid generic -metabolite KEGG:C13646 m-Chlorophenylbiguanide generic -metabolite KEGG:C13650 Debrisoquin generic -metabolite KEGG:C13651 Glucagon hydrochloride generic -metabolite KEGG:C13652 Ampicillin sodium generic -metabolite KEGG:C13660 Piperazine citrate generic -metabolite KEGG:C13662 Arg-vasopressin generic -metabolite KEGG:C13664 Bufotenidine generic -metabolite KEGG:C13665 2-Methyl-5-hydroxytryptamine generic -metabolite KEGG:C13666 Tropisetron generic -metabolite KEGG:C13667 2,3-Dioxo-6-nitro-7-sulfamoylbenzo[f]quinoxaline generic -metabolite KEGG:C13668 CNQX generic -metabolite KEGG:C13670 Talampanel generic -metabolite KEGG:C13671 (S)-F-Willardiine generic -metabolite KEGG:C13672 AMPA generic -metabolite KEGG:C13673 (S)-ACPA generic -metabolite KEGG:C13674 1-Naphthylacetylspermine generic -metabolite KEGG:C13675 Ampalex generic -metabolite KEGG:C13676 LY395153 generic -metabolite KEGG:C13677 4-(N-Maleimido)benzyltrimethylammonium iodide generic -metabolite KEGG:C13678 4-(N-Maleimido)phenyltrimethylammonium iodide generic -metabolite KEGG:C13679 Bis(3-azidopyridinium)-1,10-decane perchlorate generic -metabolite KEGG:C13680 Lophotoxin generic -metabolite KEGG:C13681 p-N,N-(Dimethylamino)phenyldiazonium fluoroborate generic -metabolite KEGG:C13682 Dihydro-beta-erythroidine generic -metabolite KEGG:C13683 Histrionicotoxin generic -metabolite KEGG:C13684 Clindamycin hydrochloride generic -metabolite KEGG:C13687 Cunaniol generic -metabolite KEGG:C13688 delta-Guanidinovaleric acid generic -metabolite KEGG:C13689 m-Benzenesulfonium diazonium chloride generic -metabolite KEGG:C13690 Dopamine 3-O-sulfate generic -metabolite KEGG:C13691 Dopamine 4-O-sulfate generic -metabolite KEGG:C13692 Pentylenetetrazole generic -metabolite KEGG:C13693 4,5,6,7-Tetrahydroisoxazolo(5,4-c)pyridin-3-ol generic -metabolite KEGG:C13694 Isoguvacine generic -metabolite KEGG:C13695 ZAPA generic -metabolite KEGG:C13696 trans-3-Aminocyclopentane-1-carboxylic acid generic -metabolite KEGG:C13697 Fenamic acid generic -metabolite KEGG:C13698 Niflumic acid generic -metabolite KEGG:C13699 9-Anthroic acid generic -metabolite KEGG:C13700 Clofibric acid generic -metabolite KEGG:C13701 2-(4-Chlorophenoxy)propionic acid generic -metabolite KEGG:C13702 4-Acetamido-4'-isothiocyanostilbene-2,2'-disulphonic acid generic -metabolite KEGG:C13703 IAA-94 generic -metabolite KEGG:C13704 TS-TM-calix(4)arene generic -metabolite KEGG:C13705 5-Nitro-2-(3-phenylpropylamino)benzoic acid generic -metabolite KEGG:C13706 DNDS generic -metabolite KEGG:C13707 RU-0211 generic -metabolite KEGG:C13708 IBMX generic -metabolite KEGG:C13709 CPX generic -metabolite KEGG:C13710 4-PIOL generic -metabolite KEGG:C13711 Thio-THIP generic -metabolite KEGG:C13712 Allopregnanolone generic -metabolite KEGG:C13713 Allotetrahydrodeoxycorticosterone generic -metabolite KEGG:C13714 alpha-EMGBL generic -metabolite KEGG:C13715 Miltirone generic -metabolite KEGG:C13716 Ro 19-4603 generic -metabolite KEGG:C13717 beta-EMGBL generic -metabolite KEGG:C13718 Dieldrin generic -metabolite KEGG:C13719 Nocodazole generic -metabolite KEGG:C13720 alpha-EMTBL generic -metabolite KEGG:C13721 Cyanotriphenylborate generic -metabolite KEGG:C13722 Adenophostin B generic -metabolite KEGG:C13723 Dextran sulfate generic -metabolite KEGG:C13724 Polyvinyl sulfate generic -metabolite KEGG:C13725 Patent blue generic -metabolite KEGG:C13726 Pentosan sulfate generic -metabolite KEGG:C13727 Adenophostin A generic -metabolite KEGG:C13728 4-Aminopyridine generic -metabolite KEGG:C13729 Pinacidil generic -metabolite KEGG:C13730 LY382884 generic -metabolite KEGG:C13731 NS-102 generic -metabolite KEGG:C13732 Domoic acid generic -metabolite KEGG:C13733 (S)-ATPA generic -metabolite KEGG:C13734 2-Amino-5-phosphopentanoic acid generic -metabolite KEGG:C13735 Selfotel generic -metabolite KEGG:C13736 Memantine generic -metabolite KEGG:C13737 Dizocilpine generic -metabolite KEGG:C13738 5-Tetrazolyl-glycine generic -metabolite KEGG:C13739 (R)-AMAA generic -metabolite KEGG:C13740 alpha,beta-Methylene ATP generic -metabolite KEGG:C13741 beta,gamma-Methylene ATP generic -metabolite KEGG:C13742 Adenosine 5-O-(3-thiotriphophate) generic -metabolite KEGG:C13743 Adenosine 5-O-(3-thiodiphophate) generic -metabolite KEGG:C13744 3'-O-(4-Benzoyl)benzoyl ATP generic -metabolite KEGG:C13745 Pyridoxalphosphate-6-azophenyl-2',4'-disulfonic acid generic -metabolite KEGG:C13746 Reactive blue 2 generic -metabolite KEGG:C13747 1,7-Dimethylxanthine generic -metabolite KEGG:C13748 9-Methyl-7-bromoeudistomin D generic -metabolite KEGG:C13749 Sulmazole generic -metabolite KEGG:C13750 Batrachotoxin generic -metabolite KEGG:C13751 Benzamil generic -metabolite KEGG:C13752 Phenylamil generic -metabolite KEGG:C13753 6-Chloro-3,5-diaminopyrazine-3-carboxamide generic -metabolite KEGG:C13756 Dicloxacillin sodium generic -metabolite KEGG:C13757 Saxitoxin generic -metabolite KEGG:C13758 Bay-K-8644 generic -metabolite KEGG:C13759 FPL64176 generic -metabolite KEGG:C13760 YC 170 generic -metabolite KEGG:C13761 CGP 28-392 generic -metabolite KEGG:C13762 202-791 generic -metabolite KEGG:C13763 Devapamil generic -metabolite KEGG:C13764 Gallopamil generic -metabolite KEGG:C13765 Tiapamil generic -metabolite KEGG:C13766 Emopamil generic -metabolite KEGG:C13767 H37 generic -metabolite KEGG:C13768 Colistin sulfate generic -metabolite KEGG:C13769 Bufuralol generic -metabolite KEGG:C13771 S9947 generic -metabolite KEGG:C13772 Clofilium generic -metabolite KEGG:C13773 1,1-Diethyl-2-hydroxy-2-nitrosohydrazine generic -metabolite KEGG:C13774 Iron dextran generic -metabolite KEGG:C13776 E-4031 generic -metabolite KEGG:C13777 Azimilide generic -metabolite KEGG:C13778 HMR1556 generic -metabolite KEGG:C13779 XE991 generic -metabolite KEGG:C13780 Linopirdine generic -metabolite KEGG:C13781 Teicoplanin A2 generic -metabolite KEGG:C13782 Paxilline generic -metabolite KEGG:C13783 UCL 1684 generic -metabolite KEGG:C13784 TRAM-34 generic -metabolite KEGG:C13785 TRAM-3 generic -metabolite KEGG:C13786 Cetiedil generic -metabolite KEGG:C13787 17-Methyl-6Z-octadecenoic acid generic -metabolite KEGG:C13788 UCL 1608 generic -metabolite KEGG:C13789 Trichomycin generic -metabolite KEGG:C13790 2S-Hydroxytetradecanoic acid generic -metabolite KEGG:C13791 (6R,7S)-6,7-Epoxyoctadecanoic acid generic -metabolite KEGG:C13792 2-Methoxy-5Z-hexadecenoic acid generic -metabolite KEGG:C13793 3-Bromo-2Z-heptenoic acid generic -metabolite KEGG:C13794 Pitrazepin generic -metabolite KEGG:C13795 2S-Amino-tridecanoic acid generic -metabolite KEGG:C13796 SR95531 generic -metabolite KEGG:C13797 RU 5135 generic -metabolite KEGG:C13798 8-(5-Hexyl-furan-2-yl)-octanoic acid generic -metabolite KEGG:C13799 (+)-Hydrastine generic -metabolite KEGG:C13800 10-Nitrolinoleic acid generic -metabolite KEGG:C13802 Prostaglandin D3 generic -metabolite KEGG:C13803 Alphaxalone generic -metabolite KEGG:C13804 ORG 20599 generic -metabolite KEGG:C13805 N-Butyl-beta-carboline-3-carboxylate generic -metabolite KEGG:C13806 Philanthotoxin 343 generic -metabolite KEGG:C13807 Levuglandin E2 generic -metabolite KEGG:C13808 Levuglandin D2 generic -metabolite KEGG:C13809 9,11,15-Trihydroxy-prosta-5,13-dien-1-oic acid generic -metabolite KEGG:C13810 Clavulone I generic -metabolite KEGG:C13811 Piperazine adipate generic -metabolite KEGG:C13812 Clavulone II generic -metabolite KEGG:C13813 Clavulone III generic -metabolite KEGG:C13814 Clavulone IV generic -metabolite KEGG:C13815 Tetrapentylammonium generic -metabolite KEGG:C13816 (9R,13R)-12-Oxo-phytodienoic acid generic -metabolite KEGG:C13817 8-Br-cGMP generic -metabolite KEGG:C13818 F4-Neuroprostane (4-series) generic -metabolite KEGG:C13819 F4-Neuroprostane (7-series) generic -metabolite KEGG:C13820 Chromanol 293B generic -metabolite KEGG:C13821 1-Hexadecyl hexadecanoate generic -metabolite KEGG:C13822 2S,3R-Didecanoyl-docosane-2,3-diol generic -metabolite KEGG:C13823 11-Undecanolactone generic -metabolite KEGG:C13824 R-L3 generic -metabolite KEGG:C13825 O-Hexanoyl-adnosine monophosphate generic -metabolite KEGG:C13826 Retigabine generic -metabolite KEGG:C13827 Chloroform generic -metabolite KEGG:C13828 8,11,14-Eicosatrienoylethanolamide generic -metabolite KEGG:C13829 7,10,13,16-Docosatetraenoylethanolamine generic -metabolite KEGG:C13830 BMS 204352 generic -metabolite KEGG:C13831 Dodecanamide generic -metabolite KEGG:C13832 4Z,7Z,10Z-Octadecatrienenitrile generic -metabolite KEGG:C13833 NS 1619 generic -metabolite KEGG:C13834 Tridecane generic -metabolite KEGG:C13835 NS 1608 generic -metabolite KEGG:C13836 CGS 7181 generic -metabolite KEGG:C13837 Dehydrosoyasaponin I generic -metabolite KEGG:C13838 Lactobacillic acid generic -metabolite KEGG:C13840 1-Ethyl-2-benzimidazolinone generic -metabolite KEGG:C13841 Zoxazolamine generic -metabolite KEGG:C13842 alpha-Semegma mycolic acid generic -metabolite KEGG:C13843 17R,18S-Epoxy-5Z,8Z,11Z,14Z-icosatetraenoic acid generic -metabolite KEGG:C13844 DCEBIO generic -metabolite KEGG:C13845 1,3-Di-(octadec-9Z-enoyl)-1-cyano-2-methylene-propane-1,3-diol generic -metabolite KEGG:C13846 Octadecanamide generic -metabolite KEGG:C13847 CP 339818 generic -metabolite KEGG:C13848 UK 78282 generic -metabolite KEGG:C13849 Correolide generic -metabolite KEGG:C13851 BRL 32872 generic -metabolite KEGG:C13852 Sipatrigine generic -metabolite KEGG:C13853 L 735821 generic -metabolite KEGG:C13854 1-Dodecanoyl-sn-glycerol generic -metabolite KEGG:C13856 2-Arachidonoylglycerol generic -metabolite KEGG:C13857 1-Arachidonoylglycerol generic -metabolite KEGG:C13858 1-O-Octadecyl-sn-glycerol generic -metabolite KEGG:C13859 1-O-Hexadecyl-sn-glycerol generic -metabolite KEGG:C13860 1-O-Octadec-9-enyl glycerol generic -metabolite KEGG:C13861 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycerol generic -metabolite KEGG:C13862 1-O-Hexadecyl-2-(9Z-octadecenoyl)-sn-glycerol generic -metabolite KEGG:C13863 2,3-Di-O-phytanyl-sn-glycerol generic -metabolite KEGG:C13864 1-O-(1Z-Tetradecenyl)-2-(9Z-octadecenoyl)-sn-glycerol generic -metabolite KEGG:C13867 1,2-Di-(9Z,12Z,15Z-octadecatrienoyl)-3-(8-(2E,4Z-decadienoyloxy)-5,6-octadienoyl)-sn-glycerol generic -metabolite KEGG:C13869 1-Dodecanoyl-2-hexadecanoyl-3-octadecanoyl-sn-glycerol generic -metabolite KEGG:C13870 Tributyrin generic -metabolite KEGG:C13871 1,2-Di-(9Z,12Z,15Z-octadecatrienoyl)-3-O-beta-D-galactosyl-sn-glycerol generic -metabolite KEGG:C13872 Caldarchaeol generic -metabolite KEGG:C13874 Gentiobiosyl-caldarchaeol generic -metabolite KEGG:C13875 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-phosphocholine generic -metabolite KEGG:C13876 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-phosphonocholine generic -metabolite KEGG:C13877 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C13878 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-phosphonoethanolamine generic -metabolite KEGG:C13880 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-phosphoserine generic -metabolite KEGG:C13881 Barium cation generic -metabolite KEGG:C13883 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-phospho-sn-glycerol generic -metabolite KEGG:C13884 Strontium cation generic -metabolite KEGG:C13885 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-phospho-sn-glycerol 3'-phosphate generic -metabolite KEGG:C13888 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-phospho-1'-myo-inositol generic -metabolite KEGG:C13889 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-phosphate generic -metabolite KEGG:C13890 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-pyrophosphate generic -metabolite KEGG:C13891 1,2-Didodecanoyl-sn-glycero-3-cytidine-5'-diphosphate generic -metabolite KEGG:C13892 1-Hexadecanoyl-2-(9Z-octadecenoyl)-sn-glycero-3-cytidine-5'-diphosphate generic -metabolite KEGG:C13894 1-O-Hexadecyl-2-(9Z-octadecenoyl)-sn-glycero-3-phosphocholine generic -metabolite KEGG:C13895 1-O-(1Z-Tetradecenyl)-2-(9Z-octadecenoyl)-sn-glycero-3-phosphocholine generic -metabolite KEGG:C13896 sn-Caldarchaeo-1-phosphoethanolamine generic -metabolite KEGG:C13897 sn-Caldito-1-phosphoethanolamine generic -metabolite KEGG:C13898 1-Palmitoyl-2-(5-hydroxy-8-oxo-6-octenedioyl)-sn-glycero-3-phosphocholine generic -metabolite KEGG:C13900 1-Palmitoyl-2-(5-keto-6-octenedioyl)-sn-glycero-3-phosphocholine generic -metabolite KEGG:C13901 1-Palmitoyl-2-(5-hydroxy-8-oxo-6-octenoyl)-sn-glycero-3-phosphocholine generic -metabolite KEGG:C13902 1-Palmitoyl-2-(5-keto-8-oxo-6-octenoyl)-sn-glycero-3-phosphocholine generic -metabolite KEGG:C13903 1-O-Hexadecyl-lyso-sn-glycero-3-phosphocholine generic -metabolite KEGG:C13906 Balofloxacin generic -metabolite KEGG:C13907 OM-174 generic -metabolite KEGG:C13908 Diphosphoryl hexaacyl lipid A generic -metabolite KEGG:C13909 Diphosphoryl heptaacyl lipid A generic -metabolite KEGG:C13910 Undecylenic acid generic -metabolite KEGG:C13914 N,N-Dimethylsphing-4-enine generic -metabolite KEGG:C13915 Hexadecasphinganine generic -metabolite KEGG:C13916 N-(Tetradecanoyl)-sphing-4-enine generic -metabolite KEGG:C13918 N-(30-(9Z,12Z-Octadecadienoyloxy)-tricontanoyl)-sphing-4-enine generic -metabolite KEGG:C13920 Ml4Cer generic -metabolite KEGG:C13921 II2Xylbeta-Ml4Cer generic -metabolite KEGG:C13922 Ar4Cer generic -metabolite KEGG:C13923 Ar5Cer generic -metabolite KEGG:C13924 Gal-alpha1->3Gal-beta1->4Glc-beta1->1'Cer generic -metabolite KEGG:C13925 iGb4Cer generic -metabolite KEGG:C13926 iGb5Cer generic -metabolite KEGG:C13927 Argiotoxin 636 generic -metabolite KEGG:C13929 Argiotoxin 659 generic -metabolite KEGG:C13931 JSTX-3 generic -metabolite KEGG:C13932 Ruthenium red generic -metabolite KEGG:C13937 Cholinephosphorylmannosylneogalabiaosylceramide generic -metabolite KEGG:C13938 Cholinephosphorylneogalatriaosylceramide generic -metabolite KEGG:C13940 Sennoside generic -metabolite KEGG:C13945 2-Oxodecanoic acid generic -metabolite KEGG:C13946 2-Methoxy-6Z-hexadecenoic acid generic -metabolite KEGG:C13947 2-Methoxyhexadecanoic acid generic -metabolite KEGG:C13948 16-Fluorohexadecanoic acid generic -metabolite KEGG:C13949 9-Chloro-10-hydroxyhexadecanoic acid generic -metabolite KEGG:C13952 UDP-N-acetyl-D-galactosaminuronic acid generic -metabolite KEGG:C13958 12-Nitrolinoleic acid generic -metabolite KEGG:C13962 Chloramphenicol sodium succinate generic -metabolite KEGG:C13963 Mevastatin generic -metabolite KEGG:C13964 Fosfomycin calcium generic -metabolite KEGG:C13967 Carbenicillin sodium generic -metabolite KEGG:C13968 Cefamandole sodium generic -metabolite KEGG:C13973 Methicillin sodium generic -metabolite KEGG:C13974 Vincristine sulfate generic -metabolite KEGG:C13976 Carfecillin sodium generic -metabolite KEGG:C13978 Talampicillin hydrochloride generic -metabolite KEGG:C13980 Hetacillin potassium generic -metabolite KEGG:C13993 Ciprofloxacin hydrochloride generic -metabolite KEGG:C14001 Sulbactam sodium generic -metabolite KEGG:C14002 Lincomycin hydrochloride generic -metabolite KEGG:C14007 Cefotetan disodium generic -metabolite KEGG:C14010 Sodium cloxacillin monohydrate generic -metabolite KEGG:C14015 Diphenhydramine salicylate generic -metabolite KEGG:C14021 Ticarcillin disodium generic -metabolite KEGG:C14029 Trimipramine maleate generic -metabolite KEGG:C14034 Piperacillin generic -metabolite KEGG:C14039 1,1-Dichloroethylene generic -metabolite KEGG:C14040 1-Nitronaphthalene generic -metabolite KEGG:C14042 Sodium iodide generic -metabolite KEGG:C14043 ML-236C generic -metabolite KEGG:C14044 C25-Allenic-apo-aldehyde generic -metabolite KEGG:C14045 C25-Epoxy-apo-aldehyde generic -metabolite KEGG:C14049 Glycyrrhizinate dipotassium generic -metabolite KEGG:C14053 9,10-Dihydroergocornine methanesulfonate generic -metabolite KEGG:C14054 Dihydro-beta-ergocryptine mesylate generic -metabolite KEGG:C14055 Dihydroergotoxine mesylate generic -metabolite KEGG:C14056 Leucomycin A1 generic -metabolite KEGG:C14057 Leucomycin A4 generic -metabolite KEGG:C14058 Leucomycin A5 generic -metabolite KEGG:C14059 Leucomycin A6 generic -metabolite KEGG:C14060 Leucomycin A7 generic -metabolite KEGG:C14061 Leucomycin A8 generic -metabolite KEGG:C14062 Leucomycin A9 generic -metabolite KEGG:C14063 Leucomycin A13 generic -metabolite KEGG:C14064 Kitasamycin generic -metabolite KEGG:C14077 Phthalocyanine generic -metabolite KEGG:C14078 Congo red generic -metabolite KEGG:C14079 (-)-Catechin generic -metabolite KEGG:C14081 CBS 113A generic -metabolite KEGG:C14082 1-Methylnaphthalene generic -metabolite KEGG:C14083 cis-1,2-Dihydroxy-1,2-dihydro-8-methylnaphthalene generic -metabolite KEGG:C14084 1,2-Dihydroxy-8-methylnaphthalene generic -metabolite KEGG:C14085 2-Hydroxy-8-methylchromene-2-carboxylate generic -metabolite KEGG:C14086 2-Hydroxy-3-methylbenzalpyruvate generic -metabolite KEGG:C14087 3-Methylsalicylaldehyde generic -metabolite KEGG:C14088 3-Methylsalicylate generic -metabolite KEGG:C14089 1-Hydroxymethylnaphthalene generic -metabolite KEGG:C14090 1-Naphthaldehyde generic -metabolite KEGG:C14091 1-Naphthoic acid generic -metabolite KEGG:C14092 cis-1,2-Dihydroxy-1,2-dihydro-8-carboxynaphthalene generic -metabolite KEGG:C14093 1,2-Dihydroxy-8-carboxynaphthalene generic -metabolite KEGG:C14094 2-Carboxy-2-hydroxy-8-carboxychromene generic -metabolite KEGG:C14095 2-Hydroxy-3-carboxybenzalpyruvate generic -metabolite KEGG:C14096 3-Formylsalicylic acid generic -metabolite KEGG:C14097 2-Hydroxyisophthalic acid generic -metabolite KEGG:C14098 2-Methylnaphthalene generic -metabolite KEGG:C14099 2-Naphthaldehyde generic -metabolite KEGG:C14100 4-Formylsalicylic acid generic -metabolite KEGG:C14101 2-Naphthoic acid generic -metabolite KEGG:C14102 cis-1,2-Dihydroxy-1,2-dihydro-7-methylnaphthalene generic -metabolite KEGG:C14103 4-Methylsalicylate generic -metabolite KEGG:C14104 cis-1,2-Dihydroxy-1,2-dihydro-7-hydroxymethylnaphthalene generic -metabolite KEGG:C14105 1,2-Dihydroxy-7-hydroxymethylnaphthalene generic -metabolite KEGG:C14106 2-Hydroxy-7-hydroxymethylchromene-2-carboxylate generic -metabolite KEGG:C14107 2-Hydroxy-4-hydroxymethylbenzalpyruvate generic -metabolite KEGG:C14108 4-Hydroxymethylsalicylaldehyde generic -metabolite KEGG:C14109 4-Hydroxymethylsalicylate generic -metabolite KEGG:C14110 4-Hydroxymethylcatechol generic -metabolite KEGG:C14111 5,6,7,8-Tetrahydro-2-naphthoic acid generic -metabolite KEGG:C14112 cis-2-Carboxycyclohexyl-acetic acid generic -metabolite KEGG:C14113 Decahydro-2-naphthoic acid generic -metabolite KEGG:C14114 Tetralin generic -metabolite KEGG:C14115 2-Naphtylmethylsuccinic acid generic -metabolite KEGG:C14116 Naphthyl-2-methyl-succinyl-CoA generic -metabolite KEGG:C14117 Naphthyl-2-methylene-succinyl-CoA generic -metabolite KEGG:C14118 Naphthyl-2-hydroxymethyl-succinyl CoA generic -metabolite KEGG:C14119 Naphthyl-2-oxomethyl-succinyl-CoA generic -metabolite KEGG:C14120 2-Naphthoyl-CoA generic -metabolite KEGG:C14123 BMS-268770 generic -metabolite KEGG:C14125 UR-12947 generic -metabolite KEGG:C14126 Ro 61-8048 generic -metabolite KEGG:C14127 Acotiamide generic -metabolite KEGG:C14128 CGH 2466 generic -metabolite KEGG:C14129 SSR 125543 generic -metabolite KEGG:C14130 2-tert-Butylphenol generic -metabolite KEGG:C14131 Equol generic -metabolite KEGG:C14132 4-Octylphenol generic -metabolite KEGG:C14133 2,2-(2-Chlorophenyl-4'-chlorophenyl)-1,1-dichloroethene generic -metabolite KEGG:C14134 Triphenylethylene generic -metabolite KEGG:C14135 4,4'-Methylenebis(N,N-dimethylaniline) generic -metabolite KEGG:C14136 1,1,1-Trichloro-2,2-bis(4-hydroxyphenyl)ethane generic -metabolite KEGG:C14137 6-Hydroxyflavone generic -metabolite KEGG:C14138 2-sec-Butylphenol generic -metabolite KEGG:C14139 4-sec-Butylphenol generic -metabolite KEGG:C14142 sec-Butylbenzene generic -metabolite KEGG:C14143 Adipyl-CoA generic -metabolite KEGG:C14144 5-Carboxy-2-pentenoyl-CoA generic -metabolite KEGG:C14145 (3S)-3-Hydroxyadipyl-CoA generic -metabolite KEGG:C14146 alpha-Zeacarotene generic -metabolite KEGG:C14147 Cyromazine generic -metabolite KEGG:C14148 N-Cyclopropylammeline generic -metabolite KEGG:C14149 N-Cyclopropylammelide generic -metabolite KEGG:C14150 Cyclopropylamine generic -metabolite KEGG:C14151 delta-Tocopherol generic -metabolite KEGG:C14152 beta-Tocopherol generic -metabolite KEGG:C14153 alpha-Tocotrienol generic -metabolite KEGG:C14154 beta-Tocotrienol generic -metabolite KEGG:C14155 gamma-Tocotrienol generic -metabolite KEGG:C14156 delta-Tocotrienol generic -metabolite KEGG:C14157 Stylisterol A generic -metabolite KEGG:C14158 Stylisterol B generic -metabolite KEGG:C14159 Stylisterol C generic -metabolite KEGG:C14160 Hatomasterol generic -metabolite KEGG:C14161 Gibberellin A37 generic -metabolite KEGG:C14162 Gibberellin A15 generic -metabolite KEGG:C14163 Phenyl salicylate generic -metabolite KEGG:C14164 Acetrizoic acid generic -metabolite KEGG:C14165 Metrizoic acid generic -metabolite KEGG:C14166 alpha-Eucaine generic -metabolite KEGG:C14167 beta-Eucaine generic -metabolite KEGG:C14168 3-(Dimethylamino)propyl benzoate generic -metabolite KEGG:C14169 Stovaine generic -metabolite KEGG:C14170 p-Aminosalicylic acid methyl ester generic -metabolite KEGG:C14171 Orthoform generic -metabolite KEGG:C14172 Hexylcaine generic -metabolite KEGG:C14173 Piperocaine generic -metabolite KEGG:C14174 Allocain-S generic -metabolite KEGG:C14175 Diethyl phthalate generic -metabolite KEGG:C14176 Chlordane generic -metabolite KEGG:C14177 Lombricine generic -metabolite KEGG:C14178 N-Phospholombricine generic -metabolite KEGG:C14179 Sulfoacetate generic -metabolite KEGG:C14180 S-(Hydroxymethyl)glutathione generic -metabolite KEGG:C14181 2-Benzothiazolesulfonamide generic -metabolite KEGG:C14182 1,3-Benzenedisulfonamide generic -metabolite KEGG:C14183 Compactin diol lactone generic -metabolite KEGG:C14184 Mirex generic -metabolite KEGG:C14185 Heptachlor generic -metabolite KEGG:C14186 Prometon generic -metabolite KEGG:C14187 1,1,1-Trichloro-2-(o-chlorophenyl)-2-(p-chlorophenyl)ethane generic -metabolite KEGG:C14188 3-tert-Butylphenol generic -metabolite KEGG:C14189 2,4,6-Trichloro-4'-biphenylol generic -metabolite KEGG:C14190 2,3,4,5-Tetrachloro-4'-biphenylol generic -metabolite KEGG:C14191 2-Chloro-4,4'-biphenyldiol generic -metabolite KEGG:C14192 2,6-Dichloro-4'-biphenylol generic -metabolite KEGG:C14193 2,5-Dichloro-4'-biphenylol generic -metabolite KEGG:C14194 3,3',5,5'-Tetrachloro-4,4'-biphenyldiol generic -metabolite KEGG:C14195 4-Chloro-4'-biphenylol generic -metabolite KEGG:C14196 2,3,5,6-Tetrachloro-4,4'-biphenyldiol generic -metabolite KEGG:C14197 2,2',3,3',6,6'-Hexachloro-4-biphenylol generic -metabolite KEGG:C14198 2,2'3,4',6,6'-Hexachloro-4-biphenylol generic -metabolite KEGG:C14199 2,2',5,5'-Tetrachlorobiphenyl generic -metabolite KEGG:C14200 4-tert-Butylphenol generic -metabolite KEGG:C14201 2,2',4,4',5,5'-Hexachlorobiphenyl generic -metabolite KEGG:C14202 2,2',4,4',6,6'-Hexachlorobiphenyl generic -metabolite KEGG:C14203 2,2',3,3',5,5'-Hexachloro-6-biphenylol generic -metabolite KEGG:C14204 Hydroxyflutamide generic -metabolite KEGG:C14205 4-tert-Octylphenol generic -metabolite KEGG:C14206 M1 generic -metabolite KEGG:C14207 M2 generic -metabolite KEGG:C14208 Promegestone generic -metabolite KEGG:C14209 4-Hydroxyestradiol-17beta generic -metabolite KEGG:C14210 4-Androstenediol generic -metabolite KEGG:C14211 Butylbenzyl phthalate generic -metabolite KEGG:C14212 Nafoxidine generic -metabolite KEGG:C14213 Aurin generic -metabolite KEGG:C14214 Dibutyl phthalate generic -metabolite KEGG:C14215 2,4-Dihydroxybenzophenone generic -metabolite KEGG:C14216 4,4'-Sulfonyldiphenol generic -metabolite KEGG:C14217 1,6-Dimethylnaphthalene generic -metabolite KEGG:C14218 Octane-1,8-diol generic -metabolite KEGG:C14219 2-Chlorophenol generic -metabolite KEGG:C14220 4,4'-Dihydroxybenzophenone generic -metabolite KEGG:C14221 6-Hydroxyflavanone generic -metabolite KEGG:C14222 Chrysene generic -metabolite KEGG:C14223 Phenolphthalin generic -metabolite KEGG:C14224 4-Hydroxybiphenyl generic -metabolite KEGG:C14225 Bisphenol B generic -metabolite KEGG:C14226 p-tert-Amylphenol generic -metabolite KEGG:C14227 Di-n-octyl phthalate generic -metabolite KEGG:C14228 Parathion-methyl generic -metabolite KEGG:C14229 Propanil generic -metabolite KEGG:C14230 4-Hydroxybenzophenone generic -metabolite KEGG:C14231 4-Hydroxychalcone generic -metabolite KEGG:C14232 4'-Hydroxychalcone generic -metabolite KEGG:C14233 4,4'-Dihydroxystilbene generic -metabolite KEGG:C14234 Dimethylstilbestrol generic -metabolite KEGG:C14235 Triphenyl phosphate generic -metabolite KEGG:C14236 4-Heptyloxyphenol generic -metabolite KEGG:C14237 4-[2,2-Dichloro-1-(4-methoxyphenyl)ethenyl]phenol generic -metabolite KEGG:C14238 1,1-Dichloro-2,2-bis(4-hydroxyphenyl)ethylene generic -metabolite KEGG:C14239 3-Deoxyestradiol generic -metabolite KEGG:C14240 Di(2-ethylhexyl) adipate generic -metabolite KEGG:C14241 4'-Hydroxyflavanone generic -metabolite KEGG:C14242 Mytatrienediol generic -metabolite KEGG:C14243 3,3'-Dihydroxyhexestrol generic -metabolite KEGG:C14244 4-(Benzyloxyl)phenol generic -metabolite KEGG:C14245 4-Dodecylphenol generic -metabolite KEGG:C14246 2,4'-Dichlorobiphenyl generic -metabolite KEGG:C14247 2,2',4,4'-Tetrachlorobiphenyl generic -metabolite KEGG:C14248 4,4'-Dichlorobiphenyl generic -metabolite KEGG:C14249 Norethynodrel generic -metabolite KEGG:C14250 p,p'-Methoxychlor olefin generic -metabolite KEGG:C14251 1,3-Diphenyltetramethyldisiloxane generic -metabolite KEGG:C14252 1,3-Dibenzyltetramethyldisiloxane generic -metabolite KEGG:C14253 Dibutyl adipate generic -metabolite KEGG:C14254 5alpha-Androstan-17beta-ol generic -metabolite KEGG:C14255 Mibolerone generic -metabolite KEGG:C14256 11-Keto-testosterone generic -metabolite KEGG:C14257 Methyltrienolone generic -metabolite KEGG:C14258 4-Cumylphenol generic -metabolite KEGG:C14259 Stanolone benzoate generic -metabolite KEGG:C14260 Diisobutyl adipate generic -metabolite KEGG:C14261 Trenbolone generic -metabolite KEGG:C14262 p-Lactophenetide generic -metabolite KEGG:C14263 N-Benzylphthalimide generic -metabolite KEGG:C14264 2-(4-Hydroxybenzyl)isoindole-1,3-dione generic -metabolite KEGG:C14265 N-(p-Nitrobenzyl)phthalimide generic -metabolite KEGG:C14266 p-Chloroacetoacetanilide generic -metabolite KEGG:C14267 Anthrafravic acid generic -metabolite KEGG:C14268 Fenpiclonil generic -metabolite KEGG:C14269 5alpha-Androstane-3,11,17-trione generic -metabolite KEGG:C14270 3-Chlorophenol generic -metabolite KEGG:C14271 Ethohexadiol generic -metabolite KEGG:C14272 1-Octen-3-ol generic -metabolite KEGG:C14273 1,2-Octanediol generic -metabolite KEGG:C14274 4-Heptyloxybenzoic acid generic -metabolite KEGG:C14275 Furan generic -metabolite KEGG:C14276 4-(3,5-Diphenylcyclohexyl)phenol generic -metabolite KEGG:C14277 3,4-Diphenyltetrahydrofuran generic -metabolite KEGG:C14278 1,1,2-Triphenylpropane generic -metabolite KEGG:C14279 Furfural generic -metabolite KEGG:C14280 Furfural diethyl acetal generic -metabolite KEGG:C14281 5-Nitrofurfural generic -metabolite KEGG:C14282 2-Furylmercury chloride generic -metabolite KEGG:C14283 2,2'-Dihydroxy-4-methoxybenzophenone generic -metabolite KEGG:C14284 2,2'-Dihydroxybenzophenone generic -metabolite KEGG:C14285 2-Hydroxy-4-methoxybenzophenone generic -metabolite KEGG:C14286 Phenolphthalein generic -metabolite KEGG:C14287 4,4'-Methylenebis(2,6-di-tert-butylphenol) generic -metabolite KEGG:C14288 4,4'-Methylenedianiline generic -metabolite KEGG:C14289 Dibenzo-18-crown-6 generic -metabolite KEGG:C14290 7-Hydroxyflavanone generic -metabolite KEGG:C14291 Carbofuran generic -metabolite KEGG:C14292 Dichlorophen generic -metabolite KEGG:C14293 5-Nitro-2-furfuryl methyl ether generic -metabolite KEGG:C14294 Diphenolic acid generic -metabolite KEGG:C14295 Ritipenem acoxil hydrate generic -metabolite KEGG:C14296 Droloxifene generic -metabolite KEGG:C14297 4,4'-Dihydroxybiphenyl generic -metabolite KEGG:C14298 Bis(4-hydroxyphenyl)methane generic -metabolite KEGG:C14299 Cyanazine generic -metabolite KEGG:C14300 Di-n-pentyl phthalate generic -metabolite KEGG:C14301 Dicofol generic -metabolite KEGG:C14302 Dinoseb generic -metabolite KEGG:C14303 Equilenin generic -metabolite KEGG:C14304 Furamizole generic -metabolite KEGG:C14305 4-Hexyloxyphenol generic -metabolite KEGG:C14306 Nitrofurylacrylamide generic -metabolite KEGG:C14307 11beta-Chloromethylestradiol generic -metabolite KEGG:C14308 Methoprene generic -metabolite KEGG:C14309 5,6,7,8-Tetrahydro-2-naphthol generic -metabolite KEGG:C14310 Picloram generic -metabolite KEGG:C14311 4-Propylphenol generic -metabolite KEGG:C14312 Propazine generic -metabolite KEGG:C14313 3',4',7-Trihydroxyisoflavone generic -metabolite KEGG:C14314 4',6,7-Trihydroxyisoflavone generic -metabolite KEGG:C14315 Anthracene generic -metabolite KEGG:C14316 SB 218655 generic -metabolite KEGG:C14317 Benz[a]anthracene generic -metabolite KEGG:C14318 Benzo[ghi]perylene generic -metabolite KEGG:C14319 SR 141716 generic -metabolite KEGG:C14320 Benzo[b]fluoranthene generic -metabolite KEGG:C14321 Benzo[k]fluoranthene generic -metabolite KEGG:C14322 Chlorpyrifos generic -metabolite KEGG:C14323 Butylate generic -metabolite KEGG:C14324 Diazinon generic -metabolite KEGG:C14325 Dibenz[a,h]anthracene generic -metabolite KEGG:C14326 Dimethoate generic -metabolite KEGG:C14327 Heptachlor epoxide generic -metabolite KEGG:C14328 1,2-Dichlorobenzene generic -metabolite KEGG:C14329 1,2-Dimethylnaphthalene generic -metabolite KEGG:C14330 2,6-Dimethylnaphthalene generic -metabolite KEGG:C14331 4-Chloro-m-cresol generic -metabolite KEGG:C14332 Metribuzin generic -metabolite KEGG:C14333 Propyzamide generic -metabolite KEGG:C14334 Propoxur generic -metabolite KEGG:C14335 Pyrene generic -metabolite KEGG:C14336 1,2-Dibromo-3-chloropropane generic -metabolite KEGG:C14337 Bioallethrin generic -metabolite KEGG:C14338 Quintozene generic -metabolite KEGG:C14339 3,3'-Dimethylbisphenol A generic -metabolite KEGG:C14340 4-Phenethylphenol generic -metabolite KEGG:C14341 4,4'-Dihydroxybibenzyl generic -metabolite KEGG:C14342 3-Hydroxybiphenyl generic -metabolite KEGG:C14343 Trifluralin generic -metabolite KEGG:C14344 4',6-Dihydroxyflavone generic -metabolite KEGG:C14345 Bisphenol A dimethacrylate generic -metabolite KEGG:C14346 Bisphenol A bis(chloroformate) generic -metabolite KEGG:C14347 Bisphenol A bis(2-hydroxyethyl)ether generic -metabolite KEGG:C14348 Bisphenol A diglycidyl ether generic -metabolite KEGG:C14349 1,1-Bis(4-hydroxyphenyl)ethane generic -metabolite KEGG:C14350 2,2-Bis(4-hydroxyphenyl)hexafluoropropane generic -metabolite KEGG:C14351 4-Butoxyphenol generic -metabolite KEGG:C14352 6-Bromo-2-naphthol generic -metabolite KEGG:C14353 2-Chlorobiphenyl generic -metabolite KEGG:C14354 2,5-Dichlorobiphenyl generic -metabolite KEGG:C14355 2,6-Dichlorobiphenyl generic -metabolite KEGG:C14356 3,5-Dichlorobiphenyl generic -metabolite KEGG:C14357 2,3,4-Trichlorobiphenyl generic -metabolite KEGG:C14358 2,3',5-Trichlorobiphenyl generic -metabolite KEGG:C14359 2,3,6-Trichlorobiphenyl generic -metabolite KEGG:C14360 2,2',4,5-Tetrachlorobiphenyl generic -metabolite KEGG:C14361 2,3,4,4'-Tetrachlorobiphenyl generic -metabolite KEGG:C14362 2,3,4,5-Tetrachlorobiphenyl generic -metabolite KEGG:C14363 2,3,5,6-Tetrachlorobiphenyl generic -metabolite KEGG:C14364 2,4,4',6-Tetrachlorobiphenyl generic -metabolite KEGG:C14365 2,3,3',4,5-Pentachlorobiphenyl generic -metabolite KEGG:C14366 2,3,4,5,6-Pentachlorobiphenyl generic -metabolite KEGG:C14367 2,2',3,3',5,5'-Hexachlorobiphenyl generic -metabolite KEGG:C14368 Decachlorobiphenyl generic -metabolite KEGG:C14369 2,2',3,3',6,6'-Hexachlorobiphenyl generic -metabolite KEGG:C14370 2-Hydroxy-3,5-dichlorobiphenyl generic -metabolite KEGG:C14371 4-Hydroxy-3,5-dichlorobiphenyl generic -metabolite KEGG:C14372 2-Hydroxy-2',3',4',5,5'-pentachlorobiphenyl generic -metabolite KEGG:C14373 4-Hydroxy-2,2',3',4',5'-pentachlorobiphenyl generic -metabolite KEGG:C14374 4-Hydroxy-2,2',3',4',6'-pentachlorobiphenyl generic -metabolite KEGG:C14375 4-Hydroxy-2,2',3',5',6'-pentachlorobiphenyl generic -metabolite KEGG:C14376 4-Hydroxy-2,2',4',6'-tetrachlorobiphenyl generic -metabolite KEGG:C14377 4-Hydroxy-2',3,3',4',5'-pentachlorobiphenyl generic -metabolite KEGG:C14378 4-Hydroxy-2',3,3',4',6'-pentachlorobiphenyl generic -metabolite KEGG:C14379 4-Hydroxy-2',3,3',5',6'-pentachlorobiphenyl generic -metabolite KEGG:C14380 4-Hydroxy-2',3,4',6'-tetrachlorobiphenyl generic -metabolite KEGG:C14381 4-Hydroxy-2,3,3',4',5-pentachlorobiphenyl generic -metabolite KEGG:C14382 4-Hydroxy-2,2',3,4',5,5',6-heptachlorobiphenyl generic -metabolite KEGG:C14383 16-Ketoestradiol generic -metabolite KEGG:C14384 Benzo[b]fluorene generic -metabolite KEGG:C14385 2-Ethylphenol generic -metabolite KEGG:C14386 3-Ethylphenol generic -metabolite KEGG:C14387 Phenothrin generic -metabolite KEGG:C14388 Permethrin generic -metabolite KEGG:C14389 1,1,1-Trichloro-2-(4-hydroxyphenyl)-2-(4-methoxyphenyl)ethane generic -metabolite KEGG:C14390 Heptanal generic -metabolite KEGG:C14391 Diethylstilbestrol dimethyl ether generic -metabolite KEGG:C14392 Equilin generic -metabolite KEGG:C14393 Benzylparaben generic -metabolite KEGG:C14394 4-Nitrotoluene generic -metabolite KEGG:C14395 alpha-Methylstyrene generic -metabolite KEGG:C14396 Cumene generic -metabolite KEGG:C14397 Dinitrochlorobenzene generic -metabolite KEGG:C14398 Ethylenethiourea generic -metabolite KEGG:C14399 1,3-Dichloro-2-propanol generic -metabolite KEGG:C14400 1,2,3-Trichloropropane generic -metabolite KEGG:C14401 2,4-Diaminotoluene generic -metabolite KEGG:C14402 1,2-Diaminobenzene generic -metabolite KEGG:C14403 ortho-Toluidine generic -metabolite KEGG:C14404 2,4-DB generic -metabolite KEGG:C14405 N-Phenyl-1-naphthylamine generic -metabolite KEGG:C14406 3-Nitrofluoranthene generic -metabolite KEGG:C14407 2-Chloronitrobenzene generic -metabolite KEGG:C14408 1,2,3-Trichlorobenzene generic -metabolite KEGG:C14409 2-Hydroxydibenzofuran generic -metabolite KEGG:C14410 Phenbenzamine hydrochloride generic -metabolite KEGG:C14411 Dicyclopentadiene generic -metabolite KEGG:C14412 4-Toluenesulfonamide generic -metabolite KEGG:C14413 Triphenyltin chloride generic -metabolite KEGG:C14414 2-Nitrofuran generic -metabolite KEGG:C14415 Thiourea generic -metabolite KEGG:C14416 Trp-P-2 generic -metabolite KEGG:C14417 2-Anthramine generic -metabolite KEGG:C14418 3-Nitrophenol generic -metabolite KEGG:C14419 2,4-Dichloroaniline generic -metabolite KEGG:C14420 Fenthion generic -metabolite KEGG:C14421 1-Nitropyrene generic -metabolite KEGG:C14422 N-Nitrosodiethylamine generic -metabolite KEGG:C14423 1,8-Dinitropyrene generic -metabolite KEGG:C14424 1,6-Dinitropyrene generic -metabolite KEGG:C14425 Fenobucarb generic -metabolite KEGG:C14426 Acephate generic -metabolite KEGG:C14427 Diflubenzuron generic -metabolite KEGG:C14428 Thiobencarb generic -metabolite KEGG:C14429 Phenthoate generic -metabolite KEGG:C14430 Dichlorvos generic -metabolite KEGG:C14431 Methidathion generic -metabolite KEGG:C14432 Thiophanate-methyl generic -metabolite KEGG:C14433 Bendiocarb generic -metabolite KEGG:C14434 EPN generic -metabolite KEGG:C14435 Benzo[e]pyrene generic -metabolite KEGG:C14436 Edifenphos generic -metabolite KEGG:C14437 2-Mercaptobenzothiazole generic -metabolite KEGG:C14438 Captan generic -metabolite KEGG:C14439 Tributyl phosphate generic -metabolite KEGG:C14440 1,4-Dioxane generic -metabolite KEGG:C14441 16-Ketoestrone generic -metabolite KEGG:C14442 Fenitrothion generic -metabolite KEGG:C14443 3,3'-Dimethylbenzidine generic -metabolite KEGG:C14444 2-Aminoanthraquinone generic -metabolite KEGG:C14445 Tris(2-chloroethyl)phosphate generic -metabolite KEGG:C14446 Tris(butoxyethyl)phosphate generic -metabolite KEGG:C14447 2-Methylpyridine generic -metabolite KEGG:C14448 Glyoxal generic -metabolite KEGG:C14449 Epichlorohydrin generic -metabolite KEGG:C14450 4-Chloroaniline generic -metabolite KEGG:C14451 4-Chlorotoluene generic -metabolite KEGG:C14452 Morpholine generic -metabolite KEGG:C14453 4-Bromophenol generic -metabolite KEGG:C14454 2,4,6-Tribromophenol generic -metabolite KEGG:C14455 N-Ethylaniline generic -metabolite KEGG:C14456 4-Chloronitrobenzene generic -metabolite KEGG:C14457 Simetryn generic -metabolite KEGG:C14458 Dihydrogenistein generic -metabolite KEGG:C14459 2-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14460 2-Hydroxyfluorene generic -metabolite KEGG:C14461 3-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14462 3,4-Dichlorophenol generic -metabolite KEGG:C14463 (R)-3-Hydroxy-3-methyl-2-oxopentanoate generic -metabolite KEGG:C14464 4-n-Butylphenol generic -metabolite KEGG:C14465 4-n-Hexylphenol generic -metabolite KEGG:C14466 4-n-Pentylphenol generic -metabolite KEGG:C14467 cis-1,2-Diphenylcyclobutane generic -metabolite KEGG:C14468 Diisopropyl phthalate generic -metabolite KEGG:C14469 Di-n-propylphthalate generic -metabolite KEGG:C14470 3-Methylcholanthrene generic -metabolite KEGG:C14471 4-Hydroxy-2,2',4',5,5'-pentachlorobiphenyl generic -metabolite KEGG:C14472 4',5,6,7-Tetramethoxyflavone generic -metabolite KEGG:C14473 1(2H)-Phthalazinone generic -metabolite KEGG:C14474 Benzarone generic -metabolite KEGG:C14475 Bolasterone generic -metabolite KEGG:C14476 Xanthomicrol generic -metabolite KEGG:C14477 3,3-Difluoro-5alpha-androstan-17beta-yl acetate generic -metabolite KEGG:C14478 21-Deoxycortisone generic -metabolite KEGG:C14479 Flumethasone generic -metabolite KEGG:C14480 5-Diazouracil generic -metabolite KEGG:C14481 1-Hydroxy-2-acetamidofluorene generic -metabolite KEGG:C14482 3beta-Hydroxypregn-5-ene generic -metabolite KEGG:C14483 17alpha-Methylestradiol generic -metabolite KEGG:C14484 9-Fluoroprednisolone generic -metabolite KEGG:C14485 17beta-Dihydroequilin generic -metabolite KEGG:C14486 Norethindrone enanthate generic -metabolite KEGG:C14487 Ethisterone generic -metabolite KEGG:C14488 21-Fluoroprogesterone generic -metabolite KEGG:C14489 19-Norprogesterone generic -metabolite KEGG:C14490 Stenbolone generic -metabolite KEGG:C14491 Normethandrolone generic -metabolite KEGG:C14492 Ulifloxacin generic -metabolite KEGG:C14493 Methandriol generic -metabolite KEGG:C14494 4-Chloroacetanilide generic -metabolite KEGG:C14495 Eburicoic acid generic -metabolite KEGG:C14496 Estrololactone generic -metabolite KEGG:C14497 6beta-Hydroxytestosterone generic -metabolite KEGG:C14498 17alpha-Dihydroequilenin generic -metabolite KEGG:C14499 1,2-Epoxyhexadecane generic -metabolite KEGG:C14500 19-Norandrostenedione generic -metabolite KEGG:C14501 N,N'-Diphenyl-p-phenylenediamine generic -metabolite KEGG:C14502 Boldenone generic -metabolite KEGG:C14503 16-Dehydropregnenolone acetate generic -metabolite KEGG:C14504 Di-n-hexyl phthalate generic -metabolite KEGG:C14505 Di-n-decyl phthalate generic -metabolite KEGG:C14506 Chlorpropham generic -metabolite KEGG:C14507 Diphenyl carbonate generic -metabolite KEGG:C14508 Mesitylene generic -metabolite KEGG:C14509 1-Tridecanol generic -metabolite KEGG:C14510 Fensulfothion generic -metabolite KEGG:C14511 Bisphenol A glycidylmethacrylate generic -metabolite KEGG:C14512 Benzofuran generic -metabolite KEGG:C14513 Tetrachlorvinphos generic -metabolite KEGG:C14514 Chinomethionat generic -metabolite KEGG:C14515 Camphorquinone generic -metabolite KEGG:C14516 Kojic acid generic -metabolite KEGG:C14517 Pretilachlor generic -metabolite KEGG:C14518 1,2,3-Trimethylbenzene generic -metabolite KEGG:C14519 1-Hydroxypyrene generic -metabolite KEGG:C14520 Chlorpyrifos-methyl generic -metabolite KEGG:C14521 2,4-Dibromophenol generic -metabolite KEGG:C14522 3-Ethyltoluene generic -metabolite KEGG:C14523 Diisopropyl adipate generic -metabolite KEGG:C14524 Flucythrinate generic -metabolite KEGG:C14525 Mefenacet generic -metabolite KEGG:C14526 Esprocarb generic -metabolite KEGG:C14527 Methyl methacrylate generic -metabolite KEGG:C14528 Tetrachlorobisphenol A generic -metabolite KEGG:C14529 Dicyclohexyl phthalate generic -metabolite KEGG:C14530 2-Hydroxyethyl methacrylate generic -metabolite KEGG:C14531 Azomycin generic -metabolite KEGG:C14532 Fenoprop generic -metabolite KEGG:C14533 1,2,4-Trimethylbenzene generic -metabolite KEGG:C14534 1,2,4,5-Tetramethylbenzene generic -metabolite KEGG:C14535 4-t-Butylbenzoic acid generic -metabolite KEGG:C14536 Glycitein generic -metabolite KEGG:C14537 Trimethylolpropane triacrylate generic -metabolite KEGG:C14538 Trimethylolpropane trimethacrylate generic -metabolite KEGG:C14539 Krm 1657 generic -metabolite KEGG:C14540 Rifamycin S generic -metabolite KEGG:C14541 (R)-4'-Deoxyindenestrol generic -metabolite KEGG:C14542 (S)-4'-Deoxyindenestrol generic -metabolite KEGG:C14543 (R)-5-Deoxyindenestrol generic -metabolite KEGG:C14544 (S)-5-Deoxyindenestrol generic -metabolite KEGG:C14545 (S)-Indenestrol A generic -metabolite KEGG:C14546 (R)-Indenestrol A generic -metabolite KEGG:C14547 (S)-Indenestrol B generic -metabolite KEGG:C14548 (R)-Indenestrol B generic -metabolite KEGG:C14549 Triphenylsilanol generic -metabolite KEGG:C14550 4-n-Nonylphenol generic -metabolite KEGG:C14551 Diethylstilbestrol monomethyl ether generic -metabolite KEGG:C14552 11-Ketoetiocholanolone generic -metabolite KEGG:C14553 3alpha,11beta-Dihydroxy-5beta-androstane-17-one generic -metabolite KEGG:C14554 Deoxycorticosterone acetate generic -metabolite KEGG:C14555 11alpha,17beta-Dihydroxy-17-methylandrost-4-en-3-one generic -metabolite KEGG:C14556 9-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14557 8-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14558 7-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14559 5-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14560 4-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14561 2,4,6-Triphenyl-1-hexene generic -metabolite KEGG:C14562 2,4-Diphenyl-1-butene generic -metabolite KEGG:C14563 12-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14564 11-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14565 10-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14566 Diethyl adipate generic -metabolite KEGG:C14567 Acetyleugenol generic -metabolite KEGG:C14568 Bromobutide generic -metabolite KEGG:C14569 4,4'-Biphenyldithiol generic -metabolite KEGG:C14570 Dimethyl adipate generic -metabolite KEGG:C14571 Dimepiperate generic -metabolite KEGG:C14572 2-Ethyltoluene generic -metabolite KEGG:C14573 3,3',4,4',5-Pentachlorobiphenyl generic -metabolite KEGG:C14574 Chlorobenzilate generic -metabolite KEGG:C14575 Di-n-heptyl phthalate generic -metabolite KEGG:C14576 6-Hydroxybenzo[a]pyrene generic -metabolite KEGG:C14577 Diisooctyl phthalate generic -metabolite KEGG:C14578 Diisodecyl phthalate generic -metabolite KEGG:C14579 Xylylcarb generic -metabolite KEGG:C14580 Isoxathion generic -metabolite KEGG:C14581 1,3-Diphenylpropane generic -metabolite KEGG:C14582 2,4-Dimethylphenol generic -metabolite KEGG:C14583 1,4-Diethylbenzene generic -metabolite KEGG:C14584 Chlorobenside generic -metabolite KEGG:C14585 4-Chlorochalcone generic -metabolite KEGG:C14586 6alpha-Methylprogesterone generic -metabolite KEGG:C14587 11alpha-Hydroxyandrosta-1,4-diene-3,17-dione generic -metabolite KEGG:C14588 17beta-Hydroxy-7alpha-methylandrost-4-en-3-one generic -metabolite KEGG:C14589 1,2-Bis(4-nitrophenyl)ethane generic -metabolite KEGG:C14590 Estra-1,3,5(10),6-tetraen-3,17beta-diol generic -metabolite KEGG:C14591 Pyridarone generic -metabolite KEGG:C14592 N-Methyl-N'-nitro-N-nitrosoguanidine generic -metabolite KEGG:C14593 Epimestrol generic -metabolite KEGG:C14594 3alpha,17alpha,21-Trihydroxy-5beta-pregnan-20-one generic -metabolite KEGG:C14595 Methylnitrosourea generic -metabolite KEGG:C14596 Ethamoxytriphetol generic -metabolite KEGG:C14597 2,3-Bis(p-methoxyphenyl)acrylonitrile generic -metabolite KEGG:C14598 3alpha,17alpha-Dihydroxy-5beta-pregnane-11,20-dione generic -metabolite KEGG:C14599 2,3,3-Triphenylacrylonitrile generic -metabolite KEGG:C14600 16alpha-Hydroxytestosterone generic -metabolite KEGG:C14601 Methyl methoxyacetate generic -metabolite KEGG:C14602 3-Hydroxyaminophenol generic -metabolite KEGG:C14603 17beta-Hydroxyestr-4-en-3-one cyclopentanepropionate generic -metabolite KEGG:C14604 Aminohydroquinone generic -metabolite KEGG:C14605 Metholone generic -metabolite KEGG:C14606 3alpha,11beta-Dihydroxy-5alpha-androstane-17-one generic -metabolite KEGG:C14607 Testosterone decanoate generic -metabolite KEGG:C14608 3alpha,6alpha-Dihydroxy-5beta-pregnan-20-one generic -metabolite KEGG:C14609 3alpha,17alpha-Dihydroxy-5beta-pregnan-20-one generic -metabolite KEGG:C14610 (S)-5-Oxo-2,5-dihydrofuran-2-acetate generic -metabolite KEGG:C14611 1-Chloro-2-(chlorophenylmethyl)benzene generic -metabolite KEGG:C14612 Rubrophen generic -metabolite KEGG:C14613 Allenolic acid generic -metabolite KEGG:C14614 6-(Pentylthio)purine generic -metabolite KEGG:C14615 17beta-Hydroxy-17-methylandrost-4-ene-3,11-dione generic -metabolite KEGG:C14616 (3alpha,5beta,11beta,17beta)-9-Fluoro-17-methylandrostane-3,11,17-triol generic -metabolite KEGG:C14617 Chrysoidine free base generic -metabolite KEGG:C14618 6alpha-Fluoroprednisolone generic -metabolite KEGG:C14619 o-Chloroacetanilide generic -metabolite KEGG:C14620 2-Acetamido-6H-dibenzo[b,d]pyran-6-one generic -metabolite KEGG:C14621 9-Fluoro-17-methyl-11-oxotestosterone generic -metabolite KEGG:C14622 (E)-1-Methoxy-4-[2-(4-nitrophenyl)ethenyl]benzene generic -metabolite KEGG:C14623 6-(Ethylthio)purine generic -metabolite KEGG:C14624 Androstane-3,17-diol dipropionate generic -metabolite KEGG:C14625 9alpha-Fluoro-6alpha-methylprednisolone 21-acetate generic -metabolite KEGG:C14626 2'-Carboxy-4-[bis(2-chloroethyl)amino]-2-methylazobenzene generic -metabolite KEGG:C14627 14alpha,17beta-Dihydroxyandrost-4-en-3-one generic -metabolite KEGG:C14628 4,5alpha-Dihydro-2-(hydroxymethylene)testosterone generic -metabolite KEGG:C14629 Fluorometholone 17-acetate generic -metabolite KEGG:C14630 9alpha-Fluoro-11beta-hydroxy-6alpha-methylpregn-4-ene-3,20-dione generic -metabolite KEGG:C14631 5-Androstene-3beta,16alpha-diol generic -metabolite KEGG:C14632 6alpha-Methylpregn-4-ene-3,11,20-trione generic -metabolite KEGG:C14633 7-Hydroxy-2-acetamidofluorene generic -metabolite KEGG:C14634 Methandriol dipropionate generic -metabolite KEGG:C14635 16alpha,17alpha-Epoxy-20-oxopregn-5-en-3beta-yl acetate generic -metabolite KEGG:C14636 9alpha-Fluoro-11beta,17alpha,21-trihydroxypregna-1,4-diene-3,20-dione 21-acetate generic -metabolite KEGG:C14637 16beta-Hydroxy-3,11-dioxopregna-4,17(20)-dien-21-oic acid, gamma-lactone generic -metabolite KEGG:C14638 9alpha-Fluoro-11beta,16alpha,17alpha,21-tetrahydroxypregn-4-ene-3,20-dione generic -metabolite KEGG:C14639 2-Indanone oxime generic -metabolite KEGG:C14640 Estradiol 17beta-cyclopentylpropionate generic -metabolite KEGG:C14641 Cholesteryl oleate generic -metabolite KEGG:C14642 Melengestrol acetate generic -metabolite KEGG:C14643 Medrysone generic -metabolite KEGG:C14644 4-Bromophenylthiourea generic -metabolite KEGG:C14645 Estradiol-17-phenylpropionate generic -metabolite KEGG:C14646 Pregna-4,11-diene-3,20-dione generic -metabolite KEGG:C14647 Braxoron generic -metabolite KEGG:C14648 6alpha-Chloro-17-acetoxyprogesterone generic -metabolite KEGG:C14649 15alpha-Hydroxytestosterone generic -metabolite KEGG:C14650 3-Hydroxyestra-1,3,5(10),6-tetraen-17-one generic -metabolite KEGG:C14651 16alpha,17alpha-Epoxy-3,20-dioxopregn-4-en-21-yl acetate generic -metabolite KEGG:C14652 19-Nor-17alpha-pregn-5(10)-en-20-yne-3alpha,17beta-diol generic -metabolite KEGG:C14653 Descinolone acetonide generic -metabolite KEGG:C14654 12alpha-Hydroxyprogesterone generic -metabolite KEGG:C14655 17,17-Dimethyl-18-norandrosta-4,13-dien-3-one generic -metabolite KEGG:C14656 3-Hydroxy-2-acetamidofluorene generic -metabolite KEGG:C14657 2,3-Diphenyl-1-indanone generic -metabolite KEGG:C14658 Pregnenolone acetate generic -metabolite KEGG:C14660 Carbestrol generic -metabolite KEGG:C14661 3-Methoxy-19-nor-17alpha-pregna-1,3,5(10)-trien-17beta-ol generic -metabolite KEGG:C14662 (E)-4-Nitrostilbene generic -metabolite KEGG:C14663 Testosterone isocaproate generic -metabolite KEGG:C14664 11beta,16alpha,17alpha,21-Tetrahydroxy-9alpha-fluoropregn-4-ene-3,20-dione 16,17-acetonide generic -metabolite KEGG:C14665 Oranabol generic -metabolite KEGG:C14666 1-(4-Methoxyphenyl)-2-phenylethane generic -metabolite KEGG:C14667 Testosterone phenylpropionate generic -metabolite KEGG:C14668 Cortancyl generic -metabolite KEGG:C14669 12alpha-Bromo-11beta-hydroxypregn-4-ene-3,20-dione generic -metabolite KEGG:C14670 17-Ethynyl-10-hydroxy-19-nortestosterone generic -metabolite KEGG:C14671 11-Ketoandrosterone generic -metabolite KEGG:C14672 p-Chlorobenzhydrol generic -metabolite KEGG:C14673 Cholesta-5,7-dien-3beta-ol benzoate generic -metabolite KEGG:C14674 16alpha,17alpha-Dihydroxyprogesterone acetophenide generic -metabolite KEGG:C14675 11beta,21-Dihydroxypregn-4-ene-3,20-dione 21-acetate generic -metabolite KEGG:C14676 4-Chloroprogesterone generic -metabolite KEGG:C14677 1-Dehydroprogesterone generic -metabolite KEGG:C14678 5-Hydroxy-2-acetamidofluorene generic -metabolite KEGG:C14679 p-Methoxystilbene generic -metabolite KEGG:C14680 5beta-Pregnane-3alpha,17alpha,20alpha-triol generic -metabolite KEGG:C14681 16-alpha,17-Epoxypregn-4-ene-3,20-dione generic -metabolite KEGG:C14682 3-Methoxyestra-2,5(10)-dien-17beta-ol generic -metabolite KEGG:C14683 11beta,17beta-Dihydroxy-17-methylandrost-4-en-3-one generic -metabolite KEGG:C14684 17beta-Hydroxy-17-methylandrosta-4,9(11)-dien-3-one generic -metabolite KEGG:C14685 1,2-Dihydrostilbene generic -metabolite KEGG:C14686 Dicyclohexylamine generic -metabolite KEGG:C14687 2-Ethoxyethanol generic -metabolite KEGG:C14688 Bis(2-chloroethyl)ether generic -metabolite KEGG:C14689 Diethylene glycol generic -metabolite KEGG:C14690 Tetraethylenepentamine generic -metabolite KEGG:C14691 Triethylamine generic -metabolite KEGG:C14692 Chlorodibromomethane generic -metabolite KEGG:C14693 Butylhydroxytoluene generic -metabolite KEGG:C14694 N-Phenyl-2-naphthylamine generic -metabolite KEGG:C14695 Nitrilotriacetic acid generic -metabolite KEGG:C14696 1-Nonanol generic -metabolite KEGG:C14697 4-Isopentylphenol generic -metabolite KEGG:C14698 4-n-Heptylphenol generic -metabolite KEGG:C14699 1-Hydroxychlordene generic -metabolite KEGG:C14700 2-Chloro-1,1,2-trifluoroethyl ethyl ether generic -metabolite KEGG:C14701 Paraquat generic -metabolite KEGG:C14702 1,2-Dinitrobenzene generic -metabolite KEGG:C14703 1,8-Dimethylnaphthalene generic -metabolite KEGG:C14704 N-Nitrosodimethylamine generic -metabolite KEGG:C14705 1,1,1,2-Tetrachloroethane generic -metabolite KEGG:C14706 Diethyl sulfate generic -metabolite KEGG:C14707 Bromoform generic -metabolite KEGG:C14708 Bromodichloromethane generic -metabolite KEGG:C14709 1,1-Dimethylethyl benzoate generic -metabolite KEGG:C14710 Isobutyl alcohol generic -metabolite KEGG:C14711 Nickel chloride generic -metabolite KEGG:C14712 2,5-Dichloroaniline generic -metabolite KEGG:C14713 2,4-Dinitroaniline generic -metabolite KEGG:C14714 2-(m-Chlorophenyl)-2-(p-chlorophenyl)-1,1-dichloroethane generic -metabolite KEGG:C14715 4-Chloro-3,5-dimethylphenol generic -metabolite KEGG:C14716 2-Ethylhexyl-4-hydroxybenzoate generic -metabolite KEGG:C14717 15-Deoxy-Delta12,14-PGJ2 generic -metabolite KEGG:C14718 Heptyl p-hydroxybenzoate generic -metabolite KEGG:C14719 Methallenestrilphenol generic -metabolite KEGG:C14720 4-Ethyl-7-hydroxy-3-(p-methoxyphenyl)coumarin generic -metabolite KEGG:C14721 34a-Deoxy-rifamycin W generic -metabolite KEGG:C14722 Rifamycin W-hemiacetal generic -metabolite KEGG:C14723 Rifamycin Z generic -metabolite KEGG:C14724 Demethyl-desacetyl-rifamycin S generic -metabolite KEGG:C14725 27-O-Demethyl-25-O-desacetylrifamycin SV generic -metabolite KEGG:C14726 2,2',3,3',4',5,5'-Heptachloro-4-biphenylol generic -metabolite KEGG:C14727 27-O-Demethylrifamycin SV generic -metabolite KEGG:C14728 2,2',3,3',4',5-Hexachloro-4-biphenylol generic -metabolite KEGG:C14729 2',3,3',4',5-Pentachloro-4-biphenylol generic -metabolite KEGG:C14730 2,2',3,4',5,5'-Hexachloro-4-biphenylol generic -metabolite KEGG:C14731 16alpha-Bromo-17beta-estradiol generic -metabolite KEGG:C14732 5-OxoETE generic -metabolite KEGG:C14733 2',3',4',5'-Tetrachloro-3-biphenylol generic -metabolite KEGG:C14734 2',5'-Dichloro-3-biphenylol generic -metabolite KEGG:C14736 2',5'-Dichloro-2-biphenylol generic -metabolite KEGG:C14737 4,3',5'-Trichloro-4'-biphenol generic -metabolite KEGG:C14738 Indanestrol generic -metabolite KEGG:C14739 alpha,alpha'-Diethyl-3,4,3',4'-stilbenetetraol generic -metabolite KEGG:C14740 alpha,alpha'-Diethyl-3,4,4'-stilbenetriol generic -metabolite KEGG:C14741 4-Isopropyl-3-methylphenol generic -metabolite KEGG:C14742 N-Nitrosodiphenylamine generic -metabolite KEGG:C14743 Isophorone generic -metabolite KEGG:C14744 Dacthal generic -metabolite KEGG:C14745 Zindoxifene generic -metabolite KEGG:C14746 Chlordimeform generic -metabolite KEGG:C14747 2,2'-Bisphenol F generic -metabolite KEGG:C14748 20-HETE generic -metabolite KEGG:C14749 19(S)-HETE generic -metabolite KEGG:C14750 alpha-Zearalenol generic -metabolite KEGG:C14751 beta-Zearalenol generic -metabolite KEGG:C14752 alpha-Zearalanol generic -metabolite KEGG:C14753 beta-Zearalanol generic -metabolite KEGG:C14754 Zearalanone generic -metabolite KEGG:C14755 2-Chloro-4-biphenylol generic -metabolite KEGG:C14756 2,2',3,6,6'-Pentachloro-4-biphenylol generic -metabolite KEGG:C14757 Moxestrol generic -metabolite KEGG:C14758 ICI 164384 generic -metabolite KEGG:C14759 4,4'-Diaminodiphenyl ether generic -metabolite KEGG:C14760 Amaranth generic -metabolite KEGG:C14761 trans,trans-1,4-Diphenyl-1,3-butadiene generic -metabolite KEGG:C14762 13(S)-HODE generic -metabolite KEGG:C14763 trans-4-Hydroxystilbene generic -metabolite KEGG:C14764 2-Thiophenesulfonamide generic -metabolite KEGG:C14765 13-OxoODE generic -metabolite KEGG:C14766 9-OxoODE generic -metabolite KEGG:C14767 9(S)-HODE generic -metabolite KEGG:C14768 5,6-EET generic -metabolite KEGG:C14769 8,9-EET generic -metabolite KEGG:C14770 11,12-EET generic -metabolite KEGG:C14771 14,15-EET generic -metabolite KEGG:C14772 5,6-DHET generic -metabolite KEGG:C14773 8,9-DHET generic -metabolite KEGG:C14774 11,12-DHET generic -metabolite KEGG:C14775 14,15-DHET generic -metabolite KEGG:C14776 8(S)-HETE generic -metabolite KEGG:C14777 12(S)-HETE generic -metabolite KEGG:C14778 16(R)-HETE generic -metabolite KEGG:C14779 9(S)-HETE generic -metabolite KEGG:C14780 11(R)-HETE generic -metabolite KEGG:C14781 15H-11,12-EETA generic -metabolite KEGG:C14782 11,12,15-THETA generic -metabolite KEGG:C14783 1,2-Naphthoquinone generic -metabolite KEGG:C14784 1,2-Dihydroxy-3,4-epoxy-1,2,3,4-tetrahydronaphthalene generic -metabolite KEGG:C14785 1,4-Dihydroxynaphthalene generic -metabolite KEGG:C14786 (1R,2S)-Naphthalene 1,2-oxide generic -metabolite KEGG:C14787 (1S,2R)-Naphthalene 1,2-oxide generic -metabolite KEGG:C14788 1-Nitrosonaphthalene generic -metabolite KEGG:C14789 N-Hydroxy-1-aminonaphthalene generic -metabolite KEGG:C14790 1-Naphthylamine generic -metabolite KEGG:C14791 (1R)-Hydroxy-(2R)-glutathionyl-1,2-dihydronaphthalene generic -metabolite KEGG:C14792 (1S)-Hydroxy-(2S)-glutathionyl-1,2-dihydronaphthalene generic -metabolite KEGG:C14793 (1R)-Glutathionyl-(2R)-hydroxy-1,2-dihydronaphthalene generic -metabolite KEGG:C14794 2,3-Dinor-8-iso prostaglandin F2alpha generic -metabolite KEGG:C14795 2,3-Dinor-8-iso prostaglandin F1alpha generic -metabolite KEGG:C14796 (1R)-Hydroxy-(2R)-N-acetyl-L-cysteinyl-1,2-dihydronaphthalene generic -metabolite KEGG:C14797 (1R)-N-Acetyl-L-cysteinyl-(2R)-hydroxy-1,2-dihydronaphthalene generic -metabolite KEGG:C14798 (1S)-Hydroxy-(2S)-N-acetyl-L-cysteinyl-1,2-dihydronaphthalene generic -metabolite KEGG:C14799 (1R,2R)-3-[(1,2-Dihydro-2-hydroxy-1-naphthalenyl)thio]-2-oxopropanoic acid generic -metabolite KEGG:C14800 1-Nitronaphthalene-5,6-oxide generic -metabolite KEGG:C14801 1-Nitro-5,6-dihydroxy-dihydronaphthalene generic -metabolite KEGG:C14802 1-Nitronaphthalene-7,8-oxide generic -metabolite KEGG:C14803 1-Nitro-7-hydroxy-8-glutathionyl-7,8-dihydronaphthalene generic -metabolite KEGG:C14804 1-Nitro-7-glutathionyl-8-hydroxy-7,8-dihydronaphthalene generic -metabolite KEGG:C14805 1-Nitro-5-hydroxy-6-glutathionyl-5,6-dihydronaphthalene generic -metabolite KEGG:C14806 1-Nitro-5-glutathionyl-6-hydroxy-5,6-dihydronaphthalene generic -metabolite KEGG:C14807 12-OxoETE generic -metabolite KEGG:C14808 Hepoxilin A3 generic -metabolite KEGG:C14809 Trioxilin A3 generic -metabolite KEGG:C14810 Hepoxilin B3 generic -metabolite KEGG:C14811 Trioxilin B3 generic -metabolite KEGG:C14812 12(R)-HPETE generic -metabolite KEGG:C14813 11H-14,15-EETA generic -metabolite KEGG:C14814 11,14,15-THETA generic -metabolite KEGG:C14815 5,6-Epoxytetraene generic -metabolite KEGG:C14816 Sch 59884 generic -metabolite KEGG:C14817 BMS 379224 generic -metabolite KEGG:C14818 Fe2+ generic -metabolite KEGG:C14819 Fe3+ generic -metabolite KEGG:C14820 11(R)-HPETE generic -metabolite KEGG:C14821 9(S)-HPETE generic -metabolite KEGG:C14822 12(R)-HETE generic -metabolite KEGG:C14823 8(S)-HPETE generic -metabolite KEGG:C14824 8(R)-HETE generic -metabolite KEGG:C14825 9(10)-EpOME generic -metabolite KEGG:C14826 12(13)-EpOME generic -metabolite KEGG:C14827 9(S)-HPODE generic -metabolite KEGG:C14828 9,10-DHOME generic -metabolite KEGG:C14829 12,13-DHOME generic -metabolite KEGG:C14830 GDP-4-keto-6-L-deoxygalactose generic -metabolite KEGG:C14831 8(R)-HPODE generic -metabolite KEGG:C14832 12,13-Epoxy-9-hydroxy-10-octadecenoate generic -metabolite KEGG:C14833 9,12,13-TriHOME generic -metabolite KEGG:C14834 9,10-Epoxy-13-hydroxy-11-octadecenoate generic -metabolite KEGG:C14835 9,10,13-TriHOME generic -metabolite KEGG:C14836 9,10-12,13-Diepoxyoctadecanoate generic -metabolite KEGG:C14837 9,10-Dihydroxy-12,13-epoxyoctadecanoate generic -metabolite KEGG:C14838 Y 23684 generic -metabolite KEGG:C14839 Bromobenzene-3,4-oxide generic -metabolite KEGG:C14840 Bromobenzene-2,3-oxide generic -metabolite KEGG:C14841 2-Bromophenol generic -metabolite KEGG:C14842 Bromobenzene-2,3-dihydrodiol generic -metabolite KEGG:C14843 4-Bromocatechol generic -metabolite KEGG:C14844 Bromobenzene-3,4-dihydrodiol generic -metabolite KEGG:C14845 4-Bromophenol-2,3-epoxide generic -metabolite KEGG:C14846 4-Bromo-3,5-cyclohexadiene-1,2-dione generic -metabolite KEGG:C14847 3,4-Dihydro-3-hydroxy-4-S-glutathionyl bromobenzene generic -metabolite KEGG:C14848 2,3-Dihydro-2-S-glutathionyl-3-hydroxy bromobenzene generic -metabolite KEGG:C14849 Benzo[a]pyrene-9,10-oxide generic -metabolite KEGG:C14850 Benzo[a]pyrene-7,8-oxide generic -metabolite KEGG:C14851 Benzo[a]pyrene-4,5-oxide generic -metabolite KEGG:C14852 Benzo[a]pyrene-7,8-diol generic -metabolite KEGG:C14853 Benzo[a]pyrene-7,8-dihydrodiol-9,10-oxide generic -metabolite KEGG:C14854 9-Hydroxybenzo[a]pyrene-4,5-oxide generic -metabolite KEGG:C14855 4,5-Dihydro-4-hydroxy-5-S-glutathionyl-benzo[a]pyrene generic -metabolite KEGG:C14856 7,8-Dihydro-7-hydroxy-8-S-glutathionyl-benzo[a]pyrene generic -metabolite KEGG:C14857 1,1-Dichloroethylene epoxide generic -metabolite KEGG:C14858 2,2-Dichloroacetaldehyde generic -metabolite KEGG:C14859 Chloroacetyl chloride generic -metabolite KEGG:C14860 2,2-Dichloro-1,1-ethanediol generic -metabolite KEGG:C14861 S-(2,2-Dichloro-1-hydroxy)ethyl glutathione generic -metabolite KEGG:C14862 2-S-Glutathionyl acetate generic -metabolite KEGG:C14863 2-(S-Glutathionyl)acetyl glutathione generic -metabolite KEGG:C14864 S-(2-Chloroacetyl)glutathione generic -metabolite KEGG:C14865 2-(S-Glutathionyl)acetyl chloride generic -metabolite KEGG:C14866 Chloral generic -metabolite KEGG:C14867 Dichloroacetyl chloride generic -metabolite KEGG:C14868 S-(1,2-Dichlorovinyl)glutathione generic -metabolite KEGG:C14869 Trichloroethanol glucuronide generic -metabolite KEGG:C14870 2-Bromoacetaldehyde generic -metabolite KEGG:C14871 S-(Formylmethyl)glutathione generic -metabolite KEGG:C14872 Thiodiacetic acid generic -metabolite KEGG:C14873 Thiodiacetic acid sulfoxide generic -metabolite KEGG:C14874 Glutathione episulfonium ion generic -metabolite KEGG:C14875 S-(2-Hydroxyethyl)glutathione generic -metabolite KEGG:C14876 S-(2-Hydroxyethyl)-N-acetyl-L-cysteine generic -metabolite KEGG:C14877 S-[2-(N7-Guanyl)ethyl]-N-acetyl-L-cysteine generic -metabolite KEGG:C14878 6alpha,17-Dimethyl-5alpha-androstane-3beta,17beta-diol generic -metabolite KEGG:C14879 17-Methyl-3-(2,4-cyclopentadien-1-ylidene)-5alpha-androstane-17beta-ol generic -metabolite KEGG:C14880 16alpha,17-Dihydroxypregn-4-ene-3,20-dione cyclic acetal with 2-furyl methyl ketone generic -metabolite KEGG:C14881 17-Hydroxy-3-oxo-19-nor-5alpha,17alpha-pregnane-21-carboxylic acid, gamma-lactone generic -metabolite KEGG:C14882 2alpha-Methyl-5alpha-androstane-3alpha,17beta-diol generic -metabolite KEGG:C14883 (3beta,5alpha,11beta,17beta)-9-Fluoro-17-methylandrostane-3,11,17-triol generic -metabolite KEGG:C14884 cis-1,3,4,6,7,11b-Hexahydro-9-methoxy-2H-benzo[a]quinolizine-3-carboxylic acid ethyl ester generic -metabolite KEGG:C14885 9-Fluoro-11beta-hydroxy-16beta-methylandrosta-1,4-diene-3,17-dione generic -metabolite KEGG:C14886 16beta-Fluoroandrost-4-ene-3,17-dione generic -metabolite KEGG:C14887 11alpha,17beta-Dihydroxy-17alpha-methylandrosta-1,4-dien-3-one generic -metabolite KEGG:C14888 (+)-Methallenestrilphenol generic -metabolite KEGG:C14889 5alpha-Androstane-2beta-fluoro-17beta-ol-3-one acetate generic -metabolite KEGG:C14890 17beta-Hydroxy-6beta-methylandrost-4-en-3-one generic -metabolite KEGG:C14891 7alpha,17beta-Dihydroxy-17alpha-methylandrost-4-en-3-one generic -metabolite KEGG:C14892 17-Allylestra-1,3,5(10)-triene-3,17beta-diol generic -metabolite KEGG:C14893 2-(4-Chlorophenyl)-3-phenyl-3-(2-pyridinyl)acrylonitrile generic -metabolite KEGG:C14894 3',6'-Dihydroxy-2',4,4'-trimethoxy-chalcone generic -metabolite KEGG:C14895 1-(2-Hydroxy-3,4,5,6-tetramethoxyphenyl)-3-(2,3,4,6-tetramethoxyphenyl)-2-propen-1-one generic -metabolite KEGG:C14896 1-Methyl-6-(1,2,3,4-tetrahydro-6-methoxy-2-naphthyl)-2(1H)-pyridone generic -metabolite KEGG:C14897 p-(3,4-Dihydro-6-methoxy-2-naphthyl)phenol generic -metabolite KEGG:C14898 4,4a,5,6,7,8-Hexahydro-6-(p-hydroxyphenyl)-2(3H)-naphthalenone generic -metabolite KEGG:C14899 3-Dehydro-L-gulonate 6-phosphate generic -metabolite KEGG:C14900 6-(1,2,3,4-Tetrahydro-6-methoxy-2-naphthyl)-2(1H)-pyridone generic -metabolite KEGG:C14901 1-Methyl-6-(1,2,3,4-tetrahydro-6-hydroxy-2-naphthyl)-2(1H)-pyridone generic -metabolite KEGG:C14902 6-(1,2,3,4-Tetrahydro-6-hydroxy-2-naphthyl)-2(1H)-pyridone generic -metabolite KEGG:C14903 2,3-Bis(p-hydroxyphenyl)acrylonitrile generic -metabolite KEGG:C14904 alpha-(p-Methoxyphenyl)-3-pyridineacrylonitrile generic -metabolite KEGG:C14905 2-Chloro-beta-(4-chlorophenyl)phenethyl alcohol generic -metabolite KEGG:C14906 (5alpha,17beta)-3-Methyl-androst-2-en-17-ol generic -metabolite KEGG:C14907 7alpha,17beta-Dihydroxyandrosta-1,4-dien-3-one generic -metabolite KEGG:C14908 3-Ethyl-1,3,4,6,7,11b-hexahydro-9,10-dimethoxy-2H-benzo[a]quinolizin-2-one generic -metabolite KEGG:C14909 9alpha-Hydroxyandrosta-1,4-diene-3,17-dione generic -metabolite KEGG:C14910 4,4-Difluoro-17beta-hydroxy-17alpha-methyl-androst-5-en-3-one generic -metabolite KEGG:C14911 17beta-Hydroxy-2-oxa-5alpha-androstan-3-one generic -metabolite KEGG:C14912 1,2,4,5-Tetrahydrotestolactone generic -metabolite KEGG:C14913 17beta-Hydroxy-4-oxa-5alpha-androstan-3-one acetate generic -metabolite KEGG:C14914 3beta-Chloro-N,N-bis(2-chloroethyl)-androst-5-en-17beta-amine generic -metabolite KEGG:C14915 3-(2,4-Cyclopentadien-1-ylidene)-5alpha-androstan-17beta-ol generic -metabolite KEGG:C14916 Nirvanol generic -metabolite KEGG:C14917 9-Thiocyanato-androst-4-ene-3,11,17-trione generic -metabolite KEGG:C14918 9-Bromo-16alpha-methyl-pregn-4-ene-3,11,20-trione generic -metabolite KEGG:C14919 17beta-Hydroxy-2alpha-(methoxymethyl)-17-methyl-5alpha-androstan-3-one generic -metabolite KEGG:C14920 N-(6-Oxo-6H-dibenzo[b,d]pyran-3-yl)acetamide generic -metabolite KEGG:C14921 3-Oxo-N-phenyl-N-(phenylmethyl)butanamide generic -metabolite KEGG:C14922 15beta-Hydroxy-7alpha-mercapto-pregn-4-ene-3,20-dione 7-acetate generic -metabolite KEGG:C14923 12alpha-(Chloromethyl)-12-hydroxy-pregn-4-ene-3,20-dione generic -metabolite KEGG:C14924 3beta,21-Dihydroxy-pregna-5,7,9(11)-trien-20-one diacetate generic -metabolite KEGG:C14925 17beta-Hydroxy-2-methylandrost-1,4-dien-3-one generic -metabolite KEGG:C14926 3-Hydroxy-2-(4-morpholinylmethyl)estra-1,3,5(10)-trien-17-one generic -metabolite KEGG:C14927 N-(6-Oxo-6H-dibenzo[b,d]pyran-2-yl)methanesulfonamide generic -metabolite KEGG:C14928 17-[[3-(1-Pyrrolidinyl)propyl]imino]androst-5-en-3beta-ol acetate generic -metabolite KEGG:C14929 17beta-Hydroxy-16alpha-methoxy-androst-4-en-3-one generic -metabolite KEGG:C14930 3-Methoxy-androsta-3,5-diene-7,17-dione generic -metabolite KEGG:C14931 16-Butyl-3-methoxy-estra-1,3,5(10)-triene-16beta,17beta-diol generic -metabolite KEGG:C14932 11beta-Hydroxy-5alpha-androstan-17-one generic -metabolite KEGG:C14933 17-Propyl-5alpha-androst-2-en-17beta-ol generic -metabolite KEGG:C14934 16-Propyl-3-methoxy-estra-1,3,5(10)-triene-16beta,17beta-diol generic -metabolite KEGG:C14935 m-(beta-Acetyl-alpha-ethyl-p-hydroxyphenethyl)benzoic acid generic -metabolite KEGG:C14936 2-(p-Methoxyphenyl)-3-(m-chlorophenyl)acrylonitrile generic -metabolite KEGG:C14937 6beta-(Dimethylamino)-3beta,5-dihydroxy-5alpha-pregnan-20-one generic -metabolite KEGG:C14938 N-[(4-Chlorophenyl)methyl]-N-ethyl-2-pyridinamine generic -metabolite KEGG:C14939 11beta-17-Dihydroxy-6alpha-methylpregn-4-ene-3,20-dione generic -metabolite KEGG:C14940 2,3-Dihydro-2-(4-hydroxyphenyl)-5,6,7,8-tetramethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14941 Pyrethrin generic -metabolite KEGG:C14942 2-(2,4,5-Trimethoxyphenyl)-5,6,7,8-tetramethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14943 2-(2,5-Dimethoxyphenyl)-5,6,7,8-tetramethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14944 2-(3,5-Dimethoxyphenyl)-5,6,7,8-tetramethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14945 3-Methoxy-16-methyl-estra-2,5(10)-diene-16beta,17beta-diol generic -metabolite KEGG:C14946 1-Dehydro-15alpha-hydroxytestololactone generic -metabolite KEGG:C14947 17-Propylestra-1,3,5(10)-triene-3,17beta-diol diacetate generic -metabolite KEGG:C14948 2-(4-Ethoxyphenyl)-5,6,7,8-tetramethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14949 3-[(2,6-Dichlorobenzylidene)amino]-6H-dibenzo[b,d]pyran-6-one generic -metabolite KEGG:C14950 3-[(2,4-Dichlorobenzylidene)amino]-6H-dibenzo[b,d]pyran-6-one generic -metabolite KEGG:C14951 3-[(2-Chlorobenzylidene)amino]-6H-dibenzo[b,d]pyran-6-one generic -metabolite KEGG:C14952 3-Amino-6H-dibenzo[b,d]pyran-6-one generic -metabolite KEGG:C14953 2-(3,4,5-Trimethoxyphenyl)-5,6,7,8-tetramethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14954 17-Methylandrosta-4,6-diene-3beta,17beta-diol 3-acetate generic -metabolite KEGG:C14955 17beta-(Acetylthio)estra-1,3,5(10)-trien-3-ol acetate generic -metabolite KEGG:C14956 3alpha-Hydroxy-2alpha-methyl-5alpha-androstan-17-one generic -metabolite KEGG:C14957 3beta-(Acetyloxy)-5beta-methyl-6beta-chloroestr-9-en-17-one generic -metabolite KEGG:C14958 17a-Aza-D-homoandrost-5-en-3beta-ol generic -metabolite KEGG:C14959 Estra-1,3,5(10),16-tetraen-3-ol benzoate generic -metabolite KEGG:C14960 1alpha,5alpha-Dimercaptoandrostane-3alpha,17beta-diol generic -metabolite KEGG:C14961 3beta-Hydroxy-16beta-(hydroxymethyl)-5alpha-androstan-17-one generic -metabolite KEGG:C14962 17-Hydroxy-5alpha,17alpha-pregn-1-en-3-one generic -metabolite KEGG:C14963 2-[4-(Acetyloxy)phenyl]-5,6,7,8-tetramethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14964 11alpha-Hydroxy-12alpha-methyl-pregn-4-ene-3,20-dione generic -metabolite KEGG:C14965 N-(6-Oxo-6H-dibenzo[b,d]pyran-3-yl)methanesulfonamide generic -metabolite KEGG:C14966 17beta-[Bis(2-hydroxyethyl)amino]androst-5-en-3beta-ol generic -metabolite KEGG:C14967 1-[2-Bromo-1-(4-chlorophenyl)ethenyl]-2-chlorobenzene generic -metabolite KEGG:C14968 3-(2,4-Cyclopentadien-1-ylidene)pregn-4-en-20-one generic -metabolite KEGG:C14969 2,3-Dihydro-6-hydroxy-2-(4-hydroxyphenyl)-5,7-dimethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14970 2alpha-(Hydroxymethyl)-5alpha-androstane-3beta,17beta-diol generic -metabolite KEGG:C14971 N-(6-Oxo-6H-dibenzo[b,d]pyran-3-yl)-2,2,2-trifluoroacetamide generic -metabolite KEGG:C14972 3-Deoxyestrone generic -metabolite KEGG:C14973 17beta-Hydroxy-7alpha-mercaptoandrost-4-en-3-one 7-propionate generic -metabolite KEGG:C14974 3-Methoxy-16-methylestra-1,3,5(10)-triene-16beta,17beta-diol 17-acetate generic -metabolite KEGG:C14975 D-Homo-17a-oxa-5alpha-androstan-3beta-ol generic -metabolite KEGG:C14976 3alpha,21-Dihydroxy-D-homo-5beta-pregn-17a(20)-en-11-one generic -metabolite KEGG:C14977 2alpha-(Hydroxymethyl)-17-methyl-5alpha-androstane-3beta,17beta-diol generic -metabolite KEGG:C14978 17beta-Hydroxy-2alpha-(methoxymethyl)-5alpha-androstan-3-one generic -metabolite KEGG:C14979 3beta-Cyclopentyl-5alpha-androstan-17beta-ol generic -metabolite KEGG:C14980 16beta-Methyl-D-homo-17a-oxa-5alpha-androstane-3,17-dione generic -metabolite KEGG:C14981 3beta-Fluoro-5beta-pregnan-20-one generic -metabolite KEGG:C14982 6beta,17-Dimethyl-5alpha-androstane-3beta,17beta-diol generic -metabolite KEGG:C14983 6beta-Hydroxy-D-homo-17a-oxaandrost-4-ene-3,17-dione generic -metabolite KEGG:C14984 17-Hydroxy-3-oxo-19-nor-5beta,17alpha-pregnane-21-carboxylic acid, gamma-lactone generic -metabolite KEGG:C14985 6-Hydroxy-2-(4-methoxyphenyl)-5,7-dimethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14986 2-(4-Hydroxyphenyl)-5,6,7-trimethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14987 2,3-Dihydroxycyclopentaneundecanoic acid generic -metabolite KEGG:C14988 4-Nitroestra-1,3,5(10)-triene-3,17beta-diol generic -metabolite KEGG:C14990 Cyclic-3,20-bis(1,2-ethanediyl acetal)-11alpha-(acetyloxy)-5alpha,6alpha-epoxypregnane-3,20-dione generic -metabolite KEGG:C14991 3beta,21-Dihydroxy-4,4,14-trimethyl-5alpha-pregn-8-en-20-one generic -metabolite KEGG:C14992 3-(Acetyloxy)-9-mercaptoandrosta-3,5-diene-11,17-dione generic -metabolite KEGG:C14993 Nonylphenol generic -metabolite KEGG:C14994 3-Methoxy-16-octylestra-1,3,5(10)-triene-16beta,17beta-diol generic -metabolite KEGG:C14995 3-Methoxy-16-ethylestra-1,3,5(10)-triene-16beta,17beta-diol generic -metabolite KEGG:C14996 12-(2,3-Dihydroxycyclopentyl)-2-dodecanone generic -metabolite KEGG:C14997 2,3-Dihydro-6-hydroxy-2-(4-methoxyphenyl)-5,7-dimethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C14998 17beta-(1H-Imidazol-4-yl)androst-5-en-3beta-ol generic -metabolite KEGG:C14999 10-Hydroxyestra-1,4-dien-3-one acetate generic -metabolite KEGG:C15000 17beta-(Benzoyloxy)-B-norandrost-4-en-3-one generic -metabolite KEGG:C15001 3beta-(Acetyloxy)-5alpha-androst-16-ene-16-carboxaldehyde generic -metabolite KEGG:C15002 11alpha,15alpha-Dihydroxypregn-4-ene-3,20-dione generic -metabolite KEGG:C15003 17-Hydroxy-19-nor-17alpha-pregn-5(10)-en-3-one generic -metabolite KEGG:C15004 16beta-Chloro-17beta-hydroxyandrost-4-en-3-one generic -metabolite KEGG:C15005 4-Aminoestra-1,3,5(10)-triene-3,17beta-diol generic -metabolite KEGG:C15006 2-Aminoestra-1,3,5(10)-triene-3,17beta-diol generic -metabolite KEGG:C15007 2-Nitroestra-1,3,5(10)-triene-3,17beta-diol generic -metabolite KEGG:C15008 1,2,3,4,4a,9,10,10a-Octahydro-6-hydroxy-7-isopropyl-1,4a-dimethyl-1-phenanthrenemethanol generic -metabolite KEGG:C15009 17beta-Hydroxyandrost-4-ene-3,11-dione propionate generic -metabolite KEGG:C15010 16beta-Chloroandrost-4-ene-3,17-dione generic -metabolite KEGG:C15011 11beta,17beta-Dihydroxy-6alpha,17-dimethylandrost-4-en-3-one generic -metabolite KEGG:C15012 17beta-Hydroxy-2,17-dimethyl-5alpha-androst-1-en-3-one generic -metabolite KEGG:C15013 3beta-(1-Pyrrolidinyl)-5alpha-pregnane-11,20-dione generic -metabolite KEGG:C15014 3-(2-Propenyloxy)estra-1,3,5(10)-triene-16,17-dione 16-oxime generic -metabolite KEGG:C15015 2beta,21-Dihydroxypregn-4-ene-3,20-dione generic -metabolite KEGG:C15016 19-Norpregna-4,17(20)-dien-3-one generic -metabolite KEGG:C15017 17beta-Hydroxy-5alpha-androst-2-ene-2-carboxaldehyde generic -metabolite KEGG:C15018 3-Hydroxy-2-nitroestra-1,3,5(10)-trien-17-one generic -metabolite KEGG:C15019 2,3-Dihydro-2-(4-hydroxyphenyl)-5,6,7-trimethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C15020 17beta-Methylestra-1,3,5(10)-trien-3-ol generic -metabolite KEGG:C15021 4,4'-(Diphenylethenylidene)bis[N,N-dimethylbenzenamine] generic -metabolite KEGG:C15022 11alpha,17beta-Dihydroxy-2alpha,17-dimethylandrost-4-en-3-one generic -metabolite KEGG:C15023 19-Chloro-3beta-hydroxyandrost-5-en-17-one acetate generic -metabolite KEGG:C15024 19-Chloro-17beta-hydroxyandrost-4-en-3-one generic -metabolite KEGG:C15025 (S)-Carnitine generic -metabolite KEGG:C15026 L-365260 generic -metabolite KEGG:C15027 2,2-Dimethyl-3,4-bis(4-methoxyphenyl)-2H-1-benzopyran-7-ol acetate generic -metabolite KEGG:C15028 alpha-Ethyl-alpha,beta-diphenyl-2-pyridineethanol generic -metabolite KEGG:C15029 3,6-Dimethoxy-19-norpregna-1,3,5,7,9-pentaen-20-one generic -metabolite KEGG:C15030 3,6-Dimethoxyestra-1,3,5(10),6,8-pentaene-17beta-carboxylic acid methyl ester generic -metabolite KEGG:C15031 2-(4-Hydroxyphenyl)-5,6,7,8-tetrahydroxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C15032 1-(4-Methoxyphenyl)-3-(4-morpholinyl)-1-propanone generic -metabolite KEGG:C15033 Hydroxystenozole generic -metabolite KEGG:C15034 16alpha-Hydroxycorticosterone generic -metabolite KEGG:C15035 17beta-Hydroxy-2alpha-(hydroxymethyl)-5alpha-androstan-3-one generic -metabolite KEGG:C15036 2alpha-Methyl-5alpha-androstane-3,17-dione generic -metabolite KEGG:C15037 Oplophorus luciferin generic -metabolite KEGG:C15038 Oxidized Oplophorus luciferin generic -metabolite KEGG:C15039 3-(m-Aminophenyl)-2-(p-methoxyphenyl)acrylonitrile generic -metabolite KEGG:C15040 GYKI 52466 generic -metabolite KEGG:C15041 17-Methylandrost-5-ene-3beta,11beta,17beta-triol generic -metabolite KEGG:C15042 4-(2-Pyrazinylethenyl)phenol generic -metabolite KEGG:C15043 2-[2-(4-Pyridinyl)-1-butenyl]phenol generic -metabolite KEGG:C15044 2,3-Dimethoxy-[2-(4-Pyridinyl)-1-butenyl]phenol generic -metabolite KEGG:C15045 4-Chloro-[2-(4-Pyridinyl)-1-butenyl]phenol generic -metabolite KEGG:C15046 Pregna-5,16,20-triene-3beta,20-diol diacetate generic -metabolite KEGG:C15047 11,17-Dimethyl-5alpha-androstane-11beta,17beta-diol generic -metabolite KEGG:C15048 7-(Acetyloxy)-3-(3-pyridinyl)-2H-1-benzopyran-2-one generic -metabolite KEGG:C15049 (2-Butylbenzofuran-3-yl)(4-hydroxyphenyl)ketone generic -metabolite KEGG:C15050 2,2-Dimethyl-3-[4-(acetyloxy)phenyl]-4-ethyl-2H-1-benzopyran-7-ol acetate generic -metabolite KEGG:C15051 7-Hydroxy-3-(4-methoxyphenyl)-4-propyl-2H-1-benzopyran-2-one generic -metabolite KEGG:C15052 7-Hydroxy-3-(4-methoxyphenyl)-4-methylcoumarin generic -metabolite KEGG:C15053 2,2-Dimethyl-3-(4-methoxyphenyl)-4-propyl-2H-1-benzopyran-7-ol acetate generic -metabolite KEGG:C15054 2,2-Dimethyl-3-(4-methoxyphenyl)-4-ethyl-2H-1-benzopyran-7-ol generic -metabolite KEGG:C15055 2,2-Dimethyl-3-(4-methoxyphenyl)-4-ethyl-2H-1-benzopyran-7-ol acetate generic -metabolite KEGG:C15056 2,2,4-Trimethyl-3-(4-fluorophenyl)-2H-1-benzopyran-7-ol acetate generic -metabolite KEGG:C15057 3-Ethoxyandrosta-3,5-dien-17beta-ol propanoate generic -metabolite KEGG:C15058 2alpha-Methyl-5alpha-androstane-3beta,17beta-diol generic -metabolite KEGG:C15059 2,2,4-Trimethyl-3-(4-methoxyphenyl)-2H-1-benzopyran-7-ol acetate generic -metabolite KEGG:C15060 7-Methoxy-2,2,4-trimethyl-3-(4-methoxyphenyl)-2H-1-benzopyran generic -metabolite KEGG:C15061 2,2-Dibutyl-3-(4-methoxyphenyl)-4-methyl-2H-1-benzopyran-7-ol acetate generic -metabolite KEGG:C15062 17beta-Hydroxy-3-methoxyestra-1,3,5(10)-triene-17-carbonitrile generic -metabolite KEGG:C15063 3-Methoxy-D-homoestra-1,3,5(10),8,14-pentaen-17abeta-ol generic -metabolite KEGG:C15064 17beta-(Hydroxymethyl)androst-4-en-3-one acetate generic -metabolite KEGG:C15065 9-Fluoro-11beta-hydroxy-A-norpregn-3(5)-ene-2,20-dione generic -metabolite KEGG:C15066 alpha,alpha'-Diethyl-4,4'-bis(2-propynyloxy)stilbene generic -metabolite KEGG:C15067 4-Chloro-alpha-[4-[2-(diethylamino)ethoxy]phenyl]-alpha-phenylbenzeneethanol generic -metabolite KEGG:C15068 17beta-Hydroxy-4-oxa-5alpha-androst-1-en-3-one acetate generic -metabolite KEGG:C15069 4,4'-(Butane-1,1-diyl)diphenol generic -metabolite KEGG:C15070 17beta-Hydroxy-1,17-dimethylestr-5(10)-en-3-one generic -metabolite KEGG:C15071 6beta-Fluoro-5alpha-hydroxypregnane-3,20-dione generic -metabolite KEGG:C15072 6beta,19-Epoxy-17beta-hydroxyandrost-4-en-3-one generic -metabolite KEGG:C15073 17alpha-Chloroethynylestradiol generic -metabolite KEGG:C15074 16alpha-Fluoro-17alpha-hydroxyandrost-4-en-3-one generic -metabolite KEGG:C15075 3-Fluoro-1-(4-hydroxyphenyl)-1-propanone generic -metabolite KEGG:C15076 3-(4-Methoxyphenyl)-5,6,7-trimethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C15077 1-Phenyl-3-(phenylsulfonyl)-2-propen-1-one generic -metabolite KEGG:C15078 3-Methoxyestra-1,3,5(10)-triene-16,17-dione 16-oxime generic -metabolite KEGG:C15079 9-Fluoro-11beta-hydroxypregna-4,16-diene-3,20-dione generic -metabolite KEGG:C15080 4-Benzyloxy-2'-hydroxy-3',4',5',6'-tetramethoxychalcone generic -metabolite KEGG:C15081 trans-1,3,4,6,7,11b-Hexahydro-9-methoxy-2H-benzo[a]quinolizine-3-carboxylic acid ethyl ester generic -metabolite KEGG:C15082 4-(1-Ethyl-2-phenylbutyl)phenol generic -metabolite KEGG:C15083 1-Chloro-2-[1-(4-chlorophenyl)ethenyl]benzene generic -metabolite KEGG:C15084 2,3-Diphenyl-3-(2-pyridinyl)acrylonitrile generic -metabolite KEGG:C15085 17-Methyl-18-norandrosta-4,13(17)-dien-3-one generic -metabolite KEGG:C15086 3-Allyloxyestra-1,3,5(10),7-tetraene-16,17-dione dioxime generic -metabolite KEGG:C15087 3-Hydroxyestra-1,3,5(10),7-tetraene-16,17-dione 16-oxime generic -metabolite KEGG:C15088 4-Fluoro-17beta-hydroxyandrost-4-en-3-one propionate generic -metabolite KEGG:C15089 1,6-Dihydro-1-(3-methoxyphenethyl)-6-oxonicotinic acid generic -metabolite KEGG:C15090 17-Hydroxy-3-oxo-17alpha-pregna-1,4-diene-21-carboxylic acid, gamma-lactone generic -metabolite KEGG:C15091 9-Fluoro-17beta-hydroxy-6alpha,17-dimethylandrost-4-ene-3,11-dione generic -metabolite KEGG:C15092 9-Fluoro-11beta,17beta-dihydroxy-16alpha-methylandrosta-1,4-dien-3-one generic -metabolite KEGG:C15093 3beta-Fluoroandrost-5-en-17beta-ol generic -metabolite KEGG:C15094 GYKI 52895 generic -metabolite KEGG:C15095 Coumestrol diacetate generic -metabolite KEGG:C15096 GV 150013X generic -metabolite KEGG:C15097 Androst-5-ene-3beta,17beta,19-triol generic -metabolite KEGG:C15098 21-Fluoro-11beta-hydroxypregn-4-ene-3,20-dione generic -metabolite KEGG:C15099 17beta-Hydroxy-2alpha,17-dimethyl-5alpha-androstan-3-one generic -metabolite KEGG:C15100 6-Hydroxy-2-(4-hydroxyphenyl)-5,7-dimethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C15101 17-Methyl-5-alpha-androst-2-en-17-beta-ol generic -metabolite KEGG:C15102 1,2,3,4-Tetrahydro-4-oxo-1-naphthoic acid generic -metabolite KEGG:C15103 11alpha,17beta-Dihydroxy-1,4-androstadien-3-one generic -metabolite KEGG:C15104 LY-202769 generic -metabolite KEGG:C15105 9-Fluoro-16alpha-hydroxyandrost-4-ene-3,11,17-trione generic -metabolite KEGG:C15106 3-Oxopregn-4-ene-20beta-carboxaldehyde dioxime generic -metabolite KEGG:C15107 3-Methoxyestra-1,3,5(10),16-tetraene generic -metabolite KEGG:C15108 17beta-Hydroxy-6alpha,17-dimethylandrost-4-en-3-one generic -metabolite KEGG:C15109 Gardenin B generic -metabolite KEGG:C15110 1-[6-Hydroxy-2-(4-hydroxyphenyl)-1-benzofuran-3-yl]ethanone generic -metabolite KEGG:C15111 1-[2-(4-Hydroxyphenyl)-1-benzofuran-3-yl]ethanone generic -metabolite KEGG:C15112 4,4-Difluoro-17beta-hydroxyandrost-5-en-3-one propionate generic -metabolite KEGG:C15113 9-Fluoro-11beta,17beta-dihydroxy-2,17-dimethylandrost-4-en-3-one generic -metabolite KEGG:C15114 3-Methoxy-5,10-seco-5,19-cycloandrosta-1(10),2,4-trien-17-one generic -metabolite KEGG:C15115 11beta-Hydroxy-6alpha,11-dimethylpregn-4-ene-3,20-dione generic -metabolite KEGG:C15116 2alpha-Methylpregn-4-ene-3,20-dione generic -metabolite KEGG:C15117 3-Methyl-19-nor-17alpha-pregna-1,3,5(10)-trien-17-ol generic -metabolite KEGG:C15118 2,3-Dihydro-2-(4-methoxyphenyl)-5,6,7-trimethoxy-4H-1-benzopyran-4-one generic -metabolite KEGG:C15119 B-Norcholest-4-en-3-one generic -metabolite KEGG:C15120 alpha-(p-Methoxyphenyl)-4-pyridineacrylic acid generic -metabolite KEGG:C15121 alpha-(p-Methoxyphenyl)-2-pyridineacrylonitrile generic -metabolite KEGG:C15122 alpha-(p-Methoxyphenyl)-6-methyl-2-pyridineacrylic acid generic -metabolite KEGG:C15123 1,1-Dichloro-2,2-diphenylethane generic -metabolite KEGG:C15124 3-Methoxy-D-homoestra-1,3,5(10),8-tetraen-17a-one generic -metabolite KEGG:C15125 N-(Cyclohexylmethyl)-N-methylbenzenamine generic -metabolite KEGG:C15126 2,17beta-Dihydroxy-17-methylandrosta-1,4-dien-3-one generic -metabolite KEGG:C15127 6alpha-Fluoropregn-4-ene-3,20-dione generic -metabolite KEGG:C15128 1'H-5alpha-Androst-2-eno[3,2-b]indol-17beta-ol generic -metabolite KEGG:C15129 Estra-1,3,5(10)-triene-2,17beta-diol generic -metabolite KEGG:C15130 6beta,19-Epoxypregn-4-ene-3,20-dione generic -metabolite KEGG:C15131 2,5-Dimethoxystilbene generic -metabolite KEGG:C15132 11alpha,12alpha-Epoxy-5beta-pregnane-3,20-dione generic -metabolite KEGG:C15133 4-Methyl-4-aza-5-pregnene-3,20-dione generic -metabolite KEGG:C15134 3-(1,2,3,4-Tetrahydro-6-hydroxy-2-naphthyl)cyclopentanone generic -metabolite KEGG:C15135 3beta-Hydroxy-17-oxoandrost-5-en-19-al acetate generic -metabolite KEGG:C15136 3beta-Hydroxy-D-homo-17a-oxa-5alpha-androstan-17-one generic -metabolite KEGG:C15137 17beta-Hydroxy-2alpha-(hydroxymethyl)-17-methyl-5alpha-androstan-3-one generic -metabolite KEGG:C15138 17beta-Methoxyandrost-5-ene-3beta,16beta-diol generic -metabolite KEGG:C15139 D-Homo-17a-oxa-5alpha-androstan-3beta-ol acetate generic -metabolite KEGG:C15140 3,3-Difluoro-17-methyl-5alpha-androstan-17beta-ol generic -metabolite KEGG:C15141 N-(Phenylmethyl)-N-methyl-2-pyridinamine generic -metabolite KEGG:C15142 3-Methoxy-D-homoestra-1,3,5(10),8-tetraen-17abeta-ol generic -metabolite KEGG:C15143 (2-Butylbenzofuran-3-yl)(4-hydroxy-3,5-diiodophenyl)ketone generic -metabolite KEGG:C15144 16beta,17beta-Dihydroxy-16-methylestr-4-en-3-one generic -metabolite KEGG:C15145 4,4-Bis[4-(acetyloxy)phenyl]3-hexanone generic -metabolite KEGG:C15146 Pregna-4,16-diene-3,11,20-trione generic -metabolite KEGG:C15147 9-Fluoro-11beta-hydroxy-16alpha-methylandrosta-1,4-diene-3,17-dione generic -metabolite KEGG:C15148 9-Fluoro-16alpha-methylpregn-4-ene-3,11,20-trione generic -metabolite KEGG:C15149 17beta-Acetamidoandrost-4-en-3-one generic -metabolite KEGG:C15150 14-Hydroxyandrosta-1,4-diene-3,17-dione generic -metabolite KEGG:C15151 17beta-Hydroxy-4-oxa-5alpha-estr-1-en-3-one acetate generic -metabolite KEGG:C15152 4,4-Difluoropregn-5-ene-3,20-dione generic -metabolite KEGG:C15153 (-)-Methallenestrilphenol generic -metabolite KEGG:C15154 4beta,5beta-Epoxypregnane-3,20-dione generic -metabolite KEGG:C15155 9-Bromo-11beta-hydroxy-16alpha-methylpregn-4-ene-3,20-dione generic -metabolite KEGG:C15156 3-Acetyl-5alpha-androst-2-en-17beta-ol generic -metabolite KEGG:C15157 3-Acetyl-5alpha-androstane-3beta,17beta-diol 3-acetate generic -metabolite KEGG:C15158 3alpha-Ethynyl-3-hydroxy-5alpha-androstan-17-one generic -metabolite KEGG:C15159 3beta,13-Dihydroxy-16-(hydroxymethylene)-13,17-seco-5alpha-androstan-17-oic acid, delta-lactone generic -metabolite KEGG:C15160 2,2-Dimethyl-3-(4-methoxyphenyl)-4-ethyl-6-(1-pyrrolidinylmethyl)-2H-1-benzopyran-7-ol generic -metabolite KEGG:C15161 2,2-Dimethyl-3-(4-methoxyphenyl)-4-ethyl-7-hydroxy-2H-1-benzopyran-8-methanol diacetate generic -metabolite KEGG:C15162 2,2-Dimethyl-3-(4-methoxyphenyl)-4-ethyl-8-(1-pyrrolidinylmethyl)-2H-1-benzopyran-7-ol generic -metabolite KEGG:C15163 17-[(Benzylamino)methyl]estra-1,3,5(10)-triene-3,17beta-diol generic -metabolite KEGG:C15164 12alpha-Fluoro-11beta,17beta-dihydroxyandrost-4-en-3-one generic -metabolite KEGG:C15165 12alpha-Fluoro-11beta,17beta-dihydroxyandrosta-1,4-dien-3-one generic -metabolite KEGG:C15166 5alpha-Androstane-2alpha-fluoro-17beta-ol-3-one acetate generic -metabolite KEGG:C15167 3-Methoxy-19-norpregna-1,3,5(10)-trien-20-one generic -metabolite KEGG:C15168 4,4'-(2-Ethyl-1-butenylidene)diphenol generic -metabolite KEGG:C15169 16alpha-Fluoroandrost-4-ene-3,17-dione generic -metabolite KEGG:C15170 17-Methyl-18,19-dinor-17alpha-pregna-4,13-dien-3-one generic -metabolite KEGG:C15171 17beta-Hydroxyestr-4-en-3-one benzoate generic -metabolite KEGG:C15172 6alpha-Fluoro-11beta,17-dihydroxypregn-4-ene-3,20-dione generic -metabolite KEGG:C15173 3beta-Hydroxy-16-phosphonopregn-5-en-20-one monoethyl ester generic -metabolite KEGG:C15174 Estra-1,3,5-(10)-trien-17-one-3-oxyacetic acid generic -metabolite KEGG:C15175 17beta-Hydroxy-4,17-dimethyl-4-azaandrost-5-en-3-one generic -metabolite KEGG:C15176 17-Methyl-5alpha-androst-2-ene-1alpha,17beta-diol generic -metabolite KEGG:C15177 17-Methylandrosta-2,4-dieno[2,3-d]isoxazol-17beta-ol generic -metabolite KEGG:C15178 5-Nitro-2-furancarboxaldehyde (2-hydroxyethyl)hydrazone generic -metabolite KEGG:C15179 1,1-Diphenyl-2-(4-methoxyphenyl)propene generic -metabolite KEGG:C15180 17beta-Hydroxy-4-mercaptoandrost-4-en-3-one 4-acetate 17-propionate generic -metabolite KEGG:C15181 Wortmannin generic -metabolite KEGG:C15182 Temsirolimus generic -metabolite KEGG:C15183 AP 23573 generic -metabolite KEGG:C15184 17beta-Hydroxy-6alpha-methylandrost-4-en-3-one generic -metabolite KEGG:C15185 21-Acetyloxy-17-hydroxypregna-1,4-diene-3,20-dione generic -metabolite KEGG:C15186 5alpha,17alpha-Pregn-2-en-20-yn-17-ol acetate generic -metabolite KEGG:C15187 11beta,12beta-Epoxypregn-4-ene-3,20-dione generic -metabolite KEGG:C15188 19-Nor-5alpha-pregnane-3,20-dione generic -metabolite KEGG:C15189 3-(4-Chlorophenyl)-2H-1-benzopyran-2-one generic -metabolite KEGG:C15190 12alpha-Methylpregna-4,9(11)-diene-3,20-dione generic -metabolite KEGG:C15191 (2-Isopropyl-1-benzofuran-3-yl)(4-hydroxyphenyl)methanone generic -metabolite KEGG:C15192 9beta,11beta-Epoxy-17beta-hydroxy-17-methylandrost-4-en-3-one generic -metabolite KEGG:C15193 2-[3-Ethyl-5-(4-methoxyphenyl)-1H-pyrazol-4-yl]phenol generic -metabolite KEGG:C15194 Androsta-4,9(11)-diene-3,17-dione generic -metabolite KEGG:C15195 LY 294002 generic -metabolite KEGG:C15196 3,4-Dihydro-8,9-dihydroxy-1(2H)-anthracenone generic -metabolite KEGG:C15197 17beta-Pyrazol-3-ylandrost-5-en-3beta-ol generic -metabolite KEGG:C15198 3-Ethyl-5alpha-androstane-3alpha,17beta-diol generic -metabolite KEGG:C15199 3-Ethynyl-5alpha-androstane-3beta,17beta-diol generic -metabolite KEGG:C15200 9beta,11beta-Epoxyandrost-4-ene-3,17-dione generic -metabolite KEGG:C15201 5beta-Estrane-3alpha,17beta-diol generic -metabolite KEGG:C15202 2'-Chloro-4-biphenylol generic -metabolite KEGG:C15203 6-Hydroxy-2'-methoxyflavone generic -metabolite KEGG:C15204 3'-Hydroxyflavanone generic -metabolite KEGG:C15205 Diisobutyl phthalate generic -metabolite KEGG:C15206 3,3-Bis(4-hydroxyphenyl)pentane generic -metabolite KEGG:C15207 17beta-Estradiol-3-(beta-D-glucuronide) 17-sulfate generic -metabolite KEGG:C15208 Bisphenol A bis(2-hydroxypropyl) ether generic -metabolite KEGG:C15209 Bisphenol A ethoxylate diacrylate generic -metabolite KEGG:C15210 1,1-Bis(4-hydroxyphenyl)propane generic -metabolite KEGG:C15211 4,4-Bis(4-hydroxyphenyl)heptane generic -metabolite KEGG:C15212 2,2',5-Trichloro-4-hydroxybiphenyl generic -metabolite KEGG:C15213 2,2',3',4,4',5,5'-Heptachloro-3-biphenylol generic -metabolite KEGG:C15214 alpha-Hexachlorocyclohexane generic -metabolite KEGG:C15215 3-Hydroxyestra-1,3,5(10)-trien-16-one generic -metabolite KEGG:C15216 3-Methoxyestriol generic -metabolite KEGG:C15217 4-[1-Ethyl-2-(4-methylphenyl)butyl]phenol generic -metabolite KEGG:C15218 2,2',4,4'-Tetrahydroxybenzil generic -metabolite KEGG:C15219 2,6-Dimethylhexestrol generic -metabolite KEGG:C15220 2-Chloro-4-methylphenol generic -metabolite KEGG:C15221 Diisononyl phthalate generic -metabolite KEGG:C15222 3,6,4'-Trihydroxyflavone generic -metabolite KEGG:C15224 Tributyltin chloride generic -metabolite KEGG:C15225 Manzeb generic -metabolite KEGG:C15226 Thallium chloride generic -metabolite KEGG:C15227 Potassium dichromate generic -metabolite KEGG:C15228 beta-Estradiol 17-acetate generic -metabolite KEGG:C15229 Ziram generic -metabolite KEGG:C15230 Iprobenfos generic -metabolite KEGG:C15231 Maneb generic -metabolite KEGG:C15232 Zineb generic -metabolite KEGG:C15233 Cadmium chloride generic -metabolite KEGG:C15234 Lead nitrate generic -metabolite KEGG:C15235 Antimony trichloride generic -metabolite KEGG:C15236 8-Hydroxy-2,3,4-trichlorodibenzofuran generic -metabolite KEGG:C15237 8-Hydroxy-2-chlorodibenzofuran generic -metabolite KEGG:C15238 8-Hydroxy-3,4,6-trichlorodibenzofuran generic -metabolite KEGG:C15239 8-Hydroxy-3,4-dichlorodibenzofuran generic -metabolite KEGG:C15240 6-Hydroxy-3,4-dichlorodibenzofuran generic -metabolite KEGG:C15241 8-Hydroxy-3-chlorodibenzofuran generic -metabolite KEGG:C15242 8-Chloro-2,7-dibenzofurandiol generic -metabolite KEGG:C15243 3-Hydroxy-2,8-dichlorodibenzofuran generic -metabolite KEGG:C15244 7-Hydroxy-1,2,3,6,8-pentachlorodibenzofuran generic -metabolite KEGG:C15245 7-Hydroxy-3,4-dichlorodibenzofuran generic -metabolite KEGG:C15246 9-Hydroxy-3,4-dichlorodibenzofuran generic -metabolite KEGG:C15247 9-Hydroxy-2,6-dichlorodibenzofuran generic -metabolite KEGG:C15248 4-Hydroxy-2',3,5,5'-tetrachlorobiphenyl generic -metabolite KEGG:C15249 2-(3,5-Dichlorophenylcarbamoyl)-1,2-dimethylcyclopropane-1-carboxylic acid generic -metabolite KEGG:C15250 3-(3,4-Dichlorophenyl)-1-hydroxy-1-methylurea generic -metabolite KEGG:C15251 3-Aza-A-homocholest-4a-en-4-one generic -metabolite KEGG:C15252 17beta-Hydroxy-4alpha-methyl-5alpha-androstan-3-one generic -metabolite KEGG:C15253 16beta-Fluoro-17beta-hydroxyandrost-4-en-3-one propionate generic -metabolite KEGG:C15254 3-(Allyloxy)estra-1,3,5(10)-triene-16alpha,17beta-diol generic -metabolite KEGG:C15255 1-Methylestra-1,3,5(10),6-tetraene-3,17beta-diol generic -metabolite KEGG:C15256 6alpha-Fluoro-17-hydroxycorticosterone 21-acetate generic -metabolite KEGG:C15257 17beta-Hydroxyestr-5(10)-en-3-one generic -metabolite KEGG:C15258 17beta-Hydroxy-2alpha-methylestr-4-en-3-one generic -metabolite KEGG:C15259 17beta-Hydroxy-2alpha,17-dimethylestr-4-en-3-one generic -metabolite KEGG:C15260 5beta-Pregn-11-ene-3,20-dione generic -metabolite KEGG:C15261 Estra-1,3,5(10)-triene-3,16beta-diol generic -metabolite KEGG:C15262 3-Methoxyestra-1,3,5(10)-trien-16beta-ol generic -metabolite KEGG:C15263 A-Norpregn-3(5)-ene-2,20-dione generic -metabolite KEGG:C15264 17beta-Hydroxy-5alpha-androstane acetate generic -metabolite KEGG:C15265 16beta-Methylpregn-4-ene-3,20-dione generic -metabolite KEGG:C15266 17abeta-Hydroxy-D-homoandrost-4-en-3-one propionate generic -metabolite KEGG:C15267 (17Z)-3,11-Dioxopregna-4,17(20)-dien-21-oic acid methyl ester generic -metabolite KEGG:C15268 trans-2-(4-Nitrophenyl)-3-phenyloxirane generic -metabolite KEGG:C15269 9-Fluoro-11beta,17,21-trihydroxy-2alpha-methylpregn-4-ene-3,20-dione 21-acetate generic -metabolite KEGG:C15270 Cycloguanil hydrochloride generic -metabolite KEGG:C15271 9-Fluoro-2alpha-methylpregn-4-ene-3,11,20-trione generic -metabolite KEGG:C15272 3alpha,12alpha-Dihydroxy-5beta-pregnan-20-one diacetate generic -metabolite KEGG:C15273 17beta-Hydroxy-5alpha-androst-1-en-3-one propionate generic -metabolite KEGG:C15274 Allobetulin generic -metabolite KEGG:C15275 21-Acetoxy-11beta,17-dihydroxy-6alpha-methylpregn-4-ene-3,20-dione generic -metabolite KEGG:C15276 2alpha-Fluoro-17beta-hydroxyandrost-4-en-3-one generic -metabolite KEGG:C15277 3-Hydroxy-19-norpregna-1,3,5(10)-trien-20-one generic -metabolite KEGG:C15278 4,4'-(2-Methylpropylidene)bisphenol generic -metabolite KEGG:C15279 2-Amino-6-(benzylthio)purine generic -metabolite KEGG:C15280 16alpha,17-Isopropylidenedioxy-6alpha-methylprogesterone generic -metabolite KEGG:C15281 17beta-Nitro-5alpha-androstane generic -metabolite KEGG:C15282 17beta-Hydroxyestr-5(10)-en-3-one acetate generic -metabolite KEGG:C15283 17beta-Hydroxy-5alpha-androstan-3-one cyclohexanecarboxylate generic -metabolite KEGG:C15284 6beta,17beta-Dihydroxyandrost-4-en-3-one diacetate generic -metabolite KEGG:C15285 17alpha-Methyl-5alpha-androstane-3beta,11beta,17beta-triol generic -metabolite KEGG:C15286 4beta,5-Epoxy-17beta-hydroxy-5beta-androstan-3-one generic -metabolite KEGG:C15287 11beta,17beta-Dihydroxy-17alpha-methylandrosta-1,4-dien-3-one generic -metabolite KEGG:C15288 5alpha-Androstane-11beta,17beta-diol generic -metabolite KEGG:C15289 16alpha,17beta-Dihydroxyandrost-4-en-3-one dipropionate generic -metabolite KEGG:C15290 2alpha,17beta-Dihydroxyandrost-4-en-3-one dipropionate generic -metabolite KEGG:C15291 6alpha-Hydroxycortisol generic -metabolite KEGG:C15292 A-Nor-5alpha-cholestan-2-one generic -metabolite KEGG:C15293 17beta-Hydroxyandrosta-4,9(11)-dien-3-one generic -metabolite KEGG:C15294 N-Methylindolo[3,2-b]-5alpha-cholest-2-ene generic -metabolite KEGG:C15295 17beta-Hydroxy-3-methoxyestra-1,3,5(10)-trien-16-one generic -metabolite KEGG:C15296 4,4'-Dinitrostilbene generic -metabolite KEGG:C15297 2,4-Dinitro-1-(3-nitrophenoxy)benzene generic -metabolite KEGG:C15298 5alpha-Androstan-2-en-17beta-ol generic -metabolite KEGG:C15299 7alpha-Methyl-4-pregnene-3,20-dione generic -metabolite KEGG:C15300 Spiro[benzofuran-2(3H),1'-[2]cyclohexene]-7-chloro-4,6-dimethoxy-6'-methyl-2'-(methylthio)-3,4'-dione generic -metabolite KEGG:C15301 2alpha-Methylpregn-4-ene-3,11,20-trione generic -metabolite KEGG:C15302 11beta,17,21-Trihydroxy-2alpha-methylpregn-4-ene-3,20-dione 21-acetate generic -metabolite KEGG:C15303 (Z)-11beta,21-Dihydroxypregna-1,4,17(20)-trien-3-one generic -metabolite KEGG:C15304 3beta,19-Dihydroxyandrost-5-en-17-one 3-acetate generic -metabolite KEGG:C15305 9-Chloro-11beta,17,21-trihydroxypregn-4-ene-3,20-dione 21-acetate generic -metabolite KEGG:C15306 11alpha,17beta-Dihydroxyandrost-4-en-3-one generic -metabolite KEGG:C15307 17beta-Hydroxy-7alpha-methylandrost-1,4-diene-3-one generic -metabolite KEGG:C15308 3-Hydroxy-1-methylestra-1,3,5(10),6-tetraen-17-one generic -metabolite KEGG:C15309 17,21-Epoxy-9-fluoro-11beta-hydroxypregn-4-ene-3,20-dione generic -metabolite KEGG:C15310 6alpha-Fluoro-17-hydroxypregn-4-ene-3,20-dione acetate generic -metabolite KEGG:C15311 N,N-Bis(2-chloroethyl)-DL-alanine hydrochloride generic -metabolite KEGG:C15312 9alpha-Fluoro-11beta-hydroxy-4-pregnene-3,20-dione generic -metabolite KEGG:C15313 3,17beta-Diacetoxyestra-1,3,5(10)-trien-6-one generic -metabolite KEGG:C15314 11beta,17beta-Dihydroxyandrost-4-en-3-one 17-propionate generic -metabolite KEGG:C15315 1-Methylestra-1,3,5(10)-triene-3,17beta-diol generic -metabolite KEGG:C15316 5alpha-Androstane-2alpha-methyl-17beta-ol generic -metabolite KEGG:C15317 9-Fluoro-11beta-hydroxy-16alpha-methylpregn-4-ene-3,20-dione generic -metabolite KEGG:C15318 17abeta-Hydroxy-D-homoandrost-4-en-3-one generic -metabolite KEGG:C15319 9alpha-Fluoro-11beta,17alpha,21-trihydroxy-6alpha-methylpregna-1,4-diene-3,20-dione generic -metabolite KEGG:C15320 21-Fluoro-11beta,17-dihydroxy-6alpha-methylpregn-4-ene-3,20-dione generic -metabolite KEGG:C15321 6alpha-Fluoro-17beta-hydroxyandrost-4-en-3-one propionate generic -metabolite KEGG:C15322 2alpha,3alpha-(Difluoromethylene)-5alpha-androstan-17beta-ol acetate generic -metabolite KEGG:C15323 3-Hydroxy-1-methylestra-1,3,5(10)-trien-17-one generic -metabolite KEGG:C15324 Androst-4-ene-3beta,17beta-diol diacetate generic -metabolite KEGG:C15325 6-Azaequilenin generic -metabolite KEGG:C15326 17beta-Hydroxy-2alpha-methyl-5alpha-estran-3-one generic -metabolite KEGG:C15327 6alpha-Fluoropregn-4-ene-3,11,20-trione generic -metabolite KEGG:C15328 N,N-Diethyl-2-[4-[6-methoxy-2-(4-methoxyphenyl)-1H-inden-3-yl]phenoxy]ethanamine hydrochloride generic -metabolite KEGG:C15329 21-Fluoro-11beta,17-dihydroxy-6alpha-methylpregna-1,4-diene-3,20-dione generic -metabolite KEGG:C15330 3beta-Fluoro-5alpha-androstan-17beta-ol generic -metabolite KEGG:C15331 17beta-Hydroxy-6beta-methyl-5alpha-androstan-3-one propionate generic -metabolite KEGG:C15332 3beta-Hydroxy-5alpha-androstane-7,17-dione generic -metabolite KEGG:C15333 3alpha-Hydroxy-5beta-pregn-16-ene-11,20-dione 3-acetate generic -metabolite KEGG:C15334 17beta-Hydroxy-4,4-dimethylandrost-5-en-3-one generic -metabolite KEGG:C15335 3beta-Hydroxy-5-androsten-16-one generic -metabolite KEGG:C15336 3beta,4-Dimethyl-4-aza-5alpha-cholestane generic -metabolite KEGG:C15337 Allocholesterol generic -metabolite KEGG:C15338 11beta,17beta-Dihydroxy-9alpha-fluoro-17alpha-methyl-5alpha-androstan-3-one generic -metabolite KEGG:C15339 17alpha,2alpha-Dimethyl-17beta-hydroxy-4-androsten-3-one generic -metabolite KEGG:C15340 20,21,21-Trifluoro-3-methoxy-19-nor-17alpha-pregna-1,3,5(10),20-tetraen-17-ol generic -metabolite KEGG:C15341 Fluorofelbamate generic -metabolite KEGG:C15342 17beta-Hydroxy-2alpha,17-dimethyl-4,9(11)-androstadien-3-one generic -metabolite KEGG:C15343 HR1917 generic -metabolite KEGG:C15344 N-Butyl-1H-pyrazolo[3,4-d]pyrimidin-4-amine generic -metabolite KEGG:C15345 3beta-[(Tetrahydro-2H-pyran-2-yl)oxy]androst-5-en-17beta-ol generic -metabolite KEGG:C15346 5alpha-Androstane-3beta,17beta-diol diacetate generic -metabolite KEGG:C15347 6-(Isopropylthio)purine generic -metabolite KEGG:C15348 6-(Allylthio)purine generic -metabolite KEGG:C15349 11beta,17beta-Dihydroxy-17-methyl-5alpha-androstan-3-one generic -metabolite KEGG:C15350 Estra-1,3,5(10)-triene-3,16alpha-diol dipropionate generic -metabolite KEGG:C15351 7alpha-Hydroxytestololactone generic -metabolite KEGG:C15352 6-(Dibromomethylene)-17beta-hydroxyandrost-4-en-3-one generic -metabolite KEGG:C15353 17alpha-Methyl-17beta-hydroxyandrosta-4,6-dien-3-one generic -metabolite KEGG:C15354 17beta-Hydroxy-17-methyl-5alpha-androstane-3,11-dione generic -metabolite KEGG:C15355 11alpha-Hydroxy-5beta-pregnane-3,20-dione generic -metabolite KEGG:C15356 17beta-Amino-5alpha-androstan-11beta-ol generic -metabolite KEGG:C15357 Cholesta-3,5-dien-7-one generic -metabolite KEGG:C15358 4-Chloro-17alpha-methyl-17beta-hydroxy-4-androsten-3-one generic -metabolite KEGG:C15359 6-(Dibromomethylene)-17beta-hydroxy-androst-4-en-3-one propionate generic -metabolite KEGG:C15360 Evadol hydrochloride generic -metabolite KEGG:C15361 Descinolone generic -metabolite KEGG:C15362 4-Nitroestrone generic -metabolite KEGG:C15363 6beta,11alpha-Dihydroxyprogesterone generic -metabolite KEGG:C15364 15alpha-Hydroxyprogesterone generic -metabolite KEGG:C15365 4-Pregnene-16alpha,21-diol-3,20-dione generic -metabolite KEGG:C15366 Estrone 16-oxime generic -metabolite KEGG:C15367 3beta-Methoxyandrost-5-en-16beta-ol generic -metabolite KEGG:C15368 5beta-Pregnane-3alpha,17alpha,20alpha-triol-11-one generic -metabolite KEGG:C15369 9alpha-Fluoro-11beta-hydroxy-2alpha-methyl-4-pregnene-3,20-dione generic -metabolite KEGG:C15370 Androsta-5,16-dieno[17,16-b]quinolin-3beta-ol generic -metabolite KEGG:C15371 9-Bromo-17beta-hydroxy-17-methylandrost-4-ene-3,11-dione generic -metabolite KEGG:C15372 11alpha,17beta-Dihydroxyandrost-4-en-3-one diacetate generic -metabolite KEGG:C15373 5alpha-Androstan-17beta-ol propionate generic -metabolite KEGG:C15374 17beta-Hydroxy-7alpha-methylandrost-4-en-3-one propionate generic -metabolite KEGG:C15375 Apocholic acid generic -metabolite KEGG:C15376 17alpha-Methyl-5alpha-androstane-3alpha,17beta-diol generic -metabolite KEGG:C15377 17beta-Hydroxy-5alpha-androst-1-en-3-one generic -metabolite KEGG:C15378 B-Norcholesterol generic -metabolite KEGG:C15379 3beta-Hydroxylanostane-7,11-dione acetate generic -metabolite KEGG:C15380 9-Fluoro-11beta,16alpha-dihydroxypregn-4-ene-3,20-dione generic -metabolite KEGG:C15381 6alpha,9-Difluoro-11beta-hydroxypregn-4-ene-3,20-dione generic -metabolite KEGG:C15382 Estra-1,3,5(10)-triene-3,6alpha,17beta-triol triacetate generic -metabolite KEGG:C15383 (5-Phenyl-1,2,4-triazol-3-yl)urea generic -metabolite KEGG:C15384 12alpha-Hydroxy-5beta-pregnane-3,20-dione generic -metabolite KEGG:C15385 D-Homo-A-nor-17a-oxaandrost-3(5)-ene-2,17-dione generic -metabolite KEGG:C15386 D-Homo-17a-oxaandrosta-4,6-diene-3,17-dione generic -metabolite KEGG:C15387 1-Dehydro-9-fluoro-11-oxotestololactone generic -metabolite KEGG:C15388 3-Methoxy-19-nor-17alpha-pregna-1,3,5(10),20-tetraen-17-ol generic -metabolite KEGG:C15389 4,4'-Stilbenedicarboxamidine dihydrochloride generic -metabolite KEGG:C15390 1alpha,5alpha-Epidithio-17a-oxa-D-homoandrostan-3,17-dione generic -metabolite KEGG:C15391 3alpha,12alpha-Dihydroxy-5beta-pregnan-20-one generic -metabolite KEGG:C15392 1-Chloro-4-(2,2-dichloro-1-phenylethyl)benzene generic -metabolite KEGG:C15393 2-Chlorobenzhydrol generic -metabolite KEGG:C15394 2,2,2-Trifluoro-N-(6-oxo-6H-dibenzo[b,d]pyran-2-yl)acetamide generic -metabolite KEGG:C15395 17beta-Hydroxy-4-methylestr-4-en-3-one generic -metabolite KEGG:C15396 3beta-Chloro-5-androsten-17beta-ol generic -metabolite KEGG:C15397 6-(2-Chloroallylthio)purine generic -metabolite KEGG:C15398 10,13-Dimethyl-11-docosyne-10,13-diol generic -metabolite KEGG:C15399 17-Methyl-5alpha-androstane-11beta,17beta-diol generic -metabolite KEGG:C15400 9-Chloro-11beta,17beta-dihydroxy-17-methylandrost-4-en-3-one generic -metabolite KEGG:C15401 11beta,17beta-Dihydroxy-4,17-dimethylandrost-4-en-3-one generic -metabolite KEGG:C15402 17beta-Hydroxy-7alpha,17-dimethylandrosta-1,4-dien-3-one generic -metabolite KEGG:C15403 3alpha,11beta,17alpha-Trihydroxy-5beta-pregnan-20-one generic -metabolite KEGG:C15404 3beta,17-Dihydroxy-5alpha-pregnane-11,20-dione 3-acetate generic -metabolite KEGG:C15405 17beta-Carbomethoxyandrost-5-en-3beta-ol generic -metabolite KEGG:C15406 5alpha-Androst-1-ene-3,11,17-trione generic -metabolite KEGG:C15407 9-Chloro-17beta-hydroxy-17-methylandrost-4-ene-3,11-dione generic -metabolite KEGG:C15408 2alpha-Fluoro-17beta-hydroxyandrost-4-en-3-one propionate generic -metabolite KEGG:C15409 17beta-Hydroxy-A-norandrost-3(5)-en-2-one propionate generic -metabolite KEGG:C15410 1-(o-Chlorophenyl)-1-(p-chlorophenyl)ethane generic -metabolite KEGG:C15411 beta-Chloro-alpha-phenylbenzeneethanamine hydrochloride generic -metabolite KEGG:C15412 17beta-Hydroxy-4-methylandrost-4-en-3-one generic -metabolite KEGG:C15413 17beta-Hydroxy-4,4,17-trimethylandrost-5-en-3-one generic -metabolite KEGG:C15414 6alpha-Fluoro-17beta-hydroxyandrost-4-en-3-one acetate generic -metabolite KEGG:C15415 1-Phenyl-5-mercaptotetrazole generic -metabolite KEGG:C15416 17beta-Hydroxy-5alpha-androstan-3,6-dione generic -metabolite KEGG:C15417 3beta-Hydroxy-5alpha-pregnan-20-one acetate generic -metabolite KEGG:C15418 5-(alpha-Phenylethyl)semioxamazide generic -metabolite KEGG:C15419 trans-2-Phenylcyclopropanecarboxylic acid generic -metabolite KEGG:C15420 5alpha-Pregn-2-en-20-one generic -metabolite KEGG:C15421 2-Methyl-5alpha-androst-2-en-17beta-ol acetate generic -metabolite KEGG:C15422 2alpha-Methyl-17beta-[(tetrahydro-2H-pyran-2-yl)oxy]-5alpha-androstan-3-one generic -metabolite KEGG:C15423 Androst-4-ene-3alpha,17beta-diol diacetate generic -metabolite KEGG:C15424 Estra-1,3,5(10)-triene-3,17beta-diol 3-phosphate generic -metabolite KEGG:C15425 21-Hydroxypregn-4-ene-3,20-dione hydrogen succinate generic -metabolite KEGG:C15426 2,5-Bis[(iodomercuri)methyl]-p-dioxane generic -metabolite KEGG:C15427 2-Amino-1,2-bis(p-chlorophenyl)ethanol generic -metabolite KEGG:C15428 Asiaticoside generic -metabolite KEGG:C15429 17,21-Dihydroxypregn-4-ene-3,11,20-trione 21-(hydrogensuccinate) generic -metabolite KEGG:C15430 3-Hydroxyestra-1,3,5(10)-trien-17-one O-(carboxymethyl)oxime generic -metabolite KEGG:C15431 17-Ethynyl-5alpha-androstan-17beta-ol generic -metabolite KEGG:C15432 Flurogestone acetate generic -metabolite KEGG:C15433 1-(6-Oxo-6H-dibenzo[b,d]pyran-3-yl)-1H-pyrrole-2,5-dione generic -metabolite KEGG:C15434 11beta,17beta-Dihydroxy-12alpha-methylandrost-4-en-3-one generic -metabolite KEGG:C15435 Fenbutatin oxide generic -metabolite KEGG:C15436 Didecyldimethylammonium chloride generic -metabolite KEGG:C15437 1,3,5-Triphenylcyclohexane generic -metabolite KEGG:C15438 Bis(2-butoxyethyl)phthalate generic -metabolite KEGG:C15439 2-Methacryloyloxyethyl phenyl phosphate generic -metabolite KEGG:C15440 Estra-1,3,5(10)-triene-3,6beta,17beta-triol triacetate generic -metabolite KEGG:C15441 Cholesteryl linoleate generic -metabolite KEGG:C15442 5-Androstene-3beta,16beta-diol generic -metabolite KEGG:C15443 3-(Allyloxy)estra-1,3,5(10)-triene-16beta,17beta-diol generic -metabolite KEGG:C15444 11beta,17beta-Dihydroxy-9alpha-fluoro-17alpha-methyl-5beta-androstan-3-one generic -metabolite KEGG:C15445 1'H-5alpha-Cholest-2-eno[3,2-b]indole generic -metabolite KEGG:C15446 6beta-Fluoro-17beta-hydroxyandrost-4-en-3-one propionate generic -metabolite KEGG:C15447 16alpha-Fluoro-17beta-hydroxyandrost-4-en-3-one propionate generic -metabolite KEGG:C15448 Urethane dimethacrylate generic -metabolite KEGG:C15449 trans-1,2-Diphenylcyclobutane generic -metabolite KEGG:C15450 S 1033 generic -metabolite KEGG:C15451 Hinokitiol glucoside generic -metabolite KEGG:C15452 4,4'-Diaminostilbene dihydrochloride generic -metabolite KEGG:C15453 Doisynoestrol generic -metabolite KEGG:C15454 Hexestrol monomethyl ether generic -metabolite KEGG:C15455 Sodium molybdate generic -metabolite KEGG:C15456 11beta,13-Dihydroxy-3-oxo-13,17-secoandrosta-1,4-dien-17-oic acid, delta-lactone generic -metabolite KEGG:C15457 trans-2-(4-Methoxyphenyl)-3-(4-nitrophenyl)oxirane generic -metabolite KEGG:C15458 (alphaS,betaS)-alpha-Ethyl-alpha-(4-methoxyphenyl)-beta-phenyl-2-pyridineethanol generic -metabolite KEGG:C15459 13-Hydroxy-2-(hydroxymethylene)-3-oxo-13,17-seco-5alpha-androstan-17-oic acid, delta-lactone generic -metabolite KEGG:C15460 17beta-Hydroxy-17-methyl-5alpha-androst-9(11)-en-3-one generic -metabolite KEGG:C15461 17beta-Acetyl-1,2,3,4,6alpha,7alpha,10,12,13,14alpha,16,17-dodecahydro-3beta-hydroxy-10beta,13beta-dimethyl-5beta,8beta-etheno-15H-cyclopenta[a]phenanthrene-6,7-dicarboxylic anhydride acetate generic -metabolite KEGG:C15462 cis-1,3,4,6,7,11b-Hexahydro-9-methoxy-2H-benzo[a]quinolizine-3-carboxylic acid generic -metabolite KEGG:C15463 (R*,S*)-4-[1-Ethyl-2-(4-fluorophenyl)butyl]phenol generic -metabolite KEGG:C15464 (+)-12-(2-Cyclopenten-1-yl)-2-dodecanone generic -metabolite KEGG:C15465 6-Oxabicyclo[3.1.0]hexane-2-undecanoic acid methyl ester generic -metabolite KEGG:C15466 N-(6-Oxo-6H-dibenzo[b,d]pyran-3-yl)maleamic acid generic -metabolite KEGG:C15467 6beta,17-Dihydroxy-3,5-cyclo-5alpha,17alpha-pregn-20-ene-21-carboxylic acid, gamma-lactone generic -metabolite KEGG:C15468 3,5-Cyclo-5alpha,17alpha-pregn-20-yne-6beta,17-diol generic -metabolite KEGG:C15469 Butylated hydroxyanisole generic -metabolite KEGG:C15470 Toxaphene generic -metabolite KEGG:C15471 Bismuth generic -metabolite KEGG:C15472 Germanium generic -metabolite KEGG:C15473 Lithium generic -metabolite KEGG:C15474 Tropolone generic -metabolite KEGG:C15475 U 0521 generic -metabolite KEGG:C15476 Norselegiline generic -metabolite KEGG:C15477 CGP 28014 generic -metabolite KEGG:C15478 D-Fucosamine generic -metabolite KEGG:C15479 D-Quinovosamine generic -metabolite KEGG:C15480 N-Acetyl-D-fucosamine generic -metabolite KEGG:C15481 N-Acetyl-D-quinovosamine generic -metabolite KEGG:C15482 Bacitracin A generic -metabolite KEGG:C15483 D-Galactonolactone generic -metabolite KEGG:C15484 Isopregnanolone generic -metabolite KEGG:C15485 2'-Deoxymugineic acid generic -metabolite KEGG:C15486 3''-Deamino-3''-oxonicotianamine generic -metabolite KEGG:C15488 Fluoroacetaldehyde generic -metabolite KEGG:C15489 S-2-(Indol-3-yl)acetyl-CoA generic -metabolite KEGG:C15492 all-trans-13,14-Dihydroretinol generic -metabolite KEGG:C15493 9-cis-Retinoic acid generic -metabolite KEGG:C15494 Decylubiquinone generic -metabolite KEGG:C15495 Decylubiquinol generic -metabolite KEGG:C15496 Oxidized thiol-containing reductant generic -metabolite KEGG:C15497 1-(beta-D-Ribofuranosyl)-1,4-dihydronicotinamide generic -metabolite KEGG:C15498 ROOH generic -metabolite KEGG:C15499 Pentane-2,4-dione generic -metabolite KEGG:C15500 Mugineic acid generic -metabolite KEGG:C15501 3-Epihydroxymugineic acid generic -metabolite KEGG:C15502 3-Epihydroxy-2'-deoxymugineic acid generic -metabolite KEGG:C15503 N,N-Dihydroxy-L-tyrosine generic -metabolite KEGG:C15504 Demethylsulochrin generic -metabolite KEGG:C15505 2,3,5,6-Tetrachlorophenol generic -metabolite KEGG:C15506 Steroid ester generic -metabolite KEGG:C15507 Steroid lactone generic -metabolite KEGG:C15508 1,2-Epoxypropane generic -metabolite KEGG:C15509 Glyceocarpin generic -metabolite KEGG:C15510 4-Glyceollidin generic -metabolite KEGG:C15511 Glyceollin III generic -metabolite KEGG:C15512 Phenylacetone generic -metabolite KEGG:C15513 Benzyl acetate generic -metabolite KEGG:C15514 8'-Hydroxyabscisate generic -metabolite KEGG:C15515 Murideoxycholic acid generic -metabolite KEGG:C15516 Taurohyocholate generic -metabolite KEGG:C15517 Hyodeoxycholate generic -metabolite KEGG:C15518 (24S)-Cholest-5-ene-3beta,7alpha,24-triol generic -metabolite KEGG:C15519 25-Hydroxycholesterol generic -metabolite KEGG:C15520 Cholest-5-ene-3beta,7alpha,25-triol generic -metabolite KEGG:C15521 Alkanesulfonate generic -metabolite KEGG:C15522 4a-Hydroxytetrahydrobiopterin generic -metabolite KEGG:C15523 2,6-Dihydroxynicotinate generic -metabolite KEGG:C15524 Phenylglyoxylyl-CoA generic -metabolite KEGG:C15525 Eriodictyol chalcone generic -metabolite KEGG:C15527 Precorrin 1 generic -metabolite KEGG:C15528 [Cytochrome c]-arginine generic -metabolite KEGG:C15529 [Cytochrome c]-N(omega)-methylarginine generic -metabolite KEGG:C15530 Corydaline generic -metabolite KEGG:C15531 2'-O-Methylisoliquiritigenin generic -metabolite KEGG:C15532 N-Acetyl-L-citrulline generic -metabolite KEGG:C15533 4-Fluoro-L-threonine generic -metabolite KEGG:C15534 2-Arylethylamine generic -metabolite KEGG:C15535 N-Acetyl-2-arylethylamine generic -metabolite KEGG:C15536 Dihydromonacolin L generic -metabolite KEGG:C15537 Taxuyunnanin C generic -metabolite KEGG:C15538 10-Desacetyltaxuyunnanin C generic -metabolite KEGG:C15539 Anthocyanidin 3-O-beta-D-glucoside generic -metabolite KEGG:C15540 Anthocyanidin 3-O-(6-O-malonyl-beta-D-glucoside) generic -metabolite KEGG:C15541 NDP-glucose generic -metabolite KEGG:C15542 D-Mannosyl-1-phosphoundecaprenol generic -metabolite KEGG:C15543 6-(alpha-D-Mannosyl)-beta-D-mannosyl-R generic -metabolite KEGG:C15544 4-(N-Acetyl-beta-D-glucosaminyl)-beta-D-mannosyl-R generic -metabolite KEGG:C15545 cis-Zeatin generic -metabolite KEGG:C15546 O-beta-D-Glucopyranosyl-cis-zeatin generic -metabolite KEGG:C15547 1,4-Dihydroxy-2-naphthoyl-CoA generic -metabolite KEGG:C15548 2-alpha-D-Glucosyl-D-glucose generic -metabolite KEGG:C15549 Anthocyanin generic -metabolite KEGG:C15550 Anthocyanin 3'-O-beta-D-glucoside generic -metabolite KEGG:C15551 CV 2961 generic -metabolite KEGG:C15552 PD 123177 generic -metabolite KEGG:C15553 PD 123319 generic -metabolite KEGG:C15554 EXP 3174 generic -metabolite KEGG:C15555 Flavonol 3-O-D-glycoside generic -metabolite KEGG:C15556 L-3,4-Dihydroxybutan-2-one 4-phosphate generic -metabolite KEGG:C15557 Glycolithocholate generic -metabolite KEGG:C15558 Dermatan 6'-sulfate generic -metabolite KEGG:C15559 Glycochenodeoxycholate 7-sulfate generic -metabolite KEGG:C15560 Deoxycholoyl-CoA generic -metabolite KEGG:C15561 N-Benzylformamide generic -metabolite KEGG:C15562 Benzylamine generic -metabolite KEGG:C15563 2-Amino-5-formylamino-6-(5-phospho-D-ribosylamino)pyrimidin-4(3H)-one generic -metabolite KEGG:C15564 (R)-2-Haloacid generic -metabolite KEGG:C15565 (S)-2-Hydroxyacid generic -metabolite KEGG:C15566 D-Dopachrome generic -metabolite KEGG:C15567 2,7,4'-Trihydroxyisoflavanone generic -metabolite KEGG:C15568 7alpha,12alpha-Dihydroxy-3-oxochol-4-enoate generic -metabolite KEGG:C15569 12alpha-Hydroxy-3-oxochola-4,6-dienoate generic -metabolite KEGG:C15570 Dihydroflavonol generic -metabolite KEGG:C15571 Catechol generic -metabolite KEGG:C15572 Guaiacol generic -metabolite KEGG:C15573 beta-D-Glucuronosyl-(1->4)-N-acetyl-alpha-D-glucosaminylproteoglycan generic -metabolite KEGG:C15574 N-Acetyl-alpha-D-glucosaminyl-(1->4)-beta-D-glucuronosyl-(1->4)-N-acetyl-alpha-D-glucosaminylproteoglycan generic -metabolite KEGG:C15575 N-Acetyl-alpha-D-glucosaminyl-(1->4)-beta-D-glucuronosylproteoglycan generic -metabolite KEGG:C15576 beta-D-Glucuronosyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-(1->4)-beta-D-glucuronosylproteoglycan generic -metabolite KEGG:C15577 N-Acetyl-beta-D-galactosaminyl-(1->4)-beta-D-glucuronosylproteoglycan generic -metabolite KEGG:C15578 beta-D-Glucuronosyl-(1->3)-N-acetyl-beta-D-galactosaminyl-(1->4)-beta-D-glucuronosylproteoglycan generic -metabolite KEGG:C15579 Flavanone 7-O-[alpha-L-rhamnosyl-(1->2)-beta-D-glucoside] generic -metabolite KEGG:C15580 Flavonol 7-O-beta-D-glucoside generic -metabolite KEGG:C15581 Flavonol 3-O-beta-D-glucosyl-(1->2)-beta-D-glucoside generic -metabolite KEGG:C15582 Flavonol 3-O-beta-D-glucosyl-(1->2)-beta-D-glucosyl-(1->2)-beta-D-glucoside generic -metabolite KEGG:C15583 Phenyl acetate generic -metabolite KEGG:C15584 Phenol generic -metabolite KEGG:C15585 myo-Inositol phosphate generic -metabolite KEGG:C15586 N-D-Ribosylpurine generic -metabolite KEGG:C15587 Purine generic -metabolite KEGG:C15588 Glycol generic -metabolite KEGG:C15589 Chalcone generic -metabolite KEGG:C15590 Acylglycerol generic -metabolite KEGG:C15591 (6R)-2-Acetyl-6-(3-acetyl-2,4,6-trihydroxy-5-methylphenyl)-3-hydroxy-6-methyl-2,4-cyclohexadien-1-one generic -metabolite KEGG:C15592 Pyranose generic -metabolite KEGG:C15593 2-Dehydropyranose generic -metabolite KEGG:C15594 Pyranoside generic -metabolite KEGG:C15595 3-Dehydropyranoside generic -metabolite KEGG:C15596 n-Alkanal generic -metabolite KEGG:C15597 Alk-2-enal generic -metabolite KEGG:C15598 2,3-cis-2R,3R-Flavan-3-ol generic -metabolite KEGG:C15599 6-(2-Amino-2-carboxyethyl)-7,8-dioxo-1,2,3,4,7,8-hexahydroquinoline-2,4-dicarboxylate generic -metabolite KEGG:C15601 Glyceollin generic -metabolite KEGG:C15602 Quinone generic -metabolite KEGG:C15603 Hydroquinone generic -metabolite KEGG:C15604 Prenal generic -metabolite KEGG:C15605 N-Formyl-D-kynurenine generic -metabolite KEGG:C15606 1,2-Dihydroxy-5-(methylthio)pent-1-en-3-one generic -metabolite KEGG:C15607 3-Oxo-3-ureidopropanoate generic -metabolite KEGG:C15608 Flavone generic -metabolite KEGG:C15609 3',5'-Dihydroxyflavanone generic -metabolite KEGG:C15610 Cholest-5-ene-3beta,26-diol generic -metabolite KEGG:C15612 Senecionine N-oxide generic -metabolite KEGG:C15613 (25R)-3alpha,7alpha,12alpha-Trihydroxy-5beta-cholestan-26-oyl-CoA generic -metabolite KEGG:C15614 (24R,25R)-3alpha,7alpha,12alpha,24-Tetrahydroxy-5beta-cholestanoyl-CoA generic -metabolite KEGG:C15615 7-Hydroxyisoflavone generic -metabolite KEGG:C15616 7-Methoxyisoflavone generic -metabolite KEGG:C15617 Pirinixic acid generic -metabolite KEGG:C15618 Sobetirome generic -metabolite KEGG:C15619 Am 580 generic -metabolite KEGG:C15620 GW 6471 generic -metabolite KEGG:C15622 GW 7647 generic -metabolite KEGG:C15623 GW 409544 generic -metabolite KEGG:C15624 GW 2433 generic -metabolite KEGG:C15625 GW 0742 generic -metabolite KEGG:C15626 GW 1929 generic -metabolite KEGG:C15627 GW 9662 generic -metabolite KEGG:C15628 SR 12813 generic -metabolite KEGG:C15629 CGP 52608 generic -metabolite KEGG:C15630 T 0901317 generic -metabolite KEGG:C15631 GW 3965 generic -metabolite KEGG:C15632 24(S),25-Epoxycholesterol generic -metabolite KEGG:C15633 5,6-24(S),25-Diepoxycholesterol generic -metabolite KEGG:C15634 Arotinoid acid generic -metabolite KEGG:C15635 GW 4064 generic -metabolite KEGG:C15636 6-Ethylchenodeoxycholic acid generic -metabolite KEGG:C15637 Pregnenolone carbonitrile generic -metabolite KEGG:C15638 3-Androstanol generic -metabolite KEGG:C15639 CITCO generic -metabolite KEGG:C15640 LG 100268 generic -metabolite KEGG:C15641 XCT 790 generic -metabolite KEGG:C15642 GSK 4716 generic -metabolite KEGG:C15643 Dexamethasone generic -metabolite KEGG:C15644 GW 0791 generic -metabolite KEGG:C15645 1-(1-Alkenyl)-sn-glycerol generic -metabolite KEGG:C15646 1-(1-Alkenyl)-sn-glycero-3-phosphate generic -metabolite KEGG:C15647 2-Acyl-1-(1-alkenyl)-sn-glycero-3-phosphate generic -metabolite KEGG:C15648 Octachlorocamphene generic -metabolite KEGG:C15649 Fexaramine generic -metabolite KEGG:C15650 2,3-Diketo-5-methylthiopentyl-1-phosphate generic -metabolite KEGG:C15651 2-Hydroxy-3-keto-5-methylthiopentenyl-1-phosphate generic -metabolite KEGG:C15652 Neomycin C generic -metabolite KEGG:C15653 Peptide-L-methionine (R)-S-oxide generic -metabolite KEGG:C15654 Kni 102 generic -metabolite KEGG:C15655 Kynostatin 272 generic -metabolite KEGG:C15656 alpha-N-Acetyl-D-glucosaminyl-(1->4)-beta-D-glucuronosyl-(1->3)-beta-D-galactosyl-(1->3)-beta-D-galactosyl-(1->4)-beta-D-xylosylproteoglycan generic -metabolite KEGG:C15657 BILA 2185BS generic -metabolite KEGG:C15658 6-(alpha-D-Glucosaminyl)-1D-myo-inositol generic -metabolite KEGG:C15659 TMC 126 generic -metabolite KEGG:C15660 A 77003 generic -metabolite KEGG:C15661 A 80987 generic -metabolite KEGG:C15662 Dmp 323 generic -metabolite KEGG:C15663 CMN 131 generic -metabolite KEGG:C15664 B 823-08 generic -metabolite KEGG:C15665 Ro 18-5364 generic -metabolite KEGG:C15666 (7R)-7-(4-Carboxybutanamido)cephalosporanate generic -metabolite KEGG:C15667 5-Carboxyamino-1-(5-phospho-D-ribosyl)imidazole generic -metabolite KEGG:C15668 1-Pyrroline generic -metabolite KEGG:C15669 Teicoplanin A3 generic -metabolite KEGG:C15670 Heme A generic -metabolite KEGG:C15672 Heme O generic -metabolite KEGG:C15673 2-Dehydro-L-idonate generic -metabolite KEGG:C15674 Myxothiazol A generic -metabolite KEGG:C15675 Myxothiazol Z generic -metabolite KEGG:C15676 HC-toxin generic -metabolite KEGG:C15677 Leinamycin generic -metabolite KEGG:C15678 Chalcomycin generic -metabolite KEGG:C15679 Lankamycin generic -metabolite KEGG:C15680 Mycinamicin II generic -metabolite KEGG:C15681 Mycinamicin III generic -metabolite KEGG:C15682 Mycinamicin VI generic -metabolite KEGG:C15683 Mycinamicin VII generic -metabolite KEGG:C15684 Mycinamicin VIII generic -metabolite KEGG:C15685 Protomycinolide IV generic -metabolite KEGG:C15686 Arthrofactin generic -metabolite KEGG:C15687 Borrelidin generic -metabolite KEGG:C15688 Vicenistatin generic -metabolite KEGG:C15689 Aureothin generic -metabolite KEGG:C15690 Salinomycin generic -metabolite KEGG:C15691 Anabaenopeptilide 90A generic -metabolite KEGG:C15692 Anabaenopeptilide 90B generic -metabolite KEGG:C15693 Barbamide generic -metabolite KEGG:C15694 Epothilone C generic -metabolite KEGG:C15695 Complestatin generic -metabolite KEGG:C15696 Melithiazol A generic -metabolite KEGG:C15697 Nostopeptolide A1 generic -metabolite KEGG:C15698 Nostopeptolide A2 generic -metabolite KEGG:C15699 gamma-L-Glutamylputrescine generic -metabolite KEGG:C15700 gamma-Glutamyl-gamma-aminobutyraldehyde generic -metabolite KEGG:C15701 Syringolin A generic -metabolite KEGG:C15702 Tubulysin A generic -metabolite KEGG:C15703 Tubulysin B generic -metabolite KEGG:C15704 Tubulysin D generic -metabolite KEGG:C15705 Tubulysin E generic -metabolite KEGG:C15706 Spinosyn H generic -metabolite KEGG:C15707 Spinosyn J generic -metabolite KEGG:C15708 Spinosyn K generic -metabolite KEGG:C15709 Spinosyn P generic -metabolite KEGG:C15710 Phoslactomycin B generic -metabolite KEGG:C15711 Balhimycin generic -metabolite KEGG:C15712 Melithiazole E generic -metabolite KEGG:C15713 Nodularin generic -metabolite KEGG:C15714 Myxochromide S1 generic -metabolite KEGG:C15715 Myxochromide S2 generic -metabolite KEGG:C15716 Myxochromide S3 generic -metabolite KEGG:C15717 ECO 02301 generic -metabolite KEGG:C15718 Pyoverdine I generic -metabolite KEGG:C15719 Coelichelin generic -metabolite KEGG:C15720 Lyngbyatoxin generic -metabolite KEGG:C15721 Triostin A generic -metabolite KEGG:C15722 Quinomycin A generic -metabolite KEGG:C15723 Nostocyclopeptide A1 generic -metabolite KEGG:C15724 Nostocyclopeptide A2 generic -metabolite KEGG:C15725 Nostocyclopeptide A3 generic -metabolite KEGG:C15726 Zwittermicin A generic -metabolite KEGG:C15727 Thiocoraline generic -metabolite KEGG:C15728 Chivosazole A generic -metabolite KEGG:C15729 Chivosazole B generic -metabolite KEGG:C15730 Chivosazole C generic -metabolite KEGG:C15731 Chivosazole D generic -metabolite KEGG:C15732 Chivosazole E generic -metabolite KEGG:C15733 Chivosazole F generic -metabolite KEGG:C15734 Patellamide A generic -metabolite KEGG:C15735 Patellamide C generic -metabolite KEGG:C15736 Patellamide B generic -metabolite KEGG:C15737 Patellamide D generic -metabolite KEGG:C15738 Ascidiacyclamide generic -metabolite KEGG:C15739 Westiellamide generic -metabolite KEGG:C15740 Enniatin B generic -metabolite KEGG:C15741 Methylsulfomycin I generic -metabolite KEGG:C15742 Cyanopeptolin A generic -metabolite KEGG:C15743 Cyanopeptolin S generic -metabolite KEGG:C15744 Aeruginopeptin 95A generic -metabolite KEGG:C15745 Aeruginopeptin 95B generic -metabolite KEGG:C15746 Aeruginopeptin 228A generic -metabolite KEGG:C15747 Aeruginopeptin 228B generic -metabolite KEGG:C15748 Aeruginopeptin 917S-A generic -metabolite KEGG:C15749 Aeruginopeptin 917S-B generic -metabolite KEGG:C15750 Aeruginopeptin 917S-C generic -metabolite KEGG:C15751 Spicamycin generic -metabolite KEGG:C15752 Lienomycin generic -metabolite KEGG:C15753 Dihydroalbocycline generic -metabolite KEGG:C15754 Septacidin generic -metabolite KEGG:C15755 Dihydropicromycin generic -metabolite KEGG:C15756 Antibiotic TA generic -metabolite KEGG:C15757 Enniatin B4 generic -metabolite KEGG:C15758 Lankacidin C generic -metabolite KEGG:C15759 Hedamycin generic -metabolite KEGG:C15760 Pederin generic -metabolite KEGG:C15761 Concanamycin A generic -metabolite KEGG:C15762 Onnamide A generic -metabolite KEGG:C15763 SW 163C generic -metabolite KEGG:C15764 UK 63598 generic -metabolite KEGG:C15765 Coronafacic acid generic -metabolite KEGG:C15766 Halstoctacosanolide A generic -metabolite KEGG:C15767 4-(L-gamma-Glutamylamino)butanoate generic -metabolite KEGG:C15769 HBOA generic -metabolite KEGG:C15770 DIBOA generic -metabolite KEGG:C15771 TRIBOA generic -metabolite KEGG:C15772 DIBOA-glucoside generic -metabolite KEGG:C15773 Bleomycin generic -metabolite KEGG:C15774 Bleomycin A generic -metabolite KEGG:C15775 Bleomycin B generic -metabolite KEGG:C15776 4alpha-Methylfecosterol generic -metabolite KEGG:C15777 Episterol generic -metabolite KEGG:C15778 5,7,24(28)-Ergostatrienol generic -metabolite KEGG:C15780 5-Dehydroepisterol generic -metabolite KEGG:C15781 24-Methylenecholesterol generic -metabolite KEGG:C15782 Delta7-Avenasterol generic -metabolite KEGG:C15783 5-Dehydroavenasterol generic -metabolite KEGG:C15784 Campest-4-en-3beta-ol generic -metabolite KEGG:C15785 Campest-4-en-3-one generic -metabolite KEGG:C15786 5alpha-Campestan-3-one generic -metabolite KEGG:C15787 Campestanol generic -metabolite KEGG:C15788 6alpha-Hydroxycampestanol generic -metabolite KEGG:C15789 6-Oxocampestanol generic -metabolite KEGG:C15790 Cathasterone generic -metabolite KEGG:C15791 Teasterone generic -metabolite KEGG:C15792 3-Dehydroteasterone generic -metabolite KEGG:C15793 Typhasterol generic -metabolite KEGG:C15794 Castasterone generic -metabolite KEGG:C15795 22alpha-Hydroxy-campesterol generic -metabolite KEGG:C15796 22alpha-Hydroxy-campest-4-en-3-one generic -metabolite KEGG:C15797 22alpha-Hydroxy-5alpha-campestan-3-one generic -metabolite KEGG:C15798 6-Deoxocathasterone generic -metabolite KEGG:C15799 6-Deoxoteasterone generic -metabolite KEGG:C15800 3-Dehydro-6-deoxoteasterone generic -metabolite KEGG:C15801 6-Deoxotyphasterol generic -metabolite KEGG:C15802 6-Deoxocastasterone generic -metabolite KEGG:C15803 6alpha-Hydroxy-castasterone generic -metabolite KEGG:C15804 p-Hydroxyphenyl lignin generic -metabolite KEGG:C15805 Guaiacyl lignin generic -metabolite KEGG:C15806 Syringyl lignin generic -metabolite KEGG:C15807 5-Hydroxy-guaiacyl lignin generic -metabolite KEGG:C15808 4alpha-Methylzymosterol-4-carboxylate generic -metabolite KEGG:C15809 Iminoglycine generic -metabolite KEGG:C15810 Sulfur-carrier protein generic -metabolite KEGG:C15811 [Enzyme]-cysteine generic -metabolite KEGG:C15812 [Enzyme]-S-sulfanylcysteine generic -metabolite KEGG:C15813 Adenylyl-[sulfur-carrier protein] generic -metabolite KEGG:C15814 Thiocarboxy-[sulfur-carrier protein] generic -metabolite KEGG:C15816 3-Keto-4-methylzymosterol generic -metabolite KEGG:C15817 Heme C generic -metabolite KEGG:C15818 Soraphen O generic -metabolite KEGG:C15819 FK463 generic -metabolite KEGG:C15820 Teicoplanin generic -metabolite KEGG:C15821 Rimocidine generic -metabolite KEGG:C15822 CE-108 generic -metabolite KEGG:C15823 Progeldanamycin generic -metabolite KEGG:C15824 Cephabacin F3 generic -metabolite KEGG:C15825 BT1583 generic -metabolite KEGG:C15826 Jamaicamide generic -metabolite KEGG:C15827 Obscurin generic -metabolite KEGG:C15828 Syringopeptin generic -metabolite KEGG:C15829 Glycopeptidelipid generic -metabolite KEGG:C15830 Gramicidin A generic -metabolite KEGG:C15831 A54145 generic -metabolite KEGG:C15834 Narasin B generic -metabolite KEGG:C15835 Axenomycin generic -metabolite KEGG:C15838 TMC-151 generic -metabolite KEGG:C15839 Antibiotic K41 generic -metabolite KEGG:C15840 Neocarzilin generic -metabolite KEGG:C15841 Luzopeptin generic -metabolite KEGG:C15842 Lipomycin generic -metabolite KEGG:C15844 Elaiophylin generic -metabolite KEGG:C15845 Arenomycin B generic -metabolite KEGG:C15846 Isomigrastatin generic -metabolite KEGG:C15847 X-206 generic -metabolite KEGG:C15848 Angiotensin III generic -metabolite KEGG:C15849 Angiotensin IV generic -metabolite KEGG:C15850 Angiotensin (1-7) generic -metabolite KEGG:C15851 Angiotensin (1-9) generic -metabolite KEGG:C15852 Angiotensin (1-5) generic -metabolite KEGG:C15853 Dehydrospermidine generic -metabolite KEGG:C15854 N-(4-Aminobutylidene)-[eIF5A-precursor]-lysine generic -metabolite KEGG:C15855 Apelin-13 generic -metabolite KEGG:C15856 Apelin-36 generic -metabolite KEGG:C15857 9,9'-dicis-zeta-Carotene generic -metabolite KEGG:C15858 7,9,7',9'-tetracis-Lycopene generic -metabolite KEGG:C15859 1'-Hydroxy-gamma-carotene generic -metabolite KEGG:C15860 1'-Hydroxytorulene generic -metabolite KEGG:C15861 1'-Hydroxy-gamma-carotene glucoside generic -metabolite KEGG:C15862 Buccalin generic -metabolite KEGG:C15863 Cerebellin generic -metabolite KEGG:C15864 1'-Hydroxy-gamma-carotene glucoside ester generic -metabolite KEGG:C15865 Neuromedin B generic -metabolite KEGG:C15866 Neuromedin C generic -metabolite KEGG:C15867 3,4-Dehydrolycopene generic -metabolite KEGG:C15868 Neuromedin N generic -metabolite KEGG:C15869 Neuromedin U generic -metabolite KEGG:C15871 Nocistatin generic -metabolite KEGG:C15872 Kinetensin generic -metabolite KEGG:C15873 Kassinin generic -metabolite KEGG:C15874 3,4-Dehydrorhodopin generic -metabolite KEGG:C15875 Kemptide generic -metabolite KEGG:C15876 Katacalcin generic -metabolite KEGG:C15877 Anhydrorhodovibrin generic -metabolite KEGG:C15878 Rhodovibrin generic -metabolite KEGG:C15879 Hydroxyspirilloxanthin generic -metabolite KEGG:C15880 Allatostatin I generic -metabolite KEGG:C15881 Spirilloxanthin generic -metabolite KEGG:C15882 2-Methyl-6-phytylquinol generic -metabolite KEGG:C15883 2,3-Dimethyl-5-phytylquinol generic -metabolite KEGG:C15884 2-Ketospirilloxanthin generic -metabolite KEGG:C15885 2,2'-Diketospirilloxanthin generic -metabolite KEGG:C15886 3,4-Dihydroanhydrorhodovibrin generic -metabolite KEGG:C15887 3',4'-Dihydrorhodovibrin generic -metabolite KEGG:C15888 3,4,3',4'-Tetrahydrospirilloxanthin generic -metabolite KEGG:C15889 Dermaseptin generic -metabolite KEGG:C15890 Endomorphin-1 generic -metabolite KEGG:C15891 Endomorphin-2 generic -metabolite KEGG:C15892 Chloroxanthin generic -metabolite KEGG:C15893 Exendin-3 generic -metabolite KEGG:C15894 Exendin-4 generic -metabolite KEGG:C15895 3,4-Dihydrospheroidene generic -metabolite KEGG:C15897 Fibrinogen binding inhibitor peptide generic -metabolite KEGG:C15898 Demethylspheroidene generic -metabolite KEGG:C15899 Fibrinogen binding peptide generic -metabolite KEGG:C15900 Spheroidene generic -metabolite KEGG:C15901 Galanin generic -metabolite KEGG:C15902 Hydroxyspheroidene generic -metabolite KEGG:C15903 Spheroidenone generic -metabolite KEGG:C15904 Galantide generic -metabolite KEGG:C15905 Hydroxyspheroidenone generic -metabolite KEGG:C15906 Glucose-dependent insulinotropic peptide generic -metabolite KEGG:C15907 1',2'-Dihydro-gamma-carotene generic -metabolite KEGG:C15908 Chlorobactene generic -metabolite KEGG:C15910 1',2'-Dihydrochlorobactene generic -metabolite KEGG:C15911 Hydroxychlorobactene generic -metabolite KEGG:C15912 Granuliberin R generic -metabolite KEGG:C15913 HA Peptide generic -metabolite KEGG:C15914 Hydroxychlorobactene glucoside generic -metabolite KEGG:C15915 4,4-Dimethyl-5alpha-cholesta-8-en-3beta-ol generic -metabolite KEGG:C15916 Helospectin I generic -metabolite KEGG:C15917 Hydroxychlorobactene glucoside ester generic -metabolite KEGG:C15918 Helospectin II generic -metabolite KEGG:C15919 Myxol generic -metabolite KEGG:C15920 Heparin binding peptide generic -metabolite KEGG:C15921 Histatin 5 generic -metabolite KEGG:C15922 Indolicidin generic -metabolite KEGG:C15923 L-Gulose generic -metabolite KEGG:C15924 L-Gulose 1-phosphate generic -metabolite KEGG:C15925 GDP-L-gulose generic -metabolite KEGG:C15926 beta-L-Galactose 1-phosphate generic -metabolite KEGG:C15927 Leucokinin I generic -metabolite KEGG:C15928 4-Ketomyxol generic -metabolite KEGG:C15929 Leucokinin VIII generic -metabolite KEGG:C15930 L-Galactonate generic -metabolite KEGG:C15931 Magainin 1 generic -metabolite KEGG:C15932 4-Hydroxymyxol generic -metabolite KEGG:C15933 Deoxymyxol generic -metabolite KEGG:C15935 (2'S)-Deoxymyxol 2'-(2,4-di-O-methyl-alpha-L-fucoside) generic -metabolite KEGG:C15936 Magainin 2 generic -metabolite KEGG:C15937 (3R,2'S)-Myxol 2'-(2,4-di-O-methyl-alpha-L-fucoside) generic -metabolite KEGG:C15938 MAGE-3 (271 - 279) generic -metabolite KEGG:C15940 (2'S)-Deoxymyxol 2'-alpha-L-fucoside generic -metabolite KEGG:C15941 (3R,2'S)-Myxol 2'-alpha-L-fucoside generic -metabolite KEGG:C15942 (3S,2'S)-4-Ketomyxol 2'-alpha-L-fucoside generic -metabolite KEGG:C15943 Isorenieratene generic -metabolite KEGG:C15944 Mas7 generic -metabolite KEGG:C15945 Mas8 generic -metabolite KEGG:C15946 Mas17 generic -metabolite KEGG:C15947 Mastoparan generic -metabolite KEGG:C15948 Myomodulin generic -metabolite KEGG:C15949 Neuropeptide Y generic -metabolite KEGG:C15952 Thermocryptoxanthin-11 generic -metabolite KEGG:C15954 Thermocryptoxanthin-13 generic -metabolite KEGG:C15955 Thermocryptoxanthin-15 generic -metabolite KEGG:C15956 Thermozeaxanthin-13 generic -metabolite KEGG:C15957 Thermozeaxanthin-15 generic -metabolite KEGG:C15958 Thermozeaxanthin-17 generic -metabolite KEGG:C15959 Thermobiszeaxanthin-13-13 generic -metabolite KEGG:C15960 Octaneuropeptide generic -metabolite KEGG:C15961 P55-TNFR fragment generic -metabolite KEGG:C15962 P75-TNFR fragment generic -metabolite KEGG:C15963 Thermobiszeaxanthin-13-15 generic -metabolite KEGG:C15964 Thermobiszeaxanthin-15-15 generic -metabolite KEGG:C15965 3'-Hydroxyechinenone generic -metabolite KEGG:C15966 3-Hydroxyechinenone generic -metabolite KEGG:C15967 Phoenicoxanthin generic -metabolite KEGG:C15968 Adonixanthin generic -metabolite KEGG:C15969 Zeaxanthin diglucoside generic -metabolite KEGG:C15970 Abscisic acid glucose ester generic -metabolite KEGG:C15971 Dihydrophaseic acid generic -metabolite KEGG:C15972 Enzyme N6-(lipoyl)lysine generic -metabolite KEGG:C15973 Enzyme N6-(dihydrolipoyl)lysine generic -metabolite KEGG:C15974 3-Methyl-1-hydroxybutyl-ThPP generic -metabolite KEGG:C15975 [Dihydrolipoyllysine-residue (2-methylpropanoyl)transferase] S-(3-methylbutanoyl)dihydrolipoyllysine generic -metabolite KEGG:C15976 2-Methyl-1-hydroxypropyl-ThPP generic -metabolite KEGG:C15977 [Dihydrolipoyllysine-residue (2-methylpropanoyl)transferase] S-(2-methylpropanoyl)dihydrolipoyllysine generic -metabolite KEGG:C15978 2-Methyl-1-hydroxybutyl-ThPP generic -metabolite KEGG:C15979 [Dihydrolipoyllysine-residue (2-methylpropanoyl)transferase] S-(2-methylbutanoyl)dihydrolipoyllysine generic -metabolite KEGG:C15980 (S)-2-Methylbutanoyl-CoA generic -metabolite KEGG:C15981 alpha-Cryptoxanthin generic -metabolite KEGG:C15982 Thermocryptoxanthin generic -metabolite KEGG:C15983 Thermozeaxanthin generic -metabolite KEGG:C15984 Thermobiszeaxanthin generic -metabolite KEGG:C15985 17-O-Acetylajmaline generic -metabolite KEGG:C15986 2,6-Dihydroxypseudooxynicotine generic -metabolite KEGG:C15987 4-Methylaminobutyrate generic -metabolite KEGG:C15988 (9S,10S)-9,10-Dihydroxyoctadecanoate generic -metabolite KEGG:C15989 (9S,10S)-10-Hydroxy-9-(phosphonooxy)octadecanoate generic -metabolite KEGG:C15990 1L-myo-Inositol 1,2,3,4,6-pentakisphosphate generic -metabolite KEGG:C15991 myo-Inositol pentakisphosphate generic -metabolite KEGG:C15992 Cholesterol-5alpha,6alpha-epoxide generic -metabolite KEGG:C15995 Bombesin generic -metabolite KEGG:C15996 7-Cyano-7-carbaguanine generic -metabolite KEGG:C15997 Potassium 2,6-dihydroxytriazinecarboxylate generic -metabolite KEGG:C15998 L-Methionine (R)-S-oxide generic -metabolite KEGG:C15999 L-Methionine (S)-S-oxide generic -metabolite KEGG:C16000 Urodilatin generic -metabolite KEGG:C16001 Reactive black 5 generic -metabolite KEGG:C16002 Oxidized reactive black 5 generic -metabolite KEGG:C16003 Atrial natriuretic peptide generic -metabolite KEGG:C16004 Brain natriuretic peptide generic -metabolite KEGG:C16005 C-Type natriuretic peptide generic -metabolite KEGG:C16006 Uroguanylin generic -metabolite KEGG:C16007 Guanylin generic -metabolite KEGG:C16008 T-kinin generic -metabolite KEGG:C16009 Big endothelin generic -metabolite KEGG:C16010 Endothelin-1 generic -metabolite KEGG:C16011 Protein-omega-N-(ADP-D-ribosyl)-L-arginine generic -metabolite KEGG:C16012 Endothelin-2 generic -metabolite KEGG:C16013 Endothelin-3 generic -metabolite KEGG:C16014 cis-Stilbene oxide generic -metabolite KEGG:C16015 (+)-(1R,2R)-1,2-Diphenylethane-1,2-diol generic -metabolite KEGG:C16016 Urotensin II generic -metabolite KEGG:C16017 alpha-Endorphin generic -metabolite KEGG:C16018 gamma-Endorphin generic -metabolite KEGG:C16019 beta-Lipotropin generic -metabolite KEGG:C16020 gamma-Lipotropin generic -metabolite KEGG:C16021 Somatostatin-28 generic -metabolite KEGG:C16022 Somatostatin-14 generic -metabolite KEGG:C16023 Cortistatin-29 generic -metabolite KEGG:C16024 Cortistatin-17 generic -metabolite KEGG:C16025 Ghrelin generic -metabolite KEGG:C16027 Cocaine- and Amphetamine- regulated transcript (1-39) generic -metabolite KEGG:C16028 Amorpha-4,11-diene generic -metabolite KEGG:C16029 Cocaine- and Amphetamine- regulated transcript (42-89) generic -metabolite KEGG:C16030 Melanin-concentrating hormone generic -metabolite KEGG:C16031 Neuropeptide GE generic -metabolite KEGG:C16032 Neuropeptide W-30 generic -metabolite KEGG:C16033 Neuropeptide W-23 generic -metabolite KEGG:C16034 Neuropeptide B-29 generic -metabolite KEGG:C16035 Neuropeptide B-23 generic -metabolite KEGG:C16036 Neuropeptide S generic -metabolite KEGG:C16037 Leumorphin generic -metabolite KEGG:C16038 2-Amino-1-methyl-6-phenylimidazo[4,5-b]pyridine generic -metabolite KEGG:C16039 alpha-Neoendorphin generic -metabolite KEGG:C16040 beta-Neoendorphin generic -metabolite KEGG:C16041 Leu-enkephalin generic -metabolite KEGG:C16042 Met-enkephalin-Arg-Gly-Leu generic -metabolite KEGG:C16043 Met-enkephalin-Arg-Phe generic -metabolite KEGG:C16044 Nociceptin generic -metabolite KEGG:C16045 RFamide-related peptide 2 generic -metabolite KEGG:C16046 Galanin-like peptide generic -metabolite KEGG:C16047 Motilin generic -metabolite KEGG:C16048 Glucagon-like peptide 1 generic -metabolite KEGG:C16049 Glucagon-like peptide 2 generic -metabolite KEGG:C16050 Glicentin generic -metabolite KEGG:C16051 Parathyroid hormone generic -metabolite KEGG:C16052 Parathyroid hormone-related peptide (1-36) generic -metabolite KEGG:C16053 Tuberoinfundibular peptide of 39 residues generic -metabolite KEGG:C16054 Defensin alpha-1 generic -metabolite KEGG:C16055 Defensin alpha-2 generic -metabolite KEGG:C16056 Defensin alpha-3 generic -metabolite KEGG:C16057 Defensin alpha-4 generic -metabolite KEGG:C16058 Defensin alpha-5 generic -metabolite KEGG:C16059 Defensin beta-1 generic -metabolite KEGG:C16060 Defensin beta-2 generic -metabolite KEGG:C16061 Defensin beta-3 generic -metabolite KEGG:C16062 Defensin beta-4 generic -metabolite KEGG:C16063 Liver-expressed antimicrobial peptide 1 generic -metabolite KEGG:C16064 Liver-expressed antimicrobial peptide 2 generic -metabolite KEGG:C16065 Thymosin alpha-1 generic -metabolite KEGG:C16066 Thymosin beta-4 generic -metabolite KEGG:C16067 Thymosin beta-10 generic -metabolite KEGG:C16068 Humanin generic -metabolite KEGG:C16069 3-Sulfolactate generic -metabolite KEGG:C16070 6-(alpha-D-Glucosaminyl)-1D-myo-inositol 1,2-cyclic phosphate generic -metabolite KEGG:C16071 Riboflavin cyclic-4',5'-phosphate generic -metabolite KEGG:C16072 Aliphatic nitrile generic -metabolite KEGG:C16074 Phenylacetonitrile generic -metabolite KEGG:C16075 (Z)-Phenylacetaldehyde oxime generic -metabolite KEGG:C16076 Urotensin I generic -metabolite KEGG:C16077 Neurophysin I generic -metabolite KEGG:C16078 Neurophysin II generic -metabolite KEGG:C16079 Corticotropin releasing hormone generic -metabolite KEGG:C16080 Urocortin I generic -metabolite KEGG:C16081 Urocortin II generic -metabolite KEGG:C16082 Urocortin III generic -metabolite KEGG:C16084 Gonadotropin-releasing hormone II generic -metabolite KEGG:C16085 Growth hormone-releasing hormone (1-29) generic -metabolite KEGG:C16086 Prolactin-releasing peptide-31 generic -metabolite KEGG:C16087 Prolactin-releasing peptide-20 generic -metabolite KEGG:C16088 Pituitary adenylate cyclase-activating peptide-38 generic -metabolite KEGG:C16089 Pituitary adenylate cyclase-activating peptide-27 generic -metabolite KEGG:C16090 Metastin generic -metabolite KEGG:C16091 Kisspeptin-14 generic -metabolite KEGG:C16092 Kisspeptin-13 generic -metabolite KEGG:C16093 Kisspeptin-10 generic -metabolite KEGG:C16094 Substance P generic -metabolite KEGG:C16095 Neuropeptide K generic -metabolite KEGG:C16096 Neuropeptide gamma generic -metabolite KEGG:C16097 Neurokinin A generic -metabolite KEGG:C16098 Neurokinin B generic -metabolite KEGG:C16099 Endokinin A/B generic -metabolite KEGG:C16100 Endokinin C generic -metabolite KEGG:C16101 Endokinin D generic -metabolite KEGG:C16102 Obestatin generic -metabolite KEGG:C16103 Agouti related protein (87-132) generic -metabolite KEGG:C16104 Neuropeptide EI generic -metabolite KEGG:C16105 Orexin A generic -metabolite KEGG:C16106 Orexin B generic -metabolite KEGG:C16107 Neuromedin S generic -metabolite KEGG:C16108 Adrenorphin generic -metabolite KEGG:C16109 RFamide-related peptide 1 generic -metabolite KEGG:C16110 RFamide-related peptide 3 generic -metabolite KEGG:C16111 Neuropeptide AF generic -metabolite KEGG:C16112 Neuropeptide FF generic -metabolite KEGG:C16113 Gastrin-17 generic -metabolite KEGG:C16114 Cholecystokinin-8 generic -metabolite KEGG:C16115 Gastrin-releasing peptide generic -metabolite KEGG:C16116 L-Aminoacyl-L-amino acid generic -metabolite KEGG:C16117 Pancreatic polypeptide generic -metabolite KEGG:C16118 Peptide YY generic -metabolite KEGG:C16119 Vasoactive intestinal peptide generic -metabolite KEGG:C16120 C-peptide generic -metabolite KEGG:C16121 Relaxin-1 generic -metabolite KEGG:C16122 Relaxin-2 generic -metabolite KEGG:C16123 Relaxin-3 generic -metabolite KEGG:C16124 Insulin-like 3 generic -metabolite KEGG:C16125 Calcitonin gene-related peptide 1 generic -metabolite KEGG:C16126 Calcitonin gene-related peptide 2 generic -metabolite KEGG:C16127 Adrenomedullin generic -metabolite KEGG:C16128 Adrenomedullin 2 generic -metabolite KEGG:C16129 Calcitonin receptor-stimulating peptide 1 generic -metabolite KEGG:C16130 Amylin generic -metabolite KEGG:C16131 Insulin-like growth factor I generic -metabolite KEGG:C16132 Insulin-like growth factor II generic -metabolite KEGG:C16133 Cholecystokinin-33 generic -metabolite KEGG:C16134 Corticotropin-like intermediary peptide generic -metabolite KEGG:C16135 Dynorphin B generic -metabolite KEGG:C16136 beta-Melanotropin generic -metabolite KEGG:C16137 gamma-Melanotropin generic -metabolite KEGG:C16138 L-Pyrrolysine generic -metabolite KEGG:C16139 tRNA(Pyl) generic -metabolite KEGG:C16140 L-Lysyl-tRNA(Pyl) generic -metabolite KEGG:C16141 (+)-Germacrene A generic -metabolite KEGG:C16142 (-)-Germacrene D generic -metabolite KEGG:C16143 (1E,4S,5E,7R)-Germacra-1(10),5-dien-11-ol generic -metabolite KEGG:C16144 4,4'-Diapophytoene generic -metabolite KEGG:C16145 4,4'-Diaponeurosporene generic -metabolite KEGG:C16146 4,4'-Diaponeurosporenic acid generic -metabolite KEGG:C16147 Glycosyl-4,4'-diaponeurosporenoate generic -metabolite KEGG:C16148 Staphyloxanthin generic -metabolite KEGG:C16149 (3Z)-4-(2-Carboxyphenyl)-2-oxobut-3-enoate generic -metabolite KEGG:C16150 (R,S)-Nicotine generic -metabolite KEGG:C16151 2,6-Dihydroxy-N-methylmyosmine generic -metabolite KEGG:C16152 Blue pigment generic -metabolite KEGG:C16153 UDP-L-Ara4N generic -metabolite KEGG:C16154 UDP-L-Ara4FN generic -metabolite KEGG:C16155 UDP-L-Ara4O generic -metabolite KEGG:C16156 Undecaprenyl phosphate alpha-L-Ara4FN generic -metabolite KEGG:C16157 Undecaprenyl phosphate alpha-L-Ara4N generic -metabolite KEGG:C16158 Exendin-2 generic -metabolite KEGG:C16159 2-Formylglutarate generic -metabolite KEGG:C16160 Linoleoyl-[acyl-carrier protein] generic -metabolite KEGG:C16161 alpha-Linolenoyl-ACP generic -metabolite KEGG:C16162 (9Z,12Z,15Z)-Octadecatrienoyl-CoA generic -metabolite KEGG:C16163 (6Z,9Z,12Z,15Z)-Octadecatetraenoyl-CoA generic -metabolite KEGG:C16164 (8Z,11Z,14Z,17Z)-Icosatetraenoyl-CoA generic -metabolite KEGG:C16165 (5Z,8Z,11Z,14Z,17Z)-Icosapentaenoyl-CoA generic -metabolite KEGG:C16166 (7Z,10Z,13Z,16Z,19Z)-Docosapentaenoyl-CoA generic -metabolite KEGG:C16167 (9Z,12Z,15Z,18Z,21Z)-Tetracosapentaenoyl-CoA generic -metabolite KEGG:C16168 (6Z,9Z,12Z,15Z,18Z,21Z)-Tetracosahexaenoyl-CoA generic -metabolite KEGG:C16169 (4Z,7Z,10Z,13Z,16Z,19Z)-Docosahexaenoyl-CoA generic -metabolite KEGG:C16170 (7Z,10Z,13Z,16Z)-Docosatetraenoyl-CoA generic -metabolite KEGG:C16171 (9Z,12Z,15Z,18Z)-Tetracosatetraenoyl-CoA generic -metabolite KEGG:C16172 (6Z,9Z,12Z,15Z,18Z)-Tetracosapentaenoyl-CoA generic -metabolite KEGG:C16173 (4Z,7Z,10Z,13Z,16Z)-Docosapentaenoyl-CoA generic -metabolite KEGG:C16174 Litorin generic -metabolite KEGG:C16175 Ranatensin generic -metabolite KEGG:C16176 Sarafotoxin S6b generic -metabolite KEGG:C16178 Insulin-like 5 generic -metabolite KEGG:C16179 (11Z,14Z,17Z)-Icosatrienoyl-CoA generic -metabolite KEGG:C16180 (11Z,14Z)-Icosadienoyl-CoA generic -metabolite KEGG:C16181 beta-2,3,4,5,6-Pentachlorocyclohexanol generic -metabolite KEGG:C16182 beta-2,3,5,6-Tetrachloro-1,4-cyclohexanediol generic -metabolite KEGG:C16184 (5Z,8Z,11Z,14Z,17Z)-Eicosapentaenoic acid ethyl ester generic -metabolite KEGG:C16185 (4Z,7Z,10Z,13Z,16Z,19Z)-Docosahexaenoic acid ethyl ester generic -metabolite KEGG:C16186 L-Ascorbate 6-phosphate generic -metabolite KEGG:C16187 7,2'-Dihydroxy-4'-methoxy-isoflavanol generic -metabolite KEGG:C16188 7-Hydroxy-2',4',5'-trimethoxyisoflavone generic -metabolite KEGG:C16189 9-Demethylmunduserone generic -metabolite KEGG:C16190 2,7-Dihydroxy-4'-methoxyisoflavanone generic -metabolite KEGG:C16191 Malonyldaidzin generic -metabolite KEGG:C16192 Malonylgenistin generic -metabolite KEGG:C16193 1,6-Naphthalenedisulfonic acid generic -metabolite KEGG:C16194 2,6-Naphthalenedisulfonic acid generic -metabolite KEGG:C16195 Glycitin generic -metabolite KEGG:C16196 1,2-Dihydroxynaphthalene-6-sulfonate generic -metabolite KEGG:C16197 Malonylglycitin generic -metabolite KEGG:C16198 (Z)-4-(2-Hydroxy-5-sulfonatophenyl)-2-oxo-3-butenoate generic -metabolite KEGG:C16199 5-Sulfosalicylate generic -metabolite KEGG:C16200 Phenylboronic acid generic -metabolite KEGG:C16201 1-Naphthalenesulfonic acid generic -metabolite KEGG:C16202 2-Naphthalenesulfonic acid generic -metabolite KEGG:C16203 Anthracene-cis-1,2-dihydrodiol generic -metabolite KEGG:C16204 1,2-Anthracenediol generic -metabolite KEGG:C16205 Anthracene-9,10-dihydrodiol generic -metabolite KEGG:C16206 9,10-Dihydroxyanthracene generic -metabolite KEGG:C16207 Anthraquinone generic -metabolite KEGG:C16208 1-Methoxy-2-hydroxyanthracene generic -metabolite KEGG:C16209 3-(2-Carboxyvinyl)naphthalene-2-carboxylic acid generic -metabolite KEGG:C16210 4-(3-Hydroxy-2-naphthyl)-2-oxobut-3-enoic acid generic -metabolite KEGG:C16211 6,7-Benzocoumarin generic -metabolite KEGG:C16212 3-Hydroxy-2-naphthoate generic -metabolite KEGG:C16213 2,3-Dihydroxynaphthalene generic -metabolite KEGG:C16214 3-[6-(Carboxymethylene)cyclohexa-2,4-dien-1-ylidene]-2-oxopropanate generic -metabolite KEGG:C16215 1,2-Dihydrophthalic acid generic -metabolite KEGG:C16216 3-Oxostearoyl-CoA generic -metabolite KEGG:C16217 3-Hydroxyoctadecanoyl-CoA generic -metabolite KEGG:C16218 (2E)-Octadecenoyl-CoA generic -metabolite KEGG:C16219 3-Oxostearoyl-[acp] generic -metabolite KEGG:C16220 (R)-3-Hydroxyoctadecanoyl-[acp] generic -metabolite KEGG:C16221 (2E)-Octadecenoyl-[acp] generic -metabolite KEGG:C16222 Formononetin 7-O-glucoside-6''-O-malonate generic -metabolite KEGG:C16223 (-)-Medicocarpin generic -metabolite KEGG:C16224 Medicarpin 3-O-glucoside-6'-malonate generic -metabolite KEGG:C16225 (-)-Vestitol generic -metabolite KEGG:C16226 2',7-Dihydroxy-4',5'-methylenedioxyisoflavone generic -metabolite KEGG:C16227 (+)-Sophorol generic -metabolite KEGG:C16228 (-)-Sophorol generic -metabolite KEGG:C16229 (+)-Maackiain generic -metabolite KEGG:C16230 (+)-6a-Hydroxymaackiain generic -metabolite KEGG:C16231 (-)-Maackiain-3-O-glucosyl-6''-O-malonate generic -metabolite KEGG:C16232 6,7,4'-Trihydroxyflavanone generic -metabolite KEGG:C16233 2,6,7,4'-Tetrahydroxyisoflavanone generic -metabolite KEGG:C16234 o-Nitrobenzoate generic -metabolite KEGG:C16235 o-Hydroxylaminobenzoate generic -metabolite KEGG:C16236 Protein N6-(octanoyl)lysine generic -metabolite KEGG:C16237 Protein N6-(lipoyl)lysine generic -metabolite KEGG:C16238 Lipoyl-AMP generic -metabolite KEGG:C16239 Lipoyl-[acp] generic -metabolite KEGG:C16240 Apoprotein generic -metabolite KEGG:C16241 (R)-Lipoate generic -metabolite KEGG:C16242 Cobalt-precorrin 5A generic -metabolite KEGG:C16243 Cobalt-precorrin 5B generic -metabolite KEGG:C16244 Cobalt-precorrin 7 generic -metabolite KEGG:C16245 D-Glucuronic acid generic -metabolite KEGG:C16246 3,5-Dibromo-4-hydroxybenzamide generic -metabolite KEGG:C16247 2,6-Dibromophenol generic -metabolite KEGG:C16248 2,6-Dibromohydroquinone generic -metabolite KEGG:C16249 2-Bromomaleylacetate generic -metabolite KEGG:C16250 MTIC generic -metabolite KEGG:C16251 3-epi-6-Deoxocathasterone generic -metabolite KEGG:C16252 (22R,23R)-22,23-Dihydroxycampesterol generic -metabolite KEGG:C16253 (22R,23R)-22,23-Dihydroxy-campest-4-en-3-one generic -metabolite KEGG:C16254 [Dihydrolipoyllysine-residue succinyltransferase] S-succinyldihydrolipoyllysine generic -metabolite KEGG:C16255 [Dihydrolipoyllysine-residue acetyltransferase] S-acetyldihydrolipoyllysine generic -metabolite KEGG:C16256 (E)-Cinnamoyl-CoA generic -metabolite KEGG:C16257 (R)-Phenyllactyl-CoA generic -metabolite KEGG:C16258 Petromyzonol generic -metabolite KEGG:C16259 Petromyzonol 24-sulfate generic -metabolite KEGG:C16260 Scymnol generic -metabolite KEGG:C16261 5beta-Scymnol sulfate generic -metabolite KEGG:C16262 1-Hydro-1,1a-dihydroxy-9-fluorenone generic -metabolite KEGG:C16263 2,3-Dihydroxy-2'-carboxybiphenyl generic -metabolite KEGG:C16264 2-Hydroxy-6-oxo-6-(2-carboxyphenyl)-hexa-2,4-dienoate generic -metabolite KEGG:C16265 N-Acetylgalactosamine 4-sulfate generic -metabolite KEGG:C16266 3-Chloro-2-hydroxymuconic semialdehyde generic -metabolite KEGG:C16267 Cyclopropanecarboxylate generic -metabolite KEGG:C16268 Cyclopropanecarboxyl-CoA generic -metabolite KEGG:C16269 (+)-epi-Isozizaene generic -metabolite KEGG:C16270 Rhodopinal generic -metabolite KEGG:C16271 Rhodopinal glucoside generic -metabolite KEGG:C16272 3-Hydroxy-5-oxohexanoate generic -metabolite KEGG:C16273 3-Hydroxy-5-oxohexanoyl-CoA generic -metabolite KEGG:C16274 (2S,2'S)-Oscillol generic -metabolite KEGG:C16275 (2S,2'S)-Oscillol 2,2'-di(alpha-L-fucoside) generic -metabolite KEGG:C16276 epsilon-Carotene generic -metabolite KEGG:C16277 R.g.-Keto I generic -metabolite KEGG:C16278 R.g.-Keto III generic -metabolite KEGG:C16279 Thiothece-474 generic -metabolite KEGG:C16280 Okenone generic -metabolite KEGG:C16281 Thiobenzamide generic -metabolite KEGG:C16282 Caloxanthin generic -metabolite KEGG:C16283 Thiobenzamide S-oxide generic -metabolite KEGG:C16284 Nostoxanthin generic -metabolite KEGG:C16285 Thiobenzamide S,S-dioxide generic -metabolite KEGG:C16286 Geosmin generic -metabolite KEGG:C16287 D-Thevetose generic -metabolite KEGG:C16288 Pelargonidin 3-O-3'',6''-O-dimalonylglucoside generic -metabolite KEGG:C16289 Cyanidin 3-O-3'',6''-O-dimalonylglucoside generic -metabolite KEGG:C16290 Delphinidin 3-O-3'',6''-O-dimalonylglucoside generic -metabolite KEGG:C16291 7,8-Dihydro-beta-carotene generic -metabolite KEGG:C16292 Cyanidin-3-(p-coumaroyl)-rutinoside-5-glucoside generic -metabolite KEGG:C16293 Peonidin-3-(p-coumaroyl)-rutinoside-5-glucoside generic -metabolite KEGG:C16294 Delphinidin-3-(p-coumaroyl)-rutinoside-5-glucoside generic -metabolite KEGG:C16295 Petunidin-3-(p-coumaroyl)-rutinoside-5-glucoside generic -metabolite KEGG:C16296 Malvidin-3-(p-coumaroyl)-rutinoside-5-glucoside generic -metabolite KEGG:C16297 Pelargonidin 3-O-(6-caffeoyl-beta-D-glucoside) generic -metabolite KEGG:C16298 Cyanidin 5-O-glucoside generic -metabolite KEGG:C16299 Malonylshisonin generic -metabolite KEGG:C16300 Stearidonic acid generic -metabolite KEGG:C16301 Delphinidin 3-O-(6''-O-malonyl)-beta-D-glucoside generic -metabolite KEGG:C16302 Ternatin A1 generic -metabolite KEGG:C16303 Ternatin C5 generic -metabolite KEGG:C16304 Delphinidin 3-O-(6''-O-malonyl)-beta-glucoside-3'-O-beta-glucoside generic -metabolite KEGG:C16305 Pelargonidin 3-O-sophoroside generic -metabolite KEGG:C16306 Cyanidin 3-O-sophoroside generic -metabolite KEGG:C16307 Delphinidin 3-O-sophoroside generic -metabolite KEGG:C16308 Traumatic acid generic -metabolite KEGG:C16309 Traumatin generic -metabolite KEGG:C16310 3-Hexenal generic -metabolite KEGG:C16311 12-Oxo-9(Z)-dodecenoic acid generic -metabolite KEGG:C16312 Delphin generic -metabolite KEGG:C16313 Delphinidin 3-glucoside 5-caffoyl-glucoside generic -metabolite KEGG:C16314 Delphinidin 3,5,3'-triglucoside generic -metabolite KEGG:C16315 Tulipanin generic -metabolite KEGG:C16316 13(S)-HOT generic -metabolite KEGG:C16317 (+)-7-Isojasmonic acid generic -metabolite KEGG:C16318 (+)-7-Isomethyljasmonate generic -metabolite KEGG:C16319 Etherolenic acid generic -metabolite KEGG:C16320 Colnelenic acid generic -metabolite KEGG:C16321 9(S)-HPOT generic -metabolite KEGG:C16322 9-Oxononanoic acid generic -metabolite KEGG:C16323 3,6-Nonadienal generic -metabolite KEGG:C16324 9,10-EOT generic -metabolite KEGG:C16325 10-OPDA generic -metabolite KEGG:C16326 9(S)-HOT generic -metabolite KEGG:C16327 OPC8-CoA generic -metabolite KEGG:C16328 trans-2-Enoyl-OPC8-CoA generic -metabolite KEGG:C16329 3-Hydroxy-OPC8-CoA generic -metabolite KEGG:C16330 3-Oxo-OPC8-CoA generic -metabolite KEGG:C16331 OPC6-CoA generic -metabolite KEGG:C16332 trans-2-Enoyl-OPC6-CoA generic -metabolite KEGG:C16333 3-Hydroxy-OPC6-CoA generic -metabolite KEGG:C16334 3-Oxo-OPC6-CoA generic -metabolite KEGG:C16335 OPC4-CoA generic -metabolite KEGG:C16336 trans-2-Enoyl-OPC4-CoA generic -metabolite KEGG:C16337 3-Hydroxy-OPC4-CoA generic -metabolite KEGG:C16338 3-Oxo-OPC4-CoA generic -metabolite KEGG:C16339 (+)-7-Isojasmonic acid CoA generic -metabolite KEGG:C16340 beta-Isorenieratene generic -metabolite KEGG:C16341 2(R)-HPOT generic -metabolite KEGG:C16342 2(R)-HOT generic -metabolite KEGG:C16343 Heptadecatrienal generic -metabolite KEGG:C16344 Norlinolenic acid generic -metabolite KEGG:C16345 Volicitin generic -metabolite KEGG:C16346 17-Hydroxylinolenic acid generic -metabolite KEGG:C16347 Deinoxanthin generic -metabolite KEGG:C16348 cis-3-Chloroallyl aldehyde generic -metabolite KEGG:C16349 Pelargonidin 3-O-beta-D-glucoside 5-O-(6-coumaroyl-beta-D-glucoside) generic -metabolite KEGG:C16350 Cyanidin 3-O-beta-D-glucoside 5-O-(6-coumaroyl-beta-D-glucoside) generic -metabolite KEGG:C16351 Delphinidin 3-O-beta-D-glucoside 5-O-(6-coumaroyl-beta-D-glucoside) generic -metabolite KEGG:C16352 7-Methylxanthosine generic -metabolite KEGG:C16353 7-Methylxanthine generic -metabolite KEGG:C16354 Albireodelphin generic -metabolite KEGG:C16355 7-Methyluric acid generic -metabolite KEGG:C16356 1,7-Dimethyluric acid generic -metabolite KEGG:C16357 3-Methylxanthine generic -metabolite KEGG:C16358 1-Methylxanthine generic -metabolite KEGG:C16359 1-Methyluric acid generic -metabolite KEGG:C16360 3,7-Dimethyluric acid generic -metabolite KEGG:C16361 1,3,7-Trimethyluric acid generic -metabolite KEGG:C16362 3,6,8-Trimethylallantoin generic -metabolite KEGG:C16363 N-Methylurea generic -metabolite KEGG:C16364 N,N'-Dimethylurea generic -metabolite KEGG:C16365 5-Acetylamino-6-formylamino-3-methyluracil generic -metabolite KEGG:C16366 5-Acetylamino-6-amino-3-methyluracil generic -metabolite KEGG:C16367 Delphinidin 3-O-(6-caffeoyl-beta-D-glucoside) generic -metabolite KEGG:C16368 Pelargonidin 3-(6-p-coumaroyl)glucoside generic -metabolite KEGG:C16369 Cyanidin 3-(6-p-caffeoyl)glucoside generic -metabolite KEGG:C16370 Delphinidin 3-(6-p-coumaroyl)glucoside generic -metabolite KEGG:C16371 Pelargonidin 3-glucoside 5-caffeoylglucoside generic -metabolite KEGG:C16372 Cyanidin 3-glucoside 5-caffeoylglucoside generic -metabolite KEGG:C16373 Cyanidin-3-O-(6''-O-malonyl-2''-O-glucuronyl)glucoside generic -metabolite KEGG:C16374 (2E,6Z,9Z,12Z,15Z,18Z,21Z)-Tetracosaheptaenoyl-CoA generic -metabolite KEGG:C16375 (3R,6Z,9Z,12Z,15Z,18Z,21Z)-3-Hydroxytetracosahexaenoyl-CoA generic -metabolite KEGG:C16376 (6Z,9Z,12Z,15Z,18Z,21Z)-3-Oxotetracosahexaenoyl-CoA generic -metabolite KEGG:C16386 (R)-Nicotine generic -metabolite KEGG:C16387 (2E,6Z,9Z,12Z,15Z,18Z)-Tetracosahexaenoyl-CoA generic -metabolite KEGG:C16388 (3R,6Z,9Z,12Z,15Z,18Z)-3-Hydroxytetracosapentaenoyl-CoA generic -metabolite KEGG:C16389 (6Z,9Z,12Z,15Z,18Z)-3-Oxotetracosapentaenoyl-CoA generic -metabolite KEGG:C16390 (S)-2-(Hydroxymethyl)glutarate generic -metabolite KEGG:C16391 Trinitrotoluene generic -metabolite KEGG:C16392 4-Hydroxylamino-2,6-dinitrotoluene generic -metabolite KEGG:C16393 2-Hydroxylamino-4,6-dinitrotoluene generic -metabolite KEGG:C16394 4-Amino-2,6-dinitrotoluene generic -metabolite KEGG:C16395 2-Amino-4,6-dinitrotoluene generic -metabolite KEGG:C16396 2,4-Diamino-6-nitrotoluene generic -metabolite KEGG:C16397 2,6-Diamino-4-nitrotoluene generic -metabolite KEGG:C16398 2-Amino-4-nitrotoluene generic -metabolite KEGG:C16399 2,4-Diamino-6-hydroxylaminotoluene generic -metabolite KEGG:C16400 2,4,6-Triaminotoluene generic -metabolite KEGG:C16401 2,4,6-Trihydroxytoluene generic -metabolite KEGG:C16402 2,4-Dihydroxylamino-6-nitrotoluene generic -metabolite KEGG:C16403 4-Amino-2-hydroxylamino-6-nitrotoluene generic -metabolite KEGG:C16404 Pinocembrin chalcone generic -metabolite KEGG:C16405 Homoeriodictyol chalcone generic -metabolite KEGG:C16406 Phlorizin chalcone generic -metabolite KEGG:C16407 2',4,4',6'-Tetrahydroxychalcone 4'-O-glucoside generic -metabolite KEGG:C16408 2',3,4,4',6'-Peptahydroxychalcone 4'-O-glucoside generic -metabolite KEGG:C16409 Aureusidin 6-O-glucoside generic -metabolite KEGG:C16410 Bracteatin 6-O-glucoside generic -metabolite KEGG:C16411 4,4',6,6'-Tetranitro-2,2'-azoxytoluene generic -metabolite KEGG:C16412 2,4',6,6'-Tetranitro-2',4-azoxytoluene generic -metabolite KEGG:C16413 2,2',6,6'-Tetranitro-4,4'-azoxytoluene generic -metabolite KEGG:C16414 2-Amino-5-hydroxyl-4-hydroxylamino-6-nitrotoluene generic -metabolite KEGG:C16415 5-Deoxyleucopelargonidin generic -metabolite KEGG:C16416 Desmethylxanthohumol generic -metabolite KEGG:C16417 Xanthohumol generic -metabolite KEGG:C16418 Pinobanksin 3-O-acetate generic -metabolite KEGG:C16419 Pinostrobin generic -metabolite KEGG:C16420 4-Acetamido-2-amino-6-nitrotoluene generic -metabolite KEGG:C16421 AI-2 generic -metabolite KEGG:C16422 Hesperetin 7-O-glucoside generic -metabolite KEGG:C16423 Naringin chalcone generic -metabolite KEGG:C16424 Isopentenyladenosine-5'-triphosphate generic -metabolite KEGG:C16426 Isopentenyladenosine-5'-diphosphate generic -metabolite KEGG:C16427 Isopentenyl adenosine generic -metabolite KEGG:C16428 trans-Zeatin riboside triphosphate generic -metabolite KEGG:C16429 trans-Zeatin riboside diphosphate generic -metabolite KEGG:C16430 trans-Zeatin riboside monophosphate generic -metabolite KEGG:C16431 trans-Zeatin riboside generic -metabolite KEGG:C16432 5-Hydroxyectoine generic -metabolite KEGG:C16433 Aspartate generic -metabolite KEGG:C16434 Isoleucine generic -metabolite KEGG:C16435 Proline generic -metabolite KEGG:C16436 Valine generic -metabolite KEGG:C16438 Asparagine generic -metabolite KEGG:C16439 Leucine generic -metabolite KEGG:C16440 Lysine generic -metabolite KEGG:C16441 cis-Zeatin riboside monophosphate generic -metabolite KEGG:C16442 Asbestos generic -metabolite KEGG:C16443 trans-Zeatin-7-beta-D-glucoside generic -metabolite KEGG:C16444 Benzidine generic -metabolite KEGG:C16445 Dihydrozeatin riboside monophosphate generic -metabolite KEGG:C16446 Chlornaphazine generic -metabolite KEGG:C16447 Dihydrozeatin riboside generic -metabolite KEGG:C16448 Dihydrozeatin-O-glucoside generic -metabolite KEGG:C16449 cis-Zeatin riboside generic -metabolite KEGG:C16450 1,3-Butadiene generic -metabolite KEGG:C16451 Coal-tar pitch generic -metabolite KEGG:C16452 N'-Nitrosonornicotine generic -metabolite KEGG:C16453 4-(N-Nitrosomethylamino)-1-(3-pyridyl)-1-butanone generic -metabolite KEGG:C16454 Radon-222 generic -metabolite KEGG:C16455 Radium-224 generic -metabolite KEGG:C16456 Radium-226 generic -metabolite KEGG:C16457 Radium-228 generic -metabolite KEGG:C16458 Shale oils generic -metabolite KEGG:C16459 Crystalline silica generic -metabolite KEGG:C16460 Beryllium generic -metabolite KEGG:C16461 Geranic acid generic -metabolite KEGG:C16462 Citronellate generic -metabolite KEGG:C16463 3',5'-Cyclic diGMP generic -metabolite KEGG:C16464 Citronellyl-CoA generic -metabolite KEGG:C16465 trans-Geranyl-CoA generic -metabolite KEGG:C16466 7-Methyl-3-oxo-6-octenoyl-CoA generic -metabolite KEGG:C16467 cis-Prenyl-tRNA generic -metabolite KEGG:C16468 (2E)-5-Methylhexa-2,4-dienoyl-CoA generic -metabolite KEGG:C16469 3-Hydroxy-5-methylhex-4-enoyl-CoA generic -metabolite KEGG:C16470 5-Methylhex-4-enoyl-CoA generic -metabolite KEGG:C16471 5-Methyl-3-oxo-4-hexenoyl-CoA generic -metabolite KEGG:C16472 3-Fluorocatechol generic -metabolite KEGG:C16473 4-Fluorocatechol generic -metabolite KEGG:C16474 3-Fluoro-cis,cis-muconate generic -metabolite KEGG:C16475 2-Fluoro-cis,cis-muconate generic -metabolite KEGG:C16476 4-Fluoromuconolactone generic -metabolite KEGG:C16477 5-Fluoromuconolactone generic -metabolite KEGG:C16478 3-Fluorocyclohexadiene-cis,cis-1,2-diol-1-carboxylate generic -metabolite KEGG:C16479 5-Fluorocyclohexadiene-cis,cis-1,2-diol-1-carboxylate generic -metabolite KEGG:C16480 4-Fluorocyclohexadiene-cis,cis-1,2-diol-1-carboxylate generic -metabolite KEGG:C16481 6-Fluorocyclohexadiene-cis,cis-1,2-diol-1-carboxylate generic -metabolite KEGG:C16482 2-Fluorocyclohexadiene-cis,cis-1,2-diol-1-carboxylate generic -metabolite KEGG:C16483 4-Fluorocyclohexadiene-cis,cis-1,2-diol generic -metabolite KEGG:C16484 1-Fluorocyclohexadiene-cis,cis-1,2-diol generic -metabolite KEGG:C16485 4-Fluorophenol generic -metabolite KEGG:C16486 Astaxanthin diester generic -metabolite KEGG:C16487 Hydrofluoric acid generic -metabolite KEGG:C16488 Fructoselysine generic -metabolite KEGG:C16489 Fructoselysine 6-phosphate generic -metabolite KEGG:C16490 Kaempferol 3-O-beta-D-glucosylgalactoside generic -metabolite KEGG:C16491 Isovitexin 2''-O-arabinoside generic -metabolite KEGG:C16492 8-C-Glucosylnaringenin generic -metabolite KEGG:C16493 3beta,5beta-Ketodiol generic -metabolite KEGG:C16494 3beta,5beta-Ketotriol generic -metabolite KEGG:C16495 2-Deoxyecdysone generic -metabolite KEGG:C16496 3-Epiecdysone generic -metabolite KEGG:C16497 3-Dehydro-2-deoxyecdysone generic -metabolite KEGG:C16498 2,22-Dideoxy-3-dehydroecdysone generic -metabolite KEGG:C16499 26-Hydroxyecdysone generic -metabolite KEGG:C16500 20,26-Dihydroxyecdysone generic -metabolite KEGG:C16501 Farnesal generic -metabolite KEGG:C16502 Farnesoic acid generic -metabolite KEGG:C16503 Methyl farnesoate generic -metabolite KEGG:C16504 Juvenile hormone III acid generic -metabolite KEGG:C16505 (10S)-Juvenile hormone III diol generic -metabolite KEGG:C16506 (10S)-Juvenile hormone III acid diol generic -metabolite KEGG:C16507 (10S)-Juvenile hormone III diol phosphate generic -metabolite KEGG:C16508 12-trans-Hydroxy juvenile hormone III generic -metabolite KEGG:C16509 14alpha-Hydroxy-5beta-cholest-7-ene-3,6-dione generic -metabolite KEGG:C16510 C5a anaphylatoxin generic -metabolite KEGG:C16511 L-Homocysteic acid generic -metabolite KEGG:C16512 Palmitoylethanolamide generic -metabolite KEGG:C16513 (7Z,10Z,13Z,16Z,19Z)-Docosapentaenoic acid generic -metabolite KEGG:C16514 Beta-amyloid protein 40 generic -metabolite KEGG:C16515 Beta-amyloid protein 42 generic -metabolite KEGG:C16516 Indolylmethylthiohydroximate generic -metabolite KEGG:C16517 Indolylmethyl-desulfoglucosinolate generic -metabolite KEGG:C16518 S-(Indolylmethylthiohydroximoyl)-L-cysteine generic -metabolite KEGG:C16519 2-Succinyl-5-enolpyruvyl-6-hydroxy-3-cyclohexene-1-carboxylate generic -metabolite KEGG:C16520 Hexadecenoyl-[acyl-carrier protein] generic -metabolite KEGG:C16521 Isoprene generic -metabolite KEGG:C16522 Icosatrienoic acid generic -metabolite KEGG:C16523 3'-N-Debenzoyl-2'-deoxytaxol generic -metabolite KEGG:C16524 3'-N-Debenzoyltaxol generic -metabolite KEGG:C16525 Icosadienoic acid generic -metabolite KEGG:C16526 Icosenoic acid generic -metabolite KEGG:C16527 Adrenic acid generic -metabolite KEGG:C16528 Docosanoyl-CoA generic -metabolite KEGG:C16529 Tetracosanoyl-CoA generic -metabolite KEGG:C16530 Icosenoyl-CoA generic -metabolite KEGG:C16531 Docosenoyl-CoA generic -metabolite KEGG:C16532 Tetracosenoyl-CoA generic -metabolite KEGG:C16533 (13Z,16Z)-Docosadienoic acid generic -metabolite KEGG:C16534 13,16,19-Docosatrienoic acid generic -metabolite KEGG:C16535 Nonadecanoic acid generic -metabolite KEGG:C16536 9E-Heptadecenoic acid generic -metabolite KEGG:C16537 Pentadecanoic acid generic -metabolite KEGG:C16538 1,5-Anhydro-D-mannitol generic -metabolite KEGG:C16540 7(1)-Hydroxychlorophyllide a generic -metabolite KEGG:C16541 Chlorophyllide b generic -metabolite KEGG:C16542 APC generic -metabolite KEGG:C16543 NPC generic -metabolite KEGG:C16544 alpha-Hydroxytamoxifen generic -metabolite KEGG:C16545 Tamoxifen N-oxide generic -metabolite KEGG:C16546 N-Desmethyltamoxifen generic -metabolite KEGG:C16547 Endoxifen generic -metabolite KEGG:C16548 N,N-Didesmethyltamoxifen generic -metabolite KEGG:C16549 alpha-Hydroxy-N-desmethyltamoxifen generic -metabolite KEGG:C16550 Dechloroethylcyclophosphamide generic -metabolite KEGG:C16551 Alcophosphamide generic -metabolite KEGG:C16552 Nornitrogen mustard generic -metabolite KEGG:C16553 4-Hydroxyifosfamide generic -metabolite KEGG:C16554 4-Ketoifosfamide generic -metabolite KEGG:C16555 2-Dechloroethylifosfamide generic -metabolite KEGG:C16556 Aldoifosfamide generic -metabolite KEGG:C16557 Carboxyifosfamide generic -metabolite KEGG:C16558 Alcoifosfamide generic -metabolite KEGG:C16559 Isophosphoramide mustard generic -metabolite KEGG:C16560 3-Hydroxylidocaine generic -metabolite KEGG:C16561 Monoethylglycinexylidide generic -metabolite KEGG:C16562 Glutathionylspermine generic -metabolite KEGG:C16563 Bis(glutathionyl)spermine generic -metabolite KEGG:C16564 Bis(glutathionyl)spermine disulfide generic -metabolite KEGG:C16565 Aminopropylcadaverine generic -metabolite KEGG:C16566 Glutathionylaminopropylcadaverine generic -metabolite KEGG:C16567 Homotrypanothione generic -metabolite KEGG:C16568 Homotrypanothione disulfide generic -metabolite KEGG:C16569 Glycinexylidide generic -metabolite KEGG:C16570 4-Hydroxy-2,6-dimethylaniline generic -metabolite KEGG:C16571 2-Amino-3-methylbenzoate generic -metabolite KEGG:C16572 3-Hydroxymonoethylglycinexylidide generic -metabolite KEGG:C16573 3'-Hydroxyropivacaine generic -metabolite KEGG:C16574 4'-Hydroxyropivacaine generic -metabolite KEGG:C16575 (S)-2',6'-Pipecoloxylidide generic -metabolite KEGG:C16576 Norcodeine generic -metabolite KEGG:C16577 Codeine-6-glucuronide generic -metabolite KEGG:C16578 Morphine-6-glucuronide generic -metabolite KEGG:C16579 trans-Homoaconitate generic -metabolite KEGG:C16581 D-threo-Aldono-1,5-lactone generic -metabolite KEGG:C16582 2-Hydroxyfelbamate generic -metabolite KEGG:C16583 (R)-(Homo)2-citrate generic -metabolite KEGG:C16584 p-Hydroxyfelbamate generic -metabolite KEGG:C16586 2-Phenyl-1,3-propanediol monocarbamate generic -metabolite KEGG:C16587 3-Carbamoyl-2-phenylpropionaldehyde generic -metabolite KEGG:C16588 2-Oxopimelate generic -metabolite KEGG:C16589 2-Oxosuberate generic -metabolite KEGG:C16590 7-Oxoheptanoic acid generic -metabolite KEGG:C16591 3-Carbamoyl-2-phenylpropionic acid generic -metabolite KEGG:C16592 Atropaldehyde generic -metabolite KEGG:C16593 7-Mercaptoheptanoic acid generic -metabolite KEGG:C16594 7-Mercaptoheptanoylthreonine generic -metabolite KEGG:C16595 4-Hydroxy-5-phenyltetrahydro-1,3-oxazin-2-one generic -metabolite KEGG:C16596 5-Phenyl-1,3-oxazinane-2,4-dione generic -metabolite KEGG:C16597 (-)-threo-Iso(homo)2-citrate generic -metabolite KEGG:C16598 (R)-(Homo)3-citrate generic -metabolite KEGG:C16600 (-)-threo-Iso(homo)3-citrate generic -metabolite KEGG:C16601 2-Hydroxycarbamazepine generic -metabolite KEGG:C16602 3-Hydroxycarbamazepine generic -metabolite KEGG:C16603 2,3-Dihydroxycarbamazepine generic -metabolite KEGG:C16604 2-Hydroxyiminostilbene generic -metabolite KEGG:C16605 2H-Dibenz[b,f]azepin-2-one generic -metabolite KEGG:C16606 Carbamazepine-o-quinone generic -metabolite KEGG:C16607 Citalopram N-oxide generic -metabolite KEGG:C16608 Demethylcitalopram generic -metabolite KEGG:C16609 Didemethylcitalopram generic -metabolite KEGG:C16610 Citalopram propionic acid generic -metabolite KEGG:C16611 Citalopram alcohol generic -metabolite KEGG:C16612 Citalopram aldehyde generic -metabolite KEGG:C16613 6-Thiourate generic -metabolite KEGG:C16614 6-Methylmercaptopurine generic -metabolite KEGG:C16615 6-Methylthiopurine 5'-monophosphate ribonucleotide generic -metabolite KEGG:C16616 6-Mercaptopurine ribonucleoside 5'-diphosphate generic -metabolite KEGG:C16617 6-Mercaptopurine ribonucleoside triphosphate generic -metabolite KEGG:C16618 6-Thioxanthine 5'-monophosphate generic -metabolite KEGG:C16619 6-Thioguanosine monophosphate generic -metabolite KEGG:C16620 6-Methylthioguanosine monophosphate generic -metabolite KEGG:C16621 1-Methyl-4-nitroimidazole generic -metabolite KEGG:C16622 N,N'-Diacetylhydrazine generic -metabolite KEGG:C16623 Isonicotinylglycine generic -metabolite KEGG:C16624 Isoniazid pyruvate generic -metabolite KEGG:C16625 Isoniazid alpha-ketoglutaric acid generic -metabolite KEGG:C16626 Albendazole sulfone generic -metabolite KEGG:C16627 Albendazole-2-aminosulfone generic -metabolite KEGG:C16628 Albendazole-beta-hydroxysulphone generic -metabolite KEGG:C16629 Albendazole-gamma-hydroxysulphone generic -metabolite KEGG:C16630 5,6-Dihydro-5-fluorouracil generic -metabolite KEGG:C16631 alpha-Fluoro-beta-ureidopropionic acid generic -metabolite KEGG:C16632 alpha-Fluoro-beta-alanine generic -metabolite KEGG:C16633 5-Fluorouridine generic -metabolite KEGG:C16634 5-Fluorouridine monophosphate generic -metabolite KEGG:C16635 5'-Deoxy-5-fluorocytidine generic -metabolite KEGG:C16636 tRNA(Sec) generic -metabolite KEGG:C16637 5-Deoxyribose-1-phosphate generic -metabolite KEGG:C16638 O-Phosphoseryl-tRNA(Sec) generic -metabolite KEGG:C16639 beta-D-Ribofuranose generic -metabolite KEGG:C16640 CAI-1 generic -metabolite KEGG:C16641 Irinotecan generic -metabolite KEGG:C16643 Morphine-3-glucuronide generic -metabolite KEGG:C16644 1-(3,4-Dimethoxyphenyl)ethane-1,2-diol generic -metabolite KEGG:C16645 (13Z,16Z)-Docosadienoyl-CoA generic -metabolite KEGG:C16647 N,N-Diethylglycine generic -metabolite KEGG:C16648 2-n-Propyl-4-pentenoic acid generic -metabolite KEGG:C16649 4-Hydroxyvalproic acid generic -metabolite KEGG:C16650 5-Hydroxyvalproic acid generic -metabolite KEGG:C16651 3-Hydroxyvalproic acid generic -metabolite KEGG:C16652 3-Oxovalproic acid generic -metabolite KEGG:C16653 2-n-Propyl-2-pentenoic acid generic -metabolite KEGG:C16654 2-n-Propyl-3-pentenoic acid generic -metabolite KEGG:C16655 2-n-Propyl-4-oxopentanoic acid generic -metabolite KEGG:C16656 2-Propyl-2,4-pentadienoic acid generic -metabolite KEGG:C16657 2-Propylsuccinic acid generic -metabolite KEGG:C16658 2-Propylglutaric acid generic -metabolite KEGG:C16659 2-Ethylidene-1,5-dimethyl-3,3-diphenylpyrrolidine generic -metabolite KEGG:C16660 2-Ethyl-5-methyl-3,3-diphenyl-1-pyrroline generic -metabolite KEGG:C16661 L-alpha-Acetyl-N-normethadol generic -metabolite KEGG:C16662 L-alpha-Acetyl-N,N-dinormethadol generic -metabolite KEGG:C16663 Tryparedoxin generic -metabolite KEGG:C16664 Tryparedoxin disulfide generic -metabolite KEGG:C16665 12-Methyltetradecanoic acid generic -metabolite KEGG:C16666 Vanillylamine generic -metabolite KEGG:C16667 1,2-Dimyristyl-sn-glycerol generic -metabolite KEGG:C16669 Oligonucleotide 5'-diphosphate generic -metabolite KEGG:C16671 3,6-Dihydronicotinic acid generic -metabolite KEGG:C16672 Benzylpenicilloic acid generic -metabolite KEGG:C16673 Isoglutamine generic -metabolite KEGG:C16674 Formylisoglutamine generic -metabolite KEGG:C16675 7-Aminomethyl-7-carbaguanine generic -metabolite KEGG:C16676 N6-Alkylaminopurine-9-beta-D-glucoside generic -metabolite KEGG:C16677 all-trans-4-Hydroxyretinoic acid generic -metabolite KEGG:C16678 all-trans-4-Oxoretinoic acid generic -metabolite KEGG:C16679 all-trans-18-Hydroxyretinoic acid generic -metabolite KEGG:C16680 all-trans-5,6-Epoxyretinoic acid generic -metabolite KEGG:C16681 9-cis-Retinal generic -metabolite KEGG:C16682 9-cis-Retinol generic -metabolite KEGG:C16683 4-Oxoretinol generic -metabolite KEGG:C16684 N-Acetoxyarylamine generic -metabolite KEGG:C16685 N-Hydroxyarylamine generic -metabolite KEGG:C16687 Phosphomannan mannosephosphate generic -metabolite KEGG:C16688 Sucrose 6-phosphate generic -metabolite KEGG:C16689 poly-cis-Polyprenyl diphosphate longer by one C5 unit generic -metabolite KEGG:C16690 5-L-Glutamyl-D-glutamyl-peptide generic -metabolite KEGG:C16691 DNA 2,6-diamino-5-formamido-3,4-dihydro-4-oxopyrimidine generic -metabolite KEGG:C16692 Mannopine generic -metabolite KEGG:C16693 Plastoquinol generic -metabolite KEGG:C16694 Plastoquinone-1 generic -metabolite KEGG:C16695 Plastoquinol-9 generic -metabolite KEGG:C16696 Dolichotheline generic -metabolite KEGG:C16697 1-Indolizidinone generic -metabolite KEGG:C16698 N-Acetylmuramic acid 6-phosphate generic -metabolite KEGG:C16699 2-O-(6-Phospho-alpha-mannosyl)-D-glycerate generic -metabolite KEGG:C16700 3,4-Dihydroxybenzaldehyde generic -metabolite KEGG:C16701 Norbelladine generic -metabolite KEGG:C16702 4'-O-Methylnorbelladine generic -metabolite KEGG:C16703 N-Demethylnarwedine generic -metabolite KEGG:C16704 Anhalonidine generic -metabolite KEGG:C16705 Anhalonine generic -metabolite KEGG:C16706 4-Hydroxydihydrocinnamaldehyde generic -metabolite KEGG:C16707 (S)-Autumnaline generic -metabolite KEGG:C16708 Isoandrocymbine generic -metabolite KEGG:C16709 O-Methylandrocymbine generic -metabolite KEGG:C16710 N-Formyldemecolcine generic -metabolite KEGG:C16711 Vitamin K epoxide generic -metabolite KEGG:C16712 Deacetylcolchicine generic -metabolite KEGG:C16713 Floramultine generic -metabolite KEGG:C16714 Kreysigine generic -metabolite KEGG:C16715 2-Oxo-1,2-dihydroquinoline-4-carboxylate generic -metabolite KEGG:C16716 4-Hydroxy-2-quinolone generic -metabolite KEGG:C16717 Limonoate D-ring-lactone generic -metabolite KEGG:C16718 Limonoate A-ring-lactone generic -metabolite KEGG:C16719 (-)-Norephedrine generic -metabolite KEGG:C16720 Peptide 2-[3-carboxy-3-(dimethylammonio)propyl]-L-histidine generic -metabolite KEGG:C16721 Platydesmine generic -metabolite KEGG:C16722 Acceptor generic -metabolite KEGG:C16723 Pumiloside generic -metabolite KEGG:C16724 Strictosamide generic -metabolite KEGG:C16725 Deoxypumiloside generic -metabolite KEGG:C16726 Cinchoninone generic -metabolite KEGG:C16727 Cinchonamine generic -metabolite KEGG:C16728 Quinidinone generic -metabolite KEGG:C16729 [Thyroglobulin]-L-thyroxine generic -metabolite KEGG:C16730 Thyroglobulin triiodothyronine generic -metabolite KEGG:C16731 [Thyroglobulin]-3,5-diiodo-L-tyrosine generic -metabolite KEGG:C16732 [Thyroglobulin]-3-iodo-L-tyrosine generic -metabolite KEGG:C16733 [Thyroglobulin]-L-tyrosine generic -metabolite KEGG:C16734 Thyroglobulin dehydroalanine generic -metabolite KEGG:C16735 Corynantheal generic -metabolite KEGG:C16736 Thiol-containing reductant generic -metabolite KEGG:C16737 5-Deoxy-D-glucuronate generic -metabolite KEGG:C16738 Sulfuric monoester generic -metabolite KEGG:C16739 L-Arginyl-protein generic -metabolite KEGG:C16740 Procollagen L-lysine generic -metabolite KEGG:C16741 L-Hydroxylysine generic -metabolite KEGG:C16742 allo-Hydroxy-L-lysine generic -metabolite KEGG:C16743 Phosphoallohydroxy-L-lysine generic -metabolite KEGG:C16744 Spongothymidine generic -metabolite KEGG:C16745 Spongouridine generic -metabolite KEGG:C16746 Discodermolide generic -metabolite KEGG:C16747 Spergualin generic -metabolite KEGG:C16748 Patulin generic -metabolite KEGG:C16749 Acetylgitaloxin generic -metabolite KEGG:C16750 Acetylintermedine generic -metabolite KEGG:C16751 Acetyllycopsamine generic -metabolite KEGG:C16752 Acevaltrate generic -metabolite KEGG:C16753 Aflatoxin B2 generic -metabolite KEGG:C16754 Aflatoxin G2 generic -metabolite KEGG:C16755 Aflatoxin G1 generic -metabolite KEGG:C16756 Aflatoxin M1 generic -metabolite KEGG:C16757 (Z)-Ajoene generic -metabolite KEGG:C16758 (E)-Ajoene generic -metabolite KEGG:C16759 S-Allyl-L-cysteine generic -metabolite KEGG:C16760 Aloe emodin anthrone generic -metabolite KEGG:C16761 Neosurugatoxin generic -metabolite KEGG:C16762 Ciguatoxin I generic -metabolite KEGG:C16763 Luteoskyrin generic -metabolite KEGG:C16764 Rugulosin generic -metabolite KEGG:C16765 Citrinin generic -metabolite KEGG:C16766 Citreoviridin generic -metabolite KEGG:C16767 Rubratoxin B generic -metabolite KEGG:C16768 Sporidesmin J generic -metabolite KEGG:C16769 Aplysiatoxin generic -metabolite KEGG:C16770 19-Bromoaplysiatoxin generic -metabolite KEGG:C16771 Oscillatoxin A generic -metabolite KEGG:C16772 alpha-Terpineol generic -metabolite KEGG:C16773 Bisabolol oxide A generic -metabolite KEGG:C16774 Bisabolol oxide B generic -metabolite KEGG:C16775 (S)-beta-Bisabolene generic -metabolite KEGG:C16776 beta-Sesquiphellandrene generic -metabolite KEGG:C16777 Sabinene generic -metabolite KEGG:C16778 Cantharidin generic -metabolite KEGG:C16779 Dendrolasin generic -metabolite KEGG:C16780 Jasmolin I generic -metabolite KEGG:C16781 Jasmolin II generic -metabolite KEGG:C16782 (-)-Solenopsin A generic -metabolite KEGG:C16783 Meliantriol generic -metabolite KEGG:C16784 HMT-toxin generic -metabolite KEGG:C16785 PM-toxin B generic -metabolite KEGG:C16786 AM-toxin I generic -metabolite KEGG:C16787 AK-toxin I generic -metabolite KEGG:C16788 Pyriculol generic -metabolite KEGG:C16789 Toxoflavine generic -metabolite KEGG:C16790 Coronatine generic -metabolite KEGG:C16791 Halichondrin B generic -metabolite KEGG:C16792 Panaxytriol generic -metabolite KEGG:C16793 Corynomycolic acid generic -metabolite KEGG:C16794 Tuberculostearic acid generic -metabolite KEGG:C16795 Hydnocarpic acid generic -metabolite KEGG:C16796 Islandicin generic -metabolite KEGG:C16797 Sennoside C generic -metabolite KEGG:C16798 Sennoside D generic -metabolite KEGG:C16799 Cascaroside B generic -metabolite KEGG:C16800 Cascaroside D generic -metabolite KEGG:C16801 Cascaroside C generic -metabolite KEGG:C16802 Glucofrangulin A generic -metabolite KEGG:C16803 Glucofrangulin B generic -metabolite KEGG:C16804 Penicillic acid generic -metabolite KEGG:C16805 Coumachlor generic -metabolite KEGG:C16806 Coumatetralyl generic -metabolite KEGG:C16807 Difenacoum generic -metabolite KEGG:C16808 Isosilybin generic -metabolite KEGG:C16809 Isovaltrate generic -metabolite KEGG:C16810 Bioresmethrin generic -metabolite KEGG:C16811 Baldrinal generic -metabolite KEGG:C16812 Homobaldrinal generic -metabolite KEGG:C16813 Valeranone generic -metabolite KEGG:C16814 gamma-Bisabolene generic -metabolite KEGG:C16815 alpha-Cadinene generic -metabolite KEGG:C16816 Ginkgolide M generic -metabolite KEGG:C16817 Goitrin generic -metabolite KEGG:C16818 Ophiobolin F generic -metabolite KEGG:C16819 Neotigogenin generic -metabolite KEGG:C16820 k-Strophanthin-beta generic -metabolite KEGG:C16821 Guvacoline generic -metabolite KEGG:C16822 9-Aminocamptothecin generic -metabolite KEGG:C16823 Distigmine generic -metabolite KEGG:C16825 Neomenthyl acetate generic -metabolite KEGG:C16826 2-cis,6-trans-Farnesyl diphosphate generic -metabolite KEGG:C16827 p-Coumaroyl-D-glucose generic -metabolite KEGG:C16828 Caffeoquinone generic -metabolite KEGG:C16829 gamma-Humulene generic -metabolite KEGG:C16830 D-Aldonolactone generic -metabolite KEGG:C16831 L-2-Methyltryptophan generic -metabolite KEGG:C16832 Protein N6-(dihydrolipoyl)lysine generic -metabolite KEGG:C16833 beta-Phenylalanoyl-CoA generic -metabolite KEGG:C16834 1-Pentanol generic -metabolite KEGG:C16835 Succinic aldehyde generic -metabolite KEGG:C16836 1,4'-Bipiperidine-1'-carboxylic acid generic -metabolite KEGG:C16837 4-Amino-1-piperidinecarboxylic acid generic -metabolite KEGG:C16838 Alternariol generic -metabolite KEGG:C16839 Brevetoxin A generic -metabolite KEGG:C16840 Eudistomin G generic -metabolite KEGG:C16841 Squalamine generic -metabolite KEGG:C16842 SQ 26180 generic -metabolite KEGG:C16843 Deoxynojirimycin generic -metabolite KEGG:C16844 Hydroxyl radical generic -metabolite KEGG:C16845 Peroxynitrite generic -metabolite KEGG:C16846 Cinchonidinone generic -metabolite KEGG:C16847 Didemnin B generic -metabolite KEGG:C16848 6-Deoxy-5-ketofructose 1-phosphate generic -metabolite KEGG:C16849 Hydroxypyruvaldehyde phosphate generic -metabolite KEGG:C16850 2-Amino-3,7-dideoxy-D-threo-hept-6-ulosonic acid generic -metabolite KEGG:C16851 Palytoxin generic -metabolite KEGG:C16852 Gambiertoxin 4b generic -metabolite KEGG:C16854 Maitotoxin generic -metabolite KEGG:C16855 Gonyautoxin 1 generic -metabolite KEGG:C16856 Gonyautoxin 2 generic -metabolite KEGG:C16857 Brevetoxin B generic -metabolite KEGG:C16858 Pachydictyol A generic -metabolite KEGG:C16859 Renillafoulin A generic -metabolite KEGG:C16860 2,5,6-Tribromo-1-methylgramine generic -metabolite KEGG:C16861 13-Deoxytedanolide generic -metabolite KEGG:C16862 Plitidepsin generic -metabolite KEGG:C16865 Scytophycin C generic -metabolite KEGG:C16868 Tauroursodeoxycholic acid generic -metabolite KEGG:C16870 Dinophysistoxin 1 generic -metabolite KEGG:C16871 Pectenotoxin 1 generic -metabolite KEGG:C16872 Yessotoxin generic -metabolite KEGG:C16873 Bombykol generic -metabolite KEGG:C16874 Makisterone A generic -metabolite KEGG:C16875 Trabectedin generic -metabolite KEGG:C16876 Kahalalide F generic -metabolite KEGG:C16877 Cryptophycin 1 generic -metabolite KEGG:C16878 Aplyronine A generic -metabolite KEGG:C16880 S 1319 generic -metabolite KEGG:C16881 Isohomohalichondrin B generic -metabolite KEGG:C16883 Jasplakinolide generic -metabolite KEGG:C16884 D-Threitol generic -metabolite KEGG:C16885 Gambieric acid A generic -metabolite KEGG:C16886 Gambieric acid B generic -metabolite KEGG:C16887 Gambieric acid C generic -metabolite KEGG:C16888 Gambieric acid D generic -metabolite KEGG:C16889 Pahutoxin generic -metabolite KEGG:C16890 5alpha-Cyprinol generic -metabolite KEGG:C16891 Callystatin A generic -metabolite KEGG:C16892 KRN 7000 generic -metabolite KEGG:C16893 Stellettamide A generic -metabolite KEGG:C16894 Plakinamine A generic -metabolite KEGG:C16895 Plakinamine B generic -metabolite KEGG:C16896 Nakitriol generic -metabolite KEGG:C16899 Goniodomin A generic -metabolite KEGG:C16901 Latrunculin A generic -metabolite KEGG:C16902 Mycalolide B generic -metabolite KEGG:C16903 Perazine generic -metabolite KEGG:C16904 Tolytoxin generic -metabolite KEGG:C16905 Dolastatin 11 generic -metabolite KEGG:C16906 Anabaseine generic -metabolite KEGG:C16907 Azaspiracid generic -metabolite KEGG:C16908 Caryophyllene epoxide generic -metabolite KEGG:C16909 1,4-Cineole generic -metabolite KEGG:C16910 Acutumine generic -metabolite KEGG:C16911 Afzelin generic -metabolite KEGG:C16912 Alphitolic acid generic -metabolite KEGG:C16913 Anemonin generic -metabolite KEGG:C16914 Isobyakangelicol generic -metabolite KEGG:C16915 Arctiin generic -metabolite KEGG:C16916 Arundoin generic -metabolite KEGG:C16918 Atractylodin generic -metabolite KEGG:C16919 Atractylone generic -metabolite KEGG:C16920 Bornyl isovalerate generic -metabolite KEGG:C16921 Bufadienolide generic -metabolite KEGG:C16922 Bufalin generic -metabolite KEGG:C16923 Bufotalin generic -metabolite KEGG:C16924 Butylidenephthalide generic -metabolite KEGG:C16925 Byakangelicol generic -metabolite KEGG:C16926 Capillarin generic -metabolite KEGG:C16927 Capillene generic -metabolite KEGG:C16928 Capillone generic -metabolite KEGG:C16929 Catalpalactone generic -metabolite KEGG:C16930 Chavicol generic -metabolite KEGG:C16931 Cinobufagin generic -metabolite KEGG:C16932 Cinobufotalin generic -metabolite KEGG:C16933 3,6-Dihydropyridine generic -metabolite KEGG:C16937 Cnidilide generic -metabolite KEGG:C16938 Coptisine generic -metabolite KEGG:C16939 Crataegolic acid generic -metabolite KEGG:C16940 Carthamidin generic -metabolite KEGG:C16941 Carthamin generic -metabolite KEGG:C16942 Curcumenol generic -metabolite KEGG:C16943 Curzerenone generic -metabolite KEGG:C16945 Cyperol generic -metabolite KEGG:C16946 Cyperolone generic -metabolite KEGG:C16947 Decanoyl acetaldehyde generic -metabolite KEGG:C16949 Dehydrocurdione generic -metabolite KEGG:C16950 Dehydroeburicoic acid generic -metabolite KEGG:C16951 Deoxyschizandrin generic -metabolite KEGG:C16952 Dihydrocapsaicin generic -metabolite KEGG:C16953 Dihydrocorynantheine generic -metabolite KEGG:C16954 Disinomenine generic -metabolite KEGG:C16955 Eucarvone generic -metabolite KEGG:C16956 Evocarpine generic -metabolite KEGG:C16957 Fargesin generic -metabolite KEGG:C16958 Fernenol generic -metabolite KEGG:C16959 Furanodiene generic -metabolite KEGG:C16960 Furanodienone generic -metabolite KEGG:C16962 Gamabufogenin generic -metabolite KEGG:C16963 Gardoside generic -metabolite KEGG:C16964 Gastrodin generic -metabolite KEGG:C16965 Genipin 1-beta-gentiobioside generic -metabolite KEGG:C16966 Germacrone generic -metabolite KEGG:C16967 Glutinone generic -metabolite KEGG:C16968 Glycyrol generic -metabolite KEGG:C16969 Hellebrigenin generic -metabolite KEGG:C16970 Hinesol generic -metabolite KEGG:C16971 Hirsuteine generic -metabolite KEGG:C16972 Hirsutine generic -metabolite KEGG:C16973 Isoarborinol generic -metabolite KEGG:C16974 Isocyperol generic -metabolite KEGG:C16975 Isoelemicin generic -metabolite KEGG:C16976 Isoimperatorin generic -metabolite KEGG:C16977 Isokobusone generic -metabolite KEGG:C16978 Isoliquiritin generic -metabolite KEGG:C16979 Isomangiferin generic -metabolite KEGG:C16980 Isorhynchophylline generic -metabolite KEGG:C16981 Kaempferitrin generic -metabolite KEGG:C16982 Kakuol generic -metabolite KEGG:C16983 Kobusone generic -metabolite KEGG:C16984 Laurolitsine generic -metabolite KEGG:C16985 Leonurine generic -metabolite KEGG:C16986 Licoricidin generic -metabolite KEGG:C16987 Ligustilide generic -metabolite KEGG:C16988 Linderenol generic -metabolite KEGG:C16989 Liquiritin generic -metabolite KEGG:C16990 Lupenone generic -metabolite KEGG:C16991 Magnocurarine generic -metabolite KEGG:C16992 Callinecdysone A generic -metabolite KEGG:C16993 Ectocarpen generic -metabolite KEGG:C16994 Anthopleurine generic -metabolite KEGG:C16995 Methyl palmitate generic -metabolite KEGG:C16996 Methyl nigakinone generic -metabolite KEGG:C16997 Michelalbine generic -metabolite KEGG:C16998 Pavoninin 1 generic -metabolite KEGG:C16999 Futalosine generic -metabolite KEGG:C17000 Morroniside generic -metabolite KEGG:C17002 Neocnidilide generic -metabolite KEGG:C17003 Neogitogenin generic -metabolite KEGG:C17004 Kalihinol A generic -metabolite KEGG:C17005 Callytriol C generic -metabolite KEGG:C17007 Axisothiocyanate 3 generic -metabolite KEGG:C17008 Mycalamide A generic -metabolite KEGG:C17009 Mycalamide B generic -metabolite KEGG:C17010 Dehypoxanthine futalosine generic -metabolite KEGG:C17011 Leonuridine generic -metabolite KEGG:C17012 Nigakilactone A generic -metabolite KEGG:C17013 Nigakilactone B generic -metabolite KEGG:C17016 Nemertelline generic -metabolite KEGG:C17017 Cyclic dehypoxanthine futalosine generic -metabolite KEGG:C17018 1,4-Dihydroxy-6-naphthoate generic -metabolite KEGG:C17019 Navenone A generic -metabolite KEGG:C17020 Navenone B generic -metabolite KEGG:C17021 Navenone C generic -metabolite KEGG:C17022 O-Phosphoseryl-tRNA(Cys) generic -metabolite KEGG:C17023 Sulfur donor generic -metabolite KEGG:C17024 Mosesin 4 generic -metabolite KEGG:C17025 Holothurin generic -metabolite KEGG:C17027 L-Pyrrolysyl-tRNA(Pyl) generic -metabolite KEGG:C17029 Nigakilactone C generic -metabolite KEGG:C17030 Nigakilactone E generic -metabolite KEGG:C17031 Nigakilactone F generic -metabolite KEGG:C17032 Nigakilactone H generic -metabolite KEGG:C17033 Nigakilactone K generic -metabolite KEGG:C17034 Nigakilactone L generic -metabolite KEGG:C17035 Nigakilactone M generic -metabolite KEGG:C17036 Nigakilactone N generic -metabolite KEGG:C17038 Ophiopogonin B generic -metabolite KEGG:C17039 Obtusifolin generic -metabolite KEGG:C17040 Obtusin generic -metabolite KEGG:C17041 Ophiopogonin A generic -metabolite KEGG:C17042 Ophiopogonin D generic -metabolite KEGG:C17043 Ophiopogonin C generic -metabolite KEGG:C17044 Pachymic acid generic -metabolite KEGG:C17045 Physcion generic -metabolite KEGG:C17046 Phellodendrine generic -metabolite KEGG:C17047 Phellopterin generic -metabolite KEGG:C17048 Forsythin generic -metabolite KEGG:C17049 Picrasin A generic -metabolite KEGG:C17050 Picrasin B generic -metabolite KEGG:C17051 Picrasin D generic -metabolite KEGG:C17052 Picrasin E generic -metabolite KEGG:C17053 Picrasin F generic -metabolite KEGG:C17054 Picrasin G generic -metabolite KEGG:C17055 Picrocrocin generic -metabolite KEGG:C17056 Plantaginin generic -metabolite KEGG:C17057 Puerarin xyloside generic -metabolite KEGG:C17058 Resibufogenin generic -metabolite KEGG:C17059 Rhamnocitrin generic -metabolite KEGG:C17060 Isotetrandrine generic -metabolite KEGG:C17061 Rubidium cation generic -metabolite KEGG:C17062 Safranal generic -metabolite KEGG:C17063 Salicifoline generic -metabolite KEGG:C17064 Schizandrin generic -metabolite KEGG:C17065 Sesquicarene generic -metabolite KEGG:C17066 Shanzhiside generic -metabolite KEGG:C17067 Siaresinol generic -metabolite KEGG:C17068 Valerosidatum generic -metabolite KEGG:C17069 Sophoranol generic -metabolite KEGG:C17070 Sumaresinol generic -metabolite KEGG:C17071 Sweroside generic -metabolite KEGG:C17072 Telocinobufagin generic -metabolite KEGG:C17073 Terpineol-4 generic -metabolite KEGG:C17074 Timosaponin A-I generic -metabolite KEGG:C17075 Timosaponin A-III generic -metabolite KEGG:C17076 Tridecanoic acid generic -metabolite KEGG:C17077 Tuduranine generic -metabolite KEGG:C17079 3-Bromo-tyrosine generic -metabolite KEGG:C17080 3,5-Dibromo-tyrosine generic -metabolite KEGG:C17083 Worenine generic -metabolite KEGG:C17084 6,6'-Dibromoindigotin generic -metabolite KEGG:C17085 Zederone generic -metabolite KEGG:C17086 Tyrindoxyl sulfate generic -metabolite KEGG:C17087 dTDP-(3R)-amino-3,6-dideoxy-D-glucose generic -metabolite KEGG:C17088 alpha-Bergamotene generic -metabolite KEGG:C17089 6-Chloroindole generic -metabolite KEGG:C17090 alpha-Cyperone generic -metabolite KEGG:C17091 alpha-Sanshool generic -metabolite KEGG:C17092 Clionamide generic -metabolite KEGG:C17093 dTDP-3-amino-4,6-dideoxy-3,4-dehydroglucose generic -metabolite KEGG:C17094 beta-Elemene generic -metabolite KEGG:C17097 Caulerpin generic -metabolite KEGG:C17098 Lanosol generic -metabolite KEGG:C17099 Aeroplysinin 1 generic -metabolite KEGG:C17100 Thelepin generic -metabolite KEGG:C17101 3,5-Dinitroguaiacol generic -metabolite KEGG:C17102 Cartilagineal generic -metabolite KEGG:C17103 Costatol generic -metabolite KEGG:C17104 Costatone generic -metabolite KEGG:C17105 Plocamene D generic -metabolite KEGG:C17106 Mertensene generic -metabolite KEGG:C17107 Violacene generic -metabolite KEGG:C17108 Plocamene E generic -metabolite KEGG:C17109 Plocamene C generic -metabolite KEGG:C17110 Plocamene B generic -metabolite KEGG:C17111 Caespitol generic -metabolite KEGG:C17112 Isocaespitol generic -metabolite KEGG:C17113 Furocaespitane generic -metabolite KEGG:C17114 Spirolaurenone generic -metabolite KEGG:C17116 Nidificene generic -metabolite KEGG:C17117 Nidifidienol generic -metabolite KEGG:C17118 Elatol generic -metabolite KEGG:C17120 beta-Gurjunene generic -metabolite KEGG:C17121 Obtusol generic -metabolite KEGG:C17123 epi-Friedelanol generic -metabolite KEGG:C17124 gamma-Eudesmol generic -metabolite KEGG:C17125 (-)-Isomenthone generic -metabolite KEGG:C17126 Neobyakangelicol generic -metabolite KEGG:C17127 Prepacifenol epoxide generic -metabolite KEGG:C17132 Aplysin generic -metabolite KEGG:C17133 Filiformin generic -metabolite KEGG:C17135 Filiforminol generic -metabolite KEGG:C17136 Laurinterol generic -metabolite KEGG:C17139 dTDP-3,4-dioxo-2,6-dideoxy-L-glucose generic -metabolite KEGG:C17140 Tribuloside generic -metabolite KEGG:C17141 [Heparan sulfate]-glucosamine generic -metabolite KEGG:C17142 [Heparan sulfate]-N-sulfoglucosamine generic -metabolite KEGG:C17144 3-Octanol generic -metabolite KEGG:C17145 3-Octanone generic -metabolite KEGG:C17146 4-Guanidino-1-butanol generic -metabolite KEGG:C17147 Neochlorogenic acid generic -metabolite KEGG:C17148 Oleanolic acid generic -metabolite KEGG:C17156 Manoalide generic -metabolite KEGG:C17158 Plakortic acid generic -metabolite KEGG:C17159 Halistanol sulfate generic -metabolite KEGG:C17160 Fistularin 1 generic -metabolite KEGG:C17161 Fistularin 2 generic -metabolite KEGG:C17162 Aerophobin 1 generic -metabolite KEGG:C17163 Aerophobin 2 generic -metabolite KEGG:C17166 Sceptrin generic -metabolite KEGG:C17167 Eudistomin C generic -metabolite KEGG:C17168 Eudistomin H generic -metabolite KEGG:C17169 Eudistomin N generic -metabolite KEGG:C17177 Aplysinal generic -metabolite KEGG:C17179 beta-Snyderol generic -metabolite KEGG:C17181 Kylinone generic -metabolite KEGG:C17184 Rhodolaureol generic -metabolite KEGG:C17193 Heterocladol generic -metabolite KEGG:C17202 S-Palmitoylprotein generic -metabolite KEGG:C17203 N-Hydroxyl-tryptamine generic -metabolite KEGG:C17204 Indole-3-acetaldoxime N-oxide generic -metabolite KEGG:C17205 (R)-2-O-Sulfolactate generic -metabolite KEGG:C17206 Uracil 5-carbaldehyde generic -metabolite KEGG:C17207 1,4-beta-D-Mannooligosaccharide generic -metabolite KEGG:C17208 Neosaxitoxin generic -metabolite KEGG:C17209 2-Deoxy-scyllo-inosose generic -metabolite KEGG:C17210 2-(2'-Methylthio)ethylmalic acid generic -metabolite KEGG:C17211 2-Oxo-5-methylthiopentanoic acid generic -metabolite KEGG:C17212 3-(2'-Methylthio)ethylmalic acid generic -metabolite KEGG:C17213 Homomethionine generic -metabolite KEGG:C17214 2-(3'-Methylthio)propylmalic acid generic -metabolite KEGG:C17215 3-(3'-Methylthio)propylmalic acid generic -metabolite KEGG:C17216 2-Oxo-6-methylthiohexanoic acid generic -metabolite KEGG:C17217 Dihomomethionine generic -metabolite KEGG:C17218 2-(4'-Methylthio)butylmalic acid generic -metabolite KEGG:C17219 3-(4'-Methylthio)butylmalic acid generic -metabolite KEGG:C17220 2-Oxo-7-methylthioheptanoic acid generic -metabolite KEGG:C17221 Trihomomethionine generic -metabolite KEGG:C17222 2-(5'-Methylthio)pentylmalic acid generic -metabolite KEGG:C17223 3-(5'-Methylthio)pentylmalic acid generic -metabolite KEGG:C17224 2-Oxo-8-methylthiooctanoic acid generic -metabolite KEGG:C17225 Tetrahomomethionine generic -metabolite KEGG:C17226 2-(6'-Methylthio)hexylmalic acid generic -metabolite KEGG:C17227 3-(6'-Methylthio)hexylmalic acid generic -metabolite KEGG:C17228 2-Oxo-9-methylthiononanoic acid generic -metabolite KEGG:C17229 Pentahomomethionine generic -metabolite KEGG:C17230 2-(7'-Methylthio)heptylmalic acid generic -metabolite KEGG:C17231 3-(7'-Methylthio)heptylmalic acid generic -metabolite KEGG:C17232 2-Oxo-10-methylthiodecanoic acid generic -metabolite KEGG:C17233 Hexahomomethionine generic -metabolite KEGG:C17234 2-Aminobut-2-enoate generic -metabolite KEGG:C17235 L-Homophenylalanine generic -metabolite KEGG:C17236 3-Phenylpropionaldoxim generic -metabolite KEGG:C17237 S-(Phenylacetothiohydroximoyl)-L-cysteine generic -metabolite KEGG:C17238 S-(Hydroxyphenylacetothiohydroximoyl)-L-cysteine generic -metabolite KEGG:C17239 p-Hydroxyphenylacetothiohydroximate generic -metabolite KEGG:C17240 p-Hydroxybenzyldesulphoglucosinolate generic -metabolite KEGG:C17241 4-Methylthiobutanaldoxime generic -metabolite KEGG:C17242 S-(4-Methylthiobutylthiohydroximoyl)-L-cysteine generic -metabolite KEGG:C17243 4-Methylthiobutylthiohydroximate generic -metabolite KEGG:C17244 3-Methylthiopropyl-desulfoglucosinolate generic -metabolite KEGG:C17245 5-Methylthiopentanaldoxime generic -metabolite KEGG:C17246 6-Methylthiohexanaldoxime generic -metabolite KEGG:C17248 4-Methylthiobutyl-desulfoglucosinolate generic -metabolite KEGG:C17249 7-Methylthioheptanaldoxime generic -metabolite KEGG:C17250 Glucolesquerellin generic -metabolite KEGG:C17251 8-Methylthiooctanaldoxime generic -metabolite KEGG:C17252 7-Methylthioheptyl glucosinolate generic -metabolite KEGG:C17253 9-Methylthiononanaldoxime generic -metabolite KEGG:C17254 8-Methylthiooctyl glucosinolate generic -metabolite KEGG:C17255 3-Methylbutyraldehyde oxime generic -metabolite KEGG:C17256 2-Methylpropyl glucosinolate generic -metabolite KEGG:C17257 2-Methylbutyl glucosinolate generic -metabolite KEGG:C17258 Calcium sulfate hemihydrate generic -metabolite KEGG:C17259 desulfo-Glucosinolate generic -metabolite KEGG:C17260 Glucosinolate generic -metabolite KEGG:C17261 Thiohydroximic acid generic -metabolite KEGG:C17262 S-Alkyl-thiohydroximate generic -metabolite KEGG:C17263 2-Alkylmalic acid generic -metabolite KEGG:C17264 3-Alkylmalic acid generic -metabolite KEGG:C17265 Aliphatic oxo acid generic -metabolite KEGG:C17266 Homoamino acid generic -metabolite KEGG:C17267 S-Sulfanylglutathione generic -metabolite KEGG:C17268 Pyruvophenone generic -metabolite KEGG:C17271 Glucohirsutin generic -metabolite KEGG:C17272 Glucoarabin generic -metabolite KEGG:C17273 Glucoaubrietin generic -metabolite KEGG:C17274 Glucobarbarin generic -metabolite KEGG:C17275 Glucosisymbrin generic -metabolite KEGG:C17276 Retinol-(cellular-retinol-binding-protein) generic -metabolite KEGG:C17277 (+)-Valencene generic -metabolite KEGG:C17278 Ximenic acid generic -metabolite KEGG:C17279 Ximenoyl-CoA generic -metabolite KEGG:C17302 AL-294 generic -metabolite KEGG:C17303 AL-321 generic -metabolite KEGG:C17309 Cilazaprilat generic -metabolite KEGG:C17322 tRNA containing 2-thiouridine generic -metabolite KEGG:C17323 tRNA containing 5-carboxymethylaminomethyl-2-thiouridine generic -metabolite KEGG:C17324 tRNA adenine generic -metabolite KEGG:C17325 tRNA cytosine generic -metabolite KEGG:C17326 CDP-4-dehydro-3,6-dideoxy-D-glucose epimer generic -metabolite KEGG:C17327 CDP-ascarylose generic -metabolite KEGG:C17328 UDP-4-keto-rhamnose generic -metabolite KEGG:C17331 7alpha,24-Dihydroxy-4-cholesten-3-one generic -metabolite KEGG:C17332 7alpha,25-Dihydroxy-4-cholesten-3-one generic -metabolite KEGG:C17333 3beta-Hydroxy-5-cholestenoate generic -metabolite KEGG:C17335 3beta,7alpha-Dihydroxy-5-cholestenoate generic -metabolite KEGG:C17336 7alpha,26-Dihydroxy-4-cholesten-3-one generic -metabolite KEGG:C17337 7alpha-Hydroxy-3-oxo-4-cholestenoate generic -metabolite KEGG:C17339 4-Cholesten-7alpha,12alpha-diol-3-one generic -metabolite KEGG:C17343 (25S)-3alpha,7alpha,12alpha-Trihydroxy-5beta-cholestan-26-oyl-CoA generic -metabolite KEGG:C17345 (25R)-3alpha,7alpha-Dihydroxy-5beta-cholestanoyl-CoA generic -metabolite KEGG:C17346 (25S)-3alpha,7alpha-Dihydroxy-5beta-cholestanoyl-CoA generic -metabolite KEGG:C17349 Guanidine generic -metabolite KEGG:C17350 Nocardicin B generic -metabolite KEGG:C17351 Nocardicin C generic -metabolite KEGG:C17352 Isonocardicin C generic -metabolite KEGG:C17353 Nocardicin D generic -metabolite KEGG:C17354 Nocardicin F generic -metabolite KEGG:C17355 Nocardicin G generic -metabolite KEGG:C17356 2-Formyloxymethylclavam generic -metabolite KEGG:C17357 2-Hydroxymethylclavam generic -metabolite KEGG:C17358 Clavam-2-carboxylate generic -metabolite KEGG:C17359 8-Hydroxyalanylclavam generic -metabolite KEGG:C17360 Alanylclavam generic -metabolite KEGG:C17361 2-Hydroxyethylclavam generic -metabolite KEGG:C17362 Clavamycin B generic -metabolite KEGG:C17363 Clavamycin C generic -metabolite KEGG:C17364 Clavamycin D generic -metabolite KEGG:C17365 Clavamycin E generic -metabolite KEGG:C17366 (2S,5S)-trans-Carboxymethylproline generic -metabolite KEGG:C17367 (3S,5S)-Carbapenam-3-carboxylic acid generic -metabolite KEGG:C17368 8-Dehydroxythienamycin generic -metabolite KEGG:C17369 Northienamycin generic -metabolite KEGG:C17370 PS-5 generic -metabolite KEGG:C17371 PS-6 generic -metabolite KEGG:C17372 Epithienamycin A generic -metabolite KEGG:C17373 OA-6129 B1 generic -metabolite KEGG:C17374 OA-6129 B2 generic -metabolite KEGG:C17375 OA-6129 D generic -metabolite KEGG:C17376 OA-6129 E generic -metabolite KEGG:C17377 N-Acetylthienamycin generic -metabolite KEGG:C17378 O-Acylpseudotropine generic -metabolite KEGG:C17379 Lead oxide generic -metabolite KEGG:C17380 Diacetylaminoazotoluene generic -metabolite KEGG:C17381 Dihydroxyaluminum generic -metabolite KEGG:C17382 Ferrous lactate generic -metabolite KEGG:C17383 Cobaltous sulfate generic -metabolite KEGG:C17384 Citronellal generic -metabolite KEGG:C17385 2-Methoxy-5-nitrophenol generic -metabolite KEGG:C17386 2-Methoxy-4-nitrophenol generic -metabolite KEGG:C17387 Cycleanine generic -metabolite KEGG:C17388 L-Galacturonic acid calcium salt generic -metabolite KEGG:C17389 Zinc lactate generic -metabolite KEGG:C17390 Polybutene generic -metabolite KEGG:C17391 Sakuranin generic -metabolite KEGG:C17392 Calcium sulfide generic -metabolite KEGG:C17393 Methyl hesperidin generic -metabolite KEGG:C17394 Karounidiol generic -metabolite KEGG:C17395 Clavamycin F generic -metabolite KEGG:C17396 Epithienamycin B generic -metabolite KEGG:C17397 Epithienamycin C generic -metabolite KEGG:C17398 Epithienamycin D generic -metabolite KEGG:C17399 Epithienamycin F generic -metabolite KEGG:C17400 Asparenomycin A generic -metabolite KEGG:C17401 Cobalt-factor III generic -metabolite KEGG:C17402 Penicillin F generic -metabolite KEGG:C17403 Penicillin K generic -metabolite KEGG:C17404 Penicillin X generic -metabolite KEGG:C17405 Penicillin O generic -metabolite KEGG:C17407 Tenofovir generic -metabolite KEGG:C17409 Chinese gallotannin generic -metabolite KEGG:C17410 Platycodin D generic -metabolite KEGG:C17411 o-Methylpsychotrine generic -metabolite KEGG:C17412 Shikonin generic -metabolite KEGG:C17413 Acetylshikonin generic -metabolite KEGG:C17414 Isobutylshikonin generic -metabolite KEGG:C17415 beta,beta-Dimethylacrylshikonin generic -metabolite KEGG:C17416 Astrapterocarpan generic -metabolite KEGG:C17417 Onjisaponin F generic -metabolite KEGG:C17418 Genisteine generic -metabolite KEGG:C17419 Soyasapogenol A generic -metabolite KEGG:C17420 Soyasapogenol E generic -metabolite KEGG:C17421 Soyasapogenol F generic -metabolite KEGG:C17422 Soyasapogenol C generic -metabolite KEGG:C17423 Soyasapogenol D generic -metabolite KEGG:C17424 Lindenenone generic -metabolite KEGG:C17425 Linderalactone generic -metabolite KEGG:C17426 Dicentrine generic -metabolite KEGG:C17427 Kanokonol generic -metabolite KEGG:C17428 Kanokoside A generic -metabolite KEGG:C17429 Kanokoside B generic -metabolite KEGG:C17430 Kanokoside C generic -metabolite KEGG:C17431 Kanokoside D generic -metabolite KEGG:C17432 all-trans-Decaprenyl diphosphate generic -metabolite KEGG:C17433 Tricosane generic -metabolite KEGG:C17434 di-trans,poly-cis-Hexaprenyl diphosphate generic -metabolite KEGG:C17435 di-trans,poly-cis-Pentaprenyl diphosphate generic -metabolite KEGG:C17436 di-trans,poly-cis-Heptaprenyl diphosphate generic -metabolite KEGG:C17437 di-trans,poly-cis-Octaprenyl diphosphate generic -metabolite KEGG:C17438 di-trans,poly-cis-Nonaprenyl diphosphate generic -metabolite KEGG:C17439 Dihydrogeranylgeranyl diphosphate generic -metabolite KEGG:C17440 Tetrahydrogeranylgeranyl diphosphate generic -metabolite KEGG:C17441 Polygalacin D generic -metabolite KEGG:C17442 Isomatrine generic -metabolite KEGG:C17443 Platycodin A generic -metabolite KEGG:C17444 Kurarinol generic -metabolite KEGG:C17445 Kuraridinol generic -metabolite KEGG:C17446 Kurarinone generic -metabolite KEGG:C17447 (3S,9Z)-1,9-Heptadecadiene-4,6-diyn-3-ol generic -metabolite KEGG:C17449 Astilbin generic -metabolite KEGG:C17450 Rehmaionoside A generic -metabolite KEGG:C17451 Rehmaionoside B generic -metabolite KEGG:C17452 Rehmaionoside C generic -metabolite KEGG:C17453 Paeoniflorigenone generic -metabolite KEGG:C17454 Paeonilactone A generic -metabolite KEGG:C17455 Paeonilactone B generic -metabolite KEGG:C17456 Paeonilactone C generic -metabolite KEGG:C17457 Albiflorin generic -metabolite KEGG:C17458 Gallotannin generic -metabolite KEGG:C17459 Alisol A generic -metabolite KEGG:C17460 Alisol B generic -metabolite KEGG:C17461 Alisol C generic -metabolite KEGG:C17462 Alismol generic -metabolite KEGG:C17463 Nupharidine generic -metabolite KEGG:C17464 Nupharamine generic -metabolite KEGG:C17465 Parishin B generic -metabolite KEGG:C17466 Parishin C generic -metabolite KEGG:C17467 p-Hydroxybenzyl alcohol generic -metabolite KEGG:C17468 Methylprotodioscin generic -metabolite KEGG:C17469 Pseudoprotodioscin generic -metabolite KEGG:C17470 Asparasaponin II generic -metabolite KEGG:C17471 Ophiopogonone A generic -metabolite KEGG:C17472 Ophiopogonone B generic -metabolite KEGG:C17473 Methylophiopogonone A generic -metabolite KEGG:C17474 Methylophiopogonone B generic -metabolite KEGG:C17475 Ophiopogonanone A generic -metabolite KEGG:C17476 Osthenol-7-O-beta-D-gentiobioside generic -metabolite KEGG:C17477 D-Galacturonic acid calcium salt generic -metabolite KEGG:C17478 Calcium oxalate generic -metabolite KEGG:C17479 Fraxidin generic -metabolite KEGG:C17480 Isofraxidin generic -metabolite KEGG:C17482 (-)-Deltoin generic -metabolite KEGG:C17483 Hamaudol generic -metabolite KEGG:C17484 sec-o-Glucosylhamaudol generic -metabolite KEGG:C17485 Ignavine generic -metabolite KEGG:C17486 Coryneine generic -metabolite KEGG:C17487 Platycodin C generic -metabolite KEGG:C17488 Furanogermenone generic -metabolite KEGG:C17489 (4S,5S)-(+)-Germacrone 4,5-epoxide generic -metabolite KEGG:C17490 Zedoarol generic -metabolite KEGG:C17491 13-Hydroxygermacrone generic -metabolite KEGG:C17492 Curcumenone generic -metabolite KEGG:C17493 Curdione generic -metabolite KEGG:C17494 Turmerone generic -metabolite KEGG:C17495 [8]-Gingerol generic -metabolite KEGG:C17496 (10)-Gingerol generic -metabolite KEGG:C17497 Zingerone generic -metabolite KEGG:C17498 Galanolactone generic -metabolite KEGG:C17499 Notopterol generic -metabolite KEGG:C17500 6-Iminocyclohexa-2,4-dienone generic -metabolite KEGG:C17501 Cyperotundone generic -metabolite KEGG:C17502 Sugetriol generic -metabolite KEGG:C17503 Cnidilin generic -metabolite KEGG:C17504 Sugeonol generic -metabolite KEGG:C17505 Cyperene generic -metabolite KEGG:C17506 Sugeonyl acetate generic -metabolite KEGG:C17507 Palmatoside G generic -metabolite KEGG:C17508 Isocolumbin generic -metabolite KEGG:C17509 Thymine dimer generic -metabolite KEGG:C17510 Two thymine residues (in DNA) generic -metabolite KEGG:C17512 N-Methylanthranilamide generic -metabolite KEGG:C17513 trans-Crocetin (beta-D-glucosyl) (beta-D-gentibiosyl) ester generic -metabolite KEGG:C17514 4-o-Galloylbergenin generic -metabolite KEGG:C17515 Capsi-amide generic -metabolite KEGG:C17516 Capsianside A generic -metabolite KEGG:C17517 beta-Terpineol generic -metabolite KEGG:C17518 gamma-Terpineol generic -metabolite KEGG:C17519 Amaroswerin generic -metabolite KEGG:C17520 11-o-Galloylbergenin generic -metabolite KEGG:C17521 Mallotinic acid generic -metabolite KEGG:C17522 Mallogenin-3-o-alpha-L-rhamnopyranoside generic -metabolite KEGG:C17523 Panogenin-3-o-alpha-L-rhamnopyranoside generic -metabolite KEGG:C17524 Coroglaucigenin-3-o-alpha-L-rhamnopyranoside generic -metabolite KEGG:C17525 Corotoxigenin-3-O-alpha-L-rhamnopyranoside generic -metabolite KEGG:C17526 Boivinide A generic -metabolite KEGG:C17527 Rengyol generic -metabolite KEGG:C17528 beta-Hydroxyacteoside generic -metabolite KEGG:C17529 (-)-Pinoresinol glucoside generic -metabolite KEGG:C17530 Methyl acetate generic -metabolite KEGG:C17531 Plantagoside generic -metabolite KEGG:C17532 Metoxadiazone generic -metabolite KEGG:C17533 Gambirtannine generic -metabolite KEGG:C17534 Cylindrin generic -metabolite KEGG:C17535 Aplotaxene generic -metabolite KEGG:C17536 Sibiricoside A generic -metabolite KEGG:C17537 Sibiricoside B generic -metabolite KEGG:C17538 Cimigenol generic -metabolite KEGG:C17539 Chikusetsusaponin III generic -metabolite KEGG:C17540 Chikusetsusaponin IV generic -metabolite KEGG:C17541 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-D-isoglutaminyl-L-lysyl-(glycyl)-D-alanyl-D-alanine generic -metabolite KEGG:C17542 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-D-isoglutaminyl-L-lysyl-(glycyl)3-D-alanyl-D-alanine generic -metabolite KEGG:C17543 Chikusetsusaponin V generic -metabolite KEGG:C17544 Chikusetsusaponin Ia generic -metabolite KEGG:C17545 Chikusetsusaponin Ib generic -metabolite KEGG:C17546 Akeboside Stf generic -metabolite KEGG:C17547 Akeboside Std generic -metabolite KEGG:C17548 Akeboside Ste generic -metabolite KEGG:C17549 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-gamma-D-glutamyl-L-lysyl-(L-alanyl-L-alanyl)-D-alanyl-D-alanine generic -metabolite KEGG:C17550 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-gamma-D-glutamyl-L-lysyl-(L-alanyl)-D-alanyl-D-alanine generic -metabolite KEGG:C17551 2-Polyprenyl-6-hydroxyphenol generic -metabolite KEGG:C17552 2-Polyprenyl-6-methoxyphenol generic -metabolite KEGG:C17553 Condurango glycoside A generic -metabolite KEGG:C17554 3-Polyprenyl-4,5-dihydroxybenzoate generic -metabolite KEGG:C17555 Icariin generic -metabolite KEGG:C17556 di-trans,poly-cis-Undecaprenyl phosphate generic -metabolite KEGG:C17557 Lonicerin generic -metabolite KEGG:C17558 di-trans,poly-cis-Undecaprenol generic -metabolite KEGG:C17559 3-Polyprenyl-4-hydroxy-5-methoxybenzoate generic -metabolite KEGG:C17560 2-Polyprenyl-6-methoxy-1,4-benzoquinone generic -metabolite KEGG:C17561 2-Polyprenyl-3-methyl-6-methoxy-1,4-benzoquinone generic -metabolite KEGG:C17562 2-Polyprenyl-3-methyl-5-hydroxy-6-methoxy-1,4-benzoquinone generic -metabolite KEGG:C17563 Multinoside A generic -metabolite KEGG:C17564 Zizybeoside I generic -metabolite KEGG:C17565 Zizybeoside II generic -metabolite KEGG:C17566 Coixenolide generic -metabolite KEGG:C17567 Lotusine generic -metabolite KEGG:C17568 Ubiquinone-6 generic -metabolite KEGG:C17569 Ubiquinone-8 generic -metabolite KEGG:C17570 2-Methyl-6-solanyl-1,4-benzoquinol generic -metabolite KEGG:C17571 5'-Hydroxystreptomycin generic -metabolite KEGG:C17572 Bluensidine 6-phosphate generic -metabolite KEGG:C17573 Bluensomycin generic -metabolite KEGG:C17574 2-epi-Streptamine generic -metabolite KEGG:C17575 Actinamine generic -metabolite KEGG:C17576 3-Keto-scyllo-inosamine generic -metabolite KEGG:C17577 myo-Inosose-5 generic -metabolite KEGG:C17578 neo-Inosamine-2 generic -metabolite KEGG:C17579 Hygromycin A generic -metabolite KEGG:C17580 2-Deoxy-scyllo-inosamine generic -metabolite KEGG:C17581 3-Amino-2,3-dideoxy-scyllo-inosose generic -metabolite KEGG:C17582 2'-N-Acetylparomamine generic -metabolite KEGG:C17583 6'-Dehydro-6'-oxoparomamine generic -metabolite KEGG:C17584 Xylostasin generic -metabolite KEGG:C17585 Butirosin A generic -metabolite KEGG:C17586 Butirosin B generic -metabolite KEGG:C17587 2'''-N-Acetyl-6'''-deamino-6'''-hydroxyneomycin C generic -metabolite KEGG:C17588 6'''-Deamino-6'''-hydroxyneomycin C generic -metabolite KEGG:C17589 6'''-Deamino-6'''-oxoneomycin C generic -metabolite KEGG:C17590 Catechin generic -metabolite KEGG:C17591 (S)-Corytuberine generic -metabolite KEGG:C17592 Laudanine generic -metabolite KEGG:C17593 Uncarine A generic -metabolite KEGG:C17594 Uncarine B generic -metabolite KEGG:C17595 Uncarine C generic -metabolite KEGG:C17596 Uncarine D generic -metabolite KEGG:C17597 Uncarine E generic -metabolite KEGG:C17598 Uncarine F generic -metabolite KEGG:C17599 Methylarbutin generic -metabolite KEGG:C17600 Multiflorin B generic -metabolite KEGG:C17601 2(5H)-Furanone generic -metabolite KEGG:C17602 2(3H)-Furanone generic -metabolite KEGG:C17603 Kikkanol A generic -metabolite KEGG:C17604 Kikkanol B generic -metabolite KEGG:C17605 Kikkanol C generic -metabolite KEGG:C17606 Kikkanol D generic -metabolite KEGG:C17607 Kikkanol E generic -metabolite KEGG:C17608 Kikkanol F generic -metabolite KEGG:C17609 Chrysantherol generic -metabolite KEGG:C17610 Chrysanthetriol generic -metabolite KEGG:C17611 Chrysanthemol generic -metabolite KEGG:C17612 Indicumenone generic -metabolite KEGG:C17613 Handelin generic -metabolite KEGG:C17614 1-Octen-3-ol-3-o-beta-D-xylopyranosyl(1->6)-beta-D-glucopyranoside generic -metabolite KEGG:C17615 Kukoamine A generic -metabolite KEGG:C17616 Kukoamine B generic -metabolite KEGG:C17617 Kukoamine C generic -metabolite KEGG:C17618 Kukoamine D generic -metabolite KEGG:C17619 10-(beta-Dimethylaminopropionyl)phenothiazine generic -metabolite KEGG:C17620 Epomediol generic -metabolite KEGG:C17621 (6E)-8-Hydroxygeraniol generic -metabolite KEGG:C17622 (6E)-8-Oxogeranial generic -metabolite KEGG:C17623 (-)-Pulegone generic -metabolite KEGG:C17624 Cinnamtannin A1 generic -metabolite KEGG:C17625 Cinnamtannin A2 generic -metabolite KEGG:C17626 Cinnamtannin A3 generic -metabolite KEGG:C17627 Prenyl diphosphate generic -metabolite KEGG:C17628 Prenol generic -metabolite KEGG:C17629 Cinnamtannin B2 generic -metabolite KEGG:C17631 Cinnamtannin B1 generic -metabolite KEGG:C17632 Cinnamtannin D1 generic -metabolite KEGG:C17633 Cinnamtannin D2 generic -metabolite KEGG:C17634 Schizonepetoside A generic -metabolite KEGG:C17635 Schizonepetoside B generic -metabolite KEGG:C17636 Schizonepetoside C generic -metabolite KEGG:C17637 Schizonepetoside D generic -metabolite KEGG:C17638 Schizonepetoside E generic -metabolite KEGG:C17639 Procyanidin B2 generic -metabolite KEGG:C17640 Procyanidin B5 generic -metabolite KEGG:C17641 Cinncassiol C3 generic -metabolite KEGG:C17642 Cinncassiol C2 generic -metabolite KEGG:C17643 Cinncassiol C1 generic -metabolite KEGG:C17644 Ursocholate generic -metabolite KEGG:C17645 Cinncassiol A generic -metabolite KEGG:C17646 12-Epideoxycholic acid generic -metabolite KEGG:C17647 alpha-Muricholate generic -metabolite KEGG:C17648 Cinncassiol B generic -metabolite KEGG:C17649 Hyocholate generic -metabolite KEGG:C17650 Vulpecholate generic -metabolite KEGG:C17651 alpha-Phocaecholic acid generic -metabolite KEGG:C17652 Cinncassiol D1 generic -metabolite KEGG:C17653 Cinncassiol D2 generic -metabolite KEGG:C17654 beta-Phocaecholate generic -metabolite KEGG:C17655 Cinncassiol D3 generic -metabolite KEGG:C17656 Cinncassiol D4 generic -metabolite KEGG:C17657 Bitocholate generic -metabolite KEGG:C17658 Isolithocholate generic -metabolite KEGG:C17659 Cinncassiol E generic -metabolite KEGG:C17660 Isochenodeoxycholate generic -metabolite KEGG:C17661 Isodeoxycholate generic -metabolite KEGG:C17662 Isoursodeoxycholate generic -metabolite KEGG:C17663 3-Phenylpropyl acetate generic -metabolite KEGG:C17664 Allochenodeoxycholate generic -metabolite KEGG:C17665 2-Phenylpropyl acetate generic -metabolite KEGG:C17666 1-Phenylpropyl acetate generic -metabolite KEGG:C17667 Avicholate generic -metabolite KEGG:C17668 Haemulcholate generic -metabolite KEGG:C17669 Chryso-obtusin generic -metabolite KEGG:C17670 Aurantio-obtusin generic -metabolite KEGG:C17671 Norrubrofusarin generic -metabolite KEGG:C17672 Torachrysone generic -metabolite KEGG:C17673 Toralactone generic -metabolite KEGG:C17674 Cassiaside B2 generic -metabolite KEGG:C17675 Neocarthamin generic -metabolite KEGG:C17676 Cryptomeridiol generic -metabolite KEGG:C17677 Eudesobovatol B generic -metabolite KEGG:C17678 Magnoloside A generic -metabolite KEGG:C17679 Magnoloside B generic -metabolite KEGG:C17680 Magnoloside C generic -metabolite KEGG:C17682 Neoarctin A generic -metabolite KEGG:C17683 Neoarctin B generic -metabolite KEGG:C17684 Lappaol A generic -metabolite KEGG:C17685 Lappaol B generic -metabolite KEGG:C17686 Lappaol C generic -metabolite KEGG:C17687 Allodeoxycholate generic -metabolite KEGG:C17688 Aluminum acetoacetate generic -metabolite KEGG:C17689 Ursodeoxycholoyl-CoA generic -metabolite KEGG:C17690 4-(4-Hydroxyphenyl)-2-butanol generic -metabolite KEGG:C17691 2-epi-5-epi-Valiolone generic -metabolite KEGG:C17692 2-epi-5-epi-Valiolone 7-phosphate generic -metabolite KEGG:C17693 5-epi-Valiolone 7-phosphate generic -metabolite KEGG:C17694 5-epi-Valiolone generic -metabolite KEGG:C17695 2-Keto-5-epi-valiolone generic -metabolite KEGG:C17696 Valienone generic -metabolite KEGG:C17697 Valienone 7-phosphate generic -metabolite KEGG:C17698 Salbostatin generic -metabolite KEGG:C17699 Cetoniacytone A generic -metabolite KEGG:C17700 Validoxylamine A generic -metabolite KEGG:C17701 Gentamicin A2 generic -metabolite KEGG:C17702 Gentamicin X2 generic -metabolite KEGG:C17703 Antibiotic G-418 generic -metabolite KEGG:C17704 Antibiotic JI-20A generic -metabolite KEGG:C17705 Antibiotic JI-20B generic -metabolite KEGG:C17706 Gentamicin C2b generic -metabolite KEGG:C17707 Lividomycin A generic -metabolite KEGG:C17708 Fortimicin A generic -metabolite KEGG:C17709 Fortimicin B generic -metabolite KEGG:C17710 Sannamycin A generic -metabolite KEGG:C17711 Sannamycin B generic -metabolite KEGG:C17712 Paromomycin II generic -metabolite KEGG:C17713 dl-alpha-Tocopheryl sodium phosphate generic -metabolite KEGG:C17714 Heptanoic acid generic -metabolite KEGG:C17715 Undecanoic acid generic -metabolite KEGG:C17716 Dehydrofalcarinol generic -metabolite KEGG:C17717 5-Phenyl-1,3-pentadiyne generic -metabolite KEGG:C17718 Sulfamethoxazole sodium generic -metabolite KEGG:C17719 Tenitramine generic -metabolite KEGG:C17720 Difenpiramide generic -metabolite KEGG:C17721 Vinyl ether generic -metabolite KEGG:C17722 Narcobarbital generic -metabolite KEGG:C17723 Metabutethamine generic -metabolite KEGG:C17724 Ethadione generic -metabolite KEGG:C17725 Heptabarbital generic -metabolite KEGG:C17726 beta-Muricholate generic -metabolite KEGG:C17727 omega-Muricholate generic -metabolite KEGG:C17728 Idanpramine generic -metabolite KEGG:C17729 Nicofetamide generic -metabolite KEGG:C17730 Piperidione generic -metabolite KEGG:C17731 Sodium folinate generic -metabolite KEGG:C17732 Magnesium peroxide generic -metabolite KEGG:C17733 7-Oxateasterone generic -metabolite KEGG:C17734 Acetoxolone generic -metabolite KEGG:C17735 7-Oxatyphasterol generic -metabolite KEGG:C17737 Allocholic acid generic -metabolite KEGG:C17740 p-Coumaroyl-diketide-CoA generic -metabolite KEGG:C17741 Feruloyl-diketide-CoA generic -metabolite KEGG:C17742 Demethoxycurcumin generic -metabolite KEGG:C17743 Bisdemethoxycurcumin generic -metabolite KEGG:C17744 1-(4-Hydroxyphenyl)-1-decene-3,5-dione generic -metabolite KEGG:C17745 1-(3,4-Dihydroxyphenyl)-1-decene-3,5-dione generic -metabolite KEGG:C17746 1-Dehydro-[6]-gingerdione generic -metabolite KEGG:C17747 5-Hydroxy-1-(4-hydroxyphenyl)-3-decanone generic -metabolite KEGG:C17748 1-(3,4-Dihydroxyphenyl)-5-hydroxy-3-decanone generic -metabolite KEGG:C17749 Curcumin monoglucoside generic -metabolite KEGG:C17750 Curcumin diglucoside generic -metabolite KEGG:C17751 cyclo-Dopa 5-O-glucoside generic -metabolite KEGG:C17752 cyclo-Dopa-glucuronylglucoside generic -metabolite KEGG:C17753 Dopaxanthin quinone generic -metabolite KEGG:C17754 3-Methoxytyramine-betaxanthin generic -metabolite KEGG:C17755 Dopamine quinone generic -metabolite KEGG:C17756 2-Descarboxy-cyclo-dopa generic -metabolite KEGG:C17757 2-Descarboxy-betanidin generic -metabolite KEGG:C17758 4,5-seco-Dopa generic -metabolite KEGG:C17759 1-O-Feruloyl-beta-D-glucose generic -metabolite KEGG:C17760 Senegin III generic -metabolite KEGG:C17761 Senegin IV generic -metabolite KEGG:C17762 Homoplantaginin generic -metabolite KEGG:C17763 6-Hydroxyluteolin 7-glucoside generic -metabolite KEGG:C17764 Glabric acid generic -metabolite KEGG:C17765 Licoricone generic -metabolite KEGG:C17766 Condurangogenin C generic -metabolite KEGG:C17767 Condurangogenin A generic -metabolite KEGG:C17768 Condurango glycoside A0 generic -metabolite KEGG:C17769 Condurango glycoside C generic -metabolite KEGG:C17770 Sarcostin generic -metabolite KEGG:C17771 Lithospermoside generic -metabolite KEGG:C17772 Gambiriin A1 generic -metabolite KEGG:C17773 Gambiriin A2 generic -metabolite KEGG:C17774 Gambiriin A3 generic -metabolite KEGG:C17775 Gambiriin B1 generic -metabolite KEGG:C17776 Gambiriin B2 generic -metabolite KEGG:C17777 Gambiriin B3 generic -metabolite KEGG:C17778 Isobarbaloin generic -metabolite KEGG:C17779 Aloinoside A generic -metabolite KEGG:C17780 Aloinoside B generic -metabolite KEGG:C17781 2''-o-p-Coumaroylaloesin generic -metabolite KEGG:C17782 3,5-Dimethoxyallylbenzene generic -metabolite KEGG:C17783 Capillanol generic -metabolite KEGG:C17784 4'-Methylcapillarisin generic -metabolite KEGG:C17785 7-Methylcapillarisin generic -metabolite KEGG:C17786 6-Demethoxycapillarisin generic -metabolite KEGG:C17787 Arcapillin generic -metabolite KEGG:C17788 Eupatolitin generic -metabolite KEGG:C17789 Capillartemisin A generic -metabolite KEGG:C17790 Dehydrocorydaline generic -metabolite KEGG:C17791 Cycloaraloside C generic -metabolite KEGG:C17792 Cycloaraloside F generic -metabolite KEGG:C17793 Isoastragaloside I generic -metabolite KEGG:C17794 Isoastragaloside II generic -metabolite KEGG:C17795 Capillartemisin B generic -metabolite KEGG:C17796 Norcapillene generic -metabolite KEGG:C17797 Astragaloside I generic -metabolite KEGG:C17798 Astragaloside II generic -metabolite KEGG:C17799 Astragaloside IV generic -metabolite KEGG:C17800 Astragaloside V generic -metabolite KEGG:C17801 Astragaloside VI generic -metabolite KEGG:C17802 Astragaloside VII generic -metabolite KEGG:C17803 Dimethyl suberate generic -metabolite KEGG:C17804 Clematichinenoside A generic -metabolite KEGG:C17805 Clematichinenoside B generic -metabolite KEGG:C17806 Clematichinenoside C generic -metabolite KEGG:C17807 Huzhongoside B generic -metabolite KEGG:C17808 Clemaphenol A generic -metabolite KEGG:C17809 Polygonimitin B generic -metabolite KEGG:C17810 Citreorosein generic -metabolite KEGG:C17811 Questinol generic -metabolite KEGG:C17812 Lappaol D generic -metabolite KEGG:C17813 Activin A generic -metabolite KEGG:C17814 Gomisin B generic -metabolite KEGG:C17815 Civetol generic -metabolite KEGG:C17816 Gomisin D generic -metabolite KEGG:C17817 Gomisin E generic -metabolite KEGG:C17818 Gomisin F generic -metabolite KEGG:C17819 Gomisin G generic -metabolite KEGG:C17820 Gomisin H generic -metabolite KEGG:C17821 2,4,5-Trimethoxy-1-allylbenzene generic -metabolite KEGG:C17822 3,4,5-Trimethoxytoluene generic -metabolite KEGG:C17823 2,4,5-Trimethoxytoluene generic -metabolite KEGG:C17824 (+/-)-Asarinol A generic -metabolite KEGG:C17825 (+/-)-Asarinol B generic -metabolite KEGG:C17826 Hexahydrocurcumin generic -metabolite KEGG:C17827 Hydroxy-gamma-sanshool generic -metabolite KEGG:C17828 Protojujuboside A generic -metabolite KEGG:C17829 Protojujuboside B generic -metabolite KEGG:C17830 Protojujuboside B1 generic -metabolite KEGG:C17831 Jujuboside A generic -metabolite KEGG:C17832 Jujuboside B generic -metabolite KEGG:C17833 Jujuboside C generic -metabolite KEGG:C17834 Spinosin generic -metabolite KEGG:C17835 Swertisin generic -metabolite KEGG:C17836 6''-Feruloylspinosin generic -metabolite KEGG:C17837 Isospinosin generic -metabolite KEGG:C17838 Visamminol generic -metabolite KEGG:C17839 Terrestriamide generic -metabolite KEGG:C17840 Dehydrozingerone generic -metabolite KEGG:C17841 Dahurinol generic -metabolite KEGG:C17842 Acerinol generic -metabolite KEGG:C17843 Norvisnagin generic -metabolite KEGG:C17844 (+)-Demethoxyaschantin generic -metabolite KEGG:C17845 (+)-Aschantin generic -metabolite KEGG:C17846 alpha-Asaron generic -metabolite KEGG:C17847 Magnosalin generic -metabolite KEGG:C17848 Biondinin A generic -metabolite KEGG:C17849 Biondinin B generic -metabolite KEGG:C17850 Biondinin C generic -metabolite KEGG:C17851 Biondinin D generic -metabolite KEGG:C17852 Biondinin E generic -metabolite KEGG:C17853 Senkyunolide generic -metabolite KEGG:C17854 Butylphthalide generic -metabolite KEGG:C17855 Coniferyl ferulate generic -metabolite KEGG:C17856 Atractylodinol generic -metabolite KEGG:C17857 Acetylatractylodinol generic -metabolite KEGG:C17858 Atractyloside A generic -metabolite KEGG:C17859 Atractyloside B generic -metabolite KEGG:C17860 Atractyloside C generic -metabolite KEGG:C17861 Atractyloside D generic -metabolite KEGG:C17862 Atractyloside E generic -metabolite KEGG:C17863 Atractyloside F generic -metabolite KEGG:C17864 Atractyloside G generic -metabolite KEGG:C17865 Atractyloside H generic -metabolite KEGG:C17866 Atractyloside I generic -metabolite KEGG:C17867 Cyclomorusin generic -metabolite KEGG:C17868 Morusinol generic -metabolite KEGG:C17869 Sanggenon A generic -metabolite KEGG:C17870 Sanggenon B generic -metabolite KEGG:C17871 Sanggenon E generic -metabolite KEGG:C17872 Corynantheine generic -metabolite KEGG:C17873 2-Hydroxytetracosanoic acid generic -metabolite KEGG:C17874 Uncaric acid A generic -metabolite KEGG:C17875 Sedanonic acid lactone generic -metabolite KEGG:C17877 Dioxation generic -metabolite KEGG:C17878 Eucommiol generic -metabolite KEGG:C17879 Nigakinone generic -metabolite KEGG:C17880 Cryptocyanin generic -metabolite KEGG:C17881 Zhebeinine generic -metabolite KEGG:C17882 Peiminoside generic -metabolite KEGG:C17883 4-Vinylguaiacol generic -metabolite KEGG:C17884 3beta-Hydroxyatractylon generic -metabolite KEGG:C17885 Atractylenolide I generic -metabolite KEGG:C17886 Atractylenolide II generic -metabolite KEGG:C17887 Atractylenolide III generic -metabolite KEGG:C17888 Eriojaposide A generic -metabolite KEGG:C17889 Eriojaposide B generic -metabolite KEGG:C17890 Euscaphic acid generic -metabolite KEGG:C17891 Cryptogenin generic -metabolite KEGG:C17892 Arecatannin B1 generic -metabolite KEGG:C17893 Arecatannin A2 generic -metabolite KEGG:C17894 Arecatannin A1 generic -metabolite KEGG:C17895 Arecatannin A3 generic -metabolite KEGG:C17896 Arecatannin B2 generic -metabolite KEGG:C17897 Arecatannin C1 generic -metabolite KEGG:C17898 Sinactine generic -metabolite KEGG:C17899 Isosinomenine generic -metabolite KEGG:C17900 Menisdaurilide generic -metabolite KEGG:C17901 Simiarenol generic -metabolite KEGG:C17902 Ephedroxane generic -metabolite KEGG:C17903 (+)-N-Methylpseudoephedrine generic -metabolite KEGG:C17904 alpha-Allokainic acid generic -metabolite KEGG:C17905 Cannabisin A generic -metabolite KEGG:C17906 Cannabisin B generic -metabolite KEGG:C17907 Cannabisin C generic -metabolite KEGG:C17908 Cannabisin D generic -metabolite KEGG:C17909 Cannabisin E generic -metabolite KEGG:C17910 Cannabisin F generic -metabolite KEGG:C17911 Cannabisin G generic -metabolite KEGG:C17912 Isozaluzanin C generic -metabolite KEGG:C17913 Isodehydrocostus lactone generic -metabolite KEGG:C17914 Nootkatone generic -metabolite KEGG:C17915 Nootkatol generic -metabolite KEGG:C17916 Coixinden A generic -metabolite KEGG:C17917 Coixinden B generic -metabolite KEGG:C17918 Scabraside generic -metabolite KEGG:C17919 Rindoside generic -metabolite KEGG:C17920 Dihydroabietic acid generic -metabolite KEGG:C17921 Scopoloside I generic -metabolite KEGG:C17922 Scopoloside II generic -metabolite KEGG:C17925 Nordephrine generic -metabolite KEGG:C17926 2-Pyridinemethanamine generic -metabolite KEGG:C17927 Thiazolylethylamine generic -metabolite KEGG:C17928 2-Methylhistamine generic -metabolite KEGG:C17929 4-Methylhistamine generic -metabolite KEGG:C17930 Dimaprit generic -metabolite KEGG:C17931 Imetit generic -metabolite KEGG:C17932 Immepip generic -metabolite KEGG:C17933 Thioperamide generic -metabolite KEGG:C17934 Clobenpropit generic -metabolite KEGG:C17935 Cysteinyldopa generic -metabolite KEGG:C17936 Phaeomelanin generic -metabolite KEGG:C17937 Eumelanin generic -metabolite KEGG:C17938 5,6-Indolequinone-2-carboxylic acid generic -metabolite KEGG:C17939 10-Hydroxycamptothecin generic -metabolite KEGG:C17940 Rhizocticin B generic -metabolite KEGG:C17941 2-Oxo-4-phosphonobutanoate generic -metabolite KEGG:C17942 FR 900098 generic -metabolite KEGG:C17943 Formylphosphonate generic -metabolite KEGG:C17944 Rhizocticin A generic -metabolite KEGG:C17945 Phosphonoformyl-CMP generic -metabolite KEGG:C17946 Carboxyphosphonopyruvate generic -metabolite KEGG:C17947 2-Phosphinomethylmalate generic -metabolite KEGG:C17948 Deamino-alpha-keto-demethylphosphinothricin generic -metabolite KEGG:C17949 N-Acetyldemethylphosphinothricin generic -metabolite KEGG:C17950 N-Acetyldemethylphosphinothricin tripeptide generic -metabolite KEGG:C17951 N-Acetylbialaphos generic -metabolite KEGG:C17952 N-Acetylphosphinothricin generic -metabolite KEGG:C17953 (5S)-Albaflavenol generic -metabolite KEGG:C17954 Albaflavenone generic -metabolite KEGG:C17955 (5R)-Albaflavenol generic -metabolite KEGG:C17956 Grandifloric acid generic -metabolite KEGG:C17957 Irigenin generic -metabolite KEGG:C17958 Irisflorentin generic -metabolite KEGG:C17959 alpha-L-Rhamnosyl-(1->3)-alpha-D-galactosyl-diphosphoundecaprenol generic -metabolite KEGG:C17960 Rhizocticin C generic -metabolite KEGG:C17961 Rhizocticin D generic -metabolite KEGG:C17962 Demethylphosphinothricin generic -metabolite KEGG:C17963 Colchicoside generic -metabolite KEGG:C17964 Pilocarpidine generic -metabolite KEGG:C17965 trans-Lachnophyllol generic -metabolite KEGG:C17966 Shionone generic -metabolite KEGG:C17967 Bluensidine generic -metabolite KEGG:C17968 Kasugamycin generic -metabolite KEGG:C17969 Minosaminomycin generic -metabolite KEGG:C17970 Spenolimycin generic -metabolite KEGG:C17971 Fortimicin FU-10 generic -metabolite KEGG:C17972 Fortimicin AO generic -metabolite KEGG:C17973 Fortimicin KL1 generic -metabolite KEGG:C17974 Fortimicin KK1 generic -metabolite KEGG:C17975 Fortimicin AP generic -metabolite KEGG:C17976 Fortimicin KH generic -metabolite KEGG:C17977 Fortimicin KR generic -metabolite KEGG:C17978 1-epi-Fortimicin B generic -metabolite KEGG:C17979 Formimidoyl-fortimicin A generic -metabolite KEGG:C17980 1-Epidactimicin generic -metabolite KEGG:C17981 Istamycin FU-10 generic -metabolite KEGG:C17982 Istamycin AO generic -metabolite KEGG:C17983 Istamycin KL1 generic -metabolite KEGG:C17984 Istamycin AP generic -metabolite KEGG:C17985 Istamycin Y0 generic -metabolite KEGG:C17986 Istamycin X0 generic -metabolite KEGG:C17987 Istamycin A1 generic -metabolite KEGG:C17988 Istamycin A2 generic -metabolite KEGG:C17989 Istamycin A3 generic -metabolite KEGG:C17990 Istamycin B0 generic -metabolite KEGG:C17991 Istamycin B generic -metabolite KEGG:C17992 Istamycin B1 generic -metabolite KEGG:C17993 Istamycin B3 generic -metabolite KEGG:C17994 Istamycin C0 generic -metabolite KEGG:C17995 Istamycin C generic -metabolite KEGG:C17996 Istamycin C1 generic -metabolite KEGG:C17997 Oxyapramycin generic -metabolite KEGG:C17998 Saccharocin generic -metabolite KEGG:C17999 6-O-Glc-paromamine generic -metabolite KEGG:C18000 Nebramycin factor 4 generic -metabolite KEGG:C18001 Nebramycin 5' generic -metabolite KEGG:C18002 5-Ribosylparomamine generic -metabolite KEGG:C18003 Lividomycin B generic -metabolite KEGG:C18004 5''-Phosphoribostamycin generic -metabolite KEGG:C18005 gamma-L-Glutamyl-butirosin B generic -metabolite KEGG:C18006 gamma-L-Glutamyl-[acp] generic -metabolite KEGG:C18007 4-Aminobutyryl-[acp] generic -metabolite KEGG:C18008 4-(gamma-L-Glutamylamino)butanoyl-[acp] generic -metabolite KEGG:C18009 4-(gamma-L-Glutamylamino)-(2S)-2-hydroxybutanoyl-[acp] generic -metabolite KEGG:C18010 Deltorphin A generic -metabolite KEGG:C18011 7-Hydroxy-6-methylhepta-3,5-dienal generic -metabolite KEGG:C18012 Flaviolin generic -metabolite KEGG:C18013 3,3'-Biflaviolin generic -metabolite KEGG:C18014 3,8'-Biflaviolin generic -metabolite KEGG:C18015 Momilactone A generic -metabolite KEGG:C18016 3beta-Hydroxy-9beta-pimara-7,15-diene-19,6beta-olide generic -metabolite KEGG:C18017 8-p-Menthen-2-ol generic -metabolite KEGG:C18018 p-Menth-8-en-2-one generic -metabolite KEGG:C18019 1-Hydroxy-p-menth-8-en-2-one generic -metabolite KEGG:C18020 p-Menth-8-ene-1,2-diol generic -metabolite KEGG:C18021 Pheophorbide a generic -metabolite KEGG:C18022 Red chlorophyll catabolite generic -metabolite KEGG:C18023 Sophoraflavanone B generic -metabolite KEGG:C18024 Leachianone G generic -metabolite KEGG:C18025 (+)-Menthofuran generic -metabolite KEGG:C18026 (2S)-Ethylmalonyl-CoA generic -metabolite KEGG:C18027 (4R,7S)-7-Isopropyl-4-methyloxepan-2-one generic -metabolite KEGG:C18028 L-Fucono-1,5-lactone generic -metabolite KEGG:C18029 dTDP-3-oxo-2,6-dideoxy-D-glucose generic -metabolite KEGG:C18030 dTDP-2,6-dideoxy-D-kanosamine generic -metabolite KEGG:C18031 dTDP-D-angolosamine generic -metabolite KEGG:C18032 dTDP-4-oxo-2,3,6-trideoxy-D-glucose generic -metabolite KEGG:C18033 dTDP-4-amino-2,3,4,6-tetradeoxy-D-glucose generic -metabolite KEGG:C18034 dTDP-D-forosamine generic -metabolite KEGG:C18035 dTDP-3-methyl-4-oxo-2,6-dideoxy-D-glucose generic -metabolite KEGG:C18036 Strigolactone ABC-rings generic -metabolite KEGG:C18037 5-Deoxystrigol generic -metabolite KEGG:C18038 7alpha-Hydroxypregnenolone generic -metabolite KEGG:C18039 Aldosterone hemiacetal generic -metabolite KEGG:C18040 5alpha-Dihydrodeoxycorticosterone generic -metabolite KEGG:C18041 5alpha-Pregnan-20alpha-ol-3-one generic -metabolite KEGG:C18042 5alpha-Pregnane-3alpha,20alpha-diol generic -metabolite KEGG:C18043 Cholesterol sulfate generic -metabolite KEGG:C18044 3beta-Hydroxypregn-5-en-20-one sulfate generic -metabolite KEGG:C18045 7alpha-Hydroxydehydroepiandrosterone generic -metabolite KEGG:C18046 Biotinyl-[protein] generic -metabolite KEGG:C18047 Carboxybiotinyl-[protein] generic -metabolite KEGG:C18048 N-Succinyl-L-citrulline generic -metabolite KEGG:C18049 N-Acyl-L-homoserine lactone generic -metabolite KEGG:C18050 beta-D-Fructofuranosyl-alpha-D-mannopyranoside 6F-phosphate generic -metabolite KEGG:C18051 Chrysanthemyl diphosphate generic -metabolite KEGG:C18052 Lavandulyl diphosphate generic -metabolite KEGG:C18053 Sophoraflavanone G generic -metabolite KEGG:C18054 2-Amino-2-deoxyisochorismate generic -metabolite KEGG:C18055 N-Acetyl-alpha-D-hexosamine 1-phosphate generic -metabolite KEGG:C18056 N-Desmethylzolmitriptan generic -metabolite KEGG:C18058 1D-myo-Inositol bisdiphosphate tetrakisphosphate generic -metabolite KEGG:C18059 CDP-2,3-bis-O-(geranylgeranyl)-sn-glycerol generic -metabolite KEGG:C18060 N-Acetyl-alpha-D-galactosamine 1-phosphate generic -metabolite KEGG:C18061 N-Acyl-L-homoserine generic -metabolite KEGG:C18062 TRIBOA-glucoside generic -metabolite KEGG:C18063 C-13(2)-Carboxypyropheophorbide a generic -metabolite KEGG:C18064 Pyropheophorbide a generic -metabolite KEGG:C18066 7-Isopropyl-4-methyloxepan-2-one generic -metabolite KEGG:C18067 6-Hydroxy-3,7-dimethyloctanoate generic -metabolite KEGG:C18068 beta-D-Fructofuranosyl-alpha-D-mannopyranoside generic -metabolite KEGG:C18069 N1,N5,N10-Tricoumaroyl spermidine generic -metabolite KEGG:C18070 N1,N5,N10-Tricaffeoyl spermidine generic -metabolite KEGG:C18071 N1,N5,N10-Triferuloyl spermidine generic -metabolite KEGG:C18072 N1,N5,N10-Tri(hydroxyferuloyl) spermidine generic -metabolite KEGG:C18073 N1,N5-Di(hydroxyferuloyl)-N10-sinapoyl spermidine generic -metabolite KEGG:C18075 11beta,17beta-Dihydroxy-4-androsten-3-one generic -metabolite KEGG:C18076 5'-Phosphoguanylyl(3'->5')guanosine generic -metabolite KEGG:C18077 Methylenedioxycinnamic acid generic -metabolite KEGG:C18078 Ayapin generic -metabolite KEGG:C18079 Isoscopoletin generic -metabolite KEGG:C18080 Osthenol generic -metabolite KEGG:C18081 Sphondin generic -metabolite KEGG:C18082 Isobergapten generic -metabolite KEGG:C18083 Demethylsuberosin generic -metabolite KEGG:C18084 Isobergaptol generic -metabolite KEGG:C18085 6-Hydroxyangelicin generic -metabolite KEGG:C18086 2'-Hydroxy caffeic acid generic -metabolite KEGG:C18087 2'-Hydroxyferulic acid generic -metabolite KEGG:C18088 2'-Hydroxy-MDCA generic -metabolite KEGG:C18089 2',4'-Dihydroxycinnamic acid generic -metabolite KEGG:C18090 Tricaine generic -metabolite KEGG:C18091 Ethylnitronate generic -metabolite KEGG:C18092 dTDP-L-ristosamine generic -metabolite KEGG:C18093 Iopodic acid generic -metabolite KEGG:C18094 UDP-L-arabinofuranose generic -metabolite KEGG:C18095 Deltorphin B generic -metabolite KEGG:C18096 D-Allulose 6-phosphate generic -metabolite KEGG:C18097 Deltorphin C generic -metabolite KEGG:C18098 Primary fluorescent chlorophyll catabolite generic -metabolite KEGG:C18099 1,2,3,7,8-Pentachlorodibenzodioxin generic -metabolite KEGG:C18100 1,2,3,4,7,8-Hexachlorodibenzodioxin generic -metabolite KEGG:C18101 1,2,3,6,7,8-Hexachlorodibenzodioxin generic -metabolite KEGG:C18102 1,2,3,7,8,9-Hexachlorodibenzodioxin generic -metabolite KEGG:C18103 1,2,3,4,6,7,8-Heptachlorodibenzodioxin generic -metabolite KEGG:C18104 2,3,7,8-Tetrachlorodibenzofuran generic -metabolite KEGG:C18105 1,2,3,7,8-Pentachlorodibenzofuran generic -metabolite KEGG:C18106 2,3,4,7,8-Pentachlorodibenzofuran generic -metabolite KEGG:C18107 1,2,3,4,7,8-Hexachlorodibenzofuran generic -metabolite KEGG:C18108 1,2,3,7,8,9-Hexachlorodibenzofuran generic -metabolite KEGG:C18109 1,2,3,6,7,8-Hexachlorodibenzofuran generic -metabolite KEGG:C18110 2,3,4,6,7,8-Hexachlorodibenzofuran generic -metabolite KEGG:C18111 1,2,3,4,6,7,8-Heptachlorodibenzofuran generic -metabolite KEGG:C18112 1,2,3,4,7,8,9-Heptachlorodibenzofuran generic -metabolite KEGG:C18113 1,2,3,4,6,7,8,9-Octachlorodibenzofuran generic -metabolite KEGG:C18114 3,4,4',5-Tetrachlorobiphenyl generic -metabolite KEGG:C18115 3,4,5,3',4',5'-Hexachlorobiphenyl generic -metabolite KEGG:C18116 2,3,4,3',4'-Pentachlorobiphenyl generic -metabolite KEGG:C18117 2,3,4,4',5-Pentachlorobiphenyl generic -metabolite KEGG:C18118 2,3',4,4',5-Pentachlorobiphenyl generic -metabolite KEGG:C18119 2,3',4,4',5'-Pentachlorobiphenyl generic -metabolite KEGG:C18120 2,3,3',4,4',5-Hexachlorobiphenyl generic -metabolite KEGG:C18121 2,3,3',4,4',5'-Hexachlorobiphenyl generic -metabolite KEGG:C18122 2,3',4,4',5,5'-Hexachlorobiphenyl generic -metabolite KEGG:C18123 2,3,3',4,4',5,5'-Heptachlorobiphenyl generic -metabolite KEGG:C18124 Endrin generic -metabolite KEGG:C18125 1-Acyl-sn-glycero-3-phosphoserine generic -metabolite KEGG:C18126 1-Acyl-sn-glycero-3-phosphoglycerol generic -metabolite KEGG:C18127 beta-Funaltrexamine generic -metabolite KEGG:C18128 Naltrindole generic -metabolite KEGG:C18129 Monolysocardiolipin generic -metabolite KEGG:C18130 Norbinaltorphimine generic -metabolite KEGG:C18131 Geranyl-hydroxybenzoate generic -metabolite KEGG:C18132 3''-Hydroxy-geranylhydroquinone generic -metabolite KEGG:C18133 Deoxyshikonin generic -metabolite KEGG:C18134 Dihydroechinofuran generic -metabolite KEGG:C18135 Dihydroshikonofuran generic -metabolite KEGG:C18136 2''-Adenylylgentamicin A generic -metabolite KEGG:C18137 2,2',4,4',5,5'-Hexabromodiphenyl ether generic -metabolite KEGG:C18138 2,2',4,4',5,6'-Hexabromodiphenyl ether generic -metabolite KEGG:C18139 2,2',3,3',4',5,6'-Heptabromodiphenyl ether generic -metabolite KEGG:C18140 2,2',3,4,4',5',6-Heptabromodiphenyl ether generic -metabolite KEGG:C18141 Pentachlorobenzene generic -metabolite KEGG:C18142 Perfluorooctanesulfonic acid generic -metabolite KEGG:C18143 Perfluorooctylsulfonyl fluoride generic -metabolite KEGG:C18144 Metiram generic -metabolite KEGG:C18145 trans-Nonachlor generic -metabolite KEGG:C18146 Oxychlordane generic -metabolite KEGG:C18147 Esfenvalerate generic -metabolite KEGG:C18148 Octachlorostyrene generic -metabolite KEGG:C18149 Tributyltin oxide generic -metabolite KEGG:C18150 n-Butylbenzene generic -metabolite KEGG:C18151 7(1)-Hydroxychlorophyll a generic -metabolite KEGG:C18152 3-Vinylbacteriochlorophyllide a generic -metabolite KEGG:C18153 3-Hydroxyethylbacteriochlorophyllide a generic -metabolite KEGG:C18154 3-Hydroxyethylchlorophyllide a generic -metabolite KEGG:C18155 Bacteriochlorophyllide a generic -metabolite KEGG:C18156 Bacteriochlorophyllide b generic -metabolite KEGG:C18157 8-Ethyl-12-methyl-3-vinylbacteriochlorophyllide d generic -metabolite KEGG:C18158 17-Oxosparteine generic -metabolite KEGG:C18159 Polyplatillen generic -metabolite KEGG:C18160 Bacteriochlorophyllide d generic -metabolite KEGG:C18161 Bacteriochlorophyllide c generic -metabolite KEGG:C18162 Bacteriochlorophyll d generic -metabolite KEGG:C18163 Bacteriochlorophyll c generic -metabolite KEGG:C18164 Deoxymiroestrol generic -metabolite KEGG:C18165 Enterolactone generic -metabolite KEGG:C18166 Enterodiol generic -metabolite KEGG:C18167 Secoisolariciresinol generic -metabolite KEGG:C18168 Diacylglycerylhomoserine generic -metabolite KEGG:C18169 Diacylglyceryl-N,N,N-trimethylhomoserine generic -metabolite KEGG:C18170 3-Acetamidopropanal generic -metabolite KEGG:C18171 Resolvin E1 generic -metabolite KEGG:C18172 Carboxyspermidine generic -metabolite KEGG:C18173 Resolvin E2 generic -metabolite KEGG:C18174 Carboxynorspermidine generic -metabolite KEGG:C18175 5,6-Epoxy-18R-HEPE generic -metabolite KEGG:C18176 5S-Hydroperoxy-18R-HEPE generic -metabolite KEGG:C18177 18R-HEPE generic -metabolite KEGG:C18178 Resolvin D1 generic -metabolite KEGG:C18179 Resolvin D2 generic -metabolite KEGG:C18180 1,2,3,4,6,7,8,9-Octachlorodibenzo-p-dioxin generic -metabolite KEGG:C18181 Growth hormone generic -metabolite KEGG:C18182 Thyroid stimulating hormone generic -metabolite KEGG:C18183 Luteinizing hormone generic -metabolite KEGG:C18184 Follicle stimulating hormone generic -metabolite KEGG:C18185 Chorionic gonadotropin generic -metabolite KEGG:C18186 Gastrin-14 generic -metabolite KEGG:C18187 Gastrin-34 generic -metabolite KEGG:C18188 Leptin generic -metabolite KEGG:C18189 Adiponectin generic -metabolite KEGG:C18190 Resistin generic -metabolite KEGG:C18191 13-Sophorosyloxydocosanoic acid generic -metabolite KEGG:C18192 Vitamin D4 generic -metabolite KEGG:C18193 Vitamin D5 generic -metabolite KEGG:C18195 (3R)-11-cis-3-Hydroxyretinal generic -metabolite KEGG:C18196 (3R)-all-trans-3-Hydroxyretinal generic -metabolite KEGG:C18197 Oxyntomodulin generic -metabolite KEGG:C18198 Proadrenomedullin N-terminal 20 peptide generic -metabolite KEGG:C18200 Erythropoietin generic -metabolite KEGG:C18201 Prolactin generic -metabolite KEGG:C18202 8-Methyl-6-nonenoic acid generic -metabolite KEGG:C18203 2,2',4,4',5-Pentabromodiphenyl ether generic -metabolite KEGG:C18204 2,2',4,5'-Tetrabromodiphenyl ether generic -metabolite KEGG:C18205 2,2',4,4'-Tetrabromodiphenyl ether generic -metabolite KEGG:C18206 cis-11-Methyl-2-dodecenoic acid generic -metabolite KEGG:C18208 Activin AB generic -metabolite KEGG:C18209 Activin B generic -metabolite KEGG:C18210 Placental lactogen generic -metabolite KEGG:C18211 Isopimara-7,15-diene generic -metabolite KEGG:C18212 Jamaicamide A generic -metabolite KEGG:C18213 Jamaicamide B generic -metabolite KEGG:C18214 Jamaicamide C generic -metabolite KEGG:C18215 Bis(4-hydroxyphenyl)methanol generic -metabolite KEGG:C18216 4-Hydroxyphenyl-4-hydroxybenzoate generic -metabolite KEGG:C18217 16-Feruloyloxypalmitate generic -metabolite KEGG:C18218 16-Hydroxypalmitate generic -metabolite KEGG:C18219 Palustradienol generic -metabolite KEGG:C18220 Palustradienal generic -metabolite KEGG:C18221 Isopimaradienol generic -metabolite KEGG:C18222 Isopimaradienal generic -metabolite KEGG:C18223 Stemar-13-ene generic -metabolite KEGG:C18224 Stemod-13(17)-ene generic -metabolite KEGG:C18225 9beta-Pimara-7,15-diene generic -metabolite KEGG:C18226 ent-Cassa-12,15-diene generic -metabolite KEGG:C18228 ent-Pimara-8(14),15-diene generic -metabolite KEGG:C18229 Fusicocca-2,10(14)-diene generic -metabolite KEGG:C18230 Calcitroic acid generic -metabolite KEGG:C18231 Calcitetrol generic -metabolite KEGG:C18232 N-Formylmaleamic acid generic -metabolite KEGG:C18233 Ferricytochrome cL generic -metabolite KEGG:C18234 Ferrocytochrome cL generic -metabolite KEGG:C18235 S-(Hydroxymethyl)mycothiol generic -metabolite KEGG:C18236 1,2,3,4-Tetrachlorobenzene generic -metabolite KEGG:C18237 Molybdoenzyme molybdenum cofactor generic -metabolite KEGG:C18238 cis-Chlorobenzene dihydrodiol generic -metabolite KEGG:C18239 Precursor Z generic -metabolite KEGG:C18240 Tetrachlorocatechol generic -metabolite KEGG:C18241 Tetrachloro-cis,cis-muconate generic -metabolite KEGG:C18242 2,3,5-Trichlorodienelactone generic -metabolite KEGG:C18243 2,3,5-Trichloromaleylacetate generic -metabolite KEGG:C18244 2,4-Dichloro-3-oxoadipate generic -metabolite KEGG:C18245 8-epi-Cedrol generic -metabolite KEGG:C18246 1,1,1-Trichloroethane generic -metabolite KEGG:C18247 1,1-Dichloroethane generic -metabolite KEGG:C18248 Chloroethane generic -metabolite KEGG:C18249 cis-4,5-Dihydroxy-4,5-dihydropyrene generic -metabolite KEGG:C18250 4,5-Dihydroxypyrene generic -metabolite KEGG:C18251 Pyrene-4,5-dione generic -metabolite KEGG:C18252 Phenanthrene-4,5-dicarboxylate generic -metabolite KEGG:C18253 Phenanthrene-4-carboxylate generic -metabolite KEGG:C18254 Pyrene-4,5-oxide generic -metabolite KEGG:C18255 trans-4,5-Dihydroxy-4,5-dihydropyrene generic -metabolite KEGG:C18256 cis-3,4-Phenanthrenedihydrodiol-4-carboxylate generic -metabolite KEGG:C18257 Pyrene-1,6-dione generic -metabolite KEGG:C18258 Pyrene-1,8-dione generic -metabolite KEGG:C18259 1-Methoxypyrene generic -metabolite KEGG:C18260 1,6-Dimethoxypyrene generic -metabolite KEGG:C18261 1-Hydroxy-6-methoxypyrene generic -metabolite KEGG:C18262 1-Methoxypyrene-6,7-oxide generic -metabolite KEGG:C18263 1,6-Dihydroxypyrene generic -metabolite KEGG:C18264 1,8-Dihydroxypyrene generic -metabolite KEGG:C18265 1-Hydroxypyrene-6,7-oxide generic -metabolite KEGG:C18266 1-Hydroxypyrene-7,8-oxide generic -metabolite KEGG:C18267 Pyrene-1,2-oxide generic -metabolite KEGG:C18268 2-Hydroxypyrene generic -metabolite KEGG:C18269 1-Pyrenylsulfate generic -metabolite KEGG:C18270 Benzo[a]pyrene-cis-4,5-dihydrodiol generic -metabolite KEGG:C18271 cis-4-(7-Hydroxtpyren-8-yl)-2-oxobut-3-enoate generic -metabolite KEGG:C18272 cis-4-(8-Hydroxypyren-7-yl)-2-oxobut-3-enoate generic -metabolite KEGG:C18273 7,8-Dihydropyrene-8-carboxylate generic -metabolite KEGG:C18274 7,8-Dihydropyrene-7-carboxylate generic -metabolite KEGG:C18275 Benzo[a]pyrene-cis-7,8-dihydrodiol generic -metabolite KEGG:C18276 Benzo[a]pyrene-cis-9,10-dihydrodiol generic -metabolite KEGG:C18277 4,5-Chrysenedicarboxylate generic -metabolite KEGG:C18278 9,10-Dihydroxybenzo[a]pyrene generic -metabolite KEGG:C18279 4,5-Dihydroxybenzo[a]pyrene generic -metabolite KEGG:C18280 11,12-Dihydroxybenzo[a]pyrene generic -metabolite KEGG:C18281 10-Oxabenzo[def]chrysen-9-one generic -metabolite KEGG:C18282 5-Chrysenecarboxylate generic -metabolite KEGG:C18283 4-Chrysenecarboxylate generic -metabolite KEGG:C18284 Benzo[a]pyrene-cis-11,12-dihydrodiol generic -metabolite KEGG:C18285 Benzo[a]pyrene-trans-11,12-dihydrodiol generic -metabolite KEGG:C18286 Benzo[a]pyrene-11,12-epoxide generic -metabolite KEGG:C18287 Monocyte locomotion inhibitory factor generic -metabolite KEGG:C18293 Nonaketamide monocyclic intermediate generic -metabolite KEGG:C18294 Nonaketamide tricyclic intermediate generic -metabolite KEGG:C18295 Pretetramid generic -metabolite KEGG:C18296 5a,11a-Dehydrooxytetracycline generic -metabolite KEGG:C18297 Anhydrochlortetracycline generic -metabolite KEGG:C18298 5a,11a-Dehydrochlortetracycline generic -metabolite KEGG:C18299 4-Aminoanhydrochlortetracycline generic -metabolite KEGG:C18300 2,4-Dichlorotoluene generic -metabolite KEGG:C18301 4,6-Dichloro-3-methyl-cis-1,2-dihydroxycyclohexa-3,5-diene generic -metabolite KEGG:C18302 4,6-Dichloro-3-methylcatechol generic -metabolite KEGG:C18303 3,5-Dichloro-2-methylmuconate generic -metabolite KEGG:C18304 2-Chloro-5-methyl-cis-dienelactone generic -metabolite KEGG:C18305 2-Chloro-5-methylmaleylacetate generic -metabolite KEGG:C18306 5-Methylmaleylacetate generic -metabolite KEGG:C18307 2-Methyl-3-oxoadipate generic -metabolite KEGG:C18308 3,5-Dichloro-2-methylmuconolactone generic -metabolite KEGG:C18309 3-Chloro-2-methyldienelactone generic -metabolite KEGG:C18310 3-Chloro-2-methylmaleylacetate generic -metabolite KEGG:C18311 4-Methyl-3-oxoadipate-enol-lactone generic -metabolite KEGG:C18312 4-Methyl-3-oxoadipate generic -metabolite KEGG:C18313 LL-37 generic -metabolite KEGG:C18314 Phthalate 3,4-cis-dihydrodiol generic -metabolite KEGG:C18315 4-Methyl-5-nitrocatechol generic -metabolite KEGG:C18316 2-Hydroxy-5-methylquinone generic -metabolite KEGG:C18317 2,4,5-Trihydroxytoluene generic -metabolite KEGG:C18318 cis,cis-2,4-Dihydroxy-5-methyl-6-oxo-2,4-hexadienoate generic -metabolite KEGG:C18319 2-Methylbutyrate generic -metabolite KEGG:C18320 4-Amino-2-nitrotoluene generic -metabolite KEGG:C18321 trans,octacis-Decaprenyl diphosphate generic -metabolite KEGG:C18323 3-Methylfumaryl-CoA generic -metabolite KEGG:C18324 (2S)-Methylsuccinyl-CoA generic -metabolite KEGG:C18325 Feruloylagmatine generic -metabolite KEGG:C18326 p-Coumaroylputrescine generic -metabolite KEGG:C18327 7,9,12-Octaketide intermediate 1 generic -metabolite KEGG:C18328 7,9,12-Octaketide intermediate 2 generic -metabolite KEGG:C18329 7,9,12-Octaketide intermediate 3 generic -metabolite KEGG:C18330 7,9,12-Decaketide intermediate 1 generic -metabolite KEGG:C18331 7,9,12-Decaketide intermediate 2 generic -metabolite KEGG:C18332 7,9,12-Decaketide intermediate 3 generic -metabolite KEGG:C18333 7,9,12-Decaketide intermediate 4 generic -metabolite KEGG:C18334 7,9,12-Decaketide intermediate 5 generic -metabolite KEGG:C18335 7,9,12-Decaketide intermediate 6 generic -metabolite KEGG:C18336 7,12-Decaketide intermediate 1 generic -metabolite KEGG:C18337 9,14-Decaketide intermediate 1 generic -metabolite KEGG:C18338 5-Carboxyvanillic acid generic -metabolite KEGG:C18339 L-Ascorbic acid-2-glucoside generic -metabolite KEGG:C18340 Magnesium L-ascorbic acid-2-phosphate generic -metabolite KEGG:C18341 Sodium L-ascorbic acid 2-phosphate generic -metabolite KEGG:C18342 3-O-Ethyl-L-ascorbic acid generic -metabolite KEGG:C18343 4-n-Butylresorcinol generic -metabolite KEGG:C18344 Adenosine 5'-phosphate disodium generic -metabolite KEGG:C18345 4-Carboxy-2-hydroxy-6-methoxy-6-oxohexa-2,4-dienoate generic -metabolite KEGG:C18346 4-Methoxy potassium salicylate generic -metabolite KEGG:C18347 5,5'-Dehydrodivanillate generic -metabolite KEGG:C18348 2,2',3-Trihydroxy-3'-methoxy-5,5'-dicarboxybiphenyl generic -metabolite KEGG:C18349 4-[2-(5-Carboxy-2-hydroxy-3-methoxyphenyl)-2-oxoethylidene]-2-hydroxy-2-pentenedioate generic -metabolite KEGG:C18350 Asulam generic -metabolite KEGG:C18351 4-Aminocatechol generic -metabolite KEGG:C18352 Oxocamphor generic -metabolite KEGG:C18353 Octaketide bicyclic intermediate generic -metabolite KEGG:C18354 (S)-Chiral alcohol generic -metabolite KEGG:C18355 (R)-Chiral alcohol generic -metabolite KEGG:C18356 (S)-Hemiketal generic -metabolite KEGG:C18357 (R)-Hemiketal generic -metabolite KEGG:C18358 DHKred-OH generic -metabolite KEGG:C18359 Dihydrogranaticin generic -metabolite KEGG:C18360 Dihydrokalafungin dihydroquinone form generic -metabolite KEGG:C18361 Mafoprazine mesylate generic -metabolite KEGG:C18362 Tepoxalin generic -metabolite KEGG:C18363 Firocoxib generic -metabolite KEGG:C18364 Carprofen generic -metabolite KEGG:C18365 Carbetocin generic -metabolite KEGG:C18366 Sodium iodate generic -metabolite KEGG:C18367 Malachite green generic -metabolite KEGG:C18368 Chlorine dioxide generic -metabolite KEGG:C18369 dl-Camphor generic -metabolite KEGG:C18370 Alkyldiaminoethylglycine hydrochloride generic -metabolite KEGG:C18371 Stearyltrimethylammonium chloride generic -metabolite KEGG:C18372 Chlorhexidine acetate generic -metabolite KEGG:C18373 Tetramethrin generic -metabolite KEGG:C18374 Clostebol acetate generic -metabolite KEGG:C18375 Osaterone acetate generic -metabolite KEGG:C18376 Fursultiamine hydrochloride generic -metabolite KEGG:C18377 Thiamine disulfide generic -metabolite KEGG:C18378 Menadione sodium bisulfite generic -metabolite KEGG:C18379 Calcium propionate generic -metabolite KEGG:C18380 Calcium levulinate anhydrous generic -metabolite KEGG:C18381 Calcium iodide generic -metabolite KEGG:C18382 Ethylendiamine dihydroiodide generic -metabolite KEGG:C18383 Sodium chondroitin sulfate generic -metabolite KEGG:C18384 Magnesium dipropionate generic -metabolite KEGG:C18386 Sulfadimethoxine sodium generic -metabolite KEGG:C18387 Sulfamoyldapsone generic -metabolite KEGG:C18388 Diminazene generic -metabolite KEGG:C18389 Nicarbazin generic -metabolite KEGG:C18390 Emodepside generic -metabolite KEGG:C18391 Dithiazanine iodide generic -metabolite KEGG:C18392 Bromofenofos generic -metabolite KEGG:C18393 Disophenol generic -metabolite KEGG:C18394 Anilofos generic -metabolite KEGG:C18395 Cadusafos generic -metabolite KEGG:C18396 Methyridine generic -metabolite KEGG:C18397 Cyanophos generic -metabolite KEGG:C18398 Dichlofenthion generic -metabolite KEGG:C18399 Ethephon generic -metabolite KEGG:C18400 Disulfoton generic -metabolite KEGG:C18401 Fosetyl generic -metabolite KEGG:C18402 Fosthiazate generic -metabolite KEGG:C18403 Pirimiphos-methyl generic -metabolite KEGG:C18404 Profenofos generic -metabolite KEGG:C18405 Prothiofos generic -metabolite KEGG:C18406 Pyraclofos generic -metabolite KEGG:C18407 Tolclofos-methyl generic -metabolite KEGG:C18408 Acrinathrin generic -metabolite KEGG:C18409 Cycloprothrin generic -metabolite KEGG:C18410 Etofenprox generic -metabolite KEGG:C18411 Fenpropathrin generic -metabolite KEGG:C18412 Silafluofen generic -metabolite KEGG:C18413 Tralomethrin generic -metabolite KEGG:C18414 Alanycarb generic -metabolite KEGG:C18415 Benthiavalicarb isopropyl generic -metabolite KEGG:C18416 Carbosulfan generic -metabolite KEGG:C18417 Desmedipham generic -metabolite KEGG:C18418 Isoprocarb generic -metabolite KEGG:C18419 Oxamyl generic -metabolite KEGG:C18420 Phenmedipham generic -metabolite KEGG:C18421 Propamocarb hydrochloride generic -metabolite KEGG:C18422 Pyributicarb generic -metabolite KEGG:C18423 Thiodicarb generic -metabolite KEGG:C18424 Metam-sodium generic -metabolite KEGG:C18425 Cumyluron generic -metabolite KEGG:C18426 Chlorfluazuron generic -metabolite KEGG:C18427 Daimuron generic -metabolite KEGG:C18428 Diuron generic -metabolite KEGG:C18429 Flucetosulfuron generic -metabolite KEGG:C18430 Flufenoxuron generic -metabolite KEGG:C18431 Iodosulfuron-methyl-sodium generic -metabolite KEGG:C18432 Isouron generic -metabolite KEGG:C18433 Karbutilate generic -metabolite KEGG:C18434 Lufenuron generic -metabolite KEGG:C18435 Siduron generic -metabolite KEGG:C18436 Tebuthiuron generic -metabolite KEGG:C18437 Teflubenzuron generic -metabolite KEGG:C18438 Azimsulfuron generic -metabolite KEGG:C18439 Cyclosulfamuron generic -metabolite KEGG:C18440 Ethoxysulfuron generic -metabolite KEGG:C18441 Flazasulfuron generic -metabolite KEGG:C18442 Halosulfuron-methyl generic -metabolite KEGG:C18443 Imazosulfuron generic -metabolite KEGG:C18444 Pyrazosulfuron-ethyl generic -metabolite KEGG:C18445 Chloropicrin generic -metabolite KEGG:C18446 Dienochlor generic -metabolite KEGG:C18447 Methyl bromide generic -metabolite KEGG:C18448 Methyl iodide generic -metabolite KEGG:C18449 Amobam generic -metabolite KEGG:C18450 Propineb generic -metabolite KEGG:C18451 Tetradifon generic -metabolite KEGG:C18452 Benfuresate generic -metabolite KEGG:C18453 Bispyribac-sodium generic -metabolite KEGG:C18454 Chlorantraniliprole generic -metabolite KEGG:C18455 Chlorfenapyr generic -metabolite KEGG:C18456 Cyproconazole generic -metabolite KEGG:C18457 Dazomet generic -metabolite KEGG:C18458 Diclomezine generic -metabolite KEGG:C18459 Difenoconazole generic -metabolite KEGG:C18460 Echlomezole generic -metabolite KEGG:C18461 Fenbuconazole generic -metabolite KEGG:C18462 Fludioxonil generic -metabolite KEGG:C18463 Flonicamid generic -metabolite KEGG:C18464 Fluopicolide generic -metabolite KEGG:C18465 Flurprimidol generic -metabolite KEGG:C18466 Hexaconazole generic -metabolite KEGG:C18467 Hexythiazox generic -metabolite KEGG:C18468 Imibenconazole generic -metabolite KEGG:C18469 Imicyafos generic -metabolite KEGG:C18470 Indanofan generic -metabolite KEGG:C18471 Ipconazole generic -metabolite KEGG:C18472 L-Capreomycidine generic -metabolite KEGG:C18473 beta-Hydroxyarginine generic -metabolite KEGG:C18474 Maleic hydrazide generic -metabolite KEGG:C18475 Mepiquat chloride generic -metabolite KEGG:C18476 Metconazole generic -metabolite KEGG:C18477 Myclobutanil generic -metabolite KEGG:C18478 Oxyquinoline sulfate generic -metabolite KEGG:C18479 Paclobutrazol generic -metabolite KEGG:C18480 Pefurazoate generic -metabolite KEGG:C18481 Penoxsulam generic -metabolite KEGG:C18482 Penthiopyrad generic -metabolite KEGG:C18483 Probenazole generic -metabolite KEGG:C18484 Pyridalyl generic -metabolite KEGG:C18485 Pyriftalid generic -metabolite KEGG:C18486 Pyriminobac-methyl generic -metabolite KEGG:C18487 Pyroquilon generic -metabolite KEGG:C18488 Spiromesifen generic -metabolite KEGG:C18489 Tebuconazole generic -metabolite KEGG:C18490 Tetraconazole generic -metabolite KEGG:C18491 Tolfenpyrad generic -metabolite KEGG:C18492 Tricyclazole generic -metabolite KEGG:C18493 Triflumizole generic -metabolite KEGG:C18494 Uniconazole P generic -metabolite KEGG:C18495 Etoxazole generic -metabolite KEGG:C18496 Oxadiazon generic -metabolite KEGG:C18497 Cafenstrole generic -metabolite KEGG:C18498 Cymoxanil generic -metabolite KEGG:C18499 Dimethenamid generic -metabolite KEGG:C18500 Etobenzanid generic -metabolite KEGG:C18501 Fentrazamide generic -metabolite KEGG:C18502 Flutolanil generic -metabolite KEGG:C18503 Furametpyr generic -metabolite KEGG:C18504 Isoxaben generic -metabolite KEGG:C18505 Thifluzamide generic -metabolite KEGG:C18506 Furamethrin generic -metabolite KEGG:C18507 Acetamiprid generic -metabolite KEGG:C18508 Clothianidin generic -metabolite KEGG:C18509 Dinotefuran generic -metabolite KEGG:C18510 Prallethrin generic -metabolite KEGG:C18511 Nitenpyram generic -metabolite KEGG:C18512 Thiacloprid generic -metabolite KEGG:C18513 Thiamethoxam generic -metabolite KEGG:C18514 Chlorophacinone generic -metabolite KEGG:C18515 Chromafenozide generic -metabolite KEGG:C18516 Cyflufenamid generic -metabolite KEGG:C18517 Cyflumetofen generic -metabolite KEGG:C18518 Diclocymet generic -metabolite KEGG:C18519 Fenoxanil generic -metabolite KEGG:C18520 Flubendiamide generic -metabolite KEGG:C18521 Flusulfamide generic -metabolite KEGG:C18522 Mandipropamid generic -metabolite KEGG:C18523 Metaflumizone generic -metabolite KEGG:C18524 Empenthrin generic -metabolite KEGG:C18525 Methoxyfenozide generic -metabolite KEGG:C18526 Tebufenozide generic -metabolite KEGG:C18527 Fluazifop generic -metabolite KEGG:C18528 MCPA generic -metabolite KEGG:C18529 2-Methyl-4-chlorophenoxybutyric acid generic -metabolite KEGG:C18530 Quizalofop-ethyl generic -metabolite KEGG:C18531 Clomeprop generic -metabolite KEGG:C18532 Ethychlozate generic -metabolite KEGG:C18533 alpha-Naphthylacetamide generic -metabolite KEGG:C18534 1-Naphthaleneacetic acid sodium salt generic -metabolite KEGG:C18535 Acequinocyl generic -metabolite KEGG:C18536 Benzobicyclon generic -metabolite KEGG:C18537 Dimethametryn generic -metabolite KEGG:C18538 Prohydrojasmon generic -metabolite KEGG:C18539 Sethoxydim generic -metabolite KEGG:C18540 Tepraloxydim generic -metabolite KEGG:C18541 Trinexapac-ethyl generic -metabolite KEGG:C18542 Prometryn generic -metabolite KEGG:C18543 Flupoxam generic -metabolite KEGG:C18544 Simeconazole generic -metabolite KEGG:C18545 Cyenopyrafen generic -metabolite KEGG:C18546 Ioxynil generic -metabolite KEGG:C18547 Boscalid generic -metabolite KEGG:C18548 Mepronil generic -metabolite KEGG:C18549 Diflufenican generic -metabolite KEGG:C18550 Tiadinil generic -metabolite KEGG:C18551 Fluoroimide generic -metabolite KEGG:C18552 Ethiprole generic -metabolite KEGG:C18553 Spirodiclofen generic -metabolite KEGG:C18554 Pyraflufen-ethyl generic -metabolite KEGG:C18555 Benzofenap generic -metabolite KEGG:C18556 Pyrazoxyfen generic -metabolite KEGG:C18557 Milbemectin generic -metabolite KEGG:C18558 Azoxystrobin generic -metabolite KEGG:C18559 Metominostrobin generic -metabolite KEGG:C18560 Orysastrobin generic -metabolite KEGG:C18561 Pyraclostrobin generic -metabolite KEGG:C18562 Trifloxystrobin generic -metabolite KEGG:C18563 Bensultap generic -metabolite KEGG:C18564 Glyphosate-isopropylammonium generic -metabolite KEGG:C18565 Glyphosate-monoammonium generic -metabolite KEGG:C18566 Calcium peroxide generic -metabolite KEGG:C18567 Thallium sulfate generic -metabolite KEGG:C18568 Iminoctadine acetate generic -metabolite KEGG:C18569 Indoxacarb generic -metabolite KEGG:C18570 Chloridazon generic -metabolite KEGG:C18571 Oxaziclomefone generic -metabolite KEGG:C18572 Oxpoconazole fumarate generic -metabolite KEGG:C18573 Cyazofamid generic -metabolite KEGG:C18574 Dithianon generic -metabolite KEGG:C18575 Quinoxaline generic -metabolite KEGG:C18576 Clofentezine generic -metabolite KEGG:C18577 Diquat generic -metabolite KEGG:C18578 Fluazinam generic -metabolite KEGG:C18579 Ferimzone generic -metabolite KEGG:C18580 Pyriprole generic -metabolite KEGG:C18581 Amisulbrom generic -metabolite KEGG:C18582 Butralin generic -metabolite KEGG:C18583 Dimethomorph generic -metabolite KEGG:C18584 Quinoclamin generic -metabolite KEGG:C18585 Chlormequat generic -metabolite KEGG:C18586 Calcium formate generic -metabolite KEGG:C18587 Methyl isothiocyanate generic -metabolite KEGG:C18588 Sodium fluoroacetate generic -metabolite KEGG:C18589 Bifenazate generic -metabolite KEGG:C18590 Pymetrozine generic -metabolite KEGG:C18591 Famoxadone generic -metabolite KEGG:C18592 Pentoxazone generic -metabolite KEGG:C18593 Fenhexamid generic -metabolite KEGG:C18594 Bentazone-sodium generic -metabolite KEGG:C18595 Fluacrypyrim generic -metabolite KEGG:C18596 Bromadiolone generic -metabolite KEGG:C18597 Dicamba generic -metabolite KEGG:C18598 Imazamox generic -metabolite KEGG:C18599 Coumafuryl generic -metabolite KEGG:C18600 Dalapon generic -metabolite KEGG:C18601 Sodium oleate generic -metabolite KEGG:C18602 Propargite generic -metabolite KEGG:C18603 Pyrimidifen generic -metabolite KEGG:C18604 Forchlorfenuron generic -metabolite KEGG:C18605 Pyriproxyfen generic -metabolite KEGG:C18606 Potassium bicarbonate generic -metabolite KEGG:C18607 Cyhalofop-butyl generic -metabolite KEGG:C18608 Mecoprop-P generic -metabolite KEGG:C18609 Clethodim generic -metabolite KEGG:C18610 Monoammonium glycyrrhizinate generic -metabolite KEGG:C18611 Phthalide generic -metabolite KEGG:C18612 Nonoxynol-9 iodine generic -metabolite KEGG:C18613 Pyraclonil generic -metabolite KEGG:C18614 Pyridaben generic -metabolite KEGG:C18615 Triflumuron generic -metabolite KEGG:C18616 Methoxymalonyl-[acp] generic -metabolite KEGG:C18617 Hydroxymalonyl-[acp] generic -metabolite KEGG:C18618 Aminomalonyl-[acp] generic -metabolite KEGG:C18619 4-Dimethylamino-L-phenylalanine generic -metabolite KEGG:C18620 3-Hydroxypicolinic acid generic -metabolite KEGG:C18621 3-Hydroxyquinaldic acid generic -metabolite KEGG:C18622 L-Homotyrosine generic -metabolite KEGG:C18623 L-Phenylglycine generic -metabolite KEGG:C18624 Quinoxaline-2-carboxylic acid generic -metabolite KEGG:C18625 4-Nitrobenzoic acid generic -metabolite KEGG:C18626 Metalaxyl-M generic -metabolite KEGG:C18627 1,3-Dichloropropene generic -metabolite KEGG:C18628 Thiadiazin generic -metabolite KEGG:C18629 Deoxynogalonate generic -metabolite KEGG:C18630 Nogalaviketone generic -metabolite KEGG:C18631 Nogalavinone generic -metabolite KEGG:C18632 1-OH-Nogalamycinone generic -metabolite KEGG:C18633 Nogalamycin generic -metabolite KEGG:C18634 Aclacinomycin T generic -metabolite KEGG:C18635 Aclacinomycin S generic -metabolite KEGG:C18636 dTDP-2-deoxy-beta-L-fucose generic -metabolite KEGG:C18637 Aclacinomycin N generic -metabolite KEGG:C18638 Aclacinomycin A generic -metabolite KEGG:C18639 Aclacinomycin Y generic -metabolite KEGG:C18640 epsilon-Rhodomycin T generic -metabolite KEGG:C18641 15-Demethoxy-epsilon-rhodomycin generic -metabolite KEGG:C18642 beta-Rhodomycin generic -metabolite KEGG:C18643 dTDP-beta-L-rhodosamine generic -metabolite KEGG:C18644 Azinphos-ethyl generic -metabolite KEGG:C18645 Butocarboxim generic -metabolite KEGG:C18646 Butoxycarboxim generic -metabolite KEGG:C18647 Calcium arsenate generic -metabolite KEGG:C18648 Lead arsenate generic -metabolite KEGG:C18649 Ethiofencarb generic -metabolite KEGG:C18650 Furathiocarb generic -metabolite KEGG:C18651 Methiocarb generic -metabolite KEGG:C18652 Thiofanox generic -metabolite KEGG:C18653 DNOC generic -metabolite KEGG:C18654 Chlorfenvinphos generic -metabolite KEGG:C18655 Demeton-S-methyl generic -metabolite KEGG:C18656 Dicrotophos generic -metabolite KEGG:C18657 Triazophos generic -metabolite KEGG:C18658 Famphur generic -metabolite KEGG:C18659 Fenamiphos generic -metabolite KEGG:C18660 Heptenophos generic -metabolite KEGG:C18661 Mecarbam generic -metabolite KEGG:C18662 Omethoate generic -metabolite KEGG:C18663 Monocrotophos generic -metabolite KEGG:C18664 Oxydemeton-methyl generic -metabolite KEGG:C18665 Thiometon generic -metabolite KEGG:C18666 Vamidothion generic -metabolite KEGG:C18667 Methamidophos generic -metabolite KEGG:C18668 Formetanate generic -metabolite KEGG:C18669 Propetamphos generic -metabolite KEGG:C18670 Mercuric oxide generic -metabolite KEGG:C18671 Dinoterb generic -metabolite KEGG:C18672 Methylmercury generic -metabolite KEGG:C18673 Sodium cyanide generic -metabolite KEGG:C18674 Zinc phosphide generic -metabolite KEGG:C18675 Fluoroacetamide generic -metabolite KEGG:C18676 alpha-Chlorohydrin generic -metabolite KEGG:C18677 Chlorethoxyfos generic -metabolite KEGG:C18678 UWM6 generic -metabolite KEGG:C18679 2,3-Dehydro-UWM6 generic -metabolite KEGG:C18680 Jadomycin A generic -metabolite KEGG:C18681 C1'-C9-Glycosylated UWM6 generic -metabolite KEGG:C18682 11-Deoxylandomycinone generic -metabolite KEGG:C18683 Landomycin H generic -metabolite KEGG:C18684 Landomycin D generic -metabolite KEGG:C18685 Landomycin E generic -metabolite KEGG:C18686 Chlormephos generic -metabolite KEGG:C18687 Ethoprophos generic -metabolite KEGG:C18688 Mevinphos generic -metabolite KEGG:C18689 Phosphamidon generic -metabolite KEGG:C18690 Phorate generic -metabolite KEGG:C18691 Sulfotep generic -metabolite KEGG:C18692 Tebupirimfos generic -metabolite KEGG:C18693 Terbufos generic -metabolite KEGG:C18694 Brodifacoum generic -metabolite KEGG:C18695 Difethialone generic -metabolite KEGG:C18696 Flocoumafen generic -metabolite KEGG:C18697 Bromethalin generic -metabolite KEGG:C18698 Diphenadione generic -metabolite KEGG:C18699 (-)-Jasmonoyl-L-isoleucine generic -metabolite KEGG:C18700 Ametryn generic -metabolite KEGG:C18701 Azaconazole generic -metabolite KEGG:C18702 Azamethiphos generic -metabolite KEGG:C18703 Bensulide generic -metabolite KEGG:C18704 Bromuconazole generic -metabolite KEGG:C18705 Butroxydim generic -metabolite KEGG:C18706 Butylamine generic -metabolite KEGG:C18707 Chloralose generic -metabolite KEGG:C18708 Chlorphonium chloride generic -metabolite KEGG:C18709 Decaketide tricyclic intermediate generic -metabolite KEGG:C18710 3A-Deolivosylpremithramycin B generic -metabolite KEGG:C18711 Mithramycin DK generic -metabolite KEGG:C18712 Copper hydroxide generic -metabolite KEGG:C18713 Copper sulfate generic -metabolite KEGG:C18714 Cuprous oxide generic -metabolite KEGG:C18715 alpha-Cypermethrin generic -metabolite KEGG:C18716 Diclofop generic -metabolite KEGG:C18717 Difenzoquat generic -metabolite KEGG:C18718 Dimethachlor generic -metabolite KEGG:C18719 Dimethipin generic -metabolite KEGG:C18720 Diniconazole generic -metabolite KEGG:C18721 Dinobuton generic -metabolite KEGG:C18722 Diphenamid generic -metabolite KEGG:C18723 Dodine generic -metabolite KEGG:C18724 Endothal-disodium generic -metabolite KEGG:C18725 Ethion generic -metabolite KEGG:C18726 Fenpropidin generic -metabolite KEGG:C18727 Fenazaquin generic -metabolite KEGG:C18728 Fentin acetate generic -metabolite KEGG:C18729 Fentin hydroxide generic -metabolite KEGG:C18730 Fluchloralin generic -metabolite KEGG:C18731 Flufenacet generic -metabolite KEGG:C18732 Fluoroglycofen generic -metabolite KEGG:C18733 Flusilazole generic -metabolite KEGG:C18734 Flutriafol generic -metabolite KEGG:C18735 Fluxofenim generic -metabolite KEGG:C18736 Fomesafen generic -metabolite KEGG:C18737 Fuberidazole generic -metabolite KEGG:C18738 BHC generic -metabolite KEGG:C18739 Enilconazole generic -metabolite KEGG:C18740 Ioxynil octanoate generic -metabolite KEGG:C18741 MCPA-thioethyl generic -metabolite KEGG:C18742 Mecoprop generic -metabolite KEGG:C18743 Mefluidide generic -metabolite KEGG:C18744 Metaldehyde generic -metabolite KEGG:C18745 Methacrifos generic -metabolite KEGG:C18746 Methasulfocarb generic -metabolite KEGG:C18747 Metolcarb generic -metabolite KEGG:C18748 Nabam generic -metabolite KEGG:C18749 Naled generic -metabolite KEGG:C18750 2-Napthyloxyacetic acid generic -metabolite KEGG:C18751 Nitrapyrin generic -metabolite KEGG:C18752 Octhilinone generic -metabolite KEGG:C18753 Oxadixyl generic -metabolite KEGG:C18754 Captafol generic -metabolite KEGG:C18755 Pebulate generic -metabolite KEGG:C18756 Phosmet generic -metabolite KEGG:C18757 Phoxim generic -metabolite KEGG:C18758 Piperophos generic -metabolite KEGG:C18759 Propachlor generic -metabolite KEGG:C18760 Prosulfocarb generic -metabolite KEGG:C18761 Pyrazophos generic -metabolite KEGG:C18762 Pyridafenthion generic -metabolite KEGG:C18763 Quizalofop generic -metabolite KEGG:C18764 Quizalofop-P-tefuryl generic -metabolite KEGG:C18765 Sodium chlorate generic -metabolite KEGG:C18766 Sulfluramid generic -metabolite KEGG:C18767 2,3,6-TBA generic -metabolite KEGG:C18768 Terbumeton generic -metabolite KEGG:C18769 Tralkoxydim generic -metabolite KEGG:C18770 Triazamate generic -metabolite KEGG:C18771 XMC generic -metabolite KEGG:C18772 Alloxydim generic -metabolite KEGG:C18773 Ammonium sulfamate generic -metabolite KEGG:C18774 Ancymidol generic -metabolite KEGG:C18775 Benazolin generic -metabolite KEGG:C18776 Bupirimate generic -metabolite KEGG:C18777 Chlorimuron generic -metabolite KEGG:C18778 8-D-Olivosyl-landomycin generic -metabolite KEGG:C18779 Clopyralid generic -metabolite KEGG:C18780 Cycloate generic -metabolite KEGG:C18781 Diafenthiuron generic -metabolite KEGG:C18782 Dichlormid generic -metabolite KEGG:C18783 Dimefuron generic -metabolite KEGG:C18784 Dimethirimol generic -metabolite KEGG:C18785 Dinitramine generic -metabolite KEGG:C18786 Dodemorph generic -metabolite KEGG:C18787 Fenpropimorph generic -metabolite KEGG:C18788 Flamprop-M generic -metabolite KEGG:C18789 Fosamine generic -metabolite KEGG:C18790 tau-Fluvalinate generic -metabolite KEGG:C18791 Halofenozide generic -metabolite KEGG:C18792 Methyldymron generic -metabolite KEGG:C18793 Metobromuron generic -metabolite KEGG:C18794 Monolinuron generic -metabolite KEGG:C18795 MGK 264 generic -metabolite KEGG:C18796 (2R)-2-Hydroxy-2-methylbutanenitrile generic -metabolite KEGG:C18797 (S)-Hydroxynitrile generic -metabolite KEGG:C18798 5,10-Methylene-H4SPT generic -metabolite KEGG:C18799 5-Methyl-H4SPT generic -metabolite KEGG:C18800 Ofurace generic -metabolite KEGG:C18801 Penconazole generic -metabolite KEGG:C18802 Tetrahydrosarcinapterin generic -metabolite KEGG:C18803 Pyridate generic -metabolite KEGG:C18804 Pyrifenox generic -metabolite KEGG:C18805 Pyrithiobac-sodium generic -metabolite KEGG:C18806 Quinclorac generic -metabolite KEGG:C18807 Spirotetramat generic -metabolite KEGG:C18808 TCA-sodium generic -metabolite KEGG:C18809 Temefos generic -metabolite KEGG:C18810 Terbuthylazine generic -metabolite KEGG:C18811 Terbutryn generic -metabolite KEGG:C18812 Thidiazuron generic -metabolite KEGG:C18813 Tri-allate generic -metabolite KEGG:C18814 Trietazine generic -metabolite KEGG:C18815 Triticonazole generic -metabolite KEGG:C18816 Cryolite generic -metabolite KEGG:C18817 Chlorotoluron generic -metabolite KEGG:C18818 Cinosulfuron generic -metabolite KEGG:C18819 Cloxyfonac-sodium generic -metabolite KEGG:C18820 Dichlofluanid generic -metabolite KEGG:C18821 Diclosulam generic -metabolite KEGG:C18822 Landomycin A generic -metabolite KEGG:C18823 Landomycin B generic -metabolite KEGG:C18824 Landomycin J generic -metabolite KEGG:C18825 Dikegulac generic -metabolite KEGG:C18826 Dithiopyr generic -metabolite KEGG:C18827 Ethalfluralin generic -metabolite KEGG:C18828 Ethirimol generic -metabolite KEGG:C18829 Ethofumesate generic -metabolite KEGG:C18830 Ethyl 3-(N-butylacetamido)propionate generic -metabolite KEGG:C18831 Fenchlorazole-ethyl generic -metabolite KEGG:C18832 Fenclorim generic -metabolite KEGG:C18833 Fenfuram generic -metabolite KEGG:C18834 Propylmalonyl-CoA generic -metabolite KEGG:C18835 (R)-DNPA generic -metabolite KEGG:C18836 Griseophenone C generic -metabolite KEGG:C18837 Griseophenone B generic -metabolite KEGG:C18838 Dehydrogriseofulvin generic -metabolite KEGG:C18839 Prechromomycin B generic -metabolite KEGG:C18840 R1128A generic -metabolite KEGG:C18841 R1128B generic -metabolite KEGG:C18842 R1128C generic -metabolite KEGG:C18843 R1128D generic -metabolite KEGG:C18844 Spiramycin III generic -metabolite KEGG:C18845 Mycinamicin I generic -metabolite KEGG:C18846 Mycinamicin IV generic -metabolite KEGG:C18847 Mycinamicin V generic -metabolite KEGG:C18848 Chalcolactone generic -metabolite KEGG:C18849 Flumetralin generic -metabolite KEGG:C18850 Florasulam generic -metabolite KEGG:C18851 Flucarbazone-sodium generic -metabolite KEGG:C18852 Flumetsulam generic -metabolite KEGG:C18853 Fluometuron generic -metabolite KEGG:C18854 Flupropanate generic -metabolite KEGG:C18855 Flupyrsulfuron-methyl sodium generic -metabolite KEGG:C18856 Flurecol generic -metabolite KEGG:C18857 Fluridone generic -metabolite KEGG:C18858 Fluroxypyr generic -metabolite KEGG:C18859 Fluthiacet generic -metabolite KEGG:C18860 Folpet generic -metabolite KEGG:C18861 Hexaflumuron generic -metabolite KEGG:C18862 Hydroprene generic -metabolite KEGG:C18863 2-(Octylthio)ethanol generic -metabolite KEGG:C18864 Imazapyr generic -metabolite KEGG:C18865 Imazethapyr generic -metabolite KEGG:C18866 Iprovalicarb generic -metabolite KEGG:C18867 Metosulam generic -metabolite KEGG:C18868 Napropamide generic -metabolite KEGG:C18869 Naptalam generic -metabolite KEGG:C18870 Selenodiglutathione generic -metabolite KEGG:C18871 Glutathioselenol generic -metabolite KEGG:C18872 Trimethylselenonium generic -metabolite KEGG:C18873 Nitrothal-isopropyl generic -metabolite KEGG:C18874 Norflurazon generic -metabolite KEGG:C18875 Novaluron generic -metabolite KEGG:C18876 Noviflumuron generic -metabolite KEGG:C18877 Oryzalin generic -metabolite KEGG:C18878 Oxabetrinil generic -metabolite KEGG:C18879 Oxine-copper generic -metabolite KEGG:C18880 Piperonyl butoxide generic -metabolite KEGG:C18881 Oxyfluorfen generic -metabolite KEGG:C18882 Pentanochlor generic -metabolite KEGG:C18883 Primisulfuron generic -metabolite KEGG:C18884 Prodiamine generic -metabolite KEGG:C18885 Propamocarb generic -metabolite KEGG:C18886 Propaquizafop generic -metabolite KEGG:C18887 Propham generic -metabolite KEGG:C18888 Prothioconazole generic -metabolite KEGG:C18889 Pyrazosulfuron generic -metabolite KEGG:C18890 Pyriminobac generic -metabolite KEGG:C18891 Quinmerac generic -metabolite KEGG:C18892 Quinoxyfen generic -metabolite KEGG:C18893 1-Methylseleno-N-acetyl-D-galactosamine generic -metabolite KEGG:C18894 Spinetoram generic -metabolite KEGG:C18895 Sulfometuron generic -metabolite KEGG:C18896 Tebutam generic -metabolite KEGG:C18897 Tecnazene generic -metabolite KEGG:C18898 Tiocarbazil generic -metabolite KEGG:C18899 Tolylfluanid generic -metabolite KEGG:C18900 Tribenuron generic -metabolite KEGG:C18901 Triflusulfuron-methyl generic -metabolite KEGG:C18902 Methylselenic acid generic -metabolite KEGG:C18903 Zoxamide generic -metabolite KEGG:C18904 Methylselenopyruvate generic -metabolite KEGG:C18905 Methylselenocysteine Se-oxide generic -metabolite KEGG:C18906 Aldoxycarb generic -metabolite KEGG:C18907 Benodanil generic -metabolite KEGG:C18908 Chloraniformethan generic -metabolite KEGG:C18909 Cyprofuram generic -metabolite KEGG:C18910 2,5-Diamino-6-(5-phospho-D-ribitylamino)pyrimidin-4(3H)-one generic -metabolite KEGG:C18911 (R)-4-Phosphopantoate generic -metabolite KEGG:C18912 Furmecyclox generic -metabolite KEGG:C18913 Mebenil generic -metabolite KEGG:C18914 Pyracarbolid generic -metabolite KEGG:C18915 Salicylanilide generic -metabolite KEGG:C18916 Trichlamide generic -metabolite KEGG:C18917 Cypendazole generic -metabolite KEGG:C18918 Thiophanate generic -metabolite KEGG:C18919 Furconazole-cis generic -metabolite KEGG:C18920 Fluoromidine generic -metabolite KEGG:C18921 Myclozolin generic -metabolite KEGG:C18922 Dinocton 6 generic -metabolite KEGG:C18923 Carbamorph generic -metabolite KEGG:C18924 Benquinox generic -metabolite KEGG:C18925 Ditalimfos generic -metabolite KEGG:C18926 Phosdiphen generic -metabolite KEGG:C18927 Triamiphos generic -metabolite KEGG:C18928 Dichlozoline generic -metabolite KEGG:C18929 Drazoxolon generic -metabolite KEGG:C18930 Buthiobate generic -metabolite KEGG:C18931 Pyridinitril generic -metabolite KEGG:C18932 Triarimol generic -metabolite KEGG:C18933 Chloranil generic -metabolite KEGG:C18934 Metsulfovax generic -metabolite KEGG:C18935 Anilazine generic -metabolite KEGG:C18936 Chlorquinox generic -metabolite KEGG:C18937 Fenaminosulf generic -metabolite KEGG:C18938 Fenitropan generic -metabolite KEGG:C18939 Fluotrimazole generic -metabolite KEGG:C18940 Glyodin generic -metabolite KEGG:C18941 Halacrinate generic -metabolite KEGG:C18942 Mecarbinzid generic -metabolite KEGG:C18943 Prothiocarb generic -metabolite KEGG:C18944 Quinacetol sulfate generic -metabolite KEGG:C18945 Thicyofen generic -metabolite KEGG:C18946 Thioquinox generic -metabolite KEGG:C18947 Allyxycarb generic -metabolite KEGG:C18948 Bufencarb generic -metabolite KEGG:C18949 Butacarb generic -metabolite KEGG:C18950 Carbanolate generic -metabolite KEGG:C18951 Cloethocarb generic -metabolite KEGG:C18952 Mexacarbate generic -metabolite KEGG:C18953 Dioxacarb generic -metabolite KEGG:C18954 Nitrilacarb generic -metabolite KEGG:C18955 Promacyl generic -metabolite KEGG:C18956 Promecarb generic -metabolite KEGG:C18957 2,3,5-Trimethacarb generic -metabolite KEGG:C18958 Bromocyclen generic -metabolite KEGG:C18959 Chlorbicyclen generic -metabolite KEGG:C18960 Isobenzan generic -metabolite KEGG:C18961 Isodrin generic -metabolite KEGG:C18962 Kelevan generic -metabolite KEGG:C18963 Amidithion generic -metabolite KEGG:C18964 Athidathion generic -metabolite KEGG:C18965 Bromofos generic -metabolite KEGG:C18966 Bromophos-ethyl generic -metabolite KEGG:C18967 Butonate generic -metabolite KEGG:C18968 Carbophenothion generic -metabolite KEGG:C18969 Chlorphoxim generic -metabolite KEGG:C18970 Chlorthiophos generic -metabolite KEGG:C18971 Crotoxyphos generic -metabolite KEGG:C18972 Crufomate generic -metabolite KEGG:C18973 Cyanofenphos generic -metabolite KEGG:C18974 Cyanthoate generic -metabolite KEGG:C18975 Demephion-O generic -metabolite KEGG:C18976 Demephion-S generic -metabolite KEGG:C18977 Demeton-O generic -metabolite KEGG:C18978 Demeton-S generic -metabolite KEGG:C18979 Demeton-S-methylsulphon generic -metabolite KEGG:C18980 Dimefox generic -metabolite KEGG:C18981 Salithion generic -metabolite KEGG:C18982 Endothion generic -metabolite KEGG:C18983 Ethoate-methyl generic -metabolite KEGG:C18984 Oxydeprofos generic -metabolite KEGG:C18985 Etrimfos generic -metabolite KEGG:C18986 Fenchlorphos generic -metabolite KEGG:C18987 Fonofos generic -metabolite KEGG:C18988 Formothion generic -metabolite KEGG:C18989 Fosmethilan generic -metabolite KEGG:C18992 Vinylidene chloride-vinyl chloride copolymer generic -metabolite KEGG:C18993 2,5-Xylidine generic -metabolite KEGG:C18999 Fosthietan generic -metabolite KEGG:C19000 IPSP generic -metabolite KEGG:C19001 Isazofos generic -metabolite KEGG:C19002 Iodofenphos generic -metabolite KEGG:C19003 Leptophos generic -metabolite KEGG:C19004 Lythidathion generic -metabolite KEGG:C19005 Mecarphon generic -metabolite KEGG:C19006 Menazon generic -metabolite KEGG:C19007 Mephosfolan generic -metabolite KEGG:C19008 Mipafox generic -metabolite KEGG:C19009 Oxydisulfoton generic -metabolite KEGG:C19010 Phenkapton generic -metabolite KEGG:C19011 Phosfolan generic -metabolite KEGG:C19012 Pirimiphos-ethyl generic -metabolite KEGG:C19013 Propaphos generic -metabolite KEGG:C19014 Prothoate generic -metabolite KEGG:C19015 Schradan generic -metabolite KEGG:C19016 Sulprofos generic -metabolite KEGG:C19017 TEPP generic -metabolite KEGG:C19018 Trichloronat generic -metabolite KEGG:C19019 Aramite generic -metabolite KEGG:C19020 Azothoate generic -metabolite KEGG:C19021 Benzoximate generic -metabolite KEGG:C19022 Binapacryl generic -metabolite KEGG:C19023 Chlorfenethol generic -metabolite KEGG:C19024 Chlorfenson generic -metabolite KEGG:C19025 Chlorfensulphide generic -metabolite KEGG:C19026 Chloromethiuron generic -metabolite KEGG:C19027 Chloropropylate generic -metabolite KEGG:C19028 Dialifor generic -metabolite KEGG:C19029 Fenazaflor generic -metabolite KEGG:C19030 Fenson generic -metabolite KEGG:C19031 Fluenetil generic -metabolite KEGG:C19032 Tetrasul generic -metabolite KEGG:C19033 Carbon disulfide generic -metabolite KEGG:C19034 1,2-Dichloropropane generic -metabolite KEGG:C19035 Diamidafos generic -metabolite KEGG:C19036 Thionazin generic -metabolite KEGG:C19037 Chloromebuform generic -metabolite KEGG:C19038 Dinex generic -metabolite KEGG:C19039 Malonoben generic -metabolite KEGG:C19040 Sodium hexafluorosilicate generic -metabolite KEGG:C19041 Flubenzimine generic -metabolite KEGG:C19042 Kinoprene generic -metabolite KEGG:C19043 Allidochlor generic -metabolite KEGG:C19044 Benzoylprop-ethyl generic -metabolite KEGG:C19045 Butenachlor generic -metabolite KEGG:C19046 Chloranocryl generic -metabolite KEGG:C19047 Isocarbamid generic -metabolite KEGG:C19048 Quinonamid generic -metabolite KEGG:C19049 Cypromid generic -metabolite KEGG:C19050 Delachlor generic -metabolite KEGG:C19051 Diethatyl-ethyl generic -metabolite KEGG:C19052 Flamprop generic -metabolite KEGG:C19053 Monalide generic -metabolite KEGG:C19054 Perfluidone generic -metabolite KEGG:C19055 Hexaflurate generic -metabolite KEGG:C19056 Chloramben generic -metabolite KEGG:C19057 Tricamba generic -metabolite KEGG:C19058 Benzthiazuron generic -metabolite KEGG:C19059 Barban generic -metabolite KEGG:C19060 Chlorbufam generic -metabolite KEGG:C19061 Phenisopham generic -metabolite KEGG:C19062 SWEP generic -metabolite KEGG:C19063 Isopropalin generic -metabolite KEGG:C19064 Nitralin generic -metabolite KEGG:C19065 Profluralin generic -metabolite KEGG:C19066 Chlomethoxyfen generic -metabolite KEGG:C19067 Potassium cyanate generic -metabolite KEGG:C19068 Medinoterb acetate generic -metabolite KEGG:C19069 Bromofenoxim generic -metabolite KEGG:C19070 Clofop generic -metabolite KEGG:C19071 Disul generic -metabolite KEGG:C19072 Erbon generic -metabolite KEGG:C19073 Isoxapyrifop generic -metabolite KEGG:C19074 Buturon generic -metabolite KEGG:C19075 Chloroxuron generic -metabolite KEGG:C19076 Difenoxuron generic -metabolite KEGG:C19077 Fenuron-TCA generic -metabolite KEGG:C19078 tRNA with a 3' cytidine generic -metabolite KEGG:C19079 (4R)-7-Hydroxy-4-isopropenyl-7-methyl-2-oxo-oxepanone generic -metabolite KEGG:C19080 tRNA with a 3' CC end generic -metabolite KEGG:C19081 (4S)-Limonene-1,2-epoxide generic -metabolite KEGG:C19082 (1R,2R,4S)-Limonene-1,2-diol generic -metabolite KEGG:C19083 (1R,4S)-1-Hydroxy-2-oxolimonene generic -metabolite KEGG:C19084 (4S)-7-Hydroxy-4-isopropenyl-7-methyl-2-oxo-oxepanone generic -metabolite KEGG:C19085 tRNA with a 3' CCA end generic -metabolite KEGG:C19086 Methiuron generic -metabolite KEGG:C19087 Monuron generic -metabolite KEGG:C19088 Monuron-TCA generic -metabolite KEGG:C19089 Parafluron generic -metabolite KEGG:C19090 Phenobenzuron generic -metabolite KEGG:C19091 Haloxydine generic -metabolite KEGG:C19092 Ethidimuron generic -metabolite KEGG:C19093 Thiazafluron generic -metabolite KEGG:C19094 Diallat generic -metabolite KEGG:C19095 Ethiolate generic -metabolite KEGG:C19096 Sulfallate generic -metabolite KEGG:C19097 Vernolate generic -metabolite KEGG:C19098 Atraton generic -metabolite KEGG:C19099 Aziprotryne generic -metabolite KEGG:C19100 Desmetryn generic -metabolite KEGG:C19101 Dipropetryn generic -metabolite KEGG:C19102 Eglinazine generic -metabolite KEGG:C19103 Ipazine generic -metabolite KEGG:C19104 Methoprotryne generic -metabolite KEGG:C19105 Proglinazine generic -metabolite KEGG:C19106 Secbumeton generic -metabolite KEGG:C19107 Isomethiozin generic -metabolite KEGG:C19108 Isocil generic -metabolite KEGG:C19109 Cycluron generic -metabolite KEGG:C19110 Isonoruron generic -metabolite KEGG:C19111 Noruron generic -metabolite KEGG:C19112 Buthidazole generic -metabolite KEGG:C19113 Calcium carbimide generic -metabolite KEGG:C19114 Chlorfenac generic -metabolite KEGG:C19115 Chlorfenprop-methyl generic -metabolite KEGG:C19116 Credazine generic -metabolite KEGG:C19117 Cyometrinil generic -metabolite KEGG:C19118 Dimexano generic -metabolite KEGG:C19119 Dinoseb acetate generic -metabolite KEGG:C19120 Dixanthogen generic -metabolite KEGG:C19121 Fenthiaprop generic -metabolite KEGG:C19122 Hexachloroacetone generic -metabolite KEGG:C19123 Methazole generic -metabolite KEGG:C19124 Methoxyphenone generic -metabolite KEGG:C19125 Naphthalic anhydride generic -metabolite KEGG:C19126 Oxapyrazon generic -metabolite KEGG:C19127 Proxan generic -metabolite KEGG:C19128 Pydanon generic -metabolite KEGG:C19129 Terbucarb generic -metabolite KEGG:C19130 Tridiphane generic -metabolite KEGG:C19131 Etacelasil generic -metabolite KEGG:C19132 Glyphosine generic -metabolite KEGG:C19133 Piproctanyl generic -metabolite KEGG:C19134 Heptopargil generic -metabolite KEGG:C19135 Triapenthenol generic -metabolite KEGG:C19136 ANTU generic -metabolite KEGG:C19137 Bisthiosemi generic -metabolite KEGG:C19138 Crimidine generic -metabolite KEGG:C19139 Norbormide generic -metabolite KEGG:C19140 Phosacetim generic -metabolite KEGG:C19141 Pindone generic -metabolite KEGG:C19142 Butopyronoxyl generic -metabolite KEGG:C19143 Dibutyl succinate generic -metabolite KEGG:C19144 Trifenmorph generic -metabolite KEGG:C19145 Propyl isome generic -metabolite KEGG:C19146 Sesamex generic -metabolite KEGG:C19147 Piperonyl sulfoxide generic -metabolite KEGG:C19148 S-Seven generic -metabolite KEGG:C19149 TCA-ethadyl generic -metabolite KEGG:C19150 Diethyldithiocarbamic acid generic -metabolite KEGG:C19151 Coenzyme F420-3 generic -metabolite KEGG:C19152 Coenzyme F420-1 generic -metabolite KEGG:C19153 Coenzyme F420-0 generic -metabolite KEGG:C19154 7,8-Didemethyl-8-hydroxy-5-deazariboflavin generic -metabolite KEGG:C19155 (2S)-Lactyl-2-diphospho-5'-guanosine generic -metabolite KEGG:C19156 (2S)-2-Phospholactate generic -metabolite KEGG:C19157 Thorium-232 generic -metabolite KEGG:C19158 Bis(chloromethyl) ether generic -metabolite KEGG:C19159 Plutonium generic -metabolite KEGG:C19160 Chloromethyl methyl ether generic -metabolite KEGG:C19161 Chromium (VI) generic -metabolite KEGG:C19162 Phosphorus-32 generic -metabolite KEGG:C19163 Erionite generic -metabolite KEGG:C19164 Sulfur mustard generic -metabolite KEGG:C19165 Benzal chloride generic -metabolite KEGG:C19166 Benzotrichloride generic -metabolite KEGG:C19167 Benzyl chloride generic -metabolite KEGG:C19168 Benzoyl chloride generic -metabolite KEGG:C19169 4-Chloro-ortho-toluidine generic -metabolite KEGG:C19170 Chlorozotocin generic -metabolite KEGG:C19171 Cobalt generic -metabolite KEGG:C19172 Creosotes generic -metabolite KEGG:C19173 Cyclopenta[cd]pyrene generic -metabolite KEGG:C19174 Dibenzo[a,l]pyrene generic -metabolite KEGG:C19175 Dimethylcarbamoyl chloride generic -metabolite KEGG:C19176 1,2-Dimethylhydrazine generic -metabolite KEGG:C19177 Dimethyl sulfate generic -metabolite KEGG:C19178 N-Nitroso-N-ethylurea generic -metabolite KEGG:C19179 Indium phosphide generic -metabolite KEGG:C19180 2-Amino-3-methylimidazo[4,5-f]quinoline generic -metabolite KEGG:C19181 Methyl methanesulfonate generic -metabolite KEGG:C19182 Tris(2,3-dibromopropyl) phosphate generic -metabolite KEGG:C19183 Tungsten carbide generic -metabolite KEGG:C19184 Vinyl bromide generic -metabolite KEGG:C19185 Vinyl fluoride generic -metabolite KEGG:C19186 2-Amino-9H-pyrido[2,3-b]indole generic -metabolite KEGG:C19187 para-Aminoazobenzene generic -metabolite KEGG:C19188 ortho-Aminoazotoluene generic -metabolite KEGG:C19189 2-Amino-5-(5-nitro-2-furyl)-1,3,4-thiadiazole generic -metabolite KEGG:C19190 Trehalose-6,6'-dibehenate generic -metabolite KEGG:C19191 ortho-Anisidine generic -metabolite KEGG:C19192 Antimony trioxide generic -metabolite KEGG:C19193 Auramine generic -metabolite KEGG:C19194 Azaserine generic -metabolite KEGG:C19195 Benz[j]aceanthrylene generic -metabolite KEGG:C19196 Benzo[j]fluoranthene generic -metabolite KEGG:C19197 Benzo[c]phenanthrene generic -metabolite KEGG:C19198 Benzyl violet 4B generic -metabolite KEGG:C19199 2,2-Bis(bromomethyl)propane-1,3-diol generic -metabolite KEGG:C19200 Bitumens generic -metabolite KEGG:C19201 beta-Butyrolactone generic -metabolite KEGG:C19202 Carbon black generic -metabolite KEGG:C19203 Poligeenan generic -metabolite KEGG:C19204 Chlorendic acid generic -metabolite KEGG:C19205 3-Chloro-4-(dichloromethyl)-5-hydroxy-2(5H)-furanone generic -metabolite KEGG:C19206 1-Chloro-2-methylpropene generic -metabolite KEGG:C19207 4-Chloro-ortho-phenylenediamine generic -metabolite KEGG:C19208 Chloroprene generic -metabolite KEGG:C19209 CI Acid red 114 generic -metabolite KEGG:C19210 CI Basic red 9 generic -metabolite KEGG:C19211 1-Amino-2,4-dibromoanthraquinone generic -metabolite KEGG:C19212 Bromochloroacetic acid generic -metabolite KEGG:C19213 C.I. Direct blue 15 generic -metabolite KEGG:C19214 Citrus Red No.2 generic -metabolite KEGG:C19215 Cobalt sulfate generic -metabolite KEGG:C19216 para-Cresidine generic -metabolite KEGG:C19217 N,N'-Diacetylbenzidine generic -metabolite KEGG:C19218 2,4-Diaminoanisole generic -metabolite KEGG:C19219 Dibenz[a,h]acridine generic -metabolite KEGG:C19220 Dibenz[a,j]acridine generic -metabolite KEGG:C19221 7H-Dibenzo[c,g]carbazole generic -metabolite KEGG:C19222 Dibenzo[a,h]pyrene generic -metabolite KEGG:C19223 Dibenzo[a,i]pyrene generic -metabolite KEGG:C19224 2,3-Dibromo-1-propanol generic -metabolite KEGG:C19225 3,3'-Dichlorobenzidine generic -metabolite KEGG:C19226 3,3'-Dichloro-4,4'-diaminodiphenyl ether generic -metabolite KEGG:C19227 1,2-Diethylhydrazine generic -metabolite KEGG:C19228 Diglycidyl resorcinol ether generic -metabolite KEGG:C19229 Dihydrosafrole generic -metabolite KEGG:C19230 Diisopropyl sulfate generic -metabolite KEGG:C19231 3,3'-Dimethoxybenzidine generic -metabolite KEGG:C19232 trans-2-[(Dimethylamino)methylimino]-5-[2-(5-nitro-2- furyl)-vinyl]-1,3,4-oxadiazole generic -metabolite KEGG:C19233 1,1-Dimethylhydrazine generic -metabolite KEGG:C19234 3,7-Dinitrofluoranthene generic -metabolite KEGG:C19235 3,9-Dinitrofluoranthene generic -metabolite KEGG:C19236 Disperse Blue 1 generic -metabolite KEGG:C19237 1,2-Epoxybutane generic -metabolite KEGG:C19238 Ethyl acrylate generic -metabolite KEGG:C19239 Ethyl methanesulfonate generic -metabolite KEGG:C19240 Nifurthiazole generic -metabolite KEGG:C19241 Fumonisin B1 generic -metabolite KEGG:C19242 Fumonisin B2 generic -metabolite KEGG:C19243 Fusarin C generic -metabolite KEGG:C19244 Glu-P-1 generic -metabolite KEGG:C19245 Glu-P-2 generic -metabolite KEGG:C19246 Glycidaldehyde generic -metabolite KEGG:C19247 HC Blue No.1 generic -metabolite KEGG:C19248 Hexachloroethane generic -metabolite KEGG:C19249 2,4-Hexadienal generic -metabolite KEGG:C19250 Hexamethylphosphoramide generic -metabolite KEGG:C19251 Indeno[1,2,3-cd]pyrene generic -metabolite KEGG:C19252 Magenta generic -metabolite KEGG:C19253 2-Amino-3-methyl-9H-pyrido[2,3-b]indole generic -metabolite KEGG:C19254 MeIQ generic -metabolite KEGG:C19255 MeIQx generic -metabolite KEGG:C19256 Merphalan generic -metabolite KEGG:C19257 2-Methylaziridine generic -metabolite KEGG:C19258 Methylazoxymethanol acetate generic -metabolite KEGG:C19259 5-Methylchrysene generic -metabolite KEGG:C19260 4,4'-Methylene bis(2-methylaniline) generic -metabolite KEGG:C19261 2-Methylimidazole generic -metabolite KEGG:C19262 4-Methylimidazole generic -metabolite KEGG:C19263 Methyl isobutyl ketone generic -metabolite KEGG:C19264 2-Methyl-1-nitroanthraquinone generic -metabolite KEGG:C19265 Methylthiouracil generic -metabolite KEGG:C19266 4,4'-Bis(dimethylamino)benzophenone generic -metabolite KEGG:C19267 Levofuraltadone generic -metabolite KEGG:C19268 Niridazole generic -metabolite KEGG:C19269 5-Nitroacenaphthene generic -metabolite KEGG:C19270 2-Nitroanisole generic -metabolite KEGG:C19271 6-Nitrochrysene generic -metabolite KEGG:C19272 Nifuradene generic -metabolite KEGG:C19273 N-[4-(5-Nitro-2-furyl)-2-thiazolyl]acetamide generic -metabolite KEGG:C19274 Nitrogen mustard N-oxide generic -metabolite KEGG:C19275 Nitromethane generic -metabolite KEGG:C19276 4-Nitropyrene generic -metabolite KEGG:C19277 N-Nitrosodi-n-butylamine generic -metabolite KEGG:C19278 N-Nitrosodiethanolamine generic -metabolite KEGG:C19279 N-Nitrosodi-n-propylamine generic -metabolite KEGG:C19280 3-(N-Nitrosomethylamino)propionitrile generic -metabolite KEGG:C19281 N-Nitrosomethylethylamine generic -metabolite KEGG:C19282 N-Nitrosomethylvinylamine generic -metabolite KEGG:C19283 N-Nitrosomorpholine generic -metabolite KEGG:C19284 N-Nitrosopiperidine generic -metabolite KEGG:C19285 N-Nitrosopyrrolidine generic -metabolite KEGG:C19286 N-Nitrososarcosine generic -metabolite KEGG:C19287 Oil Orange SS generic -metabolite KEGG:C19288 Palygorskite generic -metabolite KEGG:C19289 Panfuran S generic -metabolite KEGG:C19290 Phenazopyridine hydrochloride generic -metabolite KEGG:C19291 Phenyl glycidyl ether generic -metabolite KEGG:C19292 Talc generic -metabolite KEGG:C19293 Ponceau 3R generic -metabolite KEGG:C19294 Ponceau MX generic -metabolite KEGG:C19295 Potassium bromate generic -metabolite KEGG:C19296 1,3-Propane sultone generic -metabolite KEGG:C19297 Propiolactone generic -metabolite KEGG:C19298 Sodium ortho-phenylphenate generic -metabolite KEGG:C19299 Tetrafluoroethylene generic -metabolite KEGG:C19300 Tetranitromethane generic -metabolite KEGG:C19301 N-Nitroso-N-methylurethane generic -metabolite KEGG:C19302 Thioacetamide generic -metabolite KEGG:C19303 4,4'-Thiodianiline generic -metabolite KEGG:C19304 Thiouracil generic -metabolite KEGG:C19305 Trichlormethine generic -metabolite KEGG:C19306 Trp-P-1 generic -metabolite KEGG:C19307 Trypan Blue generic -metabolite KEGG:C19308 Vanadium pentoxide generic -metabolite KEGG:C19309 Vinyl acetate generic -metabolite KEGG:C19310 4-Vinylcyclohexene generic -metabolite KEGG:C19311 4-Vinylcyclohexene diepoxide generic -metabolite KEGG:C19312 Acenaphthene generic -metabolite KEGG:C19314 Acepyrene generic -metabolite KEGG:C19315 Acridine orange generic -metabolite KEGG:C19316 Allyl chloride generic -metabolite KEGG:C19317 Allyl isothiocyanate generic -metabolite KEGG:C19318 Allyl isovalerate generic -metabolite KEGG:C19319 5-Aminoacenaphthene generic -metabolite KEGG:C19320 1-Amino-2-methylanthraquinone generic -metabolite KEGG:C19321 2-Amino-4-nitrophenol generic -metabolite KEGG:C19322 2-Amino-5-nitrophenol generic -metabolite KEGG:C19323 4-Amino-2-nitrophenol generic -metabolite KEGG:C19324 2-Amino-5-nitrothiazole generic -metabolite KEGG:C19325 11-Aminoundecanoic acid generic -metabolite KEGG:C19326 para-Anisidine generic -metabolite KEGG:C19327 Anthanthrene generic -metabolite KEGG:C19328 Antimony trisulfide generic -metabolite KEGG:C19329 Apholate generic -metabolite KEGG:C19330 para-Aramid fibrils generic -metabolite KEGG:C19331 Arsenobetaine generic -metabolite KEGG:C19332 2-(1-Aziridinyl)ethanol generic -metabolite KEGG:C19333 Aziridyl benzoquinone generic -metabolite KEGG:C19334 Azobenzene generic -metabolite KEGG:C19335 11H-Benz[bc]aceanthrylene generic -metabolite KEGG:C19336 Benz[l]aceanthrylene generic -metabolite KEGG:C19337 Benz[a]acridine generic -metabolite KEGG:C19338 Benz[c]acridine generic -metabolite KEGG:C19339 Benzo[b]chrysene generic -metabolite KEGG:C19340 Benzo[g]chrysene generic -metabolite KEGG:C19341 Benzo[a]fluoranthene generic -metabolite KEGG:C19342 Benzo[ghi]fluoranthene generic -metabolite KEGG:C19343 Benzo[a]fluorene generic -metabolite KEGG:C19344 Benzo[c]fluorene generic -metabolite KEGG:C19345 para-Benzoquinone dioxime generic -metabolite KEGG:C19346 Benzoyl peroxide generic -metabolite KEGG:C19347 Bis(1-aziridinyl)morpholinophosphine sulfide generic -metabolite KEGG:C19348 1,2-Bis(chloromethoxy)ethane generic -metabolite KEGG:C19349 1,4-Bis(chloromethoxymethyl)benzene generic -metabolite KEGG:C19350 Bis(2-chloro-1-methylethyl)ether generic -metabolite KEGG:C19351 Bis(2,3-epoxycyclopentyl)ether generic -metabolite KEGG:C19352 Brilliant blue generic -metabolite KEGG:C19353 Bromochloroacetonitrile generic -metabolite KEGG:C19354 Bromoethane generic -metabolite KEGG:C19355 2-Butoxyethanol generic -metabolite KEGG:C19356 1-tert-Butoxy-2-propanol generic -metabolite KEGG:C19357 3-Carbethoxypsoralen generic -metabolite KEGG:C19358 Carmoisine generic -metabolite KEGG:C19359 Chloramine generic -metabolite KEGG:C19360 Chloroacetonitrile generic -metabolite KEGG:C19361 Chlorodifluoromethane generic -metabolite KEGG:C19362 Chlorofluoromethane generic -metabolite KEGG:C19363 3-Chloro-2-methylpropene generic -metabolite KEGG:C19364 1-Chloro-3-nitrobenzene generic -metabolite KEGG:C19365 4-Chloro-meta-phenylenediamine generic -metabolite KEGG:C19366 5-Chloro-ortho-toluidine generic -metabolite KEGG:C19367 2-Chloro-1,1,1-trifluoroethane generic -metabolite KEGG:C19368 Chromium (III) generic -metabolite KEGG:C19369 Chrysoidine generic -metabolite KEGG:C19370 CI Acid Orange 3 generic -metabolite KEGG:C19371 CI Acid Orange 20 generic -metabolite KEGG:C19372 CI Orange G generic -metabolite KEGG:C19373 CI Pigment Red 3 generic -metabolite KEGG:C19374 Cinnamyl anthranilate generic -metabolite KEGG:C19375 Coronene generic -metabolite KEGG:C19376 meta-Cresidine generic -metabolite KEGG:C19377 Crotonaldehyde generic -metabolite KEGG:C19378 Cyclamate generic -metabolite KEGG:C19379 Cyclochlorotine generic -metabolite KEGG:C19380 4H-Cyclopenta[def]chrysene generic -metabolite KEGG:C19381 5,6-Cyclopenteno-1,2-benzanthracene generic -metabolite KEGG:C19382 D and C Red No. 9 generic -metabolite KEGG:C19383 Decabromodiphenyl oxide generic -metabolite KEGG:C19384 1,2-Diamino-4-nitrobenzene generic -metabolite KEGG:C19385 1,4-Diamino-2-nitrobenzene generic -metabolite KEGG:C19386 2,5-Diaminotoluene generic -metabolite KEGG:C19387 Diazomethane generic -metabolite KEGG:C19388 Dibenz[a,c]anthracene generic -metabolite KEGG:C19389 Dibenz[a,j]anthracene generic -metabolite KEGG:C19390 Dibenzo[a,e]fluoranthene generic -metabolite KEGG:C19391 13H-Dibenzo[a,g]fluorene generic -metabolite KEGG:C19392 Dibenzo[h,rst]pentaphene generic -metabolite KEGG:C19393 Dibenzo[a,e]pyrene generic -metabolite KEGG:C19394 Dibenzo[e,l]pyrene generic -metabolite KEGG:C19395 Dichloroacetonitrile generic -metabolite KEGG:C19396 Dibromoacetonitrile generic -metabolite KEGG:C19397 1,3-Dichlorobenzene generic -metabolite KEGG:C19398 trans-1,4-Dichlorobutene generic -metabolite KEGG:C19399 2,6-Dichloro-para-phenylenediamine generic -metabolite KEGG:C19400 N,N'-Diethylthiourea generic -metabolite KEGG:C19401 Dihydroaceanthrylene generic -metabolite KEGG:C19402 Dimethoxane generic -metabolite KEGG:C19403 3,3'-Dimethoxybenzidine-4,4'-diisocyanate generic -metabolite KEGG:C19404 4,4'-Dimethylangelicin generic -metabolite KEGG:C19405 4,5'-Dimethylangelicin generic -metabolite KEGG:C19406 Dimethyl hydrogen phosphite generic -metabolite KEGG:C19407 1,4-Dimethylphenanthrene generic -metabolite KEGG:C19408 1,3-Dinitropyrene generic -metabolite KEGG:C19409 Dinitrosopentamethylenetetramine generic -metabolite KEGG:C19410 3,5-Dinitrotoluene generic -metabolite KEGG:C19411 2,4'-Diphenyldiamine generic -metabolite KEGG:C19412 Disperse Yellow 3 generic -metabolite KEGG:C19413 Doxefazepam generic -metabolite KEGG:C19414 Doxylamine succinate generic -metabolite KEGG:C19415 Dulcin generic -metabolite KEGG:C19416 Eosin generic -metabolite KEGG:C19417 3,4-Epoxy-6-methylcyclohexylmethyl-3,4-epoxy-6-methylcyclo-hexanecarboxylate generic -metabolite KEGG:C19418 cis-9,10-Epoxystearic acid generic -metabolite KEGG:C19419 Ethylene sulfide generic -metabolite KEGG:C19420 2-Ethylhexyl acrylate generic -metabolite KEGG:C19421 Ethyl selenac generic -metabolite KEGG:C19422 Evans blue generic -metabolite KEGG:C19423 Fast green FCF generic -metabolite KEGG:C19424 Ferric oxide generic -metabolite KEGG:C19425 Fluoranthene generic -metabolite KEGG:C19426 Glycidyl oleate generic -metabolite KEGG:C19427 Glycidyl stearate generic -metabolite KEGG:C19428 Guinea green B generic -metabolite KEGG:C19429 HC Blue No. 2 generic -metabolite KEGG:C19430 HC Red No. 3 generic -metabolite KEGG:C19431 HC Yellow No. 4 generic -metabolite KEGG:C19432 Hycanthone mesylate generic -metabolite KEGG:C19433 4-Hydroxyazobenzene generic -metabolite KEGG:C19434 8-Hydroxyquinoline generic -metabolite KEGG:C19435 Hydroxysenkirkine generic -metabolite KEGG:C19436 Iron-dextrin complex generic -metabolite KEGG:C19437 Iron sorbitex generic -metabolite KEGG:C19438 Lauroyl peroxide generic -metabolite KEGG:C19439 Light green SF generic -metabolite KEGG:C19440 Malonaldehyde generic -metabolite KEGG:C19441 Mannomustine dihydrochloride generic -metabolite KEGG:C19442 Medphalan generic -metabolite KEGG:C19443 Methyl acrylate generic -metabolite KEGG:C19444 5-Methylangelicin generic -metabolite KEGG:C19445 Methyl carbamate generic -metabolite KEGG:C19446 Methyl chloride generic -metabolite KEGG:C19447 1-Methylchrysene generic -metabolite KEGG:C19448 2-Methylchrysene generic -metabolite KEGG:C19449 3-Methylchrysene generic -metabolite KEGG:C19450 4-Methylchrysene generic -metabolite KEGG:C19451 6-Methylchrysene generic -metabolite KEGG:C19452 N-Methyl-N,4-dinitrosoaniline generic -metabolite KEGG:C19453 4,4'-Methylenediphenyl diisocyanate generic -metabolite KEGG:C19454 2-Methylfluoranthene generic -metabolite KEGG:C19455 3-Methylfluoranthene generic -metabolite KEGG:C19456 N-Methylolacrylamide generic -metabolite KEGG:C19457 1-Methylphenanthrene generic -metabolite KEGG:C19458 7-Methylpyrido[3,4-c]psoralen generic -metabolite KEGG:C19459 Methyl red generic -metabolite KEGG:C19460 Methyl selenac generic -metabolite KEGG:C19461 Musk ambrette generic -metabolite KEGG:C19462 Musk xylene generic -metabolite KEGG:C19463 1,5-Naphthalenediamine generic -metabolite KEGG:C19464 1,5-Naphthalene diisocyanate generic -metabolite KEGG:C19465 Naphtho[1,2-b]fluoranthene generic -metabolite KEGG:C19466 Naphtho[2,1-a]fluoranthene generic -metabolite KEGG:C19467 Naphtho[2,3-e]pyrene generic -metabolite KEGG:C19468 Nithiazide generic -metabolite KEGG:C19469 5-Nitro-ortho-anisidine generic -metabolite KEGG:C19470 9-Nitroanthracene generic -metabolite KEGG:C19471 7-Nitrobenz[a]anthracene generic -metabolite KEGG:C19472 6-Nitrobenzo[a]pyrene generic -metabolite KEGG:C19473 4-Nitrobiphenyl generic -metabolite KEGG:C19474 2-Nitronaphthalene generic -metabolite KEGG:C19475 3-Nitroperylene generic -metabolite KEGG:C19476 2-Nitropyrene generic -metabolite KEGG:C19477 N'-Nitrosoanabasine generic -metabolite KEGG:C19478 N'-Nitrosoanatabine generic -metabolite KEGG:C19479 para-Nitrosodiphenylamine generic -metabolite KEGG:C19480 N-Nitrosofolic acid generic -metabolite KEGG:C19481 N-Nitrosoguvacine generic -metabolite KEGG:C19482 N-Nitrosoguvacoline generic -metabolite KEGG:C19483 N-Nitrosohydroxyproline generic -metabolite KEGG:C19484 3-(N-Nitrosomethylamino)propionaldehyde generic -metabolite KEGG:C19485 N-Nitrosoproline generic -metabolite KEGG:C19486 3-Nitrotoluene generic -metabolite KEGG:C19487 Nitrovin generic -metabolite KEGG:C19488 7,12-Dimethylbenz[a]anthracene generic -metabolite KEGG:C19489 1a,11b-Dihydro-4,9-dimethylbenz[a]anthra[3,4-b]oxirene generic -metabolite KEGG:C19490 trans-3,4-Dihydro-3,4-dihydroxy-7,12-dimethylbenz[a]anthracene generic -metabolite KEGG:C19491 (E)-2-Methylbutanal oxime generic -metabolite KEGG:C19492 Nylon 6 generic -metabolite KEGG:C19493 Estradiol mustard generic -metabolite KEGG:C19494 Oxyphenbutazone generic -metabolite KEGG:C19495 Penicillic acid generic -metabolite KEGG:C19496 Pentachloroethane generic -metabolite KEGG:C19497 Perylene generic -metabolite KEGG:C19498 Phenicarbazide generic -metabolite KEGG:C19499 para-Phenylenediamine generic -metabolite KEGG:C19500 Picene generic -metabolite KEGG:C19501 Polyacrylic acid generic -metabolite KEGG:C19502 Polychloroprene generic -metabolite KEGG:C19503 Polyethylene generic -metabolite KEGG:C19504 Polymethyl methacrylate generic -metabolite KEGG:C19505 Polipropene 25 generic -metabolite KEGG:C19506 Polystyrene generic -metabolite KEGG:C19507 Polytetrafluoroethylene generic -metabolite KEGG:C19508 Polyvinyl chloride generic -metabolite KEGG:C19509 Polyvinyl pyrrolidone generic -metabolite KEGG:C19510 Ponceau SX generic -metabolite KEGG:C19511 Potassium bis(2-hydroxyethyl)dithiocarbamate generic -metabolite KEGG:C19512 Prednimustine generic -metabolite KEGG:C19513 Pronetalol hydrochloride generic -metabolite KEGG:C19514 n-Propyl carbamate generic -metabolite KEGG:C19515 Ptaquiloside generic -metabolite KEGG:C19516 Pyrido[3,4-c]psoralen generic -metabolite KEGG:C19517 Rhodamine B generic -metabolite KEGG:C19518 Ripazepam generic -metabolite KEGG:C19519 Saccharated iron oxide generic -metabolite KEGG:C19520 Scarlet Red generic -metabolite KEGG:C19521 Semicarbazide hydrochloride generic -metabolite KEGG:C19522 Sepiolite generic -metabolite KEGG:C19523 Sodium chlorite generic -metabolite KEGG:C19524 Succinic anhydride generic -metabolite KEGG:C19525 Sudan I generic -metabolite KEGG:C19526 Sudan II generic -metabolite KEGG:C19527 Sudan III generic -metabolite KEGG:C19528 Sudan Brown RR generic -metabolite KEGG:C19529 Sudan Red 7B generic -metabolite KEGG:C19530 Sulfamethazine generic -metabolite KEGG:C19531 Sunset Yellow FCF generic -metabolite KEGG:C19532 Strobane generic -metabolite KEGG:C19533 2,2',5,5'-Tetrachlorobenzidine generic -metabolite KEGG:C19534 1,1,2,2-Tetrachloroethane generic -metabolite KEGG:C19535 Trichloroacetonitrile generic -metabolite KEGG:C19536 1,1,2-Trichloroethane generic -metabolite KEGG:C19537 Triethylene glycol diglycidyl ether generic -metabolite KEGG:C19538 4,4',6-Trimethylangelicin generic -metabolite KEGG:C19539 2,4,5-Trimethylaniline generic -metabolite KEGG:C19540 2,4,6-Trimethylaniline generic -metabolite KEGG:C19541 Triphenylene generic -metabolite KEGG:C19542 Triaziquone generic -metabolite KEGG:C19543 Tris(1-aziridinyl)phosphine oxide generic -metabolite KEGG:C19544 1,2,3-Tris(chloromethoxy)propane generic -metabolite KEGG:C19545 Vat Yellow 4 generic -metabolite KEGG:C19546 Vinyl chloride-vinyl acetate copolymer generic -metabolite KEGG:C19547 Vinylidene fluoride generic -metabolite KEGG:C19548 N-Vinyl-2-pyrrolidone generic -metabolite KEGG:C19549 Vinyl toluene generic -metabolite KEGG:C19550 Wollastonite generic -metabolite KEGG:C19551 Xylene generic -metabolite KEGG:C19552 Yellow AB generic -metabolite KEGG:C19553 Yellow OB generic -metabolite KEGG:C19554 Acriflavinium chloride generic -metabolite KEGG:C19555 Hematite generic -metabolite KEGG:C19556 Tris(2-methyl-1-aziridinyl)phosphine oxide generic -metabolite KEGG:C19557 Treosulfan generic -metabolite KEGG:C19558 AF-2 generic -metabolite KEGG:C19559 (1aalpha,2beta,3alpha,11calpha)-1a,2,3,11c-Tetrahydro-6,11-dimethylbenzo[6,7]phenanthro[3,4-b]oxirene-2,3-diol generic -metabolite KEGG:C19560 Toluene diisocyanates generic -metabolite KEGG:C19561 7-Hydroxymethyl-12-methylbenz[a]anthracene generic -metabolite KEGG:C19562 7-Hydroxymethyl-12-methylbenz[a]anthracene sulfate generic -metabolite KEGG:C19563 4-[(Hydroxymethyl)nitrosoamino]-1-(3-pyridinyl)-1-butanone generic -metabolite KEGG:C19564 4-(Nitrosoamino)-1-(3-pyridinyl)-1-butanone generic -metabolite KEGG:C19565 4-Hydroxy-1-(3-pyridinyl)-1-butanone generic -metabolite KEGG:C19566 4-Hydroxy-4-(methylnitrosoamino)-1-(3-pyridinyl)-1-butanone generic -metabolite KEGG:C19567 4-Oxo-1-(3-pyridyl)-1-butanone generic -metabolite KEGG:C19568 N-Nitrosomethanamine generic -metabolite KEGG:C19569 3-Succinoylpyridine generic -metabolite KEGG:C19570 Ethyl tellurac generic -metabolite KEGG:C19571 Polymethylene polyphenyl isocyanate generic -metabolite KEGG:C19572 Silica generic -metabolite KEGG:C19573 Styrene-acrylonitrile copolymer generic -metabolite KEGG:C19574 4-(Methylnitrosamino)-1-(3-pyridyl)-1-butanol generic -metabolite KEGG:C19575 Styrene-butadiene copolymer generic -metabolite KEGG:C19576 Zeolite generic -metabolite KEGG:C19577 1-(Methylnitrosoamino)-4-(3-pyridinyl)-1,4-butanediol generic -metabolite KEGG:C19578 5-(3-Pyridyl)-2-hydroxytetrahydrofuran generic -metabolite KEGG:C19579 gamma-Hydroxy-3-pyridinebutanoate generic -metabolite KEGG:C19580 alpha-[3-[(Hydroxymethyl)nitrosoamino]propyl]-3-pyridinemethanol generic -metabolite KEGG:C19581 alpha-[3-(Nitrosoamino)propyl]-3-pyridinemethanol generic -metabolite KEGG:C19582 1-(3-Pyridinyl)-1,4-butanediol generic -metabolite KEGG:C19583 Fusarenone X generic -metabolite KEGG:C19584 Aflatoxicol generic -metabolite KEGG:C19585 Aflatoxin Q1 generic -metabolite KEGG:C19586 Aflatoxin B1-exo-8,9-epoxide generic -metabolite KEGG:C19587 Aflatoxin P1 generic -metabolite KEGG:C19588 Aflatoxin B1 diol generic -metabolite KEGG:C19589 Aflatoxin B1 dialdehyde generic -metabolite KEGG:C19590 6-[2,3-Dihydroxy-1-(hydroxymethyl)propyl]-1,2-dihydro-7-hydroxy-9-methoxy-cyclopenta[c][1]benzopyran-3,4-dione generic -metabolite KEGG:C19591 1,2,3,4-Tetrahydro-alpha,7-dihydroxy-beta-(hydroxymethyl)-9-methoxy-3,4-dioxocyclopenta[c][1]benzopyran-6-propanal generic -metabolite KEGG:C19592 alpha-(1,2-Dihydroxyethyl)-1,2,3,4-tetrahydro-7-hydroxy-9-methoxy-3,4-dioxocyclopenta[c][1]benzopyran-6-acetaldehyde generic -metabolite KEGG:C19594 Aflatoxin-M1-8,9-epoxide generic -metabolite KEGG:C19595 Aflatoxin B1-endo-8,9-epoxide generic -metabolite KEGG:C19596 Lipooligosaccharide generic -metabolite KEGG:C19597 2-Nitrotoluene generic -metabolite KEGG:C19598 Polyurethane foam generic -metabolite KEGG:C19599 Sodium diethyldithiocarbamate generic -metabolite KEGG:C19600 Calcium salicylate generic -metabolite KEGG:C19601 Theobromine, calcium salt generic -metabolite KEGG:C19602 4-(Methylnitrosamino)-1-(1-oxido-3-pyridinyl)-1-butanone generic -metabolite KEGG:C19603 4-(Methylnitrosamino)-1-(3-pyridyl-N-oxide)-1-butanol generic -metabolite KEGG:C19604 7,12-Dimethylbenz[a]anthracene 5,6-oxide generic -metabolite KEGG:C19605 4-(Methylnitrosamino)-1-(3-pyridyl)-1-butanol glucuronide generic -metabolite KEGG:C19606 NNAL-N-glucuronide generic -metabolite KEGG:C19607 trans-5,6-Dihydro-5,6-dihydroxy-7,12-dimethylbenz[a]anthracene generic -metabolite KEGG:C19608 Ferritin generic -metabolite KEGG:C19609 Nickel(2+) generic -metabolite KEGG:C19610 Manganese(2+) generic -metabolite KEGG:C19611 Manganese(3+) generic -metabolite KEGG:C19612 Coriose generic -metabolite KEGG:C19613 Juvenile hormone I generic -metabolite KEGG:C19614 16-Oxopalmitate generic -metabolite KEGG:C19615 Hexadecanedioate generic -metabolite KEGG:C19616 18-Hydroxyoleate generic -metabolite KEGG:C19617 18-Oxooleate generic -metabolite KEGG:C19618 Octadec-9-ene-1,18-dioic-acid generic -metabolite KEGG:C19619 (+)-Germacrene D generic -metabolite KEGG:C19620 9,10-Epoxy-18-hydroxystearate generic -metabolite KEGG:C19621 9,10,18-Trihydroxystearate generic -metabolite KEGG:C19622 9,10-Dihydroxystearate generic -metabolite KEGG:C19623 22-Hydroxydocosanoate generic -metabolite KEGG:C19624 22-Oxodocosanoate generic -metabolite KEGG:C19625 Docosanedioate generic -metabolite KEGG:C19630 Diketone generic -metabolite KEGG:C19631 6-Hydroxy-3-succinoylpyridine generic -metabolite KEGG:C19632 Kojibiose generic -metabolite KEGG:C19633 Maltulose generic -metabolite KEGG:C19634 Melibiulose generic -metabolite KEGG:C19635 Scillabiose generic -metabolite KEGG:C19636 Turanose generic -metabolite KEGG:C19637 Coenzyme M disulfide generic -metabolite KEGG:C19638 5alpha-Gonane generic -metabolite KEGG:C19639 Gonane generic -metabolite KEGG:C19640 5beta-Gonane generic -metabolite KEGG:C19641 Estrane generic -metabolite KEGG:C19642 5beta-Cholanic acid generic -metabolite KEGG:C19643 Scillarenin generic -metabolite KEGG:C19644 Stigmastanol generic -metabolite KEGG:C19645 Acceptor generic -metabolite KEGG:C19646 Acceptor beta-D-glucuronoside generic -metabolite KEGG:C19648 Pseudotigogenin generic -metabolite KEGG:C19649 Pseudosarsasapogenin generic -metabolite KEGG:C19650 Pseudosmilagenin generic -metabolite KEGG:C19651 Ergostanol generic -metabolite KEGG:C19652 alpha-Ergostenol generic -metabolite KEGG:C19653 Lumisterol generic -metabolite KEGG:C19654 gamma-Sitosterol generic -metabolite KEGG:C19655 Gorgosterol generic -metabolite KEGG:C19656 Sarcoaldesterol A generic -metabolite KEGG:C19657 Acanthasterol generic -metabolite KEGG:C19658 Cardanolide generic -metabolite KEGG:C19659 5alpha-Cholane generic -metabolite KEGG:C19660 Bufanolide generic -metabolite KEGG:C19661 Cholestane generic -metabolite KEGG:C19662 Spirostan generic -metabolite KEGG:C19663 Furostan generic -metabolite KEGG:C19664 Ergostane generic -metabolite KEGG:C19665 5alpha-Campestane generic -metabolite KEGG:C19666 Stigmastane generic -metabolite KEGG:C19667 5alpha-Poriferastane generic -metabolite KEGG:C19668 Gorgostane generic -metabolite KEGG:C19669 Thermospermine generic -metabolite KEGG:C19670 Oleamide generic -metabolite KEGG:C19671 Amicyanin generic -metabolite KEGG:C19672 Reduced amicyanin generic -metabolite KEGG:C19673 Malonyl-[acp] methyl ester generic -metabolite KEGG:C19674 D-Arabinitol 1-phosphate generic -metabolite KEGG:C19675 (R)-2,3-Dihydroxypropane-1-sulfonate generic -metabolite KEGG:C19676 Germacra-1(10),4,11(13)-trien-12-ol generic -metabolite KEGG:C19677 Germacra-1(10),4,11(13)-trien-12-al generic -metabolite KEGG:C19678 Germacrene A acid generic -metabolite KEGG:C19679 L-Sorbosone generic -metabolite KEGG:C19680 N,N-Dimethyl-4-nitrosoaniline generic -metabolite KEGG:C19681 4-(Hydroxylamino)-N,N-dimethylaniline generic -metabolite KEGG:C19682 3,4-Didehydroadipyl-CoA generic -metabolite KEGG:C19683 3,4-Didehydroadipyl-CoA semialdehyde generic -metabolite KEGG:C19684 2,3-Epoxy-2,3-dihydrobenzoyl-CoA generic -metabolite KEGG:C19685 Sulfoacetyl-CoA generic -metabolite KEGG:C19686 3-(1-Carboxyvinyloxy)anthranilate generic -metabolite KEGG:C19687 7-Chloro-L-tryptophan generic -metabolite KEGG:C19688 2-Imino-3-(7-chloroindol-3-yl)propanoate generic -metabolite KEGG:C19689 Glutathione amide generic -metabolite KEGG:C19690 Glutathione amide disulfide generic -metabolite KEGG:C19691 Farnesylcysteine generic -metabolite KEGG:C19692 Polysulfide generic -metabolite KEGG:C19693 Reactive Blue 5 generic -metabolite KEGG:C19694 D-Alanyl-(R)-lactate generic -metabolite KEGG:C19695 [beta-GlcNAc-(1->4)-Mur2Ac(oyl-L-Ala-gamma-D-Glu-L-Lys-D-Ala-D-Ala)]n generic -metabolite KEGG:C19696 [beta-GlcNAc-(1->4)-Mur2Ac(oyl-L-Ala-gamma-D-Glu-6-N-(beta-D-Asp)-L-Lys-D-Ala-D-Ala)]n generic -metabolite KEGG:C19697 Hypochlorous acid generic -metabolite KEGG:C19698 3,4-Bis(7-chloroindol-3-yl)pyrrole-2,5-dicarboxylate generic -metabolite KEGG:C19699 Dichloroarcyriaflavin A generic -metabolite KEGG:C19700 4'-O-Demethylrebeccamycin generic -metabolite KEGG:C19701 Rebeccamycin generic -metabolite KEGG:C19702 1-O-(2-Amino-2-deoxy-alpha-D-glucopyranosyl)-1D-myo-inositol generic -metabolite KEGG:C19703 1-O-[2-(L-Cysteinamido)-2-deoxy-alpha-D-glucopyranosyl]-1D-myo-inositol generic -metabolite KEGG:C19704 Dinoflagellate luciferin generic -metabolite KEGG:C19705 Oxidized dinoflagellate luciferin generic -metabolite KEGG:C19706 cis-3-Hydroxy-L-proline generic -metabolite KEGG:C19707 (+)-Columbianetin generic -metabolite KEGG:C19708 5-Epiaristolochene generic -metabolite KEGG:C19709 [L-Asp(4-L-Arg)]n generic -metabolite KEGG:C19710 [L-Asp(4-L-Arg)]n-L-Asp generic -metabolite KEGG:C19711 Solavetivol generic -metabolite KEGG:C19712 N-Hydroxy-L-phenylalanine generic -metabolite KEGG:C19713 [L-Asp(4-L-Arg)]n+1 generic -metabolite KEGG:C19714 (E)-Phenylacetaldoxime generic -metabolite KEGG:C19715 N,N-Dihydroxy-L-phenylalanine generic -metabolite KEGG:C19716 N-Hydroxy-L-tryptophan generic -metabolite KEGG:C19717 N,N-Dihydroxy-L-tryptophan generic -metabolite KEGG:C19719 D-Alanyl-D-serine generic -metabolite KEGG:C19720 N6-(UDP-N-acetyl-alpha-D-muramoyl-L-alanyl-gamma-D-glutamyl)-D-lysine generic -metabolite KEGG:C19721 5-Hydroxypyrrole-2-carboxylate generic -metabolite KEGG:C19722 [tRNA(Ile2)]-cytidine34 generic -metabolite KEGG:C19723 [tRNA(Ile2)]-lysidine34 generic -metabolite KEGG:C19724 Cobyrinate c-monamide generic -metabolite KEGG:C19725 UDP-2,3-diacetamido-2,3-dideoxy-alpha-D-glucuronate generic -metabolite KEGG:C19726 15beta-Hydroxyprogesterone generic -metabolite KEGG:C19727 5-Hydroxypseudobaptigenin generic -metabolite KEGG:C19728 all-trans-8'-Apo-beta-carotenal generic -metabolite KEGG:C19729 (2E,4E,6E)-2,6-Dimethylocta-2,4,6-trienedial generic -metabolite KEGG:C19730 Crocetin dialdehyde generic -metabolite KEGG:C19731 (3S)-3-Hydroxycyclocitral generic -metabolite KEGG:C19732 24-Hydroxy-beta-amyrin generic -metabolite KEGG:C19733 Sophoradiol generic -metabolite KEGG:C19734 (-)-alpha-Gurjunene generic -metabolite KEGG:C19735 (-)-endo-alpha-Bergamotene generic -metabolite KEGG:C19736 (+)-alpha-Santalene generic -metabolite KEGG:C19737 (+)-endo-beta-Bergamotene generic -metabolite KEGG:C19738 (-)-gamma-Cadinene generic -metabolite KEGG:C19739 3'-O-Methyltricetin generic -metabolite KEGG:C19740 (+)-alpha-Barbatene generic -metabolite KEGG:C19741 (+)-Cubenene generic -metabolite KEGG:C19742 (+)-delta-Selinene generic -metabolite KEGG:C19743 (-)-Drimenol generic -metabolite KEGG:C19744 (+)-Epicubenol generic -metabolite KEGG:C19745 UDP-2,3-diacetamido-2,3-dideoxy-alpha-D-mannuronate generic -metabolite KEGG:C19746 (3R,6E)-Nerolidol generic -metabolite KEGG:C19747 Germacrene C generic -metabolite KEGG:C19748 (E)-gamma-Bisabolene generic -metabolite KEGG:C19749 (E)-alpha-Bisabolene generic -metabolite KEGG:C19750 3,5-Dihydroxybiphenyl generic -metabolite KEGG:C19752 (S)-beta-Macrocarpene generic -metabolite KEGG:C19753 cis-Muurola-3,5-diene generic -metabolite KEGG:C19754 cis-Muurola-4(14),5-diene generic -metabolite KEGG:C19755 Patchoulol generic -metabolite KEGG:C19756 Presilphiperfolan-8beta-ol generic -metabolite KEGG:C19757 (Z)-3-Hexen-1-ol acetate generic -metabolite KEGG:C19758 beta-D-Galactosyl-(1->4)-L-rhamnose generic -metabolite KEGG:C19759 7,9,9'-tricis-Neurosporene generic -metabolite KEGG:C19760 (2Z,6Z)-Farnesyl diphosphate generic -metabolite KEGG:C19761 1-O-(2-Acetamido-2-deoxy-alpha-D-glucopyranosyl)-1D-myo-inositol 3-phosphate generic -metabolite KEGG:C19762 Cyanidin 3-O-(2-O-beta-D-glucuronosyl)-beta-D-glucoside generic -metabolite KEGG:C19763 Soyasapogenol B 3-O-D-glucuronide generic -metabolite KEGG:C19764 9,15,9'-tricis-zeta-Carotene generic -metabolite KEGG:C19765 15,9'-dicis-Phytofluene generic -metabolite KEGG:C19766 5'-Deoxy-5'-fluoroadenosine generic -metabolite KEGG:C19767 7-(3-Methylbut-2-enyl)-L-tryptophan generic -metabolite KEGG:C19768 5-Deoxy-5-chloroadenosine generic -metabolite KEGG:C19769 1,6-Anhydro-N-acetyl-beta-muramate generic -metabolite KEGG:C19770 N-Acetyl-beta-muramate 6-phosphate generic -metabolite KEGG:C19771 2'-(5-Triphosphoribosyl)-3'-dephospho-CoA generic -metabolite KEGG:C19772 alpha-D-Glucopyranosyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C19773 3-O-alpha-D-Mannopyranosyl-alpha-D-mannopyranose generic -metabolite KEGG:C19774 3-O-(6-O-alpha-D-Xylosylphospho-alpha-D-mannopyranosyl)-alpha-D-mannopyranose generic -metabolite KEGG:C19775 Fluoroacetyl-CoA generic -metabolite KEGG:C19776 1,2-Diacyl-sn-glycerol 3-diphosphate generic -metabolite KEGG:C19777 L-Homoserine lactone generic -metabolite KEGG:C19778 (R)-Piperazine-2-carboxamide generic -metabolite KEGG:C19779 beta-Alaninamide generic -metabolite KEGG:C19780 (R)-Piperazine-2-carboxylate generic -metabolite KEGG:C19781 L-Prolinamide generic -metabolite KEGG:C19782 (S)-Piperazine-2-carboxamide generic -metabolite KEGG:C19783 (S)-Piperazine-2-carboxylate generic -metabolite KEGG:C19784 1-O-[2-(Acetylamino)-2-deoxy-alpha-D-glucopyranosyl]-D-myo-Inositol generic -metabolite KEGG:C19785 Streptothricin F generic -metabolite KEGG:C19786 Streptothricin F acid generic -metabolite KEGG:C19787 5'-S-Methyl-5'-thioinosine generic -metabolite KEGG:C19788 5-Nitroanthranilate generic -metabolite KEGG:C19789 5-Nitrosalicylate generic -metabolite KEGG:C19790 Reduced flavin generic -metabolite KEGG:C19791 2-O-(alpha-D-Glucopyranosyl)-3-phospho-D-glycerate generic -metabolite KEGG:C19792 2-O-(alpha-D-Glucopyranosyl)-D-glycerate generic -metabolite KEGG:C19793 2-O-[2-O-(alpha-D-Mannopyranosyl)-alpha-D-glucopyranosyl]-3-phospho-D-glycerate generic -metabolite KEGG:C19794 CDP-1L-myo-inositol generic -metabolite KEGG:C19795 1-Hydroxy-1,2-dihydrolycopene generic -metabolite KEGG:C19796 Quercetin 3-O-rhamnoside 7-O-glucoside generic -metabolite KEGG:C19797 4,4'-Diapolycopene generic -metabolite KEGG:C19798 4,4'-Diapolycopenedial generic -metabolite KEGG:C19799 Bis(1L-myo-inositol)-3,1'-phosphate 1-phosphate generic -metabolite KEGG:C19800 (3-Phenoxyphenyl)methanol generic -metabolite KEGG:C19801 Isomultiflorenol generic -metabolite KEGG:C19802 [Protein]-3-O-(N-acetyl-D-glucosaminyl)-L-serine generic -metabolite KEGG:C19803 [Protein]-L-threonine generic -metabolite KEGG:C19804 [Protein]-3-O-(N-acetyl-D-glucosaminyl)-L-threonine generic -metabolite KEGG:C19805 Aminopentol generic -metabolite KEGG:C19806 Propane-1,2,3-tricarboxylate generic -metabolite KEGG:C19807 3',4',5'-O-Trimethyltricetin generic -metabolite KEGG:C19808 Glucovanillin generic -metabolite KEGG:C19809 (S)-Piperidine-2-carboxamide generic -metabolite KEGG:C19810 ent-Pimara-9(11),15-diene generic -metabolite KEGG:C19811 9-cis-Epoxycarotenoid generic -metabolite KEGG:C19812 12'-apo-Carotenal generic -metabolite KEGG:C19813 threo-3-Hydroxy-D-aspartate generic -metabolite KEGG:C19814 Terpentetriene generic -metabolite KEGG:C19815 Terpentedienyl diphosphate generic -metabolite KEGG:C19816 Elisabethatriene generic -metabolite KEGG:C19817 Phyllocladan-16alpha-ol generic -metabolite KEGG:C19818 beta-Phellandrene generic -metabolite KEGG:C19819 Cucurbitadienol generic -metabolite KEGG:C19820 Protostadienol generic -metabolite KEGG:C19821 2-Hydroxy-2-(hydroxymethyl)-2H-pyran-3(6H)-one generic -metabolite KEGG:C19822 1,5-Anhydro-4-deoxy-D-glycero-hex-3-en-2-ulose generic -metabolite KEGG:C19823 UDP-2-acetamido-2,6-dideoxy-beta-L-arabino-hexos-4-ulose generic -metabolite KEGG:C19824 D-5-Monosubstituted hydantoin generic -metabolite KEGG:C19825 L-5-Monosubstituted hydantoin generic -metabolite KEGG:C19826 1,5-Anhydro-4-deoxy-D-glycero-hex-1-en-3-ulose generic -metabolite KEGG:C19827 Colneleate generic -metabolite KEGG:C19828 Arabidiol generic -metabolite KEGG:C19829 Dammarenediol II generic -metabolite KEGG:C19830 (5S,6S)-6-Amino-5-hydroxycyclohexa-1,3-diene-1-carboxylate generic -metabolite KEGG:C19831 (1R,6S)-6-Amino-5-oxocyclohex-2-ene-1-carboxylate generic -metabolite KEGG:C19832 Thalianol generic -metabolite KEGG:C19833 Germanicol generic -metabolite KEGG:C19834 Dammara-20,24-diene generic -metabolite KEGG:C19835 Camelliol C generic -metabolite KEGG:C19836 Halima-5(6),13-dien-15-yl diphosphate generic -metabolite KEGG:C19837 Indole-3-carboxylate generic -metabolite KEGG:C19838 D-erythro-3-Hydroxyaspartate generic -metabolite KEGG:C19839 4,4'-Diaponeurosporen-4-al generic -metabolite KEGG:C19840 4,4'-Diapophytofluene generic -metabolite KEGG:C19841 4,4'-Diapo-zeta-carotene generic -metabolite KEGG:C19842 Peptidoglycan-D-glucosamine generic -metabolite KEGG:C19843 L-Asp(4-L-Arg) generic -metabolite KEGG:C19844 (1S,3R)-3-(2,2-Dichloroethenyl)-2,2-dimethylcyclopropanecarboxylate generic -metabolite KEGG:C19845 Pimeloyl-[acyl-carrier protein] generic -metabolite KEGG:C19846 Pimeloyl-[acyl-carrier protein] methyl ester generic -metabolite KEGG:C19847 Demethylmenaquinol generic -metabolite KEGG:C19848 Adenylated molybdopterin generic -metabolite KEGG:C19850 4-O-Phosphohygromycin B generic -metabolite KEGG:C19851 ADP-ribose 1'',2''-phosphate generic -metabolite KEGG:C19852 tritrans,heptacis-Undecaprenyl diphosphate generic -metabolite KEGG:C19853 trans,polycis-Polyprenyl diphosphate generic -metabolite KEGG:C19854 D-GlcA-beta-(1->2)-D-Man-alpha-(1->3)-D-Glc-beta-(1->4)-D-Glc-alpha-1-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C19855 D-Man-alpha-(1->3)-D-Glc-beta-(1->4)-D-Glc-alpha-1-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C19856 D-Glc-beta-(1->4)-Glc-alpha-1-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C19857 D-Man-beta-(1->4)-GlcA-beta-(1->2)-D-Man-alpha-(1->3)-D-Glc-beta-(1->4)-D-Glc-alpha-1-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C19858 2-Methoxy-6-all-trans-polyprenyl-1,4-benzoquinol generic -metabolite KEGG:C19859 6-Methoxy-3-methyl-2-all-trans-polyprenyl-1,4-benzoquinol generic -metabolite KEGG:C19861 3-Hydroxy fatty acid generic -metabolite KEGG:C19862 Cyclic ketone generic -metabolite KEGG:C19863 Lupan-3beta,20-diol generic -metabolite KEGG:C19864 trans-Permethrin generic -metabolite KEGG:C19865 Soyasaponin III generic -metabolite KEGG:C19866 N-Acetyl-beta-D-galactosaminyl-(1->3)-beta-D-galactosyl-(1->4)-beta-D-glucosylceramide generic -metabolite KEGG:C19867 beta-D-Glucosyl crocetin generic -metabolite KEGG:C19868 Bis(beta-D-glucosyl) crocetin generic -metabolite KEGG:C19869 beta-D-Gentiobiosyl crocetin generic -metabolite KEGG:C19870 4,6-CH3(COO-)C-D-Man-beta-(1->4)-D-GlcA-beta-(1->2)-D-Man-alpha-(1->3)-D-Glc-beta-(1->4)-D-Glc-alpha-1-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C19871 Guanylyl molybdenum cofactor generic -metabolite KEGG:C19872 N-Formyl-4-amino-5-aminomethyl-2-methylpyrimidine generic -metabolite KEGG:C19873 26-Hydroxycastasterone generic -metabolite KEGG:C19874 26-Hydroxybrassinolide generic -metabolite KEGG:C19875 alpha-Kdo-(2->8)-alpha-Kdo-(2->4)-alpha-Kdo-(2->6)-lipid IVA generic -metabolite KEGG:C19876 alpha-Kdo-(2->8)-[alpha-Kdo-(2->4)]-alpha-Kdo-(2->4)-alpha-Kdo-(2->6)-lipid IVA generic -metabolite KEGG:C19877 4-O-Phospho-alpha-Kdo-(2->6)-lipid IVA generic -metabolite KEGG:C19878 D-glycero-alpha-D-manno-Heptose 7-phosphate generic -metabolite KEGG:C19879 D-glycero-alpha-D-manno-Heptose 1,7-bisphosphate generic -metabolite KEGG:C19880 D-glycero-alpha-D-manno-Heptose 1-phosphate generic -metabolite KEGG:C19881 GDP-D-glycero-alpha-D-manno-heptose generic -metabolite KEGG:C19882 D-glycero-D-manno-Heptose 7-phosphate generic -metabolite KEGG:C19883 alpha-Kdo-(2->4)-alpha-Kdo-(2->6)-[4-P-L-Ara4N]-lipid IVA generic -metabolite KEGG:C19884 Lipid IIA generic -metabolite KEGG:C19885 alpha-Aminoadipate carrier protein LysW generic -metabolite KEGG:C19886 LysW-gamma-L-alpha-aminoadipate generic -metabolite KEGG:C19887 LysW-gamma-L-alpha-aminoadipyl 6-phosphate generic -metabolite KEGG:C19888 LysW-gamma-L-alpha-aminoadipate 6-semialdehyde generic -metabolite KEGG:C19889 LysW-gamma-L-lysine generic -metabolite KEGG:C19890 alpha-Kdo-(2->4)-alpha-Kdo-(2->6)-[4-P-L-Ara4N]-lipid A generic -metabolite KEGG:C19891 1D-chiro-Inositol generic -metabolite KEGG:C19892 4'-Apo-beta,psi-caroten-4'-al generic -metabolite KEGG:C19893 10-epi-gamma-Eudesmol generic -metabolite KEGG:C19894 1,1'-Dihydroxy-1,1',2,2'-tetrahydrolycopene generic -metabolite KEGG:C19895 4'-Methoxyflavanone generic -metabolite KEGG:C19896 4'-Hydroxyflavanone generic -metabolite KEGG:C19897 Debromohymenialdisine generic -metabolite KEGG:C19898 Manzamine A generic -metabolite KEGG:C19899 Dolastatin 15 generic -metabolite KEGG:C19900 12-epi-Scalaradial generic -metabolite KEGG:C19901 Luffariellolide generic -metabolite KEGG:C19902 Contignasterol generic -metabolite KEGG:C19903 Lasonolide A generic -metabolite KEGG:C19904 Latrunculin B generic -metabolite KEGG:C19905 DMXB-A generic -metabolite KEGG:C19906 omega-Conotoxin generic -metabolite KEGG:C19907 Pyrrole generic -metabolite KEGG:C19908 (+)-beta-Chamigrene generic -metabolite KEGG:C19909 N-Acetyl-alpha-neuraminate generic -metabolite KEGG:C19910 N-Acetyl-beta-neuraminate generic -metabolite KEGG:C19911 Iminodiacetate generic -metabolite KEGG:C19912 N-Arachidonoyl-phosphatidylethanolamine generic -metabolite KEGG:C19913 Phospho-anandamide generic -metabolite KEGG:C19914 Myriocin generic -metabolite KEGG:C19915 Pyrazinoic acid generic -metabolite KEGG:C19916 Halomon generic -metabolite KEGG:C19917 Pateamine generic -metabolite KEGG:C19918 Parkeol generic -metabolite KEGG:C19919 Safranin generic -metabolite KEGG:C19920 Diatoxanthin generic -metabolite KEGG:C19921 Diadinoxanthin generic -metabolite KEGG:C19922 Cytochrome c-554 generic -metabolite KEGG:C19923 Cytochrome P-460 generic -metabolite KEGG:C19924 Membrane-associated cytochrome c-552 generic -metabolite KEGG:C19925 Cytochrome c-550 generic -metabolite KEGG:C19926 Pseudoazurin generic -metabolite KEGG:C19927 Cytochrome b generic -metabolite KEGG:C19928 Molybdopterin guanine dinucleotide generic -metabolite KEGG:C19929 N(alpha)-Acetyl-L-2,4-diaminobutyrate generic -metabolite KEGG:C19930 tert-Butylbicyclophosphorothionate generic -metabolite KEGG:C19931 Raucaffrinoline generic -metabolite KEGG:C19932 Perakine generic -metabolite KEGG:C19933 Prosolanapyrone II generic -metabolite KEGG:C19934 Prosolanapyrone III generic -metabolite KEGG:C19935 Azide generic -metabolite KEGG:C19936 (9R,10E,12Z,15Z)-9-Hydroperoxyoctadeca-10,12,15-trienoate generic -metabolite KEGG:C19937 (8E,10R,12Z)-10-Hydroperoxy-8,12-octadecadienoate generic -metabolite KEGG:C19938 Pentalen-13-ol generic -metabolite KEGG:C19939 Pentalen-13-al generic -metabolite KEGG:C19940 Ferredoxin N generic -metabolite KEGG:C19941 FdI generic -metabolite KEGG:C19942 11alpha-Hydroxy-beta-amyrin generic -metabolite KEGG:C19943 11-Oxo-beta-amyrin generic -metabolite KEGG:C19944 3-Hydroxy-9,10-secoandrosta-1,3,5(10)-triene-9,17-dione generic -metabolite KEGG:C19945 3-Oxo-5,6-dehydrosuberyl-CoA generic -metabolite KEGG:C19946 3-Oxo-5,6-dehydrosuberyl-CoA semialdehyde generic -metabolite KEGG:C19947 dTDP-3-amino-3,6-dideoxy-alpha-D-galactopyranose generic -metabolite KEGG:C19948 dTDP-3-dimethylamino-3,6-dideoxy-alpha-D-galactopyranose generic -metabolite KEGG:C19949 Acromelic acid A generic -metabolite KEGG:C19950 Samandarine generic -metabolite KEGG:C19951 Samandarone generic -metabolite KEGG:C19952 HT-2 Toxin generic -metabolite KEGG:C19953 Cytochalasin A generic -metabolite KEGG:C19954 Cytochalasin B generic -metabolite KEGG:C19955 Phomopsin A generic -metabolite KEGG:C19956 Neoilludin A generic -metabolite KEGG:C19957 Fasciculol E generic -metabolite KEGG:C19958 Fasciculol F generic -metabolite KEGG:C19959 Orellanine generic -metabolite KEGG:C19960 dTDP-3-dehydro-6-deoxy-alpha-D-galactopyranose generic -metabolite KEGG:C19961 UDP-4-amino-4,6-dideoxy-N-acetyl-beta-L-altrosamine generic -metabolite KEGG:C19962 13-cis-Retinol generic -metabolite KEGG:C19963 Tuberculosinol generic -metabolite KEGG:C19964 (13S)-Isotuberculosinol generic -metabolite KEGG:C19965 beta-D-4-Deoxy-Delta4-GlcA-(1->4)-beta-D-Glc-(1->4)-alpha-L-Rha-(1->3)-D-Glc generic -metabolite KEGG:C19966 beta-D-Glc-(1->4)-alpha-L-Rha-(1->3)-D-Glc generic -metabolite KEGG:C19967 8-Oxo-dGTP generic -metabolite KEGG:C19968 8-Oxo-dGMP generic -metabolite KEGG:C19969 2-Hydroxy-dATP generic -metabolite KEGG:C19970 2-Hydroxy-dAMP generic -metabolite KEGG:C19971 UDP-2,4-bis(acetamido)-2,4,6-trideoxy-beta-L-altropyranose generic -metabolite KEGG:C19972 2,4-Bis(acetamido)-2,4,6-trideoxy-beta-L-altropyranose generic -metabolite KEGG:C19973 (+)-beta-Caryophyllene generic -metabolite KEGG:C19974 (+)-Caryolan-1-ol generic -metabolite KEGG:C19975 2-Oxepin-2(3H)-ylideneacetyl-CoA generic -metabolite KEGG:C19976 Valinopine generic -metabolite KEGG:C19977 Clitidine generic -metabolite KEGG:C19978 Sclerocitrin generic -metabolite KEGG:C19979 Ustalic acid generic -metabolite KEGG:C19980 Domesticine generic -metabolite KEGG:C19981 Gloriosine generic -metabolite KEGG:C19982 Gelsedine generic -metabolite KEGG:C19983 Conhydrine generic -metabolite KEGG:C19984 Cerberin generic -metabolite KEGG:C19985 Nantenine generic -metabolite KEGG:C19986 Convalloside generic -metabolite KEGG:C19987 Oleandrin generic -metabolite KEGG:C19988 Strophanthidin generic -metabolite KEGG:C19989 Taxine B generic -metabolite KEGG:C19990 Aconine generic -metabolite KEGG:C19991 Euphornin generic -metabolite KEGG:C19992 Rhodojaponin I generic -metabolite KEGG:C19993 Virol A generic -metabolite KEGG:C19994 Virol B generic -metabolite KEGG:C19995 Microcystin RR generic -metabolite KEGG:C19996 Microcystin RA generic -metabolite KEGG:C19997 Microcystin YR generic -metabolite KEGG:C19998 Anatoxin a(s) generic -metabolite KEGG:C19999 Cylindrospermopsin generic -metabolite KEGG:C20000 Onchidal generic -metabolite KEGG:C20001 CTX 3C generic -metabolite KEGG:C20002 Ciguatoxin 4A generic -metabolite KEGG:C20003 Caribbean ciguatoxin 1 generic -metabolite KEGG:C20004 Gambierol generic -metabolite KEGG:C20005 Dinophysistoxin 4 generic -metabolite KEGG:C20006 Acanthifolicin generic -metabolite KEGG:C20007 Caribenolide I generic -metabolite KEGG:C20008 Hoffmanniolide generic -metabolite KEGG:C20009 Iriomoteolide 1a generic -metabolite KEGG:C20010 Anatibant generic -metabolite KEGG:C20011 Homoyessotoxin generic -metabolite KEGG:C20012 Pectenotoxin 2 generic -metabolite KEGG:C20013 Brevetoxin B1 generic -metabolite KEGG:C20014 Brevetoxin B2 generic -metabolite KEGG:C20015 Brevetoxin C generic -metabolite KEGG:C20016 Hemibrevetoxin B generic -metabolite KEGG:C20017 Satratoxin H generic -metabolite KEGG:C20018 Gonyautoxin 5 generic -metabolite KEGG:C20019 Gonyautoxin 6 generic -metabolite KEGG:C20020 Gonyautoxin 8 generic -metabolite KEGG:C20021 Decarbamoylsaxitoxin generic -metabolite KEGG:C20022 Decarbamoylgonyautoxin 1 generic -metabolite KEGG:C20023 Prorocentrolide generic -metabolite KEGG:C20024 Prorocentrolide B generic -metabolite KEGG:C20025 Gymnodimine generic -metabolite KEGG:C20026 11-Deoxytetrodotoxin generic -metabolite KEGG:C20027 Isodomoic acid A generic -metabolite KEGG:C20028 Ostreocin D generic -metabolite KEGG:C20029 Eledoisin generic -metabolite KEGG:C20030 Dermorphin generic -metabolite KEGG:C20031 Pumiliotoxin 251D generic -metabolite KEGG:C20032 Batrachotoxinin A generic -metabolite KEGG:C20033 Pumiliotoxin A generic -metabolite KEGG:C20034 Allopumiliotoxin 267A generic -metabolite KEGG:C20035 Arenobufagin generic -metabolite KEGG:C20036 Marinobufagenin generic -metabolite KEGG:C20037 alpha-Bungarotoxin generic -metabolite KEGG:C20038 beta-Bungarotoxin generic -metabolite KEGG:C20039 Dendrotoxin generic -metabolite KEGG:C20040 Fasciculin generic -metabolite KEGG:C20041 Calciseptine generic -metabolite KEGG:C20042 Cardiotoxin III generic -metabolite KEGG:C20043 Taicatoxin generic -metabolite KEGG:C20044 Enanthotoxin generic -metabolite KEGG:C20045 Verruculogen generic -metabolite KEGG:C20046 Mollicellin C generic -metabolite KEGG:C20047 Adolapin generic -metabolite KEGG:C20048 Apamine generic -metabolite KEGG:C20049 Mast cell degranulating peptide generic -metabolite KEGG:C20050 Polisteskinin JT generic -metabolite KEGG:C20051 Mandaratoxin generic -metabolite KEGG:C20052 Philanthotoxin generic -metabolite KEGG:C20053 Tertiapin generic -metabolite KEGG:C20054 alpha-Latrotoxin generic -metabolite KEGG:C20055 Iberiotoxin generic -metabolite KEGG:C20056 Agitoxin 1 generic -metabolite KEGG:C20057 Margatoxin generic -metabolite KEGG:C20058 Leiurotoxin I generic -metabolite KEGG:C20059 Samandenone generic -metabolite KEGG:C20060 Cephalostatin 1 generic -metabolite KEGG:C20061 Ritterazine A generic -metabolite KEGG:C20062 2-(1,2-Epoxy-1,2-dihydrophenyl)acetyl-CoA generic -metabolite KEGG:C20063 Bestoxin generic -metabolite KEGG:C20064 kappa-Hefutoxin 1 generic -metabolite KEGG:C20065 Maurotoxin generic -metabolite KEGG:C20066 Slotoxin generic -metabolite KEGG:C20067 Stromatoxin 1 generic -metabolite KEGG:C20068 Abrin generic -metabolite KEGG:C20069 Charybdotoxin generic -metabolite KEGG:C20070 Penitrem A generic -metabolite KEGG:C20073 Xestoquinone generic -metabolite KEGG:C20077 Megascoliakinin generic -metabolite KEGG:C20078 alpha-Pompilidotoxin generic -metabolite KEGG:C20079 beta-Pompilidotoxin generic -metabolite KEGG:C20080 Bombolitin I generic -metabolite KEGG:C20081 Vespakinin M generic -metabolite KEGG:C20082 Pseudaminic acid generic -metabolite KEGG:C20083 CMP-pseudaminic acid generic -metabolite KEGG:C20084 Contulakin G generic -metabolite KEGG:C20085 Botrocetin generic -metabolite KEGG:C20086 Crotalase generic -metabolite KEGG:C20087 Crotalocytin generic -metabolite KEGG:C20088 Echistatin generic -metabolite KEGG:C20089 Gabonase generic -metabolite KEGG:C20090 Toxin omega-Aga-IA generic -metabolite KEGG:C20091 Toxin omega-Aga-IIIA generic -metabolite KEGG:C20092 Toxin omega-Aga-IVA generic -metabolite KEGG:C20093 Argiopinin I generic -metabolite KEGG:C20094 Argiopinin II generic -metabolite KEGG:C20095 Argiopinin III generic -metabolite KEGG:C20096 Pseudoargiopinin I generic -metabolite KEGG:C20097 Pseudoargiopinin III generic -metabolite KEGG:C20098 Cupiennin 1a generic -metabolite KEGG:C20099 Cupiennin 1b generic -metabolite KEGG:C20100 Jingzhaotoxin I generic -metabolite KEGG:C20101 Jingzhaotoxin III generic -metabolite KEGG:C20102 Jingzhaotoxin V generic -metabolite KEGG:C20103 Latarcin 1 generic -metabolite KEGG:C20104 Latarcin 2a generic -metabolite KEGG:C20105 Latarcin 3a generic -metabolite KEGG:C20106 Lycocitin 1 generic -metabolite KEGG:C20107 Lycocitin 2 generic -metabolite KEGG:C20108 Lycocitin 3 generic -metabolite KEGG:C20109 Lycotoxin I generic -metabolite KEGG:C20110 Lycotoxin II generic -metabolite KEGG:C20111 Oxyopinin 1 generic -metabolite KEGG:C20112 Oxyopinin 2a generic -metabolite KEGG:C20113 Phrixotoxin 1 generic -metabolite KEGG:C20114 Phrixotoxin 2 generic -metabolite KEGG:C20115 Agelenin generic -metabolite KEGG:C20116 Hanatoxin 1 generic -metabolite KEGG:C20117 Huwentoxin-XI generic -metabolite KEGG:C20118 Robustoxin generic -metabolite KEGG:C20119 Protein-cysteine generic -metabolite KEGG:C20120 S-Farnesyl protein generic -metabolite KEGG:C20121 trans,trans-Farnesyl phosphate generic -metabolite KEGG:C20122 Dibenz[c,h]acridine generic -metabolite KEGG:C20123 Dibromoacetic acid generic -metabolite KEGG:C20124 Benzo[b]naphtho[2,1-d]thiophene generic -metabolite KEGG:C20125 Dibenzothiophene generic -metabolite KEGG:C20126 Methylone generic -metabolite KEGG:C20127 alpha-Methyltryptamine generic -metabolite KEGG:C20128 Bombykal generic -metabolite KEGG:C20129 (S)-Warfarin generic -metabolite KEGG:C20130 (S)-Mephenytoin generic -metabolite KEGG:C20131 Aclatonium generic -metabolite KEGG:C20132 Platensimycin generic -metabolite KEGG:C20133 Sugiresinol generic -metabolite KEGG:C20134 19-Chloroproansamitocin generic -metabolite KEGG:C20135 20-O-Methyl-19-chloroproansamitocin generic -metabolite KEGG:C20136 N-Demethyl-desepoxymaytansinol generic -metabolite KEGG:C20137 N-Demethyl-desepoxyansamitocin P-3 generic -metabolite KEGG:C20138 N-Demethylansamitocin P-3 generic -metabolite KEGG:C20139 Ansamitocinoside P-3 generic -metabolite KEGG:C20140 4''-O-Carbamoyl ansamitocinoside P-3 generic -metabolite KEGG:C20141 Acridine generic -metabolite KEGG:C20142 Acridone generic -metabolite KEGG:C20143 (25S)-26-Hydroxycholest-4-en-3-one generic -metabolite KEGG:C20144 Androsta-1,4-diene-3,17-dione generic -metabolite KEGG:C20145 ent-Isokaurene generic -metabolite KEGG:C20146 ent-2alpha-Hydroxyisokaurene generic -metabolite KEGG:C20147 9beta-Pimara-7,15-dien-19-ol generic -metabolite KEGG:C20148 9beta-Pimara-7,15-dien-19-al generic -metabolite KEGG:C20149 9beta-Pimara-7,15-dien-19-oate generic -metabolite KEGG:C20150 ent-11beta-Hydroxycassa-12,15-diene generic -metabolite KEGG:C20151 10beta,14beta-Dihydroxytaxa-4(20),11-dien-5alpha-yl acetate generic -metabolite KEGG:C20152 Taxusin generic -metabolite KEGG:C20153 7beta-Hydroxytaxusin generic -metabolite KEGG:C20154 3-Methoxy-4',5-dihydroxy-trans-stilbene generic -metabolite KEGG:C20155 8-Oxoguanine generic -metabolite KEGG:C20156 dTDP-3-acetamido-3,6-dideoxy-alpha-D-galactopyranose generic -metabolite KEGG:C20157 beta-Carboline generic -metabolite KEGG:C20158 (13E)-Labda-7,13-dien-15-ol generic -metabolite KEGG:C20159 7-epi-alpha-Selinene generic -metabolite KEGG:C20160 CTOP generic -metabolite KEGG:C20161 alpha-Guaiene generic -metabolite KEGG:C20162 Viridiflorene generic -metabolite KEGG:C20163 5-epi-alpha-Selinene generic -metabolite KEGG:C20164 DPDPE generic -metabolite KEGG:C20165 DSLET generic -metabolite KEGG:C20166 Naltriben generic -metabolite KEGG:C20167 7-Benzylidenenaltrexone generic -metabolite KEGG:C20168 (-)TAN-67 generic -metabolite KEGG:C20169 (+)TAN-67 generic -metabolite KEGG:C20170 Benzoyl isothiocyanate generic -metabolite KEGG:C20171 Icilin generic -metabolite KEGG:C20172 Cubebol generic -metabolite KEGG:C20173 (+)-gamma-Cadinene generic -metabolite KEGG:C20174 delta-Guaiene generic -metabolite KEGG:C20175 Bicyclogermacrene generic -metabolite KEGG:C20176 8-Oxo-dGDP generic -metabolite KEGG:C20177 7-epi-Sesquithujene generic -metabolite KEGG:C20178 Sesquithujene generic -metabolite KEGG:C20179 gamma-Curcumene generic -metabolite KEGG:C20180 (-)-alpha-Cuprenene generic -metabolite KEGG:C20181 Avermitilol generic -metabolite KEGG:C20182 (-)-delta-Cadinene generic -metabolite KEGG:C20183 N7-Methylguanosine 5'-diphosphate generic -metabolite KEGG:C20184 (+)-T-Muurolol generic -metabolite KEGG:C20185 (12E)-9alpha-Labda-8(17),12,14-triene generic -metabolite KEGG:C20186 5S,8R-DiHODE generic -metabolite KEGG:C20187 Achilleol B generic -metabolite KEGG:C20188 Glutinol generic -metabolite KEGG:C20189 Baccharis oxide generic -metabolite KEGG:C20190 P1,P6-Bis(5'-adenosyl)hexaphosphate generic -metabolite KEGG:C20191 alpha-seco-Amyrin generic -metabolite KEGG:C20192 Marneral generic -metabolite KEGG:C20193 beta-seco-Amyrin generic -metabolite KEGG:C20194 delta-Amyrin generic -metabolite KEGG:C20195 Tirucalla-7,24-dien-3beta-ol generic -metabolite KEGG:C20196 Salvinorin A generic -metabolite KEGG:C20197 Prostratin generic -metabolite KEGG:C20198 Adenosine 5'-pentaphosphate generic -metabolite KEGG:C20199 3-[(3aS,4S,7aS)-7a-Methyl-1,5-dioxo-octahydro-1H-inden-4-yl]propanoate generic -metabolite KEGG:C20200 Baruol generic -metabolite KEGG:C20201 (-)-Solanapyrone A generic -metabolite KEGG:C20202 BRACO-19 generic -metabolite KEGG:C20203 Capsiate generic -metabolite KEGG:C20204 Entadamide A generic -metabolite KEGG:C20205 Tanabalin generic -metabolite KEGG:C20206 Albaspidin BB generic -metabolite KEGG:C20207 Grandinol generic -metabolite KEGG:C20208 syn-Stemoden-19-oate generic -metabolite KEGG:C20209 Meconic acid generic -metabolite KEGG:C20210 Eugenin generic -metabolite KEGG:C20211 Yakuchinone A generic -metabolite KEGG:C20212 Steviol generic -metabolite KEGG:C20213 Annonacin generic -metabolite KEGG:C20214 Andrographolide generic -metabolite KEGG:C20215 Homocapsaicin generic -metabolite KEGG:C20216 Nordihydrocapsaicin generic -metabolite KEGG:C20217 Cannabidivarin generic -metabolite KEGG:C20218 Cannabielsoin generic -metabolite KEGG:C20219 Cannabigerol generic -metabolite KEGG:C20220 AM251 generic -metabolite KEGG:C20221 (6E)-8-Oxolinalool generic -metabolite KEGG:C20222 (6E)-8-Hydroxygeranial generic -metabolite KEGG:C20223 (6E)-8-Oxogeraniol generic -metabolite KEGG:C20224 Coniferyl ester generic -metabolite KEGG:C20225 Coniferyl acetate generic -metabolite KEGG:C20226 Benzil generic -metabolite KEGG:C20227 (S)-Benzoin generic -metabolite KEGG:C20228 (R)-Benzoin generic -metabolite KEGG:C20229 10-Hydroxy-alpha-humulene generic -metabolite KEGG:C20230 (+)-Sabinene generic -metabolite KEGG:C20231 (Z)-3-Ureidoacrylate peracid generic -metabolite KEGG:C20232 (Z)-2-Methylureidoacrylate peracid generic -metabolite KEGG:C20233 17-Hydroxylupanine generic -metabolite KEGG:C20234 5-Guanidino-3-methyl-2-oxopentanoate generic -metabolite KEGG:C20235 (E)-2-Methylgeranyl diphosphate generic -metabolite KEGG:C20236 4-O-beta-D-Mannopyranosyl-D-glucopyranose generic -metabolite KEGG:C20237 alpha-Maltose 1-phosphate generic -metabolite KEGG:C20238 (2R)-Ethylmalonyl-CoA generic -metabolite KEGG:C20239 6-Carboxy-5,6,7,8-tetrahydropterin generic -metabolite KEGG:C20240 (2Z,4Z)-2-Hydroxyhexa-2,4-dienoate generic -metabolite KEGG:C20241 Tricyclene generic -metabolite KEGG:C20242 (-)-Sabinene generic -metabolite KEGG:C20243 2-Methylisoborneol generic -metabolite KEGG:C20244 (+)-beta-Pinene generic -metabolite KEGG:C20245 UDP-N-acetyl-alpha-D-glucosamine 3'-phosphate generic -metabolite KEGG:C20246 2-[(2R,5Z)-2-Carboxy-4-methylthiazol-5(2H)-ylidene]ethyl phosphate generic -metabolite KEGG:C20247 2-(2-Carboxy-4-methylthiazol-5-yl)ethyl phosphate generic -metabolite KEGG:C20248 7-Carboxy-7-carbaguanine generic -metabolite KEGG:C20249 (Z)-3-Peroxyaminoacrylate generic -metabolite KEGG:C20250 (Z)-2-Methylperoxyaminoacrylate generic -metabolite KEGG:C20251 1-Keto-D-chiro-inositol generic -metabolite KEGG:C20252 5-Androstene-3,17-dione generic -metabolite KEGG:C20253 Aminoacrylate generic -metabolite KEGG:C20254 Ureidoacrylate generic -metabolite KEGG:C20258 (2S,4S)-4-Hydroxy-2,3,4,5-tetrahydrodipicolinate generic -metabolite KEGG:C20259 Mertansine generic -metabolite KEGG:C20260 (+)-Thujan-3-one generic -metabolite KEGG:C20261 (+)-Thujan-3-ol generic -metabolite KEGG:C20262 Zerumbone generic -metabolite KEGG:C20263 L-threo-7,8-Dihydrobiopterin generic -metabolite KEGG:C20264 L-threo-Tetrahydrobiopterin generic -metabolite KEGG:C20265 2,3-Epoxymenaquinone generic -metabolite KEGG:C20266 AMD 070 generic -metabolite KEGG:C20267 4-Amino-5-aminomethyl-2-methylpyrimidine generic -metabolite KEGG:C20268 Combretastatin A-4 generic -metabolite KEGG:C20269 Eugenol quinone methide generic -metabolite KEGG:C20270 Copal-8-ol diphosphate generic -metabolite KEGG:C20271 [(1R)-2,2,3-Trimethyl-5-oxocyclopent-3-enyl]acetate generic -metabolite KEGG:C20272 alpha-Muurolene generic -metabolite KEGG:C20273 gamma-Muurolene generic -metabolite KEGG:C20274 beta-Copaene generic -metabolite KEGG:C20275 (+)-Sativene generic -metabolite KEGG:C20276 Tetraprenyl-beta-curcumene generic -metabolite KEGG:C20277 (2R,3R)-3-Methylornithine generic -metabolite KEGG:C20278 (2R,3R)-3-Methylornithinyl-N6-lysine generic -metabolite KEGG:C20279 (2R,3R)-3-Methylglutamyl-5-semialdehyde-N6-lysine generic -metabolite KEGG:C20280 1-Phenylazo-2,6-dihydroxynaphthalene generic -metabolite KEGG:C20281 1-(4-Hydroxyphenylazo)-2-naphthol generic -metabolite KEGG:C20282 1-(4-Hydroxyphenylazo)-naphthalene-2,6-diol generic -metabolite KEGG:C20283 1-(3,4-Dihydroxyphenylazo)-2-naphthol generic -metabolite KEGG:C20284 Benzenediazonium generic -metabolite KEGG:C20285 4-Acetylaminobiphenyl generic -metabolite KEGG:C20286 2-Hydroxyamino-1-methyl-6-phenylimidazo[4,5-b]pyridine generic -metabolite KEGG:C20287 2-Acetoxyamino-1-methyl-6-phenylimidazo[4,5-b]pyridine generic -metabolite KEGG:C20288 N-Sulfonyloxy-PhIP generic -metabolite KEGG:C20289 N-Hydroxy-IQ generic -metabolite KEGG:C20290 N-Acetoxy-IQ generic -metabolite KEGG:C20291 N-Hydroxy-MeIQx generic -metabolite KEGG:C20292 Tetramethylammonium generic -metabolite KEGG:C20293 N-Acetoxy-MeIQx generic -metabolite KEGG:C20294 Chromium (V) generic -metabolite KEGG:C20295 Chromium (IV) generic -metabolite KEGG:C20296 Arsenic (V) generic -metabolite KEGG:C20297 Narcotine hemiacetal generic -metabolite KEGG:C20298 Arsenic (III) generic -metabolite KEGG:C20299 Papaveroxine generic -metabolite KEGG:C20300 Dimethylarsinous acid generic -metabolite KEGG:C20301 alpha-Hydroxy-NDMA generic -metabolite KEGG:C20302 Methyldiazonium ion generic -metabolite KEGG:C20303 Chloroethylene oxide generic -metabolite KEGG:C20304 S-(2-Chloroethyl)glutathione generic -metabolite KEGG:C20305 1,2-Dichloroethanol generic -metabolite KEGG:C20306 Methyldiazohydroxide generic -metabolite KEGG:C20307 Artemisinic alcohol generic -metabolite KEGG:C20308 Artemisinic aldehyde generic -metabolite KEGG:C20309 Artemisinate generic -metabolite KEGG:C20310 N-Hydroxy-L-isoleucine generic -metabolite KEGG:C20311 N,N-Dihydroxy-L-isoleucine generic -metabolite KEGG:C20312 (Z)-2-Methylbutanal oxime generic -metabolite KEGG:C20313 N-Hydroxy-L-valine generic -metabolite KEGG:C20314 N,N-Dihydroxy-L-valine generic -metabolite KEGG:C20315 (Z)-2-Methylpropanal oxime generic -metabolite KEGG:C20316 4-Nitrosobiphenyl generic -metabolite KEGG:C20317 S-(1,2-Dichlorovinyl)-L-cysteine generic -metabolite KEGG:C20318 S-(1,2-Dichlorovinyl)thiol generic -metabolite KEGG:C20319 Hydronitroxide radical generic -metabolite KEGG:C20320 Bornane-2,6-dione generic -metabolite KEGG:C20321 [(2R)-3,3,4-Trimethyl-6-oxo-3,6-dihydro-1H-pyran-2-yl]acetyl-CoA generic -metabolite KEGG:C20322 (+)-6-exo-Hydroxycamphor generic -metabolite KEGG:C20323 (+)-6-endo-Hydroxycamphor generic -metabolite KEGG:C20324 [(1S)-4-Hydroxy-2,2,3-trimethylcyclopent-3-enyl]acetate generic -metabolite KEGG:C20325 (11R)-Dihydroartemisinic aldehyde generic -metabolite KEGG:C20326 2-exo-Hydroxy-1,8-cineole generic -metabolite KEGG:C20327 2-Oxo-4-phenylbutyric acid generic -metabolite KEGG:C20328 N-Acetyl-alpha-D-glucosamine generic -metabolite KEGG:C20329 Abieta-7,13-dien-18,18-diol generic -metabolite KEGG:C20330 L-Hydroxyarginine generic -metabolite KEGG:C20331 beta-Carotene-15,15'-epoxide generic -metabolite KEGG:C20332 15,15'-Dihydroxy-beta-carotene generic -metabolite KEGG:C20333 N2-Citryl-N6-acetyl-N6-hydroxy-L-lysine generic -metabolite KEGG:C20334 1,2,6-Hexanetriol generic -metabolite KEGG:C20335 1,3-Butanediol generic -metabolite KEGG:C20336 Alphazurine FG generic -metabolite KEGG:C20337 Alizarin cyanin green generic -metabolite KEGG:C20338 2-Octyl dodecanol generic -metabolite KEGG:C20339 N,N-Dimethylacetamide generic -metabolite KEGG:C20340 L-Ascorbic acid, 6-octadecanoate generic -metabolite KEGG:C20341 Disodium malate generic -metabolite KEGG:C20342 Isobutylparaben generic -metabolite KEGG:C20343 Isopropylparaben generic -metabolite KEGG:C20344 New coccine generic -metabolite KEGG:C20345 Isopentenyl phosphate generic -metabolite KEGG:C20346 C.I. Acid red 33 generic -metabolite KEGG:C20347 Rose bengal generic -metabolite KEGG:C20348 Lissamine rhodamine B generic -metabolite KEGG:C20349 Quinoline yellow WS generic -metabolite KEGG:C20350 2'-Deamino-2'-hydroxyneamine generic -metabolite KEGG:C20351 2'-Deamino-2'-hydroxy-6'-dehydroparomamine generic -metabolite KEGG:C20352 trans,octacis-Decaprenylphospho-beta-D-ribofuranose 5-phosphate generic -metabolite KEGG:C20353 2'-Deamino-2'-hydroxyparomamine generic -metabolite KEGG:C20354 3-O-alpha-D-Glucopyranosyl-L-rhamnopyranose generic -metabolite KEGG:C20355 Glyceryl tri(2-ethylhexanoate) generic -metabolite KEGG:C20356 Isooctadecanoic acid generic -metabolite KEGG:C20357 UDP-N,N'-Diacetylbacillosamine generic -metabolite KEGG:C20358 Caloxetate trisodium generic -metabolite KEGG:C20359 UDP-2-acetamido-3-amino-2,3-dideoxy-alpha-D-glucuronate generic -metabolite KEGG:C20360 Sodium methallylsulfonate generic -metabolite KEGG:C20361 Pseudooxynicotine generic -metabolite KEGG:C20362 Ethyl maltol generic -metabolite KEGG:C20363 Ethylene carbonate generic -metabolite KEGG:C20364 Erythorbic acid generic -metabolite KEGG:C20365 Decyl oleate generic -metabolite KEGG:C20366 2-Oxo-3-(5-oxofuran-2-ylidene)propanoate generic -metabolite KEGG:C20367 4-Nitro-6-oxohepta-2,4-dienedioate generic -metabolite KEGG:C20368 trans,octacis-Decaprenylphospho-beta-D-ribofuranose generic -metabolite KEGG:C20369 trans,octacis-Decaprenylphospho-beta-D-erythro-pentofuranosid-2-ulose generic -metabolite KEGG:C20370 trans,octacis-Decaprenylphospho-beta-D-arabinofuranose generic -metabolite KEGG:C20371 Ecgonone methyl ester generic -metabolite KEGG:C20372 3-Ketoglutaryl-[acp] methyl ester generic -metabolite KEGG:C20373 3-Hydroxyglutaryl-[acp] methyl ester generic -metabolite KEGG:C20374 Enoylglutaryl-[acp] methyl ester generic -metabolite KEGG:C20375 Glutaryl-[acp] methyl ester generic -metabolite KEGG:C20376 3-Ketopimeloyl-[acp] methyl ester generic -metabolite KEGG:C20377 3-Hydroxypimeloyl-[acp] methyl ester generic -metabolite KEGG:C20378 Enoylpimeloyl-[acp] methyl ester generic -metabolite KEGG:C20379 Chanoclavine-I aldehyde generic -metabolite KEGG:C20380 Mycophenolate generic -metabolite KEGG:C20381 3,3'-Bipyridine-2,2',5,5',6,6'-hexol generic -metabolite KEGG:C20382 Imidazol-2-one generic -metabolite KEGG:C20383 Mycophenolic acid O-acyl-glucuronide generic -metabolite KEGG:C20384 Bisnorbiotin generic -metabolite KEGG:C20385 Tetranorbiotin generic -metabolite KEGG:C20386 Biotin sulfoxide generic -metabolite KEGG:C20387 Biotin sulfone generic -metabolite KEGG:C20388 12(S)-HHT generic -metabolite KEGG:C20389 Lauryltrimethylaminium bromide generic -metabolite KEGG:C20390 N-Acetyl-alpha-D-glucosaminyl-diphospho-trans,octacis-decaprenol generic -metabolite KEGG:C20394 2-Hydroxybenzoyl-CoA generic -metabolite KEGG:C20395 UDP-2-acetamido-2-deoxy-alpha-D-ribo-hex-3-uluronate generic -metabolite KEGG:C20396 Methylphosphonate generic -metabolite KEGG:C20397 Pentalenolactone F generic -metabolite KEGG:C20398 Pentalenolactone E generic -metabolite KEGG:C20399 Pentalenolactone D generic -metabolite KEGG:C20400 1-Deoxy-11-oxopentalenate generic -metabolite KEGG:C20402 Neopentalenolactone D generic -metabolite KEGG:C20403 1-Deoxy-11beta-hydroxypentalenate generic -metabolite KEGG:C20404 1-Deoxypentalenate generic -metabolite KEGG:C20405 Pentalenate generic -metabolite KEGG:C20406 Cannabigerolate generic -metabolite KEGG:C20407 Pentalenolactone generic -metabolite KEGG:C20408 Festuclavine generic -metabolite KEGG:C20409 6,8-Dimethyl-6,7-didehydroergoline generic -metabolite KEGG:C20410 4-Dimethylallyl-L-abrine generic -metabolite KEGG:C20411 3-Methyl-1,2-didehydro-2,3-dihydrosqualene generic -metabolite KEGG:C20412 3,22-Dimethyl-1,2,23,24-tetradehydro-2,3,22,23-tetrahydrosqualene generic -metabolite KEGG:C20413 3,5,7-Trioxododecanoyl-CoA generic -metabolite KEGG:C20414 4-Hydroxycoumarin generic -metabolite KEGG:C20415 dTDP-4-acetamido-4,6-dideoxy-alpha-D-galactose generic -metabolite KEGG:C20416 alpha-L-Rhamnopyranosyl-(1->3)-N-acetyl-alpha-D-glucosaminyl-diphospho-trans,octacis-decaprenol generic -metabolite KEGG:C20417 2,4-Dihydroxy-6-pentylbenzoate generic -metabolite KEGG:C20418 N,N'-Diacetyllegionaminate generic -metabolite KEGG:C20419 CMP-N,N'-diacetyllegionaminate generic -metabolite KEGG:C20420 tritrans,heptacis-Undecaprenyl phosphate generic -metabolite KEGG:C20421 N,N'-Diacetyl-alpha-D-bacillosaminyldiphospho-tritrans,heptacis-undecaprenol generic -metabolite KEGG:C20422 alpha-D-Ribose 1-methylphosphonate 5-triphosphate generic -metabolite KEGG:C20423 alpha-D-Ribose 1-methylphosphonate 5-phosphate generic -metabolite KEGG:C20424 2,4-Diacetamido-2,4,6-trideoxy-D-mannopyranose generic -metabolite KEGG:C20425 beta-Cyclocitral generic -metabolite KEGG:C20426 Mycorradicin generic -metabolite KEGG:C20427 N-Acetyl-D-galactosaminyl-alpha-(1->3)-N,N'-diacetyl-alpha-D-bacillosaminyldiphospho-tritrans,heptacis-undecaprenol generic -metabolite KEGG:C20428 (3S)-11-cis-3-Hydroxyretinal generic -metabolite KEGG:C20429 (3S)-all-trans-3-Hydroxyretinal generic -metabolite KEGG:C20430 (+)-Larreatricin generic -metabolite KEGG:C20431 (+)-3'-Hydroxylarreatricin generic -metabolite KEGG:C20432 C30 Botryococcene generic -metabolite KEGG:C20433 3-Methyl-1,2-didehydro-2,3-dihydrobotryococcene generic -metabolite KEGG:C20434 20-Methyl-21,22-didehydro-20,21-dihydrobotryococcene generic -metabolite KEGG:C20435 3,20-Dimethyl-1,2,21,22-tetradehydro-2,3,20,21-tetrahydrobotryococcene generic -metabolite KEGG:C20436 Fumigaclavine A generic -metabolite KEGG:C20437 Fumigaclavine B generic -metabolite KEGG:C20438 Fumigaclavine C generic -metabolite KEGG:C20439 NBMPR generic -metabolite KEGG:C20440 alpha-D-Ribose 1,2-cyclic phosphate 5-phosphate generic -metabolite KEGG:C20441 Furfuryl alcohol generic -metabolite KEGG:C20442 Dermatan 2,4-sulfate generic -metabolite KEGG:C20443 5-Hydroxymethylfurfuryl alcohol generic -metabolite KEGG:C20444 Dihydrodemethylsterigmatocystin generic -metabolite KEGG:C20445 Dihydrosterigmatocystin generic -metabolite KEGG:C20446 tRNA 7-aminomethyl-7-carbaguanine generic -metabolite KEGG:C20447 2-Oxoglutaryl-CoA generic -metabolite KEGG:C20448 5-Hydroxymethyl-2-furoate generic -metabolite KEGG:C20449 5-Formyl-2-furoate generic -metabolite KEGG:C20450 2,5-Furandicarboxylate generic -metabolite KEGG:C20451 tRNA hypoxanthine generic -metabolite KEGG:C20452 Norsolorinic acid generic -metabolite KEGG:C20453 Norsolorinic acid anthrone generic -metabolite KEGG:C20454 (-)-Lariciresinol generic -metabolite KEGG:C20455 (-)-Pinoresinol generic -metabolite KEGG:C20456 (+)-Secoisolariciresinol generic -metabolite KEGG:C20457 6,8-Dimethyl-6,7,8,9-tetradehydroergoline generic -metabolite KEGG:C20458 tRNA(Ala) hypoxanthine generic -metabolite KEGG:C20459 tRNA(Ala) adenine generic -metabolite KEGG:C20460 Cyanidin 3-O-[6-O-(6-O-4-hydroxycinnamoyl-beta-D-glucosyl)-2-O-beta-D-xylosyl-beta-D-galactoside] generic -metabolite KEGG:C20461 Anthocyanidin 3-O-[6-O-(4-hydroxycinnamoyl)-beta-D-glucoside] generic -metabolite KEGG:C20462 5,7-Dihydroxy-2-methyl-4H-chromen-4-one generic -metabolite KEGG:C20463 Purine deoxyribonucleoside generic -metabolite KEGG:C20464 Isochavicol generic -metabolite KEGG:C20465 Coumaryl acetate generic -metabolite KEGG:C20466 2,3-Bis-O-(geranylgeranyl)-sn-glycero-1-phospho-L-serine generic -metabolite KEGG:C20467 Anthocyanidin 3-O-beta-D-sambubioside generic -metabolite KEGG:C20468 Cyanidin 3-O-(beta-D-xylosyl-(1->2)-beta-D-galactoside) generic -metabolite KEGG:C20469 Cyanidin 3,7-di-O-beta-D-glucoside generic -metabolite KEGG:C20470 1-O-Vanilloyl-beta-D-glucose generic -metabolite KEGG:C20471 Anthocyanidin 3-O-sophoroside generic -metabolite KEGG:C20472 Anthocyanidin 3-O-[2-O-(4-coumaroyl)-alpha-L-rhamnosyl-(1->6)-beta-D-glucoside] generic -metabolite KEGG:C20473 Anthocyanidin 3-O-[2-O-(4-coumaroyl)-alpha-L-rhamnosyl-(1->6)-beta-D-glucoside] 5-O-beta-D-glucoside generic -metabolite KEGG:C20474 Anthocyanidin 5-O-beta-D-glucoside 3-O-beta-D-sambubioside generic -metabolite KEGG:C20475 Sporulenol generic -metabolite KEGG:C20476 Delta6-Protoilludene generic -metabolite KEGG:C20477 (-)-alpha-Isocomene generic -metabolite KEGG:C20478 (E)-2-epi-beta-Caryophyllene generic -metabolite KEGG:C20479 (+)-epi-alpha-Bisabolol generic -metabolite KEGG:C20480 Valerena-4,7(11)-diene generic -metabolite KEGG:C20481 cis-Abienol generic -metabolite KEGG:C20482 (6R)-6beta-Hydroxy-1,4,5,6-tetrahydronicotinamide-adenine dinucleotide generic -metabolite KEGG:C20483 (6R)-6beta-Hydroxy-1,4,5,6-tetrahydronicotinamide-adenine dinucleotide phosphate generic -metabolite KEGG:C20484 9-cis-beta-Carotene generic -metabolite KEGG:C20485 (4S)-4-Hydroxy-2-oxoglutarate generic -metabolite KEGG:C20486 7-Epizingiberene generic -metabolite KEGG:C20487 L-beta-Phenylalanine generic -metabolite KEGG:C20488 D-beta-Phenylalanine generic -metabolite KEGG:C20489 Pelargonidin 3-O-beta-D-sambubioside generic -metabolite KEGG:C20490 Cyanidin 3-O-beta-D-sambubioside generic -metabolite KEGG:C20491 Delphinidin 3-O-beta-D-sambubioside generic -metabolite KEGG:C20492 Pelargonidin 5-O-beta-D-glucoside 3-O-beta-D-sambubioside generic -metabolite KEGG:C20493 Cyanidin 5-O-beta-D-glucoside 3-O-beta-D-sambubioside generic -metabolite KEGG:C20494 Delphinidin 5-O-beta-D-glucoside 3-O-beta-D-sambubioside generic -metabolite KEGG:C20495 Pelargonidin 3,7-di-O-beta-D-glucoside generic -metabolite KEGG:C20496 Delphinidin 3,7-di-O-beta-D-glucoside generic -metabolite KEGG:C20497 N-Acetyl-beta-D-mannosaminuronosyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20498 4-Acetamido-4,6-dideoxy-alpha-D-galactosyl-(1->4)-N-acetyl-beta-D-mannosaminuronosyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20499 (1'S)-Averantin generic -metabolite KEGG:C20500 (1'S,5'S)-5'-Hydroxyaverantin generic -metabolite KEGG:C20501 (1'S,5'R)-5'-Hydroxyaverantin generic -metabolite KEGG:C20502 5'-Oxoaverantin generic -metabolite KEGG:C20503 1'-Hydroxyversicolorone generic -metabolite KEGG:C20504 Versicolorone generic -metabolite KEGG:C20505 Versiconal hemiacetal acetate generic -metabolite KEGG:C20506 Versiconol acetate generic -metabolite KEGG:C20507 Versiconal generic -metabolite KEGG:C20508 Versiconol generic -metabolite KEGG:C20509 2'-Dehydrokanamycin A generic -metabolite KEGG:C20510 30-Hydroxy-11-oxo-beta-amyrin generic -metabolite KEGG:C20511 Glycyrrhetaldehyde generic -metabolite KEGG:C20512 Tryprostatin B generic -metabolite KEGG:C20513 6-Hydroxytryprostatin B generic -metabolite KEGG:C20514 Cyclo(L-leucyl-L-leucyl) generic -metabolite KEGG:C20515 Pulcherriminic acid generic -metabolite KEGG:C20516 Cyclo(L-tyrosyl-L-tyrosyl) generic -metabolite KEGG:C20517 Mycocyclosin generic -metabolite KEGG:C20518 2,3-Bis-(O-phytanyl)-sn-glycerol 1-phosphate generic -metabolite KEGG:C20519 Cyclo(L-leucyl-L-phenylalanyl) generic -metabolite KEGG:C20520 Albonoursin generic -metabolite KEGG:C20521 Cyclo[(Z)-alpha,beta-didehydrophenylalanyl-L-leucyl] generic -metabolite KEGG:C20522 Dihydrourocanate generic -metabolite KEGG:C20525 3-Geranylgeranylindole generic -metabolite KEGG:C20526 10,11-Epoxy-3-geranylgeranylindole generic -metabolite KEGG:C20527 Emindole SB generic -metabolite KEGG:C20528 Terpendole B generic -metabolite KEGG:C20529 14,15-Epoxyemindole SB generic -metabolite KEGG:C20530 Paspaline generic -metabolite KEGG:C20531 13-Desoxypaxilline generic -metabolite KEGG:C20532 20,21-Diprenylterpendole I generic -metabolite KEGG:C20533 Lolitrem K generic -metabolite KEGG:C20534 12-Demethyl-11,12-dehydropaspaline generic -metabolite KEGG:C20535 beta-PC-M6 generic -metabolite KEGG:C20536 Terpendole E generic -metabolite KEGG:C20542 13-Desoxyterpendole I generic -metabolite KEGG:C20543 Terpendole I generic -metabolite KEGG:C20545 Terpendole J generic -metabolite KEGG:C20546 Terpendole C generic -metabolite KEGG:C20548 Lolitriol generic -metabolite KEGG:C20549 Lolitrem J generic -metabolite KEGG:C20550 Lolitrem E generic -metabolite KEGG:C20551 Lolitrem B generic -metabolite KEGG:C20552 Terpendole K generic -metabolite KEGG:C20553 Paspalicine generic -metabolite KEGG:C20554 Paspalinine generic -metabolite KEGG:C20555 Aflatrem generic -metabolite KEGG:C20558 alpha-PC-M6 generic -metabolite KEGG:C20559 4-(beta-D-Ribofuranosyl)aniline 5'-phosphate generic -metabolite KEGG:C20560 N1-(3-Aminopropyl)agmatine generic -metabolite KEGG:C20561 21,22-Diprenylpaxilline generic -metabolite KEGG:C20562 N-[(7,8-Dihydropterin-6-yl)methyl]-4-(beta-D-ribofuranosyl)aniline 5'-phosphate generic -metabolite KEGG:C20563 Brevianamide F generic -metabolite KEGG:C20564 Fumitremorgin A generic -metabolite KEGG:C20565 Cyclic di-3',5'-adenylate generic -metabolite KEGG:C20566 7,8-Dihydroneopterin 2'-phosphate generic -metabolite KEGG:C20567 7,8-Dihydroneopterin 2',3'-cyclic phosphate generic -metabolite KEGG:C20568 beta-L-Arabinofuranosyl-(1->2)-beta-L-arabinofuranose generic -metabolite KEGG:C20569 beta-L-Arabinofuranose generic -metabolite KEGG:C20570 alpha-1,5-L-Arabinobiose generic -metabolite KEGG:C20571 alpha-1,5-L-Arabinotriose generic -metabolite KEGG:C20572 alpha-1,5-L-Arabinotetraose generic -metabolite KEGG:C20573 Aldotetraouronic acid generic -metabolite KEGG:C20574 (1'S,5'S)-Averufin generic -metabolite KEGG:C20575 Versicolorin B generic -metabolite KEGG:C20576 Kunzeaol generic -metabolite KEGG:C20577 6-Tuliposide A generic -metabolite KEGG:C20578 Tulipalin A generic -metabolite KEGG:C20579 Cyclopeptine generic -metabolite KEGG:C20580 [tRNA(Ile2)]-2-agmatinylcytidine34 generic -metabolite KEGG:C20581 cis-(Homo)2-aconitate generic -metabolite KEGG:C20582 cis-(Homo)3-aconitate generic -metabolite KEGG:C20583 Versicolorin A generic -metabolite KEGG:C20584 Lolicine A generic -metabolite KEGG:C20585 Lolicine B generic -metabolite KEGG:C20586 Terpendole G generic -metabolite KEGG:C20587 Paspaline B generic -metabolite KEGG:C20588 Tetrabromophenol blue generic -metabolite KEGG:C20589 D-Glucosaminate-6-phosphate generic -metabolite KEGG:C20590 beta-Ergocryptine generic -metabolite KEGG:C20591 Fusaproliferin generic -metabolite KEGG:C20592 Moniliformin generic -metabolite KEGG:C20593 beta-Paxitriol generic -metabolite KEGG:C20594 20,21-Diprenylterpendole J generic -metabolite KEGG:C20595 20,21-Diprenylterpendole C generic -metabolite KEGG:C20596 Penitrem D generic -metabolite KEGG:C20597 Penitrem E generic -metabolite KEGG:C20598 Penitrem F generic -metabolite KEGG:C20599 Pennigritrem generic -metabolite KEGG:C20600 Janthitrem B generic -metabolite KEGG:C20601 Janthitrem C generic -metabolite KEGG:C20602 L-Enduracididine generic -metabolite KEGG:C20603 (3S)-3-Hydroxy-L-enduracididine generic -metabolite KEGG:C20604 Fumitremorgin C generic -metabolite KEGG:C20605 12alpha,13alpha-Dihydroxyfumitremorgin C generic -metabolite KEGG:C20607 Tryprostatin A generic -metabolite KEGG:C20608 (S)-2-Chloropropanoate generic -metabolite KEGG:C20609 2-Chloroacrylate generic -metabolite KEGG:C20612 GDP-4-dehydro-3,6-dideoxy-alpha-D-mannose generic -metabolite KEGG:C20613 GDP-beta-L-colitose generic -metabolite KEGG:C20614 Kanamycin X generic -metabolite KEGG:C20616 Aldono-1,5-lactone generic -metabolite KEGG:C20617 beta-D-Gal-(1->3)-alpha-D-GlcNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20618 beta-D-Gal-(1->4)-alpha-D-GlcNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20619 beta-D-Glc-(1->3)-alpha-D-GlcNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20620 N-Acetyl-alpha-D-galactosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20621 alpha-D-GalNAc-(1->3)-alpha-D-GalNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20622 beta-D-Gal-(1->3)-alpha-D-GalNAc-(1->3)-alpha-D-GalNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20623 Caldariellaquinol generic -metabolite KEGG:C20624 Caldariellaquinone generic -metabolite KEGG:C20625 alpha-L-Fuc-(1->2)-beta-D-Gal-(1->3)-alpha-D-GalNAc-(1->3)-alpha-D-GalNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20626 alpha-D-Gal-(1->3)-(alpha-L-Fuc-(1->2))-beta-D-Gal-(1->3)-alpha-D-GalNAc-(1->3)-alpha-D-GalNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20627 CDP-2,3-bis-(O-phytanyl)-sn-glycerol generic -metabolite KEGG:C20628 2,3-Bis-(O-phytanyl)-sn-glycero-1-phospho-L-serine generic -metabolite KEGG:C20629 8-Demethylnovobiocic acid generic -metabolite KEGG:C20630 Fumitremorgin B generic -metabolite KEGG:C20631 (2S,3S)-3-Hydroxyasparagine generic -metabolite KEGG:C20632 Methyl gibberellin A9 generic -metabolite KEGG:C20633 Methyl gibberellin A4 generic -metabolite KEGG:C20634 O-Methyl anthranilate generic -metabolite KEGG:C20635 Methyl (indol-3-yl)acetate generic -metabolite KEGG:C20636 Deoxybrevianamide E generic -metabolite KEGG:C20637 5-[[(4,7-Dihydroxy-2-oxo-2H-1-benzopyran-3-yl)amino]carbonyl]-4-methyl-1H-pyrrole-3-carboxylate generic -metabolite KEGG:C20638 GDP-4-amino-4,6-dideoxy-alpha-D-mannose generic -metabolite KEGG:C20639 O-Ureido-L-serine generic -metabolite KEGG:C20640 Cyclic GMP-AMP generic -metabolite KEGG:C20641 L-Threonylcarbamoyladenylate generic -metabolite KEGG:C20642 1-Archaetidyl-1D-myo-inositol 3-phosphate generic -metabolite KEGG:C20643 2-Heptyl-4(1H)-quinolone generic -metabolite KEGG:C20644 2-Amino-4,5-dihydroxy-6-oxo-7-(phosphooxy)heptanoate generic -metabolite KEGG:C20645 Methyl benzoate generic -metabolite KEGG:C20646 (3S)-2-Oxo-3-phenylbutanoate generic -metabolite KEGG:C20647 N1-Methyladenine in rRNA generic -metabolite KEGG:C20648 Adenine in rRNA generic -metabolite KEGG:C20649 7-[(3S)-(3-Amino-3-carboxypropyl)]wyosine in tRNA(Phe) generic -metabolite KEGG:C20650 7-(Dihydroxymethyl)bacteriochlorophyllide c generic -metabolite KEGG:C20651 O-Ureido-D-serine generic -metabolite KEGG:C20652 7-[(3S)-3-Amino-3-carboxypropyl]-4-demethylwyosine in tRNA(Phe) generic -metabolite KEGG:C20653 2-Benzylmalic acid generic -metabolite KEGG:C20654 3-Benzylmalic acid generic -metabolite KEGG:C20655 Aldopyranose generic -metabolite KEGG:C20656 (L-Prolyl)adenylate generic -metabolite KEGG:C20657 meso-2,3-Butanediol generic -metabolite KEGG:C20658 O-Acetyl-ADP-ribose generic -metabolite KEGG:C20659 7-[(3S)-3-Amino-3-(methoxycarbonyl)propyl]wyosine in tRNA(Phe) generic -metabolite KEGG:C20660 Wybutosine in tRNA(Phe) generic -metabolite KEGG:C20661 7-(2-Hydroxy-3-amino-3-carboxypropyl)wyosine in tRNA(Phe) generic -metabolite KEGG:C20662 Hydroxywybutosine in tRNA(Phe) generic -metabolite KEGG:C20663 L-Histidine-[translation elongation factor 2] generic -metabolite KEGG:C20664 (-)-Bornyl diphosphate generic -metabolite KEGG:C20666 5-Oxo-delta-bilirubin generic -metabolite KEGG:C20667 15-Oxo-beta-bilirubin generic -metabolite KEGG:C20668 3-Dehydro-D-glucose 6-phosphate generic -metabolite KEGG:C20669 2-Amino-5-chlorophenol generic -metabolite KEGG:C20670 2-Amino-5-chloromuconate 6-semialdehyde generic -metabolite KEGG:C20672 GDP-4-acetamido-4,6-dideoxy-alpha-D-mannose generic -metabolite KEGG:C20673 N-Isovaleryl-L-homoserine lactone generic -metabolite KEGG:C20674 N7-Methylguanosine generic -metabolite KEGG:C20675 Short-chain acyl-CoA generic -metabolite KEGG:C20676 Short-chain trans-2,3-dehydroacyl-CoA generic -metabolite KEGG:C20677 N-(4-Coumaroyl)-L-homoserine lactone generic -metabolite KEGG:C20678 26-Deglucoprotodioscin generic -metabolite KEGG:C20679 Tungstate generic -metabolite KEGG:C20680 2-Dehydro-3-deoxy-L-galactonate generic -metabolite KEGG:C20681 (E,E)-Geranyllinalool generic -metabolite KEGG:C20682 dTDP-alpha-D-fucofuranose generic -metabolite KEGG:C20683 Long-chain acyl-[acyl-carrier protein] generic -metabolite KEGG:C20684 O-Carbamoyladenylate generic -metabolite KEGG:C20685 (R)-(2,4-Dichlorophenoxy)propanoate generic -metabolite KEGG:C20686 (S)-2-(4-Chloro-2-methylphenoxy)propanoate generic -metabolite KEGG:C20687 (S)-(2,4-Dichlorophenoxy)propanoate generic -metabolite KEGG:C20688 N1-Methylguanine in tRNA(Phe) generic -metabolite KEGG:C20689 15-Demethylaclacinomycin T generic -metabolite KEGG:C20690 1D-myo-Inositol 1,5-bis(diphosphate) 2,3,4,6-tetrakisphosphate generic -metabolite KEGG:C20691 4-Demethylwyosine in tRNA(Phe) generic -metabolite KEGG:C20692 9-cis-10'-Apo-beta-carotenal generic -metabolite KEGG:C20693 Carlactone generic -metabolite KEGG:C20694 (2E,4E,6E)-7-Hydroxy-4-methylhepta-2,4,6-trienal generic -metabolite KEGG:C20695 all-trans-10'-Apo-beta-carotenal generic -metabolite KEGG:C20696 13-Apo-beta-carotenone generic -metabolite KEGG:C20697 (2E,4E,6E)-4-Methylocta-2,4,6-trienedial generic -metabolite KEGG:C20698 2-Aminoethyl diphenylborinate generic -metabolite KEGG:C20699 6''-O-Carbamoylkanamycin A generic -metabolite KEGG:C20700 (E,E)-4,8,12-Trimethyltrideca-1,3,7,11-tetraene generic -metabolite KEGG:C20701 But-3-en-2-one generic -metabolite KEGG:C20702 (8E,10S)-10-Hydroperoxyoctadeca-8-enoate generic -metabolite KEGG:C20703 (8E,10S,12Z)-10-Hydroperoxyoctadeca-8,12-dienoate generic -metabolite KEGG:C20704 (8E,10S,12Z,15Z)-10-Hydroperoxyoctadeca-8,12,15-trienoate generic -metabolite KEGG:C20705 4-O-(beta-L-Arabinofuranosyl-(1->2)-beta-L-arabinofuranosyl-(1->2)-beta-L-arabinofuranosyl)-(2S,4S)-4-hydroxyproline generic -metabolite KEGG:C20706 4-O-(beta-L-Arabinofuranosyl)-(2S,4S)-4-hydroxyproline generic -metabolite KEGG:C20707 26-Desgluco-avenacoside B generic -metabolite KEGG:C20708 Robenacoxib generic -metabolite KEGG:C20709 Diosgenin 3-O-beta-D-glucopyranoside generic -metabolite KEGG:C20710 (4R,5R)-4,5-Dihydroxycyclohexa-1(6),2-diene-1-carboxylate generic -metabolite KEGG:C20711 Miltiradiene generic -metabolite KEGG:C20712 (S)-Laudanine generic -metabolite KEGG:C20713 Ginsenoside Rb1 generic -metabolite KEGG:C20714 3-Oxodecanoate generic -metabolite KEGG:C20715 Protopanaxadiol generic -metabolite KEGG:C20716 Protopanaxatriol generic -metabolite KEGG:C20717 4-Hydroxy-2,5-dimethylfuran-3(2H)-one generic -metabolite KEGG:C20718 4-Hydroxy-5-methyl-2-methylenefuran-3(2H)-one generic -metabolite KEGG:C20719 Vancomycin aglycone generic -metabolite KEGG:C20720 Desvancosaminyl-vancomycin generic -metabolite KEGG:C20721 Chloroorienticin B generic -metabolite KEGG:C20722 3-O-(alpha-D-Mannosyl)-L-threonyl-[protein] generic -metabolite KEGG:C20723 3-O-[N-Acetyl-beta-D-glucosaminyl-(1->4)-alpha-D-mannosyl]-L-threonyl-[protein] generic -metabolite KEGG:C20724 (+)-Thujopsene generic -metabolite KEGG:C20725 Ginsenoside Rd generic -metabolite KEGG:C20726 Phenyl 5-phospho-alpha-D-ribofuranoside generic -metabolite KEGG:C20727 Kaempferol 3-O-beta-D-xyloside generic -metabolite KEGG:C20729 [Sulfur-carrier protein]-Gly-NH-CH2-C(O)-S-L-cysteine generic -metabolite KEGG:C20730 [Protein]-FMN-L-Threonine generic -metabolite KEGG:C20731 Penitrem B generic -metabolite KEGG:C20732 Mycothiol S-conjugate generic -metabolite KEGG:C20734 3-O-[N-Acetyl-beta-D-galactosaminyl-(1->3)-N-acetyl-beta-D-glucosaminyl-(1->4)-alpha-D-mannosyl]-L-threonyl-[protein] generic -metabolite KEGG:C20735 N-Acyl-aromatic-L-amino acid generic -metabolite KEGG:C20736 Gypenoside XVII generic -metabolite KEGG:C20737 6-Geranylgeranyl-2-methylbenzene-1,4-diol generic -metabolite KEGG:C20738 6-Geranylgeranyl-2,3-dimethylbenzene-1,4-diol generic -metabolite KEGG:C20739 Neopikromycin generic -metabolite KEGG:C20740 Novapikromycin generic -metabolite KEGG:C20741 Novamethymycin generic -metabolite KEGG:C20742 2'-Phospho-cyclic ADP-ribose generic -metabolite KEGG:C20743 Protein N6-acetyl-L-lysine generic -metabolite KEGG:C20744 alpha-NADH generic -metabolite KEGG:C20745 alpha-NADPH generic -metabolite KEGG:C20746 (3R)-Citramalyl-CoA generic -metabolite KEGG:C20747 (R)-Malyl-CoA generic -metabolite KEGG:C20748 (E)-4-(Trimethylammonio)but-2-enoyl-CoA generic -metabolite KEGG:C20749 4-Trimethylammoniobutanoyl-CoA generic -metabolite KEGG:C20750 L-Carnitinyl-CoA generic -metabolite KEGG:C20751 N6-L-Threonylcarbamoyladenine in tRNA generic -metabolite KEGG:C20752 2-Methylthio-N6-L-threonylcarbamoyladenine in tRNA generic -metabolite KEGG:C20753 2-Methylthio-N6-dimethylallyladenine in tRNA generic -metabolite KEGG:C20754 2-Thio-N6-L-threonylcarbamoyladenine in tRNA generic -metabolite KEGG:C20755 2-Thio-N6-dimethylallyladenine in tRNA generic -metabolite KEGG:C20756 [Ribosomal protein S12]-L-aspartate generic -metabolite KEGG:C20757 [Ribosomal protein S12]-3-thioaspartate generic -metabolite KEGG:C20758 [Ribosomal protein S12]-3-methylthioaspartate generic -metabolite KEGG:C20759 Desulfo-A47934 generic -metabolite KEGG:C20760 20-Oxo-5-O-beta-mycaminosyltylactone generic -metabolite KEGG:C20761 alpha-D-Man-(1->2)-alpha-D-Man-(1->2)-[alpha-D-Man-(1->3)-alpha-D-Man-(1->3)-alpha-D-Man-(1->2)-alpha-D-Man-(1->2)]n-alpha-D-Man-(1->3)-alpha-D-Man-(1->3)-alpha-D-Man-(1->3)-alpha-D-GlcNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20762 3-O-Phospho-alpha-D-Man-(1->2)-alpha-D-Man-(1->2)-[alpha-D-Man-(1->3)-alpha-D-Man-(1->3)-alpha-D-Man-(1->2)-alpha-D-Man-(1->2)]n-alpha-D-Man-(1->3)-alpha-D-Man-(1->3)-alpha-D-Man-(1->3)-alpha-D-GlcNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20763 3-O-Methylphospho-alpha-D-Man-(1->2)-alpha-D-Man-(1->2)-[alpha-D-Man-(1->3)-alpha-D-Man-(1->3)-alpha-D-Man-(1->2)-alpha-D-Man-(1->2)]n-alpha-D-Man-(1->3)-alpha-D-Man-(1->3)-alpha-D-Man-(1->3)-alpha-D-GlcNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C20764 Phytyl phosphate generic -metabolite KEGG:C20765 dTDP-beta-L-evernosamine generic -metabolite KEGG:C20766 dTDP-N-hydroxy-beta-L-evernosamine generic -metabolite KEGG:C20767 dTDP-2,3,6-trideoxy-3-C-methyl-4-O-methyl-3-nitroso-beta-L-arabino-hexopyranose generic -metabolite KEGG:C20768 UDP-2-acetamido-2,6-dideoxy-beta-L-talose generic -metabolite KEGG:C20770 N-Methylpavine generic -metabolite KEGG:C20771 (+/-)-Pavine generic -metabolite KEGG:C20772 3-[(1-Carboxyvinyl)oxy]benzoate generic -metabolite KEGG:C20773 6-Amino-6-deoxyfutalosine generic -metabolite KEGG:C20774 UDP-N-acetyl-beta-L-fucosamine generic -metabolite KEGG:C20775 beta-Citryl-L-glutamate generic -metabolite KEGG:C20776 N-Acetylaspartylglutamylglutamate generic -metabolite KEGG:C20777 Gypenoside LXXV generic -metabolite KEGG:C20778 Ginsenoside Rg3 generic -metabolite KEGG:C20779 Ginsenoside F2 generic -metabolite KEGG:C20780 Ginsenoside F1 generic -metabolite KEGG:C20781 2,4-Diketo-3-deoxy-L-fuconate generic -metabolite KEGG:C20782 (S)-2-Phenyloxirane generic -metabolite KEGG:C20783 Propane generic -metabolite KEGG:C20784 ADP-5-ethyl-4-methylthiazole-2-carboxylate generic -metabolite KEGG:C20785 Eleutheroside A generic -metabolite KEGG:C20786 Eleutheroside E generic -metabolite KEGG:C20787 23,24-Dihydrocucurbitacin B generic -metabolite KEGG:C20788 Homocystine generic -metabolite KEGG:C20789 7-Deoxyloganetate generic -metabolite KEGG:C20790 7-Deoxyloganetin generic -metabolite KEGG:C20791 Methyl thioether generic -metabolite KEGG:C20792 Oleoylethanolamide generic -metabolite KEGG:C20793 3-Hydroxyoctanoate generic -metabolite KEGG:C20794 n-7 Unsaturated acyl-[acyl-carrier protein] generic -metabolite KEGG:C20795 Penitrem C generic -metabolite KEGG:C20796 N6-Dimethyladenine in rRNA generic -metabolite KEGG:C20797 2,3-Dihydroxypropane-1-sulfonate generic -metabolite KEGG:C20798 2-Hydroxy-3-oxopropane-1-sulfonate generic -metabolite KEGG:C20799 Grixazone B generic -metabolite KEGG:C20800 3-Methyl-L-tyrosine generic -metabolite KEGG:C20801 3-Hydroxy-5-methyl-L-tyrosine generic -metabolite KEGG:C20802 (4S)-4-Hydroxy-L-isoleucine generic -metabolite KEGG:C20803 5-Methyl-1-naphthoate generic -metabolite KEGG:C20804 alpha-Longipinene generic -metabolite KEGG:C20805 3-Hydroxy-5-methyl-1-naphthoate generic -metabolite KEGG:C20806 omega-Hydroxyphylloquinone generic -metabolite KEGG:C20807 3-Hydroxy-L-phenylalanine generic -metabolite KEGG:C20808 2-Methyl-1-pyrroline generic -metabolite KEGG:C20809 (R)-2-Methylpyrrolidine generic -metabolite KEGG:C20810 (S)-3-Chloro-beta-tyrosyl-[pcp] generic -metabolite KEGG:C20811 (-)-exo-alpha-Bergamotene generic -metabolite KEGG:C20813 OA-6129 A generic -metabolite KEGG:C20814 OA-6129 C generic -metabolite KEGG:C20815 MM 4550 generic -metabolite KEGG:C20816 Deacetylepithienamycin F generic -metabolite KEGG:C20817 C20817 generic -metabolite KEGG:C20818 C20818 generic -metabolite KEGG:C20819 C20819 generic -metabolite KEGG:C20820 2,3-Dihydrothienamycin generic -metabolite KEGG:C20821 C20821 generic -metabolite KEGG:C20822 C20822 generic -metabolite KEGG:C20823 C20823 generic -metabolite KEGG:C20824 3-Nitrobenzanthrone generic -metabolite KEGG:C20825 Seminolipid generic -metabolite KEGG:C20826 Isovalerylcarnitine generic -metabolite KEGG:C20827 3-Hydroxyisovalerate generic -metabolite KEGG:C20828 3-Methylcrotonylglycine generic -metabolite KEGG:C20829 Sulfoquinovose generic -metabolite KEGG:C20830 6-Deoxy-6-sulfo-D-fructose generic -metabolite KEGG:C20831 6-Deoxy-6-sulfo-D-fructose 1-phosphate generic -metabolite KEGG:C20832 Hydroperoxyicosatetraenoate generic -metabolite KEGG:C20833 Oxoicosatetraenoate generic -metabolite KEGG:C20834 Cyclooctat-9-en-7-ol generic -metabolite KEGG:C20835 alpha-L-Fucopyranose generic -metabolite KEGG:C20836 beta-L-Fucopyranose generic -metabolite KEGG:C20837 Hydroxyepoxyicosatrienoate generic -metabolite KEGG:C20838 3-[(3aS,4S,7aS)-7a-Methyl-1,5-dioxo-octahydro-1H-inden-4-yl]propanoyl-CoA generic -metabolite KEGG:C20839 (25R)-3-Oxocholest-4-en-26-oate generic -metabolite KEGG:C20840 (25S)-3-Oxocholest-4-en-26-oyl-CoA generic -metabolite KEGG:C20841 2-Hydroxy-7-methoxy-5-methyl-1-naphthoate generic -metabolite KEGG:C20842 2-Hydroxy-7-methoxy-5-methyl-1-naphthoyl-CoA generic -metabolite KEGG:C20843 N5-Phenyl-L-glutamine generic -metabolite KEGG:C20844 (2Z,4S,5R)-2-Amino-4,5,6-trihydroxyhex-2-enoate generic -metabolite KEGG:C20845 (4S,5R)-4,5,6-Trihydroxy-2-iminohexanoate generic -metabolite KEGG:C20846 3-Oxo-3-ureidoisobutyrate generic -metabolite KEGG:C20847 (R)-Mevalonate 3-phosphate generic -metabolite KEGG:C20848 (R)-Mevalonate 3,5-bisphosphate generic -metabolite KEGG:C20849 UDP-2-acetamido-3-dehydro-2-deoxy-alpha-D-glucopyranose generic -metabolite KEGG:C20850 N5-Hydroxy-L-ornithine generic -metabolite KEGG:C20851 Dihydromonacolin L acid generic -metabolite KEGG:C20852 3alpha-Hydroxy-3,5-dihydromonacolin L acid generic -metabolite KEGG:C20853 Monacolin L acid generic -metabolite KEGG:C20854 Monacolin J acid generic -metabolite KEGG:C20855 22-Hydroxydocosahexaenoate generic -metabolite KEGG:C20856 2-Hydroxy-5-methyl-1-naphthoate generic -metabolite KEGG:C20857 2,7-Dihydroxy-5-methyl-1-naphthoate generic -metabolite KEGG:C20858 Protein N5-methyl-L-glutamine generic -metabolite KEGG:C20859 Galactosyl-1-alkyl-2-acylglycerol generic -metabolite KEGG:C20860 Triglucosyldiacylglycerol generic -metabolite KEGG:C20861 Mannobiose generic -metabolite KEGG:C20862 5'-(N7-Methyl 5'-triphosphoguanosine)-(2'-O-methyl-purine-ribonucleotide)-(2'-O-methyl-ribonucleotide)-[mRNA] generic -metabolite KEGG:C20863 5'-Phospho-[mRNA] generic -metabolite KEGG:C20864 5'-Triphospho-[mRNA] generic -metabolite KEGG:C20865 3beta,12alpha-Dihydroxy-5beta-cholanoate generic -metabolite KEGG:C20866 Alloavicholate generic -metabolite KEGG:C20867 Avideoxycholate generic -metabolite KEGG:C20868 Cygnocholate generic -metabolite KEGG:C20869 UDPMurNAc(oyl-L-Ala-gamma-D-Glu-L-Lys-D-Ala-D-Lac) generic -metabolite KEGG:C20870 3-(Methylthio)propanoyl-CoA generic -metabolite KEGG:C20871 3'-Hydroxyflavone generic -metabolite KEGG:C20872 3'-Methoxyflavone generic -metabolite KEGG:C20873 UDPMurNAc(oyl-L-Ala-gamma-D-Glu-L-Lys-D-Ala-D-Ser) generic -metabolite KEGG:C20874 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-gamma-D-glutamyl-L-lysyl-D-alanyl-D-serine generic -metabolite KEGG:C20875 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-gamma-D-glutamyl-L-lysyl-D-alanyl-D-lactate generic -metabolite KEGG:C20876 Very-long-chain acyl-CoA generic -metabolite KEGG:C20877 Very-long-chain 3-oxoacyl-CoA generic -metabolite KEGG:C20878 Very-long-chain (3R)-3-hydroxyacyl-CoA generic -metabolite KEGG:C20879 Very-long-chain trans-2,3-dehydroacyl-CoA generic -metabolite KEGG:C20880 UDP-N-acetylmuramoyl-L-alanyl-D-glutamyl-LL-2,6-diaminopimeloyl-D-alanyl-D-lactate generic -metabolite KEGG:C20881 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-D-glutamyl-LL-2,6-diaminopimeloyl-D-alanyl-D-Lactate generic -metabolite KEGG:C20882 Undecaprenyl-diphospho-N-acetylmuramoyl-(N-acetylglucosamine)-L-alanyl-D-glutamyl-LL-2,6-diaminopimeloyl-(glycyl)-D-alanyl-D-lactate generic -metabolite KEGG:C20886 UDP-N-acetylmuramoyl-L-alanyl-gamma-D-glutamyl-LL-2,6-diaminopimelate generic -metabolite KEGG:C20887 beta-D-Mannosyl-1,4-N-acetyl-D-glucosamine generic -metabolite KEGG:C20888 Cellobionate generic -metabolite KEGG:C20889 D-Galactaro-1,5-lactone generic -metabolite KEGG:C20890 D-Glucaro-1,5-lactone generic -metabolite KEGG:C20891 Isoxazolin-5-one generic -metabolite KEGG:C20892 3-(5-Oxoisoxazolin-2-yl)-L-alanine generic -metabolite KEGG:C20893 3-(5-Oxoisoxazolin-4-yl)-L-alanine generic -metabolite KEGG:C20894 beta-Citraurin generic -metabolite KEGG:C20895 (2S,3S)-3-Methylphenylalanine generic -metabolite KEGG:C20896 D-Galactaro-1,4-lactone generic -metabolite KEGG:C20897 Glycerophosphoglycoglycerolipid generic -metabolite KEGG:C20898 Lipoteichoic acid generic -metabolite KEGG:C20899 Furan-2,5-dicarbaldehyde generic -metabolite KEGG:C20900 5-(Dihydroxymethyl)furan-2-carbaldehyde generic -metabolite KEGG:C20901 5-(Dihydroxymethyl)furan-2-carboxylate generic -metabolite KEGG:C20902 3,6-Anhydro-alpha-L-galactopyranose generic -metabolite KEGG:C20903 3,6-Anhydro-L-galactonate generic -metabolite KEGG:C20904 2-Iminopropanoate generic -metabolite KEGG:C20905 2-Iminobutanoate generic -metabolite KEGG:C20906 Galactosylglucosyldiacylglycerol generic -metabolite KEGG:C20907 Chondroitin 4,6-sulfate generic -metabolite KEGG:C20908 Dermatan 4-sulfate generic -metabolite KEGG:C20909 Dermatan 4,6-sulfate generic -metabolite KEGG:C20910 L-4-Hydroxyphenylglycyl-L-arginine generic -metabolite KEGG:C20911 C20911 generic -metabolite KEGG:C20912 C20912 generic -metabolite KEGG:C20913 C20913 generic -metabolite KEGG:C20914 C20914 generic -metabolite KEGG:C20915 C20915 generic -metabolite KEGG:C20916 C20916 generic -metabolite KEGG:C20917 Tabtoxin generic -metabolite KEGG:C20918 Tabtoxinine-beta-lactam generic -metabolite KEGG:C20919 Isotabtoxin generic -metabolite KEGG:C20920 Tabtoxinine-delta-lactam generic -metabolite KEGG:C20921 N1-Acetyl-tabtoxinine-beta-lactam generic -metabolite KEGG:C20922 Cembrene C generic -metabolite KEGG:C20923 (R)-Nephthenol generic -metabolite KEGG:C20924 (1S,4E,8E,12E)-2,2,5,9,13-Pentamethylcyclopentadeca-4,8,12-trien-1-ol generic -metabolite KEGG:C20925 L-Alanyl-gamma-D-glutamyl-meso-2,6-diaminoheptanedioate generic -metabolite KEGG:C20926 gamma-Glutamyltyramine generic -metabolite KEGG:C20927 Sulfazecin generic -metabolite KEGG:C20928 MM 42842 generic -metabolite KEGG:C20929 3alpha-Hydroxy-3-aminoacylmonobactamic acid generic -metabolite KEGG:C20930 C18G peptide generic -metabolite KEGG:C20931 4-Amino-4-deoxy-L-arabinose generic -metabolite KEGG:C20933 (9Z)-Hexadec-9-enoyl-KDO2-lipid IV(A) generic -metabolite KEGG:C20934 3-Deoxy-D-glycero-D-galacto-non-2-ulosonic acid generic -metabolite KEGG:C20935 2-5A generic -metabolite KEGG:C20936 pppA2'p5'A2'p5'A generic -metabolite KEGG:C20937 Nitroxyl generic -metabolite KEGG:C20938 2,2'-Disulfonyl azobenzene generic -metabolite KEGG:C20939 3-[(4-Amino-6-chloro-1,3,5-triazin-2-yl)amino]benzenesulfonate generic -metabolite KEGG:C20940 L-Dihydroanticapsin generic -metabolite KEGG:C20941 L-Anticapsin generic -metabolite KEGG:C20942 Bacilysin generic -metabolite KEGG:C20943 (R)-Ipsdienol generic -metabolite KEGG:C20944 Ipsdienone generic -metabolite KEGG:C20945 Erythrodiol generic -metabolite KEGG:C20946 Oleanolic aldehyde generic -metabolite KEGG:C20947 (Z)-Icos-5-enoyl-CoA generic -metabolite KEGG:C20948 LysW-L-glutamate generic -metabolite KEGG:C20949 LysW-L-glutamyl 5-phosphate generic -metabolite KEGG:C20950 LysW-L-glutamate 5-semialdehyde generic -metabolite KEGG:C20951 LysW-L-ornithine generic -metabolite KEGG:C20953 3-[(4R)-4-Hydroxycyclohexa-1,5-dien-1-yl]-2-oxopropanoate generic -metabolite KEGG:C20954 (5-Formylfuran-3-yl)methyl phosphate generic -metabolite KEGG:C20955 3-(Methylthio)acryloyl-CoA generic -metabolite KEGG:C20956 alpha-D-Sedoheptulopyranose 7-phosphate generic -metabolite KEGG:C20957 L-Alanyl-D-glutamate generic -metabolite KEGG:C20958 L-Alanyl-L-glutamate generic -metabolite KEGG:C20959 (4S)-4-Hydroxy-5-phosphooxypentane-2,3-dione generic -metabolite KEGG:C20960 3-Hydroxy-5-phosphooxypentane-2,4-dione generic -metabolite KEGG:C20961 N3-Fumaroyl-L-2,3-diaminopropanoate generic -metabolite KEGG:C20962 Dapdiamide A generic -metabolite KEGG:C20963 Dapdiamide B generic -metabolite KEGG:C20964 Dapdiamide C generic -metabolite KEGG:C20965 N(beta)-Epoxysuccinamoyl-DAP-Val generic -metabolite KEGG:C20966 3-{[(2E)-4-Amino-4-oxobut-2-enoyl]amino}-L-alanine generic -metabolite KEGG:C20967 N(beta)-Epoxysuccinamoyl-DAP generic -metabolite KEGG:C20968 3-Hydroxy-3-(methylthio)propanoyl-CoA generic -metabolite KEGG:C20969 Carboxyphosphate generic -metabolite KEGG:C20970 Angiotensin A generic -metabolite KEGG:C20971 Alamandine generic -metabolite KEGG:C20972 Angiotensin (5-8) generic -metabolite KEGG:C20973 Angiotensin (5-7) generic -metabolite KEGG:C20974 8-Demethyl-8-alpha-L-rhamnosyltetracenomycin C generic -metabolite KEGG:C20975 8-Demethyl-8-(2-O-methyl-alpha-L-rhamnosyl)tetracenomycin C generic -metabolite KEGG:C20976 8-Demethyl-8-(2,3-di-O-methyl-alpha-L-rhamnosyl)tetracenomycin C generic -metabolite KEGG:C20977 8-Demethyl-8-(2,3,4-tri-O-methyl-alpha-L-rhamnosyl)tetracenomycin C generic -metabolite KEGG:C20978 Glucoselysine generic -metabolite KEGG:C20979 Glucoselysine-6-phosphate generic -metabolite KEGG:C20980 3-Methoxy-5-methyl-1-naphthoate generic -metabolite KEGG:C20981 5,10-Dihydrophenazine-1-carboxylate generic -metabolite KEGG:C20982 9-(Dimethylallyl)-5,10-dihydrophenazine-1-carboxylate generic -metabolite KEGG:C20983 4-O-Dimethylallyl-L-tyrosine generic -metabolite KEGG:C20984 3-Linalylflaviolin generic -metabolite KEGG:C20985 2-Sulfotrehalose generic -metabolite KEGG:C20986 D-Ribose 2,5-bisphosphate generic -metabolite KEGG:C20987 3-Sulfinopropanoyl-CoA generic -metabolite KEGG:C20988 [N-(6-Aminohexanoyl)]n generic -metabolite KEGG:C20990 6-Aminohexanoate cyclic oligomer generic -metabolite KEGG:C20991 1,2-Diacyl-3-O-[beta-D-galactosyl-(1->6)-beta-D-galactosyl]-sn-glycerol generic -metabolite KEGG:C20992 Juvenile hormone I acid generic -metabolite KEGG:C20993 S-(L-Histidin-5-yl)-L-cysteine S-oxide generic -metabolite KEGG:C20994 S-(Hercyn-2-yl)-L-cysteine S-oxide generic -metabolite KEGG:C20995 gamma-L-Glutamyl-S-(hercyn-2-yl)-L-cysteine S-oxide generic -metabolite KEGG:C20996 (14E)-Hexadec-14-enoyl-CoA generic -metabolite KEGG:C20997 (14Z)-Hexadec-14-enoyl-CoA generic -metabolite KEGG:C20998 (11Z)-Hexadec-11-enoyl-CoA generic -metabolite KEGG:C20999 (10E,12Z)-Hexadeca-10,12-dienoyl-CoA generic -metabolite KEGG:C21000 (9Z,12Z)-Hexadeca-9,12-dienoyl-CoA generic -metabolite KEGG:C21001 2-O,3-Dimethylflaviolin generic -metabolite KEGG:C21002 6-Linalyl-2-O,3-dimethylflaviolin generic -metabolite KEGG:C21003 7-O-Geranyl-2-O,3-dimethylflaviolin generic -metabolite KEGG:C21004 Norspermine generic -metabolite KEGG:C21005 18-Hydroxyoleoyl-CoA generic -metabolite KEGG:C21006 18-Hydroxylinoleoyl-CoA generic -metabolite KEGG:C21007 5,6,7,8-Tetrahydromonapterin generic -metabolite KEGG:C21008 7,8-Dihydromonapterin generic -metabolite KEGG:C21009 N4-Aminopropylspermidine generic -metabolite KEGG:C21010 N4-Bis(aminopropyl)spermidine generic -metabolite KEGG:C21011 [Protein]-N(epsilon)-(carboxymethyl)lysine generic -metabolite KEGG:C21012 [Protein]-N(epsilon)-(carboxyethyl)lysine generic -metabolite KEGG:C21013 [Protein]-pyrraline generic -metabolite KEGG:C21014 [Protein]-pentosidine generic -metabolite KEGG:C21015 gamma-L-Glutamyl-L-2-aminobutyrate generic -metabolite KEGG:C21016 Ophthalmate generic -metabolite KEGG:C21017 2-(alpha-Hydroxypropyl)thiamine diphosphate generic -metabolite KEGG:C21018 Enzyme N6-(S-propyldihydrolipoyl)lysine generic -metabolite KEGG:C21019 1-Acyl-2-[(12R)-12-hydroxyoleoyl]-sn-glycero-3-phosphocholine generic -metabolite KEGG:C21020 (2'R)-2'-Hydroxyphytoceramide generic -metabolite KEGG:C21021 (2'R)-2'-Hydroxydihydroceramide generic -metabolite KEGG:C21022 (4E,8E)-Sphinga-4,8-dienine ceramide generic -metabolite KEGG:C21023 (4E,8E,10E)-Sphinga-4,8,10-trienine ceramide generic -metabolite KEGG:C21024 (4R,8E)-4-Hydroxysphing-8-enine ceramide generic -metabolite KEGG:C21025 (4R,8Z)-4-Hydroxysphing-8-enine ceramide generic -metabolite KEGG:C21026 Iminoarginine generic -metabolite KEGG:C21027 N-Acetylmuramic acid alpha-1-phosphate generic -metabolite KEGG:C21028 (R)-5,6-Dihydrothymine generic -metabolite KEGG:C21029 (R)-3-Ureidoisobutyrate generic -metabolite KEGG:C21030 (R)-Methylmalonate semialdehyde generic -metabolite KEGG:C21031 DNA 5-hydroxymethylcytosine generic -metabolite KEGG:C21032 L-Altrose generic -metabolite KEGG:C21033 6-Deoxy-L-altrose generic -metabolite KEGG:C21034 L-Altruronic acid generic -metabolite KEGG:C21035 L-Altrosamine generic -metabolite KEGG:C21036 N-Acetyl-L-altrosamine generic -metabolite KEGG:C21037 D-Alluronic acid generic -metabolite KEGG:C21038 D-Allosamine generic -metabolite KEGG:C21039 N-Acetyl-D-allosamine generic -metabolite KEGG:C21040 Apiose generic -metabolite KEGG:C21041 Bacillosamine generic -metabolite KEGG:C21042 D-glycero-D-manno-Heptose generic -metabolite KEGG:C21043 L-glycero-D-manno-Heptose generic -metabolite KEGG:C21044 3-Deoxy-lyxo-heptulosaric acid generic -metabolite KEGG:C21045 D-Digitoxose generic -metabolite KEGG:C21046 N-Acetyl-L-fucosamine generic -metabolite KEGG:C21047 D-Guluronic acid generic -metabolite KEGG:C21048 D-Gulosamine generic -metabolite KEGG:C21049 N-Acetyl-D-gulosamine generic -metabolite KEGG:C21050 L-Idose generic -metabolite KEGG:C21051 L-Idosamine generic -metabolite KEGG:C21052 N-Acetyl-L-idosamine generic -metabolite KEGG:C21053 N-Glycolylmuramic acid generic -metabolite KEGG:C21054 Olivose generic -metabolite KEGG:C21055 Paratose generic -metabolite KEGG:C21056 N-Acetyl-L-rhamnosamine generic -metabolite KEGG:C21057 D-Ribose generic -metabolite KEGG:C21058 6-Deoxy-D-talose generic -metabolite KEGG:C21059 D-Taluronic acid generic -metabolite KEGG:C21060 D-Talosamine generic -metabolite KEGG:C21061 N-Acetyl-D-talosamine generic -metabolite KEGG:C21062 Tyvelose generic -metabolite KEGG:C21063 Ketodeoxyoctonic acid generic -metabolite KEGG:C21064 6-Deoxy-6-sulfo-D-glucono-1,5-lactone generic -metabolite KEGG:C21065 7,8-Dihydroxanthopterin generic -metabolite KEGG:C21066 D-Galactofuranose generic -metabolite KEGG:C21067 D-Arabinofuranose generic -metabolite KEGG:C21068 [5-(Aminomethyl)furan-3-yl]methyl phosphate generic -metabolite KEGG:C21069 [5-(Aminomethyl)furan-3-yl]methyl diphosphate generic -metabolite KEGG:C21070 (4-{4-[2-(gamma-L-Glutamylamino)ethyl]phenoxymethyl}furan-2-yl)methanamine generic -metabolite KEGG:C21071 dTDP-3-O-methyl-4-oxo-2,6-dideoxy-L-mannose generic -metabolite KEGG:C21072 Palmitoleoyl-CoA generic -metabolite KEGG:C21073 dTDP-3-N,N-dimethylamino-2,3,6-trideoxy-4-keto-D-glucose generic -metabolite KEGG:C21074 dTDP-3-N,N-dimethylamino-4-oxo-2,3,6-trideoxy-L-allose generic -metabolite KEGG:C21075 5-(N-Methyl-4,5-dihydro-1H-pyrrol-2-yl)pyridin-2-ol generic -metabolite KEGG:C21076 Delta4-Dafachronic acid generic -metabolite KEGG:C21077 Delta7-Dafachronic acid generic -metabolite KEGG:C21078 2,6-Dimethyldeca-2,4,6,8-tetraenedial generic -metabolite KEGG:C21079 5'-Dehydrouridine generic -metabolite KEGG:C21080 7-Hydroxydodecanoate generic -metabolite KEGG:C21081 Gentisyl-CoA generic -metabolite KEGG:C21082 (5Z,11Z,14Z)-Icosa-5,11,14-trienoyl-CoA generic -metabolite KEGG:C21083 (5Z,11Z,14Z,17Z)-Icosa-5,11,14,17-tetraenoyl-CoA generic -metabolite KEGG:C21084 Demethylphylloquinol generic -metabolite KEGG:C21085 3-[(1E,4R)-4-Hydroxycyclohex-2-en-1-ylidene]-2-oxopropanoate generic -metabolite KEGG:C21086 (3E)-3-[(1R,5R,6S)-5-Hydroxy-7-oxabicyclo[4.1.0]heptan-2-ylidene]-2-oxopropanoate generic -metabolite KEGG:C21087 3-[(1R,2S,5R,6S)-5-Hydroxy-7-oxabicyclo[4.1.0]heptan-2-yl]-2-oxopropanoate generic -metabolite KEGG:C21088 L-Altarate generic -metabolite KEGG:C21089 (R)-2-Hydroxyisocaproyl-CoA generic -metabolite KEGG:C21090 Isocaprenoyl-CoA generic -metabolite KEGG:C21091 (2S,3R)-2,3-Dihydroxy-5-oxohexanedioate generic -metabolite KEGG:C21092 D-allo-Isoleucine generic -metabolite KEGG:C21093 Terpentecin generic -metabolite KEGG:C21094 7,8-Dihydromonapterin 3'-triphosphate generic -metabolite KEGG:C21095 D-Glucaro-1,4-lactone generic -metabolite KEGG:C21096 L-allo-Isoleucine generic -metabolite KEGG:C21097 Peptidyl-carrier protein generic -metabolite KEGG:C21098 L-allo-Isoleucyl-[peptidyl-carrier protein] generic -metabolite KEGG:C21099 L-Arginyl-L-amino acid generic -metabolite KEGG:C21100 Caldopentamine generic -metabolite KEGG:C21101 Protein N(omega)-phospho-L-arginine generic -metabolite KEGG:C21102 5'-Deoxyinosine generic -metabolite KEGG:C21103 2,6-Dichloro-p-benzoquinone generic -metabolite KEGG:C21104 2,5-Dichloro-p-benzoquinone generic -metabolite KEGG:C21105 5-Chloro-2-hydroxy-p-benzoquinone generic -metabolite KEGG:C21106 24-epi-Campesterol generic -metabolite KEGG:C21107 4-(beta-D-Ribofuranosyl)phenol 5'-phosphate generic -metabolite KEGG:C21108 Dihydromonacolin L-[acyl-carrier protein] generic -metabolite KEGG:C21109 Aminopyrrolnitrin generic -metabolite KEGG:C21110 Monodechloroaminopyrrolnitrin generic -metabolite KEGG:C21111 Pyrithiamine generic -metabolite KEGG:C21112 Oxypyrithiamine generic -metabolite KEGG:C21113 NMNH generic -metabolite KEGG:C21114 (4Z)-Hexadec-4-enoyl-[acyl-carrier protein] generic -metabolite KEGG:C21115 (6Z)-Hexadec-6-enoyl-[acyl-carrier protein] generic -metabolite KEGG:C21116 Hydroxysqualene generic -metabolite KEGG:C21117 Adenosylhopane generic -metabolite KEGG:C21118 Ribosylhopane generic -metabolite KEGG:C21119 Bacteriohopanetetrol generic -metabolite KEGG:C21120 Bacteriohopanetetrol-acetylglucosamine generic -metabolite KEGG:C21121 Bacteriohopanetetrol-glucosamine generic -metabolite KEGG:C21122 Bacteriohopanetetrol cyclitol ether generic -metabolite KEGG:C21123 Aminobacteriohopanetriol generic -metabolite KEGG:C21124 IPA imine generic -metabolite KEGG:C21125 Chromopyrrolate generic -metabolite KEGG:C21126 K-252c generic -metabolite KEGG:C21127 Holyrine A generic -metabolite KEGG:C21128 O-Demethyl-N-demethyl-staurosporine generic -metabolite KEGG:C21129 (S)-2-Methylbutanoyl-[acp] generic -metabolite KEGG:C21130 Lovastatin acid generic -metabolite KEGG:C21131 Protodeoxyviolaceinic acid generic -metabolite KEGG:C21132 Deoxyviolaceinic acid generic -metabolite KEGG:C21133 Deoxyviolacein generic -metabolite KEGG:C21134 Protoviolaceinic acid generic -metabolite KEGG:C21135 Violaceinic acid generic -metabolite KEGG:C21136 Violacein generic -metabolite KEGG:C21137 dTDP-3-amino-4-oxo-2,3,6-trideoxy-L-allose generic -metabolite KEGG:C21138 trans-2-Octenal generic -metabolite KEGG:C21139 (S)-3-Acetyloctanal generic -metabolite KEGG:C21140 Aurachin B generic -metabolite KEGG:C21141 4-Hydroxy-2-methyl-3-oxo-4-[(2E,6E)-farnesyl]-3,4-dihydroquinoline 1-oxide generic -metabolite KEGG:C21142 3,4-Dihydroxy-2-methy-4-[(2E,6E)-farnesyl]-3,4-dihydroquinoline 1-oxide generic -metabolite KEGG:C21143 2'-N-Hydroxyrifampicin generic -metabolite KEGG:C21144 1,3,7-Trimethyl-5-hydroxyisourate generic -metabolite KEGG:C21145 Protoasukamycin generic -metabolite KEGG:C21146 4-Hydroxyprotoasukamycin generic -metabolite KEGG:C21147 Asperlicin C generic -metabolite KEGG:C21148 Asperlicin E generic -metabolite KEGG:C21149 Dibenzothiophene-5-oxide generic -metabolite KEGG:C21150 Dibenzothiophene-5,5-dioxide generic -metabolite KEGG:C21151 Peptide diphthine methyl ester generic -metabolite KEGG:C21152 N,N'-Diacetylchitobiose 6'-phosphate generic -metabolite KEGG:C21153 Adenosylcobalamin 5'-phosphate generic -metabolite KEGG:C21154 N-Methylmyosmine generic -metabolite KEGG:C21155 Isatinate generic -metabolite KEGG:C21156 Acarbose 7IV-phosphate generic -metabolite KEGG:C21157 KDO2-lipid A 1-diphosphate generic -metabolite KEGG:C21158 Nucleoside 3',5'-bisphosphate generic -metabolite KEGG:C21159 2,4-Dinitroanisole generic -metabolite KEGG:C21160 L-Alanyl-gamma-D-glutamyl-L-lysine generic -metabolite KEGG:C21161 Mitomycin A generic -metabolite KEGG:C21162 Mitomycin B generic -metabolite KEGG:C21163 7-Demethylmitomycin A generic -metabolite KEGG:C21164 7-Demethylmitomycin B generic -metabolite KEGG:C21165 9-Methyl-(4E,8E)-sphinga-4,8-dienine ceramide generic -metabolite KEGG:C21166 4-Hydroxy-3-methylbenzaldehyde generic -metabolite KEGG:C21167 4-Hydroxy-3-methylbenzoate generic -metabolite KEGG:C21168 4-Hydroxyisophthalate generic -metabolite KEGG:C21169 N1,N8-Bis(4-coumaroyl)spermidine generic -metabolite KEGG:C21170 N1,N8-Bis(sinapoyl)spermidine generic -metabolite KEGG:C21171 [Wnt]-O-(9Z)-hexadec-9-enoyl-L-serine generic -metabolite KEGG:C21172 [Wnt]-L-serine generic -metabolite KEGG:C21173 PEtN-KDO2-lipid A generic -metabolite KEGG:C21174 PEtN-KDO2-lipid IV(A) generic -metabolite KEGG:C21175 Dihydrocaffeoyl-CoA generic -metabolite KEGG:C21176 3''-Oxoribostamycin generic -metabolite KEGG:C21177 Prokaryotic ubiquitin-like protein generic -metabolite KEGG:C21178 Pupylated protein generic -metabolite KEGG:C21179 [Prokaryotic ubiquitin-like protein]-L-glutamine generic -metabolite KEGG:C21180 2-Dehydro-3,6-dideoxy-6-sulfo-D-gluconate generic -metabolite KEGG:C21181 (2S)-3-Sulfolactaldehyde generic -metabolite KEGG:C21182 6-Deoxy-6-sulfo-D-gluconate generic -metabolite KEGG:C21183 Bursehernin generic -metabolite KEGG:C21184 (-)-5'-Demethylyatein generic -metabolite KEGG:C21185 4'-Demethylepipodophyllotoxin generic -metabolite KEGG:C21186 6-Tuliposide B generic -metabolite KEGG:C21187 Tulipalin B generic -metabolite KEGG:C21188 Protein N(omega),N(omega)-dimethyl-L-arginine generic -metabolite KEGG:C21189 Protein N(omega),N(omega)'-dimethyl-L-arginine generic -metabolite KEGG:C21190 Protein N5-methyl-L-arginine generic -metabolite KEGG:C21191 Pluviatolide generic -metabolite KEGG:C21192 Epoxypheophorbide a generic -metabolite KEGG:C21193 Hexa-acyl lipid A in lipopolysaccharide generic -metabolite KEGG:C21194 Hepta-acyl lipid A in lipopolysaccharide generic -metabolite KEGG:C21195 N-(3-Hydroxybutanoyl)-L-homoserine lactone generic -metabolite KEGG:C21197 N-Hexanoyl-L-homoserine lactone generic -metabolite KEGG:C21198 N-(3-Oxohexanoyl)-L-homoserine lactone generic -metabolite KEGG:C21199 N-Octanoyl-L-homoserine lactone generic -metabolite KEGG:C21200 N-3-Hydroxyoctanoyl-L-homoserine lactone generic -metabolite KEGG:C21201 N-3-Oxo-dodecanoyl-L-homoserine lactone generic -metabolite KEGG:C21202 cis-2-Dodecenoic acid generic -metabolite KEGG:C21203 Geranyl phosphate generic -metabolite KEGG:C21204 5-epi-Valiolol 7-phosphate generic -metabolite KEGG:C21205 1-epi-Valienol 7-phosphate generic -metabolite KEGG:C21206 1,7-Diphospho-1-epi-valienol generic -metabolite KEGG:C21207 NDP-1-epi-valienol 7-phosphate generic -metabolite KEGG:C21208 dTDP-acarviose-7-phosphate generic -metabolite KEGG:C21209 1-epi-Valienol 1-phosphate generic -metabolite KEGG:C21210 NDP-1-epi-valienol generic -metabolite KEGG:C21211 Salbostatin 6'-phosphate generic -metabolite KEGG:C21212 Archaeal dolichyl phosphate generic -metabolite KEGG:C21213 Archaeal dolichyl 3-O-(2,3-diacetamido-2,3-dideoxy-beta-D-glucuronsyl)-N-acetyl-alpha-D-glucosaminyl phosphate generic -metabolite KEGG:C21214 Dimethylallyl phosphate generic -metabolite KEGG:C21215 Prenylated FMNH2 generic -metabolite KEGG:C21216 Validamine 7-phosphate generic -metabolite KEGG:C21217 Geranylgeranyl bacteriochlorophyllide a generic -metabolite KEGG:C21218 Validone 7-phosphate generic -metabolite KEGG:C21219 Validoxylamine A 7'-phosphate generic -metabolite KEGG:C21220 AIP-1 generic -metabolite KEGG:C21221 CSP generic -metabolite KEGG:C21222 CSP generic -metabolite KEGG:C21223 Blp generic -metabolite KEGG:C21224 SHP2 generic -metabolite KEGG:C21225 SHP3 generic -metabolite KEGG:C21226 cCF10 generic -metabolite KEGG:C21227 iCF10 generic -metabolite KEGG:C21228 cAD1 generic -metabolite KEGG:C21229 iAD1 generic -metabolite KEGG:C21230 ComX pheromone generic -metabolite KEGG:C21231 PhrA pentapeptide generic -metabolite KEGG:C21232 PhrC pentapeptide generic -metabolite KEGG:C21233 PhrE pentapeptide generic -metabolite KEGG:C21234 PhrF pentapeptide generic -metabolite KEGG:C21235 PhrG pentapeptide generic -metabolite KEGG:C21236 PhrH pentapeptide generic -metabolite KEGG:C21237 PhrK pentapeptide generic -metabolite KEGG:C21238 NprX peptide generic -metabolite KEGG:C21239 PapR peptide generic -metabolite KEGG:C21240 Gentamicin C 2''-phosphate generic -metabolite KEGG:C21241 AIP-2 generic -metabolite KEGG:C21242 AIP-3 generic -metabolite KEGG:C21243 AIP-4 generic -metabolite KEGG:C21244 AgrD peptide generic -metabolite KEGG:C21245 AgrD1 peptide generic -metabolite KEGG:C21246 GBAP generic -metabolite KEGG:C21247 2-Amino-5-epi-valiolone generic -metabolite KEGG:C21248 2-Aminovalienone generic -metabolite KEGG:C21249 Cetoniacytone B generic -metabolite KEGG:C21250 2-Methyl-trans-aconitate generic -metabolite KEGG:C21251 6'-Oxokanamycin X generic -metabolite KEGG:C21252 6'-Oxokanamycin C generic -metabolite KEGG:C21253 Kanamycin D generic -metabolite KEGG:C21254 3''-Deamino-3''-hydroxykanamycin B generic -metabolite KEGG:C21255 Lividamine generic -metabolite KEGG:C21256 6'-Oxolividamine generic -metabolite KEGG:C21257 4'-Oxolividamine generic -metabolite KEGG:C21258 4'-Oxonebramine generic -metabolite KEGG:C21259 Nebramine generic -metabolite KEGG:C21260 5''-Phosphoribosylparomamine generic -metabolite KEGG:C21261 2'''-N-Acetyl-6'''-deamino-6'''-hydroxyparomomycin II generic -metabolite KEGG:C21262 6'''-Deamino-6'''-hydroxyparomomycin II generic -metabolite KEGG:C21263 6'''-Deamino-6'''-oxoparomomycin II generic -metabolite KEGG:C21264 5'''-epi-Lividomycin B generic -metabolite KEGG:C21265 3''-Oxogentamicin A2 generic -metabolite KEGG:C21266 3''-Amino-3''-deoxygentamicin A2 generic -metabolite KEGG:C21267 6'-Oxogentamicin X2 generic -metabolite KEGG:C21268 6'-Oxo-G418 generic -metabolite KEGG:C21269 Antibiotic JI-20Ba generic -metabolite KEGG:C21270 Gentamicin C2a generic -metabolite KEGG:C21273 Benfluralin generic -metabolite KEGG:C21275 Mycolactone C generic -metabolite KEGG:C21276 Mycolactone D generic -metabolite KEGG:C21277 Mycolactone E generic -metabolite KEGG:C21278 Mycolactone F generic -metabolite KEGG:C21279 BGC 945 generic -metabolite KEGG:C21280 AG 2034 generic -metabolite KEGG:C21281 Demethyl-4-deoxygadusol generic -metabolite KEGG:C21282 2-epi-Valiolone generic -metabolite KEGG:C21283 3-Indoleacrylate generic -metabolite KEGG:C21284 Fe-coproporphyrin III generic -metabolite KEGG:C21285 D-Erythrulose 1-phosphate generic -metabolite KEGG:C21286 L-Erythrulose 4-phosphate generic -metabolite KEGG:C21287 2-Hydroxyisobutanoyl-CoA generic -metabolite KEGG:C21288 (2S,3R)-2-Hydroxy-3-(indol-3-yl)butanoate generic -metabolite KEGG:C21289 (R)-3-(Indol-3-yl)-2-oxobutyrate generic -metabolite KEGG:C21290 2-Methylpropane-1,2-diol generic -metabolite KEGG:C21291 2-Hydroxy-2-methylpropanal generic -metabolite KEGG:C21292 Maduropeptin chromophore generic -metabolite KEGG:C21293 Validamycin B generic -metabolite KEGG:C21294 D-Erythritol 1-phosphate generic -metabolite KEGG:C21295 5-Methylphenazine-1-carboxylate generic -metabolite KEGG:C21296 1alpha-Hydroxytestosterone generic -metabolite KEGG:C21297 2-Hydroxy-2-methylpropanoate generic -metabolite KEGG:C21298 2,6-Dihydroxybenzoate generic -metabolite KEGG:C21299 RCH2NHR' generic -metabolite KEGG:C21300 R'NH2 generic -metabolite KEGG:C21301 Kedarcidin chromophore generic -metabolite KEGG:C21303 (25R)-26-Hydroxycholest-4-en-3-one generic -metabolite KEGG:C21304 (25S)-26-Oxocholest-4-en-3-one generic -metabolite KEGG:C21305 (25R)-26-Oxocholest-4-en-3-one generic -metabolite KEGG:C21306 3,4-Dihydro-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carboxylate generic -metabolite KEGG:C21307 3,4-Dihydro-7-hydroxy-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carboxylate generic -metabolite KEGG:C21308 (S)-beta-Tyrosine generic -metabolite KEGG:C21309 (S)-beta-Tyrosyl-[pcp] generic -metabolite KEGG:C21310 (8S)-3',8-Cyclo-7,8-dihydroguanosine 5'-triphosphate generic -metabolite KEGG:C21311 3-(4-Hydroxyphenyl)-3-oxopropanoyl-[pcp] generic -metabolite KEGG:C21312 6-Methylsalicylyl-CoA generic -metabolite KEGG:C21313 3,6-Dimethylsalicylyl-CoA generic -metabolite KEGG:C21314 NDP-D-mannose generic -metabolite KEGG:C21315 NDP-4-oxo-6-deoxy-D-mannose generic -metabolite KEGG:C21316 NDP-2,6-dideoxy-D-glycero-hex-2-enos-4-ulose generic -metabolite KEGG:C21317 NDP-2-amino-4-oxo-2,6-dideoxy-D-galactose generic -metabolite KEGG:C21318 NDP-2-amino-2,6-dideoxy-D-galactose generic -metabolite KEGG:C21319 NDP-2-methylamino-2,6-dideoxy-D-galactose generic -metabolite KEGG:C21320 3,6,8-Trihydroxy-2-naphthoate generic -metabolite KEGG:C21321 3,6,7,8-Tetrahydroxy-2-naphthoate generic -metabolite KEGG:C21322 3-Hydroxy-6,7,8-trimethoxy-2-naphthoate generic -metabolite KEGG:C21323 3-Hydroxy-7,8-dimethoxy-6-isopropoxy-2-naphthoate generic -metabolite KEGG:C21324 3-Hydroxy-7,8-dimethoxy-6-isopropoxy-2-naphthoyl-CoA generic -metabolite KEGG:C21325 Azatyrosine generic -metabolite KEGG:C21326 (R)-2-Aza-beta-tyrosine generic -metabolite KEGG:C21327 (R)-2-Aza-beta-tyrosyl-[pcp] generic -metabolite KEGG:C21328 (R)-2-Aza-3-chloro-beta-tyrosyl-[pcp] generic -metabolite KEGG:C21329 Benzoyl cyanide generic -metabolite KEGG:C21330 Aurachin C generic -metabolite KEGG:C21331 Aurachin C epoxide generic -metabolite KEGG:C21332 8-Dehydro-3-deoxy-D-manno-octulosonate generic -metabolite KEGG:C21333 8-Amino-3,8-dideoxy-D-manno-octulosonate generic -metabolite KEGG:C21334 CMP-8-amino-3,8-dideoxy-beta-D-manno-octulosonate generic -metabolite KEGG:C21335 1,2-beta-Oligomannan generic -metabolite KEGG:C21336 beta-1,2-Mannobiose generic -metabolite KEGG:C21337 Calicheamicinone generic -metabolite KEGG:C21338 Calicheamicin T0 generic -metabolite KEGG:C21339 4-Deoxy-4-thio-alpha-D-digitoxosyl-calicheamicin T0 generic -metabolite KEGG:C21340 Calicheamicin PsAg generic -metabolite KEGG:C21341 Calicheamicin alpha1(I) generic -metabolite KEGG:C21342 Calicheamicin alpha3(I) generic -metabolite KEGG:C21343 Orsellinate-[acp] generic -metabolite KEGG:C21344 2-Methoxyorsellinate-[acp] generic -metabolite KEGG:C21345 5-Iodo-2-methoxyorsellinate-[acp] generic -metabolite KEGG:C21346 3-Hydroxy-5-iodo-2-methoxyorsellinate-[acp] generic -metabolite KEGG:C21347 5-Iodo-2,3-dimethoxyorsellinate-[acp] generic -metabolite KEGG:C21348 dTDP-4-hydroxyamino-4,6-dideoxy-alpha-D-glucose generic -metabolite KEGG:C21349 dTDP-4-deoxy-4-thio-alpha-D-digitoxose generic -metabolite KEGG:C21350 dTDP-3-O-methyl-beta-L-rhamnose generic -metabolite KEGG:C21351 dTDP-4-oxo-alpha-D-xylose generic -metabolite KEGG:C21352 dTDP-4-oxo-2-deoxy-alpha-D-pentos-2-ene generic -metabolite KEGG:C21353 dTDP-4-oxo-2-deoxy-beta-L-xylose generic -metabolite KEGG:C21354 dTDP-4-amino-2,4-dideoxy-beta-L-xylose generic -metabolite KEGG:C21355 dTDP-4-methylamino-2,4-dideoxy-beta-L-xylose generic -metabolite KEGG:C21356 dTDP-4-ethylamino-3-O-methyl-2,4-dideoxy-L-threo-pentopyranose generic -metabolite KEGG:C21357 3-Hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-[acp] generic -metabolite KEGG:C21358 1,3,5,7,9,11,13-Pentadecaheptaene generic -metabolite KEGG:C21361 3-(2-Chloro-3-hydroxy-4-methoxyphenyl)-3-hydroxypropanoyl-[pcp] generic -metabolite KEGG:C21362 dTDP-3-methyl-4-oxo-alpha-D-ribopyranose generic -metabolite KEGG:C21363 dTDP-madurosamine generic -metabolite KEGG:C21364 [Fructose-bisphosphate aldolase]-L-lysine generic -metabolite KEGG:C21365 [Fructose-bisphosphate aldolase]-N6,N6,N6-trimethyl-L-lysine generic -metabolite KEGG:C21366 3-O-[N-Acetyl-beta-D-galactosaminyl-(1->3)-N-acetyl-beta-D-glucosaminyl-(1->4)-alpha-D-(6-phospho)mannosyl]-L-threonyl-[protein] generic -metabolite KEGG:C21367 Valienol 1-phosphate generic -metabolite KEGG:C21368 GDP-valienol generic -metabolite KEGG:C21369 N-(2-Methylpropanyl)hydroxylamine generic -metabolite KEGG:C21370 (S)-Nandinine generic -metabolite KEGG:C21371 Validone generic -metabolite KEGG:C21372 3-Phosphinomethylmalate generic -metabolite KEGG:C21373 (3R)-3,4-Epoxy-3-methylbut-1-ene generic -metabolite KEGG:C21374 2-(Glutathion-S-yl)-2-methylbut-3-en-1-ol generic -metabolite KEGG:C21375 3-Hydroxy-4-methylanthranilyl-[aryl-carrier protein] generic -metabolite KEGG:C21376 3,5-Dihydroxy-4-methylanthranilyl-[aryl-carrier protein] generic -metabolite KEGG:C21377 [F-actin]-L-methionine generic -metabolite KEGG:C21378 [F-actin]-L-methionine-(R)-S-oxide generic -metabolite KEGG:C21379 (2S,3R)-Flavan-3-ol generic -metabolite KEGG:C21380 (2S,3S)-Flavan-3-ol generic -metabolite KEGG:C21381 Anthocyanidin with a 3-hydroxy group generic -metabolite KEGG:C21382 R-THMF generic -metabolite KEGG:C21383 2-Keto-3-deoxy-D-glycero-D-galacto-nononate 9-phosphate generic -metabolite KEGG:C21384 CMP-2-keto-3-deoxy-D-glycero-D-galacto-nononate generic -metabolite KEGG:C21385 trans-12-Hydroxyjasmonic acid generic -metabolite KEGG:C21386 L-Leucyl-L-arginyl-protein generic -metabolite KEGG:C21387 L-Leucyl-L-lysyl-protein generic -metabolite KEGG:C21388 L-Lysyl-protein generic -metabolite KEGG:C21389 tert-Butyl alcohol generic -metabolite KEGG:C21390 Butane generic -metabolite KEGG:C21391 11a-Hydroxytetracycline generic -metabolite KEGG:C21392 Multi-methyl-branched acyl-[acp] generic -metabolite KEGG:C21393 C32-Mycocerosyl-[acp] generic -metabolite KEGG:C21394 C27-Mycolipanoyl-[acp] generic -metabolite KEGG:C21395 dTDP-4-(methylamino)-2,3,4,6-tetradeoxy-D-glucose generic -metabolite KEGG:C21396 Ethylenediaminetriacetic acid generic -metabolite KEGG:C21397 Ethylenediamine-N,N'-diacetic acid generic -metabolite KEGG:C21398 Methanesulfinic acid generic -metabolite KEGG:C21399 Isocaproate generic -metabolite KEGG:C21400 Isocaproyl-CoA generic -metabolite KEGG:C21401 tert-Amyl alcohol generic -metabolite KEGG:C21402 Isoprenyl alcohol generic -metabolite KEGG:C21403 2-Acetamidoethylphosphonate generic -metabolite KEGG:C21404 N-Ethylacetamide generic -metabolite KEGG:C21405 (4aS,10bR)-Noroxomaritidine generic -metabolite KEGG:C21406 (4aR,10bS)-Noroxomaritidine generic -metabolite KEGG:C21407 7-(Hydroxymethyl)bacteriochlorophyllide c generic -metabolite KEGG:C21408 (1R,6R)-1,4,5,5a,6,9-Hexahydrophenazine-1,6-dicarboxylate generic -metabolite KEGG:C21409 (1R,10aS)-1,4,10,10a-Tetrahydrophenazine-1,6-dicarboxylate generic -metabolite KEGG:C21410 (5aS)-5,5a-Dihydrophenazine-1,6-dicarboxylate generic -metabolite KEGG:C21411 (1R,10aS)-1,4,10,10a-Tetrahydrophenazine-1-carboxylate generic -metabolite KEGG:C21412 (10aS)-10,10a-Dihydrophenazine-1-carboxylate generic -metabolite KEGG:C21413 (1R)-1,4,5,10-Tetrahydrophenazine-1-carboxylate generic -metabolite KEGG:C21414 Naphthalene-1,2,4,8-tetrol generic -metabolite KEGG:C21415 Valienol 7-phosphate generic -metabolite KEGG:C21416 2-Amino-1,5-anhydro-2-deoxyglucitol generic -metabolite KEGG:C21417 (2R,3R)-Dihydroflavonol generic -metabolite KEGG:C21418 (2R,3S,4S)-Leucoanthocyanidin generic -metabolite KEGG:C21419 1-(3,4-Dimethoxyphenyl)-2-(2-methoxyphenoxy)propane-1,3-diol generic -metabolite KEGG:C21420 (3,4-Dimethoxyphenyl)methanol generic -metabolite KEGG:C21421 (3,4-Dimethoxyphenyl)methanol radical generic -metabolite KEGG:C21422 1-(4-Hydroxy-3-methoxyphenyl)-2-(2-methoxyphenoxy)propane-1,3-diol generic -metabolite KEGG:C21423 1,2-Dihydro-beta-NAD generic -metabolite KEGG:C21424 1,6-Dihydro-beta-NAD generic -metabolite KEGG:C21425 Abieta-8,11,13-triene generic -metabolite KEGG:C21426 3-Vinyl bacteriochlorophyllide d generic -metabolite KEGG:C21427 8,12-Diethyl-3-vinylbacteriochlorophyllide d generic -metabolite KEGG:C21428 12-Ethyl-8-propyl-3-vinylbacteriochlorophyllide d generic -metabolite KEGG:C21429 12-Ethyl-8-isobutyl-3-vinylbacteriochlorophyllide d generic -metabolite KEGG:C21430 Malonamoyl-[acyl-carrier protein] generic -metabolite KEGG:C21431 8-Ethyl-12-methylbacteriochlorophyllide d generic -metabolite KEGG:C21432 8,12-Diethylbacteriochlorophyllide d generic -metabolite KEGG:C21433 12-Ethyl-8-propylbacteriochlorophyllide d generic -metabolite KEGG:C21434 12-Ethyl-8-isobutylbacteriochlorophyllide d generic -metabolite KEGG:C21435 Geranylgeranyl bacteriochlorophyllide b generic -metabolite KEGG:C21436 4-Methylamino-4-de(dimethylamino)anhydrotetracycline generic -metabolite KEGG:C21437 [Sulfur-carrier protein]-Gly-Gly-L-Cys generic -metabolite KEGG:C21438 11a-Hydroxyoxytetracycline generic -metabolite KEGG:C21439 11a-Hydroxy-7-chlortetracycline generic -metabolite KEGG:C21440 [Protein]-S-sulfanyl-L-cysteine generic -metabolite KEGG:C21441 Bacteriochlorophyllide g generic -metabolite KEGG:C21442 Phenazine-1-carboxylate generic -metabolite KEGG:C21443 N-Demethylindolmycin generic -metabolite KEGG:C21444 Indolmycin generic -metabolite KEGG:C21445 17-(4-Hydroxyphenyl)heptadecanoyl adenylate generic -metabolite KEGG:C21446 17-(4-Hydroxyphenyl)heptadecanoate generic -metabolite KEGG:C21447 19-(4-Hydroxyphenyl)nonadecanoyl adenylate generic -metabolite KEGG:C21448 19-(4-Hydroxyphenyl)nonadecanoate generic -metabolite KEGG:C21449 Lithocholoyl-CoA generic -metabolite KEGG:C21450 4-(2-Hydroxyethoxycarbonyl)benzoate generic -metabolite KEGG:C21451 Poly(ethylene terephthalate) generic -metabolite KEGG:C21452 2-Aminobenzoylacetyl-CoA generic -metabolite KEGG:C21453 2-Aminobenzoylacetate generic -metabolite KEGG:C21454 beta-1,2-Mannotriose generic -metabolite KEGG:C21455 L-Leucyl-L-glutamyl-protein generic -metabolite KEGG:C21456 L-Glutamyl-protein generic -metabolite KEGG:C21457 L-Leucyl-L-aspartyl-protein generic -metabolite KEGG:C21458 L-Aspartyl-protein generic -metabolite KEGG:C21459 6-Hydroxyferuloyl-CoA generic -metabolite KEGG:C21460 (3-Hydroxy-4-methylanthranilyl)adenylate generic -metabolite KEGG:C21461 Kdo2-lipid A 1-(2-aminoethyl diphosphate) generic -metabolite KEGG:C21462 Kdo2-lipid A 4'-(2-aminoethyl diphosphate) generic -metabolite KEGG:C21463 Kdo2-lipid A 1,4'-bis(2-aminoethyl diphosphate) generic -metabolite KEGG:C21464 4-O-[(2R)-1-Glycerophospho]-N-acetyl-beta-D-mannosaminyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21465 L-Asparaginyl-protein generic -metabolite KEGG:C21466 Protein Nomega-(1-hydroxy-2-oxopropyl)-L-arginine generic -metabolite KEGG:C21467 Protein N6-(1-hydroxy-2-oxopropyl)-L-lysine generic -metabolite KEGG:C21468 Protein S-(1-hydroxy-2-oxopropyl)-L-cysteine generic -metabolite KEGG:C21469 7alpha,12alpha-Dihydroxy-3-oxochol-4-en-24-oyl-CoA generic -metabolite KEGG:C21470 12alpha-Hydroxy-3-oxochola-4,6-dien-24-oyl-CoA generic -metabolite KEGG:C21471 7alpha-Hydroxy-3-oxochol-4-en-24-oyl-CoA generic -metabolite KEGG:C21472 3-Oxochola-4,6-dien-24-oyl-CoA generic -metabolite KEGG:C21473 (1R,5aS,6R)-4a-Hydroxy-1,4,4a,5,5a,6,9,10a-octahydrophenazine-1,6-dicarboxylate generic -metabolite KEGG:C21474 5,10-Dihydrophenazine-1,6-dicarboxylate generic -metabolite KEGG:C21475 5,10-Dihydrophenazine generic -metabolite KEGG:C21476 Phenazine generic -metabolite KEGG:C21477 1-Hydroxyphenazine generic -metabolite KEGG:C21478 Erastin generic -metabolite KEGG:C21479 RSL3 generic -metabolite KEGG:C21480 1-Octadecanoyl-2-(5Z,8Z,11Z,14Z-eicosatetraenoyl)-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C21481 1-Octadecanoyl-2-(7Z,10Z,13Z,16Z-docosatetraenoyl)-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C21482 1-Octadecanoyl-2-(15S-hydroxy-5Z,8Z,11Z,13E-eicosatetraenoyl)-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C21483 1-Octadecanoyl-2-(15S-hydroperoxy-5Z,8Z,11Z,13E-eicosatetraenoyl)-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C21484 1-Octadecanoyl-sn-glycero-3-phosphoethanolamine generic -metabolite KEGG:C21485 Cytidylyl molybdenum cofactor generic -metabolite KEGG:C21486 Thio-molybdenum cofactor generic -metabolite KEGG:C21487 L-Cysteinyl-protein generic -metabolite KEGG:C21488 S-Anthraniloyl-L-cysteinyl-protein generic -metabolite KEGG:C21489 S-Octanoyl-L-cysteinyl-protein generic -metabolite KEGG:C21490 1-(2-Aminophenyl)decane-1,3-dione generic -metabolite KEGG:C21491 (S)-Tembetarine generic -metabolite KEGG:C21492 4'-O-Methylxanthohumol generic -metabolite KEGG:C21493 alpha-D-Gal-(1->3)-alpha-D-GlcNAc-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21494 alpha-L-Fucosyl-(1->2)-beta-D-galactosyl-(1->4)-N-acetyl-beta-D-glucosaminyl-R generic -metabolite KEGG:C21495 8-Geranylumbelliferone generic -metabolite KEGG:C21496 8-Geranylesculetin generic -metabolite KEGG:C21497 4-Hydroxybenzoyl-adenylate generic -metabolite KEGG:C21498 2-Acylphloroglucinol generic -metabolite KEGG:C21499 2-Acyl-4-prenylphloroglucinol generic -metabolite KEGG:C21500 2-Acyl-4,6-bisprenylphloroglucinol generic -metabolite KEGG:C21501 2-Acyl-4,6,6-trisprenylcyclohexa-2,4-dien-1-one generic -metabolite KEGG:C21502 4-O-Di[(2R)-1-glycerophospho]-N-acetyl-beta-D-mannosaminyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21503 4-O-[1-D-Ribitylphospho-(2R)-1-glycerophospho]-N-acetyl-beta-D-mannosaminyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21504 4-O-[(1-D-Ribitylphospho)n-(1-D-ribitylphospho)-(2R)-1-glycerophospho]-N-acetyl-beta-D-mannosaminyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21505 4-Hydroxybenzoyl-[acp] generic -metabolite KEGG:C21506 17-(4-Hydroxyphenyl)heptadecanoyl-[acp] generic -metabolite KEGG:C21507 19-(4-Hydroxyphenyl)nonadecanoyl-[acp] generic -metabolite KEGG:C21508 4-O-(D-Ribitylphospho)n-di[(2R)-1-glycerophospho]-N-acetyl-beta-D-mannosaminyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21509 Jasmonoyl-L-amino acid generic -metabolite KEGG:C21510 Nickel-sirohydrochlorin generic -metabolite KEGG:C21511 Nickel-sirohydrochlorin a,c-diamide generic -metabolite KEGG:C21512 15,17(3)-Seco-F430-17(3)-acid generic -metabolite KEGG:C21513 Turicine generic -metabolite KEGG:C21514 D-Proline betaine generic -metabolite KEGG:C21515 Trandolaprilat generic -metabolite KEGG:C21516 Paliperidone generic -metabolite KEGG:C21517 Perindoprilat generic -metabolite KEGG:C21518 Tazarotenic acid generic -metabolite KEGG:C21519 Imidaprilat generic -metabolite KEGG:C21520 18-502 generic -metabolite KEGG:C21521 Deglymidodrine generic -metabolite KEGG:C21522 Tebipenem generic -metabolite KEGG:C21523 L-Tagatose generic -metabolite KEGG:C21524 D-Altritol generic -metabolite KEGG:C21525 2-Methylbutanenitrile generic -metabolite KEGG:C21526 Menaquinone-9 generic -metabolite KEGG:C21527 beta-Dihydromenaquinone-9 generic -metabolite KEGG:C21528 (9Z,12Z)-Hexadeca-9,12,15-trienoyl-CoA generic -metabolite KEGG:C21529 Linoleoyl-[glycerolipid] generic -metabolite KEGG:C21530 Pinolenoyl-[glycerolipid] generic -metabolite KEGG:C21531 alpha-Linolenoyl-[glycerolipid] generic -metabolite KEGG:C21532 Coniferonoyl-[glycerolipid] generic -metabolite KEGG:C21533 Deacetylalacepril generic -metabolite KEGG:C21534 L-Polyhomomethionine generic -metabolite KEGG:C21535 omega-(Methylthio)-(E)-alkanal oxime generic -metabolite KEGG:C21536 L-N-Hydroxypolyhomomethionine generic -metabolite KEGG:C21537 L-N,N-Dihydroxypolyhomomethionine generic -metabolite KEGG:C21538 1-aci-Nitro-omega-(methylthio)alkane generic -metabolite KEGG:C21539 (E)-1-(Glutathione-S-yl)-omega-(methylthio)alkylhydroximate generic -metabolite KEGG:C21540 Quinaprilat generic -metabolite KEGG:C21541 Benazeprilat generic -metabolite KEGG:C21542 Fosinoprilat generic -metabolite KEGG:C21543 Olmesartan generic -metabolite KEGG:C21544 Cefotiam generic -metabolite KEGG:C21545 Mecillinam generic -metabolite KEGG:C21546 Cefditoren generic -metabolite KEGG:C21547 Cefcapene generic -metabolite KEGG:C21548 Cefteram generic -metabolite KEGG:C21549 Miproxifene generic -metabolite KEGG:C21550 Fludarabine generic -metabolite KEGG:C21551 Melagatran generic -metabolite KEGG:C21552 Valdecoxib generic -metabolite KEGG:C21553 Fluocortin generic -metabolite KEGG:C21554 Torcitabine generic -metabolite KEGG:C21555 Aprepitant generic -metabolite KEGG:C21556 Dabigatran generic -metabolite KEGG:C21557 Laninamivir generic -metabolite KEGG:C21558 Temsavir generic -metabolite KEGG:C21559 N-[(2S)-2-Amino-2-carboxyethyl]-L-glutamate generic -metabolite KEGG:C21560 ent-Sandaracopimaradien-3beta-ol generic -metabolite KEGG:C21561 Oryzalexin E generic -metabolite KEGG:C21562 Oryzalexin D generic -metabolite KEGG:C21563 2-(Glutathione-S-yl)-hydroquinone generic -metabolite KEGG:C21564 [(1->4)-N-Acetyl-beta-D-glucosaminyl]n-(1->4)-N-acetyl-2-deoxy-2-amino-D-glucono-1,5-lactone generic -metabolite KEGG:C21565 Prodigiosin generic -metabolite KEGG:C21566 6-O-Methyldeacetylisoipecoside generic -metabolite KEGG:C21567 Pyrrolyl-2-carboxyl-S-[acyl-carrier protein] generic -metabolite KEGG:C21568 4-Hydroxy-2,2'-bipyrrole-5-methanol generic -metabolite KEGG:C21569 4-Hydroxy-2,2'-bipyrrole-5-carbaldehyde generic -metabolite KEGG:C21570 4-Methoxy-2,2'-bipyrrole-5-carbaldehyde generic -metabolite KEGG:C21571 2-Methyl-3-n-amyl-dihydropyrrole generic -metabolite KEGG:C21572 2-Methyl-3-n-amyl-pyrrole generic -metabolite KEGG:C21573 4-Keto-2-undecylpyrroline generic -metabolite KEGG:C21574 2-Undecylpyrrole generic -metabolite KEGG:C21575 Delaprilat generic -metabolite KEGG:C21576 Zofenoprilat generic -metabolite KEGG:C21577 LY404039 generic -metabolite KEGG:C21578 Bromo-isophosphoramide mustard generic -metabolite KEGG:C21579 12ADT generic -metabolite KEGG:C21580 12ADT-Asp generic -metabolite KEGG:C21581 Simvastatin acid generic -metabolite KEGG:C21582 Bacteriochlorophyllide e generic -metabolite KEGG:C21583 6-O-Methyl-N-deacetylisoipecoside aglycon generic -metabolite KEGG:C21584 7'-O-Dmethylcephaeline generic -metabolite KEGG:C21585 4-Phospho-D-threonate generic -metabolite KEGG:C21586 (S)-1-Hydroxy-N-methylcanadine generic -metabolite KEGG:C21587 (13S,14R)-1,13-Dihydroxy-N-methylcanadine generic -metabolite KEGG:C21588 (13S,14R)-1-Hydroxy-13-O-acetyl-N-methylcanadine generic -metabolite KEGG:C21589 (13S,14R)-1,8-Dihydroxy-13-O-acetyl-N-methylcanadine generic -metabolite KEGG:C21590 4'-O-Desmethyl-3-O-acetylpapaveroxine generic -metabolite KEGG:C21591 3-O-Acetylpapaveroxine generic -metabolite KEGG:C21592 Ceftizoxime alapivoxil generic -metabolite KEGG:C21593 D-Erythronate generic -metabolite KEGG:C21594 Clindamycin palmitate generic -metabolite KEGG:C21595 Erythromycin 2'-acetate generic -metabolite KEGG:C21596 Cytarabine ocfosphate generic -metabolite KEGG:C21598 Laninamivir octanoate generic -metabolite KEGG:C21599 4'-O-Desmethylpapaveroxine generic -metabolite KEGG:C21600 Narcotoline hemiacetal generic -metabolite KEGG:C21601 3-(Aminomethyl)indole generic -metabolite KEGG:C21602 (1H-Indol-3-yl)-N-methylmethanamine generic -metabolite KEGG:C21603 Anaerobilin generic -metabolite KEGG:C21604 (3S)-6-Acetamido-3-aminohexanoate generic -metabolite KEGG:C21605 Arbaclofen generic -metabolite KEGG:C21606 2-O-(alpha-D-Mannosyl)-1-phosphatidyl-1D-myo-inositol generic -metabolite KEGG:C21607 2,6-Di-O-alpha-D-mannosyl-1-phosphatidyl-1D-myo-inositol generic -metabolite KEGG:C21608 2-O-(6-O-Acyl-alpha-D-mannosyl)-6-O-alpha-D-mannosyl-1-phosphatidyl-1D-myo-inositol generic -metabolite KEGG:C21609 2-O-(6-O-Acyl-alpha-D-mannosyl)-1-phosphatidyl-1D-myo-inositol generic -metabolite KEGG:C21610 3-Dehydro-4-phospho-D-erythronate generic -metabolite KEGG:C21611 3-Dehydro-4-phospho-L-erythronate generic -metabolite KEGG:C21612 3-Dehydro-L-erythronate generic -metabolite KEGG:C21613 (R)-2-(Phosphonomethyl)malate generic -metabolite KEGG:C21614 Glycolaldehyde phosphate generic -metabolite KEGG:C21615 Glycolaldehyde triphosphate generic -metabolite KEGG:C21616 Psicoselysine generic -metabolite KEGG:C21617 2-Dehydro-D-erythronate generic -metabolite KEGG:C21618 2-Dehydro-L-erythronate generic -metabolite KEGG:C21619 (2-Hydroxy-1H-indol-3-yl)acetate generic -metabolite KEGG:C21620 S-[(E)-N-Hydroxy(indol-3-yl)acetimidoyl]-L-glutathione generic -metabolite KEGG:C21621 Methanofuran generic -metabolite KEGG:C21622 S-[(Z)-N-Hydroxy(phenyl)acetimidoyl]-L-glutathione generic -metabolite KEGG:C21623 1-aci-Nitro-2-phenylethane generic -metabolite KEGG:C21624 Mycobilin a generic -metabolite KEGG:C21625 Mycobilin b generic -metabolite KEGG:C21626 [(1->4)-beta-D-Glucosyl]n-(1->4)-D-glucono-1,5-lactone generic -metabolite KEGG:C21628 4-Dehydro-beta-D-glucosyl-[(1->4)-beta-D-glucosyl]n-1 generic -metabolite KEGG:C21629 Formylmethanofuran generic -metabolite KEGG:C21630 (S)-Norlaudanine generic -metabolite KEGG:C21631 (S)-Tetrahydropapaverine generic -metabolite KEGG:C21632 2-Hydroxyparaconate generic -metabolite KEGG:C21633 Noroxopluviine generic -metabolite KEGG:C21634 Norcraugsodine generic -metabolite KEGG:C21635 (4aR,10bS)-Normaritidine generic -metabolite KEGG:C21637 Elwesine generic -metabolite KEGG:C21639 Maritinamine generic -metabolite KEGG:C21640 6-(1'-Hydroxy-2'-oxopropyl)-tetrahydropterin generic -metabolite KEGG:C21641 Hydroperoxyl radical generic -metabolite KEGG:C21642 4-Hydroxynonenal generic -metabolite KEGG:C21643 3-Dehydro-scyllo-inosose generic -metabolite KEGG:C21644 5-Dehydro-L-gluconate generic -metabolite KEGG:C21645 (2R,3S)-2-Alkyl-3-hydroxyalkanoate generic -metabolite KEGG:C21646 8-Amino-8-demethylriboflavin generic -metabolite KEGG:C21647 Roseoflavin generic -metabolite KEGG:C21648 8-Demethyl-8-(methylamino)riboflavin generic -metabolite KEGG:C21649 D-Threonate generic -metabolite KEGG:C21650 7-Methylthioheptyl-desulfoglucosinolate generic -metabolite KEGG:C21651 (R)-2-Alkyl-3-oxoalkanoate generic -metabolite KEGG:C21652 RNA 2'-terminal-phosphate generic -metabolite KEGG:C21653 (+)-Kolavelool generic -metabolite KEGG:C21654 (+)-Kolavenyl diphosphate generic -metabolite KEGG:C21655 Cyclobis-1,6-alpha-nigerosyl generic -metabolite KEGG:C21656 ent-8alpha-Hydroxylabd-13-en-15-yl diphosphate generic -metabolite KEGG:C21657 cis-3-Alkyl-4-alkyloxetan-2-one generic -metabolite KEGG:C21658 Peregrinol diphosphate generic -metabolite KEGG:C21659 alpha-Isomaltosyl-1,3-isomaltose generic -metabolite KEGG:C21660 (+)-Isoafricanol generic -metabolite KEGG:C21661 (-)-Spiroviolene generic -metabolite KEGG:C21662 (E)-1-(L-Cysteinylglycine-S-yl)-N-hydroxy-omega-(methylsulfanyl)alkane-1-imine generic -metabolite KEGG:C21663 (E)-1-(L-Cysteinylglycine-S-yl)-N-hydroxy-2-(1H-indol-3-yl)ethane-1-imine generic -metabolite KEGG:C21664 (Glutathione-S-yl)(1H-indol-3-yl)acetonitrile generic -metabolite KEGG:C21665 (L-Cysteinylglycine-S-yl)(1H-indol-3-yl)acetonitrile generic -metabolite KEGG:C21666 (3R,4R)-3-[(1S)-1-Hydroxyalkyl]-4-(hydroxymethyl)oxolan-2-one generic -metabolite KEGG:C21667 (Z)-1-(L-Cysteinylglycine-S-yl)-N-hydroxy-2-phenylethane-1-imine generic -metabolite KEGG:C21668 (3R,4R)-3-Alkanoyl-4-(hydroxymethyl)oxolan-2-one generic -metabolite KEGG:C21669 12-Hydroxyjasmonate generic -metabolite KEGG:C21670 Tsukubadiene generic -metabolite KEGG:C21671 12-Sulfooxyjasmonate generic -metabolite KEGG:C21672 Ornithine lipid generic -metabolite KEGG:C21673 N-Methylornithine lipid generic -metabolite KEGG:C21674 N,N-Dimethylornithine lipid generic -metabolite KEGG:C21675 N,N,N-Trimethylornithine lipid generic -metabolite KEGG:C21676 (2S,3R,6S,9S)-(-)-Protoillud-7-ene generic -metabolite KEGG:C21677 (3S)-(+)-Asterisca-2(9),6-diene generic -metabolite KEGG:C21678 (3R)-3-Hydroxy-16-methoxy-1,2-didehydro-2,3-dihydrotabersonine generic -metabolite KEGG:C21679 (-)-alpha-Amorphene generic -metabolite KEGG:C21680 Lyso-ornithine lipid generic -metabolite KEGG:C21681 (+)-Corvol ether B generic -metabolite KEGG:C21682 (3R)-3-Hydroxy-2,3-dihydrotabersonine generic -metabolite KEGG:C21683 (3R)-3-Hydroxy-1,2-didehydro-2,3-dihydrotabersonine generic -metabolite KEGG:C21684 (+)-Eremophilene generic -metabolite KEGG:C21685 (1R,4R,5S)-(-)-Guaia-6,10(14)-diene generic -metabolite KEGG:C21686 (+)-(1E,4E,6S,7R)-Germacra-1(10),4-dien-6-ol generic -metabolite KEGG:C21687 (3E,7E)-Dolabella-3,7-dien-18-ol generic -metabolite KEGG:C21688 (3E,7E)-Dolathalia-3,7,11-triene generic -metabolite KEGG:C21689 7-epi-alpha-Eudesmol generic -metabolite KEGG:C21690 4-epi-Cubebol generic -metabolite KEGG:C21691 omega-(Methylthio)alkyl-glucosinolate generic -metabolite KEGG:C21692 omega-(Methylsulfinyl)alkyl-glucosinolate generic -metabolite KEGG:C21693 (+)-Corvol ether A generic -metabolite KEGG:C21694 10-epi-Juneol generic -metabolite KEGG:C21695 tau-Cadinol generic -metabolite KEGG:C21696 12-Hydroxyjasmonoyl-L-amino acid generic -metabolite KEGG:C21697 12-Hydroxy-12-oxojasmonoyl-L-amino acid generic -metabolite KEGG:C21698 (2E,6E)-Hedycaryol generic -metabolite KEGG:C21699 12-Oxojasmonoyl-L-amino acid generic -metabolite KEGG:C21700 10-epi-Cubebol generic -metabolite KEGG:C21701 Sesterfisherol generic -metabolite KEGG:C21702 beta-Thujene generic -metabolite KEGG:C21703 Stellata-2,6,19-triene generic -metabolite KEGG:C21704 Stellatate generic -metabolite KEGG:C21705 Guaia-4,6-diene generic -metabolite KEGG:C21706 Pseudolaratriene generic -metabolite KEGG:C21707 Selina-4(15),7(11)-diene generic -metabolite KEGG:C21708 (+)-(2S,3R,9R)-Pristinol generic -metabolite KEGG:C21709 Nezukol generic -metabolite KEGG:C21710 5-Hydroxy-alpha-gurjunene generic -metabolite KEGG:C21711 ent-Atiserene generic -metabolite KEGG:C21712 2-Chloro-N-(2,6-diethylphenyl)acetamide generic -metabolite KEGG:C21713 Butyl formate generic -metabolite KEGG:C21714 ent-13-epi-Manoyl oxide generic -metabolite KEGG:C21715 (2Z,6E)-Hedycaryol generic -metabolite KEGG:C21716 beta-Geranylfarnesene generic -metabolite KEGG:C21717 beta-Hexaprene generic -metabolite KEGG:C21718 beta-Heptaprene generic -metabolite KEGG:C21719 2-(L-Cystein-S-yl)-2-(1H-indol-3-yl)acetonitrile generic -metabolite KEGG:C21720 9,13-Epoxylabda-14-ene generic -metabolite KEGG:C21721 Camalexin generic -metabolite KEGG:C21722 (R)-Dihydrocamalexate generic -metabolite KEGG:C21723 Biliverdin-IX-delta generic -metabolite KEGG:C21724 Biliverdin-IX-beta generic -metabolite KEGG:C21725 Manoyl oxide generic -metabolite KEGG:C21726 Cycloaraneosene generic -metabolite KEGG:C21727 (13E)-Labda-7,13-dien-15-yl diphosphate generic -metabolite KEGG:C21728 Labda-7,13(16),14-triene generic -metabolite KEGG:C21729 (12E)-Labda-8(17),12,14-triene generic -metabolite KEGG:C21730 epsilon-(gamma-L-Glutamyl)-L-lysine generic -metabolite KEGG:C21731 2-(Hydroxysulfanyl)hercynine generic -metabolite KEGG:C21732 (3S,22S)-2,3:22,23-Diepoxy-2,3,22,23-tetrahydrosqualene generic -metabolite KEGG:C21733 Pre-alpha-onocerin generic -metabolite KEGG:C21734 alpha-Onocerin generic -metabolite KEGG:C21735 (-)-Kolavenyl diphosphate generic -metabolite KEGG:C21736 4-Sulfanylbutanoate generic -metabolite KEGG:C21737 4,4'-Disulfanediyldibutanoate generic -metabolite KEGG:C21738 (4R)-4,2'-Dihydroxyisoflavan generic -metabolite KEGG:C21739 (3R)-2'-Hydroxyisoflavanone generic -metabolite KEGG:C21740 [Sulfatase]-L-cysteine generic -metabolite KEGG:C21741 [Sulfatase]-3-oxo-L-alanine generic -metabolite KEGG:C21742 beta-D-Gal-(1->4)-beta-D-GlcNAc-(1->3)-beta-D-Gal-(1->4)-beta-D-GlcNAc-R generic -metabolite KEGG:C21743 beta-D-Gal-(1->4)-beta-D-GlcNAc-(1->3)-[beta-D-GlcNAc-(1->6)]-beta-D-Gal-(1->4)-beta-D-GlcNAc-R generic -metabolite KEGG:C21744 Mn(IV)O2 generic -metabolite KEGG:C21746 8-Methylthiooctyl-desulfoglucosinolate generic -metabolite KEGG:C21747 N-Acetyl-beta-D-glucosaminyl-(1->4)-D-glucosamine generic -metabolite KEGG:C21748 5-Fluorouridine diphosphate generic -metabolite KEGG:C21749 5-Fluorouridine triphosphate generic -metabolite KEGG:C21750 5-Fluorodeoxyuridine diphosphate generic -metabolite KEGG:C21751 5-Fluorodeoxyuridine triphosphate generic -metabolite KEGG:C21752 2-Hydroxyethyl-CoM generic -metabolite KEGG:C21753 2-Chloro-2-hydroxyethyl-CoM generic -metabolite KEGG:C21754 Isonicotinoyl radical generic -metabolite KEGG:C21755 Isonicotinoyl-NAD+ generic -metabolite KEGG:C21756 Isonicotinoyl-NADP+ generic -metabolite KEGG:C21757 4-Isonicotinoylnicotinamide generic -metabolite KEGG:C21758 Hepatotoxins generic -metabolite KEGG:C21759 Isonicotinoyl-NAD adduct generic -metabolite KEGG:C21760 Isonicotinoyl-NADP adduct generic -metabolite KEGG:C21761 (3R)-3-Hydroxy-4-oxobutanoate generic -metabolite KEGG:C21762 4-Hydroxytryptamine generic -metabolite KEGG:C21763 Long-chain alkane generic -metabolite KEGG:C21764 5-Hydroxybenzimidazole generic -metabolite KEGG:C21765 Rhizathalene A generic -metabolite KEGG:C21766 4,4'-Diapolycopen-4-al generic -metabolite KEGG:C21767 Pyridinium-3,5-bisthiocarboxylate mononucleotide generic -metabolite KEGG:C21768 4,4'-Diapolycopen-4-oate generic -metabolite KEGG:C21769 Ni(II)-pyridinium-3,5-bisthiocarboxylate mononucleotide generic -metabolite KEGG:C21770 4,4'-Diapolycopene-4,4'-dioate generic -metabolite KEGG:C21771 L-Firefly luciferin generic -metabolite KEGG:C21772 L-Firefly luciferyl-CoA generic -metabolite KEGG:C21773 [(3S)-4-Alkanoyl-5-oxooxolan-3-yl]methyl phosphate generic -metabolite KEGG:C21774 (4-Alkanoyl-5-oxo-2,5-dihydrofuran-3-yl)methyl phosphate generic -metabolite KEGG:C21775 1-(4-Methoxyphenyl)-N-methyl-N-[(3-methyloxetan-3-yl)methyl]methanamine generic -metabolite KEGG:C21776 2-({[(4-Methoxyphenyl)methyl](methyl)amino}methyl)-2-methylpropane-1,3-diol generic -metabolite KEGG:C21777 4-Hydroxy-L-tryptophan generic -metabolite KEGG:C21778 Norbaeocystin generic -metabolite KEGG:C21779 Baeocystin generic -metabolite KEGG:C21780 alpha-D-Mannosyl-(1->3)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21781 alpha-D-Mannosyl-(1->3)-alpha-D-mannosyl-(1->3)-alpha-D-mannosyl-(1->3)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21782 Mogrol generic -metabolite KEGG:C21783 Mogroside IE generic -metabolite KEGG:C21784 Nerylneryl diphosphate generic -metabolite KEGG:C21785 N5-Phospho-L-glutamine generic -metabolite KEGG:C21786 Oleuropein aglycone generic -metabolite KEGG:C21787 S-Sulfinatoglutathione generic -metabolite KEGG:C21788 Tulathromycin A generic -metabolite KEGG:C21789 Tulathromycin B generic -metabolite KEGG:C21790 Trehalose dimycolate generic -metabolite KEGG:C21791 Rhodocytin generic -metabolite KEGG:C21792 ManLAM generic -metabolite KEGG:C21793 4-Phenylbutyrate generic -metabolite KEGG:C21794 2-Hydroxyornithine lipid generic -metabolite KEGG:C21795 (3E)-4,8-Dimethylnona-1,3,7-triene generic -metabolite KEGG:C21796 11-Hydroxyferruginol generic -metabolite KEGG:C21797 all-trans-3,4-Didehydroretinol generic -metabolite KEGG:C21798 Adenine in U6 snRNA generic -metabolite KEGG:C21799 N6-Methyladenine in U6 snRNA generic -metabolite KEGG:C21800 (+)-O-Methylkolavelool generic -metabolite KEGG:C21801 (+)-Demethylpiperitol generic -metabolite KEGG:C21802 (+)-Didemethylpinoresinol generic -metabolite KEGG:C21803 8-Demethyl-8-formylriboflavin 5'-phosphate generic -metabolite KEGG:C21804 8-Carboxy-8-demethylriboflavin 5'-phosphate generic -metabolite KEGG:C21805 8-Amino-8-demethylriboflavin 5'-phosphate generic -metabolite KEGG:C21808 21-Phosphorifampicin generic -metabolite KEGG:C21811 Wall teichoic acid generic -metabolite KEGG:C21812 Wall teichoic acid generic -metabolite KEGG:C21814 [SoxY protein]-S-disulfanyl-L-cysteine generic -metabolite KEGG:C21815 [SoxY protein]-S-sulfosulfanyl-L-cysteine generic -metabolite KEGG:C21816 alpha-D-Galacturonosyl-[(1->2)-alpha-L-rhamnosyl-(1->4)-alpha-D-galacturonosyl]n generic -metabolite KEGG:C21817 [(1->2)-alpha-L-Rhamnosyl-(1->4)-alpha-D-galacturonosyl]n generic -metabolite KEGG:C21818 Carnosic acid generic -metabolite KEGG:C21819 Salviol generic -metabolite KEGG:C21820 Maniladiol generic -metabolite KEGG:C21821 Daturadiol generic -metabolite KEGG:C21822 Sugiol generic -metabolite KEGG:C21823 11-Hydroxysugiol generic -metabolite KEGG:C21824 11,20-Dihydroxysugiol generic -metabolite KEGG:C21825 9beta-Pimara-7,15-diene-3beta-ol generic -metabolite KEGG:C21826 ent-3beta-Hydroxycassa-12,15-dien-2-one generic -metabolite KEGG:C21827 ent-Cassa-12,15-dien-2beta-ol generic -metabolite KEGG:C21828 ent-Cassa-12,15-dien-2-one generic -metabolite KEGG:C21829 ent-Cassa-12,15-diene-2beta,3beta-diol generic -metabolite KEGG:C21830 11,20-Dihydroxyferruginol generic -metabolite KEGG:C21831 ent-2alpha,3alpha-Dihydroxyisokaurene generic -metabolite KEGG:C21832 (4S)- 2,3-Dehydroflavan-3,4-diol generic -metabolite KEGG:C21833 Kaempferol-3-O-rutinoside generic -metabolite KEGG:C21834 (4Z,8Z)-4,8-Dimethyl-12-oxotrideca-4,8-dienal generic -metabolite KEGG:C21835 12,18-Didecarboxysiroheme generic -metabolite KEGG:C21836 meso-Zeaxanthin generic -metabolite KEGG:C21837 3-Geranyl-3-[(Z)-2-isocyanoethenyl]-1H-indole generic -metabolite KEGG:C21838 Hapalindole H generic -metabolite KEGG:C21839 12-epi-Hapalindole U generic -metabolite KEGG:C21840 12-epi-Fischerindole U generic -metabolite KEGG:C21841 11-Oxocucurbitadienol generic -metabolite KEGG:C21842 11-Hydroxycucurbitadienol generic -metabolite KEGG:C21843 Drimendiol generic -metabolite KEGG:C21844 Adenine in mRNA generic -metabolite KEGG:C21845 N6-Methyladenine in mRNA generic -metabolite KEGG:C21846 Sordaricin generic -metabolite KEGG:C21847 4'-O-Demethylsordarin generic -metabolite KEGG:C21848 GDP-6-deoxy-alpha-D-altrose generic -metabolite KEGG:C21849 4-O-(2-N-Acetyl-beta-D-glucosaminyl-D-ribitylphospho)n-di[(2R)-1-glycerophospho]-N-acetyl-beta-D-mannosaminyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21850 3-Bromo-4-hydroxybenzoate generic -metabolite KEGG:C21851 Pyridinium-3,5-biscarboxylic acid mononucleotide generic -metabolite KEGG:C21852 3,5-Dibromobenzene-1,2-diol generic -metabolite KEGG:C21853 3-Bromo-4,5-dihydroxybenzoate generic -metabolite KEGG:C21854 Kaempferol 3-O-rhamnoside-7-O-glucoside generic -metabolite KEGG:C21855 5-Chloro-1H-pyrrole-2-carbonyl-[peptidyl-carrier protein] generic -metabolite KEGG:C21856 4,5-Dichloro-1H-pyrrole-2-carbonyl-[peptidyl-carrier protein] generic -metabolite KEGG:C21858 N-(4-Oxoglutaryl)-L-cysteinylglycine generic -metabolite KEGG:C21859 cis-3-[2,2-Dichloro-1-(4-chlorophenyl)vinyl]-6-chlorocyclohexa-3,5-diene-1,2-diol generic -metabolite KEGG:C21860 3-Demethylubiquinol generic -metabolite KEGG:C21861 [Protein]-dehydroalanine generic -metabolite KEGG:C21862 5-Bromo-1H-pyrrole-2-carbonyl-[peptidyl-carrier protein] generic -metabolite KEGG:C21863 4,5-Dibromo-1H-pyrrole-2-carbonyl-[peptidyl-carrier protein] generic -metabolite KEGG:C21864 3,4,5-Tribromo-1H-pyrrole-2-carbonyl-[peptidyl-carrier protein] generic -metabolite KEGG:C21865 5-Chloro-L-tryptophan generic -metabolite KEGG:C21866 6-Chloro-L-tryptophan generic -metabolite KEGG:C21867 6-Chloro-D-tryptophan generic -metabolite KEGG:C21868 6,7-Dichloro-L-tryptophan generic -metabolite KEGG:C21869 4-O-[(2-beta-D-Glucosyl-1-D-ribitylphospho)n-(1-D-ribitylphospho)-(2R)-1-glycerophospho]-N-acetyl-beta-D-mannosaminyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21870 4-O-(2-N-Acetyl-alpha-D-glucosaminyl-D-ribitylphospho)n-di[(2R)-1-glycerophospho]-N-acetyl-beta-D-mannosaminyl-(1->4)-N-acetyl-alpha-D-glucosaminyl-diphospho-ditrans,octacis-undecaprenol generic -metabolite KEGG:C21871 (E)-omega-(Methylthio)alkyl-thiohydroximate generic -metabolite KEGG:C21872 Aliphatic desulfoglucosinolate generic -metabolite KEGG:C21873 2-Methylquinolin-4-ol generic -metabolite KEGG:C21874 Aurachin B epoxide generic -metabolite KEGG:C21875 Aurachin A generic -metabolite KEGG:C21876 Fenbendazole generic -metabolite KEGG:C21877 5-Carboxy-1-(5-O-phospho-beta-D-ribofuranosyl)pyridin-1-ium-3-carbonyl adenylate generic -metabolite KEGG:C21878 Pyridinium-3-carboxy-5-thiocarboxylic acid mononucleotide generic -metabolite KEGG:C21879 1-(5-O-Phospho-beta-D-ribofuranosyl)-5-(sulfanylcarbonyl)pyridin-1-ium-3-carbonyl adenylate generic -metabolite KEGG:C21880 [Protein]-S-[5-carboxy-1-(5-O-phosphono-beta-D-ribofuranosyl)pyridin-1-ium-3-carbonyl]-L-cysteine generic -metabolite KEGG:C21881 [Protein]-S-[1-(5-O-phosphono-beta-D-ribofuranosyl)-5-(sulfanylcarbonyl)pyridin-1-ium-3-carbonyl]-L-cysteine generic -metabolite KEGG:C21882 Fenbendazole S-oxide generic -metabolite KEGG:C21883 Hydroxyalbendazole generic -metabolite KEGG:C21884 4'-Hydroxyfenbendazole generic -metabolite KEGG:C21885 omega-Hydroxy-beta-dihydromenaquinone-9 generic -metabolite KEGG:C21886 omega-Hydroxy-long-chain fatty acid generic -metabolite KEGG:C21887 Rhizobitoxine generic -metabolite KEGG:C21888 Dihydrorhizobitoxine generic -metabolite KEGG:C21889 (2S)-3-(4-Hydroxyphenyl)-2-isocyanopropanoate generic -metabolite KEGG:C21890 4-[(E)-2-Isocyanoethenyl]phenol generic -metabolite KEGG:C21891 (2E)-3-(4-Hydroxyphenyl)-2-isocyanoprop-2-enoate generic -metabolite KEGG:C21892 (2S)-3-(1H-Indol-3-yl)-2-isocyanopropanoate generic -metabolite KEGG:C21893 3-[(Z)-2-Isocyanoethenyl]-1H-indole generic -metabolite KEGG:C21894 3-[(E)-2-Isocyanoethenyl]-1H-indole generic -metabolite KEGG:C21895 2-Acetylphloroglucinol generic -metabolite KEGG:C21896 2,4-Diacetylphloroglucinol generic -metabolite KEGG:C21897 Dihydrochanoclavine-I aldehyde generic -metabolite KEGG:C21898 [SoxY protein]-S-sulfanyl-L-cysteine generic -metabolite KEGG:C21899 [SoxY protein]-S-(2-sulfodisulfanyl)-L-cysteine generic -metabolite KEGG:C21900 [SAMP]-Gly-Gly generic -metabolite KEGG:C21901 [SAMP]-Gly-Gly-AMP generic -metabolite KEGG:C21902 Dolichyl beta-D-glucuronosyl-(1->3)-beta-D-glucosyl phosphate generic -metabolite KEGG:C21903 Delta9-Tetrahydrocannabinolate generic -metabolite KEGG:C21904 Trehalose monomycolate generic -metabolite KEGG:C21905 3-Oxocholan-24-oyl-CoA generic -metabolite KEGG:C21906 3-Oxochol-4-en-24-oyl-CoA generic -metabolite KEGG:C21907 12alpha-Hydroxy-3-oxocholan-24-oyl-CoA generic -metabolite KEGG:C21908 12alpha-Hydroxy-3-oxochol-4-en-24-oyl-CoA generic -metabolite KEGG:C21909 7alpha-Hydroxy-3-oxochol-24-oyl-CoA generic -metabolite KEGG:C21910 7alpha,12alpha-Dihydroxy-3-oxochol-24-oyl-CoA generic -metabolite KEGG:C21911 7beta-Hydroxy-3-oxochol-24-oyl-CoA generic -metabolite KEGG:C21912 7beta-Hydroxy-3-oxochol-4-en-24-oyl-CoA generic -metabolite KEGG:C21913 Dihydro-4-coumaroyl-CoA generic -metabolite KEGG:C21914 Dihydroferuloyl-CoA generic -metabolite KEGG:C21915 Carotenoid beta-end group generic -metabolite KEGG:C21916 Carotenoid phi-end group generic -metabolite KEGG:C21917 Carotenoid chi-end group generic -metabolite KEGG:C21918 14alpha-Methylsteroid generic -metabolite KEGG:C21919 Delta14-Steroid generic -metabolite KEGG:C21920 14alpha-Hydroxymethylsteroid generic -metabolite KEGG:C21921 14alpha-Formylsteroid generic -metabolite KEGG:C21922 6alpha-Hydroxygermacra-1(10),4,11(13)-trien-12-oate generic -metabolite KEGG:C21923 9-Hydroxy-12-oxo-10(E),15(Z)-octadecadienoic acid generic -metabolite KEGG:C21924 9-Hydroxy-12-oxo-15(Z)-octadecenoic acid generic -metabolite KEGG:C21925 Medium-chain fatty acid generic -metabolite KEGG:C21926 Medium-chain acyl-CoA generic -metabolite KEGG:C21927 Medium-chain acyl-[acyl-carrier protein] generic -metabolite KEGG:C21928 (2Z,4E)-4-Amino-6-oxohepta-2,4-dienedioate generic -metabolite KEGG:C21929 (-)-Bornane-2,5-dione generic -metabolite KEGG:C21930 (-)-5-Oxo-1,2-campholide generic -metabolite KEGG:C21931 Cerotic acid generic -metabolite KEGG:C21932 Cerotoyl-CoA generic -metabolite KEGG:C21933 Montanic acid generic -metabolite KEGG:C21934 Montanoyl-CoA generic -metabolite KEGG:C21935 (6Z,9Z)-Octadecadienoyl-CoA generic -metabolite KEGG:C21936 (8Z,11Z)-Icosadienoic acid generic -metabolite KEGG:C21937 (8Z,11Z)-Icosadienoyl-CoA generic -metabolite KEGG:C21938 Mead acid generic -metabolite KEGG:C21939 (5Z,8Z,11Z)-Icosatrienoyl-CoA generic -metabolite KEGG:C21940 (7Z,10Z,13Z)-Docosatrienoic acid generic -metabolite KEGG:C21941 (7Z,10Z,13Z)-Docosatrienoyl-CoA generic -metabolite KEGG:C21942 Sapienic acid generic -metabolite KEGG:C21943 Sapienoyl-CoA generic -metabolite KEGG:C21944 cis-Vaccenic acid generic -metabolite KEGG:C21945 cis-Vaccenoyl-CoA generic -metabolite KEGG:C21946 Paullinic acid generic -metabolite KEGG:C21947 Paullinoyl-CoA generic -metabolite KEGG:C21948 Shibic acid generic -metabolite KEGG:C21949 (11Z,14Z,17Z,20Z,23Z)-Hexacosapentaenoyl-CoA generic -metabolite KEGG:C21950 (13Z,16Z,19Z,22Z,25Z)-Octacosapentaenoic acid generic -metabolite KEGG:C21951 (13Z,16Z,19Z,22Z,25Z)-Octacosapentaenoyl-CoA generic -metabolite KEGG:C21952 (8Z,11Z,14Z,17Z,20Z,23Z)-Hexacosahexaenoic acid generic -metabolite KEGG:C21953 (8Z,11Z,14Z,17Z,20Z,23Z)-Hexacosahexaenoyl-CoA generic -metabolite KEGG:C21954 (+)-Piperitol generic -metabolite KEGG:C21955 L-Galactono-1,5-lactone generic -metabolite KEGG:C21956 1,6-Didemethyltoxoflavin generic -metabolite KEGG:C21957 Reumycin generic -metabolite KEGG:C21958 (10Z,13Z,16Z,19Z,22Z,25Z)-Octacosahexaenoic acid generic -metabolite KEGG:C21959 (10Z,13Z,16Z,19Z,22Z,25Z)-Octacosahexaenoyl-CoA generic -metabolite KEGG:C21960 (11Z,14Z,17Z,20Z)-Hexacosatetraenoic acid generic -metabolite KEGG:C21961 (11Z,14Z,17Z,20Z)-Hexacosatetraenoyl-CoA generic -metabolite KEGG:C21962 (13Z,16Z,19Z,22Z)-Octacosatetraenoic acid generic -metabolite KEGG:C21963 (13Z,16Z,19Z,22Z)-Octacosatetraenoyl-CoA generic -metabolite KEGG:C21964 (8Z,11Z,14Z,17Z,20Z)-Hexacosapentaenoic acid generic -metabolite KEGG:C21965 (8Z,11Z,14Z,17Z,20Z)-Hexacosapentaenoyl-CoA generic -metabolite KEGG:C21966 (10Z,13Z,16Z,19Z,22Z)-Octacosapentaenoic acid generic -metabolite KEGG:C21967 (10Z,13Z,16Z,19Z,22Z)-Octacosapentaenoyl-CoA generic -metabolite KEGG:C21968 2-O-[alpha-D-Glucopyranosyl-(1->6)-alpha-D-glucopyranosyl]-D-glycerate generic -metabolite KEGG:C21969 2-O-[6-O-Octanoyl-alpha-D-glucopyranosyl-(1->6)-alpha-D-glucopyranosyl]-D-glycerate generic -metabolite KEGG:C21970 2-Acylphloroglucinol 1-O-beta-D-glucoside generic -metabolite KEGG:C21971 5-Amino-5-(4-hydroxybenzyl)-6-(D-ribitylimino)-5,6-dihydrouracil generic -metabolite KEGG:C21972 [SoxY protein]-L-cysteine generic -metabolite KEGG:C21973 Hapalindole U generic -metabolite KEGG:C21974 Hapalindole G generic -metabolite KEGG:C21975 12-epi-Fischerindole G generic -metabolite KEGG:C21976 L-Threonyl-[L-threonyl-carrier protein] generic -metabolite KEGG:C21977 4-Chloro-L-threonyl-[L-threonyl-carrier protein] generic -metabolite KEGG:C21978 Cyclooctat-9-ene-5,7-diol generic -metabolite KEGG:C21979 Cyclooctatin generic -metabolite KEGG:C21980 (6Z,9Z)-Hexadecadienoic acid generic -metabolite KEGG:C21981 (6Z,9Z)-Hexadecadienoyl-CoA generic -metabolite KEGG:C21982 Lipid IVB generic -metabolite KEGG:C21983 Deacyl-lipid IVB generic -metabolite KEGG:C21984 Deacyl-lipid IVA generic -metabolite KEGG:C21985 Penta-acylated lipid A generic -metabolite KEGG:C21986 Penta-acylated KDO-lipid A generic -metabolite KEGG:C21987 Penta-acylated KDO2-lipid A generic -metabolite KEGG:C21988 Hexa-acylated KDO2-lipid A generic -metabolite KEGG:C21991 Palmitoleoyl-myristoyl-KDO2-lipid A generic -metabolite KEGG:C21992 3'-O-Deacylated KDO2-lipid A generic -metabolite KEGG:C21993 C16-KDO2-lipid A generic -metabolite KEGG:C21994 1-Dephospho-KDO2-lipid A generic -metabolite KEGG:C21995 1-PEtN-KDO2-lipid A generic -metabolite KEGG:C21996 1-PEtN-KDO-lipid A generic -metabolite KEGG:C21997 4'-Dephosphorylated 1-PEtN-KDO-lipid A generic -metabolite KEGG:C21998 H. pylori KDO-lipid A generic -metabolite KEGG:C21999 Acyl-KDO2-lipid IVA generic -metabolite KEGG:C22000 (R)-3-(Tetradecanoyloxy)tetradecanoic acid generic -metabolite KEGG:C22001 (R)-3-Hydroxymyristic acid generic -metabolite KEGG:C22002 Lipid IIB generic -metabolite KEGG:C22003 (S)-2-Hydroxymyristate-modified lipid A generic -metabolite KEGG:C22005 2-Hydroxyflavanone generic -metabolite KEGG:C22006 (R)-(Indol-3-yl)lactate generic -metabolite KEGG:C22007 Sideretin generic -metabolite KEGG:C22008 Dolabradiene generic -metabolite KEGG:C22009 15,16-Epoxydolabrene generic -metabolite KEGG:C22010 3beta-Hydroxy-15,16-epoxydolabrene generic -metabolite KEGG:C22011 Zealexin A1 generic -metabolite KEGG:C22012 [(4S)-4-(5,5-Dimethylcyclohex-1-en-1-yl)-cyclohex-1-en-1-yl]methanol generic -metabolite KEGG:C22013 (4S)-4-(5,5-Dimethylcyclohex-1-en-1-yl)cyclohex-1-ene-1-carbaldehyde generic -metabolite KEGG:C22014 7-Deoxyloganetic alcohol generic -metabolite KEGG:C22015 Indole-3-carbonyl nitrile generic -metabolite KEGG:C22016 4-Hydroxyindole-3-carbonyl nitrile generic -metabolite KEGG:C22017 1-Hexacosanoyl-2-acyl-[phosphoglycerolipid] generic -metabolite KEGG:C22018 1-[(17Z)-Hexacos-17-enoyl]-2-acyl-[phosphoglycerolipid] generic -metabolite KEGG:C22019 1-Tetracosanoyl-2-acyl-[phosphoglycerolipid] generic -metabolite KEGG:C22020 1-[(15Z)-Tetracos-15-enoyl]-2-acyl-[phosphoglycerolipid] generic -metabolite KEGG:C22021 L-Tyrosinal generic -metabolite KEGG:C22022 trans-Delta2-Meromycolyl-[acyl-carrier protein] generic -metabolite KEGG:C22023 Meromycolyl-[acyl-carrier protein] generic -metabolite KEGG:C22024 Staphylopine generic -metabolite KEGG:C22025 (2S)-2-Amino-4-{[(1R)-1-carboxy-2-(1H-imidazol-4-yl)ethyl]amino}butanoate generic -metabolite KEGG:C22026 (R)-3-(Tetradecanoyloxy)hexadecanoic acid generic -metabolite KEGG:C22027 8-Methylmenaquinone generic -metabolite KEGG:C22028 2-Demethyl-8-methylmenaquinone generic -metabolite KEGG:C22029 alpha-D-Galactosamine 1-phosphate generic -metabolite KEGG:C22030 5-Amino-1-(beta-D-ribosyl)imidazole generic -metabolite KEGG:C22031 Cytidine 5'-diphosphoramidate generic -metabolite KEGG:C22032 Cytidine 3'-phospho-5'-diphosphoramidate generic -metabolite KEGG:C22033 N5-(Cytidine 5'-diphosphoramidyl)-L-glutamine generic -metabolite KEGG:C22034 D-Xylono-1,4-lactone 5-phosphate generic -metabolite KEGG:C22035 5-Phospho-D-xylonate generic -metabolite KEGG:C22036 L-Arabino-1,4-lactone 5-phosphate generic -metabolite KEGG:C22037 5-Phospho-L-arabinate generic -metabolite KEGG:C22038 (R)-3-(3,4-Dihydroxyphenyl)lactate generic -metabolite KEGG:C22039 2-Carboxy-1,4-naphthoquinone generic -metabolite KEGG:C22040 S-Methyl-L-cysteine generic -metabolite KEGG:C22041 Acifluorfen generic -metabolite KEGG:C22042 Pyribencarb generic diff --git a/code/reasoningtool/kg-construction/neo4j-backup.sh b/code/reasoningtool/kg-construction/neo4j-backup.sh deleted file mode 100755 index edb8335fe..000000000 --- a/code/reasoningtool/kg-construction/neo4j-backup.sh +++ /dev/null @@ -1,67 +0,0 @@ -#!/bin/sh - -### BEGIN INTRO -# Function: This script is to dump the Neo4j database and transfer the backup file to http://rtxkgdump.saramsey.org/ -# Instance: 'rtxsteve' docker container in 'rtxsteve.saramesy.org' instance -# Where to run the script: any directory -# Who can run the script: root -# How to run the script: sh neo4j-backup.sh -# The backup files will be stored in the /var/www/html folder of the 'rtxkgdump.saramsey.org' instance. -# The backup files can be accessed in http://rtxkgdump.saramsey.org/ -# -# How to run it: -# ssh ubuntu@rtxsteve.saramsey.org -# screen (backup can take a while; best to run in a "screen" session) -# sudo docker start rtxsteve (if the rtxsteve container is not already running) -# sudo docker exec -it rtxsteve /usr/bin/sudo -H -u rt bash -c 'cd ~/kg-construction && git pull origin master' -# sudo docker exec rtxsteve /mnt/data/orangeboard/RTX/code/reasoningtool/kg-construction/neo4j-backup.sh -# -### END INTRO - -### BEGIN PREREQUISITE -# folder and file permissions on 'rtxkgdump.saramsey.org' instance -# user: ubuntu -# command: -# sudo chown -R ubuntu:ubuntu /var/www/html -# sudo chmod -R 755 /var/www/html -### END PREREQUISITE - -### BEGIN HOW TO LOAD -# command: -# neo4j-admin load --from=[absolute directory]/xxxx.dump --database=graph --force -# ref: https://neo4j.com/docs/operations-manual/current/tools/dump-load/ -### END HOW TO LOAD - -# Author: Deqing Qu - -set -e - -file=`date '+%Y%m%d-%H%M%S'` - -wall Neo4j will be shut down - -echo 'shut down Neo4j ...' -service neo4j stop - -echo 'start backup ...' -if [ ! -d "/mnt/data/backup/" ]; then - mkdir /mnt/data/backup/ -fi -neo4j-admin dump --database=graph --to=/mnt/data/backup/$file.dump - -echo 'backup complete ...' -echo 'start Neo4j ...' -service neo4j start - -echo 'zip the backup file ...' -cd /mnt/data/backup/ -tar -czvf $file.tar.gz $file.dump -rm $file.dump - -echo 'start transfering the backup file ...' -chown rt:rt $file.tar.gz -su - rt -c "scp /mnt/data/backup/$file.tar.gz ubuntu@steveneo4j.rtx.ai:/var/www/html" - -echo 'file transfer complete ...' - - diff --git a/code/reasoningtool/kg-construction/nodes_id_name.csv b/code/reasoningtool/kg-construction/nodes_id_name.csv deleted file mode 100644 index d4f4d5ea1..000000000 --- a/code/reasoningtool/kg-construction/nodes_id_name.csv +++ /dev/null @@ -1,69186 +0,0 @@ -"id","name" -"GO:1904636","response to ionomycin" -"GO:0014819","regulation of skeletal muscle contraction" -"GO:0046361","2-oxobutyrate metabolic process" -"GO:0035899","negative regulation of blood coagulation in other organism" -"GO:0046951","ketone body biosynthetic process" -"GO:0051790","short-chain fatty acid biosynthetic process" -"GO:0015800","acidic amino acid transport" -"GO:1901897","regulation of relaxation of cardiac muscle" -"GO:0015885","5-formyltetrahydrofolate transport" -"GO:0061389","regulation of direction of cell growth" -"GO:1903690","negative regulation of wound healing, spreading of epidermal cells" -"GO:0006685","sphingomyelin catabolic process" -"GO:1902145","regulation of response to cell cycle checkpoint signaling" -"GO:1903206","negative regulation of hydrogen peroxide-induced cell death" -"GO:0010591","regulation of lamellipodium assembly" -"GO:0045366","regulation of interleukin-13 biosynthetic process" -"GO:0090720","primary adaptive immune response" -"GO:1902251","negative regulation of erythrocyte apoptotic process" -"GO:0045528","regulation of interleukin-24 biosynthetic process" -"GO:0009143","nucleoside triphosphate catabolic process" -"GO:1900067","regulation of cellular response to alkaline pH" -"GO:0045081","negative regulation of interleukin-10 biosynthetic process" -"GO:0010646","regulation of cell communication" -"GO:0060292","long term synaptic depression" -"GO:1905881","positive regulation of oogenesis" -"GO:0019605","butyrate metabolic process" -"GO:2000193","positive regulation of fatty acid transport" -"GO:0009647","skotomorphogenesis" -"GO:1904251","regulation of bile acid metabolic process" -"GO:0045384","regulation of interleukin-19 biosynthetic process" -"GO:0019090","mitochondrial rRNA export from mitochondrion" -"GO:0006085","acetyl-CoA biosynthetic process" -"GO:0000101","sulfur amino acid transport" -"GO:0002404","antigen sampling in mucosal-associated lymphoid tissue" -"GO:1900259","regulation of RNA-directed 5'-3' RNA polymerase activity" -"GO:0048631","regulation of skeletal muscle tissue growth" -"GO:0071689","muscle thin filament assembly" -"GO:0060237","regulation of fungal-type cell wall organization" -"GO:0000272","polysaccharide catabolic process" -"GO:2000236","negative regulation of tRNA processing" -"GO:1905613","regulation of developmental vegetative growth" -"GO:0009594","detection of nutrient" -"GO:0031344","regulation of cell projection organization" -"GO:2000567","regulation of memory T cell activation" -"GO:0052548","regulation of endopeptidase activity" -"GO:1902423","regulation of attachment of mitotic spindle microtubules to kinetochore" -"GO:0019687","pyruvate biosynthetic process from acetate" -"GO:0055097","high density lipoprotein particle mediated signaling" -"GO:1904322","cellular response to forskolin" -"GO:0035528","UDP-N-acetylglucosamine biosynthesis involved in chitin biosynthesis" -"GO:0060737","prostate gland morphogenetic growth" -"GO:1903913","regulation of fusion of virus membrane with host plasma membrane" -"GO:0031953","negative regulation of protein autophosphorylation" -"GO:0045777","positive regulation of blood pressure" -"GO:1904078","positive regulation of estrogen biosynthetic process" -"GO:0097751","spore-bearing structure formation" -"GO:0031125","rRNA 3'-end processing" -"GO:1903023","regulation of ascospore-type prospore membrane assembly" -"GO:0048459","floral whorl structural organization" -"GO:1903954","positive regulation of voltage-gated potassium channel activity involved in atrial cardiac muscle cell action potential repolarization" -"GO:0010901","regulation of very-low-density lipoprotein particle remodeling" -"GO:0070253","somatostatin secretion" -"GO:1901223","negative regulation of NIK/NF-kappaB signaling" -"GO:0007541","sex determination, primary response to X:A ratio" -"GO:1903171","carbon dioxide homeostasis" -"GO:0045871","negative regulation of rhodopsin gene expression" -"GO:0051339","regulation of lyase activity" -"GO:0032455","nerve growth factor processing" -"GO:1903118","urate homeostasis" -"GO:0010372","positive regulation of gibberellin biosynthetic process" -"GO:0043165","Gram-negative-bacterium-type cell outer membrane assembly" -"GO:0050686","negative regulation of mRNA processing" -"GO:0019475","L-lysine catabolic process to acetate" -"GO:1901911","adenosine 5'-(hexahydrogen pentaphosphate) catabolic process" -"GO:0002121","inter-male aggressive behavior" -"GO:1905371","ceramide phosphoethanolamine metabolic process" -"GO:0070093","negative regulation of glucagon secretion" -"GO:0070507","regulation of microtubule cytoskeleton organization" -"GO:0007265","Ras protein signal transduction" -"GO:0007050","cell cycle arrest" -"GO:1903329","regulation of iron-sulfur cluster assembly" -"GO:0046519","sphingoid metabolic process" -"GO:0001178","regulation of transcriptional start site selection at RNA polymerase II promoter" -"GO:1903385","regulation of homophilic cell adhesion" -"GO:0044779","meiotic spindle checkpoint" -"GO:1905793","protein localization to pericentriolar material" -"GO:0050822","peptide stabilization" -"GO:1901913","regulation of capsule organization" -"GO:0044879","morphogenesis checkpoint" -"GO:1903456","positive regulation of androst-4-ene-3,17-dione biosynthetic process" -"GO:0036331","avascular cornea development in camera-type eye" -"GO:0043648","dicarboxylic acid metabolic process" -"GO:0060884","clearance of cells from fusion plate" -"GO:0060493","mesenchymal-endodermal cell signaling involved in lung induction" -"GO:0010072","primary shoot apical meristem specification" -"GO:0006461","protein complex assembly" -"GO:0045704","regulation of salivary gland boundary specification" -"GO:0033519","phytyl diphosphate metabolic process" -"GO:1902706","hexose catabolic process to acetate" -"GO:0001754","eye photoreceptor cell differentiation" -"GO:0002737","negative regulation of plasmacytoid dendritic cell cytokine production" -"GO:0044743","protein transmembrane import into intracellular organelle" -"GO:0030707","ovarian follicle cell development" -"GO:0120061","negative regulation of gastric emptying" -"GO:0050804","modulation of chemical synaptic transmission" -"GO:0043012","regulation of fusion of sperm to egg plasma membrane" -"GO:0071609","chemokine (C-C motif) ligand 5 production" -"GO:0034153","positive regulation of toll-like receptor 6 signaling pathway" -"GO:0060142","regulation of syncytium formation by plasma membrane fusion" -"GO:0019043","establishment of viral latency" -"GO:0046902","regulation of mitochondrial membrane permeability" -"GO:0061635","regulation of protein complex stability" -"GO:0045176","apical protein localization" -"GO:1990571","meiotic centromere clustering" -"GO:2000939","regulation of plant-type cell wall cellulose catabolic process" -"GO:0099075","mitochondrion-derived vesicle mediated transport" -"GO:0033076","isoquinoline alkaloid metabolic process" -"GO:0048508","embryonic meristem development" -"GO:0043180","rhythmic inhibition" -"GO:1904437","positive regulation of transferrin receptor binding" -"GO:1900104","regulation of hyaluranon cable assembly" -"GO:0034124","regulation of MyD88-dependent toll-like receptor signaling pathway" -"GO:0030003","cellular cation homeostasis" -"GO:0045601","regulation of endothelial cell differentiation" -"GO:0070757","interleukin-35-mediated signaling pathway" -"GO:0010451","floral meristem growth" -"GO:0032099","negative regulation of appetite" -"GO:0042386","hemocyte differentiation" -"GO:0006182","cGMP biosynthetic process" -"GO:0009231","riboflavin biosynthetic process" -"GO:2001223","negative regulation of neuron migration" -"GO:1904300","positive regulation of transcytosis" -"GO:0035278","miRNA mediated inhibition of translation" -"GO:0097274","urea homeostasis" -"GO:0106001","intestinal hexose absorption" -"GO:0009642","response to light intensity" -"GO:1901891","regulation of cell septum assembly" -"GO:0035266","meristem growth" -"GO:0031620","regulation of fever generation" -"GO:1901909","diadenosine hexaphosphate catabolic process" -"GO:0036103","Kdo2-lipid A metabolic process" -"GO:0080112","seed growth" -"GO:0045338","farnesyl diphosphate metabolic process" -"GO:1902047","polyamine transmembrane transport" -"GO:1901632","regulation of synaptic vesicle membrane organization" -"GO:0010228","vegetative to reproductive phase transition of meristem" -"GO:0036208","negative regulation of histone gene expression" -"GO:1900004","negative regulation of serine-type endopeptidase activity" -"GO:0070407","oxidation-dependent protein catabolic process" -"GO:0007497","posterior midgut development" -"GO:0072362","regulation of glycolytic process by negative regulation of transcription from RNA polymerase II promoter" -"GO:0060515","prostate field specification" -"GO:0140042","lipid droplet formation" -"GO:0009648","photoperiodism" -"GO:0034127","regulation of MyD88-independent toll-like receptor signaling pathway" -"GO:2001009","regulation of plant-type cell wall cellulose biosynthetic process" -"GO:0038163","thrombopoietin-mediated signaling pathway" -"GO:0050917","sensory perception of umami taste" -"GO:0051129","negative regulation of cellular component organization" -"GO:0007195","adenylate cyclase-inhibiting dopamine receptor signaling pathway" -"GO:0050711","negative regulation of interleukin-1 secretion" -"GO:0030476","ascospore wall assembly" -"GO:0033483","gas homeostasis" -"GO:0032014","positive regulation of ARF protein signal transduction" -"GO:1990918","double-strand break repair involved in meiotic recombination" -"GO:2001186","negative regulation of CD8-positive, alpha-beta T cell activation" -"GO:0051971","positive regulation of transmission of nerve impulse" -"GO:0007204","positive regulation of cytosolic calcium ion concentration" -"GO:0002200","somatic diversification of immune receptors" -"GO:1903772","regulation of viral budding via host ESCRT complex" -"GO:0007294","germarium-derived oocyte fate determination" -"GO:0010252","auxin homeostasis" -"GO:0002420","natural killer cell mediated cytotoxicity directed against tumor cell target" -"GO:2000654","regulation of cellular response to testosterone stimulus" -"GO:0021937","cerebellar Purkinje cell-granule cell precursor cell signaling involved in regulation of granule cell precursor cell proliferation" -"GO:0034058","endosomal vesicle fusion" -"GO:0055017","cardiac muscle tissue growth" -"GO:0021526","medial motor column neuron differentiation" -"GO:1901075","negative regulation of engulfment of apoptotic cell" -"GO:0048266","behavioral response to pain" -"GO:1903391","regulation of adherens junction organization" -"GO:0097337","response to ziprasidone" -"GO:0010705","meiotic DNA double-strand break processing involved in reciprocal meiotic recombination" -"GO:0099145","regulation of exocytic insertion of neurotransmitter receptor to postsynaptic membrane" -"GO:0051130","positive regulation of cellular component organization" -"GO:0097273","creatinine homeostasis" -"GO:1990762","cytoplasmic alanyl-tRNA aminoacylation" -"GO:1900194","negative regulation of oocyte maturation" -"GO:0045654","positive regulation of megakaryocyte differentiation" -"GO:1905468","regulation of clathrin-coated pit assembly" -"GO:0051884","regulation of timing of anagen" -"GO:0042045","epithelial fluid transport" -"GO:1902699","pentose catabolic process to acetate" -"GO:0002301","CD4-positive, alpha-beta intraepithelial T cell differentiation" -"GO:0032812","positive regulation of epinephrine secretion" -"GO:1903774","positive regulation of viral budding via host ESCRT complex" -"GO:0002440","production of molecular mediator of immune response" -"GO:0048504","regulation of timing of animal organ formation" -"GO:0090214","spongiotrophoblast layer developmental growth" -"GO:0086100","endothelin receptor signaling pathway" -"GO:0045733","acetate catabolic process" -"GO:0042446","hormone biosynthetic process" -"GO:1901907","diadenosine pentaphosphate catabolic process" -"GO:0002252","immune effector process" -"GO:0048219","inter-Golgi cisterna vesicle-mediated transport" -"GO:0033986","response to methanol" -"GO:0001890","placenta development" -"GO:0036107","4-amino-4-deoxy-alpha-L-arabinopyranosyl undecaprenyl phosphate metabolic process" -"GO:0010365","positive regulation of ethylene biosynthetic process" -"GO:1905002","positive regulation of membrane repolarization during atrial cardiac muscle cell action potential" -"GO:0021740","principal sensory nucleus of trigeminal nerve development" -"GO:0015842","aminergic neurotransmitter loading into synaptic vesicle" -"GO:1903618","regulation of transdifferentiation" -"GO:0007306","eggshell chorion assembly" -"GO:0071543","diphosphoinositol polyphosphate metabolic process" -"GO:0045969","positive regulation of juvenile hormone biosynthetic process" -"GO:0032465","regulation of cytokinesis" -"GO:0009588","UV-A, blue light phototransduction" -"GO:0007295","growth of a germarium-derived egg chamber" -"GO:0032964","collagen biosynthetic process" -"GO:1902872","regulation of horizontal cell localization" -"GO:0098786","biofilm matrix disassembly" -"GO:0032670","regulation of interleukin-26 production" -"GO:0008062","eclosion rhythm" -"GO:1904694","negative regulation of vascular smooth muscle contraction" -"GO:0032653","regulation of interleukin-10 production" -"GO:1901989","positive regulation of cell cycle phase transition" -"GO:0032664","regulation of interleukin-20 production" -"GO:0060222","regulation of retinal cone cell fate commitment" -"GO:0003062","regulation of heart rate by chemical signal" -"GO:0099557","trans-synaptic signaling by trans-synaptic complex, modulating synaptic transmission" -"GO:2000263","regulation of blood coagulation, extrinsic pathway" -"GO:0030199","collagen fibril organization" -"GO:0072089","stem cell proliferation" -"GO:0038017","Wnt receptor internalization" -"GO:1903762","positive regulation of voltage-gated potassium channel activity involved in ventricular cardiac muscle cell action potential repolarization" -"GO:0061323","cell proliferation involved in heart morphogenesis" -"GO:0022410","circadian sleep/wake cycle process" -"GO:0032676","regulation of interleukin-7 production" -"GO:2000690","regulation of cardiac muscle cell myoblast differentiation" -"GO:0048817","negative regulation of hair follicle maturation" -"GO:0061417","negative regulation of transcription from RNA polymerase II promoter in response to oxidative stress" -"GO:0006528","asparagine metabolic process" -"GO:0061376","mammillotegmental axonal tract development" -"GO:1904540","positive regulation of glycolytic process through fructose-6-phosphate" -"GO:0035284","brain segmentation" -"GO:0035172","hemocyte proliferation" -"GO:1901845","negative regulation of cell communication by electrical coupling involved in cardiac conduction" -"GO:1905661","regulation of telomerase RNA reverse transcriptase activity" -"GO:0006829","zinc ion transport" -"GO:0061046","regulation of branching involved in lung morphogenesis" -"GO:1901841","regulation of high voltage-gated calcium channel activity" -"GO:0070341","fat cell proliferation" -"GO:1905025","negative regulation of membrane repolarization during ventricular cardiac muscle cell action potential" -"GO:0032655","regulation of interleukin-12 production" -"GO:0001834","trophectodermal cell proliferation" -"GO:0009742","brassinosteroid mediated signaling pathway" -"GO:1901735","(R)-mevalonic acid metabolic process" -"GO:1902869","regulation of amacrine cell differentiation" -"GO:1903589","positive regulation of blood vessel endothelial cell proliferation involved in sprouting angiogenesis" -"GO:0032678","regulation of interleukin-9 production" -"GO:0017121","phospholipid scrambling" -"GO:0090215","regulation of 1-phosphatidylinositol-4-phosphate 5-kinase activity" -"GO:1990654","sebum secreting cell proliferation" -"GO:0035881","amacrine cell differentiation" -"GO:0009683","indoleacetic acid metabolic process" -"GO:0015872","dopamine transport" -"GO:0050673","epithelial cell proliferation" -"GO:0032663","regulation of interleukin-2 production" -"GO:0010750","positive regulation of nitric oxide mediated signal transduction" -"GO:0030538","embryonic genitalia morphogenesis" -"GO:0071851","mitotic G1 cell cycle arrest in response to nitrogen starvation" -"GO:0045671","negative regulation of osteoclast differentiation" -"GO:0097377","spinal cord interneuron axon guidance" -"GO:0018924","mandelate metabolic process" -"GO:0002683","negative regulation of immune system process" -"GO:0045385","negative regulation of interleukin-19 biosynthetic process" -"GO:0010585","glutamine secretion" -"GO:0072190","ureter urothelium development" -"GO:0032443","regulation of ergosterol biosynthetic process" -"GO:0010463","mesenchymal cell proliferation" -"GO:0032643","regulation of connective tissue growth factor production" -"GO:0002067","glandular epithelial cell differentiation" -"GO:0052695","cellular glucuronidation" -"GO:0035622","intrahepatic bile duct development" -"GO:0017062","respiratory chain complex III assembly" -"GO:0060722","cell proliferation involved in embryonic placenta development" -"GO:0032118","horsetail-astral microtubule organization" -"GO:0007629","flight behavior" -"GO:0018871","1-aminocyclopropane-1-carboxylate metabolic process" -"GO:0061076","negative regulation of neural retina development" -"GO:0035736","cell proliferation involved in compound eye morphogenesis" -"GO:0033619","membrane protein proteolysis" -"GO:0032677","regulation of interleukin-8 production" -"GO:0010248","establishment or maintenance of transmembrane electrochemical gradient" -"GO:0060018","astrocyte fate commitment" -"GO:2000195","negative regulation of female gonad development" -"GO:0032662","regulation of interleukin-19 production" -"GO:1904816","positive regulation of protein localization to chromosome, telomeric region" -"GO:0090255","cell proliferation involved in imaginal disc-derived wing morphogenesis" -"GO:1905621","positive regulation of alpha-(1->3)-fucosyltransferase activity" -"GO:0080184","response to phenylpropanoid" -"GO:0009220","pyrimidine ribonucleotide biosynthetic process" -"GO:0090208","positive regulation of triglyceride metabolic process" -"GO:0009687","abscisic acid metabolic process" -"GO:0032652","regulation of interleukin-1 production" -"GO:0017185","peptidyl-lysine hydroxylation" -"GO:0010710","regulation of collagen catabolic process" -"GO:0043297","apical junction assembly" -"GO:0051248","negative regulation of protein metabolic process" -"GO:0003170","heart valve development" -"GO:0015315","organophosphate:inorganic phosphate antiporter activity" -"GO:0002921","negative regulation of humoral immune response" -"GO:2000503","positive regulation of natural killer cell chemotaxis" -"GO:0061075","positive regulation of neural retina development" -"GO:1904305","negative regulation of gastro-intestinal system smooth muscle contraction" -"GO:0008333","endosome to lysosome transport" -"GO:0002941","synoviocyte proliferation" -"GO:0006675","mannosyl-inositol phosphorylceramide metabolic process" -"GO:0072342","response to anion stress" -"GO:0036093","germ cell proliferation" -"GO:0061683","branching involved in seminal vesicle morphogenesis" -"GO:0032672","regulation of interleukin-3 production" -"GO:0021836","chemorepulsion involved in postnatal olfactory bulb interneuron migration" -"GO:0061351","neural precursor cell proliferation" -"GO:0070473","negative regulation of uterine smooth muscle contraction" -"GO:0072197","ureter morphogenesis" -"GO:0061447","endocardial cushion cell fate specification" -"GO:0032656","regulation of interleukin-13 production" -"GO:0019297","coenzyme B metabolic process" -"GO:0090288","negative regulation of cellular response to growth factor stimulus" -"GO:0033002","muscle cell proliferation" -"GO:0002018","renin-angiotensin regulation of aldosterone production" -"GO:0003419","growth plate cartilage chondrocyte proliferation" -"GO:0006063","uronic acid metabolic process" -"GO:0044347","cell wall polysaccharide catabolic process" -"GO:0032671","regulation of interleukin-27 production" -"GO:1904140","negative regulation of microglial cell migration" -"GO:0032668","regulation of interleukin-24 production" -"GO:0090221","mitotic spindle-templated microtubule nucleation" -"GO:1903817","negative regulation of voltage-gated potassium channel activity" -"GO:0050977","magnetoreception by sensory perception of chemical stimulus" -"GO:0050795","regulation of behavior" -"GO:0071335","hair follicle cell proliferation" -"GO:0070168","negative regulation of biomineral tissue development" -"GO:0060224","regulation of retinal rod cell fate commitment" -"GO:0070754","regulation of interleukin-35 production" -"GO:0002034","regulation of blood vessel diameter by renin-angiotensin" -"GO:0030152","bacteriocin biosynthetic process" -"GO:0060517","epithelial cell proliferation involved in prostatic bud elongation" -"GO:0071849","G1 cell cycle arrest in response to nitrogen starvation" -"GO:1905680","regulation of innate immunity memory response" -"GO:0070910","cell wall macromolecule catabolic process involved in cell wall disassembly" -"GO:0021521","ventral spinal cord interneuron specification" -"GO:1902261","positive regulation of delayed rectifier potassium channel activity" -"GO:1902497","iron-sulfur cluster transport" -"GO:0071504","cellular response to heparin" -"GO:0098901","regulation of cardiac muscle cell action potential" -"GO:0051026","chiasma assembly" -"GO:0009451","RNA modification" -"GO:0070661","leukocyte proliferation" -"GO:0071661","regulation of granzyme B production" -"GO:0051000","positive regulation of nitric-oxide synthase activity" -"GO:0031990","mRNA export from nucleus in response to heat stress" -"GO:0060451","negative regulation of hindgut contraction" -"GO:0033395","beta-alanine biosynthetic process via 3-hydroxypropionate" -"GO:0018898","2,4-dichlorobenzoate metabolic process" -"GO:2000793","cell proliferation involved in heart valve development" -"GO:0014009","glial cell proliferation" -"GO:0009694","jasmonic acid metabolic process" -"GO:1905484","negative regulation of motor neuron migration" -"GO:0007585","respiratory gaseous exchange" -"GO:0021868","ventricular zone cell-producing asymmetric radial glial cell division in forebrain" -"GO:2000621","regulation of DNA replication termination" -"GO:1904319","negative regulation of smooth muscle contraction involved in micturition" -"GO:0032666","regulation of interleukin-22 production" -"GO:0006625","protein targeting to peroxisome" -"GO:0019654","acetate fermentation" -"GO:0018217","peptidyl-aspartic acid phosphorylation" -"GO:1905003","picolinic acid metabolic process" -"GO:0032661","regulation of interleukin-18 production" -"GO:1904782","negative regulation of NMDA glutamate receptor activity" -"GO:0039531","regulation of viral-induced cytoplasmic pattern recognition receptor signaling pathway" -"GO:0007489","maintenance of imaginal histoblast diploidy" -"GO:0014733","regulation of skeletal muscle adaptation" -"GO:0048134","germ-line cyst formation" -"GO:0032119","sequestering of zinc ion" -"GO:0019922","protein-chromophore linkage via peptidyl-cysteine" -"GO:0032328","alanine transport" -"GO:0003221","right ventricular cardiac muscle tissue morphogenesis" -"GO:1905673","positive regulation of lysosome organization" -"GO:0018901","2,4-dichlorophenoxyacetic acid metabolic process" -"GO:0042770","signal transduction in response to DNA damage" -"GO:1905124","negative regulation of glucosylceramidase activity" -"GO:0001833","inner cell mass cell proliferation" -"GO:0035988","chondrocyte proliferation" -"GO:1904870","negative regulation of protein localization to Cajal body" -"GO:0019100","male germ-line sex determination" -"GO:0060221","retinal rod cell differentiation" -"GO:0060627","regulation of vesicle-mediated transport" -"GO:0032658","regulation of interleukin-15 production" -"GO:0012501","programmed cell death" -"GO:0036176","response to neutral pH" -"GO:0060543","negative regulation of strand invasion" -"GO:2001257","regulation of cation channel activity" -"GO:0021592","fourth ventricle development" -"GO:0036158","outer dynein arm assembly" -"GO:1904779","regulation of protein localization to centrosome" -"GO:0034149","positive regulation of toll-like receptor 5 signaling pathway" -"GO:1902990","mitotic telomere maintenance via semi-conservative replication" -"GO:0061379","inferior colliculus development" -"GO:0099539","neuropeptide secretion from presynapse" -"GO:0005992","trehalose biosynthetic process" -"GO:0090657","telomeric loop disassembly" -"GO:1905797","negative regulation of intraciliary anterograde transport" -"GO:0019251","anaerobic cobalamin biosynthetic process" -"GO:0001947","heart looping" -"GO:0032598","B cell receptor transport into immunological synapse" -"GO:0003190","atrioventricular valve formation" -"GO:0061484","hematopoietic stem cell homeostasis" -"GO:0033182","regulation of histone ubiquitination" -"GO:0097291","renal phosphate ion absorption" -"GO:0019651","citrate catabolic process to diacetyl" -"GO:0031054","pre-miRNA processing" -"GO:0042340","keratan sulfate catabolic process" -"GO:0070471","uterine smooth muscle contraction" -"GO:0017015","regulation of transforming growth factor beta receptor signaling pathway" -"GO:0032693","negative regulation of interleukin-10 production" -"GO:0014038","regulation of Schwann cell differentiation" -"GO:0007487","analia development" -"GO:0048722","anterior cibarial plate development" -"GO:1905853","regulation of heparan sulfate binding" -"GO:0002742","regulation of cytokine biosynthetic process involved in immune response" -"GO:0071907","determination of digestive tract left/right asymmetry" -"GO:0033562","co-transcriptional gene silencing by RNA interference machinery" -"GO:0072055","renal cortex development" -"GO:0098676","modulation of host virulence by virus" -"GO:0035508","positive regulation of myosin-light-chain-phosphatase activity" -"GO:1904762","positive regulation of myofibroblast differentiation" -"GO:0051356","visual perception involved in equilibrioception" -"GO:0050955","thermoception" -"GO:1900369","negative regulation of RNA interference" -"GO:0061762","CAMKK-AMPK signaling cascade" -"GO:0021516","dorsal spinal cord development" -"GO:0046586","regulation of calcium-dependent cell-cell adhesion" -"GO:0002012","vasoconstriction of artery involved in chemoreceptor response to lowering of systemic arterial blood pressure" -"GO:0007189","adenylate cyclase-activating G-protein coupled receptor signaling pathway" -"GO:0035905","ascending aorta development" -"GO:0002566","somatic diversification of immune receptors via somatic mutation" -"GO:0006382","adenosine to inosine editing" -"GO:0035019","somatic stem cell population maintenance" -"GO:0055001","muscle cell development" -"GO:0043268","positive regulation of potassium ion transport" -"GO:0042173","regulation of sporulation resulting in formation of a cellular spore" -"GO:0001820","serotonin secretion" -"GO:0006362","transcription elongation from RNA polymerase I promoter" -"GO:0015110","cyanate transmembrane transporter activity" -"GO:0072684","mitochondrial tRNA 3'-trailer cleavage, endonucleolytic" -"GO:0014033","neural crest cell differentiation" -"GO:0070286","axonemal dynein complex assembly" -"GO:0000732","strand displacement" -"GO:1903234","negative regulation of calcium ion-dependent exocytosis of neurotransmitter" -"GO:0046822","regulation of nucleocytoplasmic transport" -"GO:0060287","epithelial cilium movement involved in determination of left/right asymmetry" -"GO:0045690","positive regulation of antipodal cell differentiation" -"GO:0071768","mycolic acid biosynthetic process" -"GO:0086014","atrial cardiac muscle cell action potential" -"GO:0016553","base conversion or substitution editing" -"GO:0034414","tRNA 3'-trailer cleavage, endonucleolytic" -"GO:0060692","mesenchymal cell differentiation involved in salivary gland development" -"GO:0060061","Spemann organizer formation" -"GO:0061054","dermatome development" -"GO:0003360","brainstem development" -"GO:0042744","hydrogen peroxide catabolic process" -"GO:2000374","regulation of oxygen metabolic process" -"GO:0099120","socially cooperative development" -"GO:1904430","negative regulation of t-circle formation" -"GO:0002862","negative regulation of inflammatory response to antigenic stimulus" -"GO:1905214","regulation of RNA binding" -"GO:0035319","imaginal disc-derived wing hair elongation" -"GO:0072022","descending thin limb development" -"GO:0043044","ATP-dependent chromatin remodeling" -"GO:0031297","replication fork processing" -"GO:0007537","inactivation of recombination (HML)" -"GO:0014829","vascular smooth muscle contraction" -"GO:1903793","positive regulation of anion transport" -"GO:0007199","G-protein coupled receptor signaling pathway coupled to cGMP nucleotide second messenger" -"GO:0048289","isotype switching to IgE isotypes" -"GO:0072520","seminiferous tubule development" -"GO:0021765","cingulate gyrus development" -"GO:0035280","miRNA loading onto RISC involved in gene silencing by miRNA" -"GO:2001263","regulation of C-C chemokine binding" -"GO:0071440","regulation of histone H3-K14 acetylation" -"GO:0051695","actin filament uncapping" -"GO:0006743","ubiquinone metabolic process" -"GO:0007496","anterior midgut development" -"GO:0021890","olfactory bulb interneuron fate commitment" -"GO:0033686","positive regulation of luteinizing hormone secretion" -"GO:2000554","regulation of T-helper 1 cell cytokine production" -"GO:0071910","determination of liver left/right asymmetry" -"GO:0001188","RNA polymerase I transcriptional preinitiation complex assembly" -"GO:0007124","pseudohyphal growth" -"GO:1901810","beta-carotene metabolic process" -"GO:0008150","biological_process" -"GO:2000824","negative regulation of androgen receptor activity" -"GO:0009110","vitamin biosynthetic process" -"GO:0033566","gamma-tubulin complex localization" -"GO:0061040","female gonad morphogenesis" -"GO:0060964","regulation of gene silencing by miRNA" -"GO:0001702","gastrulation with mouth forming second" -"GO:0061709","reticulophagy" -"GO:0072134","nephrogenic mesenchyme morphogenesis" -"GO:0032206","positive regulation of telomere maintenance" -"GO:0043313","regulation of neutrophil degranulation" -"GO:1900130","regulation of lipid binding" -"GO:0080163","regulation of protein serine/threonine phosphatase activity" -"GO:2001137","positive regulation of endocytic recycling" -"GO:0010098","suspensor development" -"GO:0046855","inositol phosphate dephosphorylation" -"GO:0050953","sensory perception of light stimulus" -"GO:0043615","astrocyte cell migration" -"GO:1903931","positive regulation of pyrimidine-containing compound salvage" -"GO:0032508","DNA duplex unwinding" -"GO:0046856","phosphatidylinositol dephosphorylation" -"GO:1904819","parietal peritoneum development" -"GO:0000335","negative regulation of transposition, DNA-mediated" -"GO:0000723","telomere maintenance" -"GO:0032909","regulation of transforming growth factor beta2 production" -"GO:0050968","detection of chemical stimulus involved in sensory perception of pain" -"GO:0060956","endocardial cell differentiation" -"GO:0060972","left/right pattern formation" -"GO:1904506","negative regulation of telomere maintenance in response to DNA damage" -"GO:0097738","substrate mycelium formation" -"GO:0001998","angiotensin-mediated vasoconstriction involved in regulation of systemic arterial blood pressure" -"GO:0098586","cellular response to virus" -"GO:0043554","aerobic respiration, using arsenite as electron donor" -"GO:0003341","cilium movement" -"GO:0070327","thyroid hormone transport" -"GO:2001259","positive regulation of cation channel activity" -"GO:1903700","caecum development" -"GO:0006565","L-serine catabolic process" -"GO:0002641","negative regulation of immunoglobulin biosynthetic process" -"GO:0033341","regulation of collagen binding" -"GO:0040032","post-embryonic body morphogenesis" -"GO:0045071","negative regulation of viral genome replication" -"GO:0006356","regulation of transcription by RNA polymerase I" -"GO:0061808","negative regulation of DNA recombination at centromere" -"GO:0003356","regulation of cilium beat frequency" -"GO:0031053","primary miRNA processing" -"GO:0070640","vitamin D3 metabolic process" -"GO:0071559","response to transforming growth factor beta" -"GO:0010614","negative regulation of cardiac muscle hypertrophy" -"GO:0070788","conidiophore stalk development" -"GO:0033301","cell cycle comprising mitosis without cytokinesis" -"GO:0051135","positive regulation of NK T cell activation" -"GO:0044458","motile cilium assembly" -"GO:0072051","juxtaglomerular apparatus development" -"GO:1903577","cellular response to L-arginine" -"GO:0039506","modulation by virus of host molecular function" -"GO:2001273","regulation of glucose import in response to insulin stimulus" -"GO:0048480","stigma development" -"GO:0039703","RNA replication" -"GO:0045910","negative regulation of DNA recombination" -"GO:0046881","positive regulation of follicle-stimulating hormone secretion" -"GO:0036159","inner dynein arm assembly" -"GO:0061869","regulation of hepatic stellate cell migration" -"GO:0042742","defense response to bacterium" -"GO:0055081","anion homeostasis" -"GO:1905049","negative regulation of metallopeptidase activity" -"GO:0003220","left ventricular cardiac muscle tissue morphogenesis" -"GO:0035469","determination of pancreatic left/right asymmetry" -"GO:0010569","regulation of double-strand break repair via homologous recombination" -"GO:0048290","isotype switching to IgA isotypes" -"GO:0075733","intracellular transport of virus" -"GO:1904535","positive regulation of telomeric loop disassembly" -"GO:0008654","phospholipid biosynthetic process" -"GO:1903584","regulation of histone deubiquitination" -"GO:0097191","extrinsic apoptotic signaling pathway" -"GO:0006486","protein glycosylation" -"GO:0035195","gene silencing by miRNA" -"GO:0038086","VEGF-activated platelet-derived growth factor receptor signaling pathway" -"GO:0036493","positive regulation of translation in response to endoplasmic reticulum stress" -"GO:0031579","membrane raft organization" -"GO:0042592","homeostatic process" -"GO:0001930","positive regulation of exocyst assembly" -"GO:2000331","regulation of terminal button organization" -"GO:0099152","regulation of neurotransmitter receptor transport, endosome to postsynaptic membrane" -"GO:0002718","regulation of cytokine production involved in immune response" -"GO:0016925","protein sumoylation" -"GO:0090190","positive regulation of branching involved in ureteric bud morphogenesis" -"GO:0031285","regulation of sorocarp stalk cell differentiation" -"GO:0001402","signal transduction involved in filamentous growth" -"GO:0072189","ureter development" -"GO:0045383","positive regulation of interleukin-18 biosynthetic process" -"GO:0009723","response to ethylene" -"GO:0032654","regulation of interleukin-11 production" -"GO:0032180","ubiquinone biosynthetic process from tyrosine" -"GO:1904624","regulation of glycine secretion, neurotransmission" -"GO:1902473","regulation of protein localization to synapse" -"GO:1905207","regulation of cardiocyte differentiation" -"GO:2000457","positive regulation of T-helper 17 cell extravasation" -"GO:1904368","regulation of sclerenchyma cell differentiation" -"GO:0071497","cellular response to freezing" -"GO:0051873","killing by host of symbiont cells" -"GO:0031944","negative regulation of glucocorticoid metabolic process" -"GO:0098926","postsynaptic signal transduction" -"GO:0034102","erythrocyte clearance" -"GO:0110020","regulation of actomyosin structure organization" -"GO:0034551","mitochondrial respiratory chain complex III assembly" -"GO:1903459","mitotic DNA replication lagging strand elongation" -"GO:0072243","metanephric nephron epithelium development" -"GO:0007032","endosome organization" -"GO:0007399","nervous system development" -"GO:0002474","antigen processing and presentation of peptide antigen via MHC class I" -"GO:0032915","positive regulation of transforming growth factor beta2 production" -"GO:0060454","positive regulation of gastric acid secretion" -"GO:0070911","global genome nucleotide-excision repair" -"GO:0032645","regulation of granulocyte macrophage colony-stimulating factor production" -"GO:0018283","iron incorporation into metallo-sulfur cluster" -"GO:0006042","glucosamine biosynthetic process" -"GO:0001658","branching involved in ureteric bud morphogenesis" -"GO:1904320","positive regulation of smooth muscle contraction involved in micturition" -"GO:0014048","regulation of glutamate secretion" -"GO:0098728","germline stem cell asymmetric division" -"GO:0045860","positive regulation of protein kinase activity" -"GO:0038105","sequestering of TGFbeta from receptor via TGFbeta binding" -"GO:0060083","smooth muscle contraction involved in micturition" -"GO:0000398","mRNA splicing, via spliceosome" -"GO:1903888","regulation of plant epidermal cell differentiation" -"GO:0009942","longitudinal axis specification" -"GO:0071588","hydrogen peroxide mediated signaling pathway" -"GO:0016458","gene silencing" -"GO:0009756","carbohydrate mediated signaling" -"GO:0050766","positive regulation of phagocytosis" -"GO:0031030","negative regulation of septation initiation signaling" -"GO:0061968","maintenance of left/right asymmetry" -"GO:0007411","axon guidance" -"GO:0060619","cell migration involved in mammary placode formation" -"GO:0001867","complement activation, lectin pathway" -"GO:1903544","response to butyrate" -"GO:1901269","lipooligosaccharide metabolic process" -"GO:1900195","positive regulation of oocyte maturation" -"GO:0060696","regulation of phospholipid catabolic process" -"GO:1905915","regulation of cell differentiation involved in phenotypic switching" -"GO:0080141","regulation of jasmonic acid biosynthetic process" -"GO:1902105","regulation of leukocyte differentiation" -"GO:0043571","maintenance of CRISPR repeat elements" -"GO:1902420","signal transduction involved in Dma1-dependent checkpoint" -"GO:0006638","neutral lipid metabolic process" -"GO:0045070","positive regulation of viral genome replication" -"GO:2000893","cellotriose metabolic process" -"GO:0010017","red or far-red light signaling pathway" -"GO:1903725","regulation of phospholipid metabolic process" -"GO:0031175","neuron projection development" -"GO:2000871","negative regulation of progesterone secretion" -"GO:0019577","aldaric acid metabolic process" -"GO:0032669","regulation of interleukin-25 production" -"GO:0010517","regulation of phospholipase activity" -"GO:0046355","mannan catabolic process" -"GO:0046836","glycolipid transport" -"GO:0045691","regulation of embryo sac central cell differentiation" -"GO:0060189","positive regulation of protein desumoylation" -"GO:0070537","histone H2A K63-linked deubiquitination" -"GO:0002688","regulation of leukocyte chemotaxis" -"GO:0060339","negative regulation of type I interferon-mediated signaling pathway" -"GO:0090204","protein localization to nuclear pore" -"GO:0009668","plastid membrane organization" -"GO:0033530","raffinose metabolic process" -"GO:0060506","smoothened signaling pathway involved in lung development" -"GO:0032897","negative regulation of viral transcription" -"GO:1903929","primary palate development" -"GO:0007166","cell surface receptor signaling pathway" -"GO:0044062","regulation of excretion" -"GO:0006953","acute-phase response" -"GO:0009735","response to cytokinin" -"GO:0021842","chemorepulsion involved in interneuron migration from the subpallium to the cortex" -"GO:0060926","cardiac pacemaker cell development" -"GO:0045960","positive regulation of complement activation, classical pathway" -"GO:0015757","galactose transmembrane transport" -"GO:0000117","regulation of transcription involved in G2/M transition of mitotic cell cycle" -"GO:0048304","positive regulation of isotype switching to IgG isotypes" -"GO:1904231","positive regulation of succinate dehydrogenase activity" -"GO:0060004","reflex" -"GO:1903201","regulation of oxidative stress-induced cell death" -"GO:0090361","regulation of platelet-derived growth factor production" -"GO:0010468","regulation of gene expression" -"GO:0048525","negative regulation of viral process" -"GO:0006740","NADPH regeneration" -"GO:0097701","response to pulsatile fluid shear stress" -"GO:0100024","regulation of carbohydrate metabolic process by transcription from RNA polymerase II promoter" -"GO:1902231","positive regulation of intrinsic apoptotic signaling pathway in response to DNA damage" -"GO:0050926","regulation of positive chemotaxis" -"GO:0035455","response to interferon-alpha" -"GO:0032005","signal transduction involved in positive regulation of conjugation with cellular fusion" -"GO:0006801","superoxide metabolic process" -"GO:0070511","negative regulation of histone H4-K20 methylation" -"GO:0006997","nucleus organization" -"GO:0009155","purine deoxyribonucleotide catabolic process" -"GO:0071899","negative regulation of estrogen receptor binding" -"GO:0032657","regulation of interleukin-14 production" -"GO:0051679","6-alpha-maltosylglucose metabolic process" -"GO:1901143","insulin catabolic process" -"GO:0140145","copper ion export from vacuole" -"GO:0007291","sperm individualization" -"GO:0030155","regulation of cell adhesion" -"GO:0007210","serotonin receptor signaling pathway" -"GO:1903831","signal transduction involved in cellular response to ammonium ion" -"GO:0003337","mesenchymal to epithelial transition involved in metanephros morphogenesis" -"GO:0034199","activation of protein kinase A activity" -"GO:0035522","monoubiquitinated histone H2A deubiquitination" -"GO:0060337","type I interferon signaling pathway" -"GO:0090520","sphingolipid mediated signaling pathway" -"GO:0019747","regulation of isoprenoid metabolic process" -"GO:0097527","necroptotic signaling pathway" -"GO:1904048","regulation of spontaneous neurotransmitter secretion" -"GO:0002480","antigen processing and presentation of exogenous peptide antigen via MHC class I, TAP-independent" -"GO:0048011","neurotrophin TRK receptor signaling pathway" -"GO:0050812","regulation of acyl-CoA biosynthetic process" -"GO:0019418","sulfide oxidation" -"GO:0021565","accessory nerve development" -"GO:0018344","protein geranylgeranylation" -"GO:0045694","regulation of embryo sac egg cell differentiation" -"GO:0006612","protein targeting to membrane" -"GO:0001759","organ induction" -"GO:0097485","neuron projection guidance" -"GO:1903426","regulation of reactive oxygen species biosynthetic process" -"GO:1903719","regulation of I-kappaB phosphorylation" -"GO:0060456","positive regulation of digestive system process" -"GO:0048866","stem cell fate specification" -"GO:0071071","regulation of phospholipid biosynthetic process" -"GO:0060786","regulation of cell differentiation involved in tissue homeostasis" -"GO:0100020","regulation of transport by transcription from RNA polymerase II promoter" -"GO:0061999","regulation of cardiac endothelial to mesenchymal transition" -"GO:0035773","insulin secretion involved in cellular response to glucose stimulus" -"GO:0000054","ribosomal subunit export from nucleus" -"GO:0051622","negative regulation of norepinephrine uptake" -"GO:0051349","positive regulation of lyase activity" -"GO:0010204","defense response signaling pathway, resistance gene-independent" -"GO:0060544","regulation of necroptotic process" -"GO:0071502","cellular response to temperature stimulus" -"GO:0015230","FAD transmembrane transporter activity" -"GO:0010019","chloroplast-nucleus signaling pathway" -"GO:0007422","peripheral nervous system development" -"GO:0033531","stachyose metabolic process" -"GO:0045697","regulation of synergid differentiation" -"GO:0051601","exocyst localization" -"GO:0086004","regulation of cardiac muscle cell contraction" -"GO:2000592","regulation of metanephric DCT cell differentiation" -"GO:0060863","regulation of floral organ abscission by signal transduction" -"GO:2001122","maltoheptaose metabolic process" -"GO:0061541","rhabdomere morphogenesis" -"GO:1990403","embryonic brain development" -"GO:0035987","endodermal cell differentiation" -"GO:0044090","positive regulation of vacuole organization" -"GO:0023014","signal transduction by protein phosphorylation" -"GO:0051585","negative regulation of dopamine uptake involved in synaptic transmission" -"GO:0072091","regulation of stem cell proliferation" -"GO:0045840","positive regulation of mitotic nuclear division" -"GO:1903284","positive regulation of glutathione peroxidase activity" -"GO:0036295","cellular response to increased oxygen levels" -"GO:0090092","regulation of transmembrane receptor protein serine/threonine kinase signaling pathway" -"GO:0002790","peptide secretion" -"GO:0019230","proprioception" -"GO:1902285","semaphorin-plexin signaling pathway involved in neuron projection guidance" -"GO:0051691","cellular oligosaccharide metabolic process" -"GO:0055083","monovalent inorganic anion homeostasis" -"GO:1905770","regulation of mesodermal cell differentiation" -"GO:2000889","cellodextrin metabolic process" -"GO:0060518","cell migration involved in prostatic bud elongation" -"GO:0035616","histone H2B conserved C-terminal lysine deubiquitination" -"GO:0032646","regulation of hepatocyte growth factor production" -"GO:0001789","G-protein coupled receptor signaling pathway, coupled to S1P second messenger" -"GO:0009223","pyrimidine deoxyribonucleotide catabolic process" -"GO:0007436","larval salivary gland morphogenesis" -"GO:0010799","regulation of peptidyl-threonine phosphorylation" -"GO:0039614","induction by virus of host protein phosphorylation" -"GO:1904799","regulation of neuron remodeling" -"GO:0007231","osmosensory signaling pathway" -"GO:0006241","CTP biosynthetic process" -"GO:0071788","endoplasmic reticulum tubular network maintenance" -"GO:1901594","response to capsazepine" -"GO:0045727","positive regulation of translation" -"GO:1904266","regulation of Schwann cell chemotaxis" -"GO:0048680","positive regulation of axon regeneration" -"GO:0050932","regulation of pigment cell differentiation" -"GO:0018908","organosulfide cycle" -"GO:1904494","regulation of substance P secretion, neurotransmission" -"GO:0033533","verbascose metabolic process" -"GO:0055076","transition metal ion homeostasis" -"GO:1905557","regulation of mitotic nuclear envelope disassembly" -"GO:0060183","apelin receptor signaling pathway" -"GO:0048484","enteric nervous system development" -"GO:1905873","positive regulation of protein localization to cell leading edge" -"GO:0010111","glyoxysome organization" -"GO:0097702","response to oscillatory fluid shear stress" -"GO:0015009","corrin metabolic process" -"GO:0044242","cellular lipid catabolic process" -"GO:0033535","ajugose metabolic process" -"GO:0009863","salicylic acid mediated signaling pathway" -"GO:0000086","G2/M transition of mitotic cell cycle" -"GO:0086103","G-protein coupled receptor signaling pathway involved in heart process" -"GO:0097430","copper ion import across prospore membane" -"GO:0098703","calcium ion import across plasma membrane" -"GO:0006097","glyoxylate cycle" -"GO:0035971","peptidyl-histidine dephosphorylation" -"GO:0046438","D-cysteine metabolic process" -"GO:0071634","regulation of transforming growth factor beta production" -"GO:0006468","protein phosphorylation" -"GO:0061434","regulation of replicative cell aging by regulation of transcription from RNA polymerase II promoter in response to caloric restriction" -"GO:0033631","cell-cell adhesion mediated by integrin" -"GO:1905537","positive regulation of eukaryotic translation initiation factor 4F complex assembly" -"GO:0071219","cellular response to molecule of bacterial origin" -"GO:0071892","thrombocyte activation" -"GO:0046340","diacylglycerol catabolic process" -"GO:0090077","foam cell differentiation" -"GO:0030211","heparin catabolic process" -"GO:0045645","positive regulation of eosinophil differentiation" -"GO:0009563","synergid differentiation" -"GO:0044671","sorocarp spore cell differentiation" -"GO:0046338","phosphatidylethanolamine catabolic process" -"GO:0051775","response to redox state" -"GO:0060006","angular vestibuloocular reflex" -"GO:1902574","negative regulation of leucine import by regulation of transcription from RNA polymerase II promoter" -"GO:0044337","canonical Wnt signaling pathway involved in positive regulation of apoptotic process" -"GO:0016578","histone deubiquitination" -"GO:0006744","ubiquinone biosynthetic process" -"GO:0072364","regulation of cellular ketone metabolic process by regulation of transcription from RNA polymerase II promoter" -"GO:0042981","regulation of apoptotic process" -"GO:0043354","enucleate erythrocyte maturation" -"GO:0060003","copper ion export" -"GO:0006273","lagging strand elongation" -"GO:0035995","detection of muscle stretch" -"GO:1904919","transmembrane L-cystine transport from lysosomal lumen to cytosol" -"GO:0060974","cell migration involved in heart formation" -"GO:2001252","positive regulation of chromosome organization" -"GO:0051647","nucleus localization" -"GO:0071220","cellular response to bacterial lipoprotein" -"GO:0072236","metanephric loop of Henle development" -"GO:0035950","regulation of oligopeptide transport by regulation of transcription from RNA polymerase II promoter" -"GO:0010672","regulation of transcription from RNA polymerase II promoter involved in meiotic cell cycle" -"GO:0090030","regulation of steroid hormone biosynthetic process" -"GO:0022036","rhombomere cell differentiation" -"GO:0051104","DNA-dependent DNA replication DNA ligation" -"GO:0009557","antipodal cell differentiation" -"GO:0000244","spliceosomal tri-snRNP complex assembly" -"GO:1900382","regulation of thiamine biosynthetic process by regulation of transcription from RNA polymerase II promoter" -"GO:0002622","regulation of B cell antigen processing and presentation" -"GO:1901199","positive regulation of calcium ion transport into cytosol involved in cellular response to salt stress" -"GO:0051102","DNA ligation involved in DNA recombination" -"GO:0008583","mystery cell differentiation" -"GO:0072299","negative regulation of metanephric glomerulus development" -"GO:0001196","regulation of mating-type specific transcription from RNA polymerase II promoter" -"GO:0060059","embryonic retina morphogenesis in camera-type eye" -"GO:0090603","sieve element differentiation" -"GO:0014901","satellite cell activation involved in skeletal muscle regeneration" -"GO:0002924","negative regulation of humoral immune response mediated by circulating immunoglobulin" -"GO:0001742","oenocyte differentiation" -"GO:0000819","sister chromatid segregation" -"GO:0006202","GMP catabolic process to guanine" -"GO:0060677","ureteric bud elongation" -"GO:1902220","positive regulation of intrinsic apoptotic signaling pathway in response to osmotic stress" -"GO:0001778","plasma membrane repair" -"GO:0007009","plasma membrane organization" -"GO:0019241","citrulline catabolic process" -"GO:0048760","plant parenchymal cell differentiation" -"GO:0002605","negative regulation of dendritic cell antigen processing and presentation" -"GO:1901213","regulation of transcription from RNA polymerase II promoter involved in heart development" -"GO:0006694","steroid biosynthetic process" -"GO:0001811","negative regulation of type I hypersensitivity" -"GO:0044030","regulation of DNA methylation" -"GO:0090679","cell differentiation involved in phenotypic switching" -"GO:0060299","negative regulation of sarcomere organization" -"GO:1903433","regulation of constitutive secretory pathway" -"GO:0061318","renal filtration cell differentiation" -"GO:1990708","conditioned place preference" -"GO:0006102","isocitrate metabolic process" -"GO:1905133","negative regulation of meiotic chromosome separation" -"GO:0051403","stress-activated MAPK cascade" -"GO:1903756","regulation of transcription from RNA polymerase II promoter by histone modification" -"GO:0050974","detection of mechanical stimulus involved in sensory perception" -"GO:0019563","glycerol catabolic process" -"GO:1904374","cellular response to kainic acid" -"GO:1903304","positive regulation of pyruvate kinase activity" -"GO:1900210","positive regulation of cardiolipin metabolic process" -"GO:0051048","negative regulation of secretion" -"GO:0007049","cell cycle" -"GO:0075106","modulation by symbiont of host adenylate cyclase activity" -"GO:0035960","regulation of ergosterol biosynthetic process by regulation of transcription from RNA polymerase II promoter" -"GO:0046479","glycosphingolipid catabolic process" -"GO:1903102","1-phosphatidyl-1D-myo-inositol 3,5-bisphosphate biosynthetic process" -"GO:0086045","membrane depolarization during AV node cell action potential" -"GO:0046019","regulation of transcription from RNA polymerase II promoter by pheromones" -"GO:0060034","notochord cell differentiation" -"GO:0038009","regulation of signal transduction by receptor internalization" -"GO:0043380","regulation of memory T cell differentiation" -"GO:2001188","regulation of T cell activation via T cell receptor contact with antigen bound to MHC molecule on antigen presenting cell" -"GO:0060962","regulation of ribosomal protein gene transcription by RNA polymerase II" -"GO:1905844","negative regulation of cellular response to gamma radiation" -"GO:1900744","regulation of p38MAPK cascade" -"GO:1900374","positive regulation of mating type switching by regulation of transcription from RNA polymerase II promoter" -"GO:0006488","dolichol-linked oligosaccharide biosynthetic process" -"GO:0021772","olfactory bulb development" -"GO:1904697","regulation of acinar cell proliferation" -"GO:0061615","glycolytic process through fructose-6-phosphate" -"GO:0002521","leukocyte differentiation" -"GO:1905644","regulation of FACT complex assembly" -"GO:0100051","positive regulation of meiotic nuclear division by transcription from RNA polymerase II promoter" -"GO:0090264","regulation of immune complex clearance by monocytes and macrophages" -"GO:0030263","apoptotic chromosome condensation" -"GO:0009560","embryo sac egg cell differentiation" -"GO:1990511","piRNA biosynthetic process" -"GO:0060500","regulation of transcription from RNA polymerase II promoter involved in lung bud formation" -"GO:0014806","smooth muscle hyperplasia" -"GO:0061521","hepatic stellate cell differentiation" -"GO:1901587","positive regulation of acid-sensing ion channel activity" -"GO:0045356","positive regulation of interferon-alpha biosynthetic process" -"GO:0002191","cap-dependent translational initiation" -"GO:0070646","protein modification by small protein removal" -"GO:0019385","methanogenesis, from acetate" -"GO:0019492","proline salvage" -"GO:0060508","lung basal cell differentiation" -"GO:0090627","plant epidermal cell differentiation" -"GO:1905242","response to 3,3',5-triiodo-L-thyronine" -"GO:1901580","regulation of telomeric RNA transcription from RNA pol II promoter" -"GO:0043569","negative regulation of insulin-like growth factor receptor signaling pathway" -"GO:1900415","regulation of fungal-type cell wall biogenesis by regulation of transcription from RNA polymerase II promoter" -"GO:0006342","chromatin silencing" -"GO:1905612","positive regulation of mRNA cap binding" -"GO:0060660","epidermis morphogenesis involved in nipple formation" -"GO:0071498","cellular response to fluid shear stress" -"GO:0051151","negative regulation of smooth muscle cell differentiation" -"GO:0030254","protein secretion by the type III secretion system" -"GO:0033292","T-tubule organization" -"GO:0075075","modulation by host of symbiont adenylate cyclase activity" -"GO:1901019","regulation of calcium ion transmembrane transporter activity" -"GO:0061396","regulation of transcription from RNA polymerase II promoter in response to copper ion" -"GO:0021940","positive regulation of cerebellar granule cell precursor proliferation" -"GO:1902064","regulation of transcription from RNA polymerase II promoter involved in spermatogenesis" -"GO:0061378","corpora quadrigemina development" -"GO:0043705","cyanophycin metabolic process" -"GO:0048684","positive regulation of collateral sprouting of intact axon in response to injury" -"GO:0009177","pyrimidine deoxyribonucleoside monophosphate biosynthetic process" -"GO:0002266","follicular dendritic cell activation" -"GO:2000604","negative regulation of secondary growth" -"GO:1900826","negative regulation of membrane depolarization during cardiac muscle cell action potential" -"GO:0002608","negative regulation of myeloid dendritic cell antigen processing and presentation" -"GO:1902564","negative regulation of neutrophil activation" -"GO:1905696","regulation of polysome binding" -"GO:1900393","regulation of iron ion transport by regulation of transcription from RNA polymerase II promoter" -"GO:0014740","negative regulation of muscle hyperplasia" -"GO:1900094","regulation of transcription from RNA polymerase II promoter involved in determination of left/right symmetry" -"GO:1905194","positive regulation of chloroplast fission" -"GO:0014890","smooth muscle atrophy" -"GO:1903037","regulation of leukocyte cell-cell adhesion" -"GO:0051394","regulation of nerve growth factor receptor activity" -"GO:0090172","microtubule cytoskeleton organization involved in homologous chromosome segregation" -"GO:1905380","regulation of snRNA transcription by RNA polymerase II" -"GO:0031276","negative regulation of lateral pseudopodium assembly" -"GO:0071763","nuclear membrane organization" -"GO:2001199","negative regulation of dendritic cell differentiation" -"GO:0017144","drug metabolic process" -"GO:0034638","phosphatidylcholine catabolic process" -"GO:0002627","positive regulation of T cell antigen processing and presentation" -"GO:0014001","sclerenchyma cell differentiation" -"GO:0000455","enzyme-directed rRNA pseudouridine synthesis" -"GO:1905260","positive regulation of nitrosative stress-induced intrinsic apoptotic signaling pathway" -"GO:0061867","establishment of mitotic spindle asymmetry" -"GO:0060412","ventricular septum morphogenesis" -"GO:0060044","negative regulation of cardiac muscle cell proliferation" -"GO:0150022","apical dendrite development" -"GO:0050894","determination of affect" -"GO:0021800","cerebral cortex tangential migration" -"GO:0033131","regulation of glucokinase activity" -"GO:0044546","NLRP3 inflammasome complex assembly" -"GO:0061449","olfactory bulb tufted cell development" -"GO:0006420","arginyl-tRNA aminoacylation" -"GO:0009991","response to extracellular stimulus" -"GO:1900999","nitrobenzene biosynthetic process" -"GO:0033365","protein localization to organelle" -"GO:0042060","wound healing" -"GO:0051666","actin cortical patch localization" -"GO:0002277","myeloid dendritic cell activation involved in immune response" -"GO:1904918","transmembrane L-histidine transport from lysosomal lumen to cytosol" -"GO:0002374","cytokine secretion involved in immune response" -"GO:0090422","thiamine pyrophosphate transmembrane transporter activity" -"GO:0035581","sequestering of extracellular ligand from receptor" -"GO:0007435","salivary gland morphogenesis" -"GO:0032744","positive regulation of interleukin-20 production" -"GO:0003321","positive regulation of blood pressure by epinephrine-norepinephrine" -"GO:1905098","negative regulation of guanyl-nucleotide exchange factor activity" -"GO:0006474","N-terminal protein amino acid acetylation" -"GO:0050784","cocaine catabolic process" -"GO:0098902","regulation of membrane depolarization during action potential" -"GO:0015217","ADP transmembrane transporter activity" -"GO:0061294","mesonephric renal vesicle induction" -"GO:0050920","regulation of chemotaxis" -"GO:0005340","nucleotide-sulfate transmembrane transporter activity" -"GO:0046419","octopine metabolic process" -"GO:0048596","embryonic camera-type eye morphogenesis" -"GO:0016576","histone dephosphorylation" -"GO:0048661","positive regulation of smooth muscle cell proliferation" -"GO:0006915","apoptosis" -"GO:0010217","cellular aluminum ion homeostasis" -"GO:1902274","positive regulation of (R)-carnitine transmembrane transport" -"GO:0062000","positive regulation of cardiac endothelial to mesenchymal transition" -"GO:0070495","negative regulation of thrombin-activated receptor signaling pathway" -"GO:0050701","interleukin-1 secretion" -"GO:0042929","ferrichrome transmembrane transporter activity" -"GO:0071938","vitamin A transport" -"GO:0007157","heterophilic cell-cell adhesion via plasma membrane cell adhesion molecules" -"GO:0060562","epithelial tube morphogenesis" -"GO:0061691","detoxification of hydrogen peroxide" -"GO:0033300","dehydroascorbic acid transmembrane transporter activity" -"GO:1903770","negative regulation of beta-galactosidase activity" -"GO:0097242","amyloid-beta clearance" -"GO:0032621","interleukin-18 production" -"GO:0008521","acetyl-CoA transmembrane transporter activity" -"GO:0050790","regulation of catalytic activity" -"GO:0034622","cellular protein-containing complex assembly" -"GO:0007584","response to nutrient" -"GO:0090131","mesenchyme migration" -"GO:0070234","positive regulation of T cell apoptotic process" -"GO:1904401","cellular response to Thyroid stimulating hormone" -"GO:0061903","positive regulation of 1-phosphatidylinositol-3-kinase activity" -"GO:0006412","protein biosynthesis" -"GO:0032737","positive regulation of interleukin-14 production" -"GO:0006260","DNA replication" -"GO:0021778","oligodendrocyte cell fate specification" -"GO:0070572","positive regulation of neuron projection regeneration" -"GO:0046824","positive regulation of nucleocytoplasmic transport" -"GO:1901316","positive regulation of histone H2A K63-linked ubiquitination" -"GO:1990852","protein transport along microtubule to spindle pole body" -"GO:0045500","sevenless signaling pathway" -"GO:0061303","cornea development in camera-type eye" -"GO:0002160","desmosome maintenance" -"GO:0046502","uroporphyrinogen III metabolic process" -"GO:0052315","phytoalexin biosynthetic process" -"GO:0021759","globus pallidus development" -"GO:0016180","snRNA processing" -"GO:0060087","relaxation of vascular smooth muscle" -"GO:0009106","lipoate metabolic process" -"GO:0021905","forebrain-midbrain boundary formation" -"GO:0097065","anterior head development" -"GO:0106092","glial cell projection elongation involved in axon ensheathment" -"GO:0021912","regulation of transcription from RNA polymerase II promoter involved in spinal cord motor neuron fate specification" -"GO:0090081","regulation of heart induction by regulation of canonical Wnt signaling pathway" -"GO:2001310","gliotoxin biosynthetic process" -"GO:0097272","ammonia homeostasis" -"GO:0031926","pyridoxal phosphate transmembrane transporter activity" -"GO:0061257","mesonephric glomerular visceral epithelial cell development" -"GO:0060699","regulation of endoribonuclease activity" -"GO:1903699","tarsal gland development" -"GO:2000311","regulation of AMPA receptor activity" -"GO:0032726","positive regulation of hepatocyte growth factor production" -"GO:0100007","negative regulation of ceramide biosynthetic process by transcription from RNA polymerase II promoter" -"GO:0060752","intestinal phytosterol absorption" -"GO:0048505","regulation of timing of cell differentiation" -"GO:0060340","positive regulation of type I interferon-mediated signaling pathway" -"GO:0051068","dihydrolipoamide metabolic process" -"GO:1990375","baculum development" -"GO:0032745","positive regulation of interleukin-21 production" -"GO:1905315","cell proliferation involved in endocardial cushion morphogenesis" -"GO:0050888","determination of stimulus location" -"GO:0034656","nucleobase-containing small molecule catabolic process" -"GO:0032751","positive regulation of interleukin-27 production" -"GO:0007182","common-partner SMAD protein phosphorylation" -"GO:1902477","regulation of defense response to bacterium, incompatible interaction" -"GO:0048704","embryonic skeletal system morphogenesis" -"GO:0060398","regulation of growth hormone receptor signaling pathway" -"GO:0048644","muscle organ morphogenesis" -"GO:0061741","chaperone-mediated protein transport involved in chaperone-mediated autophagy" -"GO:0072318","clathrin coat disassembly" -"GO:0032750","positive regulation of interleukin-26 production" -"GO:0046003","negative regulation of syncytial blastoderm mitotic cell cycle" -"GO:0035760","cytoplasmic polyadenylation-dependent rRNA catabolic process" -"GO:1904364","positive regulation of calcitonin secretion" -"GO:0043415","positive regulation of skeletal muscle tissue regeneration" -"GO:0097500","receptor localization to non-motile cilium" -"GO:0035318","imaginal disc-derived wing hair outgrowth" -"GO:0075158","negative regulation of G-protein coupled receptor protein signaling pathway in response to host" -"GO:1903448","geraniol biosynthetic process" -"GO:0030240","skeletal muscle thin filament assembly" -"GO:0035809","regulation of urine volume" -"GO:1905626","positive regulation of L-methionine import across plasma membrane" -"GO:0021902","commitment of neuronal cell to specific neuron type in forebrain" -"GO:0003214","cardiac left ventricle morphogenesis" -"GO:0071417","cellular response to organonitrogen compound" -"GO:0071629","cytoplasm protein quality control by the ubiquitin-proteasome system" -"GO:0051281","positive regulation of release of sequestered calcium ion into cytosol" -"GO:0035788","cell migration involved in metanephros development" -"GO:0035002","liquid clearance, open tracheal system" -"GO:1905398","activated CD4-positive, alpha-beta T cell apoptotic process" -"GO:2000563","positive regulation of CD4-positive, alpha-beta T cell proliferation" -"GO:0070231","T cell apoptotic process" -"GO:0009786","regulation of asymmetric cell division" -"GO:1990086","lens fiber cell apoptotic process" -"GO:0021986","habenula development" -"GO:0050889","determination of stimulus intensity" -"GO:0098747","slow, calcium ion-dependent exocytosis of neurotransmitter" -"GO:0007165","signal transduction" -"GO:1904308","cellular response to desipramine" -"GO:1900323","positive regulation of maltotetraose transport" -"GO:0046805","protein-heme linkage via 1'-L-histidine" -"GO:1905324","telomere-telomerase complex assembly" -"GO:0001406","glycerophosphodiester transmembrane transporter activity" -"GO:1905786","positive regulation of anaphase-promoting complex-dependent catabolic process" -"GO:0032756","positive regulation of interleukin-7 production" -"GO:1903557","positive regulation of tumor necrosis factor superfamily cytokine production" -"GO:0048844","artery morphogenesis" -"GO:0008258","head involution" -"GO:0003322","pancreatic A cell development" -"GO:0048855","adenohypophysis morphogenesis" -"GO:0005456","CMP-N-acetylneuraminate transmembrane transporter activity" -"GO:0006451","translational readthrough" -"GO:2000369","regulation of clathrin-dependent endocytosis" -"GO:1900111","positive regulation of histone H3-K9 dimethylation" -"GO:0021644","vagus nerve morphogenesis" -"GO:1905317","inferior endocardial cushion morphogenesis" -"GO:0071310","cellular response to organic substance" -"GO:2000321","positive regulation of T-helper 17 cell differentiation" -"GO:1905076","regulation of interleukin-17 secretion" -"GO:0000147","actin cortical patch assembly" -"GO:0071357","cellular response to type I interferon" -"GO:0014833","skeletal muscle satellite stem cell asymmetric division" -"GO:0008283","cell proliferation" -"GO:0032739","positive regulation of interleukin-16 production" -"GO:0009880","embryonic pattern specification" -"GO:1990790","response to glial cell derived neurotrophic factor" -"GO:0042138","meiotic DNA double-strand break formation" -"GO:0045376","negative regulation of interleukin-16 biosynthetic process" -"GO:0120039","plasma membrane bounded cell projection morphogenesis" -"GO:1903173","fatty alcohol metabolic process" -"GO:0010712","regulation of collagen metabolic process" -"GO:0016094","polyprenol biosynthetic process" -"GO:0046375","K antigen metabolic process" -"GO:2000388","positive regulation of antral ovarian follicle growth" -"GO:0060029","convergent extension involved in organogenesis" -"GO:1900555","emericellamide metabolic process" -"GO:0060638","mesenchymal-epithelial cell signaling" -"GO:0031989","bombesin receptor signaling pathway" -"GO:1900176","negative regulation of nodal signaling pathway involved in determination of lateral mesoderm left/right asymmetry" -"GO:0051885","positive regulation of timing of anagen" -"GO:1903068","positive regulation of protein localization to cell tip" -"GO:0000469","cleavage involved in rRNA processing" -"GO:0052779","amino disaccharide metabolic process" -"GO:1904073","regulation of trophectodermal cell proliferation" -"GO:0070848","response to growth factor" -"GO:0018378","cytochrome c-heme linkage via heme-L-cysteine" -"GO:0060686","negative regulation of prostatic bud formation" -"GO:0060766","negative regulation of androgen receptor signaling pathway" -"GO:1901838","positive regulation of transcription of nucleolar large rRNA by RNA polymerase I" -"GO:1904815","negative regulation of protein localization to chromosome, telomeric region" -"GO:1905711","response to phosphatidylethanolamine" -"GO:0032305","positive regulation of icosanoid secretion" -"GO:0061354","planar cell polarity pathway involved in pericardium morphogenesis" -"GO:0150012","positive regulation of neuron projection arborization" -"GO:0033628","regulation of cell adhesion mediated by integrin" -"GO:0015903","fluconazole transport" -"GO:0032686","negative regulation of hepatocyte growth factor production" -"GO:0042909","acridine transport" -"GO:0060067","cervix development" -"GO:0032622","interleukin-19 production" -"GO:1903416","response to glycoside" -"GO:0031098","stress-activated protein kinase signaling cascade" -"GO:0006264","mitochondrial DNA replication" -"GO:0046013","regulation of T cell homeostatic proliferation" -"GO:0061516","monocyte proliferation" -"GO:1905035","negative regulation of antifungal innate immune response" -"GO:0010171","body morphogenesis" -"GO:0006975","DNA damage induced protein phosphorylation" -"GO:0036413","histone H3-R26 citrullination" -"GO:0021949","brainstem precerebellar neuron precursor migration" -"GO:0044773","mitotic DNA damage checkpoint" -"GO:1905406","positive regulation of mitotic cohesin loading" -"GO:0070348","negative regulation of brown fat cell proliferation" -"GO:0034439","lipoprotein lipid oxidation" -"GO:0032058","positive regulation of translational initiation in response to stress" -"GO:0032147","activation of protein kinase activity" -"GO:0097325","melanocyte proliferation" -"GO:0061682","seminal vesicle morphogenesis" -"GO:0052309","negative regulation by organism of innate immune response in other organism involved in symbiotic interaction" -"GO:2000002","negative regulation of DNA damage checkpoint" -"GO:1990798","pancreas regeneration" -"GO:1902229","regulation of intrinsic apoptotic signaling pathway in response to DNA damage" -"GO:0019546","arginine deiminase pathway" -"GO:0006587","serotonin biosynthetic process from tryptophan" -"GO:0014905","myoblast fusion involved in skeletal muscle regeneration" -"GO:0030825","positive regulation of cGMP metabolic process" -"GO:0097192","extrinsic apoptotic signaling pathway in absence of ligand" -"GO:0070498","interleukin-1-mediated signaling pathway" -"GO:0038169","somatostatin receptor signaling pathway" -"GO:0006390","mitochondrial transcription" -"GO:0014861","regulation of skeletal muscle contraction via regulation of action potential" -"GO:0045684","positive regulation of epidermis development" -"GO:0052301","modulation by organism of defense-related calcium ion flux in other organism involved in symbiotic interaction" -"GO:0072180","mesonephric duct morphogenesis" -"GO:0038084","vascular endothelial growth factor signaling pathway" -"GO:0042918","alkanesulfonate transport" -"GO:2000049","positive regulation of cell-cell adhesion mediated by cadherin" -"GO:0030217","T cell differentiation" -"GO:0007524","adult visceral muscle development" -"GO:0016091","prenol biosynthetic process" -"GO:0070755","negative regulation of interleukin-35 production" -"GO:0019466","ornithine catabolic process via proline" -"GO:0032711","negative regulation of interleukin-27 production" -"GO:0032231","regulation of actin filament bundle assembly" -"GO:0060532","bronchus cartilage development" -"GO:0000162","tryptophan biosynthetic process" -"GO:0070550","rDNA condensation" -"GO:1904355","positive regulation of telomere capping" -"GO:0008292","acetylcholine biosynthetic process" -"GO:0032097","positive regulation of response to food" -"GO:1902898","fatty acid methyl ester metabolic process" -"GO:0035803","egg coat formation" -"GO:1901537","positive regulation of DNA demethylation" -"GO:0007523","larval visceral muscle development" -"GO:1902810","negative regulation of skeletal muscle fiber differentiation" -"GO:0007315","pole plasm assembly" -"GO:0007346","regulation of mitotic cell cycle" -"GO:0061157","mRNA destabilization" -"GO:0072201","negative regulation of mesenchymal cell proliferation" -"GO:1901344","response to leptomycin B" -"GO:0015900","benomyl transport" -"GO:0000757","signal transduction involved in regulation of conjugation with mutual genetic exchange" -"GO:0034111","negative regulation of homotypic cell-cell adhesion" -"GO:0002922","positive regulation of humoral immune response" -"GO:0018101","protein citrullination" -"GO:0071169","establishment of protein localization to chromatin" -"GO:0051948","negative regulation of glutamate uptake involved in transmission of nerve impulse" -"GO:0072094","metanephric renal vesicle induction" -"GO:0001109","promoter clearance during DNA-templated transcription" -"GO:0001776","leukocyte homeostasis" -"GO:0060331","negative regulation of response to interferon-gamma" -"GO:2000096","positive regulation of Wnt signaling pathway, planar cell polarity pathway" -"GO:0007019","microtubule depolymerization" -"GO:0048726","labrum development" -"GO:1903244","positive regulation of cardiac muscle hypertrophy in response to stress" -"GO:1904249","negative regulation of age-related resistance" -"GO:0007208","phospholipase C-activating serotonin receptor signaling pathway" -"GO:0034421","post-translational protein acetylation" -"GO:0097401","synaptic vesicle lumen acidification" -"GO:0035588","G-protein coupled purinergic receptor signaling pathway" -"GO:0006646","phosphatidylethanolamine biosynthetic process" -"GO:0046474","glycerophospholipid biosynthetic process" -"GO:0060958","endocardial cell development" -"GO:1900747","negative regulation of vascular endothelial growth factor signaling pathway" -"GO:0019479","L-alanine oxidation to D-lactate and ammonia" -"GO:0000186","activation of MAPKK activity" -"GO:0032704","negative regulation of interleukin-20 production" -"GO:0043977","histone H2A-K5 acetylation" -"GO:0045995","regulation of embryonic development" -"GO:0002609","positive regulation of myeloid dendritic cell antigen processing and presentation" -"GO:0035009","negative regulation of melanization defense response" -"GO:0006352","DNA-templated transcription, initiation" -"GO:0010879","cholesterol transport involved in cholesterol storage" -"GO:0045591","positive regulation of regulatory T cell differentiation" -"GO:0071921","cohesin loading" -"GO:1903392","negative regulation of adherens junction organization" -"GO:0071345","cellular response to cytokine stimulus" -"GO:2000368","positive regulation of acrosomal vesicle exocytosis" -"GO:0051450","myoblast proliferation" -"GO:1901137","carbohydrate derivative biosynthetic process" -"GO:0000375","RNA splicing, via transesterification reactions" -"GO:1905681","negative regulation of innate immunity memory response" -"GO:0042374","phylloquinone metabolic process" -"GO:0099509","regulation of presynaptic cytosolic calcium ion concentration" -"GO:0046644","negative regulation of gamma-delta T cell activation" -"GO:0048144","fibroblast proliferation" -"GO:0014011","Schwann cell proliferation involved in axon regeneration" -"GO:0016441","posttranscriptional gene silencing" -"GO:0001192","maintenance of transcriptional fidelity during DNA-templated transcription elongation" -"GO:0097646","calcitonin family receptor signaling pathway" -"GO:0090634","microglial cell mediated cytotoxicity" -"GO:2000360","negative regulation of binding of sperm to zona pellucida" -"GO:0006195","purine nucleotide catabolic process" -"GO:0015906","sulfathiazole transport" -"GO:0002687","positive regulation of leukocyte migration" -"GO:1904550","response to arachidonic acid" -"GO:0032710","negative regulation of interleukin-26 production" -"GO:1990596","histone H3-K4 deacetylation" -"GO:1901108","granaticin catabolic process" -"GO:0045082","positive regulation of interleukin-10 biosynthetic process" -"GO:0032705","negative regulation of interleukin-21 production" -"GO:0090507","phenylethylamine metabolic process involved in synaptic transmission" -"GO:1905903","negative regulation of mesoderm formation" -"GO:0044257","cellular protein catabolic process" -"GO:0007211","octopamine or tyramine signaling pathway" -"GO:2000386","positive regulation of ovarian follicle development" -"GO:0018022","peptidyl-lysine methylation" -"GO:0000708","meiotic strand invasion" -"GO:0060775","planar cell polarity pathway involved in gastrula mediolateral intercalation" -"GO:0048848","neurohypophysis morphogenesis" -"GO:2000139","regulation of octopamine signaling pathway involved in response to food" -"GO:0002366","leukocyte activation involved in immune response" -"GO:0043377","negative regulation of CD8-positive, alpha-beta T cell differentiation" -"GO:1903926","cellular response to bisphenol A" -"GO:1904862","inhibitory synapse assembly" -"GO:0002174","mammary stem cell proliferation" -"GO:0030845","phospholipase C-inhibiting G-protein coupled receptor signaling pathway" -"GO:0072087","renal vesicle development" -"GO:0019356","nicotinate nucleotide biosynthetic process from tryptophan" -"GO:1903554","G-protein coupled receptor signaling pathway involved in defense response to Gram-negative bacterium" -"GO:1903127","positive regulation of centriole-centriole cohesion" -"GO:0045026","plasma membrane fusion" -"GO:0010243","response to organonitrogen compound" -"GO:1904926","response to palmitoleic acid" -"GO:1902669","positive regulation of axon guidance" -"GO:0071923","negative regulation of cohesin loading" -"GO:0032327","W-molybdopterin cofactor catabolic process" -"GO:0048665","neuron fate specification" -"GO:0006270","DNA replication initiation" -"GO:0033578","protein glycosylation in Golgi" -"GO:2000566","positive regulation of CD8-positive, alpha-beta T cell proliferation" -"GO:1905884","negative regulation of triglyceride transport" -"GO:0071163","DNA replication preinitiation complex assembly" -"GO:0003165","Purkinje myocyte development" -"GO:0060641","mammary gland duct regression in males" -"GO:0042254","ribosome biogenesis" -"GO:0006367","transcription initiation from RNA polymerase II promoter" -"GO:1903573","negative regulation of response to endoplasmic reticulum stress" -"GO:1900275","negative regulation of phospholipase C activity" -"GO:0035887","aortic smooth muscle cell differentiation" -"GO:0046967","cytosol to ER transport" -"GO:0045105","intermediate filament polymerization or depolymerization" -"GO:0098535","de novo centriole assembly involved in multi-ciliated epithelial cell differentiation" -"GO:1903053","regulation of extracellular matrix organization" -"GO:0018907","dimethyl sulfoxide metabolic process" -"GO:0046110","xanthine metabolic process" -"GO:2000781","positive regulation of double-strand break repair" -"GO:0045770","positive regulation of asymmetric cell division" -"GO:0008156","negative regulation of DNA replication" -"GO:1900016","negative regulation of cytokine production involved in inflammatory response" -"GO:0051412","response to corticosterone" -"GO:0006268","DNA unwinding involved in DNA replication" -"GO:0045607","regulation of inner ear auditory receptor cell differentiation" -"GO:0046541","saliva secretion" -"GO:1990700","nucleolar chromatin organization" -"GO:0016999","antibiotic metabolic process" -"GO:0070376","regulation of ERK5 cascade" -"GO:0010391","glucomannan metabolic process" -"GO:0009629","response to gravity" -"GO:1905246","negative regulation of aspartic-type peptidase activity" -"GO:0043983","histone H4-K12 acetylation" -"GO:0035563","positive regulation of chromatin binding" -"GO:0036484","trunk neural crest cell migration" -"GO:0043105","negative regulation of GTP cyclohydrolase I activity" -"GO:0002333","transitional one stage B cell differentiation" -"GO:0051882","mitochondrial depolarization" -"GO:0061739","protein lipidation involved in autophagosome assembly" -"GO:0031448","positive regulation of fast-twitch skeletal muscle fiber contraction" -"GO:0019470","4-hydroxyproline catabolic process" -"GO:0035498","carnosine metabolic process" -"GO:1903420","protein localization to endoplasmic reticulum tubular network" -"GO:0046506","sulfolipid biosynthetic process" -"GO:0097302","lipoprotein biosynthetic process via diacylglyceryl transfer" -"GO:0002743","negative regulation of cytokine biosynthetic process involved in immune response" -"GO:0036510","trimming of terminal mannose on C branch" -"GO:1904668","positive regulation of ubiquitin protein ligase activity" -"GO:1903641","positive regulation of gastrin-induced gastric acid secretion" -"GO:0050798","activated T cell proliferation" -"GO:0002739","regulation of cytokine secretion involved in immune response" -"GO:0033029","regulation of neutrophil apoptotic process" -"GO:0019883","antigen processing and presentation of endogenous antigen" -"GO:1903059","regulation of protein lipidation" -"GO:1901813","astaxanthin metabolic process" -"GO:2001165","positive regulation of phosphorylation of RNA polymerase II C-terminal domain serine 2 residues" -"GO:0000082","G1/S transition of mitotic cell cycle" -"GO:0051465","negative regulation of corticotropin-releasing hormone secretion" -"GO:0052653","3',5'-cyclic diguanylic acid metabolic process" -"GO:0075047","negative regulation of formation by symbiont of haustorium for nutrient acquisition from host" -"GO:0060764","cell-cell signaling involved in mammary gland development" -"GO:2000104","negative regulation of DNA-dependent DNA replication" -"GO:1902209","negative regulation of bacterial-type flagellum assembly" -"GO:1901847","nicotinate metabolic process" -"GO:0045876","positive regulation of sister chromatid cohesion" -"GO:2000109","regulation of macrophage apoptotic process" -"GO:0031658","negative regulation of cyclin-dependent protein serine/threonine kinase activity involved in G1/S transition of mitotic cell cycle" -"GO:0030002","cellular anion homeostasis" -"GO:1901867","ecgonine methyl ester metabolic process" -"GO:1902795","heterochromatin domain assembly" -"GO:1902250","regulation of erythrocyte apoptotic process" -"GO:1903184","L-dopa metabolic process" -"GO:0044093","positive regulation of molecular function" -"GO:1904426","positive regulation of GTP binding" -"GO:0034614","cellular response to reactive oxygen species" -"GO:1905125","positive regulation of glucosylceramidase activity" -"GO:0006853","carnitine shuttle" -"GO:0018917","fluorene metabolic process" -"GO:0032079","positive regulation of endodeoxyribonuclease activity" -"GO:1902374","regulation of rRNA catabolic process" -"GO:0045976","negative regulation of mitotic cell cycle, embryonic" -"GO:0006558","L-phenylalanine metabolic process" -"GO:0034402","recruitment of 3'-end processing factors to RNA polymerase II holoenzyme complex" -"GO:0070730","cAMP transport" -"GO:0031509","telomeric heterochromatin assembly" -"GO:1901748","leukotriene D4 metabolic process" -"GO:0048871","multicellular organismal homeostasis" -"GO:0030497","fatty acid elongation" -"GO:1901775","mitomycin C metabolic process" -"GO:0003355","cilium movement involved in otolith formation" -"GO:2001295","malonyl-CoA biosynthetic process" -"GO:0000394","RNA splicing, via endonucleolytic cleavage and ligation" -"GO:0046146","tetrahydrobiopterin metabolic process" -"GO:0050862","positive regulation of T cell receptor signaling pathway" -"GO:0002544","chronic inflammatory response" -"GO:0031179","peptide modification" -"GO:2000655","negative regulation of cellular response to testosterone stimulus" -"GO:0009610","response to symbiotic fungus" -"GO:1900121","negative regulation of receptor binding" -"GO:1900042","positive regulation of interleukin-2 secretion" -"GO:0000079","regulation of cyclin-dependent protein serine/threonine kinase activity" -"GO:0007449","proximal/distal pattern formation, imaginal disc" -"GO:0048739","cardiac muscle fiber development" -"GO:0033555","multicellular organismal response to stress" -"GO:1905832","positive regulation of spindle assembly" -"GO:0070468","dentin secretion" -"GO:0019310","inositol catabolic process" -"GO:0006030","chitin metabolic process" -"GO:0050777","negative regulation of immune response" -"GO:0072719","cellular response to cisplatin" -"GO:1902794","heterochromatin island assembly" -"GO:0006687","glycosphingolipid metabolic process" -"GO:0060662","salivary gland cavitation" -"GO:0035908","ventral aorta development" -"GO:0002602","negative regulation of antigen processing and presentation of polysaccharide antigen via MHC class II" -"GO:0090181","regulation of cholesterol metabolic process" -"GO:1904917","L-arginine transmembrane transport from lysosomal lumen to cytosol" -"GO:1904976","cellular response to bleomycin" -"GO:2000619","negative regulation of histone H4-K16 acetylation" -"GO:1902505","negative regulation of signal transduction involved in mitotic G2 DNA damage checkpoint" -"GO:1902115","regulation of organelle assembly" -"GO:0070869","heterochromatin assembly involved in chromatin silencing" -"GO:0045403","negative regulation of interleukin-4 biosynthetic process" -"GO:0061002","negative regulation of dendritic spine morphogenesis" -"GO:0015801","aromatic amino acid transport" -"GO:1905891","regulation of cellular response to thapsigargin" -"GO:0006190","inosine salvage" -"GO:0002063","chondrocyte development" -"GO:1905957","regulation of cellular response to alcohol" -"GO:0019504","stachydrine catabolic process" -"GO:0036241","glutamate catabolic process to 4-hydroxybutyrate" -"GO:0038031","non-canonical Wnt signaling pathway via JNK cascade" -"GO:0060275","maintenance of stationary phase in response to starvation" -"GO:0071376","cellular response to corticotropin-releasing hormone stimulus" -"GO:0046952","ketone body catabolic process" -"GO:0031919","vitamin B6 transport" -"GO:0045531","regulation of interleukin-27 biosynthetic process" -"GO:0016204","determination of muscle attachment site" -"GO:0016561","protein import into peroxisome matrix, translocation" -"GO:0060444","branching involved in mammary gland duct morphogenesis" -"GO:1904306","positive regulation of gastro-intestinal system smooth muscle contraction" -"GO:1905065","positive regulation of vascular smooth muscle cell differentiation" -"GO:1901020","negative regulation of calcium ion transmembrane transporter activity" -"GO:2000060","positive regulation of ubiquitin-dependent protein catabolic process" -"GO:0099564","modification of synaptic structure, modulating synaptic transmission" -"GO:0032970","regulation of actin filament-based process" -"GO:0090304","nucleic acid metabolic process" -"GO:0060673","cell-cell signaling involved in placenta development" -"GO:0009447","putrescine catabolic process" -"GO:0019657","glycolytic fermentation to propionate" -"GO:0002432","granuloma formation" -"GO:1901094","negative regulation of protein homotetramerization" -"GO:0010939","regulation of necrotic cell death" -"GO:0006860","extracellular amino acid transport" -"GO:0051315","attachment of mitotic spindle microtubules to kinetochore" -"GO:0010666","positive regulation of cardiac muscle cell apoptotic process" -"GO:0002542","Factor XII activation" -"GO:0097699","vascular endothelial cell response to fluid shear stress" -"GO:1905341","negative regulation of protein localization to kinetochore" -"GO:0048681","negative regulation of axon regeneration" -"GO:0018299","iron incorporation into the Rieske iron-sulfur cluster via bis-L-cysteinyl bis-L-histidino diiron disulfide" -"GO:0071951","conversion of methionyl-tRNA to N-formyl-methionyl-tRNA" -"GO:1902905","positive regulation of supramolecular fiber organization" -"GO:0045554","regulation of TRAIL biosynthetic process" -"GO:0046223","aflatoxin catabolic process" -"GO:1903984","positive regulation of TRAIL-activated apoptotic signaling pathway" -"GO:0033610","oxalate biosynthetic process" -"GO:0034694","response to prostaglandin" -"GO:0000381","regulation of alternative mRNA splicing, via spliceosome" -"GO:1905609","positive regulation of smooth muscle cell-matrix adhesion" -"GO:0050754","positive regulation of fractalkine biosynthetic process" -"GO:0046999","regulation of conjugation" -"GO:1903982","negative regulation of microvillus length" -"GO:1902160","negative regulation of cyclic nucleotide-gated ion channel activity" -"GO:2000220","regulation of pseudohyphal growth" -"GO:1900190","regulation of single-species biofilm formation" -"GO:0002342","central B cell deletion" -"GO:1904056","positive regulation of cholangiocyte proliferation" -"GO:1902426","deactivation of mitotic spindle assembly checkpoint" -"GO:1904063","negative regulation of cation transmembrane transport" -"GO:0098870","action potential propagation" -"GO:0015937","coenzyme A biosynthetic process" -"GO:0042268","regulation of cytolysis" -"GO:0099156","cell-cell signaling via exosome" -"GO:0021955","central nervous system neuron axonogenesis" -"GO:0045714","regulation of low-density lipoprotein particle receptor biosynthetic process" -"GO:0038133","ERBB2-ERBB3 signaling pathway" -"GO:0010050","vegetative phase change" -"GO:0045420","regulation of connective tissue growth factor biosynthetic process" -"GO:1990688","Golgi vesicle fusion with endoplasmic reticulum-Golgi intermediate compartment (ERGIC) membrane" -"GO:0032821","negative regulation of natural killer cell proliferation involved in immune response" -"GO:0015807","L-amino acid transport" -"GO:0045584","negative regulation of cytotoxic T cell differentiation" -"GO:0051923","sulfation" -"GO:0070750","regulation of interleukin-35 biosynthetic process" -"GO:0042149","cellular response to glucose starvation" -"GO:0002838","negative regulation of immune response to tumor cell" -"GO:0060995","cell-cell signaling involved in kidney development" -"GO:1902595","regulation of DNA replication origin binding" -"GO:0033674","positive regulation of kinase activity" -"GO:1901894","regulation of calcium-transporting ATPase activity" -"GO:0044721","protein import into peroxisome matrix, substrate release" -"GO:1903788","positive regulation of glutathione biosynthetic process" -"GO:1904017","cellular response to Thyroglobulin triiodothyronine" -"GO:0038015","positive regulation of insulin receptor signaling pathway by insulin receptor internalization" -"GO:0015830","diaminopimelate transport" -"GO:0033198","response to ATP" -"GO:0018147","molybdenum incorporation via L-selenocysteinyl molybdenum bis(molybdopterin guanine dinucleotide)" -"GO:0042051","compound eye photoreceptor development" -"GO:0039704","viral translational shunt" -"GO:0046342","CDP-diacylglycerol catabolic process" -"GO:0030702","chromatin silencing at centromere" -"GO:0019541","propionate metabolic process" -"GO:0031457","glycine betaine catabolic process" -"GO:0034453","microtubule anchoring" -"GO:2000272","negative regulation of signaling receptor activity" -"GO:0060495","cell-cell signaling involved in lung development" -"GO:1902649","regulation of histone H2A-H2B dimer displacement" -"GO:0090160","Golgi to lysosome transport" -"GO:0086023","adenylate cyclase-activating adrenergic receptor signaling pathway involved in heart process" -"GO:2001258","negative regulation of cation channel activity" -"GO:0010693","negative regulation of alkaline phosphatase activity" -"GO:0034171","regulation of toll-like receptor 11 signaling pathway" -"GO:0070904","transepithelial L-ascorbic acid transport" -"GO:2000337","positive regulation of endothelial microparticle formation" -"GO:0032833","negative regulation of CD4-positive, CD25-positive, alpha-beta regulatory T cell differentiation involved in immune response" -"GO:0051383","kinetochore organization" -"GO:1904109","positive regulation of cholesterol import" -"GO:1900049","regulation of histone exchange" -"GO:1903548","negative regulation of growth hormone activity" -"GO:0061572","actin filament bundle organization" -"GO:0036499","PERK-mediated unfolded protein response" -"GO:0030264","nuclear fragmentation involved in apoptotic nuclear change" -"GO:0055119","relaxation of cardiac muscle" -"GO:2000612","regulation of thyroid-stimulating hormone secretion" -"GO:0046058","cAMP metabolic process" -"GO:1902525","regulation of protein monoubiquitination" -"GO:0033617","mitochondrial respiratory chain complex IV assembly" -"GO:0046208","spermine catabolic process" -"GO:0003136","negative regulation of heart induction by canonical Wnt signaling pathway" -"GO:0030416","methylamine metabolic process" -"GO:0019732","antifungal humoral response" -"GO:0006696","ergosterol biosynthetic process" -"GO:0060024","rhythmic synaptic transmission" -"GO:0031286","negative regulation of sorocarp stalk cell differentiation" -"GO:0044345","stromal-epithelial cell signaling involved in prostate gland development" -"GO:0030001","metal ion transport" -"GO:0036003","positive regulation of transcription from RNA polymerase II promoter in response to stress" -"GO:1900060","negative regulation of ceramide biosynthetic process" -"GO:0052710","N-alpha,N-alpha,N-alpha-trimethyl-L-histidine catabolic process" -"GO:1903307","positive regulation of regulated secretory pathway" -"GO:2000105","positive regulation of DNA-dependent DNA replication" -"GO:1905389","response to leukotriene B4" -"GO:0030831","positive regulation of cGMP catabolic process" -"GO:1902425","positive regulation of attachment of mitotic spindle microtubules to kinetochore" -"GO:0045390","regulation of interleukin-21 biosynthetic process" -"GO:0033598","mammary gland epithelial cell proliferation" -"GO:0032076","negative regulation of deoxyribonuclease activity" -"GO:0033262","regulation of nuclear cell cycle DNA replication" -"GO:0001550","ovarian cumulus expansion" -"GO:0036091","positive regulation of transcription from RNA polymerase II promoter in response to oxidative stress" -"GO:0045363","regulation of interleukin-11 biosynthetic process" -"GO:1902275","regulation of chromatin organization" -"GO:1901350","cell-cell signaling involved in cell-cell junction organization" -"GO:0032913","negative regulation of transforming growth factor beta3 production" -"GO:1902334","fructose export from vacuole to cytoplasm" -"GO:0046656","folic acid biosynthetic process" -"GO:0001560","regulation of cell growth by extracellular stimulus" -"GO:0014734","skeletal muscle hypertrophy" -"GO:1904753","negative regulation of vascular associated smooth muscle cell migration" -"GO:0032581","ER-dependent peroxisome organization" -"GO:0045530","regulation of interleukin-26 biosynthetic process" -"GO:0006596","polyamine biosynthetic process" -"GO:0042108","positive regulation of cytokine biosynthetic process" -"GO:0032379","positive regulation of intracellular lipid transport" -"GO:0045168","cell-cell signaling involved in cell fate commitment" -"GO:0034654","nucleobase-containing compound biosynthetic process" -"GO:0061233","mesonephric glomerular basement membrane development" -"GO:0010815","bradykinin catabolic process" -"GO:0048337","positive regulation of mesodermal cell fate specification" -"GO:1904608","response to monosodium L-glutamate" -"GO:0036250","peroxisome transport along microtubule" -"GO:0090337","regulation of formin-nucleated actin cable assembly" -"GO:1901895","negative regulation of calcium-transporting ATPase activity" -"GO:0016558","protein import into peroxisome matrix" -"GO:1904197","positive regulation of granulosa cell proliferation" -"GO:1904058","positive regulation of sensory perception of pain" -"GO:0072708","response to sorbitol" -"GO:0045369","regulation of interleukin-14 biosynthetic process" -"GO:0007264","small GTPase mediated signal transduction" -"GO:2000578","negative regulation of ATP-dependent microtubule motor activity, minus-end-directed" -"GO:0002764","immune response-regulating signaling pathway" -"GO:1904791","negative regulation of shelterin complex assembly" -"GO:1901367","response to L-cysteine" -"GO:0042883","cysteine transport" -"GO:1900226","negative regulation of NLRP3 inflammasome complex assembly" -"GO:0031644","regulation of neurological system process" -"GO:0006836","neurotransmitter transport" -"GO:0000472","endonucleolytic cleavage to generate mature 5'-end of SSU-rRNA from (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:0071608","macrophage inflammatory protein-1 alpha production" -"GO:0120041","positive regulation of macrophage proliferation" -"GO:1902170","cellular response to reactive nitrogen species" -"GO:1901370","response to glutathione" -"GO:0000022","mitotic spindle elongation" -"GO:0006165","nucleoside diphosphate phosphorylation" -"GO:0070779","D-aspartate import across plasma membrane" -"GO:0052555","positive regulation by organism of immune response of other organism involved in symbiotic interaction" -"GO:0010607","negative regulation of cytoplasmic mRNA processing body assembly" -"GO:0070479","nuclear-transcribed mRNA catabolic process, 5'-3' exonucleolytic nonsense-mediated decay" -"GO:0040009","regulation of growth rate" -"GO:0003044","regulation of systemic arterial blood pressure mediated by a chemical signal" -"GO:1901593","response to GW 7647" -"GO:0060188","regulation of protein desumoylation" -"GO:0010562","positive regulation of phosphorus metabolic process" -"GO:0007214","gamma-aminobutyric acid signaling pathway" -"GO:1905245","regulation of aspartic-type peptidase activity" -"GO:0071255","Cvt vesicle assembly" -"GO:0050945","positive regulation of iridophore differentiation" -"GO:0030050","vesicle transport along actin filament" -"GO:0045953","negative regulation of natural killer cell mediated cytotoxicity" -"GO:1900110","negative regulation of histone H3-K9 dimethylation" -"GO:0014847","proximal stomach smooth muscle contraction" -"GO:1903119","protein localization to actin cytoskeleton" -"GO:0050946","positive regulation of xanthophore differentiation" -"GO:0045681","positive regulation of R8 cell differentiation" -"GO:1902418","(+)-abscisic acid D-glucopyranosyl ester transmembrane transport" -"GO:1904955","planar cell polarity pathway involved in midbrain dopaminergic neuron differentiation" -"GO:0048888","neuromast mantle cell differentiation" -"GO:1900113","negative regulation of histone H3-K9 trimethylation" -"GO:0001207","histone displacement" -"GO:1903583","positive regulation of basophil degranulation" -"GO:0014055","acetylcholine secretion, neurotransmission" -"GO:0035853","chromosome passenger complex localization to spindle midzone" -"GO:1900106","positive regulation of hyaluranon cable assembly" -"GO:0098776","protein transport across the cell outer membrane" -"GO:0042419","epinephrine catabolic process" -"GO:0050712","negative regulation of interleukin-1 alpha secretion" -"GO:1902443","negative regulation of ripoptosome assembly involved in necroptotic process" -"GO:0032272","negative regulation of protein polymerization" -"GO:0080175","phragmoplast microtubule organization" -"GO:0002361","CD4-positive, CD25-positive, alpha-beta regulatory T cell differentiation" -"GO:0070543","response to linoleic acid" -"GO:0021910","smoothened signaling pathway involved in ventral spinal cord patterning" -"GO:0010809","negative regulation of synaptic vesicle priming" -"GO:0043311","positive regulation of eosinophil degranulation" -"GO:1902474","positive regulation of protein localization to synapse" -"GO:0099606","microtubule plus-end directed mitotic chromosome migration" -"GO:1903742","regulation of anterograde synaptic vesicle transport" -"GO:0097446","protein localization to eisosome filament" -"GO:1900513","negative regulation of starch utilization system complex assembly" -"GO:0110024","positive regulation of cardiac muscle myoblast proliferation" -"GO:0045987","positive regulation of smooth muscle contraction" -"GO:0090455","ornithine transmembrane import into vacuole" -"GO:0039672","suppression by virus of host natural killer cell activation" -"GO:0048777","positive regulation of leucophore differentiation" -"GO:2000305","semaphorin-plexin signaling pathway involved in regulation of photoreceptor cell axon guidance" -"GO:0002720","positive regulation of cytokine production involved in immune response" -"GO:1904628","cellular response to phorbol 13-acetate 12-myristate" -"GO:0042203","toluene catabolic process" -"GO:0046530","photoreceptor cell differentiation" -"GO:0072698","protein localization to microtubule cytoskeleton" -"GO:0051958","methotrexate transport" -"GO:0005513","detection of calcium ion" -"GO:1901121","tobramycin biosynthetic process" -"GO:0002430","complement receptor mediated signaling pathway" -"GO:0015074","DNA integration" -"GO:1901280","D-ribose 5-phosphate biosynthetic process" -"GO:0030842","regulation of intermediate filament depolymerization" -"GO:1904883","negative regulation of telomerase catalytic core complex assembly" -"GO:0061206","mesonephros morphogenesis" -"GO:0042675","compound eye cone cell differentiation" -"GO:0009636","response to toxic substance" -"GO:0071701","regulation of MAPK export from nucleus" -"GO:0022619","generative cell differentiation" -"GO:0007190","activation of adenylate cyclase activity" -"GO:0018287","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl triiron tetrasulfide" -"GO:1901663","quinone biosynthetic process" -"GO:1901191","negative regulation of formation of translation initiation ternary complex" -"GO:0061349","planar cell polarity pathway involved in cardiac right atrium morphogenesis" -"GO:0003092","renal water retention" -"GO:0043322","negative regulation of natural killer cell degranulation" -"GO:0045782","positive regulation of cell budding" -"GO:0051592","response to calcium ion" -"GO:0090133","mesendoderm migration" -"GO:0000489","maturation of SSU-rRNA from tetracistronic rRNA transcript (SSU-rRNA, LSU-rRNA, 4.5S-rRNA, 5S-rRNA)" -"GO:0035080","heat shock-mediated polytene chromosome puffing" -"GO:1903054","negative regulation of extracellular matrix organization" -"GO:0007163","establishment or maintenance of cell polarity" -"GO:0043953","protein transport by the Tat complex" -"GO:2001056","positive regulation of cysteine-type endopeptidase activity" -"GO:0046711","GDP biosynthetic process" -"GO:0006409","tRNA export from nucleus" -"GO:0022620","vegetative cell differentiation" -"GO:0005471","ATP:ADP antiporter activity" -"GO:0036465","synaptic vesicle recycling" -"GO:0061307","cardiac neural crest cell differentiation involved in heart development" -"GO:0036346","cellular response to L-cysteine" -"GO:0071286","cellular response to magnesium ion" -"GO:0008594","photoreceptor cell morphogenesis" -"GO:1903285","positive regulation of hydrogen peroxide catabolic process" -"GO:0060728","negative regulation of coreceptor activity involved in epidermal growth factor receptor signaling pathway" -"GO:2000392","regulation of lamellipodium morphogenesis" -"GO:0090100","positive regulation of transmembrane receptor protein serine/threonine kinase signaling pathway" -"GO:0031468","nuclear envelope reassembly" -"GO:0003328","pancreatic D cell fate commitment" -"GO:0060239","positive regulation of signal transduction involved in conjugation with cellular fusion" -"GO:1905363","positive regulation of endosomal vesicle fusion" -"GO:0042323","negative regulation of circadian sleep/wake cycle, non-REM sleep" -"GO:0019714","peptidyl-glutamine esterification" -"GO:0018277","protein deamination" -"GO:2000180","negative regulation of androgen biosynthetic process" -"GO:0006974","cellular response to DNA damage stimulus" -"GO:0010458","exit from mitosis" -"GO:0044397","actin cortical patch internalization" -"GO:0046532","regulation of photoreceptor cell differentiation" -"GO:0090648","response to environmental enrichment" -"GO:0042034","peptidyl-L-lysine methyl ester biosynthetic process from peptidyl-lysine" -"GO:0090148","membrane fission" -"GO:0090117","endosome to lysosome transport of low-density lipoprotein particle" -"GO:0035759","mesangial cell-matrix adhesion" -"GO:0019673","GDP-mannose metabolic process" -"GO:0006940","regulation of smooth muscle contraction" -"GO:2000194","regulation of female gonad development" -"GO:1903382","negative regulation of endoplasmic reticulum stress-induced neuron intrinsic apoptotic signaling pathway" -"GO:0060705","neuron differentiation involved in salivary gland development" -"GO:1903629","positive regulation of dUTP diphosphatase activity" -"GO:0090218","positive regulation of lipid kinase activity" -"GO:0007175","negative regulation of epidermal growth factor-activated receptor activity" -"GO:0043299","leukocyte degranulation" -"GO:0044262","cellular carbohydrate metabolic process" -"GO:0038190","VEGF-activated neuropilin signaling pathway" -"GO:1905962","glutamatergic neuron differentiation" -"GO:0006789","bilirubin conjugation" -"GO:0052371","regulation by organism of entry into other organism involved in symbiotic interaction" -"GO:0061848","cellular response to cholecystokinin" -"GO:1903546","protein localization to photoreceptor outer segment" -"GO:0035388","positive regulation of Roundabout signaling pathway" -"GO:0046552","photoreceptor cell fate commitment" -"GO:0009789","positive regulation of abscisic acid-activated signaling pathway" -"GO:0051346","negative regulation of hydrolase activity" -"GO:0001921","positive regulation of receptor recycling" -"GO:2000543","positive regulation of gastrulation" -"GO:0050792","regulation of viral process" -"GO:1902073","positive regulation of hypoxia-inducible factor-1alpha signaling pathway" -"GO:0035610","protein side chain deglutamylation" -"GO:0031916","regulation of synaptic metaplasticity" -"GO:1904377","positive regulation of protein localization to cell periphery" -"GO:0051338","regulation of transferase activity" -"GO:0015760","glucose-6-phosphate transport" -"GO:0051553","flavone biosynthetic process" -"GO:0009107","lipoate biosynthetic process" -"GO:1990268","response to gold nanoparticle" -"GO:0070981","L-asparagine biosynthetic process" -"GO:1902188","positive regulation of viral release from host cell" -"GO:0097533","cellular stress response to acid chemical" -"GO:0052203","modulation of catalytic activity in other organism involved in symbiotic interaction" -"GO:1903509","liposaccharide metabolic process" -"GO:1902843","positive regulation of netrin-activated signaling pathway" -"GO:0090312","positive regulation of protein deacetylation" -"GO:1902530","positive regulation of protein linear polyubiquitination" -"GO:0010994","free ubiquitin chain polymerization" -"GO:2001262","positive regulation of semaphorin-plexin signaling pathway" -"GO:1900171","positive regulation of glucocorticoid mediated signaling pathway" -"GO:0075231","modulation of spore movement on or near host" -"GO:0046103","inosine biosynthetic process" -"GO:2000640","positive regulation of SREBP signaling pathway" -"GO:0032818","negative regulation of natural killer cell proliferation" -"GO:0090228","positive regulation of red or far-red light signaling pathway" -"GO:0048822","enucleate erythrocyte development" -"GO:0071636","positive regulation of transforming growth factor beta production" -"GO:0003407","neural retina development" -"GO:1902103","negative regulation of metaphase/anaphase transition of meiotic cell cycle" -"GO:0010954","positive regulation of protein processing" -"GO:0048667","cell morphogenesis involved in neuron differentiation" -"GO:1905275","Rohon-Beard neuron differentiation" -"GO:0007407","neuroblast activation" -"GO:0046111","xanthine biosynthetic process" -"GO:0090259","regulation of retinal ganglion cell axon guidance" -"GO:1903572","positive regulation of protein kinase D signaling" -"GO:0072376","protein activation cascade" -"GO:0070956","negative regulation of neutrophil mediated killing of bacterium" -"GO:0060828","regulation of canonical Wnt signaling pathway" -"GO:0070256","negative regulation of mucus secretion" -"GO:0032261","purine nucleotide salvage" -"GO:0003300","cardiac muscle hypertrophy" -"GO:0097475","motor neuron migration" -"GO:0006529","asparagine biosynthetic process" -"GO:1902046","positive regulation of Fas signaling pathway" -"GO:0035753","maintenance of DNA trinucleotide repeats" -"GO:0060319","primitive erythrocyte differentiation" -"GO:0090611","ubiquitin-independent protein catabolic process via the multivesicular body sorting pathway" -"GO:0002861","regulation of inflammatory response to antigenic stimulus" -"GO:0035494","SNARE complex disassembly" -"GO:0072751","cellular response to L-thialysine" -"GO:0070660","inner ear receptor cell differentiation involved in inner ear sensory epithelium regeneration" -"GO:1905512","regulation of short-term synaptic potentiation" -"GO:0034208","steroid deacetylation" -"GO:0052074","positive regulation by symbiont of host salicylic acid-mediated defense response" -"GO:0090032","negative regulation of steroid hormone biosynthetic process" -"GO:0044861","protein transport into plasma membrane raft" -"GO:1902450","negative regulation of ATP-dependent DNA helicase activity" -"GO:0120033","negative regulation of plasma membrane bounded cell projection assembly" -"GO:1904049","negative regulation of spontaneous neurotransmitter secretion" -"GO:0043103","hypoxanthine salvage" -"GO:1904797","negative regulation of core promoter binding" -"GO:0018174","protein-heme P460 linkage" -"GO:0010911","regulation of isomerase activity" -"GO:0032834","positive regulation of CD4-positive, CD25-positive, alpha-beta regulatory T cell differentiation involved in immune response" -"GO:0006157","deoxyadenosine catabolic process" -"GO:0044566","chondrocyte activation" -"GO:1904029","regulation of cyclin-dependent protein kinase activity" -"GO:0001570","vasculogenesis" -"GO:1901755","vitamin D3 biosynthetic process" -"GO:1902283","negative regulation of primary amine oxidase activity" -"GO:0043007","maintenance of rDNA" -"GO:0032368","regulation of lipid transport" -"GO:0006779","porphyrin-containing compound biosynthetic process" -"GO:0009939","positive regulation of gibberellic acid mediated signaling pathway" -"GO:0031279","regulation of cyclase activity" -"GO:0016080","synaptic vesicle targeting" -"GO:0023059","positive adaptation of signaling pathway" -"GO:0031284","positive regulation of guanylate cyclase activity" -"GO:1905477","positive regulation of protein localization to membrane" -"GO:0080151","positive regulation of salicylic acid mediated signaling pathway" -"GO:0048705","skeletal system morphogenesis" -"GO:0006154","adenosine catabolic process" -"GO:0006127","glycerophosphate shuttle" -"GO:0034699","response to luteinizing hormone" -"GO:1902811","positive regulation of skeletal muscle fiber differentiation" -"GO:0090673","endothelial cell-matrix adhesion" -"GO:2000735","positive regulation of glial cell-derived neurotrophic factor receptor signaling pathway involved in ureteric bud formation" -"GO:0002149","hypochlorous acid biosynthetic process" -"GO:0060550","positive regulation of fructose 1,6-bisphosphate 1-phosphatase activity" -"GO:0060407","negative regulation of penile erection" -"GO:1990878","cellular response to gastrin" -"GO:1905375","cellular response to homocysteine" -"GO:1901732","quercetin metabolic process" -"GO:0010770","positive regulation of cell morphogenesis involved in differentiation" -"GO:1904472","positive regulation of endothelin secretion" -"GO:0044843","cell cycle G1/S phase transition" -"GO:1904887","Wnt signalosome assembly" -"GO:0034394","protein localization to cell surface" -"GO:0048734","proboscis morphogenesis" -"GO:0045822","negative regulation of heart contraction" -"GO:0007414","axonal defasciculation" -"GO:0045086","positive regulation of interleukin-2 biosynthetic process" -"GO:0002300","CD8-positive, alpha-beta intraepithelial T cell differentiation" -"GO:0014045","establishment of endothelial blood-brain barrier" -"GO:0098987","regulation of modification of synapse structure, modulating synaptic transmission" -"GO:0002667","regulation of T cell anergy" -"GO:0099546","protein catabolic process, modulating synaptic transmission" -"GO:0071382","cellular response to prostaglandin I stimulus" -"GO:1900120","regulation of receptor binding" -"GO:0060073","micturition" -"GO:0045066","regulatory T cell differentiation" -"GO:0097264","self proteolysis" -"GO:1905436","negative regulation of histone H3-K4 trimethylation" -"GO:0002863","positive regulation of inflammatory response to antigenic stimulus" -"GO:0002336","B-1 B cell lineage commitment" -"GO:0099550","trans-synaptic signaling, modulating synaptic transmission" -"GO:0072183","negative regulation of nephron tubule epithelial cell differentiation" -"GO:0097334","response to perphenazine" -"GO:0042110","T cell activation" -"GO:0007636","chemosensory jump behavior" -"GO:2000582","positive regulation of ATP-dependent microtubule motor activity, plus-end-directed" -"GO:1905119","response to haloperidol" -"GO:0050672","negative regulation of lymphocyte proliferation" -"GO:1904804","response to latrunculin A" -"GO:0001765","membrane raft assembly" -"GO:0006302","double-strand break repair" -"GO:1903956","response to latrunculin B" -"GO:0021877","forebrain neuron fate commitment" -"GO:1990335","process resulting in tolerance to alcohol" -"GO:0003412","establishment of epithelial cell apical/basal polarity involved in camera-type eye morphogenesis" -"GO:2000852","regulation of corticosterone secretion" -"GO:0036523","positive regulation by symbiont of host cytokine secretion" -"GO:0042812","pheromone catabolic process" -"GO:0006958","complement activation, classical pathway" -"GO:0060702","negative regulation of endoribonuclease activity" -"GO:0097307","response to farnesol" -"GO:2001028","positive regulation of endothelial cell chemotaxis" -"GO:1901427","response to propan-1-ol" -"GO:0014721","twitch skeletal muscle contraction" -"GO:0070873","regulation of glycogen metabolic process" -"GO:0042275","error-free postreplication DNA repair" -"GO:0006843","mitochondrial citrate transmembrane transport" -"GO:2001182","regulation of interleukin-12 secretion" -"GO:0001798","positive regulation of type IIa hypersensitivity" -"GO:0035211","spermathecum morphogenesis" -"GO:1901528","hydrogen peroxide mediated signaling pathway involved in stomatal movement" -"GO:0046641","positive regulation of alpha-beta T cell proliferation" -"GO:0042495","detection of triacyl bacterial lipopeptide" -"GO:0006973","intracellular accumulation of glycerol" -"GO:0048795","swim bladder morphogenesis" -"GO:0009737","response to abscisic acid" -"GO:0048294","negative regulation of isotype switching to IgE isotypes" -"GO:0044758","modulation by symbiont of host synaptic transmission" -"GO:1905092","response to diosgenin" -"GO:0045589","regulation of regulatory T cell differentiation" -"GO:0061552","ganglion morphogenesis" -"GO:0060510","Type II pneumocyte differentiation" -"GO:0052363","catabolism by organism of protein in other organism involved in symbiotic interaction" -"GO:0048911","efferent axon development in anterior lateral line nerve" -"GO:1901798","positive regulation of signal transduction by p53 class mediator" -"GO:1904066","G-protein coupled receptor signaling pathway involved in dauer larval development" -"GO:0007637","proboscis extension reflex" -"GO:0002903","negative regulation of B cell apoptotic process" -"GO:0014068","positive regulation of phosphatidylinositol 3-kinase signaling" -"GO:0035075","response to ecdysone" -"GO:0071309","cellular response to phylloquinone" -"GO:0070637","pyridine nucleoside metabolic process" -"GO:0071221","cellular response to bacterial lipopeptide" -"GO:0003094","glomerular filtration" -"GO:0032060","bleb assembly" -"GO:0046898","response to cycloheximide" -"GO:0097306","cellular response to alcohol" -"GO:0045857","negative regulation of molecular function, epigenetic" -"GO:1904560","response to diphenidol" -"GO:0071526","semaphorin-plexin signaling pathway" -"GO:0014029","neural crest formation" -"GO:0009119","ribonucleoside metabolic process" -"GO:0042496","detection of diacyl bacterial lipopeptide" -"GO:1904252","negative regulation of bile acid metabolic process" -"GO:1903343","positive regulation of meiotic DNA double-strand break formation" -"GO:0061366","behavioral response to chemical pain" -"GO:0031064","negative regulation of histone deacetylation" -"GO:1990173","protein localization to nucleoplasm" -"GO:1902044","regulation of Fas signaling pathway" -"GO:2000844","negative regulation of testosterone secretion" -"GO:1900987","ajmaline catabolic process" -"GO:0006957","complement activation, alternative pathway" -"GO:0035691","macrophage migration inhibitory factor signaling pathway" -"GO:2000320","negative regulation of T-helper 17 cell differentiation" -"GO:0019835","cytolysis" -"GO:0048302","regulation of isotype switching to IgG isotypes" -"GO:0072194","kidney smooth muscle tissue development" -"GO:0055026","negative regulation of cardiac muscle tissue development" -"GO:0045076","regulation of interleukin-2 biosynthetic process" -"GO:0042278","purine nucleoside metabolic process" -"GO:0097017","renal protein absorption" -"GO:0003133","endodermal-mesodermal cell signaling" -"GO:1902946","protein localization to early endosome" -"GO:0045965","negative regulation of ecdysteroid metabolic process" -"GO:2001256","regulation of store-operated calcium entry" -"GO:0045077","negative regulation of interferon-gamma biosynthetic process" -"GO:0014741","negative regulation of muscle hypertrophy" -"GO:1903494","response to dehydroepiandrosterone" -"GO:0032073","negative regulation of restriction endodeoxyribonuclease activity" -"GO:0034105","positive regulation of tissue remodeling" -"GO:0009866","induced systemic resistance, ethylene mediated signaling pathway" -"GO:0034219","carbohydrate transmembrane transport" -"GO:0039008","pronephric nephron tubule morphogenesis" -"GO:0031128","developmental induction" -"GO:0089700","protein kinase D signaling" -"GO:0030449","regulation of complement activation" -"GO:0003093","regulation of glomerular filtration" -"GO:0042089","cytokine biosynthetic process" -"GO:0150018","basal dendrite development" -"GO:1905040","otic placode development" -"GO:0006883","cellular sodium ion homeostasis" -"GO:0075119","positive regulation by symbiont of host G-protein coupled receptor protein signal transduction" -"GO:1904835","dorsal root ganglion morphogenesis" -"GO:0032914","positive regulation of transforming growth factor beta1 production" -"GO:0097393","telomeric repeat-containing RNA transcription" -"GO:0021892","cerebral cortex GABAergic interneuron differentiation" -"GO:0006956","complement activation" -"GO:0017196","N-terminal peptidyl-methionine acetylation" -"GO:0044795","trans-Golgi network to recycling endosome transport" -"GO:0009163","nucleoside biosynthetic process" -"GO:1901355","response to rapamycin" -"GO:0032713","negative regulation of interleukin-4 production" -"GO:0097102","endothelial tip cell fate specification" -"GO:0071381","cellular response to prostaglandin F stimulus" -"GO:0032740","positive regulation of interleukin-17 production" -"GO:0071263","negative regulation of translational initiation in response to starvation" -"GO:0010594","regulation of endothelial cell migration" -"GO:0080170","hydrogen peroxide transmembrane transport" -"GO:0006286","base-excision repair, base-free sugar-phosphate removal" -"GO:0061485","memory T cell proliferation" -"GO:1904975","response to bleomycin" -"GO:0090400","stress-induced premature senescence" -"GO:0009120","deoxyribonucleoside metabolic process" -"GO:0072704","response to mercaptoethanol" -"GO:0009071","serine family amino acid catabolic process" -"GO:0035422","activation of MAPKKK activity involved in innate immune response" -"GO:0016256","N-glycan processing to lysosome" -"GO:0097374","sensory neuron axon guidance" -"GO:0070634","transepithelial ammonium transport" -"GO:0021649","vestibulocochlear nerve structural organization" -"GO:0007057","spindle assembly involved in female meiosis I" -"GO:0001970","positive regulation of activation of membrane attack complex" -"GO:0090206","negative regulation of cholesterol metabolic process" -"GO:0052060","evasion or tolerance by symbiont of host-produced nitric oxide" -"GO:0072288","metanephric proximal tubule morphogenesis" -"GO:2001014","regulation of skeletal muscle cell differentiation" -"GO:0006839","mitochondrial transport" -"GO:1902028","regulation of histone H3-K18 acetylation" -"GO:0032345","negative regulation of aldosterone metabolic process" -"GO:1901563","response to camptothecin" -"GO:1903780","negative regulation of cardiac conduction" -"GO:0007302","nurse cell nucleus anchoring" -"GO:0036323","vascular endothelial growth factor receptor-1 signaling pathway" -"GO:0071348","cellular response to interleukin-11" -"GO:0019636","phosphonoacetate metabolic process" -"GO:0080090","regulation of primary metabolic process" -"GO:0015709","thiosulfate transport" -"GO:0034132","negative regulation of toll-like receptor 1 signaling pathway" -"GO:0046471","phosphatidylglycerol metabolic process" -"GO:0042335","cuticle development" -"GO:1904124","microglial cell migration" -"GO:0071238","cellular response to brefeldin A" -"GO:1901778","pentalenolactone metabolic process" -"GO:0018872","arsonoacetate metabolic process" -"GO:0072035","pre-tubular aggregate formation" -"GO:1904744","positive regulation of telomeric DNA binding" -"GO:0035740","CD8-positive, alpha-beta T cell proliferation" -"GO:0036215","response to stem cell factor" -"GO:0039692","single stranded viral RNA replication via double stranded DNA intermediate" -"GO:0060952","cardiac glial cell development" -"GO:0030205","dermatan sulfate metabolic process" -"GO:0002211","behavioral defense response to insect" -"GO:0007225","patched ligand maturation" -"GO:1902597","positive regulation of DNA replication origin binding" -"GO:0071358","cellular response to type III interferon" -"GO:0019674","NAD metabolic process" -"GO:0006781","succinyl-CoA pathway" -"GO:0006434","seryl-tRNA aminoacylation" -"GO:0007441","anterior midgut (ectodermal) morphogenesis" -"GO:0039690","positive stranded viral RNA replication" -"GO:0033517","myo-inositol hexakisphosphate metabolic process" -"GO:0003197","endocardial cushion development" -"GO:0034607","turning behavior involved in mating" -"GO:0075034","nuclear division involved in appressorium formation on or near host" -"GO:0045075","regulation of interleukin-12 biosynthetic process" -"GO:0071283","cellular response to iron(III) ion" -"GO:0071912","asynchronous neurotransmitter secretion" -"GO:1990668","vesicle fusion with endoplasmic reticulum-Golgi intermediate compartment (ERGIC) membrane" -"GO:1903511","orotic acid metabolic process" -"GO:0120010","intermembrane phospholipid transfer" -"GO:0061530","aspartate secretion, neurotransmission" -"GO:0009435","NAD biosynthetic process" -"GO:0097174","1,6-anhydro-N-acetyl-beta-muramic acid metabolic process" -"GO:0046083","adenine metabolic process" -"GO:1901562","response to paraquat" -"GO:0007534","gene conversion at mating-type locus" -"GO:0070625","zymogen granule exocytosis" -"GO:0048388","endosomal lumen acidification" -"GO:0015702","chlorate transport" -"GO:0032350","regulation of hormone metabolic process" -"GO:0060471","cortical granule exocytosis" -"GO:1901049","atropine metabolic process" -"GO:0043500","muscle adaptation" -"GO:0046482","para-aminobenzoic acid metabolic process" -"GO:0034254","regulation of urea catabolic process" -"GO:0015942","formate metabolic process" -"GO:0060872","semicircular canal development" -"GO:0050851","antigen receptor-mediated signaling pathway" -"GO:0009892","negative regulation of metabolic process" -"GO:0001966","thigmotaxis" -"GO:0051294","establishment of spindle orientation" -"GO:0006028","galactosaminoglycan catabolic process" -"GO:0000316","sulfite transport" -"GO:0003279","cardiac septum development" -"GO:1902522","response to 4'-epidoxorubicin" -"GO:0006875","cellular metal ion homeostasis" -"GO:1905290","negative regulation of CAMKK-AMPK signaling cascade" -"GO:0015710","tellurite transport" -"GO:0097308","cellular response to farnesol" -"GO:0080160","selenate transport" -"GO:0006576","cellular biogenic amine metabolic process" -"GO:0045555","negative regulation of TRAIL biosynthetic process" -"GO:0032847","regulation of cellular pH reduction" -"GO:0046968","peptide antigen transport" -"GO:0030861","negative regulation of polarized epithelial cell differentiation" -"GO:0015703","chromate transport" -"GO:0072401","signal transduction involved in DNA integrity checkpoint" -"GO:0098758","response to interleukin-8" -"GO:2000868","negative regulation of estrone secretion" -"GO:0038178","complement component C5a signaling pathway" -"GO:0140014","mitotic nuclear division" -"GO:2000651","positive regulation of sodium ion transmembrane transporter activity" -"GO:0042120","alginic acid metabolic process" -"GO:1903514","release of sequestered calcium ion into cytosol by endoplasmic reticulum" -"GO:0071911","synchronous neurotransmitter secretion" -"GO:1902520","response to doxorubicin" -"GO:0046278","3,4-dihydroxybenzoate metabolic process" -"GO:1901653","cellular response to peptide" -"GO:0046166","glyceraldehyde-3-phosphate biosynthetic process" -"GO:0019885","antigen processing and presentation of endogenous peptide antigen via MHC class I" -"GO:1903687","negative regulation of border follicle cell migration" -"GO:0018980","2,4,5-trichlorophenoxyacetic acid metabolic process" -"GO:0060707","trophoblast giant cell differentiation" -"GO:2000502","negative regulation of natural killer cell chemotaxis" -"GO:0016246","RNA interference" -"GO:0014839","myoblast migration involved in skeletal muscle regeneration" -"GO:0015706","nitrate transport" -"GO:0000154","rRNA modification" -"GO:1902023","L-arginine transport" -"GO:0010023","proanthocyanidin biosynthetic process" -"GO:0051337","amitosis" -"GO:0045488","pectin metabolic process" -"GO:0042857","chrysobactin metabolic process" -"GO:1905299","negative regulation of intestinal epithelial cell development" -"GO:0002307","CD8-positive, alpha-beta regulatory T cell differentiation" -"GO:0015699","antimonite transport" -"GO:0060774","auxin mediated signaling pathway involved in phyllotactic patterning" -"GO:0097112","gamma-aminobutyric acid receptor clustering" -"GO:0003099","positive regulation of the force of heart contraction by chemical signal" -"GO:0007089","traversing start control point of mitotic cell cycle" -"GO:0002489","antigen processing and presentation of endogenous peptide antigen via MHC class Ib via ER pathway, TAP-dependent" -"GO:0034650","cortisol metabolic process" -"GO:0015827","tryptophan transport" -"GO:0015890","nicotinamide mononucleotide transport" -"GO:0070816","phosphorylation of RNA polymerase II C-terminal domain" -"GO:1905821","positive regulation of chromosome condensation" -"GO:0039689","negative stranded viral RNA replication" -"GO:0030712","negative regulation of border follicle cell delamination" -"GO:0060049","regulation of protein glycosylation" -"GO:0051467","detection of steroid hormone stimulus" -"GO:0006261","DNA-dependent DNA replication" -"GO:0050960","detection of temperature stimulus involved in thermoception" -"GO:1990793","substance P secretion, neurotransmission" -"GO:0043304","regulation of mast cell degranulation" -"GO:0055015","ventricular cardiac muscle cell development" -"GO:0016095","polyprenol catabolic process" -"GO:1902570","protein localization to nucleolus" -"GO:1905495","positive regulation of G-quadruplex DNA binding" -"GO:0048611","embryonic ectodermal digestive tract development" -"GO:2000697","negative regulation of epithelial cell differentiation involved in kidney development" -"GO:0052209","interaction with other organism via substance secreted by type IV secretion system involved in symbiotic interaction" -"GO:1904290","negative regulation of mitotic DNA damage checkpoint" -"GO:1904605","positive regulation of advanced glycation end-product receptor activity" -"GO:0039638","lipopolysaccharide-mediated virion attachment to host cell" -"GO:0030578","PML body organization" -"GO:0022898","regulation of transmembrane transporter activity" -"GO:0033078","extrathymic T cell differentiation" -"GO:0009165","nucleotide biosynthetic process" -"GO:0006977","DNA damage response, signal transduction by p53 class mediator resulting in cell cycle arrest" -"GO:0098928","presynaptic signal transduction" -"GO:2000051","negative regulation of non-canonical Wnt signaling pathway" -"GO:1990414","replication-born double-strand break repair via sister chromatid exchange" -"GO:0006639","acylglycerol metabolic process" -"GO:0032020","ISG15-protein conjugation" -"GO:0051142","positive regulation of NK T cell proliferation" -"GO:1903997","positive regulation of non-membrane spanning protein tyrosine kinase activity" -"GO:1904354","negative regulation of telomere capping" -"GO:0071276","cellular response to cadmium ion" -"GO:0005272","sodium channel activity" -"GO:1900458","negative regulation of brassinosteroid mediated signaling pathway" -"GO:0055095","lipoprotein particle mediated signaling" -"GO:2000754","regulation of sphingomyelin catabolic process" -"GO:0060755","negative regulation of mast cell chemotaxis" -"GO:1904404","response to formaldehyde" -"GO:1905099","positive regulation of guanyl-nucleotide exchange factor activity" -"GO:0032835","glomerulus development" -"GO:0016236","macroautophagy" -"GO:0010589","leaf proximal/distal pattern formation" -"GO:1901526","positive regulation of mitophagy" -"GO:0090384","phagosome-lysosome docking" -"GO:2000108","positive regulation of leukocyte apoptotic process" -"GO:0009686","gibberellin biosynthetic process" -"GO:0007602","phototransduction" -"GO:1904631","response to glucoside" -"GO:0007063","regulation of sister chromatid cohesion" -"GO:0098816","mini excitatory postsynaptic potential" -"GO:1903415","flavonoid transport from endoplasmic reticulum to plant-type vacuole" -"GO:1903147","negative regulation of autophagy of mitochondrion" -"GO:0071461","cellular response to redox state" -"GO:0030968","endoplasmic reticulum unfolded protein response" -"GO:0060334","regulation of interferon-gamma-mediated signaling pathway" -"GO:0060395","SMAD protein signal transduction" -"GO:1902643","positive regulation of 1-phosphatidyl-1D-myo-inositol 4,5-bisphosphate catabolic process" -"GO:1902880","positive regulation of BMP signaling pathway involved in spinal cord association neuron specification" -"GO:1903759","signal transduction involved in regulation of aerobic respiration" -"GO:0043934","sporulation" -"GO:0045069","regulation of viral genome replication" -"GO:1903384","negative regulation of hydrogen peroxide-induced neuron intrinsic apoptotic signaling pathway" -"GO:0071301","cellular response to vitamin B1" -"GO:1902641","regulation of 1-phosphatidyl-1D-myo-inositol 4,5-bisphosphate catabolic process" -"GO:0035093","spermatogenesis, exchange of chromosomal proteins" -"GO:0035744","T-helper 1 cell cytokine production" -"GO:0032765","positive regulation of mast cell cytokine production" -"GO:0071538","SH2 domain-mediated complex assembly" -"GO:0070564","positive regulation of vitamin D receptor signaling pathway" -"GO:0071480","cellular response to gamma radiation" -"GO:0106041","positive regulation of GABA-A receptor activity" -"GO:0060472","positive regulation of cortical granule exocytosis by positive regulation of cytosolic calcium ion concentration" -"GO:1902526","negative regulation of protein monoubiquitination" -"GO:0030522","intracellular receptor signaling pathway" -"GO:2000179","positive regulation of neural precursor cell proliferation" -"GO:0006635","fatty acid beta-oxidation" -"GO:1902254","negative regulation of intrinsic apoptotic signaling pathway by p53 class mediator" -"GO:1903751","negative regulation of intrinsic apoptotic signaling pathway in response to hydrogen peroxide" -"GO:2000318","positive regulation of T-helper 17 type immune response" -"GO:0002082","regulation of oxidative phosphorylation" -"GO:0042817","pyridoxal metabolic process" -"GO:0007091","metaphase/anaphase transition of mitotic cell cycle" -"GO:0043381","negative regulation of memory T cell differentiation" -"GO:0038097","positive regulation of mast cell activation by Fc-epsilon receptor signaling pathway" -"GO:0051574","positive regulation of histone H3-K9 methylation" -"GO:0036040","curcumin catabolic process" -"GO:0031334","positive regulation of protein complex assembly" -"GO:0060193","positive regulation of lipase activity" -"GO:0046838","phosphorylated carbohydrate dephosphorylation" -"GO:0006709","progesterone catabolic process" -"GO:1903214","regulation of protein targeting to mitochondrion" -"GO:0021529","spinal cord oligodendrocyte cell differentiation" -"GO:1901896","positive regulation of calcium-transporting ATPase activity" -"GO:0015974","guanosine pentaphosphate catabolic process" -"GO:0045636","positive regulation of melanocyte differentiation" -"GO:0097190","apoptotic signaling pathway" -"GO:0033687","osteoblast proliferation" -"GO:0006139","nucleobase-containing compound metabolic process" -"GO:0072717","cellular response to actinomycin D" -"GO:0035556","intracellular signal transduction" -"GO:0048241","epinephrine transport" -"GO:0032026","response to magnesium ion" -"GO:0046671","negative regulation of retinal cell programmed cell death" -"GO:0051687","maintenance of spindle location" -"GO:0009248","K antigen biosynthetic process" -"GO:0002860","positive regulation of natural killer cell mediated cytotoxicity directed against tumor cell target" -"GO:1901507","negative regulation of acylglycerol transport" -"GO:0071792","bacillithiol metabolic process" -"GO:0019685","photosynthesis, dark reaction" -"GO:0097411","hypoxia-inducible factor-1alpha signaling pathway" -"GO:0036392","chemokine (C-C motif) ligand 20 production" -"GO:0050671","positive regulation of lymphocyte proliferation" -"GO:0038113","interleukin-9-mediated signaling pathway" -"GO:0045184","establishment of protein localization" -"GO:2000330","positive regulation of T-helper 17 cell lineage commitment" -"GO:2000175","negative regulation of pro-T cell differentiation" -"GO:1905415","positive regulation of dense core granule exocytosis" -"GO:0023041","neuronal signal transduction" -"GO:0003361","noradrenergic neuron differentiation involved in brainstem development" -"GO:0060718","chorionic trophoblast cell differentiation" -"GO:0098931","virion attachment to host cell flagellum" -"GO:0009755","hormone-mediated signaling pathway" -"GO:1902203","negative regulation of hepatocyte growth factor receptor signaling pathway" -"GO:0003014","renal system process" -"GO:0043050","pharyngeal pumping" -"GO:0042509","regulation of tyrosine phosphorylation of STAT protein" -"GO:0009407","toxin catabolic process" -"GO:1904933","regulation of cell proliferation in midbrain" -"GO:0061265","mesonephric nephron tubule epithelial cell differentiation" -"GO:0001916","positive regulation of T cell mediated cytotoxicity" -"GO:0006984","ER-nucleus signaling pathway" -"GO:1900450","negative regulation of glutamate receptor signaling pathway" -"GO:0031318","detection of folic acid" -"GO:0032946","positive regulation of mononuclear cell proliferation" -"GO:0007216","G-protein coupled glutamate receptor signaling pathway" -"GO:0072422","signal transduction involved in DNA damage checkpoint" -"GO:1905280","negative regulation of retrograde transport, endosome to Golgi" -"GO:1904005","regulation of phospholipase D activity" -"GO:0021921","regulation of cell proliferation in dorsal spinal cord" -"GO:1901797","negative regulation of signal transduction by p53 class mediator" -"GO:0033183","negative regulation of histone ubiquitination" -"GO:0070155","mitochondrial methionyl-tRNA aminoacylation" -"GO:0002827","positive regulation of T-helper 1 type immune response" -"GO:0070782","phosphatidylserine exposure on apoptotic cell surface" -"GO:1901365","funalenone catabolic process" -"GO:0075149","negative regulation of signal transduction in response to host" -"GO:0018205","peptidyl-lysine modification" -"GO:0000716","transcription-coupled nucleotide-excision repair, DNA damage recognition" -"GO:0042095","interferon-gamma biosynthetic process" -"GO:0043392","negative regulation of DNA binding" -"GO:0035896","positive regulation of mast cell degranulation in other organism" -"GO:2001171","positive regulation of ATP biosynthetic process" -"GO:1900786","naphtho-gamma-pyrone catabolic process" -"GO:0034104","negative regulation of tissue remodeling" -"GO:0050663","cytokine secretion" -"GO:1990967","multi-organism toxin transport" -"GO:0023045","signal transduction by conformational transition" -"GO:0035775","pronephric glomerulus morphogenesis" -"GO:1902660","negative regulation of glucose mediated signaling pathway" -"GO:0010559","regulation of glycoprotein biosynthetic process" -"GO:0019383","(+)-camphor catabolic process" -"GO:0098817","evoked excitatory postsynaptic potential" -"GO:0000450","cleavage of bicistronic rRNA transcript (SSU-rRNA, LSU-rRNA)" -"GO:0031930","mitochondria-nucleus signaling pathway" -"GO:0140060","axon arborization" -"GO:0046461","neutral lipid catabolic process" -"GO:0071312","cellular response to alkaloid" -"GO:0046034","ATP metabolic process" -"GO:0090403","oxidative stress-induced premature senescence" -"GO:0007633","pattern orientation" -"GO:0106014","regulation of inflammatory response to wounding" -"GO:0035648","circadian mating behavior" -"GO:0031653","heat dissipation" -"GO:1904982","sucrose transmembrane transport" -"GO:0002625","regulation of T cell antigen processing and presentation" -"GO:0090229","negative regulation of red or far-red light signaling pathway" -"GO:0006582","melanin metabolic process" -"GO:0036369","transcription factor catabolic process" -"GO:0021893","cerebral cortex GABAergic interneuron fate commitment" -"GO:1904626","positive regulation of glycine secretion, neurotransmission" -"GO:0042976","activation of Janus kinase activity" -"GO:0090301","negative regulation of neural crest formation" -"GO:1901871","ecgonone methyl ester catabolic process" -"GO:1900553","asperfuranone catabolic process" -"GO:0032148","activation of protein kinase B activity" -"GO:0007387","anterior compartment pattern formation" -"GO:0045759","negative regulation of action potential" -"GO:0000714","meiotic strand displacement" -"GO:0080037","negative regulation of cytokinin-activated signaling pathway" -"GO:0042899","arabinan transmembrane transport" -"GO:0030187","melatonin biosynthetic process" -"GO:0015792","arabinitol transmembrane transport" -"GO:0099004","calmodulin dependent kinase signaling pathway" -"GO:0006648","dihydrosphingosine-1-P pathway" -"GO:0009157","deoxyribonucleoside monophosphate biosynthetic process" -"GO:1902915","negative regulation of protein polyubiquitination" -"GO:0031396","regulation of protein ubiquitination" -"GO:0098704","carbohydrate import across plasma membrane" -"GO:0014873","response to muscle activity involved in regulation of muscle adaptation" -"GO:0010850","regulation of blood pressure by chemoreceptor signaling pathway" -"GO:0070943","neutrophil mediated killing of symbiont cell" -"GO:0043382","positive regulation of memory T cell differentiation" -"GO:1902382","11-oxo-beta-amyrin catabolic process" -"GO:1902848","negative regulation of neuronal signal transduction" -"GO:0046344","ecdysteroid catabolic process" -"GO:2000777","positive regulation of proteasomal ubiquitin-dependent protein catabolic process involved in cellular response to hypoxia" -"GO:0036180","filamentous growth of a population of unicellular organisms in response to biotic stimulus" -"GO:1905666","regulation of protein localization to endosome" -"GO:1904814","regulation of protein localization to chromosome, telomeric region" -"GO:0098867","intramembranous bone growth" -"GO:0008205","ecdysone metabolic process" -"GO:1905336","negative regulation of aggrephagy" -"GO:0061625","glycolytic process through fructose-1-phosphate" -"GO:1905856","negative regulation of pentose-phosphate shunt" -"GO:0002533","lysosomal enzyme secretion involved in inflammatory response" -"GO:0097037","heme export" -"GO:1903564","regulation of protein localization to cilium" -"GO:0048298","positive regulation of isotype switching to IgA isotypes" -"GO:0090202","gene looping" -"GO:2001192","negative regulation of gamma-delta T cell activation involved in immune response" -"GO:1904555","L-proline transmembrane transport" -"GO:0034154","toll-like receptor 7 signaling pathway" -"GO:1902816","regulation of protein localization to microtubule" -"GO:0060433","bronchus development" -"GO:1903812","L-serine import across plasma membrane" -"GO:0035233","germ cell repulsion" -"GO:0010564","regulation of cell cycle process" -"GO:1901308","regulation of sterol regulatory element binding protein cleavage" -"GO:0007364","establishment of terminal gap gene boundary" -"GO:0035554","termination of Roundabout signal transduction" -"GO:0071474","cellular hyperosmotic response" -"GO:0048392","intermediate mesodermal cell differentiation" -"GO:0006620","posttranslational protein targeting to endoplasmic reticulum membrane" -"GO:0003415","chondrocyte hypertrophy" -"GO:0045692","negative regulation of embryo sac central cell differentiation" -"GO:0035398","helper T cell enhancement of T cell mediated immune response" -"GO:1903104","regulation of insulin receptor signaling pathway involved in determination of adult lifespan" -"GO:0022414","reproductive process" -"GO:0042458","nopaline catabolic process to proline" -"GO:0035904","aorta development" -"GO:2000806","positive regulation of termination of RNA polymerase II transcription, poly(A)-coupled" -"GO:1904716","positive regulation of chaperone-mediated autophagy" -"GO:0097011","cellular response to granulocyte macrophage colony-stimulating factor stimulus" -"GO:2000520","regulation of immunological synapse formation" -"GO:2001159","regulation of protein localization by the Cvt pathway" -"GO:0046485","ether lipid metabolic process" -"GO:0051599","response to hydrostatic pressure" -"GO:1904375","regulation of protein localization to cell periphery" -"GO:0045843","negative regulation of striated muscle tissue development" -"GO:0060031","mediolateral intercalation" -"GO:0016103","diterpenoid catabolic process" -"GO:0032827","negative regulation of natural killer cell differentiation involved in immune response" -"GO:0031112","positive regulation of microtubule polymerization or depolymerization" -"GO:0061780","mitotic cohesin loading" -"GO:0098795","mRNA cleavage involved in gene silencing" -"GO:0039585","PKR signal transduction" -"GO:0031399","regulation of protein modification process" -"GO:0001957","intramembranous ossification" -"GO:0051199","regulation of prosthetic group metabolic process" -"GO:0043570","maintenance of DNA repeat elements" -"GO:0072509","divalent inorganic cation transmembrane transporter activity" -"GO:0072200","negative regulation of mesenchymal cell proliferation involved in ureter development" -"GO:1902244","cis-abienol metabolic process" -"GO:0019634","organic phosphonate metabolic process" -"GO:0035392","maintenance of chromatin silencing at telomere" -"GO:0001825","blastocyst formation" -"GO:0035160","maintenance of epithelial integrity, open tracheal system" -"GO:0002630","positive regulation of proteolysis associated with antigen processing and presentation" -"GO:0007263","nitric oxide mediated signal transduction" -"GO:1904920","regulation of MAPK cascade involved in axon regeneration" -"GO:1903582","negative regulation of basophil degranulation" -"GO:0006936","muscle contraction" -"GO:0010304","PSII associated light-harvesting complex II catabolic process" -"GO:0035766","cell chemotaxis to fibroblast growth factor" -"GO:0006812","cation transport" -"GO:0002294","CD4-positive, alpha-beta T cell differentiation involved in immune response" -"GO:1905932","positive regulation of vascular smooth muscle cell differentiation involved in phenotypic switching" -"GO:0150031","regulation of protein localization to lysosome" -"GO:0098818","hyperpolarization of postsynaptic membrane" -"GO:0002314","germinal center B cell differentiation" -"GO:0090194","negative regulation of glomerulus development" -"GO:0007339","binding of sperm to zona pellucida" -"GO:0033502","cellular galactose homeostasis" -"GO:1903747","regulation of establishment of protein localization to mitochondrion" -"GO:0070789","metula development" -"GO:0051707","response to other organism" -"GO:0035272","exocrine system development" -"GO:0060381","positive regulation of single-stranded telomeric DNA binding" -"GO:0060046","regulation of acrosome reaction" -"GO:1905312","positive regulation of cardiac neural crest cell migration involved in outflow tract morphogenesis" -"GO:0060566","positive regulation of DNA-templated transcription, termination" -"GO:0003188","heart valve formation" -"GO:0006353","DNA-templated transcription, termination" -"GO:2000794","regulation of epithelial cell proliferation involved in lung morphogenesis" -"GO:1990956","fibroblast chemotaxis" -"GO:0048747","muscle fiber development" -"GO:1905901","positive regulation of smooth muscle tissue development" -"GO:0036061","muscle cell chemotaxis toward tendon cell" -"GO:2000413","regulation of fibronectin-dependent thymocyte migration" -"GO:0002001","renin secretion into blood stream" -"GO:0050838","peptidyl-5-hydroxy-L-lysine trimethylation" -"GO:2000791","negative regulation of mesenchymal cell proliferation involved in lung development" -"GO:0070343","white fat cell proliferation" -"GO:2000344","positive regulation of acrosome reaction" -"GO:0090516","L-serine transmembrane import into vacuole" -"GO:1904487","cellular response to 17alpha-ethynylestradiol" -"GO:0032464","positive regulation of protein homooligomerization" -"GO:2000342","negative regulation of chemokine (C-X-C motif) ligand 2 production" -"GO:1905340","regulation of protein localization to kinetochore" -"GO:0043441","acetoacetic acid biosynthetic process" -"GO:1903501","positive regulation of mitotic actomyosin contractile ring assembly" -"GO:0002661","regulation of B cell tolerance induction" -"GO:0085032","modulation by symbiont of host I-kappaB kinase/NF-kappaB cascade" -"GO:0050751","fractalkine biosynthetic process" -"GO:0042381","hemolymph coagulation" -"GO:0043506","regulation of JUN kinase activity" -"GO:1902740","negative regulation of interferon-alpha secretion" -"GO:2001112","regulation of cellular response to hepatocyte growth factor stimulus" -"GO:0022622","root system development" -"GO:0007493","endodermal cell fate determination" -"GO:1905647","proline import across plasma membrane" -"GO:0097054","L-glutamate biosynthetic process" -"GO:0045839","negative regulation of mitotic nuclear division" -"GO:0034636","strand invasion involved in gene conversion at mating-type locus" -"GO:1903064","positive regulation of reverse cholesterol transport" -"GO:0006428","isoleucyl-tRNA aminoacylation" -"GO:1905410","regulation of mitotic cohesin unloading" -"GO:0075049","modulation of symbiont cell wall strengthening involved in entry into host" -"GO:2000144","positive regulation of DNA-templated transcription, initiation" -"GO:0006982","response to lipid hydroperoxide" -"GO:1904405","cellular response to formaldehyde" -"GO:0060865","negative regulation of floral organ abscission by transmembrane receptor protein serine/threonine kinase signaling pathway" -"GO:1901900","regulation of protein localization to cell division site" -"GO:0098787","mRNA cleavage involved in mRNA processing" -"GO:0019939","peptidyl-S-palmitoleyl-L-cysteine biosynthetic process from peptidyl-cysteine" -"GO:1905591","regulation of optical nerve axon regeneration" -"GO:0051447","negative regulation of meiotic cell cycle" -"GO:2000315","positive regulation of fibroblast growth factor receptor signaling pathway involved in neural plate anterior/posterior pattern formation" -"GO:0061145","lung smooth muscle development" -"GO:0060819","inactivation of X chromosome by genetic imprinting" -"GO:0090283","regulation of protein glycosylation in Golgi" -"GO:0010513","positive regulation of phosphatidylinositol biosynthetic process" -"GO:0031114","regulation of microtubule depolymerization" -"GO:0061912","selective autophagy" -"GO:0098819","depolarization of postsynaptic membrane" -"GO:0001809","positive regulation of type IV hypersensitivity" -"GO:0060393","regulation of pathway-restricted SMAD protein phosphorylation" -"GO:0051776","detection of redox state" -"GO:1904406","negative regulation of nitric oxide metabolic process" -"GO:1905871","regulation of protein localization to cell leading edge" -"GO:0075520","actin-dependent intracellular transport of virus" -"GO:1905112","regulation of centromere clustering at the mitotic nuclear envelope" -"GO:0070198","protein localization to chromosome, telomeric region" -"GO:0061954","positive regulation of actin filament polymerization involved in sperm capacitation" -"GO:0031917","negative regulation of synaptic metaplasticity" -"GO:0046985","positive regulation of hemoglobin biosynthetic process" -"GO:0016102","diterpenoid biosynthetic process" -"GO:0060217","hemangioblast cell differentiation" -"GO:0080006","internode patterning" -"GO:1905766","positive regulation of protection from non-homologous end joining at telomere" -"GO:0046620","regulation of organ growth" -"GO:1903463","regulation of mitotic cell cycle DNA replication" -"GO:0036364","transforming growth factor beta1 activation" -"GO:0045372","regulation of interleukin-15 biosynthetic process" -"GO:0050763","depsipeptide biosynthetic process" -"GO:1903483","regulation of maintenance of mitotic actomyosin contractile ring localization" -"GO:0051658","maintenance of nucleus location" -"GO:0060503","bud dilation involved in lung branching" -"GO:0046784","viral mRNA export from host cell nucleus" -"GO:0034229","ethanolamine transport" -"GO:0033059","cellular pigmentation" -"GO:0030836","positive regulation of actin filament depolymerization" -"GO:0050865","regulation of cell activation" -"GO:0010626","negative regulation of Schwann cell proliferation" -"GO:0060727","positive regulation of coreceptor activity involved in epidermal growth factor receptor signaling pathway" -"GO:0090407","organophosphate biosynthetic process" -"GO:0007041","lysosomal transport" -"GO:0070994","detection of oxidative stress" -"GO:0035626","juvenile hormone mediated signaling pathway" -"GO:0070965","positive regulation of neutrophil mediated killing of fungus" -"GO:1901661","quinone metabolic process" -"GO:0023052","signaling" -"GO:0009949","polarity specification of anterior/posterior axis" -"GO:0031133","regulation of axon diameter" -"GO:0051608","histamine transport" -"GO:0061189","positive regulation of sclerotome development" -"GO:0015839","cadaverine transport" -"GO:0045136","development of secondary sexual characteristics" -"GO:2001253","regulation of histone H3-K36 trimethylation" -"GO:0099098","microtubule polymerization based movement" -"GO:1905027","regulation of membrane depolarization during AV node cell action potential" -"GO:1900337","negative regulation of methane biosynthetic process from carbon monoxide" -"GO:0048643","positive regulation of skeletal muscle tissue development" -"GO:0031922","pyridoxamine transport" -"GO:0097090","presynaptic membrane organization" -"GO:0021854","hypothalamus development" -"GO:0071492","cellular response to UV-A" -"GO:1900180","regulation of protein localization to nucleus" -"GO:0021708","Lugaro cell differentiation" -"GO:0002165","instar larval or pupal development" -"GO:0048710","regulation of astrocyte differentiation" -"GO:0042686","regulation of cardioblast cell fate specification" -"GO:0000495","box H/ACA snoRNA 3'-end processing" -"GO:0006431","methionyl-tRNA aminoacylation" -"GO:0032212","positive regulation of telomere maintenance via telomerase" -"GO:0033371","T cell secretory granule organization" -"GO:0003275","apoptotic process involved in outflow tract morphogenesis" -"GO:0039691","double stranded viral RNA replication" -"GO:1902668","negative regulation of axon guidance" -"GO:0035404","histone-serine phosphorylation" -"GO:0061109","dense core granule organization" -"GO:0051973","positive regulation of telomerase activity" -"GO:0048313","Golgi inheritance" -"GO:0061037","negative regulation of cartilage development" -"GO:0014902","myotube differentiation" -"GO:0032098","regulation of appetite" -"GO:0048686","regulation of sprouting of injured axon" -"GO:0071226","cellular response to molecule of fungal origin" -"GO:1900062","regulation of replicative cell aging" -"GO:0090104","pancreatic epsilon cell differentiation" -"GO:0006505","GPI anchor metabolic process" -"GO:0048557","embryonic digestive tract morphogenesis" -"GO:2000376","positive regulation of oxygen metabolic process" -"GO:0016486","peptide hormone processing" -"GO:0007004","telomere maintenance via telomerase" -"GO:0051781","positive regulation of cell division" -"GO:0002267","follicular dendritic cell activation involved in immune response" -"GO:0006049","UDP-N-acetylglucosamine catabolic process" -"GO:1990549","mitochondrial NAD transmembrane transport" -"GO:1904851","positive regulation of establishment of protein localization to telomere" -"GO:0002753","cytoplasmic pattern recognition receptor signaling pathway" -"GO:1900502","positive regulation of butyryl-CoA catabolic process to butyrate" -"GO:0097709","connective tissue replacement" -"GO:0070127","tRNA aminoacylation for mitochondrial protein translation" -"GO:0034383","low-density lipoprotein particle clearance" -"GO:2000387","regulation of antral ovarian follicle growth" -"GO:0042998","positive regulation of Golgi to plasma membrane protein transport" -"GO:0002754","intracellular vesicle pattern recognition receptor signaling pathway" -"GO:1905284","positive regulation of epidermal growth factor receptor signaling pathway involved in heart process" -"GO:1903859","regulation of dendrite extension" -"GO:1904784","NLRP1 inflammasome complex assembly" -"GO:0016242","negative regulation of macroautophagy" -"GO:0042740","exogenous antibiotic catabolic process" -"GO:0044772","mitotic cell cycle phase transition" -"GO:0031101","fin regeneration" -"GO:0015843","methylammonium transport" -"GO:0035872","nucleotide-binding domain, leucine rich repeat containing receptor signaling pathway" -"GO:0048617","embryonic foregut morphogenesis" -"GO:0048670","regulation of collateral sprouting" -"GO:0075191","autophagy of host cells on or near symbiont surface" -"GO:0071206","establishment of protein localization to juxtaparanode region of axon" -"GO:0090249","regulation of cell motility involved in somitogenic axis elongation" -"GO:0006914","autophagy" -"GO:0003202","endocardial cushion to mesenchymal transition involved in cardiac skeleton development" -"GO:0006991","response to sterol depletion" -"GO:0090317","negative regulation of intracellular protein transport" -"GO:0043413","macromolecule glycosylation" -"GO:0019345","cysteine biosynthetic process via S-sulfo-L-cysteine" -"GO:1903825","organic acid transmembrane transport" -"GO:0043000","Golgi to plasma membrane CFTR protein transport" -"GO:1905419","sperm flagellum movement involved in flagellated sperm motility" -"GO:0035774","positive regulation of insulin secretion involved in cellular response to glucose stimulus" -"GO:0015847","putrescine transport" -"GO:0010464","regulation of mesenchymal cell proliferation" -"GO:0006418","tRNA aminoacylation for protein translation" -"GO:0060721","regulation of spongiotrophoblast cell proliferation" -"GO:0038004","epidermal growth factor receptor ligand maturation" -"GO:0008206","bile acid metabolic process" -"GO:0051510","regulation of unidimensional cell growth" -"GO:0016570","histone modification" -"GO:0030071","regulation of mitotic metaphase/anaphase transition" -"GO:0060428","lung epithelium development" -"GO:0021858","GABAergic neuron differentiation in basal ganglia" -"GO:0061138","morphogenesis of a branching epithelium" -"GO:1905581","positive regulation of low-density lipoprotein particle clearance" -"GO:0060657","regulation of mammary gland cord elongation by mammary fat precursor cell-epithelial cell signaling" -"GO:0033512","L-lysine catabolic process to acetyl-CoA via saccharopine" -"GO:0038019","Wnt receptor recycling" -"GO:0021930","cerebellar granule cell precursor proliferation" -"GO:0042625","ATPase coupled ion transmembrane transporter activity" -"GO:0061310","canonical Wnt signaling pathway involved in cardiac neural crest cell differentiation involved in heart development" -"GO:0006396","RNA processing" -"GO:1905041","regulation of epithelium regeneration" -"GO:0061669","spontaneous neurotransmitter secretion" -"GO:0071393","cellular response to progesterone stimulus" -"GO:0035493","SNARE complex assembly" -"GO:0003433","chondrocyte development involved in endochondral bone morphogenesis" -"GO:0034382","chylomicron remnant clearance" -"GO:1905178","regulation of cardiac muscle tissue regeneration" -"GO:0015296","anion:cation symporter activity" -"GO:0010075","regulation of meristem growth" -"GO:0070827","chromatin maintenance" -"GO:0003311","pancreatic D cell differentiation" -"GO:0072721","cellular response to dithiothreitol" -"GO:1904874","positive regulation of telomerase RNA localization to Cajal body" -"GO:0019878","lysine biosynthetic process via aminoadipic acid" -"GO:0010963","regulation of L-arginine import" -"GO:0002344","B cell affinity maturation" -"GO:0006314","intron homing" -"GO:0033211","adiponectin-activated signaling pathway" -"GO:0048566","embryonic digestive tract development" -"GO:1900595","(+)-kotanin catabolic process" -"GO:1903296","positive regulation of glutamate secretion, neurotransmission" -"GO:0010507","negative regulation of autophagy" -"GO:0006355","regulation of transcription, DNA-templated" -"GO:0060364","frontal suture morphogenesis" -"GO:0030840","negative regulation of intermediate filament polymerization" -"GO:0014824","artery smooth muscle contraction" -"GO:0072491","toluene-containing compound catabolic process" -"GO:0072229","metanephric proximal convoluted tubule development" -"GO:0021703","locus ceruleus development" -"GO:0003172","sinoatrial valve development" -"GO:1990383","cellular response to biotin starvation" -"GO:0031319","detection of cAMP" -"GO:1905524","negative regulation of protein autoubiquitination" -"GO:0071374","cellular response to parathyroid hormone stimulus" -"GO:0071035","nuclear polyadenylation-dependent rRNA catabolic process" -"GO:0021623","oculomotor nerve formation" -"GO:0003294","atrial ventricular junction remodeling" -"GO:0010212","response to ionizing radiation" -"GO:0042541","hemoglobin biosynthetic process" -"GO:0010768","negative regulation of transcription from RNA polymerase II promoter in response to UV-induced DNA damage" -"GO:1905831","negative regulation of spindle assembly" -"GO:0090116","C-5 methylation of cytosine" -"GO:0000467","exonucleolytic trimming to generate mature 3'-end of 5.8S rRNA from tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:0021553","olfactory nerve development" -"GO:0046356","acetyl-CoA catabolic process" -"GO:0045814","negative regulation of gene expression, epigenetic" -"GO:0042220","response to cocaine" -"GO:0010460","positive regulation of heart rate" -"GO:0048666","neuron development" -"GO:0010652","positive regulation of cell communication by chemical coupling" -"GO:0018937","nitroglycerin metabolic process" -"GO:0071834","mating pheromone secretion" -"GO:0030072","peptide hormone secretion" -"GO:0006788","heme oxidation" -"GO:0006357","regulation of transcription by RNA polymerase II" -"GO:0050684","regulation of mRNA processing" -"GO:1901827","zeaxanthin biosynthetic process" -"GO:0003058","hormonal regulation of the force of heart contraction" -"GO:0030164","protein denaturation" -"GO:0032680","regulation of tumor necrosis factor production" -"GO:0007254","JNK cascade" -"GO:0009269","response to desiccation" -"GO:1901556","response to candesartan" -"GO:0034655","nucleobase-containing compound catabolic process" -"GO:0003310","pancreatic A cell differentiation" -"GO:0003309","type B pancreatic cell differentiation" -"GO:0021783","preganglionic parasympathetic fiber development" -"GO:0060040","retinal bipolar neuron differentiation" -"GO:1900236","positive regulation of Kit signaling pathway" -"GO:0060873","anterior semicircular canal development" -"GO:0000966","RNA 5'-end processing" -"GO:1902750","negative regulation of cell cycle G2/M phase transition" -"GO:0014826","vein smooth muscle contraction" -"GO:0007234","osmosensory signaling via phosphorelay pathway" -"GO:1902860","propionyl-CoA biosynthetic process" -"GO:0044819","mitotic G1/S transition checkpoint" -"GO:0046298","2,4-dichlorobenzoate catabolic process" -"GO:0002331","pre-B cell allelic exclusion" -"GO:1901837","negative regulation of transcription of nucleolar large rRNA by RNA polymerase I" -"GO:2000902","cellooligosaccharide metabolic process" -"GO:0002541","activation of plasma proteins involved in acute inflammatory response" -"GO:0061520","Langerhans cell differentiation" -"GO:1902916","positive regulation of protein polyubiquitination" -"GO:0071232","cellular response to histidine" -"GO:0019612","4-toluenecarboxylate catabolic process" -"GO:0006351","transcription, DNA-templated" -"GO:0034340","response to type I interferon" -"GO:0072185","metanephric cap development" -"GO:1990772","substance P secretion" -"GO:0043031","negative regulation of macrophage activation" -"GO:0045218","zonula adherens maintenance" -"GO:0097676","histone H3-K36 dimethylation" -"GO:1990687","endoplasmic reticulum-derived vesicle fusion with endoplasmic reticulum-Golgi intermediate compartment (ERGIC) membrane" -"GO:0001988","positive regulation of heart rate involved in baroreceptor response to decreased systemic arterial blood pressure" -"GO:2000803","endosomal signal transduction" -"GO:0031425","chloroplast RNA processing" -"GO:0090538","peptide pheromone secretion" -"GO:0021861","forebrain radial glial cell differentiation" -"GO:0042952","beta-ketoadipate pathway" -"GO:0061757","leukocyte adhesion to arterial endothelial cell" -"GO:0010738","regulation of protein kinase A signaling" -"GO:0048016","inositol phosphate-mediated signaling" -"GO:0042560","pteridine-containing compound catabolic process" -"GO:0070460","thyroid-stimulating hormone secretion" -"GO:0061187","regulation of chromatin silencing at rDNA" -"GO:0071051","polyadenylation-dependent snoRNA 3'-end processing" -"GO:0030843","negative regulation of intermediate filament depolymerization" -"GO:1903010","regulation of bone development" -"GO:0036260","RNA capping" -"GO:0021642","trochlear nerve formation" -"GO:0002526","acute inflammatory response" -"GO:0042551","neuron maturation" -"GO:0009200","deoxyribonucleoside triphosphate metabolic process" -"GO:0050727","regulation of inflammatory response" -"GO:0099024","plasma membrane invagination" -"GO:0034463","90S preribosome assembly" -"GO:0002317","plasma cell differentiation" -"GO:1904625","negative regulation of glycine secretion, neurotransmission" -"GO:0071909","determination of stomach left/right asymmetry" -"GO:0034354","'de novo' NAD biosynthetic process from tryptophan" -"GO:0006772","thiamine metabolic process" -"GO:0060594","mammary gland specification" -"GO:0071388","cellular response to cortisone stimulus" -"GO:1902722","positive regulation of prolactin secretion" -"GO:0014817","skeletal muscle satellite cell fate specification" -"GO:0015936","coenzyme A metabolic process" -"GO:0046272","stilbene catabolic process" -"GO:0070423","nucleotide-binding oligomerization domain containing signaling pathway" -"GO:0097176","epoxide metabolic process" -"GO:0046887","positive regulation of hormone secretion" -"GO:1902845","negative regulation of mitotic spindle elongation" -"GO:0036322","pancreatic polypeptide secretion" -"GO:1990966","ATP generation from poly-ADP-D-ribose" -"GO:0021523","somatic motor neuron differentiation" -"GO:0034169","positive regulation of toll-like receptor 10 signaling pathway" -"GO:0010816","calcitonin catabolic process" -"GO:0060039","pericardium development" -"GO:0044762","negative regulation by symbiont of host neurotransmitter secretion" -"GO:0036160","melanocyte-stimulating hormone secretion" -"GO:0018265","GPI anchor biosynthetic process via N-asparaginyl-glycosylphosphatidylinositolethanolamine" -"GO:0031129","inductive cell-cell signaling" -"GO:0015909","long-chain fatty acid transport" -"GO:0048301","positive regulation of isotype switching to IgD isotypes" -"GO:0030835","negative regulation of actin filament depolymerization" -"GO:0071168","protein localization to chromatin" -"GO:1903297","regulation of hypoxia-induced intrinsic apoptotic signaling pathway" -"GO:0048814","regulation of dendrite morphogenesis" -"GO:1905028","negative regulation of membrane depolarization during AV node cell action potential" -"GO:0072303","positive regulation of glomerular metanephric mesangial cell proliferation" -"GO:0035589","G-protein coupled purinergic nucleotide receptor signaling pathway" -"GO:1904536","regulation of mitotic telomere tethering at nuclear periphery" -"GO:0035246","peptidyl-arginine N-methylation" -"GO:0048332","mesoderm morphogenesis" -"GO:0051177","meiotic sister chromatid cohesion" -"GO:0046649","lymphocyte activation" -"GO:0060784","regulation of cell proliferation involved in tissue homeostasis" -"GO:0050903","leukocyte activation-dependent arrest" -"GO:1902224","ketone body metabolic process" -"GO:0051970","negative regulation of transmission of nerve impulse" -"GO:1905323","telomerase holoenzyme complex assembly" -"GO:0032618","interleukin-15 production" -"GO:1990367","process resulting in tolerance to organic substance" -"GO:0043102","amino acid salvage" -"GO:1905559","positive regulation of mitotic nuclear envelope disassembly" -"GO:0034389","lipid particle organization" -"GO:2000870","regulation of progesterone secretion" -"GO:1905829","negative regulation of prostaglandin catabolic process" -"GO:0052221","positive chemotaxis in environment of other organism involved in symbiotic interaction" -"GO:2001123","maltoheptaose catabolic process" -"GO:0044140","negative regulation of growth of symbiont on or near host surface" -"GO:0048626","myoblast fate specification" -"GO:0070836","caveola assembly" -"GO:0051253","negative regulation of RNA metabolic process" -"GO:0086055","Purkinje myocyte to ventricular cardiac muscle cell communication by electrical coupling" -"GO:0032493","response to bacterial lipoprotein" -"GO:0017186","peptidyl-pyroglutamic acid biosynthetic process, using glutaminyl-peptide cyclotransferase" -"GO:1905084","positive regulation of mitochondrial translational elongation" -"GO:1901862","negative regulation of muscle tissue development" -"GO:1900133","regulation of renin secretion into blood stream" -"GO:1900097","positive regulation of dosage compensation by inactivation of X chromosome" -"GO:0071865","regulation of apoptotic process in bone marrow" -"GO:1990264","peptidyl-tyrosine dephosphorylation involved in inactivation of protein kinase activity" -"GO:0003346","epicardium-derived cell migration to the myocardium" -"GO:1900625","positive regulation of monocyte aggregation" -"GO:0032957","inositol trisphosphate metabolic process" -"GO:0032743","positive regulation of interleukin-2 production" -"GO:0048339","paraxial mesoderm development" -"GO:0032802","low-density lipoprotein particle receptor catabolic process" -"GO:1902989","meiotic telomere maintenance via semi-conservative replication" -"GO:1904516","myofibroblast cell apoptotic process" -"GO:1901396","negative regulation of transforming growth factor beta2 activation" -"GO:1903121","regulation of TRAIL-activated apoptotic signaling pathway" -"GO:0098906","regulation of Purkinje myocyte action potential" -"GO:0010874","regulation of cholesterol efflux" -"GO:1990029","vasomotion" -"GO:0031949","regulation of glucocorticoid catabolic process" -"GO:0003284","septum primum development" -"GO:0090425","acinar cell differentiation" -"GO:0016200","synaptic target attraction" -"GO:1905044","regulation of Schwann cell proliferation involved in axon regeneration" -"GO:0060375","regulation of mast cell differentiation" -"GO:1902642","negative regulation of 1-phosphatidyl-1D-myo-inositol 4,5-bisphosphate catabolic process" -"GO:0007005","mitochondrion organization" -"GO:0006426","glycyl-tRNA aminoacylation" -"GO:0035376","sterol import" -"GO:0010828","positive regulation of glucose transmembrane transport" -"GO:1905931","negative regulation of vascular smooth muscle cell differentiation involved in phenotypic switching" -"GO:0009221","pyrimidine deoxyribonucleotide biosynthetic process" -"GO:0006735","NADH regeneration" -"GO:1901182","regulation of camalexin biosynthetic process" -"GO:0001913","T cell mediated cytotoxicity" -"GO:0086054","bundle of His cell to Purkinje myocyte communication by electrical coupling" -"GO:1905255","regulation of RNA binding transcription factor activity" -"GO:0042121","alginic acid biosynthetic process" -"GO:1904830","negative regulation of aortic smooth muscle cell differentiation" -"GO:0045765","regulation of angiogenesis" -"GO:1905078","positive regulation of interleukin-17 secretion" -"GO:0032078","negative regulation of endodeoxyribonuclease activity" -"GO:0009312","oligosaccharide biosynthetic process" -"GO:0097152","mesenchymal cell apoptotic process" -"GO:1900497","regulation of butyryl-CoA catabolic process to butanol" -"GO:0016255","attachment of GPI anchor to protein" -"GO:1902111","response to diethyl maleate" -"GO:0035389","establishment of chromatin silencing at silent mating-type cassette" -"GO:1900274","regulation of phospholipase C activity" -"GO:0050975","sensory perception of touch" -"GO:0061704","glycolytic process from sucrose" -"GO:1990672","medial-Golgi-derived vesicle fusion with Golgi trans cisterna membrane" -"GO:0046787","viral DNA repair" -"GO:1904584","cellular response to polyamine macromolecule" -"GO:0075120","negative regulation by symbiont of host G-protein coupled receptor protein signal transduction" -"GO:0098904","regulation of AV node cell action potential" -"GO:1903191","glyoxal biosynthetic process" -"GO:0055088","lipid homeostasis" -"GO:0060837","blood vessel endothelial cell differentiation" -"GO:0045837","negative regulation of membrane potential" -"GO:1900266","negative regulation of substance P receptor binding" -"GO:0071586","CAAX-box protein processing" -"GO:1900330","regulation of methane biosynthetic process from trimethylamine" -"GO:1903006","positive regulation of protein K63-linked deubiquitination" -"GO:0019877","diaminopimelate biosynthetic process" -"GO:1902208","regulation of bacterial-type flagellum assembly" -"GO:1990689","endoplasmic reticulum-Golgi intermediate compartment (ERGIC) derived vesicle fusion with Golgi cis cisterna membrane" -"GO:0015881","creatine transmembrane transport" -"GO:1905828","regulation of prostaglandin catabolic process" -"GO:0035026","leading edge cell differentiation" -"GO:1905510","negative regulation of myosin II filament assembly" -"GO:1990690","Golgi medial cisterna-derived vesicle fusion with Golgi cis cisterna membrane" -"GO:0050760","negative regulation of thymidylate synthase biosynthetic process" -"GO:1904353","regulation of telomere capping" -"GO:0021841","chemoattraction involved in interneuron migration from the subpallium to the cortex" -"GO:1905663","positive regulation of telomerase RNA reverse transcriptase activity" -"GO:0000097","sulfur amino acid biosynthetic process" -"GO:0061274","mesonephric distal tubule development" -"GO:0043549","regulation of kinase activity" -"GO:0010896","regulation of triglyceride catabolic process" -"GO:0061401","positive regulation of transcription from RNA polymerase II promoter in response to a hypotonic environment" -"GO:1902081","negative regulation of calcium ion import into sarcoplasmic reticulum" -"GO:1904001","positive regulation of pyrimidine-containing compound salvage by positive regulation of transcription from RNA polymerase II promoter" -"GO:0022013","pallium cell proliferation in forebrain" -"GO:0034502","protein localization to chromosome" -"GO:1900006","positive regulation of dendrite development" -"GO:0034230","enkephalin processing" -"GO:0035399","helper T cell enhancement of B cell mediated immune response" -"GO:0018243","protein O-linked glycosylation via threonine" -"GO:0018993","somatic sex determination" -"GO:0061427","negative regulation of ceramide biosynthetic process by negative regulation of transcription from RNA Polymerase II promoter" -"GO:0009073","aromatic amino acid family biosynthetic process" -"GO:0070265","necrotic cell death" -"GO:2000614","positive regulation of thyroid-stimulating hormone secretion" -"GO:0051125","regulation of actin nucleation" -"GO:0070269","pyroptosis" -"GO:0061291","canonical Wnt signaling pathway involved in ureteric bud branching" -"GO:0070920","regulation of production of small RNA involved in gene silencing by RNA" -"GO:0045952","regulation of juvenile hormone catabolic process" -"GO:0060940","epithelial to mesenchymal transition involved in cardiac fibroblast development" -"GO:2001212","regulation of vasculogenesis" -"GO:0070584","mitochondrion morphogenesis" -"GO:0098905","regulation of bundle of His cell action potential" -"GO:0010462","regulation of light-activated voltage-gated calcium channel activity" -"GO:0009956","radial pattern formation" -"GO:0003193","pulmonary valve formation" -"GO:0045022","early endosome to late endosome transport" -"GO:0098935","dendritic transport" -"GO:0120011","intermembrane sterol transfer" -"GO:1904755","regulation of gut granule assembly" -"GO:0010439","regulation of glucosinolate biosynthetic process" -"GO:0043534","blood vessel endothelial cell migration" -"GO:0034447","very-low-density lipoprotein particle clearance" -"GO:0034587","piRNA metabolic process" -"GO:0010183","pollen tube guidance" -"GO:0003212","cardiac left atrium morphogenesis" -"GO:1900855","regulation of fumitremorgin B biosynthetic process" -"GO:0099561","synaptic membrane adhesion to extracellular matrix" -"GO:0052131","positive aerotaxis" -"GO:0086019","cell-cell signaling involved in cardiac conduction" -"GO:0061469","regulation of type B pancreatic cell proliferation" -"GO:0000956","nuclear-transcribed mRNA catabolic process" -"GO:1900277","negative regulation of proteinase activated receptor activity" -"GO:0086044","atrial cardiac muscle cell to AV node cell communication by electrical coupling" -"GO:1903303","negative regulation of pyruvate kinase activity" -"GO:0061902","negative regulation of 1-phosphatidylinositol-3-kinase activity" -"GO:0035777","pronephric distal tubule development" -"GO:0070562","regulation of vitamin D receptor signaling pathway" -"GO:0035922","foramen ovale closure" -"GO:1904436","negative regulation of transferrin receptor binding" -"GO:0038026","reelin-mediated signaling pathway" -"GO:0003201","epithelial to mesenchymal transition involved in coronary vasculature morphogenesis" -"GO:0045002","double-strand break repair via single-strand annealing" -"GO:0007018","microtubule-based movement" -"GO:0008219","cell death" -"GO:0070150","mitochondrial glycyl-tRNA aminoacylation" -"GO:1902110","positive regulation of mitochondrial membrane permeability involved in apoptotic process" -"GO:0051866","general adaptation syndrome" -"GO:0001676","long-chain fatty acid metabolic process" -"GO:0019453","L-cysteine catabolic process via cystine" -"GO:0002454","peripheral B cell deletion" -"GO:1905746","positive regulation of mRNA cis splicing, via spliceosome" -"GO:0034436","glycoprotein transport" -"GO:1903941","negative regulation of respiratory gaseous exchange" -"GO:2001267","regulation of cysteine-type endopeptidase activity involved in apoptotic signaling pathway" -"GO:0062003","negative regulation of all-trans-retinyl-ester hydrolase, 11-cis retinol forming activity" -"GO:0060080","inhibitory postsynaptic potential" -"GO:1905560","negative regulation of kinetochore assembly" -"GO:0009620","response to fungus" -"GO:0030814","regulation of cAMP metabolic process" -"GO:1905467","positive regulation of G-quadruplex DNA unwinding" -"GO:1904241","positive regulation of VCP-NPL4-UFD1 AAA ATPase complex assembly" -"GO:1904737","positive regulation of fatty acid beta-oxidation using acyl-CoA dehydrogenase" -"GO:0099551","trans-synaptic signaling by neuropeptide, modulating synaptic transmission" -"GO:0097028","dendritic cell differentiation" -"GO:2000066","positive regulation of cortisol biosynthetic process" -"GO:0019098","reproductive behavior" -"GO:0044321","response to leptin" -"GO:2000704","positive regulation of fibroblast growth factor receptor signaling pathway involved in ureteric bud formation" -"GO:0006622","protein targeting to lysosome" -"GO:1901195","positive regulation of formation of translation preinitiation complex" -"GO:0002328","pro-B cell differentiation" -"GO:0010822","positive regulation of mitochondrion organization" -"GO:0015810","aspartate transmembrane transport" -"GO:1903318","negative regulation of protein maturation" -"GO:1904177","regulation of adipose tissue development" -"GO:2001235","positive regulation of apoptotic signaling pathway" -"GO:0035238","vitamin A biosynthetic process" -"GO:1904189","positive regulation of transformation of host cell by virus" -"GO:0001838","embryonic epithelial tube formation" -"GO:0000023","maltose metabolic process" -"GO:0038020","insulin receptor recycling" -"GO:0045886","negative regulation of synaptic growth at neuromuscular junction" -"GO:0071233","cellular response to leucine" -"GO:0006507","GPI anchor release" -"GO:0072540","T-helper 17 cell lineage commitment" -"GO:0046716","muscle cell cellular homeostasis" -"GO:0032411","positive regulation of transporter activity" -"GO:0071500","cellular response to nitrosative stress" -"GO:0030537","larval behavior" -"GO:0098508","endothelial to hematopoietic transition" -"GO:0006676","mannosyl diphosphorylinositol ceramide metabolic process" -"GO:0038030","non-canonical Wnt signaling pathway via MAPK cascade" -"GO:0006438","valyl-tRNA aminoacylation" -"GO:1900514","positive regulation of starch utilization system complex assembly" -"GO:0032096","negative regulation of response to food" -"GO:0009803","cinnamic acid metabolic process" -"GO:0043116","negative regulation of vascular permeability" -"GO:0097293","XMP biosynthetic process" -"GO:2000225","negative regulation of testosterone biosynthetic process" -"GO:0071875","adrenergic receptor signaling pathway" -"GO:0060273","crying behavior" -"GO:0048067","cuticle pigmentation" -"GO:0061369","negative regulation of testicular blood vessel morphogenesis" -"GO:0002209","behavioral defense response" -"GO:1905200","gibberellic acid transmembrane transport" -"GO:0016562","protein import into peroxisome matrix, receptor recycling" -"GO:1990426","mitotic recombination-dependent replication fork processing" -"GO:1904439","negative regulation of ferrous iron import across plasma membrane" -"GO:1902846","positive regulation of mitotic spindle elongation" -"GO:1903527","positive regulation of membrane tubulation" -"GO:0032537","host-seeking behavior" -"GO:0044320","cellular response to leptin stimulus" -"GO:0072674","multinuclear osteoclast differentiation" -"GO:1901898","negative regulation of relaxation of cardiac muscle" -"GO:0034198","cellular response to amino acid starvation" -"GO:1990253","cellular response to leucine starvation" -"GO:0044708","single-organism behavior" -"GO:0042590","antigen processing and presentation of exogenous peptide antigen via MHC class I" -"GO:0032017","positive regulation of Ran protein signal transduction" -"GO:0060756","foraging behavior" -"GO:1905269","positive regulation of chromatin organization" -"GO:0061408","positive regulation of transcription from RNA polymerase II promoter in response to heat stress" -"GO:0007600","sensory perception" -"GO:0010476","gibberellin mediated signaling pathway" -"GO:1905646","positive regulation of FACT complex assembly" -"GO:1904031","positive regulation of cyclin-dependent protein kinase activity" -"GO:0002026","regulation of the force of heart contraction" -"GO:0060586","multicellular organismal iron ion homeostasis" -"GO:0000297","spermine transmembrane transporter activity" -"GO:1903521","positive regulation of mammary gland involution" -"GO:0044072","negative regulation by symbiont of host cell cycle" -"GO:0043618","regulation of transcription from RNA polymerase II promoter in response to stress" -"GO:1903099","positive regulation of CENP-A containing nucleosome assembly" -"GO:1902728","positive regulation of growth factor dependent skeletal muscle satellite cell proliferation" -"GO:1904685","positive regulation of metalloendopeptidase activity" -"GO:0086028","bundle of His cell to Purkinje myocyte signaling" -"GO:1903452","positive regulation of G1 to G0 transition" -"GO:0045362","positive regulation of interleukin-1 biosynthetic process" -"GO:0045836","positive regulation of meiotic nuclear division" -"GO:1904332","negative regulation of error-prone translesion synthesis" -"GO:0048840","otolith development" -"GO:0043039","tRNA aminoacylation" -"GO:0051564","positive regulation of smooth endoplasmic reticulum calcium ion concentration" -"GO:0072432","response to G1 DNA damage checkpoint signaling" -"GO:1904393","regulation of skeletal muscle acetylcholine-gated channel clustering" -"GO:1904025","positive regulation of glucose catabolic process to lactate via pyruvate" -"GO:0034627","'de novo' NAD biosynthetic process" -"GO:1904973","positive regulation of viral translation" -"GO:2000019","negative regulation of male gonad development" -"GO:0045004","DNA replication proofreading" -"GO:0060129","thyroid-stimulating hormone-secreting cell differentiation" -"GO:1904055","negative regulation of cholangiocyte proliferation" -"GO:0006937","regulation of muscle contraction" -"GO:0014049","positive regulation of glutamate secretion" -"GO:0010730","negative regulation of hydrogen peroxide biosynthetic process" -"GO:2000012","regulation of auxin polar transport" -"GO:1903057","negative regulation of melanosome organization" -"GO:0019484","beta-alanine catabolic process" -"GO:0032754","positive regulation of interleukin-5 production" -"GO:0030237","female sex determination" -"GO:1904524","negative regulation of DNA amplification" -"GO:0032446","protein modification by small protein conjugation" -"GO:0051867","general adaptation syndrome, behavioral process" -"GO:0032429","regulation of phospholipase A2 activity" -"GO:0042311","vasodilation" -"GO:0045408","regulation of interleukin-6 biosynthetic process" -"GO:0010161","red light signaling pathway" -"GO:0097750","endosome membrane tubulation" -"GO:1905088","positive regulation of synaptonemal complex assembly" -"GO:1904717","regulation of AMPA glutamate receptor clustering" -"GO:1904785","regulation of asymmetric protein localization involved in cell fate determination" -"GO:0042534","regulation of tumor necrosis factor biosynthetic process" -"GO:1902882","regulation of response to oxidative stress" -"GO:0060545","positive regulation of necroptotic process" -"GO:0071268","homocysteine biosynthetic process" -"GO:1903656","regulation of type IV pilus biogenesis" -"GO:0030043","actin filament fragmentation" -"GO:0002574","thrombocyte differentiation" -"GO:1904120","positive regulation of otic vesicle morphogenesis" -"GO:0002766","innate immune response-inhibiting signal transduction" -"GO:1905102","positive regulation of apoptosome assembly" -"GO:1901400","positive regulation of transforming growth factor beta3 activation" -"GO:0043181","vacuolar sequestering" -"GO:0033169","histone H3-K9 demethylation" -"GO:1990126","retrograde transport, endosome to plasma membrane" -"GO:0046937","phytochelatin metabolic process" -"GO:0030302","deoxynucleotide transport" -"GO:0014057","positive regulation of acetylcholine secretion, neurotransmission" -"GO:0070077","histone arginine demethylation" -"GO:0039657","suppression by virus of host gene expression" -"GO:0075108","negative regulation by symbiont of host adenylate cyclase activity" -"GO:0014050","negative regulation of glutamate secretion" -"GO:1901970","positive regulation of mitotic sister chromatid separation" -"GO:1904240","negative regulation of VCP-NPL4-UFD1 AAA ATPase complex assembly" -"GO:0044210","'de novo' CTP biosynthetic process" -"GO:0019953","sexual reproduction" -"GO:0035678","neuromast hair cell morphogenesis" -"GO:0006702","androgen biosynthetic process" -"GO:0002318","myeloid progenitor cell differentiation" -"GO:0022031","telencephalon astrocyte cell migration" -"GO:2001177","negative regulation of mediator complex assembly" -"GO:1900124","negative regulation of nodal receptor complex assembly" -"GO:0005985","sucrose metabolic process" -"GO:0045345","positive regulation of MHC class I biosynthetic process" -"GO:0010624","regulation of Schwann cell proliferation" -"GO:1904702","regulation of protein localization to cell-cell adherens junction" -"GO:1903679","positive regulation of cap-independent translational initiation" -"GO:0045197","establishment or maintenance of epithelial cell apical/basal polarity" -"GO:0033143","regulation of intracellular steroid hormone receptor signaling pathway" -"GO:0006425","glutaminyl-tRNA aminoacylation" -"GO:0031569","mitotic G2 cell size control checkpoint" -"GO:0031111","negative regulation of microtubule polymerization or depolymerization" -"GO:0006934","substrate-bound cell migration, adhesion receptor recycling" -"GO:0015515","citrate:succinate antiporter activity" -"GO:1902483","cytotoxic T cell apoptotic process" -"GO:1903242","regulation of cardiac muscle hypertrophy in response to stress" -"GO:0044805","late nucleophagy" -"GO:0061377","mammary gland lobule development" -"GO:0060905","regulation of induction of conjugation upon nitrogen starvation" -"GO:0005253","anion channel activity" -"GO:0071696","ectodermal placode development" -"GO:0015896","nalidixic acid transport" -"GO:0036365","transforming growth factor beta2 activation" -"GO:0010214","seed coat development" -"GO:0015195","L-threonine transmembrane transporter activity" -"GO:0033670","regulation of NAD+ kinase activity" -"GO:0061169","positive regulation of hair placode formation" -"GO:1901966","regulation of cellular response to iron ion starvation" -"GO:1903760","regulation of voltage-gated potassium channel activity involved in ventricular cardiac muscle cell action potential repolarization" -"GO:0030534","adult behavior" -"GO:0010516","negative regulation of cellular response to nitrogen starvation" -"GO:0031099","regeneration" -"GO:0045226","extracellular polysaccharide biosynthetic process" -"GO:0006633","fatty acid biosynthetic process" -"GO:0080113","regulation of seed growth" -"GO:0035337","fatty-acyl-CoA metabolic process" -"GO:1902535","multi-organism membrane invagination" -"GO:0072102","glomerulus morphogenesis" -"GO:1903332","regulation of protein folding" -"GO:2000646","positive regulation of receptor catabolic process" -"GO:0071205","protein localization to juxtaparanode region of axon" -"GO:0022890","inorganic cation transmembrane transporter activity" -"GO:0044608","peptidyl-L-threonine methyl ester biosynthetic process from peptidyl-threonine" -"GO:1990551","mitochondrial 2-oxoadipate transmembrane transport" -"GO:2000176","positive regulation of pro-T cell differentiation" -"GO:0051362","peptide cross-linking via 2-tetrahydropyridinyl-5-imidazolinone glycine" -"GO:0044859","protein insertion into plasma membrane raft" -"GO:1905536","negative regulation of eukaryotic translation initiation factor 4F complex assembly" -"GO:0048193","Golgi vesicle transport" -"GO:0080186","developmental vegetative growth" -"GO:0097736","aerial mycelium formation" -"GO:0012502","induction of programmed cell death" -"GO:1903003","positive regulation of protein deubiquitination" -"GO:0001949","sebaceous gland cell differentiation" -"GO:0019431","acetyl-CoA biosynthetic process from ethanol" -"GO:0019556","histidine catabolic process to glutamate and formamide" -"GO:1903374","subarachnoid space development" -"GO:0048845","venous blood vessel morphogenesis" -"GO:0071420","cellular response to histamine" -"GO:0080065","4-alpha-methyl-delta7-sterol oxidation" -"GO:0070302","regulation of stress-activated protein kinase signaling cascade" -"GO:0042932","chrysobactin transport" -"GO:0035906","descending aorta development" -"GO:0005290","L-histidine transmembrane transporter activity" -"GO:0071655","regulation of granulocyte colony-stimulating factor production" -"GO:0099040","ceramide translocation" -"GO:0010643","cell communication by chemical coupling" -"GO:0071447","cellular response to hydroperoxide" -"GO:0071109","superior temporal gyrus development" -"GO:0030258","lipid modification" -"GO:0036366","transforming growth factor beta3 activation" -"GO:0022889","serine transmembrane transporter activity" -"GO:0036076","ligamentous ossification" -"GO:0019856","pyrimidine nucleobase biosynthetic process" -"GO:0005304","L-valine transmembrane transporter activity" -"GO:0046683","response to organophosphorus" -"GO:0033229","cysteine transmembrane transporter activity" -"GO:0010158","abaxial cell fate specification" -"GO:1905683","peroxisome disassembly" -"GO:0090085","regulation of protein deubiquitination" -"GO:0097061","dendritic spine organization" -"GO:1901018","positive regulation of potassium ion transmembrane transporter activity" -"GO:0002329","pre-B cell differentiation" -"GO:0070972","protein localization to endoplasmic reticulum" -"GO:0003248","heart capillary growth" -"GO:2000077","negative regulation of type B pancreatic cell development" -"GO:0019449","L-cysteine catabolic process to hypotaurine" -"GO:2000615","regulation of histone H3-K9 acetylation" -"GO:0090075","relaxation of muscle" -"GO:0048857","neural nucleus development" -"GO:1905031","regulation of membrane repolarization during cardiac muscle cell action potential" -"GO:0010461","light-activated ion channel activity" -"GO:0033228","cysteine export across plasma membrane" -"GO:0015121","phosphoenolpyruvate:phosphate antiporter activity" -"GO:0044381","glucose import in response to insulin stimulus" -"GO:0015188","L-isoleucine transmembrane transporter activity" -"GO:1904547","regulation of cellular response to glucose starvation" -"GO:1902619","regulation of microtubule minus-end binding" -"GO:0042180","cellular ketone metabolic process" -"GO:0015193","L-proline transmembrane transporter activity" -"GO:0051480","regulation of cytosolic calcium ion concentration" -"GO:0030804","positive regulation of cyclic nucleotide biosynthetic process" -"GO:0070252","actin-mediated cell contraction" -"GO:0032286","central nervous system myelin maintenance" -"GO:0035178","turning behavior" -"GO:0090175","regulation of establishment of planar polarity" -"GO:1902991","regulation of amyloid precursor protein catabolic process" -"GO:0090153","regulation of sphingolipid biosynthetic process" -"GO:0061524","central canal development" -"GO:0015735","uronic acid transmembrane transport" -"GO:0015192","L-phenylalanine transmembrane transporter activity" -"GO:0071308","cellular response to menaquinone" -"GO:0090628","plant epidermal cell fate specification" -"GO:1903766","positive regulation of potassium ion export across plasma membrane" -"GO:0018057","peptidyl-lysine oxidation" -"GO:0045033","peroxisome inheritance" -"GO:0072671","mitochondria-associated ubiquitin-dependent protein catabolic process" -"GO:0015190","L-leucine transmembrane transporter activity" -"GO:0036155","acylglycerol acyl-chain remodeling" -"GO:1900944","regulation of isoprene metabolic process" -"GO:0072058","outer stripe development" -"GO:1900754","4-hydroxyphenylacetate transport" -"GO:0032774","RNA biosynthetic process" -"GO:0098656","anion transmembrane transport" -"GO:0072057","inner stripe development" -"GO:1905755","protein localization to cytoplasmic microtubule" -"GO:0000064","L-ornithine transmembrane transporter activity" -"GO:0086024","adenylate cyclase-activating adrenergic receptor signaling pathway involved in positive regulation of heart rate" -"GO:0007522","visceral muscle development" -"GO:1905000","regulation of membrane repolarization during atrial cardiac muscle cell action potential" -"GO:0099132","ATP hydrolysis coupled cation transmembrane transport" -"GO:2000672","negative regulation of motor neuron apoptotic process" -"GO:0032378","negative regulation of intracellular lipid transport" -"GO:0043416","regulation of skeletal muscle tissue regeneration" -"GO:1904030","negative regulation of cyclin-dependent protein kinase activity" -"GO:0071450","cellular response to oxygen radical" -"GO:0035903","cellular response to immobilization stress" -"GO:0046583","cation efflux transmembrane transporter activity" -"GO:1905897","regulation of response to endoplasmic reticulum stress" -"GO:1900347","positive regulation of methane biosynthetic process from methanethiol" -"GO:0019432","triglyceride biosynthetic process" -"GO:0003228","atrial cardiac muscle tissue development" -"GO:0034490","basic amino acid transmembrane import into vacuole" -"GO:2000823","regulation of androgen receptor activity" -"GO:0072109","glomerular mesangium development" -"GO:0015714","phosphoenolpyruvate transport" -"GO:0035464","regulation of transforming growth factor receptor beta signaling pathway involved in determination of left/right asymmetry" -"GO:0043972","histone H3-K23 acetylation" -"GO:0089708","L-histidine transmembrane export from vacuole" -"GO:0010999","regulation of eIF2 alpha phosphorylation by heme" -"GO:0002522","leukocyte migration involved in immune response" -"GO:0042889","3-phenylpropionic acid transport" -"GO:0048868","pollen tube development" -"GO:0098598","learned vocalization behavior or vocal learning" -"GO:1901194","negative regulation of formation of translation preinitiation complex" -"GO:0106049","regulation of cellular response to osmotic stress" -"GO:0035801","adrenal cortex development" -"GO:0019623","atrazine catabolic process to urea" -"GO:1901303","negative regulation of cargo loading into COPII-coated vesicle" -"GO:0032878","regulation of establishment or maintenance of cell polarity" -"GO:0090156","cellular sphingolipid homeostasis" -"GO:0006650","glycerophospholipid metabolic process" -"GO:0015101","organic cation transmembrane transporter activity" -"GO:2001293","malonyl-CoA metabolic process" -"GO:1904149","regulation of microglial cell mediated cytotoxicity" -"GO:0014831","gastro-intestinal system smooth muscle contraction" -"GO:1905592","negative regulation of optical nerve axon regeneration" -"GO:0015719","allantoate transport" -"GO:0060156","milk ejection reflex" -"GO:0022839","ion gated channel activity" -"GO:0048098","antennal joint development" -"GO:0010374","stomatal complex development" -"GO:0060176","regulation of aggregation involved in sorocarp development" -"GO:1903832","regulation of cellular response to amino acid starvation" -"GO:0086070","SA node cell to atrial cardiac muscle cell communication" -"GO:1903779","regulation of cardiac conduction" -"GO:0032570","response to progesterone" -"GO:1904490","negative regulation of mitochondrial unfolded protein response by negative regulation of transcription from RNA polymerase II promoter" -"GO:0034052","positive regulation of plant-type hypersensitive response" -"GO:0075089","negative regulation by host of symbiont G-protein coupled receptor protein signal transduction" -"GO:1900332","positive regulation of methane biosynthetic process from trimethylamine" -"GO:0036153","triglyceride acyl-chain remodeling" -"GO:0060950","cardiac glial cell differentiation" -"GO:0061581","corneal epithelial cell migration" -"GO:1903569","positive regulation of protein localization to ciliary membrane" -"GO:1902949","positive regulation of tau-protein kinase activity" -"GO:0021770","parahippocampal gyrus development" -"GO:0060359","response to ammonium ion" -"GO:1905089","regulation of parkin-mediated stimulation of mitophagy in response to mitochondrial depolarization" -"GO:0010021","amylopectin biosynthetic process" -"GO:2000638","regulation of SREBP signaling pathway" -"GO:1904869","regulation of protein localization to Cajal body" -"GO:0030644","cellular chloride ion homeostasis" -"GO:0042698","ovulation cycle" -"GO:1990059","fruit valve development" -"GO:0048658","anther wall tapetum development" -"GO:1901232","regulation of convergent extension involved in axis elongation" -"GO:0050984","peptidyl-serine sulfation" -"GO:0005261","cation channel activity" -"GO:0044778","meiotic DNA integrity checkpoint" -"GO:2000987","positive regulation of behavioral fear response" -"GO:1903098","negative regulation of CENP-A containing nucleosome assembly" -"GO:0002809","negative regulation of antibacterial peptide biosynthetic process" -"GO:0016485","protein processing" -"GO:0060531","neuroendocrine cell differentiation involved in prostate gland acinus development" -"GO:0032966","negative regulation of collagen biosynthetic process" -"GO:0032640","tumor necrosis factor production" -"GO:0030198","extracellular matrix organization" -"GO:0042078","germ-line stem cell division" -"GO:2000676","positive regulation of type B pancreatic cell apoptotic process" -"GO:0018343","protein farnesylation" -"GO:1900484","negative regulation of protein targeting to vacuolar membrane" -"GO:0042594","response to starvation" -"GO:0060432","lung pattern specification process" -"GO:0033026","negative regulation of mast cell apoptotic process" -"GO:0071320","cellular response to cAMP" -"GO:0048896","lateral line nerve glial cell migration" -"GO:0097041","phenolic phthiocerol biosynthetic process" -"GO:0072764","cellular response to reversine" -"GO:0045017","glycerolipid biosynthetic process" -"GO:0006290","pyrimidine dimer repair" -"GO:0002894","positive regulation of type II hypersensitivity" -"GO:0086017","Purkinje myocyte action potential" -"GO:0051547","regulation of keratinocyte migration" -"GO:0099050","vesicle scission" -"GO:0072744","cellular response to trichodermin" -"GO:0043331","response to dsRNA" -"GO:0005999","xylulose biosynthetic process" -"GO:0008104","protein localization" -"GO:0042047","W-molybdopterin cofactor biosynthetic process" -"GO:0033382","maintenance of granzyme B location in T cell secretory granule" -"GO:1905753","positive regulation of argininosuccinate synthase activity" -"GO:1904023","regulation of glucose catabolic process to lactate via pyruvate" -"GO:0006098","pentose-phosphate shunt" -"GO:0090644","age-related resistance" -"GO:0043408","regulation of MAPK cascade" -"GO:0018272","protein-pyridoxal-5-phosphate linkage via peptidyl-N6-pyridoxal phosphate-L-lysine" -"GO:0007626","locomotory behavior" -"GO:0097040","phthiocerol biosynthetic process" -"GO:1901150","vistamycin metabolic process" -"GO:0045079","negative regulation of chemokine biosynthetic process" -"GO:0097384","cellular lipid biosynthetic process" -"GO:0002384","hepatic immune response" -"GO:0007389","pattern specification process" -"GO:1904620","cellular response to dimethyl sulfoxide" -"GO:0030505","inorganic diphosphate transport" -"GO:1905171","positive regulation of protein localization to phagocytic vesicle" -"GO:2000091","negative regulation of mesonephric glomerular mesangial cell proliferation" -"GO:0090387","phagolysosome assembly involved in apoptotic cell clearance" -"GO:0032889","regulation of vacuole fusion, non-autophagic" -"GO:0009103","lipopolysaccharide biosynthetic process" -"GO:1901224","positive regulation of NIK/NF-kappaB signaling" -"GO:0051247","positive regulation of protein metabolic process" -"GO:0050885","neuromuscular process controlling balance" -"GO:0002675","positive regulation of acute inflammatory response" -"GO:0051705","multi-organism behavior" -"GO:0006002","fructose 6-phosphate metabolic process" -"GO:0032808","lacrimal gland development" -"GO:1904022","positive regulation of G-protein coupled receptor internalization" -"GO:0007617","mating behavior" -"GO:0086094","positive regulation of ryanodine-sensitive calcium-release channel activity by adrenergic receptor signaling pathway involved in positive regulation of cardiac muscle contraction" -"GO:1902899","fatty acid methyl ester biosynthetic process" -"GO:0030858","positive regulation of epithelial cell differentiation" -"GO:0000098","sulfur amino acid catabolic process" -"GO:0021918","regulation of transcription from RNA polymerase II promoter involved in somatic motor neuron fate commitment" -"GO:0009847","spore germination" -"GO:0070091","glucagon secretion" -"GO:0010574","regulation of vascular endothelial growth factor production" -"GO:0036297","interstrand cross-link repair" -"GO:0002247","clearance of damaged tissue involved in inflammatory response wound healing" -"GO:0019412","aerobic respiration, using hydrogen as electron donor" -"GO:2000720","positive regulation of maintenance of mitotic sister chromatid cohesion, centromeric" -"GO:0061458","reproductive system development" -"GO:0044495","modulation of blood pressure in other organism" -"GO:1901856","negative regulation of cellular respiration" -"GO:0044075","modulation by symbiont of host vacuole organization" -"GO:0048169","regulation of long-term neuronal synaptic plasticity" -"GO:1904831","positive regulation of aortic smooth muscle cell differentiation" -"GO:0015013","heparan sulfate proteoglycan biosynthetic process, linkage to polypeptide" -"GO:1905266","blasticidin S biosynthetic process" -"GO:2000427","positive regulation of apoptotic cell clearance" -"GO:0071729","beak morphogenesis" -"GO:0046460","neutral lipid biosynthetic process" -"GO:0021821","negative regulation of cell-glial cell adhesion involved in cerebral cortex lamination" -"GO:0046889","positive regulation of lipid biosynthetic process" -"GO:0060232","delamination" -"GO:0046580","negative regulation of Ras protein signal transduction" -"GO:0034380","high-density lipoprotein particle assembly" -"GO:0090647","modulation of age-related behavioral decline" -"GO:1903968","cellular response to micafungin" -"GO:1903175","fatty alcohol biosynthetic process" -"GO:0007612","learning" -"GO:0008228","opsonization" -"GO:0033672","positive regulation of NAD+ kinase activity" -"GO:2000653","regulation of genetic imprinting" -"GO:0030212","hyaluronan metabolic process" -"GO:0043696","dedifferentiation" -"GO:0044793","negative regulation by host of viral process" -"GO:0001660","fever generation" -"GO:0045698","negative regulation of synergid differentiation" -"GO:0098815","modulation of excitatory postsynaptic potential" -"GO:0034346","positive regulation of type III interferon production" -"GO:0033103","protein secretion by the type VI secretion system" -"GO:0051563","smooth endoplasmic reticulum calcium ion homeostasis" -"GO:0032490","detection of molecule of bacterial origin" -"GO:0055090","acylglycerol homeostasis" -"GO:0046467","membrane lipid biosynthetic process" -"GO:0060318","definitive erythrocyte differentiation" -"GO:0032868","response to insulin" -"GO:0010951","negative regulation of endopeptidase activity" -"GO:0044264","cellular polysaccharide metabolic process" -"GO:0006415","translational termination" -"GO:1904514","positive regulation of initiation of premeiotic DNA replication" -"GO:0032494","response to peptidoglycan" -"GO:0070935","3'-UTR-mediated mRNA stabilization" -"GO:0032374","regulation of cholesterol transport" -"GO:0033633","negative regulation of cell-cell adhesion mediated by integrin" -"GO:0106016","positive regulation of inflammatory response to wounding" -"GO:1903464","negative regulation of mitotic cell cycle DNA replication" -"GO:0051092","positive regulation of NF-kappaB transcription factor activity" -"GO:0035665","TIRAP-dependent toll-like receptor 4 signaling pathway" -"GO:0100017","negative regulation of cell-cell adhesion by transcription from RNA polymerase II promoter" -"GO:0033031","positive regulation of neutrophil apoptotic process" -"GO:0021913","regulation of transcription from RNA polymerase II promoter involved in ventral spinal cord interneuron specification" -"GO:0016322","neuron remodeling" -"GO:0016024","CDP-diacylglycerol biosynthetic process" -"GO:0030327","prenylated protein catabolic process" -"GO:0032012","regulation of ARF protein signal transduction" -"GO:1903386","negative regulation of homophilic cell adhesion" -"GO:1900867","sarcinapterin metabolic process" -"GO:1902478","negative regulation of defense response to bacterium, incompatible interaction" -"GO:0006775","fat-soluble vitamin metabolic process" -"GO:1902034","negative regulation of hematopoietic stem cell proliferation" -"GO:0044767","single-organism developmental process" -"GO:0009052","pentose-phosphate shunt, non-oxidative branch" -"GO:0006979","response to oxidative stress" -"GO:0045219","regulation of FasL biosynthetic process" -"GO:0010387","COP9 signalosome assembly" -"GO:0033005","positive regulation of mast cell activation" -"GO:1903418","protein localization to plasma membrane of cell tip" -"GO:1903651","positive regulation of cytoplasmic transport" -"GO:1904778","positive regulation of protein localization to cell cortex" -"GO:0032620","interleukin-17 production" -"GO:1902004","positive regulation of amyloid-beta formation" -"GO:0038028","insulin receptor signaling pathway via phosphatidylinositol 3-kinase" -"GO:0006575","cellular modified amino acid metabolic process" -"GO:0060362","flight involved in flight behavior" -"GO:1904640","response to methionine" -"GO:2000310","regulation of NMDA receptor activity" -"GO:1904147","response to nonylphenol" -"GO:0032758","positive regulation of interleukin-9 production" -"GO:0048691","positive regulation of axon extension involved in regeneration" -"GO:0050704","regulation of interleukin-1 secretion" -"GO:0001953","negative regulation of cell-matrix adhesion" -"GO:0060169","negative regulation of adenosine receptor signaling pathway" -"GO:0006925","inflammatory cell apoptotic process" -"GO:2001179","regulation of interleukin-10 secretion" -"GO:0106045","guanine deglycation, methylglyoxal removal" -"GO:0140024","plus-end-directed endosome transport along mitotic spindle midzone microtubule" -"GO:1904828","positive regulation of hydrogen sulfide biosynthetic process" -"GO:1900166","regulation of glial cell-derived neurotrophic factor secretion" -"GO:0032746","positive regulation of interleukin-22 production" -"GO:0110062","negative regulation of angiotensin-activated signaling pathway" -"GO:0032544","plastid translation" -"GO:0002181","cytoplasmic translation" -"GO:0007223","Wnt signaling pathway, calcium modulating pathway" -"GO:0042759","long-chain fatty acid biosynthetic process" -"GO:2000514","regulation of CD4-positive, alpha-beta T cell activation" -"GO:0061470","T follicular helper cell differentiation" -"GO:0021943","formation of radial glial scaffolds" -"GO:0042753","positive regulation of circadian rhythm" -"GO:0045661","regulation of myoblast differentiation" -"GO:0070656","mechanoreceptor differentiation involved in mechanosensory epithelium regeneration" -"GO:0045663","positive regulation of myoblast differentiation" -"GO:1990138","neuron projection extension" -"GO:0003073","regulation of systemic arterial blood pressure" -"GO:0002029","desensitization of G-protein coupled receptor protein signaling pathway" -"GO:1902727","negative regulation of growth factor dependent skeletal muscle satellite cell proliferation" -"GO:0001829","trophectodermal cell differentiation" -"GO:0070682","proteasome regulatory particle assembly" -"GO:1900737","negative regulation of phospholipase C-activating G-protein coupled receptor signaling pathway" -"GO:1901329","regulation of odontoblast differentiation" -"GO:0036526","peptidyl-cysteine deglycation" -"GO:0052707","N-alpha,N-alpha,N-alpha-trimethyl-L-histidine biosynthesis from histidine" -"GO:0071307","cellular response to vitamin K" -"GO:1990009","retinal cell apoptotic process" -"GO:0051200","positive regulation of prosthetic group metabolic process" -"GO:0090113","regulation of ER to Golgi vesicle-mediated transport by GTP hydrolysis" -"GO:1904606","fat cell apoptotic process" -"GO:0002868","negative regulation of B cell deletion" -"GO:0071994","phytochelatin transmembrane transport" -"GO:0032543","mitochondrial translation" -"GO:0090268","activation of mitotic cell cycle spindle assembly checkpoint" -"GO:0038032","termination of G-protein coupled receptor signaling pathway" -"GO:0033028","myeloid cell apoptotic process" -"GO:0072028","nephron morphogenesis" -"GO:2000560","positive regulation of CD24 biosynthetic process" -"GO:0043276","anoikis" -"GO:0036302","atrioventricular canal development" -"GO:0089704","L-glutamate transmembrane export from vacuole" -"GO:0060010","Sertoli cell fate commitment" -"GO:1901256","regulation of macrophage colony-stimulating factor production" -"GO:0002733","regulation of myeloid dendritic cell cytokine production" -"GO:0036530","protein deglycation, methylglyoxal removal" -"GO:0071887","leukocyte apoptotic process" -"GO:0040019","positive regulation of embryonic development" -"GO:0000414","regulation of histone H3-K36 methylation" -"GO:0036336","dendritic cell migration" -"GO:0034349","glial cell apoptotic process" -"GO:0006761","dihydrofolate biosynthetic process" -"GO:0044601","protein denucleotidylation" -"GO:1901301","regulation of cargo loading into COPII-coated vesicle" -"GO:0072539","T-helper 17 cell differentiation" -"GO:1904019","epithelial cell apoptotic process" -"GO:2000312","regulation of kainate selective glutamate receptor activity" -"GO:0055079","aluminum ion homeostasis" -"GO:0036529","protein deglycation, glyoxal removal" -"GO:1900424","regulation of defense response to bacterium" -"GO:0022008","neurogenesis" -"GO:0051402","neuron apoptotic process" -"GO:0007052","mitotic spindle organization" -"GO:0008346","larval walking behavior" -"GO:0002723","positive regulation of B cell cytokine production" -"GO:0045422","positive regulation of connective tissue growth factor biosynthetic process" -"GO:1901509","regulation of endothelial tube morphogenesis" -"GO:0000493","box H/ACA snoRNP assembly" -"GO:0035973","aggrephagy" -"GO:1900025","negative regulation of substrate adhesion-dependent cell spreading" -"GO:1903168","positive regulation of pyrroline-5-carboxylate reductase activity" -"GO:0061042","vascular wound healing" -"GO:0043386","mycotoxin biosynthetic process" -"GO:0140208","apoptotic process in response to mitochondrial fragmentation" -"GO:1903122","negative regulation of TRAIL-activated apoptotic signaling pathway" -"GO:0045570","regulation of imaginal disc growth" -"GO:2000438","negative regulation of monocyte extravasation" -"GO:0016601","Rac protein signal transduction" -"GO:0070949","regulation of neutrophil mediated killing of symbiont cell" -"GO:1903200","positive regulation of L-dopa decarboxylase activity" -"GO:0090029","negative regulation of pheromone-dependent signal transduction involved in conjugation with cellular fusion" -"GO:1903189","glyoxal metabolic process" -"GO:0044832","positive regulation by virus of host cytokine production" -"GO:0003289","atrial septum primum morphogenesis" -"GO:0010273","detoxification of copper ion" -"GO:1905383","protein localization to presynapse" -"GO:0032748","positive regulation of interleukin-24 production" -"GO:0033048","negative regulation of mitotic sister chromatid segregation" -"GO:0043099","pyrimidine deoxyribonucleoside salvage" -"GO:0010657","muscle cell apoptotic process" -"GO:0070756","positive regulation of interleukin-35 production" -"GO:0014911","positive regulation of smooth muscle cell migration" -"GO:2001254","negative regulation of histone H3-K36 trimethylation" -"GO:0032333","activin secretion" -"GO:0032752","positive regulation of interleukin-3 production" -"GO:1904438","regulation of ferrous iron import across plasma membrane" -"GO:0071560","cellular response to transforming growth factor beta stimulus" -"GO:0006201","GMP catabolic process to IMP" -"GO:1903518","positive regulation of single strand break repair" -"GO:0071356","cellular response to tumor necrosis factor" -"GO:0009612","response to mechanical stimulus" -"GO:1902362","melanocyte apoptotic process" -"GO:2000475","negative regulation of opioid receptor signaling pathway" -"GO:0031400","negative regulation of protein modification process" -"GO:0080154","regulation of fertilization" -"GO:0050706","regulation of interleukin-1 beta secretion" -"GO:0044346","fibroblast apoptotic process" -"GO:1902685","positive regulation of receptor localization to synapse" -"GO:1905033","positive regulation of membrane repolarization during cardiac muscle cell action potential" -"GO:0035423","inactivation of MAPK activity involved in innate immune response" -"GO:2000731","negative regulation of termination of RNA polymerase I transcription" -"GO:0035611","protein branching point deglutamylation" -"GO:0042997","negative regulation of Golgi to plasma membrane protein transport" -"GO:0003327","type B pancreatic cell fate commitment" -"GO:0061445","endocardial cushion cell fate commitment" -"GO:1905745","negative regulation of mRNA cis splicing, via spliceosome" -"GO:0003108","negative regulation of the force of heart contraction by chemical signal" -"GO:1902742","apoptotic process involved in development" -"GO:0001911","negative regulation of leukocyte mediated cytotoxicity" -"GO:1902489","hepatoblast apoptotic process" -"GO:0060850","regulation of transcription involved in cell fate commitment" -"GO:1901671","positive regulation of superoxide dismutase activity" -"GO:0035592","establishment of protein localization to extracellular region" -"GO:0014850","response to muscle activity" -"GO:1900040","regulation of interleukin-2 secretion" -"GO:0071473","cellular response to cation stress" -"GO:2000157","negative regulation of ubiquitin-specific protease activity" -"GO:0035608","protein deglutamylation" -"GO:0032972","regulation of muscle filament sliding speed" -"GO:2000126","negative regulation of octopamine or tyramine signaling pathway" -"GO:1990523","bone regeneration" -"GO:0018095","protein polyglutamylation" -"GO:1903181","positive regulation of dopamine biosynthetic process" -"GO:0009644","response to high light intensity" -"GO:1901000","regulation of response to salt stress" -"GO:0071839","apoptotic process in bone marrow" -"GO:0010325","raffinose family oligosaccharide biosynthetic process" -"GO:1900078","positive regulation of cellular response to insulin stimulus" -"GO:0007420","brain development" -"GO:0035926","chemokine (C-C motif) ligand 2 secretion" -"GO:0001666","response to hypoxia" -"GO:0019342","trypanothione biosynthetic process" -"GO:1900257","negative regulation of beta1-adrenergic receptor activity" -"GO:0036528","peptidyl-lysine deglycation" -"GO:0009864","induced systemic resistance, jasmonic acid mediated signaling pathway" -"GO:0033008","positive regulation of mast cell activation involved in immune response" -"GO:0001929","negative regulation of exocyst assembly" -"GO:0001548","follicular fluid formation in ovarian follicle antrum" -"GO:0009232","riboflavin catabolic process" -"GO:0014815","initiation of skeletal muscle satellite cell activation by growth factor signaling, involved in skeletal muscle regeneration" -"GO:0046060","dATP metabolic process" -"GO:0060633","negative regulation of transcription initiation from RNA polymerase II promoter" -"GO:0003387","neuron differentiation involved in amphid sensory organ development" -"GO:0030826","regulation of cGMP biosynthetic process" -"GO:0000448","cleavage in ITS2 between 5.8S rRNA and LSU-rRNA of tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:0071641","negative regulation of macrophage inflammatory protein 1 alpha production" -"GO:0003408","optic cup formation involved in camera-type eye development" -"GO:0070778","L-aspartate transmembrane transport" -"GO:0036518","chemorepulsion of dopaminergic neuron axon" -"GO:0032822","positive regulation of natural killer cell proliferation involved in immune response" -"GO:1903873","negative regulation of DNA recombinase mediator complex assembly" -"GO:1904980","positive regulation of endosome organization" -"GO:1905865","negative regulation of Atg1/ULK1 kinase complex assembly" -"GO:1905101","negative regulation of apoptosome assembly" -"GO:0048214","regulation of Golgi vesicle fusion to target membrane" -"GO:0048780","positive regulation of erythrophore differentiation" -"GO:1903414","iron cation export" -"GO:1903712","cysteine transmembrane transport" -"GO:0021977","tectospinal tract morphogenesis" -"GO:0080053","response to phenylalanine" -"GO:1903482","positive regulation of actin filament organization involved in mitotic actomyosin contractile ring assembly" -"GO:1901786","p-cresol biosynthetic process" -"GO:1990983","tRNA demethylation" -"GO:0001326","replication of extrachromosomal circular DNA" -"GO:0034080","CENP-A containing nucleosome assembly" -"GO:0043490","malate-aspartate shuttle" -"GO:0021883","cell cycle arrest of committed forebrain neuronal progenitor cell" -"GO:0040001","establishment of mitotic spindle localization" -"GO:0035471","luteinizing hormone signaling pathway involved in ovarian follicle development" -"GO:1902935","protein localization to septin ring" -"GO:1903728","luteal cell differentiation" -"GO:1904187","regulation of transformation of host cell by virus" -"GO:0098530","positive regulation of strand invasion" -"GO:0099068","postsynapse assembly" -"GO:0032828","positive regulation of natural killer cell differentiation involved in immune response" -"GO:1905374","response to homocysteine" -"GO:0099054","presynapse assembly" -"GO:0070245","positive regulation of thymocyte apoptotic process" -"GO:0050931","pigment cell differentiation" -"GO:0016191","synaptic vesicle uncoating" -"GO:1903413","cellular response to bile acid" -"GO:0007100","mitotic centrosome separation" -"GO:0045744","negative regulation of G-protein coupled receptor protein signaling pathway" -"GO:0048341","paraxial mesoderm formation" -"GO:1904705","regulation of vascular smooth muscle cell proliferation" -"GO:2000160","negative regulation of planar cell polarity pathway involved in heart morphogenesis" -"GO:0033632","regulation of cell-cell adhesion mediated by integrin" -"GO:0051913","regulation of synaptic plasticity by chemical substance" -"GO:0043647","inositol phosphate metabolic process" -"GO:1905444","negative regulation of clathrin coat assembly" -"GO:1903985","regulation of intestinal D-glucose absorption" -"GO:0030634","carbon fixation by acetyl-CoA pathway" -"GO:0022009","central nervous system vasculogenesis" -"GO:0140058","neuron projection arborization" -"GO:0031661","negative regulation of cyclin-dependent protein serine/threonine kinase activity involved in G2/M transition of mitotic cell cycle" -"GO:0000471","endonucleolytic cleavage in 3'-ETS of tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:0001551","ovarian follicle endowment" -"GO:0097341","zymogen inhibition" -"GO:0055096","low-density lipoprotein particle mediated signaling" -"GO:2000618","regulation of histone H4-K16 acetylation" -"GO:0032270","positive regulation of cellular protein metabolic process" -"GO:0000474","maturation of SSU-rRNA from tetracistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, 2S rRNA, LSU-rRNA)" -"GO:0033314","mitotic DNA replication checkpoint" -"GO:0038124","toll-like receptor TLR6:TLR2 signaling pathway" -"GO:0060369","positive regulation of Fc receptor mediated stimulatory signaling pathway" -"GO:0015682","ferric iron transport" -"GO:0061363","negative regulation of progesterone biosynthesis involved in luteolysis" -"GO:0051174","regulation of phosphorus metabolic process" -"GO:0070106","interleukin-27-mediated signaling pathway" -"GO:0061475","cytosolic valyl-tRNA aminoacylation" -"GO:0071317","cellular response to isoquinoline alkaloid" -"GO:2000357","negative regulation of kidney smooth muscle cell differentiation" -"GO:0001125","transcription termination from bacterial-type RNA polymerase promoter" -"GO:0018906","methyl tert-butyl ether metabolic process" -"GO:0071366","cellular response to indolebutyric acid stimulus" -"GO:2001025","positive regulation of response to drug" -"GO:0032647","regulation of interferon-alpha production" -"GO:0018889","2-chloro-N-isopropylacetanilide metabolic process" -"GO:1901991","negative regulation of mitotic cell cycle phase transition" -"GO:0010642","negative regulation of platelet-derived growth factor receptor signaling pathway" -"GO:0016032","viral process" -"GO:0060916","mesenchymal cell proliferation involved in lung development" -"GO:0031647","regulation of protein stability" -"GO:1904387","cellular response to L-phenylalanine derivative" -"GO:1904015","cellular response to serotonin" -"GO:0016138","glycoside biosynthetic process" -"GO:2000795","negative regulation of epithelial cell proliferation involved in lung morphogenesis" -"GO:0060219","camera-type eye photoreceptor cell differentiation" -"GO:0060664","epithelial cell proliferation involved in salivary gland morphogenesis" -"GO:0010259","multicellular organism aging" -"GO:0043161","proteasome-mediated ubiquitin-dependent protein catabolic process" -"GO:0032919","spermine acetylation" -"GO:0006228","UTP biosynthetic process" -"GO:0007413","axonal fasciculation" -"GO:0042341","cyanogenic glycoside metabolic process" -"GO:2000900","cyclodextrin metabolic process" -"GO:0000741","karyogamy" -"GO:0072740","cellular response to anisomycin" -"GO:0018934","nitrilotriacetate metabolic process" -"GO:0021978","telencephalon regionalization" -"GO:0038171","cannabinoid signaling pathway" -"GO:0002337","B-1a B cell differentiation" -"GO:0038155","interleukin-23-mediated signaling pathway" -"GO:0048807","female genitalia morphogenesis" -"GO:0018945","organosilicon metabolic process" -"GO:0045852","pH elevation" -"GO:0034635","glutathione transport" -"GO:0071285","cellular response to lithium ion" -"GO:0030423","targeting of mRNA for destruction involved in RNA interference" -"GO:0045208","MAPK phosphatase export from nucleus" -"GO:1904069","ascaroside metabolic process" -"GO:0010272","response to silver ion" -"GO:0044205","'de novo' UMP biosynthetic process" -"GO:0106042","negative regulation of GABA-A receptor activity" -"GO:0038083","peptidyl-tyrosine autophosphorylation" -"GO:0002517","T cell tolerance induction" -"GO:0071475","cellular hyperosmotic salinity response" -"GO:0035709","memory T cell activation" -"GO:0051040","regulation of calcium-independent cell-cell adhesion" -"GO:0031622","positive regulation of fever generation" -"GO:0060946","cardiac blood vessel endothelial cell differentiation" -"GO:1900746","regulation of vascular endothelial growth factor signaling pathway" -"GO:2000408","negative regulation of T cell extravasation" -"GO:1990349","gap junction-mediated intercellular transport" -"GO:0032275","luteinizing hormone secretion" -"GO:1904310","cellular response to cordycepin" -"GO:0051626","regulation of epinephrine uptake" -"GO:0070293","renal absorption" -"GO:0090154","positive regulation of sphingolipid biosynthetic process" -"GO:0018968","tetrahydrofuran metabolic process" -"GO:0032480","negative regulation of type I interferon production" -"GO:0072752","cellular response to rapamycin" -"GO:0044791","positive regulation by host of viral release from host cell" -"GO:0046289","isoflavonoid phytoalexin metabolic process" -"GO:1904957","negative regulation of midbrain dopaminergic neuron differentiation" -"GO:0000024","maltose biosynthetic process" -"GO:0086069","bundle of His cell to Purkinje myocyte communication" -"GO:0009992","cellular water homeostasis" -"GO:0071895","odontoblast differentiation" -"GO:0060603","mammary gland duct morphogenesis" -"GO:0071955","recycling endosome to Golgi transport" -"GO:1905553","regulation of blood vessel branching" -"GO:0106035","protein maturation by [4Fe-4S] cluster transfer" -"GO:0000711","meiotic DNA repair synthesis" -"GO:0010636","positive regulation of mitochondrial fusion" -"GO:0071929","alpha-tubulin acetylation" -"GO:0031914","negative regulation of synaptic plasticity" -"GO:0097421","liver regeneration" -"GO:0035624","receptor transactivation" -"GO:0072105","ureteric peristalsis" -"GO:0050668","positive regulation of homocysteine metabolic process" -"GO:0007056","spindle assembly involved in female meiosis" -"GO:0035108","limb morphogenesis" -"GO:0006846","acetate transport" -"GO:1904952","hydroxycinnamic acid transport" -"GO:0090314","positive regulation of protein targeting to membrane" -"GO:0020027","hemoglobin metabolic process" -"GO:1905011","transmembrane phosphate ion transport from cytosol to vacuole" -"GO:0061824","cytosolic ciliogenesis" -"GO:2000041","negative regulation of planar cell polarity pathway involved in axis elongation" -"GO:0051470","ectoine transport" -"GO:0051890","regulation of cardioblast differentiation" -"GO:2000273","positive regulation of signaling receptor activity" -"GO:2001020","regulation of response to DNA damage stimulus" -"GO:0045963","negative regulation of dopamine metabolic process" -"GO:0060074","synapse maturation" -"GO:0060409","positive regulation of acetylcholine metabolic process" -"GO:1901582","positive regulation of telomeric RNA transcription from RNA pol II promoter" -"GO:0039639","suppression by virus of host cell lysis in response to superinfection" -"GO:2000648","positive regulation of stem cell proliferation" -"GO:0000821","regulation of arginine metabolic process" -"GO:0046040","IMP metabolic process" -"GO:0002787","negative regulation of antibacterial peptide production" -"GO:0140115","export across plasma membrane" -"GO:2001040","positive regulation of cellular response to drug" -"GO:0043281","regulation of cysteine-type endopeptidase activity involved in apoptotic process" -"GO:0071679","commissural neuron axon guidance" -"GO:0048662","negative regulation of smooth muscle cell proliferation" -"GO:1904257","zinc ion import across Golgi membrane" -"GO:0014719","skeletal muscle satellite cell activation" -"GO:0010157","response to chlorate" -"GO:0042724","thiamine-containing compound biosynthetic process" -"GO:0061688","glycolytic process via Entner-Doudoroff Pathway" -"GO:0007509","mesoderm migration involved in gastrulation" -"GO:0001963","synaptic transmission, dopaminergic" -"GO:2001142","nicotinate transport" -"GO:0051874","sphinganine-1-phosphate catabolic process" -"GO:0046131","pyrimidine ribonucleoside metabolic process" -"GO:0072375","medium-term memory" -"GO:1904739","regulation of synapse organization by posttranscriptional regulation of gene expression" -"GO:1904877","positive regulation of DNA ligase activity" -"GO:0006178","guanine salvage" -"GO:0090242","retinoic acid receptor signaling pathway involved in somitogenesis" -"GO:1905404","positive regulation of activated CD8-positive, alpha-beta T cell apoptotic process" -"GO:0042919","benzoate transport" -"GO:0031580","membrane raft distribution" -"GO:0014006","regulation of microglia differentiation" -"GO:0008210","estrogen metabolic process" -"GO:0042920","3-hydroxyphenylpropionic acid transport" -"GO:0035128","post-embryonic forelimb morphogenesis" -"GO:0045107","intermediate filament polymerization" -"GO:0014841","skeletal muscle satellite cell proliferation" -"GO:1900866","glycolate transport" -"GO:0014727","positive regulation of extraocular skeletal muscle development" -"GO:0018126","protein hydroxylation" -"GO:0045761","regulation of adenylate cyclase activity" -"GO:0048265","response to pain" -"GO:0060647","mesenchymal cell condensation involved in mammary fat development" -"GO:0045781","negative regulation of cell budding" -"GO:0043652","engulfment of apoptotic cell" -"GO:1990822","basic amino acid transmembrane transport" -"GO:0045349","interferon-alpha biosynthetic process" -"GO:0044525","peptidyl-cystine sulfhydration" -"GO:0003432","cell growth involved in growth plate cartilage chondrocyte morphogenesis" -"GO:1903614","negative regulation of protein tyrosine phosphatase activity" -"GO:0008277","regulation of G-protein coupled receptor protein signaling pathway" -"GO:1901874","negative regulation of post-translational protein modification" -"GO:0030581","symbiont intracellular protein transport in host" -"GO:0006780","uroporphyrinogen III biosynthetic process" -"GO:0072052","juxtaglomerulus cell differentiation" -"GO:1902594","multi-organism nuclear import" -"GO:0038003","opioid receptor signaling pathway" -"GO:0021692","cerebellar Purkinje cell layer morphogenesis" -"GO:0016036","cellular response to phosphate starvation" -"GO:0046038","GMP catabolic process" -"GO:0019645","anaerobic electron transport chain" -"GO:0050859","negative regulation of B cell receptor signaling pathway" -"GO:0048641","regulation of skeletal muscle tissue development" -"GO:0071418","cellular response to amine stimulus" -"GO:0036010","protein localization to endosome" -"GO:0071318","cellular response to ATP" -"GO:1900496","positive regulation of butyryl-CoA biosynthetic process from acetyl-CoA" -"GO:0015724","formate transport" -"GO:0044064","modulation by symbiont of host respiratory system process" -"GO:0032533","regulation of follicle cell microvillus length" -"GO:0045924","regulation of female receptivity" -"GO:0042488","positive regulation of odontogenesis of dentin-containing tooth" -"GO:0032526","response to retinoic acid" -"GO:0016569","covalent chromatin modification" -"GO:0006677","glycosylceramide metabolic process" -"GO:0043923","positive regulation by host of viral transcription" -"GO:0046100","hypoxanthine metabolic process" -"GO:0010947","negative regulation of meiotic joint molecule formation" -"GO:0010571","positive regulation of nuclear cell cycle DNA replication" -"GO:0034109","homotypic cell-cell adhesion" -"GO:0044865","negative regulation by virus of host cell division" -"GO:0043979","histone H2B-K5 acetylation" -"GO:0043482","cellular pigment accumulation" -"GO:1902412","regulation of mitotic cytokinesis" -"GO:0110015","positive regulation of elastin catabolic process" -"GO:1904908","negative regulation of maintenance of mitotic sister chromatid cohesion, telomeric" -"GO:1902093","positive regulation of flagellated sperm motility" -"GO:0072574","hepatocyte proliferation" -"GO:1904074","negative regulation of trophectodermal cell proliferation" -"GO:0072298","regulation of metanephric glomerulus development" -"GO:1901787","benzoyl-CoA metabolic process" -"GO:0006117","acetaldehyde metabolic process" -"GO:0045606","positive regulation of epidermal cell differentiation" -"GO:0060353","regulation of cell adhesion molecule production" -"GO:0051966","regulation of synaptic transmission, glutamatergic" -"GO:0051147","regulation of muscle cell differentiation" -"GO:0033504","floor plate development" -"GO:0045739","positive regulation of DNA repair" -"GO:0018400","peptidyl-proline hydroxylation to 3-hydroxy-L-proline" -"GO:0042479","positive regulation of eye photoreceptor cell development" -"GO:0035814","negative regulation of renal sodium excretion" -"GO:2000421","positive regulation of eosinophil extravasation" -"GO:2001042","negative regulation of cell separation after cytokinesis" -"GO:1905183","negative regulation of protein serine/threonine phosphatase activity" -"GO:0007212","dopamine receptor signaling pathway" -"GO:0006697","ecdysone biosynthetic process" -"GO:0048690","regulation of axon extension involved in regeneration" -"GO:0039674","exit of virus from host cell nucleus" -"GO:0006865","amino acid transport" -"GO:0048342","paraxial mesodermal cell differentiation" -"GO:0042873","aldonate transmembrane transport" -"GO:0010773","meiotic DNA recombinase assembly involved in meiotic gene conversion" -"GO:1905642","negative regulation of DNA methylation" -"GO:0034341","response to interferon-gamma" -"GO:0043654","recognition of apoptotic cell" -"GO:0002665","negative regulation of T cell tolerance induction" -"GO:0006288","base-excision repair, DNA ligation" -"GO:0042420","dopamine catabolic process" -"GO:1905264","blasticidin S metabolic process" -"GO:0097380","dorsal spinal cord interneuron anterior axon guidance" -"GO:0071594","thymocyte aggregation" -"GO:1903111","negative regulation of single-strand break repair via homologous recombination" -"GO:1900338","positive regulation of methane biosynthetic process from carbon monoxide" -"GO:0045350","interferon-beta biosynthetic process" -"GO:0045879","negative regulation of smoothened signaling pathway" -"GO:0009988","cell-cell recognition" -"GO:0000451","rRNA 2'-O-methylation" -"GO:0099008","viral entry via permeabilization of inner membrane" -"GO:1990558","mitochondrial malonate(1-) transmembrane transport" -"GO:1902796","regulation of snoRNA processing" -"GO:0003007","heart morphogenesis" -"GO:0097009","energy homeostasis" -"GO:0002635","negative regulation of germinal center formation" -"GO:0086066","atrial cardiac muscle cell to AV node cell communication" -"GO:0002897","positive regulation of central B cell tolerance induction" -"GO:0032218","riboflavin transport" -"GO:1901248","positive regulation of lung ciliated cell differentiation" -"GO:0032624","interleukin-20 production" -"GO:1903393","positive regulation of adherens junction organization" -"GO:0006874","cellular calcium ion homeostasis" -"GO:0097117","guanylate kinase-associated protein clustering" -"GO:0097043","histone H3-K56 acetylation" -"GO:0032042","mitochondrial DNA metabolic process" -"GO:0043572","plastid fission" -"GO:0034435","cholesterol esterification" -"GO:0060723","regulation of cell proliferation involved in embryonic placenta development" -"GO:0034162","toll-like receptor 9 signaling pathway" -"GO:0050675","regulation of urothelial cell proliferation" -"GO:0098706","ferric iron import across plasma membrane" -"GO:0031581","hemidesmosome assembly" -"GO:1904259","regulation of basement membrane assembly involved in embryonic body morphogenesis" -"GO:0099083","retrograde trans-synaptic signaling by neuropeptide, modulating synaptic transmission" -"GO:0032527","protein exit from endoplasmic reticulum" -"GO:0014827","intestine smooth muscle contraction" -"GO:0039650","suppression by virus of host cysteine-type endopeptidase activity involved in apoptotic process" -"GO:2000860","positive regulation of aldosterone secretion" -"GO:0003388","neuron development involved in amphid sensory organ development" -"GO:0051222","positive regulation of protein transport" -"GO:0014061","regulation of norepinephrine secretion" -"GO:0051587","inhibition of dopamine uptake involved in synaptic transmission" -"GO:0060735","regulation of eIF2 alpha phosphorylation by dsRNA" -"GO:0051835","positive regulation of synapse structural plasticity" -"GO:1905483","regulation of motor neuron migration" -"GO:1902175","regulation of oxidative stress-induced intrinsic apoptotic signaling pathway" -"GO:0035279","mRNA cleavage involved in gene silencing by miRNA" -"GO:0019465","aspartate transamidation" -"GO:0030819","positive regulation of cAMP biosynthetic process" -"GO:0046657","folic acid catabolic process" -"GO:0150024","oxidised low-density lipoprotein particle clearance" -"GO:2001206","positive regulation of osteoclast development" -"GO:0072663","establishment of protein localization to peroxisome" -"GO:0061925","negative regulation of formation of radial glial scaffolds" -"GO:0060690","epithelial cell differentiation involved in salivary gland development" -"GO:0042758","long-chain fatty acid catabolic process" -"GO:0032638","interleukin-9 production" -"GO:2000478","positive regulation of metanephric glomerular visceral epithelial cell development" -"GO:1990408","calcitonin gene-related peptide receptor signaling pathway" -"GO:0060681","branch elongation involved in ureteric bud branching" -"GO:1902762","regulation of embryonic skeletal joint development" -"GO:0045794","negative regulation of cell volume" -"GO:1900451","positive regulation of glutamate receptor signaling pathway" -"GO:0035502","metanephric part of ureteric bud development" -"GO:0070120","ciliary neurotrophic factor-mediated signaling pathway" -"GO:1904551","cellular response to arachidonic acid" -"GO:0019286","glycine betaine biosynthetic process from glycine" -"GO:0044375","regulation of peroxisome size" -"GO:2001157","negative regulation of proline catabolic process to glutamate" -"GO:1902863","regulation of embryonic camera-type eye development" -"GO:0021950","chemorepulsion involved in precerebellar neuron migration" -"GO:0071422","succinate transmembrane transport" -"GO:1903077","negative regulation of protein localization to plasma membrane" -"GO:0070444","oligodendrocyte progenitor proliferation" -"GO:0002240","response to molecule of oomycetes origin" -"GO:0002826","negative regulation of T-helper 1 type immune response" -"GO:0072637","interleukin-32 production" -"GO:0071706","tumor necrosis factor superfamily cytokine production" -"GO:0090178","regulation of establishment of planar polarity involved in neural tube closure" -"GO:0072106","regulation of ureteric bud formation" -"GO:0045832","positive regulation of light-activated channel activity" -"GO:0045992","negative regulation of embryonic development" -"GO:0070124","mitochondrial translational initiation" -"GO:0048079","regulation of cuticle pigmentation" -"GO:2000635","negative regulation of primary miRNA processing" -"GO:0098991","kainate selective glutamate receptor signaling pathway" -"GO:0006644","phospholipid metabolic process" -"GO:0044808","Oncostatin M production" -"GO:0035815","positive regulation of renal sodium excretion" -"GO:0006230","TMP biosynthetic process" -"GO:0022034","rhombomere cell proliferation" -"GO:0019518","L-threonine catabolic process to glycine" -"GO:0015919","peroxisomal membrane transport" -"GO:0021534","cell proliferation in hindbrain" -"GO:0051801","cytolysis in other organism involved in symbiotic interaction" -"GO:1904969","slow muscle cell migration" -"GO:0010638","positive regulation of organelle organization" -"GO:0097113","AMPA glutamate receptor clustering" -"GO:0019800","peptide cross-linking via chondroitin 4-sulfate glycosaminoglycan" -"GO:0034381","plasma lipoprotein particle clearance" -"GO:0055072","iron ion homeostasis" -"GO:0033034","positive regulation of myeloid cell apoptotic process" -"GO:0015677","copper ion import" -"GO:0098953","receptor diffusion trapping" -"GO:0072411","signal transduction involved in meiotic cell cycle checkpoint" -"GO:0070831","basement membrane assembly" -"GO:0006621","protein retention in ER lumen" -"GO:0002481","antigen processing and presentation of exogenous protein antigen via MHC class Ib, TAP-dependent" -"GO:0022617","extracellular matrix disassembly" -"GO:1904384","cellular response to sodium phosphate" -"GO:2000165","regulation of planar cell polarity pathway involved in pericardium morphogenesis" -"GO:0060100","positive regulation of phagocytosis, engulfment" -"GO:0090086","negative regulation of protein deubiquitination" -"GO:0036301","macrophage colony-stimulating factor production" -"GO:0060932","His-Purkinje system cell differentiation" -"GO:0007184","SMAD protein import into nucleus" -"GO:1904921","negative regulation of MAPK cascade involved in axon regeneration" -"GO:1903300","negative regulation of hexokinase activity" -"GO:0106071","positive regulation of adenylate cyclase-activating G-protein coupled receptor signaling pathway" -"GO:0014855","striated muscle cell proliferation" -"GO:1905819","negative regulation of chromosome separation" -"GO:0032601","connective tissue growth factor production" -"GO:1900335","positive regulation of methane biosynthetic process from 3-(methylthio)propionic acid" -"GO:0030335","positive regulation of cell migration" -"GO:0021514","ventral spinal cord interneuron differentiation" -"GO:1904340","positive regulation of dopaminergic neuron differentiation" -"GO:0033572","transferrin transport" -"GO:0050823","peptide antigen stabilization" -"GO:0034475","U4 snRNA 3'-end processing" -"GO:0048243","norepinephrine secretion" -"GO:0046380","N-acetylneuraminate biosynthetic process" -"GO:0070753","interleukin-35 production" -"GO:0097114","NMDA glutamate receptor clustering" -"GO:0002531","regulation of heart contraction involved in acute-phase response" -"GO:0046636","negative regulation of alpha-beta T cell activation" -"GO:1901021","positive regulation of calcium ion transmembrane transporter activity" -"GO:0035710","CD4-positive, alpha-beta T cell activation" -"GO:0045938","positive regulation of circadian sleep/wake cycle, sleep" -"GO:1903051","negative regulation of proteolysis involved in cellular protein catabolic process" -"GO:0014843","growth factor dependent regulation of skeletal muscle satellite cell proliferation" -"GO:0030203","glycosaminoglycan metabolic process" -"GO:0002777","antimicrobial peptide biosynthetic process" -"GO:0040013","negative regulation of locomotion" -"GO:0009794","regulation of mitotic cell cycle, embryonic" -"GO:0006094","gluconeogenesis" -"GO:0072163","mesonephric epithelium development" -"GO:0035634","response to stilbenoid" -"GO:0021992","cell proliferation involved in neural plate elongation" -"GO:0034473","U1 snRNA 3'-end processing" -"GO:0046949","fatty-acyl-CoA biosynthetic process" -"GO:0015783","GDP-fucose transmembrane transport" -"GO:0006771","riboflavin metabolic process" -"GO:1900334","negative regulation of methane biosynthetic process from 3-(methylthio)propionic acid" -"GO:0042158","lipoprotein biosynthetic process" -"GO:0071596","ubiquitin-dependent protein catabolic process via the N-end rule pathway" -"GO:0071042","nuclear polyadenylation-dependent mRNA catabolic process" -"GO:0034476","U5 snRNA 3'-end processing" -"GO:0002508","central tolerance induction" -"GO:0034343","type III interferon production" -"GO:0002253","activation of immune response" -"GO:0034179","regulation of toll-like receptor 13 signaling pathway" -"GO:0071028","nuclear mRNA surveillance" -"GO:1900271","regulation of long-term synaptic potentiation" -"GO:0045637","regulation of myeloid cell differentiation" -"GO:0016075","rRNA catabolic process" -"GO:0048731","system development" -"GO:2000534","positive regulation of renal albumin absorption" -"GO:1900499","positive regulation of butyryl-CoA catabolic process to butanol" -"GO:1905132","regulation of meiotic chromosome separation" -"GO:0006173","dADP biosynthetic process" -"GO:0008052","sensory organ boundary specification" -"GO:0072635","interleukin-31 production" -"GO:2000290","regulation of myotome development" -"GO:0071726","cellular response to diacyl bacterial lipopeptide" -"GO:1903729","regulation of plasma membrane organization" -"GO:0000768","syncytium formation by plasma membrane fusion" -"GO:0036371","protein localization to T-tubule" -"GO:0035674","tricarboxylic acid transmembrane transport" -"GO:0009306","protein secretion" -"GO:1905820","positive regulation of chromosome separation" -"GO:0008345","larval locomotory behavior" -"GO:0106072","negative regulation of adenylate cyclase-activating G-protein coupled receptor signaling pathway" -"GO:0022904","respiratory electron transport chain" -"GO:0003100","regulation of systemic arterial blood pressure by endothelin" -"GO:1901207","regulation of heart looping" -"GO:0060190","negative regulation of protein desumoylation" -"GO:0061517","macrophage proliferation" -"GO:0007205","protein kinase C-activating G-protein coupled receptor signaling pathway" -"GO:0051693","actin filament capping" -"GO:0071313","cellular response to caffeine" -"GO:0001975","response to amphetamine" -"GO:0098664","G-protein coupled serotonin receptor signaling pathway" -"GO:0055020","positive regulation of cardiac muscle fiber development" -"GO:0090350","negative regulation of cellular organofluorine metabolic process" -"GO:0021875","fibroblast growth factor receptor signaling pathway involved in forebrain neuroblast division" -"GO:0032832","regulation of CD4-positive, CD25-positive, alpha-beta regulatory T cell differentiation involved in immune response" -"GO:0051344","negative regulation of cyclic-nucleotide phosphodiesterase activity" -"GO:0002475","antigen processing and presentation via MHC class Ib" -"GO:0031204","posttranslational protein targeting to membrane, translocation" -"GO:0006015","5-phosphoribose 1-diphosphate biosynthetic process" -"GO:0075713","establishment of integrated proviral latency" -"GO:0032831","positive regulation of CD4-positive, CD25-positive, alpha-beta regulatory T cell differentiation" -"GO:0051100","negative regulation of binding" -"GO:0002473","non-professional antigen presenting cell antigen processing and presentation" -"GO:0042391","regulation of membrane potential" -"GO:0034420","co-translational protein acetylation" -"GO:0002685","regulation of leukocyte migration" -"GO:0014883","transition between fast and slow fiber" -"GO:0050933","early stripe melanocyte differentiation" -"GO:0060041","retina development in camera-type eye" -"GO:2000577","regulation of ATP-dependent microtubule motor activity, minus-end-directed" -"GO:0002746","antigen processing and presentation following pinocytosis" -"GO:0010664","negative regulation of striated muscle cell apoptotic process" -"GO:0060762","regulation of branching involved in mammary gland duct morphogenesis" -"GO:0086013","membrane repolarization during cardiac muscle cell action potential" -"GO:0050689","negative regulation of defense response to virus by host" -"GO:0045339","farnesyl diphosphate catabolic process" -"GO:0002872","negative regulation of natural killer cell tolerance induction" -"GO:0045067","positive extrathymic T cell selection" -"GO:1903923","positive regulation of protein processing in phagocytic vesicle" -"GO:0006851","mitochondrial calcium ion transmembrane transport" -"GO:1901883","4-hydroxycoumarin catabolic process" -"GO:0061381","cell migration in diencephalon" -"GO:0035961","positive regulation of ergosterol biosynthetic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:0061767","negative regulation of lung blood pressure" -"GO:0070814","hydrogen sulfide biosynthetic process" -"GO:0086010","membrane depolarization during action potential" -"GO:0002873","positive regulation of natural killer cell tolerance induction" -"GO:0070189","kynurenine metabolic process" -"GO:0001961","positive regulation of cytokine-mediated signaling pathway" -"GO:0051343","positive regulation of cyclic-nucleotide phosphodiesterase activity" -"GO:0031444","slow-twitch skeletal muscle fiber contraction" -"GO:2000040","regulation of planar cell polarity pathway involved in axis elongation" -"GO:0044069","modulation by symbiont of host anion transport" -"GO:0021907","fibroblast growth factor receptor signaling pathway involved in spinal cord anterior/posterior pattern formation" -"GO:0035509","negative regulation of myosin-light-chain-phosphatase activity" -"GO:0033024","mast cell apoptotic process" -"GO:0036256","cellular response to methylamine" -"GO:1901964","positive regulation of cell proliferation involved in outflow tract morphogenesis" -"GO:0100012","regulation of heart induction by canonical Wnt signaling pathway" -"GO:0019101","female somatic sex determination" -"GO:1904898","negative regulation of hepatic stellate cell proliferation" -"GO:0048291","isotype switching to IgG isotypes" -"GO:0046549","retinal cone cell development" -"GO:1902684","negative regulation of receptor localization to synapse" -"GO:0080024","indolebutyric acid metabolic process" -"GO:0061047","positive regulation of branching involved in lung morphogenesis" -"GO:0072436","detection of stimulus involved in DNA replication checkpoint" -"GO:0099093","calcium export from the mitochondrion" -"GO:0003211","cardiac ventricle formation" -"GO:0002752","cell surface pattern recognition receptor signaling pathway" -"GO:0045774","negative regulation of beta 2 integrin biosynthetic process" -"GO:0046819","protein secretion by the type V secretion system" -"GO:0014811","negative regulation of skeletal muscle contraction by regulation of release of sequestered calcium ion" -"GO:0097304","lipoprotein biosynthetic process via signal peptide cleavage" -"GO:0007394","dorsal closure, elongation of leading edge cells" -"GO:0098915","membrane repolarization during ventricular cardiac muscle cell action potential" -"GO:1905096","positive regulation of apolipoprotein A-I-mediated signaling pathway" -"GO:0061337","cardiac conduction" -"GO:0072148","epithelial cell fate commitment" -"GO:0030174","regulation of DNA-dependent DNA replication initiation" -"GO:1902849","positive regulation of neuronal signal transduction" -"GO:2000609","regulation of thyroid hormone generation" -"GO:0010119","regulation of stomatal movement" -"GO:0002362","CD4-positive, CD25-positive, alpha-beta regulatory T cell lineage commitment" -"GO:0032506","cytokinetic process" -"GO:0060014","granulosa cell differentiation" -"GO:0000492","box C/D snoRNP assembly" -"GO:0086091","regulation of heart rate by cardiac conduction" -"GO:1902247","geranylgeranyl diphosphate catabolic process" -"GO:1905589","positive regulation of L-arginine import across plasma membrane" -"GO:0061015","snRNA import into nucleus" -"GO:0001555","oocyte growth" -"GO:1902521","response to etoposide" -"GO:0001819","positive regulation of cytokine production" -"GO:0051668","localization within membrane" -"GO:1905717","positive regulation of cornification" -"GO:0006020","inositol metabolic process" -"GO:0048803","imaginal disc-derived male genitalia morphogenesis" -"GO:0055075","potassium ion homeostasis" -"GO:0034775","glutathione transmembrane transport" -"GO:0070563","negative regulation of vitamin D receptor signaling pathway" -"GO:0086005","ventricular cardiac muscle cell action potential" -"GO:1902070","positive regulation of sphingolipid mediated signaling pathway" -"GO:0071299","cellular response to vitamin A" -"GO:0061049","cell growth involved in cardiac muscle cell development" -"GO:0021831","embryonic olfactory bulb interneuron precursor migration" -"GO:0051478","mannosylglycerate metabolic process" -"GO:2000007","negative regulation of metanephric comma-shaped body morphogenesis" -"GO:0002450","B cell antigen processing and presentation" -"GO:0051231","spindle elongation" -"GO:0002468","dendritic cell antigen processing and presentation" -"GO:0039702","viral budding via host ESCRT complex" -"GO:0051295","establishment of meiotic spindle localization" -"GO:0034484","raffinose catabolic process" -"GO:0002747","antigen processing and presentation following phagocytosis" -"GO:0003331","positive regulation of extracellular matrix constituent secretion" -"GO:0002311","gamma-delta T cell proliferation involved in immune response" -"GO:0019355","nicotinamide nucleotide biosynthetic process from aspartate" -"GO:1905010","positive regulation of L-lysine import across plasma membrane" -"GO:0090597","nematode male tail mating organ morphogenesis" -"GO:0048546","digestive tract morphogenesis" -"GO:0045752","positive regulation of Toll signaling pathway" -"GO:0010697","negative regulation of mitotic spindle pole body separation" -"GO:0072421","detection of DNA damage stimulus involved in DNA damage checkpoint" -"GO:0002016","regulation of blood volume by renin-angiotensin" -"GO:1901258","positive regulation of macrophage colony-stimulating factor production" -"GO:0007093","mitotic cell cycle checkpoint" -"GO:1903209","positive regulation of oxidative stress-induced cell death" -"GO:1905905","pharyngeal gland morphogenesis" -"GO:1902890","regulation of root hair elongation" -"GO:0021830","interneuron migration from the subpallium to the cortex" -"GO:0071869","response to catecholamine" -"GO:0003051","angiotensin-mediated drinking behavior" -"GO:0007357","positive regulation of central gap gene transcription" -"GO:0080038","positive regulation of cytokinin-activated signaling pathway" -"GO:0071296","cellular response to biotin" -"GO:0036258","multivesicular body assembly" -"GO:1903919","negative regulation of actin filament severing" -"GO:0031001","response to brefeldin A" -"GO:0000463","maturation of LSU-rRNA from tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:0038010","positive regulation of signal transduction by receptor internalization" -"GO:0001971","negative regulation of activation of membrane attack complex" -"GO:1904903","ESCRT III complex disassembly" -"GO:1901740","negative regulation of myoblast fusion" -"GO:0061008","hepaticobiliary system development" -"GO:0021860","pyramidal neuron development" -"GO:0030224","monocyte differentiation" -"GO:0051270","regulation of cellular component movement" -"GO:0045932","negative regulation of muscle contraction" -"GO:0045085","negative regulation of interleukin-2 biosynthetic process" -"GO:0015200","methylammonium transmembrane transporter activity" -"GO:0030583","myxococcal fruiting body development" -"GO:0048286","lung alveolus development" -"GO:0090184","positive regulation of kidney development" -"GO:0035082","axoneme assembly" -"GO:0007034","vacuolar transport" -"GO:0032796","uropod organization" -"GO:0035850","epithelial cell differentiation involved in kidney development" -"GO:0061099","negative regulation of protein tyrosine kinase activity" -"GO:1901403","positive regulation of tetrapyrrole metabolic process" -"GO:0019595","non-phosphorylated glucose catabolic process" -"GO:0051345","positive regulation of hydrolase activity" -"GO:0006333","chromatin assembly or disassembly" -"GO:0021961","posterior commissure morphogenesis" -"GO:0018159","peptidyl-methionine oxidation" -"GO:1901539","ent-pimara-8(14),15-diene metabolic process" -"GO:0002581","negative regulation of antigen processing and presentation of peptide or polysaccharide antigen via MHC class II" -"GO:0060667","branch elongation involved in salivary gland morphogenesis" -"GO:0072009","nephron epithelium development" -"GO:0009092","homoserine metabolic process" -"GO:0033306","phytol metabolic process" -"GO:0048550","negative regulation of pinocytosis" -"GO:0071365","cellular response to auxin stimulus" -"GO:0045056","transcytosis" -"GO:0015871","choline transport" -"GO:0018046","C-terminal peptidyl-methionine amidation" -"GO:0009788","negative regulation of abscisic acid-activated signaling pathway" -"GO:1904958","positive regulation of midbrain dopaminergic neuron differentiation" -"GO:0005267","potassium channel activity" -"GO:0120028","negative regulation of osmosensory signaling pathway" -"GO:0046473","phosphatidic acid metabolic process" -"GO:0039013","pronephric distal tubule morphogenesis" -"GO:0052307","modulation by organism of defense-related calcium-dependent protein kinase pathway in other organism involved in symbiotic interaction" -"GO:0051001","negative regulation of nitric-oxide synthase activity" -"GO:1901122","bacitracin A metabolic process" -"GO:0050820","positive regulation of coagulation" -"GO:1903598","positive regulation of gap junction assembly" -"GO:0001980","regulation of systemic arterial blood pressure by ischemic conditions" -"GO:0071390","cellular response to ecdysone" -"GO:0034391","regulation of smooth muscle cell apoptotic process" -"GO:0019368","fatty acid elongation, unsaturated fatty acid" -"GO:0070109","positive regulation of interleukin-27-mediated signaling pathway" -"GO:0039011","pronephric proximal tubule morphogenesis" -"GO:0060643","epithelial cell differentiation involved in mammary gland bud morphogenesis" -"GO:0060834","oral/aboral axis specification" -"GO:0048608","reproductive structure development" -"GO:0002663","positive regulation of B cell tolerance induction" -"GO:0086001","cardiac muscle cell action potential" -"GO:0072071","kidney interstitial fibroblast differentiation" -"GO:0072195","kidney smooth muscle cell differentiation" -"GO:0006084","acetyl-CoA metabolic process" -"GO:0071032","nuclear mRNA surveillance of mRNP export" -"GO:0007501","mesodermal cell fate specification" -"GO:0060601","lateral sprouting from an epithelium" -"GO:1905424","regulation of Wnt-mediated midbrain dopaminergic neuron differentiation" -"GO:1901038","cyanidin 3-O-glucoside metabolic process" -"GO:0071446","cellular response to salicylic acid stimulus" -"GO:0002064","epithelial cell development" -"GO:0030326","embryonic limb morphogenesis" -"GO:0045404","positive regulation of interleukin-4 biosynthetic process" -"GO:1905236","cellular response to quercetin" -"GO:0021960","anterior commissure morphogenesis" -"GO:1901099","negative regulation of signal transduction in absence of ligand" -"GO:0070811","glycerol-2-phosphate transmembrane transport" -"GO:0046337","phosphatidylethanolamine metabolic process" -"GO:0046246","terpene biosynthetic process" -"GO:0098705","copper ion import across plasma membrane" -"GO:0071367","cellular response to brassinosteroid stimulus" -"GO:2001022","positive regulation of response to DNA damage stimulus" -"GO:0072062","proximal convoluted tubule segment 1 cell differentiation" -"GO:0060386","synapse assembly involved in innervation" -"GO:0033227","dsRNA transport" -"GO:0072007","mesangial cell differentiation" -"GO:0060915","mesenchymal cell differentiation involved in lung development" -"GO:0042679","compound eye cone cell fate specification" -"GO:2001134","methane biosynthetic process from carbon monoxide" -"GO:0015883","FAD transport" -"GO:0071368","cellular response to cytokinin stimulus" -"GO:0010930","negative regulation of auxin mediated signaling pathway" -"GO:0060442","branching involved in prostate gland morphogenesis" -"GO:0032384","negative regulation of intracellular cholesterol transport" -"GO:0044275","cellular carbohydrate catabolic process" -"GO:1902348","cellular response to strigolactone" -"GO:0042128","nitrate assimilation" -"GO:0021826","substrate-independent telencephalic tangential migration" -"GO:0051407","glycerone phosphate:inorganic phosphate antiporter activity" -"GO:0045970","negative regulation of juvenile hormone catabolic process" -"GO:0043576","regulation of respiratory gaseous exchange" -"GO:0044572","[4Fe-4S] cluster assembly" -"GO:0001302","replicative cell aging" -"GO:0009603","detection of symbiotic fungus" -"GO:0071804","cellular potassium ion transport" -"GO:0015671","oxygen transport" -"GO:0097395","response to interleukin-32" -"GO:1990428","miRNA transport" -"GO:0032436","positive regulation of proteasomal ubiquitin-dependent protein catabolic process" -"GO:1905007","positive regulation of epithelial to mesenchymal transition involved in endocardial cushion formation" -"GO:0032204","regulation of telomere maintenance" -"GO:0051444","negative regulation of ubiquitin-protein transferase activity" -"GO:0039014","cell differentiation involved in pronephros development" -"GO:1900740","positive regulation of protein insertion into mitochondrial membrane involved in apoptotic signaling pathway" -"GO:1903609","negative regulation of inward rectifier potassium channel activity" -"GO:0051556","leucoanthocyanidin metabolic process" -"GO:2000271","positive regulation of fibroblast apoptotic process" -"GO:0010568","regulation of budding cell apical bud growth" -"GO:1900907","positive regulation of hexadecanal metabolic process" -"GO:0060272","embryonic skeletal joint morphogenesis" -"GO:0010720","positive regulation of cell development" -"GO:0016335","morphogenesis of larval imaginal disc epithelium" -"GO:0072184","renal vesicle progenitor cell differentiation" -"GO:1904447","folic acid import across plasma membrane" -"GO:0042595","behavioral response to starvation" -"GO:0043589","skin morphogenesis" -"GO:0044041","multi-organism carbohydrate catabolic process" -"GO:0039535","regulation of RIG-I signaling pathway" -"GO:0042750","hibernation" -"GO:0006051","N-acetylmannosamine metabolic process" -"GO:0071806","protein transmembrane transport" -"GO:0009617","response to bacterium" -"GO:0072037","mesenchymal stem cell differentiation involved in nephron morphogenesis" -"GO:0050988","N-terminal peptidyl-methionine carboxylation" -"GO:0030827","negative regulation of cGMP biosynthetic process" -"GO:0070221","sulfide oxidation, using sulfide:quinone oxidoreductase" -"GO:1902168","response to catechin" -"GO:0045110","intermediate filament bundle assembly" -"GO:0055010","ventricular cardiac muscle tissue morphogenesis" -"GO:2000535","regulation of entry of bacterium into host cell" -"GO:0001568","blood vessel development" -"GO:1905627","regulation of serotonin biosynthetic process" -"GO:0060513","prostatic bud formation" -"GO:0032986","protein-DNA complex disassembly" -"GO:0006541","glutamine metabolic process" -"GO:0002392","platelet activating factor secretion" -"GO:0015813","L-glutamate transmembrane transport" -"GO:0018220","peptidyl-threonine palmitoylation" -"GO:1901888","regulation of cell junction assembly" -"GO:0060999","positive regulation of dendritic spine development" -"GO:0045994","positive regulation of translational initiation by iron" -"GO:1902809","regulation of skeletal muscle fiber differentiation" -"GO:0098542","defense response to other organism" -"GO:0001708","cell fate specification" -"GO:1902886","negative regulation of proteasome-activating ATPase activity" -"GO:1901944","miltiradiene metabolic process" -"GO:0015143","urate transmembrane transporter activity" -"GO:0019474","L-lysine catabolic process to acetyl-CoA" -"GO:0048280","vesicle fusion with Golgi apparatus" -"GO:0060355","positive regulation of cell adhesion molecule production" -"GO:0030167","proteoglycan catabolic process" -"GO:0061308","cardiac neural crest cell development involved in heart development" -"GO:0045622","regulation of T-helper cell differentiation" -"GO:0032071","regulation of endodeoxyribonuclease activity" -"GO:0061208","cell differentiation involved in mesonephros development" -"GO:0033688","regulation of osteoblast proliferation" -"GO:0033127","regulation of histone phosphorylation" -"GO:0043611","isoprene metabolic process" -"GO:1905145","cellular response to acetylcholine" -"GO:2001238","positive regulation of extrinsic apoptotic signaling pathway" -"GO:0016050","vesicle organization" -"GO:0000045","autophagosome assembly" -"GO:0090321","positive regulation of chylomicron remnant clearance" -"GO:0098829","intestinal folate absorption" -"GO:0003357","noradrenergic neuron differentiation" -"GO:0031571","mitotic G1 DNA damage checkpoint" -"GO:0010265","SCF complex assembly" -"GO:0001960","negative regulation of cytokine-mediated signaling pathway" -"GO:0031921","pyridoxal phosphate transport" -"GO:0007566","embryo implantation" -"GO:0090101","negative regulation of transmembrane receptor protein serine/threonine kinase signaling pathway" -"GO:0019579","aldaric acid catabolic process" -"GO:0042931","enterobactin transmembrane transporter activity" -"GO:0035408","histone H3-T6 phosphorylation" -"GO:2000324","positive regulation of glucocorticoid receptor signaling pathway" -"GO:0021870","Cajal-Retzius cell differentiation" -"GO:1990613","mitochondrial membrane fusion" -"GO:1903495","cellular response to dehydroepiandrosterone" -"GO:0060075","regulation of resting membrane potential" -"GO:0045617","negative regulation of keratinocyte differentiation" -"GO:0010142","farnesyl diphosphate biosynthetic process, mevalonate pathway" -"GO:0071236","cellular response to antibiotic" -"GO:0015228","coenzyme A transmembrane transporter activity" -"GO:0046283","anthocyanin-containing compound metabolic process" -"GO:0015786","UDP-glucose transmembrane transport" -"GO:0051150","regulation of smooth muscle cell differentiation" -"GO:1901103","gramicidin S biosynthetic process" -"GO:0009915","phloem sucrose loading" -"GO:2000488","positive regulation of brassinosteroid biosynthetic process" -"GO:0015347","sodium-independent organic anion transmembrane transporter activity" -"GO:0099010","modification of postsynaptic structure" -"GO:0001885","endothelial cell development" -"GO:2000286","receptor internalization involved in canonical Wnt signaling pathway" -"GO:2000441","negative regulation of toll-like receptor 15 signaling pathway" -"GO:0030193","regulation of blood coagulation" -"GO:0010506","regulation of autophagy" -"GO:0021904","dorsal/ventral neural tube patterning" -"GO:0018014","N-terminal peptidyl-methionine methylation" -"GO:0021975","pons reticulospinal tract morphogenesis" -"GO:0099100","G-protein gated cation channel activity" -"GO:0021976","medulla reticulospinal tract morphogenesis" -"GO:0005464","UDP-xylose transmembrane transporter activity" -"GO:0071503","response to heparin" -"GO:0034634","glutathione transmembrane transporter activity" -"GO:0006658","phosphatidylserine metabolic process" -"GO:1904260","negative regulation of basement membrane assembly involved in embryonic body morphogenesis" -"GO:1901147","mesenchymal cell apoptotic process involved in metanephric nephron morphogenesis" -"GO:1904011","cellular response to Aroclor 1254" -"GO:0017038","protein import" -"GO:0038056","negative regulation of BMP signaling pathway by negative regulation of BMP secretion" -"GO:0010882","regulation of cardiac muscle contraction by calcium ion signaling" -"GO:1905400","negative regulation of activated CD4-positive, alpha-beta T cell apoptotic process" -"GO:0010934","macrophage cytokine production" -"GO:0010034","response to acetate" -"GO:1903319","positive regulation of protein maturation" -"GO:0045920","negative regulation of exocytosis" -"GO:0005460","UDP-glucose transmembrane transporter activity" -"GO:1900895","positive regulation of tridecane metabolic process" -"GO:0060400","negative regulation of growth hormone receptor signaling pathway" -"GO:1903071","positive regulation of ER-associated ubiquitin-dependent protein catabolic process" -"GO:1905923","positive regulation of acetylcholine biosynthetic process" -"GO:0060529","squamous basal epithelial stem cell differentiation involved in prostate gland acinus development" -"GO:0060047","heart contraction" -"GO:1903823","telomere single strand break repair" -"GO:1901853","5,6,7,8-tetrahydrosarcinapterin metabolic process" -"GO:0021959","cuneatus tract morphogenesis" -"GO:0060213","positive regulation of nuclear-transcribed mRNA poly(A) tail shortening" -"GO:0016119","carotene metabolic process" -"GO:0052004","negative regulation by symbiont of host salicylic acid-mediated defense response" -"GO:0070884","regulation of calcineurin-NFAT signaling cascade" -"GO:0002680","pro-T cell lineage commitment" -"GO:0097484","dendrite extension" -"GO:0002260","lymphocyte homeostasis" -"GO:0007282","cystoblast division" -"GO:0050758","regulation of thymidylate synthase biosynthetic process" -"GO:1903620","positive regulation of transdifferentiation" -"GO:1990697","protein depalmitoleylation" -"GO:0051571","positive regulation of histone H3-K4 methylation" -"GO:0036515","serotonergic neuron axon guidance" -"GO:0021784","postganglionic parasympathetic fiber development" -"GO:0070807","positive regulation of phialide development" -"GO:0010070","zygote asymmetric cell division" -"GO:0090557","establishment of endothelial intestinal barrier" -"GO:0035526","retrograde transport, plasma membrane to Golgi" -"GO:1900269","negative regulation of reverse transcription" -"GO:0007589","body fluid secretion" -"GO:0032626","interleukin-22 production" -"GO:0007517","muscle organ development" -"GO:1903446","geraniol metabolic process" -"GO:0042160","lipoprotein modification" -"GO:0008519","ammonium transmembrane transporter activity" -"GO:0008344","adult locomotory behavior" -"GO:0015186","L-glutamine transmembrane transporter activity" -"GO:0098661","inorganic anion transmembrane transport" -"GO:1900187","regulation of cell adhesion involved in single-species biofilm formation" -"GO:1901244","positive regulation of transcription from RNA polymerase II promoter involved in defense response to fungus" -"GO:0021541","ammon gyrus development" -"GO:0007613","memory" -"GO:0045035","sensory organ precursor cell division" -"GO:0030432","peristalsis" -"GO:0043557","regulation of translation in response to osmotic stress" -"GO:0048105","establishment of body hair planar orientation" -"GO:0072618","interleukin-20 secretion" -"GO:1904884","positive regulation of telomerase catalytic core complex assembly" -"GO:0072611","interleukin-13 secretion" -"GO:0015196","L-tryptophan transmembrane transporter activity" -"GO:0060823","canonical Wnt signaling pathway involved in neural plate anterior/posterior pattern formation" -"GO:0043567","regulation of insulin-like growth factor receptor signaling pathway" -"GO:0015921","lipopolysaccharide export" -"GO:0001656","metanephros development" -"GO:0015327","cystine:glutamate antiporter activity" -"GO:0000436","carbon catabolite activation of transcription from RNA polymerase II promoter" -"GO:0021887","hypothalamus gonadotrophin-releasing hormone neuron fate commitment" -"GO:0060013","righting reflex" -"GO:0007531","mating type determination" -"GO:0032665","regulation of interleukin-21 production" -"GO:0048600","oocyte fate commitment" -"GO:0006493","protein O-linked glycosylation" -"GO:1904127","regulation of convergent extension involved in somitogenesis" -"GO:0060489","planar dichotomous subdivision of terminal units involved in lung branching morphogenesis" -"GO:0072638","interleukin-32 secretion" -"GO:0006279","premeiotic DNA replication" -"GO:0033492","esculetin metabolic process" -"GO:0110022","regulation of cardiac muscle myoblast proliferation" -"GO:0002876","positive regulation of chronic inflammatory response to antigenic stimulus" -"GO:0045597","positive regulation of cell differentiation" -"GO:0098939","dendritic transport of mitochondrion" -"GO:0061084","negative regulation of protein refolding" -"GO:1990868","response to chemokine" -"GO:0000165","MAPK cascade" -"GO:0060878","pouch outgrowth involved in semicircular canal formation" -"GO:1900724","positive regulation of protein adenylylation" -"GO:0006463","steroid hormone receptor complex assembly" -"GO:0090177","establishment of planar polarity involved in neural tube closure" -"GO:0021796","cerebral cortex regionalization" -"GO:0072153","renal interstitial fibroblast fate commitment" -"GO:0061392","regulation of transcription from RNA polymerase II promoter in response to osmotic stress" -"GO:0015918","sterol transport" -"GO:0072108","positive regulation of mesenchymal to epithelial transition involved in metanephros morphogenesis" -"GO:1905448","positive regulation of mitochondrial ATP synthesis coupled electron transport" -"GO:0061425","positive regulation of ethanol catabolic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:0048865","stem cell fate commitment" -"GO:0001755","neural crest cell migration" -"GO:0015187","glycine transmembrane transporter activity" -"GO:0072613","interleukin-15 secretion" -"GO:0033160","positive regulation of protein import into nucleus, translocation" -"GO:0021795","cerebral cortex cell migration" -"GO:2000969","positive regulation of AMPA receptor activity" -"GO:0032523","silicon efflux transmembrane transporter activity" -"GO:0072329","monocarboxylic acid catabolic process" -"GO:0048485","sympathetic nervous system development" -"GO:0072641","type I interferon secretion" -"GO:0098789","pre-mRNA cleavage required for polyadenylation" -"GO:0055109","invagination involved in gastrulation with mouth forming second" -"GO:0001923","B-1 B cell differentiation" -"GO:0009100","glycoprotein metabolic process" -"GO:0035070","salivary gland histolysis" -"GO:0001830","trophectodermal cell fate commitment" -"GO:0033603","positive regulation of dopamine secretion" -"GO:1900418","positive regulation of purine nucleotide biosynthetic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:0010226","response to lithium ion" -"GO:0044752","response to human chorionic gonadotropin" -"GO:0044831","modulation by virus of host cytokine production" -"GO:1990497","regulation of cytoplasmic translation in response to stress" -"GO:0061346","planar cell polarity pathway involved in heart morphogenesis" -"GO:0061926","positive regulation of formation of radial glial scaffolds" -"GO:0090377","seed trichome initiation" -"GO:0060490","lateral sprouting involved in lung morphogenesis" -"GO:0099625","ventricular cardiac muscle cell membrane repolarization" -"GO:0072366","regulation of cellular ketone metabolic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:0035544","negative regulation of SNARE complex assembly" -"GO:2001234","negative regulation of apoptotic signaling pathway" -"GO:1904446","positive regulation of establishment of Sertoli cell barrier" -"GO:0046469","platelet activating factor metabolic process" -"GO:0055118","negative regulation of cardiac muscle contraction" -"GO:0042634","regulation of hair cycle" -"GO:0019572","L-arabinose catabolic process" -"GO:0034395","regulation of transcription from RNA polymerase II promoter in response to iron" -"GO:0042122","alginic acid catabolic process" -"GO:0070651","nonfunctional rRNA decay" -"GO:1903288","positive regulation of potassium ion import" -"GO:1904174","negative regulation of histone demethylase activity (H3-K4 specific)" -"GO:0015181","arginine transmembrane transporter activity" -"GO:0098582","innate vocalization behavior" -"GO:1901882","4-hydroxycoumarin metabolic process" -"GO:0003304","myocardial epithelial involution involved in heart jogging" -"GO:0051584","regulation of dopamine uptake involved in synaptic transmission" -"GO:0051900","regulation of mitochondrial depolarization" -"GO:0009740","gibberellic acid mediated signaling pathway" -"GO:0048255","mRNA stabilization" -"GO:0021846","cell proliferation in forebrain" -"GO:0035676","anterior lateral line neuromast hair cell development" -"GO:0072624","interleukin-26 secretion" -"GO:0006517","protein deglycosylation" -"GO:1903988","ferrous iron export across plasma membrane" -"GO:1902476","chloride transmembrane transport" -"GO:0010654","apical cell fate commitment" -"GO:0072625","interleukin-27 secretion" -"GO:0048208","COPII vesicle coating" -"GO:0034418","urate biosynthetic process" -"GO:2000736","regulation of stem cell differentiation" -"GO:0061426","positive regulation of sulfite transport by positive regulation of transcription from RNA polymerase II promoter" -"GO:0071926","endocannabinoid signaling pathway" -"GO:0071703","detection of organic substance" -"GO:1903278","positive regulation of sodium ion export across plasma membrane" -"GO:0034497","protein localization to phagophore assembly site" -"GO:0042982","amyloid precursor protein metabolic process" -"GO:0060688","regulation of morphogenesis of a branching structure" -"GO:0002654","positive regulation of tolerance induction dependent upon immune response" -"GO:0060893","limb granular cell fate specification" -"GO:0090270","regulation of fibroblast growth factor production" -"GO:0060795","cell fate commitment involved in formation of primary germ layer" -"GO:2000059","negative regulation of ubiquitin-dependent protein catabolic process" -"GO:1900622","positive regulation of transcription from RNA polymerase II promoter by calcium-mediated signaling" -"GO:0075296","positive regulation of ascospore formation" -"GO:0046596","regulation of viral entry into host cell" -"GO:0015182","L-asparagine transmembrane transporter activity" -"GO:0075525","viral translational termination-reinitiation" -"GO:0009268","response to pH" -"GO:0034205","amyloid-beta formation" -"GO:2000620","positive regulation of histone H4-K16 acetylation" -"GO:0070804","positive regulation of metula development" -"GO:0045948","positive regulation of translational initiation" -"GO:0043066","negative regulation of apoptotic process" -"GO:0006044","N-acetylglucosamine metabolic process" -"GO:0070970","interleukin-2 secretion" -"GO:0072612","interleukin-14 secretion" -"GO:0003158","endothelium development" -"GO:0019243","methylglyoxal catabolic process to D-lactate via S-lactoyl-glutathione" -"GO:0072644","type III interferon secretion" -"GO:0022007","convergent extension involved in neural plate elongation" -"GO:0034275","kynurenic acid metabolic process" -"GO:0010042","response to manganese ion" -"GO:0019854","L-ascorbic acid catabolic process" -"GO:1900989","scopolamine metabolic process" -"GO:0010592","positive regulation of lamellipodium assembly" -"GO:0072363","regulation of glycolytic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:0010469","regulation of signaling receptor activity" -"GO:0090292","nuclear matrix anchoring at nuclear membrane" -"GO:0002655","regulation of tolerance induction to nonself antigen" -"GO:0090676","calcium ion transmembrane transport via low voltage-gated calcium channel" -"GO:0045635","negative regulation of melanocyte differentiation" -"GO:0032631","interleukin-27 production" -"GO:0034755","iron ion transmembrane transport" -"GO:0022858","alanine transmembrane transporter activity" -"GO:0032770","positive regulation of monooxygenase activity" -"GO:0072626","interleukin-35 secretion" -"GO:0008284","positive regulation of cell proliferation" -"GO:0014030","mesenchymal cell fate commitment" -"GO:0006626","protein targeting to mitochondrion" -"GO:1902097","positive regulation of transcription from RNA polymerase II promoter involved in defense response to Gram-negative bacterium" -"GO:0000904","cell morphogenesis involved in differentiation" -"GO:0061261","mesenchymal to epithelial transition involved in mesonephros morphogenesis" -"GO:1900423","positive regulation of mating type switching by positive regulation of transcription from RNA polymerase II promoter" -"GO:0036316","SREBP-SCAP complex retention in endoplasmic reticulum" -"GO:0032660","regulation of interleukin-17 production" -"GO:0060676","ureteric bud formation" -"GO:0051350","negative regulation of lyase activity" -"GO:0072614","interleukin-16 secretion" -"GO:0070321","regulation of translation in response to nitrogen starvation" -"GO:2000362","negative regulation of prostaglandin-E synthase activity" -"GO:1900478","positive regulation of sulfate assimilation by positive regulation of transcription from RNA polymerase II promoter" -"GO:1903771","positive regulation of beta-galactosidase activity" -"GO:0036514","dopaminergic neuron axon guidance" -"GO:0072620","interleukin-22 secretion" -"GO:0035677","posterior lateral line neuromast hair cell development" -"GO:1902041","regulation of extrinsic apoptotic signaling pathway via death domain receptors" -"GO:0072107","positive regulation of ureteric bud formation" -"GO:0032628","interleukin-24 production" -"GO:0060070","canonical Wnt signaling pathway" -"GO:0032232","negative regulation of actin filament bundle assembly" -"GO:1904938","planar cell polarity pathway involved in axon guidance" -"GO:0071680","response to indole-3-methanol" -"GO:0097069","cellular response to thyroxine stimulus" -"GO:0021987","cerebral cortex development" -"GO:0015697","quaternary ammonium group transport" -"GO:0001121","bacterial transcription" -"GO:0060993","kidney morphogenesis" -"GO:1990765","colon smooth muscle contraction" -"GO:0007224","smoothened signaling pathway" -"GO:0043524","negative regulation of neuron apoptotic process" -"GO:1903925","response to bisphenol A" -"GO:0005302","L-tyrosine transmembrane transporter activity" -"GO:0034220","ion transmembrane transport" -"GO:0035382","sterol transmembrane transport" -"GO:0006516","glycoprotein catabolic process" -"GO:0032793","positive regulation of CREB transcription factor activity" -"GO:2001240","negative regulation of extrinsic apoptotic signaling pathway in absence of ligand" -"GO:0043558","regulation of translational initiation in response to stress" -"GO:0031550","positive regulation of brain-derived neurotrophic factor receptor signaling pathway" -"GO:0072036","mesenchymal to epithelial transition involved in renal vesicle formation" -"GO:1900817","ochratoxin A catabolic process" -"GO:0035849","nephric duct elongation" -"GO:0002286","T cell activation involved in immune response" -"GO:0043641","novobiocin metabolic process" -"GO:0051216","cartilage development" -"GO:0032659","regulation of interleukin-16 production" -"GO:0048309","endoplasmic reticulum inheritance" -"GO:0002925","positive regulation of humoral immune response mediated by circulating immunoglobulin" -"GO:0031050","dsRNA fragmentation" -"GO:0001561","fatty acid alpha-oxidation" -"GO:0010814","substance P catabolic process" -"GO:0032229","negative regulation of synaptic transmission, GABAergic" -"GO:1903221","regulation of mitotic recombination involved in replication fork processing" -"GO:0007059","chromosome segregation" -"GO:0021878","forebrain astrocyte fate commitment" -"GO:1904900","negative regulation of myosin II filament organization" -"GO:0045830","positive regulation of isotype switching" -"GO:2001045","negative regulation of integrin-mediated signaling pathway" -"GO:1903967","response to micafungin" -"GO:1903108","regulation of mitochondrial transcription" -"GO:0001843","neural tube closure" -"GO:1904495","negative regulation of substance P secretion, neurotransmission" -"GO:1904590","negative regulation of protein import" -"GO:0050896","response to stimulus" -"GO:1902253","regulation of intrinsic apoptotic signaling pathway by p53 class mediator" -"GO:0034427","nuclear-transcribed mRNA catabolic process, exonucleolytic, 3'-5'" -"GO:0098813","nuclear chromosome segregation" -"GO:0035194","posttranscriptional gene silencing by RNA" -"GO:0071038","nuclear polyadenylation-dependent tRNA catabolic process" -"GO:0071156","regulation of cell cycle arrest" -"GO:0001711","endodermal cell fate commitment" -"GO:0032781","positive regulation of ATPase activity" -"GO:0006641","triglyceride metabolic process" -"GO:1905365","regulation of intralumenal vesicle formation" -"GO:1904151","positive regulation of microglial cell mediated cytotoxicity" -"GO:0070415","trehalose metabolism in response to cold stress" -"GO:1903726","negative regulation of phospholipid metabolic process" -"GO:0042157","lipoprotein metabolic process" -"GO:0044591","response to amylopectin" -"GO:1902713","regulation of interferon-gamma secretion" -"GO:0001736","establishment of planar polarity" -"GO:0060373","regulation of ventricular cardiac muscle cell membrane depolarization" -"GO:1903469","removal of RNA primer involved in mitotic DNA replication" -"GO:0061044","negative regulation of vascular wound healing" -"GO:0007409","axonogenesis" -"GO:0070509","calcium ion import" -"GO:0007028","cytoplasm organization" -"GO:0018107","peptidyl-threonine phosphorylation" -"GO:0001764","neuron migration" -"GO:0043455","regulation of secondary metabolic process" -"GO:0061180","mammary gland epithelium development" -"GO:0071412","cellular response to genistein" -"GO:1904638","response to resveratrol" -"GO:0006869","lipid transport" -"GO:2000010","positive regulation of protein localization to cell surface" -"GO:1904470","regulation of endothelin secretion" -"GO:1903063","negative regulation of reverse cholesterol transport" -"GO:0010922","positive regulation of phosphatase activity" -"GO:1904557","L-alanine transmembrane transport" -"GO:0046640","regulation of alpha-beta T cell proliferation" -"GO:0019363","pyridine nucleotide biosynthetic process" -"GO:0048148","behavioral response to cocaine" -"GO:0046470","phosphatidylcholine metabolic process" -"GO:0071369","cellular response to ethylene stimulus" -"GO:0070328","triglyceride homeostasis" -"GO:0034372","very-low-density lipoprotein particle remodeling" -"GO:1903140","regulation of establishment of endothelial barrier" -"GO:0034103","regulation of tissue remodeling" -"GO:0044334","canonical Wnt signaling pathway involved in positive regulation of epithelial to mesenchymal transition" -"GO:1900341","positive regulation of methane biosynthetic process from formic acid" -"GO:0030037","actin filament reorganization involved in cell cycle" -"GO:0007431","salivary gland development" -"GO:0060559","positive regulation of calcidiol 1-monooxygenase activity" -"GO:0071941","nitrogen cycle metabolic process" -"GO:0060323","head morphogenesis" -"GO:0090196","regulation of chemokine secretion" -"GO:0050778","positive regulation of immune response" -"GO:0030182","neuron differentiation" -"GO:0046778","modification by virus of host mRNA processing" -"GO:1904175","positive regulation of histone demethylase activity (H3-K4 specific)" -"GO:0031548","regulation of brain-derived neurotrophic factor receptor signaling pathway" -"GO:0045861","negative regulation of proteolysis" -"GO:1900524","positive regulation of flocculation via cell wall protein-carbohydrate interaction by positive regulation of transcription from RNA polymerase II promoter" -"GO:0090026","positive regulation of monocyte chemotaxis" -"GO:1903134","trehalose catabolic process involved in cellular response to stress" -"GO:0033344","cholesterol efflux" -"GO:1904827","negative regulation of hydrogen sulfide biosynthetic process" -"GO:0021691","cerebellar Purkinje cell layer maturation" -"GO:0032611","interleukin-1 beta production" -"GO:0046719","regulation by virus of viral protein levels in host cell" -"GO:0071383","cellular response to steroid hormone stimulus" -"GO:0030213","hyaluronan biosynthetic process" -"GO:0019216","regulation of lipid metabolic process" -"GO:0051633","positive regulation of acetylcholine uptake" -"GO:0048167","regulation of synaptic plasticity" -"GO:0008293","torso signaling pathway" -"GO:0043687","post-translational protein modification" -"GO:1903902","positive regulation of viral life cycle" -"GO:0030433","ubiquitin-dependent ERAD pathway" -"GO:2000665","regulation of interleukin-13 secretion" -"GO:0099404","mitotic sister chromatid cohesion, telomeric" -"GO:2000662","regulation of interleukin-5 secretion" -"GO:0071370","cellular response to gibberellin stimulus" -"GO:0033147","negative regulation of intracellular estrogen receptor signaling pathway" -"GO:1900606","tensidol B metabolic process" -"GO:1900422","positive regulation of cellular alcohol catabolic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:0010711","negative regulation of collagen catabolic process" -"GO:0072322","protein transport across periplasmic space" -"GO:0021697","cerebellar cortex formation" -"GO:0042723","thiamine-containing compound metabolic process" -"GO:0080135","regulation of cellular response to stress" -"GO:0099161","regulation of presynaptic dense core granule exocytosis" -"GO:0033083","regulation of immature T cell proliferation" -"GO:0032801","receptor catabolic process" -"GO:0060157","urinary bladder development" -"GO:0030974","thiamine pyrophosphate transmembrane transport" -"GO:1900350","positive regulation of methane biosynthetic process from methylamine" -"GO:1902042","negative regulation of extrinsic apoptotic signaling pathway via death domain receptors" -"GO:0051645","Golgi localization" -"GO:0002711","positive regulation of T cell mediated immunity" -"GO:0051347","positive regulation of transferase activity" -"GO:0048675","axon extension" -"GO:1900947","regulation of isoprene biosynthetic process" -"GO:0010902","positive regulation of very-low-density lipoprotein particle remodeling" -"GO:0001815","positive regulation of antibody-dependent cellular cytotoxicity" -"GO:0033700","phospholipid efflux" -"GO:0010115","regulation of abscisic acid biosynthetic process" -"GO:0072617","interleukin-19 secretion" -"GO:0006334","nucleosome assembly" -"GO:0061213","positive regulation of mesonephros development" -"GO:2000063","positive regulation of ureter smooth muscle cell differentiation" -"GO:1904801","positive regulation of neuron remodeling" -"GO:1904434","positive regulation of ferrous iron binding" -"GO:1905800","negative regulation of intraciliary retrograde transport" -"GO:2001017","regulation of retrograde axon cargo transport" -"GO:0048377","lateral mesodermal cell fate specification" -"GO:0019433","triglyceride catabolic process" -"GO:0010872","regulation of cholesterol esterification" -"GO:0032258","protein localization by the Cvt pathway" -"GO:0042632","cholesterol homeostasis" -"GO:0051366","protein decanoylation" -"GO:0072634","interleukin-30 secretion" -"GO:0033092","positive regulation of immature T cell proliferation in thymus" -"GO:0045358","negative regulation of interferon-beta biosynthetic process" -"GO:1900223","positive regulation of amyloid-beta clearance" -"GO:0034660","ncRNA metabolic process" -"GO:0072605","interleukin-7 secretion" -"GO:1904283","negative regulation of antigen processing and presentation of endogenous peptide antigen via MHC class I" -"GO:0060402","calcium ion transport into cytosol" -"GO:0006695","cholesterol biosynthetic process" -"GO:0046686","response to cadmium ion" -"GO:0045003","double-strand break repair via synthesis-dependent strand annealing" -"GO:0071213","cellular response to 1-aminocyclopropane-1-carboxylic acid" -"GO:0060782","regulation of mesenchymal cell proliferation involved in prostate gland development" -"GO:1903407","negative regulation of sodium:potassium-exchanging ATPase activity" -"GO:0048708","astrocyte differentiation" -"GO:0051561","positive regulation of mitochondrial calcium ion concentration" -"GO:0048259","regulation of receptor-mediated endocytosis" -"GO:0051006","positive regulation of lipoprotein lipase activity" -"GO:0060541","respiratory system development" -"GO:0060445","branching involved in salivary gland morphogenesis" -"GO:0010873","positive regulation of cholesterol esterification" -"GO:2000056","regulation of Wnt signaling pathway involved in digestive tract morphogenesis" -"GO:0031583","phospholipase D-activating G-protein coupled receptor signaling pathway" -"GO:0060809","mesodermal to mesenchymal transition involved in gastrulation" -"GO:1902548","negative regulation of cellular response to vascular endothelial growth factor stimulus" -"GO:0051914","positive regulation of synaptic plasticity by chemical substance" -"GO:0033197","response to vitamin E" -"GO:0030300","regulation of intestinal cholesterol absorption" -"GO:0009300","antisense RNA transcription" -"GO:0060783","mesenchymal smoothened signaling pathway involved in prostate gland development" -"GO:0097331","response to cytarabine" -"GO:0032515","negative regulation of phosphoprotein phosphatase activity" -"GO:0010898","positive regulation of triglyceride catabolic process" -"GO:0009171","purine deoxyribonucleoside monophosphate biosynthetic process" -"GO:1905151","negative regulation of voltage-gated sodium channel activity" -"GO:0045060","negative thymic T cell selection" -"GO:0002305","CD8-positive, gamma-delta intraepithelial T cell differentiation" -"GO:0036480","neuron intrinsic apoptotic signaling pathway in response to oxidative stress" -"GO:0045628","regulation of T-helper 2 cell differentiation" -"GO:0021985","neurohypophysis development" -"GO:0002626","negative regulation of T cell antigen processing and presentation" -"GO:0007628","adult walking behavior" -"GO:1904154","positive regulation of retrograde protein transport, ER to cytosol" -"GO:0014858","positive regulation of skeletal muscle cell proliferation" -"GO:0061350","planar cell polarity pathway involved in cardiac muscle tissue morphogenesis" -"GO:0045434","negative regulation of female receptivity, post-mating" -"GO:0018190","protein octanoylation" -"GO:0030301","cholesterol transport" -"GO:0050775","positive regulation of dendrite morphogenesis" -"GO:0072636","interleukin-31 secretion" -"GO:0060439","trachea morphogenesis" -"GO:0007418","ventral midline development" -"GO:1903999","negative regulation of eating behavior" -"GO:1900263","negative regulation of DNA-directed DNA polymerase activity" -"GO:0071620","phosphorylation of RNA polymerase II C-terminal domain serine 5 residues" -"GO:0051716","cellular response to stimulus" -"GO:0044804","autophagy of nucleus" -"GO:0032013","negative regulation of ARF protein signal transduction" -"GO:0036517","chemoattraction of serotonergic neuron axon" -"GO:0051785","positive regulation of nuclear division" -"GO:0010040","response to iron(II) ion" -"GO:0015992","proton transport" -"GO:0010597","green leaf volatile biosynthetic process" -"GO:0070830","bicellular tight junction assembly" -"GO:1903892","negative regulation of ATF6-mediated unfolded protein response" -"GO:0031918","positive regulation of synaptic metaplasticity" -"GO:0008209","androgen metabolic process" -"GO:0034460","uropod assembly" -"GO:1902018","negative regulation of cilium assembly" -"GO:1904751","positive regulation of protein localization to nucleolus" -"GO:0032877","positive regulation of DNA endoreduplication" -"GO:0090521","glomerular visceral epithelial cell migration" -"GO:0031081","nuclear pore distribution" -"GO:0042048","olfactory behavior" -"GO:0030850","prostate gland development" -"GO:0018377","protein myristoylation" -"GO:0060310","regulation of elastin catabolic process" -"GO:2000136","regulation of cell proliferation involved in heart morphogenesis" -"GO:0045423","regulation of granulocyte macrophage colony-stimulating factor biosynthetic process" -"GO:0061854","positive regulation of neuroblast migration" -"GO:1902236","negative regulation of endoplasmic reticulum stress-induced intrinsic apoptotic signaling pathway" -"GO:1901753","leukotriene A4 biosynthetic process" -"GO:0035687","T-helper 1 cell extravasation" -"GO:0015298","solute:cation antiporter activity" -"GO:0060174","limb bud formation" -"GO:1904596","regulation of connective tissue replacement involved in inflammatory response wound healing" -"GO:0071404","cellular response to low-density lipoprotein particle stimulus" -"GO:0035067","negative regulation of histone acetylation" -"GO:0006657","CDP-choline pathway" -"GO:0060875","lateral semicircular canal development" -"GO:0043585","nose morphogenesis" -"GO:0061348","planar cell polarity pathway involved in ventricular septum morphogenesis" -"GO:0007144","female meiosis I" -"GO:0006682","galactosylceramide biosynthetic process" -"GO:0048839","inner ear development" -"GO:0071216","cellular response to biotic stimulus" -"GO:1903895","negative regulation of IRE1-mediated unfolded protein response" -"GO:0051595","response to methylglyoxal" -"GO:0072609","interleukin-11 secretion" -"GO:1900046","regulation of hemostasis" -"GO:0048754","branching morphogenesis of an epithelial tube" -"GO:0042109","lymphotoxin A biosynthetic process" -"GO:0008366","axon ensheathment" -"GO:1904934","negative regulation of cell proliferation in midbrain" -"GO:1905672","negative regulation of lysosome organization" -"GO:0000423","mitophagy" -"GO:0072216","positive regulation of metanephros development" -"GO:0018268","GPI anchor biosynthetic process via N-glycyl-glycosylphosphatidylinositolethanolamine" -"GO:0034244","negative regulation of transcription elongation from RNA polymerase II promoter" -"GO:0046958","nonassociative learning" -"GO:1900222","negative regulation of amyloid-beta clearance" -"GO:0008203","cholesterol metabolic process" -"GO:1903704","negative regulation of production of siRNA involved in RNA interference" -"GO:0034156","negative regulation of toll-like receptor 7 signaling pathway" -"GO:0070665","positive regulation of leukocyte proliferation" -"GO:1990809","endoplasmic reticulum tubular network membrane organization" -"GO:0046718","viral entry into host cell" -"GO:0072623","interleukin-25 secretion" -"GO:0031590","wybutosine metabolic process" -"GO:0051155","positive regulation of striated muscle cell differentiation" -"GO:0009134","nucleoside diphosphate catabolic process" -"GO:0018227","peptidyl-S-12-hydroxyfarnesyl-L-cysteine biosynthetic process from peptidyl-cysteine" -"GO:0042167","heme catabolic process" -"GO:0009249","protein lipoylation" -"GO:1903487","regulation of lactation" -"GO:0070483","detection of hypoxia" -"GO:0001514","selenocysteine incorporation" -"GO:0072640","interleukin-33 secretion" -"GO:1902732","positive regulation of chondrocyte proliferation" -"GO:0042130","negative regulation of T cell proliferation" -"GO:2001302","lipoxin A4 metabolic process" -"GO:0043010","camera-type eye development" -"GO:0098971","anterograde dendritic transport of neurotransmitter receptor complex" -"GO:0030208","dermatan sulfate biosynthetic process" -"GO:0098711","iron ion import across plasma membrane" -"GO:0097012","response to granulocyte macrophage colony-stimulating factor" -"GO:0006337","nucleosome disassembly" -"GO:0090150","establishment of protein localization to membrane" -"GO:0042082","GSI anchor biosynthetic process" -"GO:0010106","cellular response to iron ion starvation" -"GO:0019876","nylon catabolic process" -"GO:0060459","left lung development" -"GO:0061817","endoplasmic reticulum-plasma membrane tethering" -"GO:0019273","L-alanine biosynthetic process via ornithine" -"GO:0001695","histamine catabolic process" -"GO:1902258","positive regulation of apoptotic process involved in outflow tract morphogenesis" -"GO:2000319","regulation of T-helper 17 cell differentiation" -"GO:0045625","regulation of T-helper 1 cell differentiation" -"GO:0008595","anterior/posterior axis specification, embryo" -"GO:0007029","endoplasmic reticulum organization" -"GO:0044467","glial cell-derived neurotrophic factor secretion" -"GO:0033089","positive regulation of T cell differentiation in thymus" -"GO:0045324","late endosome to vacuole transport" -"GO:0061955","positive regulation of actin filament depolymerization involved in acrosome reaction" -"GO:0045641","negative regulation of basophil differentiation" -"GO:0072369","regulation of lipid transport by positive regulation of transcription from RNA polymerase II promoter" -"GO:0002830","positive regulation of type 2 immune response" -"GO:0044330","canonical Wnt signaling pathway involved in positive regulation of wound healing" -"GO:1905597","positive regulation of low-density lipoprotein particle receptor binding" -"GO:0043616","keratinocyte proliferation" -"GO:0002829","negative regulation of type 2 immune response" -"GO:0044703","multi-organism reproductive process" -"GO:0070344","regulation of fat cell proliferation" -"GO:1902281","negative regulation of ATP-dependent RNA helicase activity" -"GO:0072639","interleukin-33 production" -"GO:0040015","negative regulation of multicellular organism growth" -"GO:0007258","JUN phosphorylation" -"GO:0036417","tRNA destabilization" -"GO:0032602","chemokine production" -"GO:0022413","reproductive process in single-celled organism" -"GO:0019354","siroheme biosynthetic process" -"GO:0016311","dephosphorylation" -"GO:1902365","positive regulation of protein localization to spindle pole body" -"GO:0010668","ectodermal cell differentiation" -"GO:1904385","cellular response to angiotensin" -"GO:0018931","naphthalene metabolic process" -"GO:0061416","regulation of transcription from RNA polymerase II promoter in response to salt stress" -"GO:0061006","regulation of cell proliferation involved in kidney morphogenesis" -"GO:0051639","actin filament network formation" -"GO:0061273","mesonephric distal tubule morphogenesis" -"GO:0048041","focal adhesion assembly" -"GO:0051782","negative regulation of cell division" -"GO:0002157","positive regulation of thyroid hormone mediated signaling pathway" -"GO:1903681","regulation of epithelial cell-cell adhesion involved in epithelium migration" -"GO:0061005","cell differentiation involved in kidney development" -"GO:0060996","dendritic spine development" -"GO:0045659","negative regulation of neutrophil differentiation" -"GO:0010708","heteroduplex formation involved in gene conversion at mating-type locus" -"GO:0032617","interleukin-14 production" -"GO:0008589","regulation of smoothened signaling pathway" -"GO:0010895","negative regulation of ergosterol biosynthetic process" -"GO:0048565","digestive tract development" -"GO:0032625","interleukin-21 production" -"GO:0090548","response to nitrate starvation" -"GO:1905936","regulation of germ cell proliferation" -"GO:1900281","positive regulation of CD4-positive, alpha-beta T cell costimulation" -"GO:0021997","neural plate axis specification" -"GO:0003194","sinoatrial valve formation" -"GO:1903363","negative regulation of cellular protein catabolic process" -"GO:0010875","positive regulation of cholesterol efflux" -"GO:0032616","interleukin-13 production" -"GO:0033627","cell adhesion mediated by integrin" -"GO:0032630","interleukin-26 production" -"GO:1904499","regulation of chromatin-mediated maintenance of transcription" -"GO:0046847","filopodium assembly" -"GO:0032619","interleukin-16 production" -"GO:0022409","positive regulation of cell-cell adhesion" -"GO:0060354","negative regulation of cell adhesion molecule production" -"GO:0035705","T-helper 17 cell chemotaxis" -"GO:2000260","regulation of blood coagulation, common pathway" -"GO:0060857","establishment of glial blood-brain barrier" -"GO:0010344","seed oilbody biogenesis" -"GO:0060761","negative regulation of response to cytokine stimulus" -"GO:2001110","negative regulation of lens epithelial cell proliferation" -"GO:1990872","negative regulation of sterol import by negative regulation of transcription from RNA polymerase II promoter" -"GO:1905304","regulation of cardiac myofibril assembly" -"GO:2001191","regulation of gamma-delta T cell activation involved in immune response" -"GO:0009856","pollination" -"GO:0061887","reproduction of symbiont in host" -"GO:0021532","neural tube patterning" -"GO:0018206","peptidyl-methionine modification" -"GO:0071397","cellular response to cholesterol" -"GO:0014012","peripheral nervous system axon regeneration" -"GO:0038014","negative regulation of insulin receptor signaling pathway by insulin receptor internalization" -"GO:0030720","oocyte localization involved in germarium-derived egg chamber formation" -"GO:0070872","plasma membrane organization involved in conjugation with cellular fusion" -"GO:0045374","positive regulation of interleukin-15 biosynthetic process" -"GO:2000403","positive regulation of lymphocyte migration" -"GO:0007015","actin filament organization" -"GO:0072633","interleukin-30 production" -"GO:0000742","karyogamy involved in conjugation with cellular fusion" -"GO:0035713","response to nitrogen dioxide" -"GO:0080027","response to herbivore" -"GO:2000464","positive regulation of astrocyte chemotaxis" -"GO:0043588","skin development" -"GO:0043308","eosinophil degranulation" -"GO:0007320","insemination" -"GO:0035602","fibroblast growth factor receptor signaling pathway involved in negative regulation of apoptotic process in bone marrow" -"GO:0071336","regulation of hair follicle cell proliferation" -"GO:0048573","photoperiodism, flowering" -"GO:0072554","blood vessel lumenization" -"GO:2000572","positive regulation of interleukin-4-dependent isotype switching to IgE isotypes" -"GO:2001138","regulation of phospholipid transport" -"GO:0002275","myeloid cell activation involved in immune response" -"GO:0051764","actin crosslink formation" -"GO:0045580","regulation of T cell differentiation" -"GO:0043048","dolichyl monophosphate biosynthetic process" -"GO:0046104","thymidine metabolic process" -"GO:0060468","prevention of polyspermy" -"GO:1901298","regulation of hydrogen peroxide-mediated programmed cell death" -"GO:0009957","epidermal cell fate specification" -"GO:0060088","auditory receptor cell stereocilium organization" -"GO:0031589","cell-substrate adhesion" -"GO:0022412","cellular process involved in reproduction in multicellular organism" -"GO:0061616","glycolytic process from fructose through fructose-6-phosphate" -"GO:0045668","negative regulation of osteoblast differentiation" -"GO:1905775","negative regulation of DNA helicase activity" -"GO:0035607","fibroblast growth factor receptor signaling pathway involved in orbitofrontal cortex development" -"GO:0018296","protein-FAD linkage via O4'-(8alpha-FAD)-L-tyrosine" -"GO:0018158","protein oxidation" -"GO:0051271","negative regulation of cellular component movement" -"GO:2000700","positive regulation of cardiac muscle cell myoblast differentiation" -"GO:0046054","dGMP metabolic process" -"GO:0030220","platelet formation" -"GO:0110030","regulation of G2/MI transition of meiotic cell cycle" -"GO:0032612","interleukin-1 production" -"GO:0008152","metabolic process" -"GO:0060614","negative regulation of mammary gland development in males by androgen receptor signaling pathway" -"GO:0010588","cotyledon vascular tissue pattern formation" -"GO:0035878","nail development" -"GO:0010988","regulation of low-density lipoprotein particle clearance" -"GO:0051017","actin filament bundle assembly" -"GO:0038180","nerve growth factor signaling pathway" -"GO:0035907","dorsal aorta development" -"GO:0007044","cell-substrate junction assembly" -"GO:1902617","response to fluoride" -"GO:2001237","negative regulation of extrinsic apoptotic signaling pathway" -"GO:0035038","female pronucleus assembly" -"GO:0035969","positive regulation of sterol import by positive regulation of transcription from RNA polymerase II promoter" -"GO:1903035","negative regulation of response to wounding" -"GO:0008101","decapentaplegic signaling pathway" -"GO:0006185","dGDP biosynthetic process" -"GO:0002819","regulation of adaptive immune response" -"GO:0036344","platelet morphogenesis" -"GO:0090360","platelet-derived growth factor production" -"GO:1904698","negative regulation of acinar cell proliferation" -"GO:0070663","regulation of leukocyte proliferation" -"GO:0035039","male pronucleus assembly" -"GO:0070370","cellular heat acclimation" -"GO:0072098","anterior/posterior pattern specification involved in kidney development" -"GO:1903170","negative regulation of calcium ion transmembrane transport" -"GO:0097186","amelogenesis" -"GO:2000583","regulation of platelet-derived growth factor receptor-alpha signaling pathway" -"GO:1901318","negative regulation of flagellated sperm motility" -"GO:0051943","positive regulation of amino acid uptake involved in synaptic transmission" -"GO:0070527","platelet aggregation" -"GO:0032634","interleukin-5 production" -"GO:0090269","fibroblast growth factor production" -"GO:0007290","spermatid nucleus elongation" -"GO:1901978","positive regulation of cell cycle checkpoint" -"GO:1905362","negative regulation of endosomal vesicle fusion" -"GO:0061500","gene conversion at mating-type locus, termination of copy-synthesis" -"GO:1903506","regulation of nucleic acid-templated transcription" -"GO:0072327","vulval cell fate specification" -"GO:0075209","positive regulation by symbiont of host cAMP-mediated signal transduction" -"GO:1903706","regulation of hemopoiesis" -"GO:2000529","positive regulation of myeloid dendritic cell chemotaxis" -"GO:0050717","positive regulation of interleukin-1 alpha secretion" -"GO:1900459","positive regulation of brassinosteroid mediated signaling pathway" -"GO:0060366","lambdoid suture morphogenesis" -"GO:0055082","cellular chemical homeostasis" -"GO:0046628","positive regulation of insulin receptor signaling pathway" -"GO:1903362","regulation of cellular protein catabolic process" -"GO:0060367","sagittal suture morphogenesis" -"GO:0009765","photosynthesis, light harvesting" -"GO:0080127","fruit septum development" -"GO:0120034","positive regulation of plasma membrane bounded cell projection assembly" -"GO:0044784","metaphase/anaphase transition of cell cycle" -"GO:0034175","regulation of toll-like receptor 12 signaling pathway" -"GO:0099574","regulation of protein catabolic process at synapse, modulating synaptic transmission" -"GO:0015683","ferric iron transmembrane transport" -"GO:0010929","positive regulation of auxin mediated signaling pathway" -"GO:0035655","interleukin-18-mediated signaling pathway" -"GO:0000278","mitotic cell cycle" -"GO:0098909","regulation of cardiac muscle cell action potential involved in regulation of contraction" -"GO:0032253","dense core granule localization" -"GO:0043692","monoterpene metabolic process" -"GO:0075148","positive regulation of signal transduction in response to host" -"GO:1905679","positive regulation of adaptive immune effector response" -"GO:0036294","cellular response to decreased oxygen levels" -"GO:0002418","immune response to tumor cell" -"GO:0061735","DNM1L-mediated stimulation of mitophagy in response to mitochondrial depolarization" -"GO:0071904","protein N-linked N-acetylgalactosaminylation via asparagine" -"GO:0003254","regulation of membrane depolarization" -"GO:1905481","cytoplasmic sequestering of protein involved in mitotic DNA replication checkpoint" -"GO:0006284","base-excision repair" -"GO:0018302","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl-L-N1'-histidino tetrairon tetrasulfide" -"GO:1990767","prostaglandin receptor internalization" -"GO:0006570","tyrosine metabolic process" -"GO:0003147","neural crest cell migration involved in heart formation" -"GO:0051495","positive regulation of cytoskeleton organization" -"GO:0086015","SA node cell action potential" -"GO:0090427","activation of meiosis" -"GO:0070889","platelet alpha granule organization" -"GO:0023016","signal transduction by trans-phosphorylation" -"GO:1904156","DN3 thymocyte differentiation" -"GO:0099121","fungal sorus development" -"GO:0051127","positive regulation of actin nucleation" -"GO:0000173","inactivation of MAPK activity involved in osmosensory signaling pathway" -"GO:0071733","transcriptional activation by promoter-enhancer looping" -"GO:0051239","regulation of multicellular organismal process" -"GO:0000188","inactivation of MAPK activity" -"GO:0014896","muscle hypertrophy" -"GO:0061713","anterior neural tube closure" -"GO:1905751","positive regulation of endosome to plasma membrane protein transport" -"GO:0046078","dUMP metabolic process" -"GO:0098660","inorganic ion transmembrane transport" -"GO:0035630","bone mineralization involved in bone maturation" -"GO:0071964","establishment of cell polarity regulating cell shape" -"GO:0016201","synaptic target inhibition" -"GO:0035308","negative regulation of protein dephosphorylation" -"GO:0014889","muscle atrophy" -"GO:0043004","cytoplasmic sequestering of CFTR protein" -"GO:0035854","eosinophil fate commitment" -"GO:0009952","anterior/posterior pattern specification" -"GO:0051030","snRNA transport" -"GO:0098739","import across plasma membrane" -"GO:0007232","osmosensory signaling pathway via Sho1 osmosensor" -"GO:0090284","positive regulation of protein glycosylation in Golgi" -"GO:0002280","monocyte activation involved in immune response" -"GO:0009093","cysteine catabolic process" -"GO:0006972","hyperosmotic response" -"GO:1900149","positive regulation of Schwann cell migration" -"GO:1905803","negative regulation of cellular response to manganese ion" -"GO:0006757","ATP generation from ADP" -"GO:1900024","regulation of substrate adhesion-dependent cell spreading" -"GO:0051582","positive regulation of neurotransmitter uptake" -"GO:1901088","benzylpenicillin biosynthetic process" -"GO:0098719","sodium ion import across plasma membrane" -"GO:0015975","energy derivation by oxidation of reduced inorganic compounds" -"GO:0061647","histone H3-K9 modification" -"GO:1905482","cytoplasmic sequestering of protein involved in G2 DNA damage checkpoint" -"GO:1905281","positive regulation of retrograde transport, endosome to Golgi" -"GO:0048936","peripheral nervous system neuron axonogenesis" -"GO:0034729","histone H3-K79 methylation" -"GO:0051067","dihydropteridine metabolic process" -"GO:0006404","RNA import into nucleus" -"GO:2000300","regulation of synaptic vesicle exocytosis" -"GO:0030318","melanocyte differentiation" -"GO:0086012","membrane depolarization during cardiac muscle cell action potential" -"GO:0000185","activation of MAPKKK activity" -"GO:0090330","regulation of platelet aggregation" -"GO:0099637","neurotransmitter receptor transport" -"GO:0006235","dTTP biosynthetic process" -"GO:0042401","cellular biogenic amine biosynthetic process" -"GO:1905450","negative regulation of Fc-gamma receptor signaling pathway involved in phagocytosis" -"GO:0035360","positive regulation of peroxisome proliferator activated receptor signaling pathway" -"GO:0075043","maintenance of turgor in appressorium by melanization" -"GO:0030841","positive regulation of intermediate filament polymerization" -"GO:0070242","thymocyte apoptotic process" -"GO:0071528","tRNA re-export from nucleus" -"GO:1990573","potassium ion import across plasma membrane" -"GO:0019684","photosynthesis, light reaction" -"GO:0061026","cardiac muscle tissue regeneration" -"GO:0021775","smoothened signaling pathway involved in ventral spinal cord interneuron specification" -"GO:0045199","maintenance of epithelial cell apical/basal polarity" -"GO:0046888","negative regulation of hormone secretion" -"GO:0001543","ovarian follicle rupture" -"GO:0000282","cellular bud site selection" -"GO:1902210","positive regulation of bacterial-type flagellum assembly" -"GO:2001055","positive regulation of mesenchymal cell apoptotic process" -"GO:0086067","AV node cell to bundle of His cell communication" -"GO:1904491","protein localization to ciliary transition zone" -"GO:1905366","negative regulation of intralumenal vesicle formation" -"GO:1905904","positive regulation of mesoderm formation" -"GO:0010696","positive regulation of mitotic spindle pole body separation" -"GO:0022018","lateral ganglionic eminence cell proliferation" -"GO:0051043","regulation of membrane protein ectodomain proteolysis" -"GO:0072350","tricarboxylic acid metabolic process" -"GO:1904983","glycine import into mitochondrion" -"GO:0006586","indolalkylamine metabolic process" -"GO:0007023","post-chaperonin tubulin folding pathway" -"GO:1990569","UDP-N-acetylglucosamine transmembrane transport" -"GO:0061719","glucose catabolic process to pyruvate utilizing ADP" -"GO:1902908","regulation of melanosome transport" -"GO:0031450","negative regulation of slow-twitch skeletal muscle fiber contraction" -"GO:1903983","positive regulation of microvillus length" -"GO:0006457","protein folding" -"GO:0021554","optic nerve development" -"GO:0061171","establishment of bipolar cell polarity" -"GO:0035149","lumen formation, open tracheal system" -"GO:1905709","negative regulation of membrane permeability" -"GO:1905949","negative regulation of calcium ion import across plasma membrane" -"GO:0060057","apoptotic process involved in mammary gland involution" -"GO:0014904","myotube cell development" -"GO:0042443","phenylethylamine metabolic process" -"GO:0071421","manganese ion transmembrane transport" -"GO:1902745","positive regulation of lamellipodium organization" -"GO:0110029","negative regulation of meiosis I" -"GO:0090696","post-embryonic plant organ development" -"GO:0006900","vesicle budding from membrane" -"GO:0021895","cerebral cortex neuron differentiation" -"GO:0071989","establishment of protein localization to spindle pole body" -"GO:1905376","negative regulation of cytochrome-c oxidase activity" -"GO:0086046","membrane depolarization during SA node cell action potential" -"GO:0033864","positive regulation of NAD(P)H oxidase activity" -"GO:1902233","negative regulation of positive thymic T cell selection" -"GO:0140141","mitochondrial potassium ion transmembrane transport" -"GO:1905218","cellular response to astaxanthin" -"GO:0021631","optic nerve morphogenesis" -"GO:0035880","embryonic nail plate morphogenesis" -"GO:0021798","forebrain dorsal/ventral pattern formation" -"GO:0071321","cellular response to cGMP" -"GO:2000435","negative regulation of protein neddylation" -"GO:0021776","smoothened signaling pathway involved in spinal cord motor neuron cell fate specification" -"GO:0003252","negative regulation of cell proliferation involved in heart valve morphogenesis" -"GO:0010725","regulation of primitive erythrocyte differentiation" -"GO:0090351","seedling development" -"GO:0039573","suppression by virus of host complement activation" -"GO:0001675","acrosome assembly" -"GO:0061188","negative regulation of chromatin silencing at rDNA" -"GO:0021766","hippocampus development" -"GO:0032989","cellular component morphogenesis" -"GO:0044071","modulation by symbiont of host cell cycle" -"GO:0019560","histidine catabolic process to hydantoin-5-propionate" -"GO:0003413","chondrocyte differentiation involved in endochondral bone morphogenesis" -"GO:1902078","positive regulation of lateral motor column neuron migration" -"GO:1901297","positive regulation of canonical Wnt signaling pathway involved in cardiac muscle cell fate commitment" -"GO:0070130","negative regulation of mitochondrial translation" -"GO:0021819","layer formation in cerebral cortex" -"GO:0071104","response to interleukin-9" -"GO:0042316","penicillin metabolic process" -"GO:0031052","chromosome breakage" -"GO:0007268","chemical synaptic transmission" -"GO:0071697","ectodermal placode morphogenesis" -"GO:0045574","sterigmatocystin catabolic process" -"GO:1990046","stress-induced mitochondrial fusion" -"GO:0090402","oncogene-induced cell senescence" -"GO:0070244","negative regulation of thymocyte apoptotic process" -"GO:0071901","negative regulation of protein serine/threonine kinase activity" -"GO:0048804","imaginal disc-derived female genitalia morphogenesis" -"GO:0039006","pronephric nephron tubule formation" -"GO:0000726","non-recombinational repair" -"GO:0071243","cellular response to arsenic-containing substance" -"GO:0032788","saturated monocarboxylic acid metabolic process" -"GO:0006177","GMP biosynthetic process" -"GO:0072140","DCT cell development" -"GO:1901209","positive regulation of heart looping" -"GO:1903338","regulation of cell wall organization or biogenesis" -"GO:0110040","pharynx morphogenesis" -"GO:0046475","glycerophospholipid catabolic process" -"GO:0006970","response to osmotic stress" -"GO:0019233","sensory perception of pain" -"GO:0036102","leukotriene B4 metabolic process" -"GO:0021602","cranial nerve morphogenesis" -"GO:0045114","beta 2 integrin biosynthetic process" -"GO:0009448","gamma-aminobutyric acid metabolic process" -"GO:0035981","tongue muscle cell differentiation" -"GO:0030866","cortical actin cytoskeleton organization" -"GO:0007167","enzyme linked receptor protein signaling pathway" -"GO:0035813","regulation of renal sodium excretion" -"GO:1904157","DN4 thymocyte differentiation" -"GO:0007260","tyrosine phosphorylation of STAT protein" -"GO:0006344","maintenance of chromatin silencing" -"GO:0060928","atrioventricular node cell development" -"GO:1905392","plant organ morphogenesis" -"GO:0036506","maintenance of unfolded protein" -"GO:0036207","positive regulation of histone gene expression" -"GO:0048729","tissue morphogenesis" -"GO:0007426","tracheal outgrowth, open tracheal system" -"GO:0003084","positive regulation of systemic arterial blood pressure" -"GO:0044786","cell cycle DNA replication" -"GO:0002731","negative regulation of dendritic cell cytokine production" -"GO:0034754","cellular hormone metabolic process" -"GO:0072202","cell differentiation involved in metanephros development" -"GO:0042501","serine phosphorylation of STAT protein" -"GO:0009099","valine biosynthetic process" -"GO:1900114","positive regulation of histone H3-K9 trimethylation" -"GO:0072113","head kidney development" -"GO:0090018","posterior neural plate formation" -"GO:0019520","aldonic acid metabolic process" -"GO:0072224","metanephric glomerulus development" -"GO:0034766","negative regulation of ion transmembrane transport" -"GO:0014044","Schwann cell development" -"GO:0018270","GPI anchor biosynthetic process via N-alanyl-glycosylphosphatidylinositolethanolamine" -"GO:0031935","regulation of chromatin silencing" -"GO:0050432","catecholamine secretion" -"GO:0050493","GPI anchor biosynthetic process via N-threonyl-glycosylphosphatidylinositolethanolamine" -"GO:0003205","cardiac chamber development" -"GO:1902607","negative regulation of large conductance calcium-activated potassium channel activity" -"GO:0048239","negative regulation of DNA recombination at telomere" -"GO:0010927","cellular component assembly involved in morphogenesis" -"GO:0015698","inorganic anion transport" -"GO:0018874","benzoate metabolic process" -"GO:0016192","vesicle-mediated transport" -"GO:0030846","termination of RNA polymerase II transcription, poly(A)-coupled" -"GO:1905870","positive regulation of 3'-UTR-mediated mRNA stabilization" -"GO:0016241","regulation of macroautophagy" -"GO:0032361","pyridoxal phosphate catabolic process" -"GO:0032789","unsaturated monocarboxylic acid metabolic process" -"GO:0006886","intracellular protein transport" -"GO:0070484","dehydro-D-arabinono-1,4-lactone metabolic process" -"GO:0035819","positive regulation of renal sodium excretion by pressure natriuresis" -"GO:0043150","DNA synthesis involved in double-strand break repair via homologous recombination" -"GO:0070544","histone H3-K36 demethylation" -"GO:1905846","regulation of cellular response to oxidopamine" -"GO:0060899","regulation of transcription involved in eye field cell fate commitment of camera-type eye" -"GO:1903907","negative regulation of plasma membrane raft polarization" -"GO:0046494","rhizobactin 1021 metabolic process" -"GO:1901242","ATPase-coupled doxorubicin transmembrane transporter activity" -"GO:1905643","positive regulation of DNA methylation" -"GO:0035978","histone H2A-S139 phosphorylation" -"GO:1905651","regulation of artery morphogenesis" -"GO:0006285","base-excision repair, AP site formation" -"GO:0070669","response to interleukin-2" -"GO:0043363","nucleate erythrocyte differentiation" -"GO:0016310","phosphorylation" -"GO:0015755","fructose transmembrane transport" -"GO:2000159","regulation of planar cell polarity pathway involved in heart morphogenesis" -"GO:0001522","pseudouridine synthesis" -"GO:2000138","positive regulation of cell proliferation involved in heart morphogenesis" -"GO:1904646","cellular response to amyloid-beta" -"GO:0090626","plant epidermis morphogenesis" -"GO:0038092","nodal signaling pathway" -"GO:0003297","heart wedging" -"GO:0060569","positive regulation of peptide hormone processing" -"GO:2001013","epithelial cell proliferation involved in renal tubule morphogenesis" -"GO:0007416","synapse assembly" -"GO:0061515","myeloid cell development" -"GO:0033618","plasma membrane respiratory chain complex IV assembly" -"GO:0050789","regulation of biological process" -"GO:0021593","rhombomere morphogenesis" -"GO:1902797","negative regulation of snoRNA processing" -"GO:0046826","negative regulation of protein export from nucleus" -"GO:1904452","negative regulation of potassium:proton exchanging ATPase activity" -"GO:0070792","Hulle cell development" -"GO:0061050","regulation of cell growth involved in cardiac muscle cell development" -"GO:0003285","septum secundum development" -"GO:0072282","metanephric nephron tubule morphogenesis" -"GO:1902381","11-oxo-beta-amyrin metabolic process" -"GO:0021694","cerebellar Purkinje cell layer formation" -"GO:1904356","regulation of telomere maintenance via telomere lengthening" -"GO:0018105","peptidyl-serine phosphorylation" -"GO:0003335","corneocyte development" -"GO:0009298","GDP-mannose biosynthetic process" -"GO:0007277","pole cell development" -"GO:1901793","3-(3-hydroxyphenyl)propanoate metabolic process" -"GO:0021583","pons morphogenesis" -"GO:0070790","phialide development" -"GO:0008542","visual learning" -"GO:0010611","regulation of cardiac muscle hypertrophy" -"GO:0052644","chlorophyllide a metabolic process" -"GO:0031063","regulation of histone deacetylation" -"GO:0009878","nodule morphogenesis" -"GO:0032048","cardiolipin metabolic process" -"GO:0036135","Schwann cell migration" -"GO:0021705","locus ceruleus formation" -"GO:0035574","histone H4-K20 demethylation" -"GO:0052805","imidazole-containing compound catabolic process" -"GO:0061001","regulation of dendritic spine morphogenesis" -"GO:1902384","glycyrrhetinate metabolic process" -"GO:0010213","non-photoreactive DNA repair" -"GO:0003050","regulation of systemic arterial blood pressure by atrial natriuretic peptide" -"GO:0072145","proximal convoluted tubule segment 1 cell development" -"GO:0060658","nipple morphogenesis" -"GO:0035911","descending aorta morphogenesis" -"GO:0033088","negative regulation of immature T cell proliferation in thymus" -"GO:0034298","arthrospore formation" -"GO:2000292","regulation of defecation" -"GO:0051166","2,5-dihydroxypyridine catabolic process" -"GO:0009405","pathogenesis" -"GO:0044634","negative regulation of complement activation, alternative pathway in other organism" -"GO:0030704","vitelline membrane formation" -"GO:1903049","negative regulation of acetylcholine-gated cation channel activity" -"GO:1901796","regulation of signal transduction by p53 class mediator" -"GO:1990543","mitochondrial S-adenosyl-L-methionine transmembrane transport" -"GO:0039682","rolling circle viral DNA replication" -"GO:0052651","monoacylglycerol catabolic process" -"GO:0031507","heterochromatin assembly" -"GO:0036335","intestinal stem cell homeostasis" -"GO:0048489","synaptic vesicle transport" -"GO:2000628","regulation of miRNA metabolic process" -"GO:0090662","ATP hydrolysis coupled transmembrane transport" -"GO:0060132","prolactin secreting cell development" -"GO:0060521","mesenchymal-epithelial cell signaling involved in prostate induction" -"GO:0021714","inferior olivary nucleus morphogenesis" -"GO:0019741","pentacyclic triterpenoid catabolic process" -"GO:0051141","negative regulation of NK T cell proliferation" -"GO:0060794","leaflet morphogenesis" -"GO:0045786","negative regulation of cell cycle" -"GO:0090105","pancreatic E cell development" -"GO:0018269","GPI anchor biosynthetic process via N-seryl-glycosylphosphatidylinositolethanolamine" -"GO:0019611","4-toluenecarboxylate metabolic process" -"GO:1905258","regulation of nitrosative stress-induced intrinsic apoptotic signaling pathway" -"GO:0048333","mesodermal cell differentiation" -"GO:1903421","regulation of synaptic vesicle recycling" -"GO:0072187","metanephric cap formation" -"GO:0021511","spinal cord patterning" -"GO:2000660","negative regulation of interleukin-1-mediated signaling pathway" -"GO:0061388","regulation of rate of cell growth" -"GO:0090598","male anatomical structure morphogenesis" -"GO:0019489","methylgallate metabolic process" -"GO:1904039","negative regulation of ferrous iron export" -"GO:0018962","3-phenylpropionate metabolic process" -"GO:0035107","appendage morphogenesis" -"GO:0018888","3-chloroacrylic acid metabolic process" -"GO:0080183","response to photooxidative stress" -"GO:0033611","oxalate catabolic process" -"GO:0032803","regulation of low-density lipoprotein particle receptor catabolic process" -"GO:0090393","sepal giant cell development" -"GO:0010134","sulfate assimilation via adenylyl sulfate reduction" -"GO:0003305","cell migration involved in heart jogging" -"GO:0006913","nucleocytoplasmic transport" -"GO:0010797","regulation of multivesicular body size involved in endosome transport" -"GO:0021579","medulla oblongata morphogenesis" -"GO:1901170","naphthalene catabolic process" -"GO:0002078","membrane fusion involved in acrosome reaction" -"GO:0061387","regulation of extent of cell growth" -"GO:0090708","specification of plant organ axis polarity" -"GO:0015956","bis(5'-nucleosidyl) oligophosphate metabolic process" -"GO:0044764","multi-organism cellular process" -"GO:0035176","social behavior" -"GO:0072198","mesenchymal cell proliferation involved in ureter development" -"GO:0034369","plasma lipoprotein particle remodeling" -"GO:0006795","regulation of phosphorus utilization" -"GO:0006564","L-serine biosynthetic process" -"GO:0060145","viral gene silencing in virus induced gene silencing" -"GO:0002530","regulation of systemic arterial blood pressure involved in acute-phase response" -"GO:0070346","positive regulation of fat cell proliferation" -"GO:0097300","programmed necrotic cell death" -"GO:2000137","negative regulation of cell proliferation involved in heart morphogenesis" -"GO:0048147","negative regulation of fibroblast proliferation" -"GO:0035212","cell competition in a multicellular organism" -"GO:0031630","regulation of synaptic vesicle fusion to presynaptic active zone membrane" -"GO:0007521","muscle cell fate determination" -"GO:0010629","negative regulation of gene expression" -"GO:0072097","negative regulation of branch elongation involved in ureteric bud branching by BMP signaling pathway" -"GO:0002411","T cell tolerance induction to tumor cell" -"GO:0032150","ubiquinone biosynthetic process from chorismate" -"GO:0048812","neuron projection morphogenesis" -"GO:0048490","anterograde synaptic vesicle transport" -"GO:0019226","transmission of nerve impulse" -"GO:0061306","DNA strand renaturation involved in double-strand break repair" -"GO:1900370","positive regulation of RNA interference" -"GO:0007096","regulation of exit from mitosis" -"GO:1904179","positive regulation of adipose tissue development" -"GO:0046031","ADP metabolic process" -"GO:0016043","cellular component organization" -"GO:0090179","planar cell polarity pathway involved in neural tube closure" -"GO:0051554","flavonol metabolic process" -"GO:0060592","mammary gland formation" -"GO:0009166","nucleotide catabolic process" -"GO:0071482","cellular response to light stimulus" -"GO:1902475","L-alpha-amino acid transmembrane transport" -"GO:0043017","positive regulation of lymphotoxin A biosynthetic process" -"GO:0042842","D-xylose biosynthetic process" -"GO:0060435","bronchiole development" -"GO:0071554","cell wall organization or biogenesis" -"GO:2001178","positive regulation of mediator complex assembly" -"GO:0045163","clustering of voltage-gated potassium channels" -"GO:0061061","muscle structure development" -"GO:0052776","diacetylchitobiose catabolic process to glucosamine and acetate" -"GO:0071625","vocalization behavior" -"GO:0007267","cell-cell signaling" -"GO:0043982","histone H4-K8 acetylation" -"GO:0042297","vocal learning" -"GO:0060401","cytosolic calcium ion transport" -"GO:0007229","integrin-mediated signaling pathway" -"GO:0019064","fusion of virus membrane with host plasma membrane" -"GO:0045479","vesicle targeting to fusome" -"GO:0010635","regulation of mitochondrial fusion" -"GO:0010118","stomatal movement" -"GO:0042461","photoreceptor cell development" -"GO:0043556","regulation of translation in response to oxidative stress" -"GO:0030260","entry into host cell" -"GO:0043434","response to peptide hormone" -"GO:0090240","positive regulation of histone H4 acetylation" -"GO:0035638","signal maturation" -"GO:0046499","S-adenosylmethioninamine metabolic process" -"GO:0060452","positive regulation of cardiac muscle contraction" -"GO:0045103","intermediate filament-based process" -"GO:0021756","striatum development" -"GO:0090514","L-tyrosine transmembrane import into vacuole" -"GO:0106022","positive regulation of vesicle docking" -"GO:0034130","toll-like receptor 1 signaling pathway" -"GO:0003417","growth plate cartilage development" -"GO:0090707","establishment of plant organ orientation" -"GO:0006146","adenine catabolic process" -"GO:0032330","regulation of chondrocyte differentiation" -"GO:0042339","keratan sulfate metabolic process" -"GO:1904297","positive regulation of osmolarity-sensing cation channel activity" -"GO:0097528","execution phase of necroptosis" -"GO:0002792","negative regulation of peptide secretion" -"GO:0034972","histone H3-R26 methylation" -"GO:0001525","angiogenesis" -"GO:0045494","photoreceptor cell maintenance" -"GO:0035848","oviduct morphogenesis" -"GO:0050428","3'-phosphoadenosine 5'-phosphosulfate biosynthetic process" -"GO:0015959","diadenosine polyphosphate metabolic process" -"GO:0010628","positive regulation of gene expression" -"GO:1900641","negative regulation of austinol biosynthetic process" -"GO:0039530","MDA-5 signaling pathway" -"GO:0008038","neuron recognition" -"GO:1904563","phosphatidylinositol 5-phosphate biosynthetic process" -"GO:0001558","regulation of cell growth" -"GO:0046670","positive regulation of retinal cell programmed cell death" -"GO:0031443","fast-twitch skeletal muscle fiber contraction" -"GO:0006799","polyphosphate biosynthetic process" -"GO:1903808","L-tyrosine import across plasma membrane" -"GO:0000378","RNA exon ligation" -"GO:0052317","camalexin metabolic process" -"GO:0032325","molybdopterin cofactor catabolic process" -"GO:0099525","presynaptic dense core vesicle exocytosis" -"GO:0071893","BMP signaling pathway involved in nephric duct formation" -"GO:0072192","ureter epithelial cell differentiation" -"GO:2001133","methane biosynthetic process from methanethiol" -"GO:0006220","pyrimidine nucleotide metabolic process" -"GO:0035984","cellular response to trichostatin A" -"GO:1904498","protein localization to mitotic actomyosin contractile ring" -"GO:2000005","negative regulation of metanephric S-shaped body morphogenesis" -"GO:0036490","regulation of translation in response to endoplasmic reticulum stress" -"GO:0071451","cellular response to superoxide" -"GO:0097284","hepatocyte apoptotic process" -"GO:0021794","thalamus development" -"GO:1903551","regulation of extracellular exosome assembly" -"GO:0003185","sinoatrial valve morphogenesis" -"GO:0009262","deoxyribonucleotide metabolic process" -"GO:0010084","specification of animal organ axis polarity" -"GO:0043984","histone H4-K16 acetylation" -"GO:0007412","axon target recognition" -"GO:0048201","vesicle targeting, plasma membrane to endosome" -"GO:2001015","negative regulation of skeletal muscle cell differentiation" -"GO:1904195","regulation of granulosa cell proliferation" -"GO:0008616","queuosine biosynthetic process" -"GO:0019046","release from viral latency" -"GO:0021761","limbic system development" -"GO:0007500","mesodermal cell fate determination" -"GO:0006148","inosine catabolic process" -"GO:0009951","polarity specification of dorsal/ventral axis" -"GO:0019362","pyridine nucleotide metabolic process" -"GO:0140025","contractile vacuole tethering involved in discharge" -"GO:0044088","regulation of vacuole organization" -"GO:0060297","regulation of sarcomere organization" -"GO:0046682","response to cyclodiene" -"GO:0010256","endomembrane system organization" -"GO:0060833","Wnt signaling pathway involved in animal/vegetal axis specification" -"GO:0061437","renal system vasculature development" -"GO:1901116","cephamycin C metabolic process" -"GO:1902759","Mo(VI)-molybdopterin cytosine dinucleotide metabolic process" -"GO:1901354","response to L-canavanine" -"GO:0075307","positive regulation of conidium formation" -"GO:0072160","nephron tubule epithelial cell differentiation" -"GO:1905743","calcium import into the mitochondrion involved in negative regulation of presynaptic cytosolic calcium concentration" -"GO:0061151","BMP signaling pathway involved in renal system segmentation" -"GO:1905072","cardiac jelly development" -"GO:0003138","primary heart field specification" -"GO:0043989","histone H4-S1 phosphorylation" -"GO:0090309","positive regulation of methylation-dependent chromatin silencing" -"GO:0038101","sequestering of nodal from receptor via nodal binding" -"GO:0030202","heparin metabolic process" -"GO:0035331","negative regulation of hippo signaling" -"GO:1902744","negative regulation of lamellipodium organization" -"GO:0003229","ventricular cardiac muscle tissue development" -"GO:0072125","negative regulation of glomerular mesangial cell proliferation" -"GO:1905563","negative regulation of vascular endothelial cell proliferation" -"GO:0048199","vesicle targeting, to, from or within Golgi" -"GO:0006163","purine nucleotide metabolic process" -"GO:1904172","positive regulation of bleb assembly" -"GO:0010286","heat acclimation" -"GO:0070542","response to fatty acid" -"GO:0009944","polarity specification of adaxial/abaxial axis" -"GO:0043981","histone H4-K5 acetylation" -"GO:0070342","brown fat cell proliferation" -"GO:0048232","male gamete generation" -"GO:0007442","hindgut morphogenesis" -"GO:0097719","neural tissue regeneration" -"GO:0002891","positive regulation of immunoglobulin mediated immune response" -"GO:0046134","pyrimidine nucleoside biosynthetic process" -"GO:1900054","positive regulation of retinoic acid biosynthetic process" -"GO:0030033","microvillus assembly" -"GO:1905442","cellular response to chondroitin 4'-sulfate" -"GO:0033231","carbohydrate export" -"GO:0071416","cellular response to tropane" -"GO:0042481","regulation of odontogenesis" -"GO:0007468","regulation of rhodopsin gene expression" -"GO:0042198","nylon metabolic process" -"GO:0046813","receptor-mediated virion attachment to host cell" -"GO:0018891","cyclohexanol metabolic process" -"GO:0019467","ornithine catabolic process, by decarboxylation" -"GO:0002694","regulation of leukocyte activation" -"GO:1904352","positive regulation of protein catabolic process in the vacuole" -"GO:0016134","saponin metabolic process" -"GO:0072710","response to hydroxyurea" -"GO:0043369","CD4-positive or CD8-positive, alpha-beta T cell lineage commitment" -"GO:0033168","conversion of ds siRNA to ss siRNA involved in RNA interference" -"GO:1904642","cellular response to dinitrophenol" -"GO:0090252","epithelium migration involved in imaginal disc-derived wing morphogenesis" -"GO:1905231","cellular response to borneol" -"GO:0015941","pantothenate catabolic process" -"GO:0070936","protein K48-linked ubiquitination" -"GO:0018981","triethanolamine metabolic process" -"GO:0048745","smooth muscle tissue development" -"GO:0006393","termination of mitochondrial transcription" -"GO:0036404","conversion of ds siRNA to ss siRNA" -"GO:0097039","protein linear polyubiquitination" -"GO:0021919","BMP signaling pathway involved in spinal cord dorsal/ventral patterning" -"GO:0035115","embryonic forelimb morphogenesis" -"GO:0071380","cellular response to prostaglandin E stimulus" -"GO:1901119","tobramycin metabolic process" -"GO:0019646","aerobic electron transport chain" -"GO:2000057","negative regulation of Wnt signaling pathway involved in digestive tract morphogenesis" -"GO:0018905","dimethyl ether metabolic process" -"GO:0044854","plasma membrane raft assembly" -"GO:0061462","protein localization to lysosome" -"GO:0014906","myotube cell development involved in skeletal muscle regeneration" -"GO:2000709","regulation of maintenance of meiotic sister chromatid cohesion, centromeric" -"GO:0014706","striated muscle tissue development" -"GO:0070480","exonucleolytic nuclear-transcribed mRNA catabolic process involved in deadenylation-independent decay" -"GO:0042197","halogenated hydrocarbon metabolic process" -"GO:0033302","quercetin O-glucoside metabolic process" -"GO:2001140","positive regulation of phospholipid transport" -"GO:0072731","cellular response to papulacandin B" -"GO:1903953","negative regulation of voltage-gated potassium channel activity involved in atrial cardiac muscle cell action potential repolarization" -"GO:0060168","positive regulation of adenosine receptor signaling pathway" -"GO:0045445","myoblast differentiation" -"GO:1904561","cellular response to diphenidol" -"GO:0071235","cellular response to proline" -"GO:0071217","cellular response to external biotic stimulus" -"GO:0010482","regulation of epidermal cell division" -"GO:0006785","heme b biosynthetic process" -"GO:0072136","metanephric mesenchymal cell proliferation involved in metanephros development" -"GO:0071954","chemokine (C-C motif) ligand 11 production" -"GO:0034213","quinolinate catabolic process" -"GO:0071304","cellular response to vitamin B6" -"GO:1903682","negative regulation of epithelial cell-cell adhesion involved in epithelium migration" -"GO:0006662","glycerol ether metabolic process" -"GO:0043372","positive regulation of CD4-positive, alpha-beta T cell differentiation" -"GO:0061511","centriole elongation" -"GO:0035712","T-helper 2 cell activation" -"GO:0021938","smoothened signaling pathway involved in regulation of cerebellar granule cell precursor cell proliferation" -"GO:0060338","regulation of type I interferon-mediated signaling pathway" -"GO:0061277","mesonephric nephron tubule formation" -"GO:0060738","epithelial-mesenchymal signaling involved in prostate gland development" -"GO:0002152","bile acid conjugation" -"GO:1905725","protein localization to microtubule end" -"GO:0018939","n-octane metabolic process" -"GO:0032376","positive regulation of cholesterol transport" -"GO:0033140","negative regulation of peptidyl-serine phosphorylation of STAT protein" -"GO:0072763","cellular response to hesperadin" -"GO:0050691","regulation of defense response to virus by host" -"GO:0042307","positive regulation of protein import into nucleus" -"GO:0051395","negative regulation of nerve growth factor receptor activity" -"GO:0018280","protein S-linked glycosylation" -"GO:0018926","methanesulfonic acid metabolic process" -"GO:0018864","acetylene metabolic process" -"GO:0048645","animal organ formation" -"GO:0007169","transmembrane receptor protein tyrosine kinase signaling pathway" -"GO:1902889","protein localization to spindle microtubule" -"GO:2000718","regulation of maintenance of mitotic sister chromatid cohesion, centromeric" -"GO:0033581","protein galactosylation in Golgi" -"GO:0070378","positive regulation of ERK5 cascade" -"GO:0097501","stress response to metal ion" -"GO:1902207","positive regulation of interleukin-2-mediated signaling pathway" -"GO:0060458","right lung development" -"GO:0009228","thiamine biosynthetic process" -"GO:0045841","negative regulation of mitotic metaphase/anaphase transition" -"GO:0038168","epidermal growth factor receptor signaling pathway via I-kappaB kinase/NF-kappaB cascade" -"GO:0018902","1,3-dichloro-2-propanol metabolic process" -"GO:0030539","male genitalia development" -"GO:0100018","regulation of glucose import by transcription from RNA polymerase II promoter" -"GO:0035136","forelimb morphogenesis" -"GO:0032648","regulation of interferon-beta production" -"GO:0098912","membrane depolarization during atrial cardiac muscle cell action potential" -"GO:0070084","protein initiator methionine removal" -"GO:0033762","response to glucagon" -"GO:0002698","negative regulation of immune effector process" -"GO:0000011","vacuole inheritance" -"GO:0018282","metal incorporation into metallo-sulfur cluster" -"GO:0090180","positive regulation of thiamine biosynthetic process" -"GO:1905449","regulation of Fc-gamma receptor signaling pathway involved in phagocytosis" -"GO:0090051","negative regulation of cell migration involved in sprouting angiogenesis" -"GO:0033590","response to cobalamin" -"GO:1904905","negative regulation of endothelial cell-matrix adhesion via fibronectin" -"GO:1903576","response to L-arginine" -"GO:0048133","male germ-line stem cell asymmetric division" -"GO:0042033","chemokine biosynthetic process" -"GO:1900958","positive regulation of 17-methylnonadec-1-ene biosynthetic process" -"GO:0015113","nitrite transmembrane transporter activity" -"GO:0042983","amyloid precursor protein biosynthetic process" -"GO:0060763","mammary duct terminal end bud growth" -"GO:0072672","neutrophil extravasation" -"GO:1904358","positive regulation of telomere maintenance via telomere lengthening" -"GO:1990091","sodium-dependent self proteolysis" -"GO:0000302","response to reactive oxygen species" -"GO:0030324","lung development" -"GO:0007160","cell-matrix adhesion" -"GO:1901579","positive regulation of alkane biosynthetic process" -"GO:0033343","positive regulation of collagen binding" -"GO:0036368","cone photoresponse recovery" -"GO:0005452","inorganic anion exchanger activity" -"GO:1990092","calcium-dependent self proteolysis" -"GO:0051725","protein de-ADP-ribosylation" -"GO:1900568","chanoclavine-I aldehyde catabolic process" -"GO:1900703","positive regulation of orcinol biosynthetic process" -"GO:0014076","response to fluoxetine" -"GO:1903966","monounsaturated fatty acid biosynthetic process" -"GO:0044179","hemolysis in other organism" -"GO:0060036","notochord cell vacuolation" -"GO:0071505","response to mycophenolic acid" -"GO:0090311","regulation of protein deacetylation" -"GO:0046944","protein carbamoylation" -"GO:1900666","positive regulation of emodin biosynthetic process" -"GO:0106091","glial cell projection elongation" -"GO:0005278","acetylcholine:proton antiporter activity" -"GO:1901843","positive regulation of high voltage-gated calcium channel activity" -"GO:0001889","liver development" -"GO:1904325","positive regulation of inhibitory G-protein coupled receptor phosphorylation" -"GO:0021650","vestibulocochlear nerve formation" -"GO:1904635","positive regulation of glomerular visceral epithelial cell apoptotic process" -"GO:0016598","protein arginylation" -"GO:0045577","regulation of B cell differentiation" -"GO:0050864","regulation of B cell activation" -"GO:0035747","natural killer cell chemotaxis" -"GO:0016260","selenocysteine biosynthetic process" -"GO:1901385","regulation of voltage-gated calcium channel activity" -"GO:0019085","early viral transcription" -"GO:1900090","positive regulation of inositol biosynthetic process" -"GO:0018411","protein glucuronidation" -"GO:0007395","dorsal closure, spreading of leading edge cells" -"GO:0032967","positive regulation of collagen biosynthetic process" -"GO:1904966","positive regulation of vitamin E biosynthetic process" -"GO:0018215","protein phosphopantetheinylation" -"GO:0100003","positive regulation of sodium ion transport by transcription from RNA polymerase II promoter" -"GO:2000594","positive regulation of metanephric DCT cell differentiation" -"GO:0070828","heterochromatin organization" -"GO:0009704","de-etiolation" -"GO:1901323","response to erythromycin" -"GO:0051333","meiotic nuclear envelope reassembly" -"GO:0010801","negative regulation of peptidyl-threonine phosphorylation" -"GO:0018249","protein dehydration" -"GO:0019231","perception of static position" -"GO:0021633","optic nerve structural organization" -"GO:1901860","positive regulation of mitochondrial DNA metabolic process" -"GO:0035166","post-embryonic hemopoiesis" -"GO:0018032","protein amidation" -"GO:0014732","skeletal muscle atrophy" -"GO:1900138","negative regulation of phospholipase A2 activity" -"GO:1904879","positive regulation of calcium ion transmembrane transport via high voltage-gated calcium channel" -"GO:0038088","VEGF-activated platelet-derived growth factor receptor-beta signaling pathway" -"GO:1900863","positive regulation of cordyol C biosynthetic process" -"GO:0061423","positive regulation of sodium ion transport by positive regulation of transcription from RNA polymerase II promoter" -"GO:0010117","photoprotection" -"GO:1903027","regulation of opsonization" -"GO:0035754","B cell chemotaxis" -"GO:0021525","lateral motor column neuron differentiation" -"GO:2000764","positive regulation of semaphorin-plexin signaling pathway involved in outflow tract morphogenesis" -"GO:0031637","regulation of neuronal synaptic plasticity in response to neurotrophin" -"GO:0007088","regulation of mitotic nuclear division" -"GO:1903425","fluoride transmembrane transporter activity" -"GO:1900657","positive regulation of diorcinol biosynthetic process" -"GO:0010923","negative regulation of phosphatase activity" -"GO:0006469","negative regulation of protein kinase activity" -"GO:0046548","retinal rod cell development" -"GO:0009609","response to symbiotic bacterium" -"GO:1901197","positive regulation of calcium-mediated signaling involved in cellular response to calcium ion" -"GO:0060979","vasculogenesis involved in coronary vascular morphogenesis" -"GO:0018193","peptidyl-amino acid modification" -"GO:1903671","negative regulation of sprouting angiogenesis" -"GO:0070278","extracellular matrix constituent secretion" -"GO:0072503","cellular divalent inorganic cation homeostasis" -"GO:1900937","positive regulation of nonadec-1-ene biosynthetic process" -"GO:0043409","negative regulation of MAPK cascade" -"GO:0006729","tetrahydrobiopterin biosynthetic process" -"GO:2000425","regulation of apoptotic cell clearance" -"GO:0008543","fibroblast growth factor receptor signaling pathway" -"GO:1900654","positive regulation of demethylkotanin biosynthetic process" -"GO:0071871","response to epinephrine" -"GO:0018322","protein tyrosinylation" -"GO:0008626","granzyme-mediated apoptotic signaling pathway" -"GO:0044619","positive regulation of relaxation of uterine smooth muscle in other organism" -"GO:0019926","peptidyl-tryptophan oxidation to tryptophyl quinone" -"GO:1900706","positive regulation of siderophore biosynthetic process" -"GO:0038065","collagen-activated signaling pathway" -"GO:0017014","protein nitrosylation" -"GO:0045132","meiotic chromosome segregation" -"GO:1901558","response to metformin" -"GO:0061360","optic chiasma development" -"GO:0072244","metanephric glomerular epithelium development" -"GO:0042094","interleukin-2 biosynthetic process" -"GO:1900084","regulation of peptidyl-tyrosine autophosphorylation" -"GO:0042422","norepinephrine catabolic process" -"GO:0015114","phosphate ion transmembrane transporter activity" -"GO:1900857","positive regulation of fumitremorgin B biosynthetic process" -"GO:0045329","carnitine biosynthetic process" -"GO:0017006","protein-tetrapyrrole linkage" -"GO:0042253","granulocyte macrophage colony-stimulating factor biosynthetic process" -"GO:0032355","response to estradiol" -"GO:2000789","positive regulation of venous endothelial cell fate commitment" -"GO:0061523","cilium disassembly" -"GO:1900694","positive regulation of (+)-kotanin biosynthetic process" -"GO:1902455","negative regulation of stem cell population maintenance" -"GO:0097576","vacuole fusion" -"GO:0080171","lytic vacuole organization" -"GO:0060815","regulation of translation involved in anterior/posterior axis specification" -"GO:0080139","borate efflux transmembrane transporter activity" -"GO:1990066","energy quenching" -"GO:0009637","response to blue light" -"GO:0051066","dihydrobiopterin metabolic process" -"GO:0120126","response to copper ion starvation" -"GO:1900824","positive regulation of ergot alkaloid biosynthetic process" -"GO:0015104","antimonite transmembrane transporter activity" -"GO:0080058","protein deglutathionylation" -"GO:0046330","positive regulation of JNK cascade" -"GO:0007155","cell adhesion" -"GO:1990019","protein storage vacuole organization" -"GO:0052231","modulation of phagocytosis in other organism involved in symbiotic interaction" -"GO:2000836","positive regulation of androgen secretion" -"GO:1905152","positive regulation of voltage-gated sodium channel activity" -"GO:1900982","positive regulation of phenazine biosynthetic process" -"GO:0017013","protein flavinylation" -"GO:1904754","positive regulation of vascular associated smooth muscle cell migration" -"GO:0060099","regulation of phagocytosis, engulfment" -"GO:1904986","positive regulation of quinolinate biosynthetic process" -"GO:0018065","protein-cofactor linkage" -"GO:0010903","negative regulation of very-low-density lipoprotein particle remodeling" -"GO:0072709","cellular response to sorbitol" -"GO:0045200","establishment of neuroblast polarity" -"GO:1901586","negative regulation of acid-sensing ion channel activity" -"GO:2000816","negative regulation of mitotic sister chromatid separation" -"GO:0042331","phototaxis" -"GO:0002679","respiratory burst involved in defense response" -"GO:0071873","response to norepinephrine" -"GO:1900848","positive regulation of naphtho-gamma-pyrone biosynthetic process" -"GO:0031365","N-terminal protein amino acid modification" -"GO:0045974","regulation of translation, ncRNA-mediated" -"GO:0010025","wax biosynthetic process" -"GO:0022027","interkinetic nuclear migration" -"GO:0015446","ATPase-coupled arsenite transmembrane transporter activity" -"GO:0015107","chlorate transmembrane transporter activity" -"GO:0001914","regulation of T cell mediated cytotoxicity" -"GO:0035601","protein deacylation" -"GO:0030813","positive regulation of nucleotide catabolic process" -"GO:0006559","L-phenylalanine catabolic process" -"GO:0019516","lactate oxidation" -"GO:0072305","negative regulation of mesenchymal cell apoptotic process involved in metanephric nephron morphogenesis" -"GO:0021852","pyramidal neuron migration" -"GO:1990169","stress response to copper ion" -"GO:0046398","UDP-glucuronate metabolic process" -"GO:0021898","commitment of multipotent stem cells to neuronal lineage in forebrain" -"GO:1900800","cspyrone B1 metabolic process" -"GO:0060476","protein localization involved in acrosome reaction" -"GO:0070902","mitochondrial tRNA pseudouridine synthesis" -"GO:0040036","regulation of fibroblast growth factor receptor signaling pathway" -"GO:0061590","calcium activated phosphatidylcholine scrambling" -"GO:0098886","modification of dendritic spine" -"GO:0002869","positive regulation of B cell deletion" -"GO:0007377","germ-band extension" -"GO:0036321","ghrelin secretion" -"GO:0097172","N-acetylmuramic acid metabolic process" -"GO:0006206","pyrimidine nucleobase metabolic process" -"GO:1902656","calcium ion import into cytosol" -"GO:0042921","glucocorticoid receptor signaling pathway" -"GO:0043330","response to exogenous dsRNA" -"GO:0030822","positive regulation of cAMP catabolic process" -"GO:0001649","osteoblast differentiation" -"GO:0048344","paraxial mesodermal cell fate determination" -"GO:0031940","positive regulation of chromatin silencing at telomere" -"GO:0010225","response to UV-C" -"GO:0033280","response to vitamin D" -"GO:0021947","outward migration of deep nuclear neurons" -"GO:0099601","regulation of neurotransmitter receptor activity" -"GO:0055048","anastral spindle assembly" -"GO:0046425","regulation of JAK-STAT cascade" -"GO:0030397","membrane disassembly" -"GO:0052701","cellular modified histidine metabolic process" -"GO:0031408","oxylipin biosynthetic process" -"GO:0100014","positive regulation of mating type switching by transcription from RNA polymerase II promoter" -"GO:1904932","negative regulation of cartilage condensation" -"GO:0034138","toll-like receptor 3 signaling pathway" -"GO:0000456","dimethylation involved in SSU-rRNA maturation" -"GO:0019264","glycine biosynthetic process from serine" -"GO:1903347","negative regulation of bicellular tight junction assembly" -"GO:0001958","endochondral ossification" -"GO:1990172","G-protein coupled receptor catabolic process" -"GO:0003249","cell proliferation involved in heart valve morphogenesis" -"GO:0002839","positive regulation of immune response to tumor cell" -"GO:0045137","development of primary sexual characteristics" -"GO:1904840","positive regulation of male germ-line stem cell asymmetric division" -"GO:0048074","negative regulation of eye pigmentation" -"GO:1905300","positive regulation of intestinal epithelial cell development" -"GO:0006501","C-terminal protein lipidation" -"GO:1905356","regulation of snRNA pseudouridine synthesis" -"GO:0046947","hydroxylysine biosynthetic process" -"GO:0008154","actin polymerization or depolymerization" -"GO:0038098","sequestering of BMP from receptor via BMP binding" -"GO:0021948","inward migration of deep nuclear neurons" -"GO:0003406","retinal pigment epithelium development" -"GO:0003295","cell proliferation involved in atrial ventricular junction remodeling" -"GO:0071699","olfactory placode morphogenesis" -"GO:0002864","regulation of acute inflammatory response to antigenic stimulus" -"GO:0048314","embryo sac morphogenesis" -"GO:1901253","negative regulation of intracellular transport of viral material" -"GO:1901481","L-glutamate import involved in cellular response to nitrogen starvation" -"GO:0045351","type I interferon biosynthetic process" -"GO:0060488","orthogonal dichotomous subdivision of terminal units involved in lung branching morphogenesis" -"GO:0010593","negative regulation of lamellipodium assembly" -"GO:0042226","interleukin-6 biosynthetic process" -"GO:0036337","Fas signaling pathway" -"GO:2000749","positive regulation of chromatin silencing at rDNA" -"GO:0035050","embryonic heart tube development" -"GO:0072741","protein localization to cell division site" -"GO:2001239","regulation of extrinsic apoptotic signaling pathway in absence of ligand" -"GO:0046677","response to antibiotic" -"GO:0034499","late endosome to Golgi transport" -"GO:0003163","sinoatrial node development" -"GO:0036269","swimming behavior" -"GO:0035046","pronuclear migration" -"GO:0003393","neuron migration involved in retrograde extension" -"GO:0051384","response to glucocorticoid" -"GO:1905676","positive regulation of adaptive immune memory response" -"GO:0021654","rhombomere boundary formation" -"GO:0007312","oocyte nucleus migration involved in oocyte dorsal/ventral axis specification" -"GO:0036051","protein localization to trailing edge" -"GO:0001704","formation of primary germ layer" -"GO:0060028","convergent extension involved in axis elongation" -"GO:0046780","suppression by virus of host mRNA splicing" -"GO:0042661","regulation of mesodermal cell fate specification" -"GO:0060123","regulation of growth hormone secretion" -"GO:1901692","regulation of compound eye retinal cell apoptotic process" -"GO:1990153","maintenance of protein localization to heterochromatin" -"GO:0003150","muscular septum morphogenesis" -"GO:0018333","enzyme active site formation via O-phospho-L-threonine" -"GO:1902613","negative regulation of anti-Mullerian hormone signaling pathway" -"GO:0046588","negative regulation of calcium-dependent cell-cell adhesion" -"GO:1990294","peptidyl-threonine trans-autophosphorylation" -"GO:0008592","regulation of Toll signaling pathway" -"GO:0051969","regulation of transmission of nerve impulse" -"GO:1904937","sensory neuron migration" -"GO:0006213","pyrimidine nucleoside metabolic process" -"GO:0046400","keto-3-deoxy-D-manno-octulosonic acid metabolic process" -"GO:0045812","negative regulation of Wnt signaling pathway, calcium modulating pathway" -"GO:0003301","physiological cardiac muscle hypertrophy" -"GO:0009187","cyclic nucleotide metabolic process" -"GO:1900841","negative regulation of helvolic acid biosynthetic process" -"GO:0043134","regulation of hindgut contraction" -"GO:2000531","regulation of fatty acid biosynthetic process by regulation of transcription from RNA polymerase II promoter" -"GO:0002258","positive regulation of kinin cascade" -"GO:2000397","positive regulation of ubiquitin-dependent endocytosis" -"GO:0032100","positive regulation of appetite" -"GO:0006226","dUMP biosynthetic process" -"GO:0001171","reverse transcription" -"GO:0035190","syncytial nuclear migration" -"GO:0035521","monoubiquitinated histone deubiquitination" -"GO:0032011","ARF protein signal transduction" -"GO:0032474","otolith morphogenesis" -"GO:0003006","developmental process involved in reproduction" -"GO:0032829","regulation of CD4-positive, CD25-positive, alpha-beta regulatory T cell differentiation" -"GO:0043397","regulation of corticotropin-releasing hormone secretion" -"GO:0097695","establishment of protein-containing complex localization to telomere" -"GO:0090163","establishment of epithelial cell planar polarity" -"GO:0097396","response to interleukin-17" -"GO:0035063","nuclear speck organization" -"GO:0090272","negative regulation of fibroblast growth factor production" -"GO:0032691","negative regulation of interleukin-1 beta production" -"GO:0090110","cargo loading into COPII-coated vesicle" -"GO:1905333","regulation of gastric motility" -"GO:0003263","cardioblast proliferation" -"GO:0090367","negative regulation of mRNA modification" -"GO:0002877","regulation of acute inflammatory response to non-antigenic stimulus" -"GO:0002776","antimicrobial peptide secretion" -"GO:1904060","negative regulation of locomotor rhythm" -"GO:1990151","protein localization to cell tip" -"GO:1904000","positive regulation of eating behavior" -"GO:0030450","regulation of complement activation, classical pathway" -"GO:0031119","tRNA pseudouridine synthesis" -"GO:0002042","cell migration involved in sprouting angiogenesis" -"GO:0006282","regulation of DNA repair" -"GO:0035405","histone-threonine phosphorylation" -"GO:1904710","positive regulation of granulosa cell apoptotic process" -"GO:0097476","spinal cord motor neuron migration" -"GO:1990481","mRNA pseudouridine synthesis" -"GO:0060220","camera-type eye photoreceptor cell fate commitment" -"GO:0044578","butyryl-CoA biosynthetic process" -"GO:0045904","negative regulation of translational termination" -"GO:0060300","regulation of cytokine activity" -"GO:0048826","cotyledon morphogenesis" -"GO:0051324","prophase" -"GO:0071888","macrophage apoptotic process" -"GO:1904936","interneuron migration" -"GO:0035113","embryonic appendage morphogenesis" -"GO:0046394","carboxylic acid biosynthetic process" -"GO:0098863","nuclear migration by microtubule mediated pushing forces" -"GO:0051606","detection of stimulus" -"GO:0016048","detection of temperature stimulus" -"GO:0090327","negative regulation of locomotion involved in locomotory behavior" -"GO:0046841","trisporic acid metabolic process" -"GO:0072498","embryonic skeletal joint development" -"GO:1904468","negative regulation of tumor necrosis factor secretion" -"GO:0019389","glucuronoside metabolic process" -"GO:0006029","proteoglycan metabolic process" -"GO:0034478","phosphatidylglycerol catabolic process" -"GO:0006518","peptide metabolic process" -"GO:0071529","cementum mineralization" -"GO:0033085","negative regulation of T cell differentiation in thymus" -"GO:0099187","presynaptic cytoskeleton organization" -"GO:0071827","plasma lipoprotein particle organization" -"GO:0045409","negative regulation of interleukin-6 biosynthetic process" -"GO:0050813","epothilone metabolic process" -"GO:0010960","magnesium ion homeostasis" -"GO:0038194","thyroid-stimulating hormone signaling pathway" -"GO:0003418","growth plate cartilage chondrocyte differentiation" -"GO:0035762","dorsal motor nucleus of vagus nerve morphogenesis" -"GO:0030334","regulation of cell migration" -"GO:0048371","lateral mesodermal cell differentiation" -"GO:0009611","response to wounding" -"GO:0015774","polysaccharide transport" -"GO:0061051","positive regulation of cell growth involved in cardiac muscle cell development" -"GO:2000158","positive regulation of ubiquitin-specific protease activity" -"GO:0106074","aminoacyl-tRNA metabolism involved in translational fidelity" -"GO:1900118","negative regulation of execution phase of apoptosis" -"GO:0046009","positive regulation of female receptivity, post-mating" -"GO:0046430","non-phosphorylated glucose metabolic process" -"GO:0015180","L-alanine transmembrane transporter activity" -"GO:0048613","embryonic ectodermal digestive tract morphogenesis" -"GO:0055008","cardiac muscle tissue morphogenesis" -"GO:0071275","cellular response to aluminum ion" -"GO:0043639","benzoate catabolic process" -"GO:0022038","corpus callosum development" -"GO:0070373","negative regulation of ERK1 and ERK2 cascade" -"GO:1901142","insulin metabolic process" -"GO:2000074","regulation of type B pancreatic cell development" -"GO:0030154","cell differentiation" -"GO:0022010","central nervous system myelination" -"GO:1905460","negative regulation of vascular associated smooth muscle cell apoptotic process" -"GO:0003424","establishment of cell polarity involved in growth plate cartilage chondrocyte division" -"GO:0006859","extracellular carbohydrate transport" -"GO:0030650","peptide antibiotic metabolic process" -"GO:0019650","glycolytic fermentation to butanediol" -"GO:0043525","positive regulation of neuron apoptotic process" -"GO:0060548","negative regulation of cell death" -"GO:0006548","histidine catabolic process" -"GO:0002359","B-1 B cell proliferation" -"GO:0048194","Golgi vesicle budding" -"GO:0070430","positive regulation of nucleotide-binding oligomerization domain containing 1 signaling pathway" -"GO:0006699","bile acid biosynthetic process" -"GO:1902341","xylitol transport" -"GO:0034316","negative regulation of Arp2/3 complex-mediated actin nucleation" -"GO:0048798","swim bladder inflation" -"GO:0000291","nuclear-transcribed mRNA catabolic process, exonucleolytic" -"GO:0046135","pyrimidine nucleoside catabolic process" -"GO:0072210","metanephric nephron development" -"GO:0010908","regulation of heparan sulfate proteoglycan biosynthetic process" -"GO:0043489","RNA stabilization" -"GO:0043200","response to amino acid" -"GO:0060426","lung vasculature development" -"GO:0070874","negative regulation of glycogen metabolic process" -"GO:2000226","regulation of pancreatic A cell differentiation" -"GO:0007252","I-kappaB phosphorylation" -"GO:0050867","positive regulation of cell activation" -"GO:0030323","respiratory tube development" -"GO:2000730","regulation of termination of RNA polymerase I transcription" -"GO:0003206","cardiac chamber morphogenesis" -"GO:0015797","mannitol transport" -"GO:0044850","menstrual cycle" -"GO:0034637","cellular carbohydrate biosynthetic process" -"GO:0070813","hydrogen sulfide metabolic process" -"GO:0050884","neuromuscular process controlling posture" -"GO:0034470","ncRNA processing" -"GO:0097070","ductus arteriosus closure" -"GO:0010560","positive regulation of glycoprotein biosynthetic process" -"GO:2000262","positive regulation of blood coagulation, common pathway" -"GO:0048856","anatomical structure development" -"GO:0030656","regulation of vitamin metabolic process" -"GO:0042252","establishment of planar polarity of larval imaginal disc epithelium" -"GO:0045958","positive regulation of complement activation, alternative pathway" -"GO:0060052","neurofilament cytoskeleton organization" -"GO:0072048","renal system pattern specification" -"GO:0003231","cardiac ventricle development" -"GO:0097082","vascular smooth muscle cell fate specification" -"GO:0015991","ATP hydrolysis coupled proton transport" -"GO:0060785","regulation of apoptosis involved in tissue homeostasis" -"GO:0015796","galactitol transport" -"GO:0051496","positive regulation of stress fiber assembly" -"GO:1904833","positive regulation of removal of superoxide radicals" -"GO:0045666","positive regulation of neuron differentiation" -"GO:0031024","interphase microtubule organizing center assembly" -"GO:0070366","regulation of hepatocyte differentiation" -"GO:0002254","kinin cascade" -"GO:0010729","positive regulation of hydrogen peroxide biosynthetic process" -"GO:0051385","response to mineralocorticoid" -"GO:0000226","microtubule cytoskeleton organization" -"GO:0051573","negative regulation of histone H3-K9 methylation" -"GO:0032516","positive regulation of phosphoprotein phosphatase activity" -"GO:0048750","compound eye corneal lens morphogenesis" -"GO:0008544","epidermis development" -"GO:0045332","phospholipid translocation" -"GO:1900017","positive regulation of cytokine production involved in inflammatory response" -"GO:0007519","skeletal muscle tissue development" -"GO:0045977","positive regulation of mitotic cell cycle, embryonic" -"GO:0070886","positive regulation of calcineurin-NFAT signaling cascade" -"GO:0052305","positive regulation by organism of innate immune response in other organism involved in symbiotic interaction" -"GO:0034059","response to anoxia" -"GO:1904720","regulation of mRNA endonucleolytic cleavage involved in unfolded protein response" -"GO:0060154","cellular process regulating host cell cycle in response to virus" -"GO:0072046","establishment of planar polarity involved in nephron morphogenesis" -"GO:0050702","interleukin-1 beta secretion" -"GO:0030710","regulation of border follicle cell delamination" -"GO:0030510","regulation of BMP signaling pathway" -"GO:1902324","positive regulation of methyl-branched fatty acid biosynthetic process" -"GO:0072277","metanephric glomerular capillary formation" -"GO:0019374","galactolipid metabolic process" -"GO:0022037","metencephalon development" -"GO:1900227","positive regulation of NLRP3 inflammasome complex assembly" -"GO:0050941","negative regulation of pigment cell differentiation" -"GO:0019664","mixed acid fermentation" -"GO:1901878","positive regulation of calcium ion binding" -"GO:0006618","SRP-dependent cotranslational protein targeting to membrane, signal sequence processing" -"GO:0070318","positive regulation of G0 to G1 transition" -"GO:0032700","negative regulation of interleukin-17 production" -"GO:0001870","positive regulation of complement activation, lectin pathway" -"GO:0007164","establishment of tissue polarity" -"GO:0045815","positive regulation of gene expression, epigenetic" -"GO:0098780","response to mitochondrial depolarisation" -"GO:0051476","mannosylglycerate transport" -"GO:0043462","regulation of ATPase activity" -"GO:2001183","negative regulation of interleukin-12 secretion" -"GO:0009441","glycolate metabolic process" -"GO:0014718","positive regulation of satellite cell activation involved in skeletal muscle regeneration" -"GO:0010791","DNA double-strand break processing involved in repair via synthesis-dependent strand annealing" -"GO:1902857","positive regulation of non-motile cilium assembly" -"GO:0097080","plasma membrane selenite transport" -"GO:0045123","cellular extravasation" -"GO:0014856","skeletal muscle cell proliferation" -"GO:0050710","negative regulation of cytokine secretion" -"GO:0060461","right lung morphogenesis" -"GO:1902757","bis(molybdopterin guanine dinucleotide)molybdenum metabolic process" -"GO:0006212","uracil catabolic process" -"GO:0009749","response to glucose" -"GO:1990074","polyuridylation-dependent mRNA catabolic process" -"GO:1990787","negative regulation of hh target transcription factor activity" -"GO:0032715","negative regulation of interleukin-6 production" -"GO:0060332","positive regulation of response to interferon-gamma" -"GO:0032707","negative regulation of interleukin-23 production" -"GO:0003416","endochondral bone growth" -"GO:1903862","positive regulation of oxidative phosphorylation" -"GO:0090698","post-embryonic plant morphogenesis" -"GO:1905715","regulation of cornification" -"GO:1905465","regulation of G-quadruplex DNA unwinding" -"GO:0007568","aging" -"GO:1905220","negative regulation of platelet formation" -"GO:1901249","regulation of lung goblet cell differentiation" -"GO:0033540","fatty acid beta-oxidation using acyl-CoA oxidase" -"GO:0010016","shoot system morphogenesis" -"GO:0033189","response to vitamin A" -"GO:0061439","kidney vasculature morphogenesis" -"GO:1904075","positive regulation of trophectodermal cell proliferation" -"GO:1901373","lipid hydroperoxide transport" -"GO:2000418","positive regulation of eosinophil migration" -"GO:0042755","eating behavior" -"GO:0071897","DNA biosynthetic process" -"GO:0002691","regulation of cellular extravasation" -"GO:0045416","positive regulation of interleukin-8 biosynthetic process" -"GO:0001502","cartilage condensation" -"GO:0097275","cellular ammonia homeostasis" -"GO:0030970","retrograde protein transport, ER to cytosol" -"GO:0048321","axial mesodermal cell differentiation" -"GO:0010976","positive regulation of neuron projection development" -"GO:1900483","regulation of protein targeting to vacuolar membrane" -"GO:0043280","positive regulation of cysteine-type endopeptidase activity involved in apoptotic process" -"GO:0046150","melanin catabolic process" -"GO:0031288","sorocarp morphogenesis" -"GO:1904250","positive regulation of age-related resistance" -"GO:0009401","phosphoenolpyruvate-dependent sugar phosphotransferase system" -"GO:0030517","negative regulation of axon extension" -"GO:0072264","metanephric glomerular endothelium development" -"GO:0002730","regulation of dendritic cell cytokine production" -"GO:0001737","establishment of imaginal disc-derived wing hair orientation" -"GO:0061438","renal system vasculature morphogenesis" -"GO:0035845","photoreceptor cell outer segment organization" -"GO:0055062","phosphate ion homeostasis" -"GO:0033146","regulation of intracellular estrogen receptor signaling pathway" -"GO:0071619","phosphorylation of RNA polymerase II C-terminal domain serine 2 residues" -"GO:0071455","cellular response to hyperoxia" -"GO:1903091","pyridoxamine transmembrane transport" -"GO:0015772","oligosaccharide transport" -"GO:0032735","positive regulation of interleukin-12 production" -"GO:0048104","establishment of body hair or bristle planar orientation" -"GO:0006995","cellular response to nitrogen starvation" -"GO:0006942","regulation of striated muscle contraction" -"GO:0015817","histidine transport" -"GO:0046653","tetrahydrofolate metabolic process" -"GO:0001894","tissue homeostasis" -"GO:1905703","negative regulation of inhibitory synapse assembly" -"GO:0072387","flavin adenine dinucleotide metabolic process" -"GO:0007603","phototransduction, visible light" -"GO:0031292","gene conversion at mating-type locus, DNA double-strand break processing" -"GO:0070501","poly-gamma-glutamate biosynthetic process" -"GO:0045223","regulation of CD4 biosynthetic process" -"GO:1902463","protein localization to cell leading edge" -"GO:0051543","regulation of elastin biosynthetic process" -"GO:0006208","pyrimidine nucleobase catabolic process" -"GO:0032385","positive regulation of intracellular cholesterol transport" -"GO:0071604","transforming growth factor beta production" -"GO:0042535","positive regulation of tumor necrosis factor biosynthetic process" -"GO:0014010","Schwann cell proliferation" -"GO:0072593","reactive oxygen species metabolic process" -"GO:0003266","regulation of secondary heart field cardioblast proliferation" -"GO:0015795","sorbitol transport" -"GO:0009886","post-embryonic animal morphogenesis" -"GO:1904161","DNA synthesis involved in UV-damage excision repair" -"GO:0032609","interferon-gamma production" -"GO:0061092","positive regulation of phospholipid translocation" -"GO:0006298","mismatch repair" -"GO:0016093","polyprenol metabolic process" -"GO:1902003","regulation of amyloid-beta formation" -"GO:0030049","muscle filament sliding" -"GO:0019751","polyol metabolic process" -"GO:0039528","cytoplasmic pattern recognition receptor signaling pathway in response to virus" -"GO:1902228","positive regulation of macrophage colony-stimulating factor signaling pathway" -"GO:1902239","negative regulation of intrinsic apoptotic signaling pathway in response to osmotic stress by p53 class mediator" -"GO:1902850","microtubule cytoskeleton organization involved in mitosis" -"GO:0002527","vasodilation involved in acute inflammatory response" -"GO:0042090","interleukin-12 biosynthetic process" -"GO:0007525","somatic muscle development" -"GO:1905634","regulation of protein localization to chromatin" -"GO:0034344","regulation of type III interferon production" -"GO:0070749","interleukin-35 biosynthetic process" -"GO:0060238","regulation of signal transduction involved in conjugation with cellular fusion" -"GO:0044107","cellular alcohol metabolic process" -"GO:0060282","positive regulation of oocyte development" -"GO:0090038","negative regulation of protein kinase C signaling" -"GO:0090287","regulation of cellular response to growth factor stimulus" -"GO:1904469","positive regulation of tumor necrosis factor secretion" -"GO:0046643","regulation of gamma-delta T cell activation" -"GO:0003302","transforming growth factor beta receptor signaling pathway involved in heart jogging" -"GO:0030466","chromatin silencing at silent mating-type cassette" -"GO:0048744","negative regulation of skeletal muscle fiber development" -"GO:2000486","negative regulation of glutamine transport" -"GO:0052182","modification by host of symbiont morphology or physiology via secreted substance" -"GO:0042439","ethanolamine-containing compound metabolic process" -"GO:0003122","norepinephrine-mediated vasodilation" -"GO:1902741","positive regulation of interferon-alpha secretion" -"GO:2000738","positive regulation of stem cell differentiation" -"GO:0014053","negative regulation of gamma-aminobutyric acid secretion" -"GO:0034728","nucleosome organization" -"GO:0060760","positive regulation of response to cytokine stimulus" -"GO:0097703","cellular response to pulsatile fluid shear stress" -"GO:1903000","regulation of lipid transport across blood brain barrier" -"GO:0021758","putamen development" -"GO:0046164","alcohol catabolic process" -"GO:2000843","regulation of testosterone secretion" -"GO:0046456","icosanoid biosynthetic process" -"GO:1903081","negative regulation of C-C chemokine receptor CCR7 signaling pathway" -"GO:0045847","negative regulation of nitrogen utilization" -"GO:0099114","chromatin silencing at subtelomere" -"GO:1902652","secondary alcohol metabolic process" -"GO:0048863","stem cell differentiation" -"GO:0006649","phospholipid transfer to membrane" -"GO:1904977","lymphatic endothelial cell migration" -"GO:0043414","macromolecule methylation" -"GO:0060346","bone trabecula formation" -"GO:0045524","interleukin-24 biosynthetic process" -"GO:0070157","mitochondrial prolyl-tRNA aminoacylation" -"GO:0035965","cardiolipin acyl-chain remodeling" -"GO:0034201","response to oleic acid" -"GO:2000837","regulation of androstenedione secretion" -"GO:0070715","sodium-dependent organic cation transport" -"GO:0061577","calcium ion transmembrane transport via high voltage-gated calcium channel" -"GO:0036211","protein modification process" -"GO:0099117","protein transport along microtubule to cell tip" -"GO:0042269","regulation of natural killer cell mediated cytotoxicity" -"GO:0046165","alcohol biosynthetic process" -"GO:0036451","cap mRNA methylation" -"GO:0018921","3-hydroxybenzyl alcohol metabolic process" -"GO:0035583","sequestering of TGFbeta in extracellular matrix" -"GO:0019323","pentose catabolic process" -"GO:0060984","epicardium-derived cardiac vascular smooth muscle cell development" -"GO:0060669","embryonic placenta morphogenesis" -"GO:0061587","transfer RNA gene-mediated silencing" -"GO:0034095","negative regulation of maintenance of meiotic sister chromatid cohesion" -"GO:0035585","calcium-mediated signaling using extracellular calcium source" -"GO:0042222","interleukin-1 biosynthetic process" -"GO:1900101","regulation of endoplasmic reticulum unfolded protein response" -"GO:0097725","histone H3-K79 dimethylation" -"GO:0070185","mitochondrial valyl-tRNA aminoacylation" -"GO:0045448","mitotic cell cycle, embryonic" -"GO:0075044","autophagy of host cells involved in interaction with symbiont" -"GO:1904027","negative regulation of collagen fibril organization" -"GO:0007198","adenylate cyclase-inhibiting serotonin receptor signaling pathway" -"GO:0032386","regulation of intracellular transport" -"GO:2000840","regulation of dehydroepiandrosterone secretion" -"GO:0045572","positive regulation of imaginal disc growth" -"GO:0098868","bone growth" -"GO:0018023","peptidyl-lysine trimethylation" -"GO:1900365","positive regulation of mRNA polyadenylation" -"GO:0070054","mRNA splicing, via endonucleolytic cleavage and ligation" -"GO:1902756","sulfurated eukaryotic molybdenum cofactor(2-) biosynthetic process" -"GO:0007620","copulation" -"GO:0097753","membrane bending" -"GO:0042201","N-cyclopropylmelamine metabolic process" -"GO:0035543","positive regulation of SNARE complex assembly" -"GO:0100023","regulation of meiotic nuclear division by transcription from RNA polymerase II promoter" -"GO:0060977","coronary vasculature morphogenesis" -"GO:0031048","chromatin silencing by small RNA" -"GO:0051596","methylglyoxal catabolic process" -"GO:0030832","regulation of actin filament length" -"GO:0006939","smooth muscle contraction" -"GO:0097198","histone H3-K36 trimethylation" -"GO:0009440","cyanate catabolic process" -"GO:0048048","embryonic eye morphogenesis" -"GO:0009597","detection of virus" -"GO:0060611","mammary gland fat development" -"GO:1905111","positive regulation of pulmonary blood vessel remodeling" -"GO:0001556","oocyte maturation" -"GO:0014726","negative regulation of extraocular skeletal muscle development" -"GO:0002419","T cell mediated cytotoxicity directed against tumor cell target" -"GO:0014713","negative regulation of branchiomeric skeletal muscle development" -"GO:0099585","release of sequestered calcium ion into presynaptic cytosol" -"GO:2000864","regulation of estradiol secretion" -"GO:0060420","regulation of heart growth" -"GO:0070144","mitochondrial arginyl-tRNA aminoacylation" -"GO:1904304","regulation of gastro-intestinal system smooth muscle contraction" -"GO:0070132","regulation of mitochondrial translational initiation" -"GO:0090728","negative regulation of brood size" -"GO:0019566","arabinose metabolic process" -"GO:1904180","negative regulation of membrane depolarization" -"GO:0060631","regulation of meiosis I" -"GO:0046071","dGTP biosynthetic process" -"GO:1903540","establishment of protein localization to postsynaptic membrane" -"GO:0031652","positive regulation of heat generation" -"GO:0046435","3-(3-hydroxy)phenylpropionate metabolic process" -"GO:0038179","neurotrophin signaling pathway" -"GO:0060501","positive regulation of epithelial cell proliferation involved in lung morphogenesis" -"GO:1900011","negative regulation of corticotropin-releasing hormone receptor activity" -"GO:1902959","regulation of aspartic-type endopeptidase activity involved in amyloid precursor protein catabolic process" -"GO:0006021","inositol biosynthetic process" -"GO:0010234","anther wall tapetum cell fate specification" -"GO:2000580","regulation of ATP-dependent microtubule motor activity, plus-end-directed" -"GO:0072323","chaperone-mediated protein transport across periplasmic space" -"GO:0061951","establishment of protein localization to plasma membrane" -"GO:1901728","monensin A metabolic process" -"GO:0034725","DNA replication-dependent nucleosome disassembly" -"GO:0099640","axo-dendritic protein transport" -"GO:0001763","morphogenesis of a branching structure" -"GO:0060349","bone morphogenesis" -"GO:0021757","caudate nucleus development" -"GO:0050817","coagulation" -"GO:0035621","ER to Golgi ceramide transport" -"GO:0001984","artery vasodilation involved in baroreceptor response to increased systemic arterial blood pressure" -"GO:0033313","meiotic cell cycle checkpoint" -"GO:0033020","cyclopentanol metabolic process" -"GO:1905830","positive regulation of prostaglandin catabolic process" -"GO:0002653","negative regulation of tolerance induction dependent upon immune response" -"GO:0016090","prenol metabolic process" -"GO:0120012","intermembrane sphingolipid transfer" -"GO:0018026","peptidyl-lysine monomethylation" -"GO:0042091","interleukin-10 biosynthetic process" -"GO:0033273","response to vitamin" -"GO:0050863","regulation of T cell activation" -"GO:0032087","regulation of Type IV site-specific deoxyribonuclease activity" -"GO:2000031","regulation of salicylic acid mediated signaling pathway" -"GO:0072310","glomerular epithelial cell development" -"GO:0021789","branchiomotor neuron axon guidance in branchial arch mesenchyme" -"GO:0002395","immune response in nasopharyngeal-associated lymphoid tissue" -"GO:0010512","negative regulation of phosphatidylinositol biosynthetic process" -"GO:0098529","neuromuscular junction development, skeletal muscle fiber" -"GO:0002623","negative regulation of B cell antigen processing and presentation" -"GO:0036058","filtration diaphragm assembly" -"GO:0097286","iron ion import" -"GO:0031621","negative regulation of fever generation" -"GO:0015679","plasma membrane copper ion transport" -"GO:0010928","regulation of auxin mediated signaling pathway" -"GO:0098504","DNA 3' dephosphorylation involved in DNA repair" -"GO:0045844","positive regulation of striated muscle tissue development" -"GO:0097752","regulation of DNA stability" -"GO:1904274","tricellular tight junction assembly" -"GO:0060771","phyllotactic patterning" -"GO:0048728","proboscis development" -"GO:2000820","negative regulation of transcription from RNA polymerase II promoter involved in smooth muscle cell differentiation" -"GO:0048692","negative regulation of axon extension involved in regeneration" -"GO:0060097","cytoskeletal rearrangement involved in phagocytosis, engulfment" -"GO:0048394","intermediate mesodermal cell fate determination" -"GO:1901739","regulation of myoblast fusion" -"GO:0031061","negative regulation of histone methylation" -"GO:1905064","negative regulation of vascular smooth muscle cell differentiation" -"GO:0016264","gap junction assembly" -"GO:0016445","somatic diversification of immunoglobulins" -"GO:0075513","caveolin-mediated endocytosis of virus by host cell" -"GO:0035270","endocrine system development" -"GO:0003104","positive regulation of glomerular filtration" -"GO:1903326","regulation of tRNA metabolic process" -"GO:0021781","glial cell fate commitment" -"GO:0071506","cellular response to mycophenolic acid" -"GO:0022023","radial glial cell fate commitment in forebrain" -"GO:0006403","RNA localization" -"GO:0090310","negative regulation of methylation-dependent chromatin silencing" -"GO:0002274","myeloid leukocyte activation" -"GO:0045887","positive regulation of synaptic growth at neuromuscular junction" -"GO:0000460","maturation of 5.8S rRNA" -"GO:1905516","positive regulation of fertilization" -"GO:1905688","negative regulation of diacylglycerol kinase activity" -"GO:0015700","arsenite transport" -"GO:2000591","positive regulation of metanephric mesenchymal cell migration" -"GO:2001226","negative regulation of chloride transport" -"GO:0061753","substrate localization to autophagosome" -"GO:0043478","pigment accumulation in response to UV light" -"GO:0000473","maturation of LSU-rRNA from tetracistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, 2S rRNA, LSU-rRNA)" -"GO:0051171","regulation of nitrogen compound metabolic process" -"GO:0009256","10-formyltetrahydrofolate metabolic process" -"GO:1905867","epididymis development" -"GO:0009972","cytidine deamination" -"GO:0090057","root radial pattern formation" -"GO:1905093","cellular response to diosgenin" -"GO:1903702","esophagus development" -"GO:0010529","negative regulation of transposition" -"GO:1905176","positive regulation of vascular smooth muscle cell dedifferentiation" -"GO:0090063","positive regulation of microtubule nucleation" -"GO:0016554","cytidine to uridine editing" -"GO:0044656","regulation of post-lysosomal vacuole size" -"GO:0098610","adhesion between unicellular organisms" -"GO:0060223","retinal rod cell fate commitment" -"GO:0002669","positive regulation of T cell anergy" -"GO:0008204","ergosterol metabolic process" -"GO:0034342","response to type III interferon" -"GO:0072255","metanephric glomerular mesangial cell development" -"GO:1901545","response to raffinose" -"GO:0035281","pre-miRNA export from nucleus" -"GO:0007419","ventral cord development" -"GO:2000322","regulation of glucocorticoid receptor signaling pathway" -"GO:0061743","motor learning" -"GO:0010232","vascular transport" -"GO:1903676","positive regulation of cap-dependent translational initiation" -"GO:0002108","maturation of LSU-rRNA from tricistronic rRNA transcript (SSU-rRNA, LSU-rRNA,5S)" -"GO:0060989","lipid tube assembly involved in organelle fusion" -"GO:1903963","arachidonate transport" -"GO:0033671","negative regulation of NAD+ kinase activity" -"GO:0002251","organ or tissue specific immune response" -"GO:1903036","positive regulation of response to wounding" -"GO:0032536","regulation of cell projection size" -"GO:0046939","nucleotide phosphorylation" -"GO:0060467","negative regulation of fertilization" -"GO:0090260","negative regulation of retinal ganglion cell axon guidance" -"GO:0000488","maturation of LSU-rRNA from tetracistronic rRNA transcript (SSU-rRNA, LSU-rRNA, 4.5S-rRNA, 5S-rRNA)" -"GO:0070383","DNA cytosine deamination" -"GO:0061170","negative regulation of hair follicle placode formation" -"GO:0070247","regulation of natural killer cell apoptotic process" -"GO:0080111","DNA demethylation" -"GO:0002692","negative regulation of cellular extravasation" -"GO:0048373","lateral mesodermal cell fate determination" -"GO:0019991","septate junction assembly" -"GO:0021702","cerebellar Purkinje cell differentiation" -"GO:0015867","ATP transport" -"GO:0051542","elastin biosynthetic process" -"GO:2001143","N-methylnicotinate transport" -"GO:0023058","adaptation of signaling pathway" -"GO:0061089","negative regulation of sequestering of zinc ion" -"GO:0015848","spermidine transport" -"GO:0006283","transcription-coupled nucleotide-excision repair" -"GO:0035561","regulation of chromatin binding" -"GO:0019463","glycine catabolic process to creatine" -"GO:0005347","ATP transmembrane transporter activity" -"GO:0061343","cell adhesion involved in heart morphogenesis" -"GO:1901364","funalenone metabolic process" -"GO:0050954","sensory perception of mechanical stimulus" -"GO:0080129","proteasome core complex assembly" -"GO:1905203","regulation of connective tissue replacement" -"GO:1901598","(-)-pinoresinol metabolic process" -"GO:0006281","DNA repair" -"GO:0052130","negative aerotaxis" -"GO:0097271","protein localization to bud neck" -"GO:2001109","regulation of lens epithelial cell proliferation" -"GO:1900256","regulation of beta1-adrenergic receptor activity" -"GO:1901962","S-adenosyl-L-methionine transmembrane transport" -"GO:0034697","response to prostaglandin I" -"GO:0022030","telencephalon glial cell migration" -"GO:0045398","positive regulation of interleukin-23 biosynthetic process" -"GO:0061373","mammillary axonal complex development" -"GO:0046762","viral budding from ER membrane" -"GO:1903519","regulation of mammary gland involution" -"GO:1904641","response to dinitrophenol" -"GO:1905364","regulation of endosomal vesicle fusion" -"GO:0072577","endothelial cell apoptotic process" -"GO:1900791","shamixanthone metabolic process" -"GO:0000296","spermine transport" -"GO:1990545","mitochondrial thiamine pyrophosphate transmembrane transport" -"GO:1990784","response to dsDNA" -"GO:2000758","positive regulation of peptidyl-lysine acetylation" -"GO:1901300","positive regulation of hydrogen peroxide-mediated programmed cell death" -"GO:1902133","(+)-secoisolariciresinol metabolic process" -"GO:1901498","response to tetralin" -"GO:0060474","positive regulation of flagellated sperm motility involved in capacitation" -"GO:0016555","uridine to cytidine editing" -"GO:0048197","Golgi membrane coat protein complex assembly" -"GO:1903056","regulation of melanosome organization" -"GO:1904014","response to serotonin" -"GO:0010207","photosystem II assembly" -"GO:0110026","regulation of DNA strand resection involved in replication fork processing" -"GO:1904318","regulation of smooth muscle contraction involved in micturition" -"GO:0097638","L-arginine import across plasma membrane" -"GO:0106070","regulation of adenylate cyclase-activating G-protein coupled receptor signaling pathway" -"GO:0045355","negative regulation of interferon-alpha biosynthetic process" -"GO:0036182","asperthecin metabolic process" -"GO:0010891","negative regulation of sequestering of triglyceride" -"GO:0072677","eosinophil migration" -"GO:0002587","negative regulation of antigen processing and presentation of peptide antigen via MHC class II" -"GO:1903563","microtubule bundle formation involved in horsetail-astral microtubule organization" -"GO:0042863","pyochelin metabolic process" -"GO:0046823","negative regulation of nucleocytoplasmic transport" -"GO:1900582","o-orsellinic acid metabolic process" -"GO:0002501","peptide antigen assembly with MHC protein complex" -"GO:1990146","protein localization to rhabdomere" -"GO:1901804","beta-glucoside metabolic process" -"GO:0033683","nucleotide-excision repair, DNA incision" -"GO:0061289","Wnt signaling pathway involved in kidney development" -"GO:0008513","secondary active organic cation transmembrane transporter activity" -"GO:0035765","motor neuron precursor migration involved in dorsal motor nucleus of vagus nerve formation" -"GO:1902748","positive regulation of lens fiber cell differentiation" -"GO:1904303","positive regulation of maternal process involved in parturition" -"GO:0019505","resorcinol metabolic process" -"GO:0097164","ammonium ion metabolic process" -"GO:1904643","response to curcumin" -"GO:0070978","voltage-gated calcium channel complex assembly" -"GO:0006297","nucleotide-excision repair, DNA gap filling" -"GO:0034552","respiratory chain complex II assembly" -"GO:0007058","spindle assembly involved in female meiosis II" -"GO:0045639","positive regulation of myeloid cell differentiation" -"GO:0018879","biphenyl metabolic process" -"GO:1901876","regulation of calcium ion binding" -"GO:0022607","cellular component assembly" -"GO:0032215","positive regulation of telomere maintenance via semi-conservative replication" -"GO:2000903","cellooligosaccharide catabolic process" -"GO:0021957","corticospinal tract morphogenesis" -"GO:0007181","transforming growth factor beta receptor complex assembly" -"GO:0018918","gallate metabolic process" -"GO:0043623","cellular protein complex assembly" -"GO:0030447","filamentous growth" -"GO:1990127","intrinsic apoptotic signaling pathway in response to osmotic stress by p53 class mediator" -"GO:1901999","homogentisate metabolic process" -"GO:1902681","regulation of replication fork arrest at rDNA repeats" -"GO:0019483","beta-alanine biosynthetic process" -"GO:1904216","positive regulation of protein import into chloroplast stroma" -"GO:0033507","glucosinolate biosynthetic process from phenylalanine" -"GO:0051963","regulation of synapse assembly" -"GO:0101030","tRNA-guanine transglycosylation" -"GO:0044871","negative regulation by host of viral glycoprotein metabolic process" -"GO:0036285","SAGA complex assembly" -"GO:1901324","response to trichodermin" -"GO:0031203","posttranslational protein targeting to membrane, docking" -"GO:0045778","positive regulation of ossification" -"GO:1900753","doxorubicin transport" -"GO:1905960","response to differentiation-inducing factor 2" -"GO:0090649","response to oxygen-glucose deprivation" -"GO:0042714","dosage compensation complex assembly" -"GO:1904323","regulation of inhibitory G-protein coupled receptor phosphorylation" -"GO:1902048","neosartoricin metabolic process" -"GO:0048564","photosystem I assembly" -"GO:0060986","endocrine hormone secretion" -"GO:0070217","transcription factor TFIIIB complex assembly" -"GO:0043636","bisphenol A catabolic process" -"GO:0009696","salicylic acid metabolic process" -"GO:0036324","vascular endothelial growth factor receptor-2 signaling pathway" -"GO:0015870","acetylcholine transport" -"GO:0045799","positive regulation of chromatin assembly or disassembly" -"GO:1900761","averantin metabolic process" -"GO:0070196","eukaryotic translation initiation factor 3 complex assembly" -"GO:0061531","primary amine secretion" -"GO:2000124","regulation of endocannabinoid signaling pathway" -"GO:0046940","nucleoside monophosphate phosphorylation" -"GO:1901423","response to benzene" -"GO:0046833","positive regulation of RNA export from nucleus" -"GO:0001781","neutrophil apoptotic process" -"GO:0019336","phenol-containing compound catabolic process" -"GO:0018881","bromoxynil metabolic process" -"GO:1990555","mitochondrial oxaloacetate transmembrane transport" -"GO:0048668","collateral sprouting" -"GO:0061504","cyclic threonylcarbamoyladenosine biosynthetic process" -"GO:1901497","response to diphenyl ether" -"GO:1904696","protein localization to cell-cell adherens junction" -"GO:2000576","positive regulation of microtubule motor activity" -"GO:0090737","telomere maintenance via telomere trimming" -"GO:0061539","octopamine secretion" -"GO:1904432","regulation of ferrous iron binding" -"GO:0003351","epithelial cilium movement" -"GO:0018961","pentachlorophenol metabolic process" -"GO:1902284","neuron projection extension involved in neuron projection guidance" -"GO:0035750","protein localization to myelin sheath abaxonal region" -"GO:0007417","central nervous system development" -"GO:1903492","response to acetylsalicylate" -"GO:1901756","butirosin metabolic process" -"GO:0060960","cardiac neuron fate commitment" -"GO:0035445","borate transmembrane transport" -"GO:1901709","(+)-larreatricin metabolic process" -"GO:1905329","sphingoid long-chain base transport" -"GO:0036039","curcumin metabolic process" -"GO:1902323","negative regulation of methyl-branched fatty acid biosynthetic process" -"GO:0032273","positive regulation of protein polymerization" -"GO:2000168","negative regulation of planar cell polarity pathway involved in neural tube closure" -"GO:0018940","orcinol metabolic process" -"GO:2000481","positive regulation of cAMP-dependent protein kinase activity" -"GO:0015619","thiamine pyrophosphate-transporting ATPase activity" -"GO:2000586","regulation of platelet-derived growth factor receptor-beta signaling pathway" -"GO:1902391","positive regulation of N-terminal peptidyl-serine acetylation" -"GO:0032201","telomere maintenance via semi-conservative replication" -"GO:0002032","desensitization of G-protein coupled receptor protein signaling pathway by arrestin" -"GO:0042854","eugenol metabolic process" -"GO:0070494","regulation of thrombin-activated receptor signaling pathway" -"GO:1904674","positive regulation of somatic stem cell population maintenance" -"GO:0044338","canonical Wnt signaling pathway involved in mesenchymal stem cell differentiation" -"GO:0048260","positive regulation of receptor-mediated endocytosis" -"GO:0071215","cellular response to abscisic acid stimulus" -"GO:0009102","biotin biosynthetic process" -"GO:0030859","polarized epithelial cell differentiation" -"GO:0043948","positive regulation by symbiont of host catalytic activity" -"GO:0140053","mitochondrial gene expression" -"GO:0042246","tissue regeneration" -"GO:0015838","amino-acid betaine transport" -"GO:0051808","translocation of peptides or proteins into other organism involved in symbiotic interaction" -"GO:0030997","regulation of centriole-centriole cohesion" -"GO:1902901","positive regulation of transcription from RNA polymerase II promoter involved in stress response to cadmium ion" -"GO:2000251","positive regulation of actin cytoskeleton reorganization" -"GO:0006525","arginine metabolic process" -"GO:0035249","synaptic transmission, glutamatergic" -"GO:0042747","circadian sleep/wake cycle, REM sleep" -"GO:1905265","blasticidin S catabolic process" -"GO:0061868","hepatic stellate cell migration" -"GO:0019295","coenzyme M biosynthetic process" -"GO:0090399","replicative senescence" -"GO:0031397","negative regulation of protein ubiquitination" -"GO:0060311","negative regulation of elastin catabolic process" -"GO:0043691","reverse cholesterol transport" -"GO:0044339","canonical Wnt signaling pathway involved in osteoblast differentiation" -"GO:0044539","long-chain fatty acid import" -"GO:0060695","negative regulation of cholesterol transporter activity" -"GO:0006471","protein ADP-ribosylation" -"GO:0034968","histone lysine methylation" -"GO:0048815","hermaphrodite genitalia morphogenesis" -"GO:0005291","high-affinity L-histidine transmembrane transporter activity" -"GO:0006550","isoleucine catabolic process" -"GO:0033629","negative regulation of cell adhesion mediated by integrin" -"GO:1901552","positive regulation of endothelial cell development" -"GO:0055074","calcium ion homeostasis" -"GO:0010757","negative regulation of plasminogen activation" -"GO:0060079","excitatory postsynaptic potential" -"GO:0015940","pantothenate biosynthetic process" -"GO:0031102","neuron projection regeneration" -"GO:0048877","homeostasis of number of retina cells" -"GO:0060990","lipid tube assembly involved in organelle fission" -"GO:1904479","negative regulation of intestinal absorption" -"GO:0050996","positive regulation of lipid catabolic process" -"GO:0021512","spinal cord anterior/posterior patterning" -"GO:0019298","coenzyme B biosynthetic process" -"GO:1903830","magnesium ion transmembrane transport" -"GO:0048709","oligodendrocyte differentiation" -"GO:0045723","positive regulation of fatty acid biosynthetic process" -"GO:1901029","negative regulation of mitochondrial outer membrane permeabilization involved in apoptotic signaling pathway" -"GO:1903254","hercynylselenocysteine metabolic process" -"GO:0090336","positive regulation of brown fat cell differentiation" -"GO:0061412","positive regulation of transcription from RNA polymerase II promoter in response to amino acid starvation" -"GO:1905405","regulation of mitotic cohesin loading" -"GO:0030195","negative regulation of blood coagulation" -"GO:0045956","positive regulation of calcium ion-dependent exocytosis" -"GO:1904568","cellular response to wortmannin" -"GO:0090036","regulation of protein kinase C signaling" -"GO:0051560","mitochondrial calcium ion homeostasis" -"GO:0051918","negative regulation of fibrinolysis" -"GO:0006568","tryptophan metabolic process" -"GO:0035951","positive regulation of oligopeptide transport by positive regulation of transcription from RNA polymerase II promoter" -"GO:0070414","trehalose metabolism in response to heat stress" -"GO:0060197","cloacal septation" -"GO:0035491","positive regulation of leukotriene production involved in inflammatory response" -"GO:0002183","cytoplasmic translational initiation" -"GO:0030730","sequestering of triglyceride" -"GO:0009813","flavonoid biosynthetic process" -"GO:0001866","NK T cell proliferation" -"GO:1902723","negative regulation of skeletal muscle satellite cell proliferation" -"GO:0061222","mesonephric mesenchymal cell proliferation involved in mesonephros development" -"GO:0060593","Wnt signaling pathway involved in mammary gland specification" -"GO:0060313","negative regulation of blood vessel remodeling" -"GO:2000381","negative regulation of mesoderm development" -"GO:0032092","positive regulation of protein binding" -"GO:0036414","histone citrullination" -"GO:0001579","medium-chain fatty acid transport" -"GO:0090386","phagosome maturation involved in apoptotic cell clearance" -"GO:0044267","cellular protein metabolic process" -"GO:2001044","regulation of integrin-mediated signaling pathway" -"GO:0022417","protein maturation by protein folding" -"GO:0002472","macrophage antigen processing and presentation" -"GO:0071295","cellular response to vitamin" -"GO:0051336","regulation of hydrolase activity" -"GO:0060064","Spemann organizer formation at the anterior end of the primitive streak" -"GO:1900320","positive regulation of methane biosynthetic process from dimethylamine" -"GO:2000117","negative regulation of cysteine-type endopeptidase activity" -"GO:0061639","Cdv-dependent cytokinesis" -"GO:0006978","DNA damage response, signal transduction by p53 class mediator resulting in transcription of p21 class mediator" -"GO:0043113","receptor clustering" -"GO:0034370","triglyceride-rich lipoprotein particle remodeling" -"GO:0048768","root hair cell tip growth" -"GO:0002190","cap-independent translational initiation" -"GO:0070510","regulation of histone H4-K20 methylation" -"GO:0070901","mitochondrial tRNA methylation" -"GO:0048858","cell projection morphogenesis" -"GO:0006711","estrogen catabolic process" -"GO:0080162","intracellular auxin transport" -"GO:1903022","positive regulation of phosphodiesterase activity, acting on 3'-phosphoglycolate-terminated DNA strands" -"GO:0060650","epithelial cell proliferation involved in mammary gland bud elongation" -"GO:0035475","angioblast cell migration involved in selective angioblast sprouting" -"GO:0002822","regulation of adaptive immune response based on somatic recombination of immune receptors built from immunoglobulin superfamily domains" -"GO:0044771","meiotic cell cycle phase transition" -"GO:0036394","amylase secretion" -"GO:0035506","negative regulation of myosin light chain kinase activity" -"GO:1901800","positive regulation of proteasomal protein catabolic process" -"GO:1901724","positive regulation of cell proliferation involved in kidney development" -"GO:0035245","peptidyl-arginine C-methylation" -"GO:0010796","regulation of multivesicular body size" -"GO:1990747","pancreatic trypsinogen secretion" -"GO:0035533","positive regulation of chemokine (C-C motif) ligand 6 production" -"GO:0019076","viral release from host cell" -"GO:0090341","negative regulation of secretion of lysosomal enzymes" -"GO:0060613","fat pad development" -"GO:0006204","IMP catabolic process" -"GO:0072716","response to actinomycin D" -"GO:0070962","positive regulation of neutrophil mediated killing of bacterium" -"GO:0018122","peptidyl-asparagine ADP-ribosylation" -"GO:0043858","arginine:ornithine antiporter activity" -"GO:1902259","regulation of delayed rectifier potassium channel activity" -"GO:0061724","lipophagy" -"GO:0035584","calcium-mediated signaling using intracellular calcium source" -"GO:0050652","dermatan sulfate proteoglycan biosynthetic process, polysaccharide chain biosynthetic process" -"GO:0072649","interferon-kappa production" -"GO:0009860","pollen tube growth" -"GO:0006429","leucyl-tRNA aminoacylation" -"GO:0021719","superior olivary nucleus morphogenesis" -"GO:0045221","negative regulation of FasL biosynthetic process" -"GO:0009247","glycolipid biosynthetic process" -"GO:0048890","lateral line ganglion development" -"GO:0071660","positive regulation of IP-10 production" -"GO:1902721","negative regulation of prolactin secretion" -"GO:1902627","regulation of assembly of large subunit precursor of preribosome" -"GO:0051999","mannosyl-inositol phosphorylceramide biosynthetic process" -"GO:0001745","compound eye morphogenesis" -"GO:2000772","regulation of cellular senescence" -"GO:0048548","regulation of pinocytosis" -"GO:1905126","regulation of axo-dendritic protein transport" -"GO:0019600","toluene oxidation" -"GO:0018291","molybdenum incorporation into iron-sulfur cluster" -"GO:2001291","codeine metabolic process" -"GO:0048382","mesendoderm development" -"GO:0019667","anaerobic L-alanine catabolic process" -"GO:1905535","regulation of eukaryotic translation initiation factor 4F complex assembly" -"GO:1902441","protein localization to meiotic spindle pole body" -"GO:1900715","positive regulation of violaceol I biosynthetic process" -"GO:0018096","peptide cross-linking via S-(2-aminovinyl)-D-cysteine" -"GO:1905109","regulation of pulmonary blood vessel remodeling" -"GO:0072049","comma-shaped body morphogenesis" -"GO:0000743","nuclear migration involved in conjugation with cellular fusion" -"GO:1904648","cellular response to rotenone" -"GO:1900512","regulation of starch utilization system complex assembly" -"GO:0018316","peptide cross-linking via L-cystine" -"GO:0061106","negative regulation of stomach neuroendocrine cell differentiation" -"GO:1902092","positive regulation of fumagillin biosynthetic process" -"GO:0019729","peptide cross-linking via 2-imino-glutaminyl-5-imidazolinone glycine" -"GO:0045224","positive regulation of CD4 biosynthetic process" -"GO:0080036","regulation of cytokinin-activated signaling pathway" -"GO:0001928","regulation of exocyst assembly" -"GO:0097155","fasciculation of sensory neuron axon" -"GO:0090677","reversible differentiation" -"GO:0021862","early neuron differentiation in forebrain" -"GO:0060914","heart formation" -"GO:0071465","cellular response to desiccation" -"GO:0010990","regulation of SMAD protein complex assembly" -"GO:0033079","immature T cell proliferation" -"GO:0070452","positive regulation of ergosterol biosynthetic process" -"GO:0019293","tyrosine biosynthetic process, by oxidation of phenylalanine" -"GO:1900709","positive regulation of tensidol A biosynthetic process" -"GO:0042771","intrinsic apoptotic signaling pathway in response to DNA damage by p53 class mediator" -"GO:0035023","regulation of Rho protein signal transduction" -"GO:0045568","positive regulation of TRAIL receptor 2 biosynthetic process" -"GO:1904863","regulation of beta-catenin-TCF complex assembly" -"GO:0018162","peptide cross-linking via S-(2-aminovinyl)-3-methyl-D-cysteine" -"GO:0018417","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl L-cysteine persulfido L-glutamato L-histidino L-serinyl nickel triiron disulfide trioxide" -"GO:1901124","bacitracin A biosynthetic process" -"GO:0072713","cellular response to thiabendazole" -"GO:2000142","regulation of DNA-templated transcription, initiation" -"GO:0019578","aldaric acid biosynthetic process" -"GO:0090028","positive regulation of pheromone-dependent signal transduction involved in conjugation with cellular fusion" -"GO:0036450","polyuridylation-dependent decapping of nuclear-transcribed mRNA" -"GO:0006907","pinocytosis" -"GO:0008299","isoprenoid biosynthetic process" -"GO:0003148","outflow tract septum morphogenesis" -"GO:1902789","cellular response to isooctane" -"GO:2000296","negative regulation of hydrogen peroxide catabolic process" -"GO:2000978","negative regulation of forebrain neuron differentiation" -"GO:0009087","methionine catabolic process" -"GO:0046924","peptide cross-linking via 2-(S-L-cysteinyl)-L-phenylalanine" -"GO:0003065","positive regulation of heart rate by epinephrine" -"GO:0051181","cofactor transport" -"GO:0071934","thiamine transmembrane transport" -"GO:0046717","acid secretion" -"GO:0015944","formate oxidation" -"GO:1904324","negative regulation of inhibitory G-protein coupled receptor phosphorylation" -"GO:0048378","regulation of lateral mesodermal cell fate specification" -"GO:0043991","histone H2B-S14 phosphorylation" -"GO:2000476","positive regulation of opioid receptor signaling pathway" -"GO:1901193","regulation of formation of translation preinitiation complex" -"GO:0006707","cholesterol catabolic process" -"GO:0032271","regulation of protein polymerization" -"GO:0002062","chondrocyte differentiation" -"GO:0036249","cadmium ion import into vacuole" -"GO:0050853","B cell receptor signaling pathway" -"GO:0072343","pancreatic stellate cell proliferation" -"GO:0032502","developmental process" -"GO:0010455","positive regulation of cell fate commitment" -"GO:0072756","cellular response to paraquat" -"GO:1904805","cellular response to latrunculin A" -"GO:0048108","peptide cross-linking via 4-amino-3-isothiazolidinone" -"GO:0018069","peptide cross-linking via 4'-(L-tryptophan)-L-tryptophyl quinone" -"GO:1904298","regulation of transcytosis" -"GO:0015689","molybdate ion transport" -"GO:0022003","negative regulation of anterior neural cell fate commitment of the neural plate by fibroblast growth factor receptor signaling pathway" -"GO:1905771","negative regulation of mesodermal cell differentiation" -"GO:1904882","regulation of telomerase catalytic core complex assembly" -"GO:0099155","synaptic transmission, noradrenergic" -"GO:1904647","response to rotenone" -"GO:0048229","gametophyte development" -"GO:0019247","lactate racemization" -"GO:0097428","protein maturation by iron-sulfur cluster transfer" -"GO:0044864","positive regulation by virus of host cell division" -"GO:0032220","plasma membrane fusion involved in cytogamy" -"GO:0015294","solute:cation symporter activity" -"GO:0051544","positive regulation of elastin biosynthetic process" -"GO:0043060","meiotic metaphase I plate congression" -"GO:0051661","maintenance of centrosome location" -"GO:0018305","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl-L-serinyl tetrairon tetrasulfide" -"GO:0009848","indoleacetic acid biosynthetic process via tryptophan" -"GO:0019715","peptidyl-aspartic acid hydroxylation to form L-erythro-beta-hydroxyaspartic acid" -"GO:0007552","metamorphosis" -"GO:0019561","anaerobic phenylalanine oxidation" -"GO:0043520","regulation of myosin II filament assembly" -"GO:0070508","cholesterol import" -"GO:0002053","positive regulation of mesenchymal cell proliferation" -"GO:0048549","positive regulation of pinocytosis" -"GO:0070871","cell wall organization involved in conjugation with cellular fusion" -"GO:0051358","peptide cross-linking via 2-imino-glutamic acid 5-imidazolinone glycine" -"GO:0006479","protein methylation" -"GO:0051932","synaptic transmission, GABAergic" -"GO:0003378","regulation of inflammatory response by sphingosine-1-phosphate signaling pathway" -"GO:0042964","thioredoxin reduction" -"GO:0110063","positive regulation of angiotensin-activated signaling pathway" -"GO:0090068","positive regulation of cell cycle process" -"GO:0019929","peptide cross-linking via 4-(S-L-cysteinyl)-L-glutamic acid" -"GO:0042986","positive regulation of amyloid precursor protein biosynthetic process" -"GO:1904790","regulation of shelterin complex assembly" -"GO:0072679","thymocyte migration" -"GO:0031447","negative regulation of fast-twitch skeletal muscle fiber contraction" -"GO:0046828","regulation of RNA import into nucleus" -"GO:1902114","D-valine metabolic process" -"GO:1902644","tertiary alcohol metabolic process" -"GO:0072755","cellular response to benomyl" -"GO:0019928","peptide cross-linking via 3-(S-L-cysteinyl)-L-aspartic acid" -"GO:0097647","amylin receptor signaling pathway" -"GO:1904239","regulation of VCP-NPL4-UFD1 AAA ATPase complex assembly" -"GO:0010890","positive regulation of sequestering of triglyceride" -"GO:0018156","peptide cross-linking via (2S,3S,6R)-3-methyl-lanthionine" -"GO:0099517","synaptic vesicle transport along microtubule" -"GO:0046331","lateral inhibition" -"GO:1902080","regulation of calcium ion import into sarcoplasmic reticulum" -"GO:0043248","proteasome assembly" -"GO:0046630","gamma-delta T cell proliferation" -"GO:0019827","stem cell population maintenance" -"GO:0072138","mesenchymal cell proliferation involved in ureteric bud development" -"GO:1900396","positive regulation of kojic acid biosynthetic process" -"GO:1900225","regulation of NLRP3 inflammasome complex assembly" -"GO:0036111","very long-chain fatty-acyl-CoA metabolic process" -"GO:0046106","thymine biosynthetic process" -"GO:0072723","cellular response to amitrole" -"GO:0110021","cardiac muscle myoblast proliferation" -"GO:0090646","mitochondrial tRNA processing" -"GO:1900952","positive regulation of 18-methylnonadec-1-ene biosynthetic process" -"GO:1902993","positive regulation of amyloid precursor protein catabolic process" -"GO:1905285","fibrous ring of heart morphogenesis" -"GO:0061315","canonical Wnt signaling pathway involved in positive regulation of cardiac muscle cell proliferation" -"GO:0036280","cellular response to L-canavanine" -"GO:2001176","regulation of mediator complex assembly" -"GO:0018081","peptide cross-linking via lanthionine or 3-methyl-lanthionine" -"GO:0002164","larval development" -"GO:0045950","negative regulation of mitotic recombination" -"GO:0010454","negative regulation of cell fate commitment" -"GO:0051057","positive regulation of small GTPase mediated signal transduction" -"GO:0045838","positive regulation of membrane potential" -"GO:0003167","atrioventricular bundle cell differentiation" -"GO:0045686","negative regulation of glial cell differentiation" -"GO:0060869","transmembrane receptor protein serine/threonine kinase signaling pathway involved in floral organ abscission" -"GO:0072683","T cell extravasation" -"GO:0042668","auditory receptor cell fate determination" -"GO:0036109","alpha-linolenic acid metabolic process" -"GO:0002523","leukocyte migration involved in inflammatory response" -"GO:0018242","protein O-linked glycosylation via serine" -"GO:1903957","cellular response to latrunculin B" -"GO:0060021","roof of mouth development" -"GO:0051359","peptide cross-linking via 2-imino-methionine 5-imidazolinone glycine" -"GO:0046595","establishment of pole plasm mRNA localization" -"GO:0045566","positive regulation of TRAIL receptor 1 biosynthetic process" -"GO:0035685","helper T cell diapedesis" -"GO:0050883","musculoskeletal movement, spinal reflex action" -"GO:0008308","voltage-gated anion channel activity" -"GO:0097410","hippocampal interneuron differentiation" -"GO:0003143","embryonic heart tube morphogenesis" -"GO:2001139","negative regulation of phospholipid transport" -"GO:0061626","pharyngeal arch artery morphogenesis" -"GO:1903192","sesquarterpene metabolic process" -"GO:0035041","sperm chromatin decondensation" -"GO:0052316","phytoalexin catabolic process" -"GO:1903457","lactate catabolic process" -"GO:0061345","planar cell polarity pathway involved in cardiac muscle cell fate commitment" -"GO:0060870","cell wall disassembly involved in floral organ abscission" -"GO:1904707","positive regulation of vascular smooth muscle cell proliferation" -"GO:0007344","pronuclear fusion" -"GO:0036112","medium-chain fatty-acyl-CoA metabolic process" -"GO:0002920","regulation of humoral immune response" -"GO:0046839","phospholipid dephosphorylation" -"GO:0048368","lateral mesoderm development" -"GO:0021799","cerebral cortex radially oriented cell migration" -"GO:0042539","hypotonic salinity response" -"GO:0043978","histone H2A-K9 acetylation" -"GO:1902442","regulation of ripoptosome assembly involved in necroptotic process" -"GO:0034308","primary alcohol metabolic process" -"GO:0050837","peptide cross-linking via L-cysteinyl-L-selenocysteine" -"GO:0010609","mRNA localization resulting in posttranscriptional regulation of gene expression" -"GO:1900278","positive regulation of proteinase activated receptor activity" -"GO:0071879","positive regulation of adenylate cyclase-activating adrenergic receptor signaling pathway" -"GO:1903650","negative regulation of cytoplasmic transport" -"GO:1904474","cellular response to L-dopa" -"GO:0006692","prostanoid metabolic process" -"GO:0018232","peptide cross-linking via S-(L-isoglutamyl)-L-cysteine" -"GO:0051663","oocyte nucleus localization involved in oocyte dorsal/ventral axis specification" -"GO:0021954","central nervous system neuron development" -"GO:0120117","T cell meandering migration" -"GO:1902367","negative regulation of Notch signaling pathway involved in somitogenesis" -"GO:0021558","trochlear nerve development" -"GO:0014032","neural crest cell development" -"GO:0042791","5S class rRNA transcription from RNA polymerase III type 1 promoter" -"GO:1905864","regulation of Atg1/ULK1 kinase complex assembly" -"GO:0002285","lymphocyte activation involved in immune response" -"GO:1901977","negative regulation of cell cycle checkpoint" -"GO:2000259","positive regulation of protein activation cascade" -"GO:1901028","regulation of mitochondrial outer membrane permeabilization involved in apoptotic signaling pathway" -"GO:0072031","proximal convoluted tubule segment 1 development" -"GO:1903664","regulation of asexual reproduction" -"GO:1900123","regulation of nodal receptor complex assembly" -"GO:0015920","lipopolysaccharide transport" -"GO:0042040","metal incorporation into metallo-molybdopterin complex" -"GO:0031960","response to corticosteroid" -"GO:0001318","formation of oxidatively modified proteins involved in replicative cell aging" -"GO:1904613","cellular response to 2,3,7,8-tetrachlorodibenzodioxine" -"GO:0032290","peripheral nervous system myelin formation" -"GO:0014003","oligodendrocyte development" -"GO:0003176","aortic valve development" -"GO:0035461","vitamin transmembrane transport" -"GO:0072607","interleukin-9 secretion" -"GO:0002040","sprouting angiogenesis" -"GO:0045763","negative regulation of cellular amino acid metabolic process" -"GO:0046442","aerobactin metabolic process" -"GO:1905549","positive regulation of telomeric heterochromatin assembly" -"GO:0060685","regulation of prostatic bud formation" -"GO:1905411","positive regulation of mitotic cohesin unloading" -"GO:1900608","tensidol B biosynthetic process" -"GO:0018184","protein polyamination" -"GO:0018079","protein halogenation" -"GO:0007228","positive regulation of hh target transcription factor activity" -"GO:2000802","positive regulation of endocardial cushion to mesenchymal transition involved in heart valve formation" -"GO:0072144","glomerular mesangial cell development" -"GO:1904117","cellular response to vasopressin" -"GO:0019430","removal of superoxide radicals" -"GO:1904673","negative regulation of somatic stem cell population maintenance" -"GO:0031950","negative regulation of glucocorticoid catabolic process" -"GO:0009912","auditory receptor cell fate commitment" -"GO:0051984","positive regulation of chromosome segregation" -"GO:0007424","open tracheal system development" -"GO:0018307","enzyme active site formation" -"GO:0035148","tube formation" -"GO:1902877","positive regulation of embryonic pattern specification" -"GO:0048706","embryonic skeletal system development" -"GO:0045608","negative regulation of inner ear auditory receptor cell differentiation" -"GO:0062001","negative regulation of cardiac endothelial to mesenchymal transition" -"GO:1902167","positive regulation of intrinsic apoptotic signaling pathway in response to DNA damage by p53 class mediator" -"GO:2000809","positive regulation of synaptic vesicle clustering" -"GO:0061053","somite development" -"GO:1904775","positive regulation of ubiquinone biosynthetic process" -"GO:0090338","positive regulation of formin-nucleated actin cable assembly" -"GO:0060463","lung lobe morphogenesis" -"GO:0043496","regulation of protein homodimerization activity" -"GO:0060038","cardiac muscle cell proliferation" -"GO:0048732","gland development" -"GO:2000282","regulation of cellular amino acid biosynthetic process" -"GO:0048660","regulation of smooth muscle cell proliferation" -"GO:0042774","plasma membrane ATP synthesis coupled electron transport" -"GO:2001151","regulation of renal water transport" -"GO:0060769","positive regulation of epithelial cell proliferation involved in prostate gland development" -"GO:0072695","regulation of DNA recombination at telomere" -"GO:0003373","dynamin family protein polymerization involved in membrane fission" -"GO:0010832","negative regulation of myotube differentiation" -"GO:0042630","behavioral response to water deprivation" -"GO:0098943","neurotransmitter receptor transport, postsynaptic endosome to lysosome" -"GO:0000032","cell wall mannoprotein biosynthetic process" -"GO:1902733","regulation of growth plate cartilage chondrocyte differentiation" -"GO:0048663","neuron fate commitment" -"GO:0019756","cyanogenic glycoside biosynthetic process" -"GO:0090186","regulation of pancreatic juice secretion" -"GO:1905310","regulation of cardiac neural crest cell migration involved in outflow tract morphogenesis" -"GO:0070930","trans-translation-dependent protein tagging" -"GO:0018919","gamma-1,2,3,4,5,6-hexachlorocyclohexane metabolic process" -"GO:0030888","regulation of B cell proliferation" -"GO:0007440","foregut morphogenesis" -"GO:0003344","pericardium morphogenesis" -"GO:0016539","intein-mediated protein splicing" -"GO:1900498","negative regulation of butyryl-CoA catabolic process to butanol" -"GO:0051657","maintenance of organelle location" -"GO:0006569","tryptophan catabolic process" -"GO:0014725","regulation of extraocular skeletal muscle development" -"GO:0097578","sequestering of copper ion" -"GO:0060523","prostate epithelial cord elongation" -"GO:0046594","maintenance of pole plasm mRNA location" -"GO:0009243","O antigen biosynthetic process" -"GO:1990775","endothelin secretion" -"GO:0097577","sequestering of iron ion" -"GO:0008214","protein dealkylation" -"GO:0010602","regulation of 1-aminocyclopropane-1-carboxylate metabolic process" -"GO:0019988","charged-tRNA amino acid modification" -"GO:0046533","negative regulation of photoreceptor cell differentiation" -"GO:2000234","positive regulation of rRNA processing" -"GO:0031167","rRNA methylation" -"GO:0045819","positive regulation of glycogen catabolic process" -"GO:0048078","positive regulation of compound eye pigmentation" -"GO:0046189","phenol-containing compound biosynthetic process" -"GO:0002076","osteoblast development" -"GO:0051099","positive regulation of binding" -"GO:0036184","asperthecin biosynthetic process" -"GO:0038183","bile acid signaling pathway" -"GO:1904578","response to thapsigargin" -"GO:0000001","mitochondrion inheritance" -"GO:0044809","chemokine (C-C motif) ligand 17 production" -"GO:0048864","stem cell development" -"GO:0018143","nucleic acid-protein covalent cross-linking" -"GO:0072616","interleukin-18 secretion" -"GO:0070476","rRNA (guanine-N7)-methylation" -"GO:1905825","regulation of selenocysteine metabolic process" -"GO:0018214","protein carboxylation" -"GO:0060447","bud outgrowth involved in lung branching" -"GO:0071248","cellular response to metal ion" -"GO:0043543","protein acylation" -"GO:0072603","interleukin-5 secretion" -"GO:1900812","helvolic acid biosynthetic process" -"GO:2000737","negative regulation of stem cell differentiation" -"GO:0035444","nickel cation transmembrane transport" -"GO:1904803","regulation of translation involved in cellular response to UV" -"GO:2000276","negative regulation of oxidative phosphorylation uncoupler activity" -"GO:0035646","endosome to melanosome transport" -"GO:2000590","negative regulation of metanephric mesenchymal cell migration" -"GO:0031660","regulation of cyclin-dependent protein serine/threonine kinase activity involved in G2/M transition of mitotic cell cycle" -"GO:0002052","positive regulation of neuroblast proliferation" -"GO:2000811","negative regulation of anoikis" -"GO:0002068","glandular epithelial cell development" -"GO:0010731","protein glutathionylation" -"GO:0072622","interleukin-24 secretion" -"GO:0035519","protein K29-linked ubiquitination" -"GO:0099532","synaptic vesicle endosomal processing" -"GO:1901698","response to nitrogen compound" -"GO:1905327","tracheoesophageal septum formation" -"GO:0007639","homeostasis of number of meristem cells" -"GO:0046197","orcinol biosynthetic process" -"GO:0098659","inorganic cation import across plasma membrane" -"GO:1905110","negative regulation of pulmonary blood vessel remodeling" -"GO:0140023","tRNA adenosine deamination to inosine" -"GO:0007221","positive regulation of transcription of Notch receptor target" -"GO:2000901","cyclodextrin catabolic process" -"GO:2000780","negative regulation of double-strand break repair" -"GO:0003273","cell migration involved in endocardial cushion formation" -"GO:0016182","synaptic vesicle budding from endosome" -"GO:1904880","response to hydrogen sulfide" -"GO:0034504","protein localization to nucleus" -"GO:0098545","maintenance of protein complex location in cytoplasm" -"GO:0010352","lithium ion export across the plasma membrane" -"GO:0006211","5-methylcytosine catabolic process" -"GO:0110059","negative regulation of blood vessel endothelial cell differentiation" -"GO:0031162","sulfur incorporation into metallo-sulfur cluster" -"GO:0016325","oocyte microtubule cytoskeleton organization" -"GO:0045109","intermediate filament organization" -"GO:0048715","negative regulation of oligodendrocyte differentiation" -"GO:0072016","glomerular parietal epithelial cell development" -"GO:0019442","tryptophan catabolic process to acetyl-CoA" -"GO:0061611","mannose to fructose-6-phosphate metabolic process" -"GO:0048859","formation of anatomical boundary" -"GO:0090220","chromosome localization to nuclear envelope involved in homologous chromosome segregation" -"GO:0044245","polysaccharide digestion" -"GO:2000062","negative regulation of ureter smooth muscle cell differentiation" -"GO:1901657","glycosyl compound metabolic process" -"GO:0043443","acetone metabolic process" -"GO:0030647","aminoglycoside antibiotic metabolic process" -"GO:0070647","protein modification by small protein conjugation or removal" -"GO:1903317","regulation of protein maturation" -"GO:0010509","polyamine homeostasis" -"GO:0045059","positive thymic T cell selection" -"GO:0070986","left/right axis specification" -"GO:0071690","cardiac muscle myosin thick filament assembly" -"GO:0090567","reproductive shoot system development" -"GO:0061900","glial cell activation" -"GO:2000565","negative regulation of CD8-positive, alpha-beta T cell proliferation" -"GO:0021515","cell differentiation in spinal cord" -"GO:0018175","protein nucleotidylation" -"GO:0019884","antigen processing and presentation of exogenous antigen" -"GO:0090308","regulation of methylation-dependent chromatin silencing" -"GO:0055012","ventricular cardiac muscle cell differentiation" -"GO:0007099","centriole replication" -"GO:0008213","protein alkylation" -"GO:0070535","histone H2A K63-linked ubiquitination" -"GO:0090357","regulation of tryptophan metabolic process" -"GO:0032435","negative regulation of proteasomal ubiquitin-dependent protein catabolic process" -"GO:0090452","lithium ion transmembrane transport" -"GO:0071539","protein localization to centrosome" -"GO:1901098","positive regulation of autophagosome maturation" -"GO:0031067","negative regulation of histone deacetylation at centromere" -"GO:1900179","positive regulation of aflatoxin biosynthetic process" -"GO:1903210","glomerular visceral epithelial cell apoptotic process" -"GO:0046673","negative regulation of compound eye retinal cell programmed cell death" -"GO:2000317","negative regulation of T-helper 17 type immune response" -"GO:0072127","renal capsule development" -"GO:0097283","keratinocyte apoptotic process" -"GO:0018982","vanillin metabolic process" -"GO:0010093","specification of floral organ identity" -"GO:1902488","cholangiocyte apoptotic process" -"GO:1900081","regulation of arginine catabolic process" -"GO:1902127","(-)-lariciresinol metabolic process" -"GO:1905498","positive regulation of triplex DNA binding" -"GO:1900353","positive regulation of methanofuran biosynthetic process" -"GO:1900570","diorcinol metabolic process" -"GO:1990134","epithelial cell apoptotic process involved in palatal shelf morphogenesis" -"GO:0010622","specification of ovule identity" -"GO:0042241","interleukin-18 biosynthetic process" -"GO:2000727","positive regulation of cardiac muscle cell differentiation" -"GO:0042097","interleukin-4 biosynthetic process" -"GO:0007202","activation of phospholipase C activity" -"GO:0018959","aerobic phenol-containing compound metabolic process" -"GO:0099118","microtubule-based protein transport" -"GO:1900976","positive regulation of tatiopterin biosynthetic process" -"GO:0019235","sensory perception of slow pain" -"GO:0010480","microsporocyte differentiation" -"GO:0071767","mycolic acid metabolic process" -"GO:0042228","interleukin-8 biosynthetic process" -"GO:1901484","negative regulation of transcription factor catabolic process" -"GO:0007329","positive regulation of transcription from RNA polymerase II promoter by pheromones" -"GO:0033494","ferulate metabolic process" -"GO:0048311","mitochondrion distribution" -"GO:0061199","striated muscle contraction involved in embryonic body morphogenesis" -"GO:0002504","antigen processing and presentation of peptide or polysaccharide antigen via MHC class II" -"GO:0055024","regulation of cardiac muscle tissue development" -"GO:0048281","inflorescence morphogenesis" -"GO:0042533","tumor necrosis factor biosynthetic process" -"GO:0003410","anterior rotation of the optic cup" -"GO:0010914","positive regulation of sterigmatocystin biosynthetic process" -"GO:0007595","lactation" -"GO:0061309","cardiac neural crest cell development involved in outflow tract morphogenesis" -"GO:2000559","regulation of CD24 biosynthetic process" -"GO:0005998","xylulose catabolic process" -"GO:1903883","positive regulation of interleukin-17-mediated signaling pathway" -"GO:1901096","regulation of autophagosome maturation" -"GO:0033047","regulation of mitotic sister chromatid segregation" -"GO:1900464","negative regulation of cellular hyperosmotic salinity response by negative regulation of transcription from RNA polymerase II promoter" -"GO:0038110","interleukin-2-mediated signaling pathway" -"GO:1903536","positive regulation of lactose biosynthetic process" -"GO:0002375","cytokine biosynthetic process involved in immune response" -"GO:0071774","response to fibroblast growth factor" -"GO:0048700","acquisition of desiccation tolerance in seed" -"GO:0070496","positive regulation of thrombin-activated receptor signaling pathway" -"GO:0019218","regulation of steroid metabolic process" -"GO:0051793","medium-chain fatty acid catabolic process" -"GO:0044505","positive regulation of G-protein coupled receptor activity in other organism" -"GO:1902136","(-)-secoisolariciresinol metabolic process" -"GO:1900012","positive regulation of corticotropin-releasing hormone receptor activity" -"GO:0009712","catechol-containing compound metabolic process" -"GO:0032207","regulation of telomere maintenance via recombination" -"GO:0048559","establishment of floral organ orientation" -"GO:0045526","interleukin-26 biosynthetic process" -"GO:0017157","regulation of exocytosis" -"GO:0035743","CD4-positive, alpha-beta T cell cytokine production" -"GO:0002725","negative regulation of T cell cytokine production" -"GO:0048833","specification of floral organ number" -"GO:0009719","response to endogenous stimulus" -"GO:0019254","carnitine metabolic process, CoA-linked" -"GO:0042234","interleukin-16 biosynthetic process" -"GO:2001132","methane biosynthetic process from 3-(methylthio)propionic acid" -"GO:0042236","interleukin-19 biosynthetic process" -"GO:1900669","positive regulation of endocrocin biosynthetic process" -"GO:0032614","interleukin-11 production" -"GO:0045951","positive regulation of mitotic recombination" -"GO:0015995","chlorophyll biosynthetic process" -"GO:1902352","negative regulation of filamentous growth of a population of unicellular organisms in response to starvation by negative regulation of transcription from RNA polymerase II promoter" -"GO:1904700","granulosa cell apoptotic process" -"GO:1902833","positive regulation of cell proliferation in dorsal spinal cord" -"GO:0030422","production of siRNA involved in RNA interference" -"GO:1900609","F-9775A metabolic process" -"GO:1904766","negative regulation of macroautophagy by TORC1 signaling" -"GO:0048655","anther wall tapetum morphogenesis" -"GO:0042212","cresol metabolic process" -"GO:0042239","interleukin-22 biosynthetic process" -"GO:1900764","emericellin metabolic process" -"GO:0042230","interleukin-11 biosynthetic process" -"GO:1901097","negative regulation of autophagosome maturation" -"GO:0034294","sexual spore wall assembly" -"GO:1900079","regulation of arginine biosynthetic process" -"GO:1902925","poly(hydroxyalkanoate) biosynthetic process from fatty acid" -"GO:0035834","indole alkaloid metabolic process" -"GO:0030947","regulation of vascular endothelial growth factor receptor signaling pathway" -"GO:0071828","apolipoprotein E recycling" -"GO:0099158","regulation of recycling endosome localization within postsynapse" -"GO:0015988","energy coupled proton transmembrane transport, against electrochemical gradient" -"GO:0007259","JAK-STAT cascade" -"GO:0033315","meiotic G2/MI DNA replication checkpoint" -"GO:0034207","steroid acetylation" -"GO:1904967","regulation of attachment of spindle microtubules to kinetochore involved in homologous chromosome segregation" -"GO:0018960","4-nitrophenol metabolic process" -"GO:0033689","negative regulation of osteoblast proliferation" -"GO:0042243","asexual spore wall assembly" -"GO:1901022","4-hydroxyphenylacetate metabolic process" -"GO:0072331","signal transduction by p53 class mediator" -"GO:2001008","positive regulation of cellulose biosynthetic process" -"GO:1900213","positive regulation of mesenchymal cell apoptotic process involved in metanephros development" -"GO:0033571","lactoferrin transport" -"GO:0050948","positive regulation of early stripe melanocyte differentiation" -"GO:0048317","seed morphogenesis" -"GO:1901885","2-hydroxybenzoyl-CoA metabolic process" -"GO:1904765","positive regulation of transcription from RNA polymerase II promoter in response to maltose" -"GO:0042233","interleukin-15 biosynthetic process" -"GO:0021786","branchiomotor neuron axon guidance in neural tube" -"GO:0010032","meiotic chromosome condensation" -"GO:0051936","gamma-aminobutyric acid reuptake" -"GO:1901430","positive regulation of syringal lignin biosynthetic process" -"GO:1902484","Sertoli cell apoptotic process" -"GO:0080126","ovary septum development" -"GO:0002091","negative regulation of receptor internalization" -"GO:1900813","monodictyphenone metabolic process" -"GO:0009061","anaerobic respiration" -"GO:0046599","regulation of centriole replication" -"GO:0042227","interleukin-7 biosynthetic process" -"GO:2001021","negative regulation of response to DNA damage stimulus" -"GO:0060732","positive regulation of inositol phosphate biosynthetic process" -"GO:2000645","negative regulation of receptor catabolic process" -"GO:0034314","Arp2/3 complex-mediated actin nucleation" -"GO:0045527","interleukin-27 biosynthetic process" -"GO:2000775","histone H3-S10 phosphorylation involved in chromosome condensation" -"GO:0042232","interleukin-14 biosynthetic process" -"GO:1900503","regulation of cellulosome assembly" -"GO:0099526","presynapse to nucleus signaling pathway" -"GO:0048439","flower morphogenesis" -"GO:0042238","interleukin-21 biosynthetic process" -"GO:0002293","alpha-beta T cell differentiation involved in immune response" -"GO:1900086","positive regulation of peptidyl-tyrosine autophosphorylation" -"GO:0031339","negative regulation of vesicle fusion" -"GO:1903097","regulation of CENP-A containing nucleosome assembly" -"GO:0019609","3-hydroxyphenylacetate metabolic process" -"GO:0071693","protein transport within extracellular region" -"GO:0045446","endothelial cell differentiation" -"GO:1903504","regulation of mitotic spindle checkpoint" -"GO:1905618","positive regulation of miRNA mediated inhibition of translation" -"GO:0090290","positive regulation of osteoclast proliferation" -"GO:0042240","interleukin-23 biosynthetic process" -"GO:0018255","peptide cross-linking via S-glycyl-L-cysteine" -"GO:0000479","endonucleolytic cleavage of tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:0046431","(R)-4-hydroxymandelate metabolic process" -"GO:0010845","positive regulation of reciprocal meiotic recombination" -"GO:0060397","JAK-STAT cascade involved in growth hormone signaling pathway" -"GO:1900734","positive regulation of polyketide biosynthetic process" -"GO:0021768","nucleus accumbens development" -"GO:0015541","secondary active cyanate transmembrane transporter activity" -"GO:0061101","neuroendocrine cell differentiation" -"GO:0072070","loop of Henle development" -"GO:1904683","regulation of metalloendopeptidase activity" -"GO:1900860","positive regulation of brevianamide F biosynthetic process" -"GO:0042104","positive regulation of activated T cell proliferation" -"GO:0033496","sinapate metabolic process" -"GO:2000873","regulation of histone H4 acetylation involved in response to DNA damage stimulus" -"GO:0090191","negative regulation of branching involved in ureteric bud morphogenesis" -"GO:0042229","interleukin-9 biosynthetic process" -"GO:0048929","efferent axon development in posterior lateral line nerve" -"GO:0090596","sensory organ morphogenesis" -"GO:0051355","proprioception involved in equilibrioception" -"GO:0010723","positive regulation of transcription from RNA polymerase II promoter in response to iron" -"GO:0051986","negative regulation of attachment of spindle microtubules to kinetochore" -"GO:0031147","1-(3,5-dichloro-2,6-dihydroxy-4-methoxyphenyl)hexan-1-one metabolic process" -"GO:0090027","negative regulation of monocyte chemotaxis" -"GO:0071866","negative regulation of apoptotic process in bone marrow" -"GO:0032925","regulation of activin receptor signaling pathway" -"GO:1902897","regulation of postsynaptic density protein 95 clustering" -"GO:0010841","positive regulation of circadian sleep/wake cycle, wakefulness" -"GO:0051128","regulation of cellular component organization" -"GO:0002943","tRNA dihydrouridine synthesis" -"GO:0042453","deoxyguanosine metabolic process" -"GO:0032741","positive regulation of interleukin-18 production" -"GO:0061534","gamma-aminobutyric acid secretion, neurotransmission" -"GO:0032230","positive regulation of synaptic transmission, GABAergic" -"GO:0060635","positive regulation of (1->3)-beta-D-glucan biosynthetic process" -"GO:0072488","ammonium transmembrane transport" -"GO:1902498","regulation of protein autoubiquitination" -"GO:0003149","membranous septum morphogenesis" -"GO:1901533","negative regulation of hematopoietic progenitor cell differentiation" -"GO:1902219","negative regulation of intrinsic apoptotic signaling pathway in response to osmotic stress" -"GO:1905929","positive regulation of invadopodium disassembly" -"GO:0015882","L-ascorbic acid transmembrane transport" -"GO:0006383","transcription by RNA polymerase III" -"GO:0097222","mitochondrial mRNA polyadenylation" -"GO:1903952","regulation of voltage-gated potassium channel activity involved in atrial cardiac muscle cell action potential repolarization" -"GO:0061936","fusion of sperm to egg plasma membrane involved in double fertilization forming a zygote and endosperm" -"GO:0001324","age-dependent response to oxidative stress involved in chronological cell aging" -"GO:2000702","regulation of fibroblast growth factor receptor signaling pathway involved in ureteric bud formation" -"GO:0010983","positive regulation of high-density lipoprotein particle clearance" -"GO:0019329","ammonia oxidation" -"GO:0045540","regulation of cholesterol biosynthetic process" -"GO:0099553","trans-synaptic signaling by endocannabinoid, modulating synaptic transmission" -"GO:0003226","right ventricular compact myocardium morphogenesis" -"GO:0002271","plasmacytoid dendritic cell activation involved in immune response" -"GO:0090593","peptidyl-histidine autophosphorylation" -"GO:0070528","protein kinase C signaling" -"GO:0045685","regulation of glial cell differentiation" -"GO:0035927","RNA import into mitochondrion" -"GO:1902606","regulation of large conductance calcium-activated potassium channel activity" -"GO:1902635","1-phosphatidyl-1D-myo-inositol 4,5-bisphosphate biosynthetic process" -"GO:1905801","positive regulation of intraciliary retrograde transport" -"GO:0098597","observational learning" -"GO:0050861","positive regulation of B cell receptor signaling pathway" -"GO:1900426","positive regulation of defense response to bacterium" -"GO:0033145","positive regulation of intracellular steroid hormone receptor signaling pathway" -"GO:0006447","regulation of translational initiation by iron" -"GO:0010133","proline catabolic process to glutamate" -"GO:0009311","oligosaccharide metabolic process" -"GO:1990145","maintenance of translational fidelity" -"GO:0052259","positive regulation by organism of inflammatory response of other organism involved in symbiotic interaction" -"GO:0051438","regulation of ubiquitin-protein transferase activity" -"GO:0045926","negative regulation of growth" -"GO:1902460","regulation of mesenchymal stem cell proliferation" -"GO:0021575","hindbrain morphogenesis" -"GO:0055086","nucleobase-containing small molecule metabolic process" -"GO:0060443","mammary gland morphogenesis" -"GO:0034147","regulation of toll-like receptor 5 signaling pathway" -"GO:1900916","positive regulation of octadecene biosynthetic process" -"GO:1905798","positive regulation of intraciliary anterograde transport" -"GO:0000957","mitochondrial RNA catabolic process" -"GO:0002212","behavioral defense response to nematode" -"GO:0051607","defense response to virus" -"GO:0097280","histamine secretion mediated by immunoglobulin" -"GO:1904456","negative regulation of neuronal action potential" -"GO:0039529","RIG-I signaling pathway" -"GO:0021936","regulation of cerebellar granule cell precursor proliferation" -"GO:1901706","mesenchymal cell differentiation involved in bone development" -"GO:1900973","positive regulation of sarcinapterin biosynthetic process" -"GO:1905403","negative regulation of activated CD8-positive, alpha-beta T cell apoptotic process" -"GO:0044858","plasma membrane raft polarization" -"GO:1905491","positive regulation of sensory neuron axon guidance" -"GO:1903090","pyridoxal transmembrane transport" -"GO:0031999","negative regulation of fatty acid beta-oxidation" -"GO:2000627","positive regulation of miRNA catabolic process" -"GO:0006424","glutamyl-tRNA aminoacylation" -"GO:1900198","positive regulation of penicillin biosynthetic process" -"GO:0033004","negative regulation of mast cell activation" -"GO:1900712","positive regulation of tensidol B biosynthetic process" -"GO:0086002","cardiac muscle cell action potential involved in contraction" -"GO:0006287","base-excision repair, gap-filling" -"GO:0032901","positive regulation of neurotrophin production" -"GO:0018904","ether metabolic process" -"GO:1901374","acetate ester transport" -"GO:1905161","protein localization to phagocytic vesicle" -"GO:0060414","aorta smooth muscle tissue morphogenesis" -"GO:1900792","shamixanthone catabolic process" -"GO:0035695","mitophagy by induced vacuole formation" -"GO:0071802","negative regulation of podosome assembly" -"GO:1905032","negative regulation of membrane repolarization during cardiac muscle cell action potential" -"GO:0061952","midbody abscission" -"GO:0046090","deoxyadenosine metabolic process" -"GO:0006401","RNA catabolic process" -"GO:0014820","tonic smooth muscle contraction" -"GO:1903950","negative regulation of AV node cell action potential" -"GO:0070230","positive regulation of lymphocyte apoptotic process" -"GO:1905814","positive regulation of motor neuron axon guidance" -"GO:0006742","NADP catabolic process" -"GO:1903692","methionine import across plasma membrane" -"GO:0072745","cellular response to antimycin A" -"GO:0002678","positive regulation of chronic inflammatory response" -"GO:0090503","RNA phosphodiester bond hydrolysis, exonucleolytic" -"GO:1902159","regulation of cyclic nucleotide-gated ion channel activity" -"GO:0000962","positive regulation of mitochondrial RNA catabolic process" -"GO:0036291","protein cis-autophosphorylation" -"GO:1900688","positive regulation of gerfelin biosynthetic process" -"GO:0006562","proline catabolic process" -"GO:0061935","fusion of sperm to egg plasma membrane involved in double fertilization forming two zygotes" -"GO:0060167","regulation of adenosine receptor signaling pathway" -"GO:0030855","epithelial cell differentiation" -"GO:0002065","columnar/cuboidal epithelial cell differentiation" -"GO:0001574","ganglioside biosynthetic process" -"GO:0019688","purine deoxyribonucleoside interconversion" -"GO:1903412","response to bile acid" -"GO:0044282","small molecule catabolic process" -"GO:0052047","interaction with other organism via secreted substance involved in symbiotic interaction" -"GO:1900851","positive regulation of pseurotin A biosynthetic process" -"GO:0035782","mature natural killer cell chemotaxis" -"GO:0042148","strand invasion" -"GO:0002159","desmosome assembly" -"GO:0046124","purine deoxyribonucleoside catabolic process" -"GO:0019296","coenzyme M metabolic process" -"GO:1900612","F-9775B metabolic process" -"GO:0019661","glucose catabolic process to lactate via pyruvate" -"GO:1900901","positive regulation of heptadecane metabolic process" -"GO:0046123","purine deoxyribonucleoside biosynthetic process" -"GO:0009876","pollen adhesion" -"GO:0010793","regulation of mRNA export from nucleus" -"GO:1905488","positive regulation of anterior/posterior axon guidance" -"GO:1903115","regulation of actin filament-based movement" -"GO:0060252","positive regulation of glial cell proliferation" -"GO:0045680","negative regulation of R8 cell differentiation" -"GO:1902914","regulation of protein polyubiquitination" -"GO:2000284","positive regulation of cellular amino acid biosynthetic process" -"GO:0051604","protein maturation" -"GO:0060405","regulation of penile erection" -"GO:1903337","positive regulation of vacuolar transport" -"GO:0090012","negative regulation of transforming growth factor beta receptor signaling pathway involved in primitive streak formation" -"GO:0002403","T cell tolerance induction in mucosal-associated lymphoid tissue" -"GO:1901979","regulation of inward rectifier potassium channel activity" -"GO:1902691","respiratory basal cell differentiation" -"GO:0005996","monosaccharide metabolic process" -"GO:1903541","regulation of exosomal secretion" -"GO:1903658","positive regulation of type IV pilus biogenesis" -"GO:0045760","positive regulation of action potential" -"GO:1900700","positive regulation of o-orsellinic acid biosynthetic process" -"GO:2001202","negative regulation of transforming growth factor-beta secretion" -"GO:0030225","macrophage differentiation" -"GO:0033386","geranylgeranyl diphosphate biosynthetic process" -"GO:0007512","adult heart development" -"GO:0045919","positive regulation of cytolysis" -"GO:1904667","negative regulation of ubiquitin protein ligase activity" -"GO:0061330","Malpighian tubule stellate cell differentiation" -"GO:0016125","sterol metabolic process" -"GO:0050905","neuromuscular process" -"GO:1901726","negative regulation of histone deacetylase activity" -"GO:1900904","positive regulation of hexadecanal biosynthetic process" -"GO:0016544","male courtship behavior, tapping to detect pheromone" -"GO:0046094","deoxyinosine metabolic process" -"GO:0035418","protein localization to synapse" -"GO:1900748","positive regulation of vascular endothelial growth factor signaling pathway" -"GO:0016237","lysosomal microautophagy" -"GO:0070954","negative regulation of neutrophil mediated cytotoxicity" -"GO:0015654","tellurite transmembrane transporter activity" -"GO:0070589","cellular component macromolecule biosynthetic process" -"GO:1904400","response to Thyroid stimulating hormone" -"GO:1904028","positive regulation of collagen fibril organization" -"GO:1901215","negative regulation of neuron death" -"GO:1903490","positive regulation of mitotic cytokinesis" -"GO:0002412","antigen transcytosis by M cells in mucosal-associated lymphoid tissue" -"GO:0072038","mesenchymal stem cell maintenance involved in nephron morphogenesis" -"GO:0006014","D-ribose metabolic process" -"GO:0006892","post-Golgi vesicle-mediated transport" -"GO:0036525","protein deglycation" -"GO:0010241","ent-kaurene oxidation to kaurenoic acid" -"GO:1902747","negative regulation of lens fiber cell differentiation" -"GO:0002734","negative regulation of myeloid dendritic cell cytokine production" -"GO:0042462","eye photoreceptor cell development" -"GO:0033233","regulation of protein sumoylation" -"GO:0018933","nicotine metabolic process" -"GO:0072321","chaperone-mediated protein transport" -"GO:0001504","neurotransmitter uptake" -"GO:0030923","metal incorporation into metallo-oxygen cluster" -"GO:0051260","protein homooligomerization" -"GO:0098718","serine import across plasma membrane" -"GO:0048876","chemical homeostasis within retina" -"GO:0009267","cellular response to starvation" -"GO:0072240","metanephric DCT cell differentiation" -"GO:0006145","purine nucleobase catabolic process" -"GO:0033053","D-glutamine metabolic process" -"GO:0000183","chromatin silencing at rDNA" -"GO:0019498","n-octane oxidation" -"GO:0035541","negative regulation of SNARE complex disassembly" -"GO:1904007","positive regulation of phospholipase D activity" -"GO:0006538","glutamate catabolic process" -"GO:0046607","positive regulation of centrosome cycle" -"GO:2000244","regulation of FtsZ-dependent cytokinesis" -"GO:0072258","metanephric interstitial fibroblast differentiation" -"GO:0010641","positive regulation of platelet-derived growth factor receptor signaling pathway" -"GO:0018153","isopeptide cross-linking via N6-(L-isoglutamyl)-L-lysine" -"GO:0008652","cellular amino acid biosynthetic process" -"GO:0046777","protein autophosphorylation" -"GO:0051408","glyceraldehyde 3-phosphate:inorganic phosphate antiporter activity" -"GO:0018180","protein desulfurization" -"GO:0031451","positive regulation of slow-twitch skeletal muscle fiber contraction" -"GO:0061256","mesonephric glomerular visceral epithelial cell differentiation" -"GO:0015115","silicate transmembrane transporter activity" -"GO:1903908","positive regulation of plasma membrane raft polarization" -"GO:0072209","metanephric mesangial cell differentiation" -"GO:0032571","response to vitamin K" -"GO:1901283","5,6,7,8-tetrahydromethanopterin metabolic process" -"GO:0070277","iodide oxidation" -"GO:0031346","positive regulation of cell projection organization" -"GO:0072281","mesenchymal stem cell differentiation involved in metanephric nephron morphogenesis" -"GO:0032285","non-myelinated axon ensheathment" -"GO:0051340","regulation of ligase activity" -"GO:1905289","regulation of CAMKK-AMPK signaling cascade" -"GO:1904181","positive regulation of membrane depolarization" -"GO:0006091","generation of precursor metabolites and energy" -"GO:0051220","cytoplasmic sequestering of protein" -"GO:0099533","positive regulation of presynaptic cytosolic calcium concentration" -"GO:0061684","chaperone-mediated autophagy" -"GO:0018342","protein prenylation" -"GO:1902340","negative regulation of chromosome condensation" -"GO:1901725","regulation of histone deacetylase activity" -"GO:0000951","methionine catabolic process to 3-methylthiopropanol" -"GO:1903084","protein localization to condensed nuclear chromosome" -"GO:1905217","response to astaxanthin" -"GO:0097064","ncRNA export from nucleus" -"GO:0006542","glutamine biosynthetic process" -"GO:0051624","inhibition of norepinephrine uptake" -"GO:1905710","positive regulation of membrane permeability" -"GO:0019676","ammonia assimilation cycle" -"GO:0006214","thymidine catabolic process" -"GO:0019361","2'-(5''-triphosphoribosyl)-3'-dephospho-CoA biosynthetic process" -"GO:0072251","metanephric juxtaglomerulus cell differentiation" -"GO:0009605","response to external stimulus" -"GO:0048102","autophagic cell death" -"GO:0072257","metanephric nephron tubule epithelial cell differentiation" -"GO:1905225","response to thyrotropin-releasing hormone" -"GO:0060263","regulation of respiratory burst" -"GO:0061302","smooth muscle cell-matrix adhesion" -"GO:1903379","regulation of mitotic chromosome condensation" -"GO:0075512","clathrin-dependent endocytosis of virus by host cell" -"GO:0051968","positive regulation of synaptic transmission, glutamatergic" -"GO:0072041","positive regulation of mesenchymal cell apoptotic process involved in nephron morphogenesis" -"GO:0032024","positive regulation of insulin secretion" -"GO:0010769","regulation of cell morphogenesis involved in differentiation" -"GO:0045892","negative regulation of transcription, DNA-templated" -"GO:0097068","response to thyroxine" -"GO:1900447","regulation of cell morphogenesis involved in phenotypic switching" -"GO:0099622","cardiac muscle cell membrane repolarization" -"GO:0019399","cyclohexanol oxidation" -"GO:0043929","primary ovarian follicle growth involved in double layer follicle stage" -"GO:0005976","polysaccharide metabolic process" -"GO:0018103","protein C-linked glycosylation" -"GO:2001111","positive regulation of lens epithelial cell proliferation" -"GO:0019708","peptidyl-glycine cholesteryl ester biosynthesis from peptidyl-glycine" -"GO:0009253","peptidoglycan catabolic process" -"GO:0070493","thrombin-activated receptor signaling pathway" -"GO:1904612","response to 2,3,7,8-tetrachlorodibenzodioxine" -"GO:0072359","circulatory system development" -"GO:0015554","tartrate transmembrane transporter activity" -"GO:1905053","positive regulation of base-excision repair" -"GO:0070374","positive regulation of ERK1 and ERK2 cascade" -"GO:0014886","transition between slow and fast fiber" -"GO:1903076","regulation of protein localization to plasma membrane" -"GO:0014019","neuroblast development" -"GO:0046667","compound eye retinal cell programmed cell death" -"GO:1905708","regulation of cell morphogenesis involved in conjugation with cellular fusion" -"GO:0070582","theta DNA replication" -"GO:0072233","metanephric thick ascending limb development" -"GO:0045872","positive regulation of rhodopsin gene expression" -"GO:0010037","response to carbon dioxide" -"GO:0002414","immunoglobulin transcytosis in epithelial cells" -"GO:0072137","condensed mesenchymal cell proliferation" -"GO:0048615","embryonic anterior midgut (ectodermal) morphogenesis" -"GO:0034976","response to endoplasmic reticulum stress" -"GO:0051382","kinetochore assembly" -"GO:0090500","endocardial cushion to mesenchymal transition" -"GO:0048842","positive regulation of axon extension involved in axon guidance" -"GO:0002652","regulation of tolerance induction dependent upon immune response" -"GO:0060317","cardiac epithelial to mesenchymal transition" -"GO:0071646","regulation of macrophage inflammatory protein-1 gamma production" -"GO:0019458","methionine catabolic process via 2-oxobutanoate" -"GO:0001562","response to protozoan" -"GO:0060843","venous endothelial cell differentiation" -"GO:0045498","sex comb development" -"GO:0042779","tRNA 3'-trailer cleavage" -"GO:0003382","epithelial cell morphogenesis" -"GO:0045881","positive regulation of sporulation resulting in formation of a cellular spore" -"GO:2000279","negative regulation of DNA biosynthetic process" -"GO:0106034","protein maturation by [2Fe-2S] cluster transfer" -"GO:0042188","1,1,1-trichloro-2,2-bis-(4-chlorophenyl)ethane catabolic process" -"GO:1903694","positive regulation of mitotic G1 cell cycle arrest in response to nitrogen starvation" -"GO:0030308","negative regulation of cell growth" -"GO:0061398","negative regulation of transcription from RNA polymerase II promoter in response to copper ion" -"GO:1902035","positive regulation of hematopoietic stem cell proliferation" -"GO:0003169","coronary vein morphogenesis" -"GO:1990845","adaptive thermogenesis" -"GO:0055059","asymmetric neuroblast division" -"GO:0051660","establishment of centrosome localization" -"GO:0003431","growth plate cartilage chondrocyte development" -"GO:0035531","regulation of chemokine (C-C motif) ligand 6 production" -"GO:1902165","regulation of intrinsic apoptotic signaling pathway in response to DNA damage by p53 class mediator" -"GO:0001938","positive regulation of endothelial cell proliferation" -"GO:1990139","protein localization to nuclear periphery" -"GO:0045664","regulation of neuron differentiation" -"GO:0036035","osteoclast development" -"GO:1905474","canonical Wnt signaling pathway involved in stem cell proliferation" -"GO:0010275","NAD(P)H dehydrogenase complex assembly" -"GO:0071406","cellular response to methylmercury" -"GO:1903251","multi-ciliated epithelial cell differentiation" -"GO:0003191","coronary sinus valve formation" -"GO:0060842","arterial endothelial cell differentiation" -"GO:0043555","regulation of translation in response to stress" -"GO:1901200","negative regulation of calcium ion transport into cytosol involved in cellular response to salt stress" -"GO:0001937","negative regulation of endothelial cell proliferation" -"GO:0045858","positive regulation of molecular function, epigenetic" -"GO:1901263","positive regulation of sorocarp spore cell differentiation" -"GO:0019417","sulfur oxidation" -"GO:0045603","positive regulation of endothelial cell differentiation" -"GO:0072017","distal tubule development" -"GO:0019050","suppression by virus of host apoptotic process" -"GO:0060733","regulation of eIF2 alpha phosphorylation by amino acid starvation" -"GO:2001189","negative regulation of T cell activation via T cell receptor contact with antigen bound to MHC molecule on antigen presenting cell" -"GO:0071637","regulation of monocyte chemotactic protein-1 production" -"GO:0060768","regulation of epithelial cell proliferation involved in prostate gland development" -"GO:0045175","basal protein localization" -"GO:1904424","regulation of GTP binding" -"GO:0044726","protection of DNA demethylation of female pronucleus" -"GO:0003209","cardiac atrium morphogenesis" -"GO:0043368","positive T cell selection" -"GO:1990831","cellular response to carcinoembryonic antigen" -"GO:0018887","4-carboxy-4'-sulfoazobenzene metabolic process" -"GO:0003208","cardiac ventricle morphogenesis" -"GO:0032924","activin receptor signaling pathway" -"GO:0060305","regulation of cell diameter" -"GO:0009677","double fertilization forming two zygotes" -"GO:0071900","regulation of protein serine/threonine kinase activity" -"GO:0052173","response to defenses of other organism involved in symbiotic interaction" -"GO:0046760","viral budding from Golgi membrane" -"GO:0033491","coniferin metabolic process" -"GO:0016258","N-glycan diversification" -"GO:0010596","negative regulation of endothelial cell migration" -"GO:0060740","prostate gland epithelium morphogenesis" -"GO:0009236","cobalamin biosynthetic process" -"GO:0043562","cellular response to nitrogen levels" -"GO:1904838","regulation of male germ-line stem cell asymmetric division" -"GO:0048711","positive regulation of astrocyte differentiation" -"GO:0046632","alpha-beta T cell differentiation" -"GO:0030645","glucose catabolic process to butyrate" -"GO:0098806","deadenylation involved in gene silencing by miRNA" -"GO:0050747","positive regulation of lipoprotein metabolic process" -"GO:1902230","negative regulation of intrinsic apoptotic signaling pathway in response to DNA damage" -"GO:1904728","positive regulation of replicative senescence" -"GO:0051902","negative regulation of mitochondrial depolarization" -"GO:0097494","regulation of vesicle size" -"GO:0060172","astral microtubule depolymerization" -"GO:0014897","striated muscle hypertrophy" -"GO:0032458","slow endocytic recycling" -"GO:0009409","response to cold" -"GO:0045602","negative regulation of endothelial cell differentiation" -"GO:0003219","cardiac right ventricle formation" -"GO:0061154","endothelial tube morphogenesis" -"GO:0071649","regulation of chemokine (C-C motif) ligand 5 production" -"GO:0070668","positive regulation of mast cell proliferation" -"GO:0072489","methylammonium transmembrane transport" -"GO:0060840","artery development" -"GO:0019482","beta-alanine metabolic process" -"GO:0051895","negative regulation of focal adhesion assembly" -"GO:1902600","proton transmembrane transport" -"GO:0043143","regulation of translation by machinery localization" -"GO:0000395","mRNA 5'-splice site recognition" -"GO:0036496","regulation of translational initiation by eIF2 alpha dephosphorylation" -"GO:0060982","coronary artery morphogenesis" -"GO:0019326","nitrotoluene metabolic process" -"GO:1902263","apoptotic process involved in embryonic digit morphogenesis" -"GO:2000574","regulation of microtubule motor activity" -"GO:0003189","aortic valve formation" -"GO:0001946","lymphangiogenesis" -"GO:0008217","regulation of blood pressure" -"GO:0098543","detection of other organism" -"GO:0097298","regulation of nucleus size" -"GO:1905894","regulation of cellular response to tunicamycin" -"GO:0043375","CD8-positive, alpha-beta T cell lineage commitment" -"GO:0001936","regulation of endothelial cell proliferation" -"GO:0032815","negative regulation of natural killer cell activation" -"GO:0003192","mitral valve formation" -"GO:1902626","assembly of large subunit precursor of preribosome" -"GO:0044380","protein localization to cytoskeleton" -"GO:0044026","DNA hypermethylation" -"GO:0006379","mRNA cleavage" -"GO:0002239","response to oomycetes" -"GO:0048843","negative regulation of axon extension involved in axon guidance" -"GO:0051413","response to cortisone" -"GO:0035924","cellular response to vascular endothelial growth factor stimulus" -"GO:1903443","cellular response to lipoic acid" -"GO:2000196","positive regulation of female gonad development" -"GO:0045699","positive regulation of synergid differentiation" -"GO:0014881","regulation of myofibril size" -"GO:0032495","response to muramyl dipeptide" -"GO:0075136","response to host" -"GO:0100070","regulation of fatty acid biosynthetic process by transcription from RNA polymerase II promoter" -"GO:0048697","positive regulation of collateral sprouting in absence of injury" -"GO:1905184","positive regulation of protein serine/threonine phosphatase activity" -"GO:1990592","protein K69-linked ufmylation" -"GO:1904954","canonical Wnt signaling pathway involved in midbrain dopaminergic neuron differentiation" -"GO:0002763","positive regulation of myeloid leukocyte differentiation" -"GO:0061298","retina vasculature development in camera-type eye" -"GO:0045073","regulation of chemokine biosynthetic process" -"GO:0060253","negative regulation of glial cell proliferation" -"GO:0032687","negative regulation of interferon-alpha production" -"GO:1903237","negative regulation of leukocyte tethering or rolling" -"GO:0010523","negative regulation of calcium ion transport into cytosol" -"GO:0043537","negative regulation of blood vessel endothelial cell migration" -"GO:0060836","lymphatic endothelial cell differentiation" -"GO:0000751","mitotic cell cycle G1 arrest in response to pheromone" -"GO:0001837","epithelial to mesenchymal transition" -"GO:0032644","regulation of fractalkine production" -"GO:0035313","wound healing, spreading of epidermal cells" -"GO:0002237","response to molecule of bacterial origin" -"GO:0034087","establishment of mitotic sister chromatid cohesion" -"GO:0031586","negative regulation of inositol 1,4,5-trisphosphate-sensitive calcium-release channel activity" -"GO:0070228","regulation of lymphocyte apoptotic process" -"GO:0003256","regulation of transcription from RNA polymerase II promoter involved in myocardial precursor cell differentiation" -"GO:0009948","anterior/posterior axis specification" -"GO:0071569","protein ufmylation" -"GO:0009608","response to symbiont" -"GO:1900182","positive regulation of protein localization to nucleus" -"GO:0043225","ATPase-coupled anion transmembrane transporter activity" -"GO:1900691","positive regulation of gliotoxin biosynthetic process" -"GO:0022900","electron transport chain" -"GO:0001731","formation of translation preinitiation complex" -"GO:0015108","chloride transmembrane transporter activity" -"GO:0006520","cellular amino acid metabolic process" -"GO:0036225","cellular response to vitamin B1 starvation" -"GO:1990372","process resulting in tolerance to organic acid" -"GO:0060528","secretory columnal luminar epithelial cell differentiation involved in prostate glandular acinus development" -"GO:0005991","trehalose metabolic process" -"GO:1900579","(17Z)-protosta-17(20),24-dien-3beta-ol metabolic process" -"GO:0048457","floral whorl morphogenesis" -"GO:0031059","histone deacetylation at centromere" -"GO:0048730","epidermis morphogenesis" -"GO:0060557","positive regulation of vitamin D biosynthetic process" -"GO:0018865","acrylonitrile metabolic process" -"GO:1900075","positive regulation of neuromuscular synaptic transmission" -"GO:2000116","regulation of cysteine-type endopeptidase activity" -"GO:0033209","tumor necrosis factor-mediated signaling pathway" -"GO:0052048","interaction with host via secreted substance involved in symbiotic interaction" -"GO:1904505","regulation of telomere maintenance in response to DNA damage" -"GO:0035076","ecdysone receptor-mediated signaling pathway" -"GO:1990388","xylem-to-phloem iron transport" -"GO:0071731","response to nitric oxide" -"GO:0006998","nuclear envelope organization" -"GO:0006588","activation of tryptophan 5-monooxygenase activity" -"GO:0006354","DNA-templated transcription, elongation" -"GO:1990778","protein localization to cell periphery" -"GO:1903713","asparagine transmembrane transport" -"GO:0035802","adrenal cortex formation" -"GO:0046496","nicotinamide nucleotide metabolic process" -"GO:1902805","positive regulation of synaptic vesicle transport" -"GO:0044206","UMP salvage" -"GO:1900164","nodal signaling pathway involved in determination of lateral mesoderm left/right asymmetry" -"GO:0046486","glycerolipid metabolic process" -"GO:0045823","positive regulation of heart contraction" -"GO:0072079","nephron tubule formation" -"GO:0061428","negative regulation of transcription from RNA polymerase II promoter in response to hypoxia" -"GO:0038157","granulocyte-macrophage colony-stimulating factor signaling pathway" -"GO:0072090","mesenchymal stem cell proliferation involved in nephron morphogenesis" -"GO:0072149","glomerular visceral epithelial cell fate commitment" -"GO:0006363","termination of RNA polymerase I transcription" -"GO:0038063","collagen-activated tyrosine kinase receptor signaling pathway" -"GO:2000417","negative regulation of eosinophil migration" -"GO:0048738","cardiac muscle tissue development" -"GO:0060296","regulation of cilium beat frequency involved in ciliary motility" -"GO:0014736","negative regulation of muscle atrophy" -"GO:0015793","glycerol transport" -"GO:0051386","regulation of neurotrophin TRK receptor signaling pathway" -"GO:1905437","positive regulation of histone H3-K4 trimethylation" -"GO:0005262","calcium channel activity" -"GO:1904672","regulation of somatic stem cell population maintenance" -"GO:0071676","negative regulation of mononuclear cell migration" -"GO:0061336","cell morphogenesis involved in Malpighian tubule morphogenesis" -"GO:0035492","negative regulation of leukotriene production involved in inflammatory response" -"GO:2000406","positive regulation of T cell migration" -"GO:0006361","transcription initiation from RNA polymerase I promoter" -"GO:0090378","seed trichome elongation" -"GO:1990942","mitotic metaphase chromosome recapture" -"GO:0072537","fibroblast activation" -"GO:1900028","negative regulation of ruffle assembly" -"GO:0046086","adenosine biosynthetic process" -"GO:0090091","positive regulation of extracellular matrix disassembly" -"GO:0046627","negative regulation of insulin receptor signaling pathway" -"GO:0060112","generation of ovulation cycle rhythm" -"GO:0021995","neuropore closure" -"GO:1902751","positive regulation of cell cycle G2/M phase transition" -"GO:0060547","negative regulation of necrotic cell death" -"GO:0061147","endocardial endothelium development" -"GO:0019742","pentacyclic triterpenoid metabolic process" -"GO:0000338","protein deneddylation" -"GO:0002110","cotranscriptional mitochondrial rRNA nucleotide insertion" -"GO:0033230","cysteine-transporting ATPase activity" -"GO:0098528","skeletal muscle fiber differentiation" -"GO:0051352","negative regulation of ligase activity" -"GO:1903539","protein localization to postsynaptic membrane" -"GO:0090201","negative regulation of release of cytochrome c from mitochondria" -"GO:0090713","immunological memory process" -"GO:1905522","negative regulation of macrophage migration" -"GO:0045391","negative regulation of interleukin-21 biosynthetic process" -"GO:0061292","canonical Wnt signaling pathway involved in mesonephros development" -"GO:0051904","pigment granule transport" -"GO:0048563","post-embryonic animal organ morphogenesis" -"GO:0038196","type III interferon signaling pathway" -"GO:2000393","negative regulation of lamellipodium morphogenesis" -"GO:0000424","micromitophagy" -"GO:0061971","replacement bone morphogenesis" -"GO:1902659","regulation of glucose mediated signaling pathway" -"GO:1900260","negative regulation of RNA-directed 5'-3' RNA polymerase activity" -"GO:0033138","positive regulation of peptidyl-serine phosphorylation" -"GO:0003156","regulation of animal organ formation" -"GO:0035024","negative regulation of Rho protein signal transduction" -"GO:0045688","regulation of antipodal cell differentiation" -"GO:1905598","negative regulation of low-density lipoprotein receptor activity" -"GO:0060909","regulation of DNA replication initiation involved in plasmid copy number maintenance" -"GO:0035921","desmosome disassembly" -"GO:0048560","establishment of anatomical structure orientation" -"GO:0007077","mitotic nuclear envelope disassembly" -"GO:0060616","mammary gland cord formation" -"GO:0048853","forebrain morphogenesis" -"GO:0006921","cellular component disassembly involved in execution phase of apoptosis" -"GO:0048766","root hair initiation" -"GO:0045578","negative regulation of B cell differentiation" -"GO:0015112","nitrate transmembrane transporter activity" -"GO:0034491","neutral amino acid transmembrane import into vacuole" -"GO:0015805","S-adenosyl-L-methionine transport" -"GO:0032297","negative regulation of DNA-dependent DNA replication initiation" -"GO:0071398","cellular response to fatty acid" -"GO:0050893","sensory processing" -"GO:0010091","trichome branching" -"GO:0015876","acetyl-CoA transport" -"GO:0045943","positive regulation of transcription by RNA polymerase I" -"GO:0048938","lateral line nerve glial cell morphogenesis involved in differentiation" -"GO:0051058","negative regulation of small GTPase mediated signal transduction" -"GO:0007375","anterior midgut invagination" -"GO:0052199","negative regulation of catalytic activity in other organism involved in symbiotic interaction" -"GO:1903179","regulation of dopamine biosynthetic process" -"GO:0044329","canonical Wnt signaling pathway involved in positive regulation of cell-cell adhesion" -"GO:0070571","negative regulation of neuron projection regeneration" -"GO:0048601","oocyte morphogenesis" -"GO:0045743","positive regulation of fibroblast growth factor receptor signaling pathway" -"GO:0060929","atrioventricular node cell fate commitment" -"GO:0007391","dorsal closure" -"GO:0140105","interleukin-10-mediated signaling pathway" -"GO:1903381","regulation of endoplasmic reticulum stress-induced neuron intrinsic apoptotic signaling pathway" -"GO:0007250","activation of NF-kappaB-inducing kinase activity" -"GO:1904770","intramembranous bone morphogenesis" -"GO:0071245","cellular response to carbon monoxide" -"GO:0050773","regulation of dendrite development" -"GO:0070197","meiotic attachment of telomere to nuclear envelope" -"GO:1903714","isoleucine transmembrane transport" -"GO:0048236","plant-type sporogenesis" -"GO:0090171","chondrocyte morphogenesis" -"GO:0010227","floral organ abscission" -"GO:0034440","lipid oxidation" -"GO:0070317","negative regulation of G0 to G1 transition" -"GO:0035772","interleukin-13-mediated signaling pathway" -"GO:1902109","negative regulation of mitochondrial membrane permeability involved in apoptotic process" -"GO:1902903","regulation of supramolecular fiber organization" -"GO:1903526","negative regulation of membrane tubulation" -"GO:0033321","homomethionine metabolic process" -"GO:0018097","protein-chromophore linkage via peptidyl-S-4-hydroxycinnamyl-L-cysteine" -"GO:0099149","regulation of postsynaptic neurotransmitter receptor internalization" -"GO:1903668","negative regulation of chemorepellent activity" -"GO:1990001","inhibition of cysteine-type endopeptidase activity involved in apoptotic process" -"GO:0018928","methyl ethyl ketone metabolic process" -"GO:0007611","learning or memory" -"GO:0072753","cellular response to glutathione" -"GO:0002471","monocyte antigen processing and presentation" -"GO:0070201","regulation of establishment of protein localization" -"GO:0038154","interleukin-11-mediated signaling pathway" -"GO:0006360","transcription by RNA polymerase I" -"GO:0006642","triglyceride mobilization" -"GO:0033234","negative regulation of protein sumoylation" -"GO:0034134","toll-like receptor 2 signaling pathway" -"GO:0097193","intrinsic apoptotic signaling pathway" -"GO:0002745","antigen processing and presentation initiated by receptor mediated uptake of antigen" -"GO:0009868","jasmonic acid and ethylene-dependent systemic resistance, jasmonic acid mediated signaling pathway" -"GO:0051139","metal ion:proton antiporter activity" -"GO:0001880","Mullerian duct regression" -"GO:1901331","positive regulation of odontoblast differentiation" -"GO:2000152","regulation of ubiquitin-specific protease activity" -"GO:0001787","natural killer cell proliferation" -"GO:0098629","trans-Golgi network membrane organization" -"GO:0070194","synaptonemal complex disassembly" -"GO:1904604","negative regulation of advanced glycation end-product receptor activity" -"GO:0090021","positive regulation of posterior neural plate formation by Wnt signaling pathway" -"GO:0031887","lipid droplet transport along microtubule" -"GO:0010772","meiotic DNA recombinase assembly involved in reciprocal meiotic recombination" -"GO:1904466","positive regulation of matrix metallopeptidase secretion" -"GO:0101026","nuclear membrane biogenesis involved in mitotic nuclear division" -"GO:0033357","L-arabinose biosynthetic process" -"GO:0086026","atrial cardiac muscle cell to AV node cell signaling" -"GO:0098657","import into cell" -"GO:0035537","positive regulation of chemokine (C-C motif) ligand 6 secretion" -"GO:0007300","ovarian nurse cell to oocyte transport" -"GO:0035044","sperm aster formation" -"GO:0043367","CD4-positive, alpha-beta T cell differentiation" -"GO:2000107","negative regulation of leukocyte apoptotic process" -"GO:0060889","limb basal epidermal cell differentiation" -"GO:2000895","hemicellulose catabolic process" -"GO:0031958","corticosteroid receptor signaling pathway" -"GO:0071346","cellular response to interferon-gamma" -"GO:1902610","response to N-phenylthiourea" -"GO:0045161","neuronal ion channel clustering" -"GO:0099111","microtubule-based transport" -"GO:0035779","angioblast cell differentiation" -"GO:0035459","cargo loading into vesicle" -"GO:0006448","regulation of translational elongation" -"GO:1902278","positive regulation of pancreatic amylase secretion" -"GO:0001300","chronological cell aging" -"GO:2000394","positive regulation of lamellipodium morphogenesis" -"GO:0006025","galactosaminoglycan biosynthetic process" -"GO:0019858","cytosine metabolic process" -"GO:0034723","DNA replication-dependent nucleosome organization" -"GO:0071289","cellular response to nickel ion" -"GO:0015299","solute:proton antiporter activity" -"GO:0001059","transcription by RNA polymerase IV" -"GO:0140077","positive regulation of lipoprotein transport" -"GO:0010159","specification of animal organ position" -"GO:0010160","formation of animal organ boundary" -"GO:0001981","baroreceptor detection of arterial stretch" -"GO:0051250","negative regulation of lymphocyte activation" -"GO:0071702","organic substance transport" -"GO:0097238","cellular response to methylglyoxal" -"GO:1904795","positive regulation of euchromatin binding" -"GO:0006238","CMP salvage" -"GO:1905599","positive regulation of low-density lipoprotein receptor activity" -"GO:1904741","positive regulation of filamentous growth of a population of unicellular organisms in response to starvation by positive regulation of transcription from RNA polymerase II promoter" -"GO:0048897","myelination of lateral line nerve axons" -"GO:0097187","dentinogenesis" -"GO:0044766","multi-organism transport" -"GO:0006571","tyrosine biosynthetic process" -"GO:1902216","positive regulation of interleukin-4-mediated signaling pathway" -"GO:0051308","male meiosis chromosome separation" -"GO:0072497","mesenchymal stem cell differentiation" -"GO:0061479","response to reverse transcriptase inhibitor" -"GO:1905251","epidermal growth factor receptor signaling pathway involved in heart process" -"GO:1902895","positive regulation of pri-miRNA transcription by RNA polymerase II" -"GO:0032940","secretion by cell" -"GO:1901678","iron coordination entity transport" -"GO:0060558","regulation of calcidiol 1-monooxygenase activity" -"GO:2001208","negative regulation of transcription elongation by RNA polymerase I" -"GO:0055011","atrial cardiac muscle cell differentiation" -"GO:0007146","meiotic recombination nodule assembly" -"GO:1900375","positive regulation of inositol biosynthetic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:0014712","positive regulation of branchiomeric skeletal muscle development" -"GO:0000294","nuclear-transcribed mRNA catabolic process, endonucleolytic cleavage-dependent decay" -"GO:1903594","negative regulation of histamine secretion by mast cell" -"GO:0042730","fibrinolysis" -"GO:0002287","alpha-beta T cell activation involved in immune response" -"GO:0038167","epidermal growth factor receptor signaling pathway via positive regulation of NF-kappaB transcription factor activity" -"GO:0015669","gas transport" -"GO:1905504","negative regulation of motile cilium assembly" -"GO:0061312","BMP signaling pathway involved in heart development" -"GO:0019375","galactolipid biosynthetic process" -"GO:0031497","chromatin assembly" -"GO:0035912","dorsal aorta morphogenesis" -"GO:0070092","regulation of glucagon secretion" -"GO:0071584","negative regulation of zinc ion transmembrane import" -"GO:1903912","negative regulation of endoplasmic reticulum stress-induced eIF2 alpha phosphorylation" -"GO:0022026","epidermal growth factor signaling pathway involved in forebrain neuron fate commitment" -"GO:0003389","retrograde extension" -"GO:0030194","positive regulation of blood coagulation" -"GO:0009058","biosynthetic process" -"GO:0010496","intercellular transport" -"GO:0035137","hindlimb morphogenesis" -"GO:0021983","pituitary gland development" -"GO:1990556","mitochondrial isopropylmalate transmembrane transport" -"GO:0019435","sophorosyloxydocosanoate biosynthetic process" -"GO:0060507","epidermal growth factor receptor signaling pathway involved in lung development" -"GO:0036372","opsin transport" -"GO:0001707","mesoderm formation" -"GO:1903971","positive regulation of response to macrophage colony-stimulating factor" -"GO:0038137","ERBB4-EGFR signaling pathway" -"GO:0003183","mitral valve morphogenesis" -"GO:1901475","pyruvate transmembrane transport" -"GO:1904244","positive regulation of pancreatic trypsinogen secretion" -"GO:0006232","TDP biosynthetic process" -"GO:0009245","lipid A biosynthetic process" -"GO:1905956","positive regulation of endothelial tube morphogenesis" -"GO:1990553","mitochondrial 5'-adenylyl sulfate transmembrane transport" -"GO:0070238","activated T cell autonomous cell death" -"GO:1903948","negative regulation of atrial cardiac muscle cell action potential" -"GO:0038029","epidermal growth factor receptor signaling pathway via MAPK cascade" -"GO:2000098","negative regulation of smooth muscle cell-matrix adhesion" -"GO:0007107","membrane addition at site of cytokinesis" -"GO:0051153","regulation of striated muscle cell differentiation" -"GO:0048198","Golgi vesicle bud deformation and release" -"GO:0001818","negative regulation of cytokine production" -"GO:2000744","positive regulation of anterior head development" -"GO:0060303","regulation of nucleosome density" -"GO:0001808","negative regulation of type IV hypersensitivity" -"GO:0006818","hydrogen transport" -"GO:1901760","beta-L-Ara4N-lipid A biosynthetic process" -"GO:0043604","amide biosynthetic process" -"GO:0098708","glucose import across plasma membrane" -"GO:1904794","negative regulation of euchromatin binding" -"GO:0002292","T cell differentiation involved in immune response" -"GO:0010862","positive regulation of pathway-restricted SMAD protein phosphorylation" -"GO:0060992","response to fungicide" -"GO:0061364","apoptotic process involved in luteolysis" -"GO:0006545","glycine biosynthetic process" -"GO:0071632","optomotor response" -"GO:0036494","positive regulation of translation initiation in response to endoplasmic reticulum stress" -"GO:0051302","regulation of cell division" -"GO:0046884","follicle-stimulating hormone secretion" -"GO:0030807","positive regulation of cyclic nucleotide catabolic process" -"GO:0008653","lipopolysaccharide metabolic process" -"GO:1902358","sulfate transmembrane transport" -"GO:1903542","negative regulation of exosomal secretion" -"GO:0100009","regulation of fever generation by prostaglandin secretion" -"GO:1905706","regulation of mitochondrial ATP synthesis coupled proton transport" -"GO:2000287","positive regulation of myotome development" -"GO:0031393","negative regulation of prostaglandin biosynthetic process" -"GO:0008314","gurken signaling pathway" -"GO:0003223","ventricular compact myocardium morphogenesis" -"GO:0015701","bicarbonate transport" -"GO:1905303","positive regulation of macropinocytosis" -"GO:1900501","negative regulation of butyryl-CoA catabolic process to butyrate" -"GO:0071705","nitrogen compound transport" -"GO:0072348","sulfur compound transport" -"GO:0003203","endocardial cushion morphogenesis" -"GO:0070561","vitamin D receptor signaling pathway" -"GO:0051664","nuclear pore localization" -"GO:0046224","bacteriocin metabolic process" -"GO:0045687","positive regulation of glial cell differentiation" -"GO:1905698","positive regulation of polysome binding" -"GO:0019532","oxalate transport" -"GO:0005978","glycogen biosynthetic process" -"GO:0070583","spore membrane bending pathway" -"GO:0009090","homoserine biosynthetic process" -"GO:0061045","negative regulation of wound healing" -"GO:0060596","mammary placode formation" -"GO:0050887","determination of sensory modality" -"GO:0070581","rolling circle DNA replication" -"GO:0032486","Rap protein signal transduction" -"GO:1904168","negative regulation of thyroid hormone receptor activity" -"GO:0014054","positive regulation of gamma-aminobutyric acid secretion" -"GO:1905889","positive regulation of cellular response to very-low-density lipoprotein particle stimulus" -"GO:1904092","regulation of autophagic cell death" -"GO:0032214","negative regulation of telomere maintenance via semi-conservative replication" -"GO:1903450","regulation of G1 to G0 transition" -"GO:0010836","negative regulation of protein ADP-ribosylation" -"GO:1905066","regulation of canonical Wnt signaling pathway involved in heart development" -"GO:0061082","myeloid leukocyte cytokine production" -"GO:0110044","regulation of cell cycle switching, mitotic to meiotic cell cycle" -"GO:0048878","chemical homeostasis" -"GO:0071850","mitotic cell cycle arrest" -"GO:2000782","regulation of establishment of cell polarity regulating cell shape" -"GO:0046854","phosphatidylinositol phosphorylation" -"GO:0099140","presynaptic actin cytoskeleton organization" -"GO:0000963","mitochondrial RNA processing" -"GO:0062010","primitive palate development" -"GO:0036306","embryonic heart tube elongation" -"GO:0003240","conus arteriosus formation" -"GO:0033045","regulation of sister chromatid segregation" -"GO:0003131","mesodermal-endodermal cell signaling" -"GO:0003175","tricuspid valve development" -"GO:0060226","negative regulation of retinal cone cell fate commitment" -"GO:0031087","deadenylation-independent decapping of nuclear-transcribed mRNA" -"GO:0036124","histone H3-K9 trimethylation" -"GO:1904894","positive regulation of STAT cascade" -"GO:0048872","homeostasis of number of cells" -"GO:0015949","nucleobase-containing small molecule interconversion" -"GO:0072060","outer medullary collecting duct development" -"GO:0090436","leaf pavement cell development" -"GO:0097235","positive regulation of fatty acid beta-oxidation by positive regulation of transcription from RNA polymerase II promoter" -"GO:1904686","regulation of mitotic spindle disassembly" -"GO:0035928","rRNA import into mitochondrion" -"GO:0072583","clathrin-dependent endocytosis" -"GO:1905409","positive regulation of creatine transmembrane transporter activity" -"GO:0008535","respiratory chain complex IV assembly" -"GO:1902504","regulation of signal transduction involved in mitotic G2 DNA damage checkpoint" -"GO:0038193","thromboxane A2 signaling pathway" -"GO:0003090","positive regulation of the force of heart contraction by neuronal epinephrine-norepinephrine" -"GO:0044648","histone H3-K4 dimethylation" -"GO:1900556","emericellamide catabolic process" -"GO:0003210","cardiac atrium formation" -"GO:1903241","U2-type prespliceosome assembly" -"GO:0001692","histamine metabolic process" -"GO:0032904","negative regulation of nerve growth factor production" -"GO:0072283","metanephric renal vesicle morphogenesis" -"GO:0043940","regulation of sexual sporulation resulting in formation of a cellular spore" -"GO:0031943","regulation of glucocorticoid metabolic process" -"GO:1990646","cellular response to prolactin" -"GO:0071351","cellular response to interleukin-18" -"GO:0003237","sinus venosus formation" -"GO:0061794","conidium development" -"GO:1905628","negative regulation of serotonin biosynthetic process" -"GO:0046681","response to carbamate" -"GO:0032888","regulation of mitotic spindle elongation" -"GO:0032875","regulation of DNA endoreduplication" -"GO:0014066","regulation of phosphatidylinositol 3-kinase signaling" -"GO:2001038","regulation of cellular response to drug" -"GO:0070316","regulation of G0 to G1 transition" -"GO:0003234","bulbus arteriosus formation" -"GO:0019060","intracellular transport of viral protein in host cell" -"GO:0070243","regulation of thymocyte apoptotic process" -"GO:0071045","nuclear histone mRNA catabolic process" -"GO:0043631","RNA polyadenylation" -"GO:0071441","negative regulation of histone H3-K14 acetylation" -"GO:0090389","phagosome-lysosome fusion involved in apoptotic cell clearance" -"GO:1905079","regulation of cerebellar neuron development" -"GO:0043928","exonucleolytic nuclear-transcribed mRNA catabolic process involved in deadenylation-dependent decay" -"GO:1904891","positive regulation of excitatory synapse assembly" -"GO:0035737","injection of substance in to other organism" -"GO:0043457","regulation of cellular respiration" -"GO:0014007","negative regulation of microglia differentiation" -"GO:0042628","mating plug formation" -"GO:1902891","negative regulation of root hair elongation" -"GO:0090224","regulation of spindle organization" -"GO:0042342","cyanogenic glycoside catabolic process" -"GO:0071481","cellular response to X-ray" -"GO:0097081","vascular smooth muscle cell fate commitment" -"GO:0006343","establishment of chromatin silencing" -"GO:0000958","mitochondrial mRNA catabolic process" -"GO:2000685","positive regulation of cellular response to X-ray" -"GO:0071623","negative regulation of granulocyte chemotaxis" -"GO:0033139","regulation of peptidyl-serine phosphorylation of STAT protein" -"GO:0072061","inner medullary collecting duct development" -"GO:0048370","lateral mesoderm formation" -"GO:0044705","multi-organism reproductive behavior" -"GO:0033259","plastid DNA replication" -"GO:0014039","negative regulation of Schwann cell differentiation" -"GO:0060416","response to growth hormone" -"GO:0031495","negative regulation of mating type switching" -"GO:0002377","immunoglobulin production" -"GO:0010737","protein kinase A signaling" -"GO:0046324","regulation of glucose import" -"GO:0021544","subpallium development" -"GO:0021979","hypothalamus cell differentiation" -"GO:0003403","optic vesicle formation" -"GO:1903323","regulation of snoRNA metabolic process" -"GO:0033595","response to genistein" -"GO:0090502","RNA phosphodiester bond hydrolysis, endonucleolytic" -"GO:0043970","histone H3-K9 acetylation" -"GO:0051795","positive regulation of timing of catagen" -"GO:0031277","positive regulation of lateral pseudopodium assembly" -"GO:0060069","Wnt signaling pathway, regulating spindle positioning" -"GO:1901270","lipooligosaccharide catabolic process" -"GO:0002281","macrophage activation involved in immune response" -"GO:0021603","cranial nerve formation" -"GO:0003242","cardiac chamber ballooning" -"GO:0033962","cytoplasmic mRNA processing body assembly" -"GO:0048173","positive regulation of short-term neuronal synaptic plasticity" -"GO:0003127","detection of nodal flow" -"GO:0000430","regulation of transcription from RNA polymerase II promoter by glucose" -"GO:0090230","regulation of centromere complex assembly" -"GO:0006661","phosphatidylinositol biosynthetic process" -"GO:0000965","mitochondrial RNA 3'-end processing" -"GO:0106012","positive regulation of protein localization to medial cortex" -"GO:0062009","secondary palate development" -"GO:0071985","multivesicular body sorting pathway" -"GO:0098628","peptidyl-N-phospho-arginine dephosphorylation" -"GO:0110028","positive regulation of mitotic spindle organization" -"GO:1902726","positive regulation of skeletal muscle satellite cell differentiation" -"GO:0019303","D-ribose catabolic process" -"GO:1990619","histone H3-K9 deacetylation" -"GO:1903341","regulation of meiotic DNA double-strand break formation" -"GO:0046364","monosaccharide biosynthetic process" -"GO:1905306","positive regulation of cardiac myofibril assembly" -"GO:0061864","basement membrane constituent secretion" -"GO:0051464","positive regulation of cortisol secretion" -"GO:0034122","negative regulation of toll-like receptor signaling pathway" -"GO:1904675","regulation of somatic stem cell division" -"GO:0000964","mitochondrial RNA 5'-end processing" -"GO:0031325","positive regulation of cellular metabolic process" -"GO:0035458","cellular response to interferon-beta" -"GO:0042793","plastid transcription" -"GO:0006768","biotin metabolic process" -"GO:0038042","dimeric G-protein coupled receptor signaling pathway" -"GO:0045968","negative regulation of juvenile hormone biosynthetic process" -"GO:0044148","positive regulation of growth of symbiont involved in interaction with host" -"GO:0006490","oligosaccharide-lipid intermediate biosynthetic process" -"GO:0008610","lipid biosynthetic process" -"GO:0071072","negative regulation of phospholipid biosynthetic process" -"GO:0010573","vascular endothelial growth factor production" -"GO:0032814","regulation of natural killer cell activation" -"GO:0061148","extracellular matrix organization involved in endocardium development" -"GO:0016556","mRNA modification" -"GO:0006188","IMP biosynthetic process" -"GO:0014879","detection of electrical stimulus involved in regulation of muscle adaptation" -"GO:0085034","negative regulation by symbiont of host I-kappaB kinase/NF-kappaB cascade" -"GO:0010608","posttranscriptional regulation of gene expression" -"GO:0044344","cellular response to fibroblast growth factor stimulus" -"GO:0045906","negative regulation of vasoconstriction" -"GO:0140049","regulation of endocardial cushion to mesenchymal transition" -"GO:0071489","cellular response to red or far red light" -"GO:0061646","positive regulation of glutamate neurotransmitter secretion in response to membrane depolarization" -"GO:0072325","vulval cell fate commitment" -"GO:0018352","protein-pyridoxal-5-phosphate linkage" -"GO:0046785","microtubule polymerization" -"GO:0090147","regulation of establishment of mitochondrion localization involved in mitochondrial fission" -"GO:0042427","serotonin biosynthetic process" -"GO:0021801","cerebral cortex radial glia guided migration" -"GO:0034982","mitochondrial protein processing" -"GO:1900659","negative regulation of emericellamide biosynthetic process" -"GO:1905601","negative regulation of receptor-mediated endocytosis involved in cholesterol transport" -"GO:1901409","positive regulation of phosphorylation of RNA polymerase II C-terminal domain" -"GO:0016540","protein autoprocessing" -"GO:1902549","protein localization to Mei2 nuclear dot" -"GO:1904651","positive regulation of fat cell apoptotic process" -"GO:0035507","regulation of myosin-light-chain-phosphatase activity" -"GO:0009894","regulation of catabolic process" -"GO:0016257","N-glycan processing to secreted and cell-surface N-glycans" -"GO:2000698","positive regulation of epithelial cell differentiation involved in kidney development" -"GO:0061844","antimicrobial humoral immune response mediated by antimicrobial peptide" -"GO:0045234","protein palmitoleylation" -"GO:2000288","positive regulation of myoblast proliferation" -"GO:1903287","negative regulation of potassium ion import" -"GO:0071765","nuclear inner membrane organization" -"GO:0002236","detection of misfolded protein" -"GO:0097604","temperature-gated cation channel activity" -"GO:0002851","positive regulation of peripheral T cell tolerance induction" -"GO:1904645","response to amyloid-beta" -"GO:0010208","pollen wall assembly" -"GO:0007621","negative regulation of female receptivity" -"GO:1901672","positive regulation of systemic acquired resistance" -"GO:0140135","mechanosensitive cation channel activity" -"GO:1900908","regulation of olefin metabolic process" -"GO:2000298","regulation of Rho-dependent protein serine/threonine kinase activity" -"GO:0098784","biofilm matrix organization" -"GO:0006595","polyamine metabolic process" -"GO:0070672","response to interleukin-15" -"GO:0051545","negative regulation of elastin biosynthetic process" -"GO:0007529","establishment of synaptic specificity at neuromuscular junction" -"GO:1902603","carnitine transmembrane transport" -"GO:0036438","maintenance of lens transparency" -"GO:0090223","chromatin-templated microtubule nucleation" -"GO:0016131","brassinosteroid metabolic process" -"GO:0015990","electron transport coupled proton transport" -"GO:0048316","seed development" -"GO:0006222","UMP biosynthetic process" -"GO:0048035","heme o catabolic process" -"GO:0019637","organophosphate metabolic process" -"GO:0019557","histidine catabolic process to glutamate and formate" -"GO:0019713","peptidyl-L-glutamic acid 5-methyl ester biosynthetic process from glutamine" -"GO:0003246","embryonic cardiac muscle cell growth involved in heart morphogenesis" -"GO:0034163","regulation of toll-like receptor 9 signaling pathway" -"GO:0042144","vacuole fusion, non-autophagic" -"GO:0015252","proton channel activity" -"GO:0043403","skeletal muscle tissue regeneration" -"GO:0007016","cytoskeletal anchoring at plasma membrane" -"GO:1901543","negative regulation of ent-pimara-8(14),15-diene biosynthetic process" -"GO:0036108","4-amino-4-deoxy-alpha-L-arabinopyranosyl undecaprenyl phosphate biosynthetic process" -"GO:0000719","photoreactive repair" -"GO:0021675","nerve development" -"GO:0035504","regulation of myosin light chain kinase activity" -"GO:1904383","response to sodium phosphate" -"GO:1900481","negative regulation of diacylglycerol biosynthetic process" -"GO:0010215","cellulose microfibril organization" -"GO:0046219","indolalkylamine biosynthetic process" -"GO:0002353","plasma kallikrein-kinin cascade" -"GO:1905036","positive regulation of antifungal innate immune response" -"GO:1903616","MAPK cascade involved in axon regeneration" -"GO:0009072","aromatic amino acid family metabolic process" -"GO:0035751","regulation of lysosomal lumen pH" -"GO:0002898","regulation of central B cell deletion" -"GO:0007402","ganglion mother cell fate determination" -"GO:0099623","regulation of cardiac muscle cell membrane repolarization" -"GO:1903530","regulation of secretion by cell" -"GO:0018910","benzene metabolic process" -"GO:0021820","extracellular matrix organization in marginal zone involved in cerebral cortex radial glia guided migration" -"GO:0002717","positive regulation of natural killer cell mediated immunity" -"GO:0042150","plasmid recombination" -"GO:0050759","positive regulation of thymidylate synthase biosynthetic process" -"GO:1900948","negative regulation of isoprene biosynthetic process" -"GO:0044092","negative regulation of molecular function" -"GO:0010755","regulation of plasminogen activation" -"GO:0098914","membrane repolarization during atrial cardiac muscle cell action potential" -"GO:1902082","positive regulation of calcium ion import into sarcoplasmic reticulum" -"GO:0021527","spinal cord association neuron differentiation" -"GO:0098693","regulation of synaptic vesicle cycle" -"GO:2000480","negative regulation of cAMP-dependent protein kinase activity" -"GO:0045186","zonula adherens assembly" -"GO:0035008","positive regulation of melanization defense response" -"GO:0097689","iron channel activity" -"GO:0015939","pantothenate metabolic process" -"GO:0035287","head segmentation" -"GO:0072135","kidney mesenchymal cell proliferation" -"GO:1903921","regulation of protein processing in phagocytic vesicle" -"GO:1900767","fonsecin metabolic process" -"GO:0034116","positive regulation of heterotypic cell-cell adhesion" -"GO:1905617","negative regulation of miRNA mediated inhibition of translation" -"GO:0072579","glycine receptor clustering" -"GO:0007545","processes downstream of sex determination signal" -"GO:0006597","spermine biosynthetic process" -"GO:0052652","cyclic purine nucleotide metabolic process" -"GO:0044350","micropinocytosis" -"GO:0090359","negative regulation of abscisic acid biosynthetic process" -"GO:0015908","fatty acid transport" -"GO:1900053","negative regulation of retinoic acid biosynthetic process" -"GO:0019626","short-chain fatty acid catabolic process" -"GO:0006760","folic acid-containing compound metabolic process" -"GO:0097502","mannosylation" -"GO:0048352","paraxial mesoderm structural organization" -"GO:0032339","negative regulation of inhibin secretion" -"GO:0038060","nitric oxide-cGMP-mediated signaling pathway" -"GO:0036104","Kdo2-lipid A biosynthetic process" -"GO:1903178","positive regulation of tyrosine 3-monooxygenase activity" -"GO:2000229","regulation of pancreatic stellate cell proliferation" -"GO:0009752","detection of salicylic acid stimulus" -"GO:1901995","positive regulation of meiotic cell cycle phase transition" -"GO:1904295","regulation of osmolarity-sensing cation channel activity" -"GO:0035027","leading edge cell fate commitment" -"GO:0014880","regulation of muscle filament sliding involved in regulation of the velocity of shortening in skeletal muscle contraction" -"GO:0045425","positive regulation of granulocyte macrophage colony-stimulating factor biosynthetic process" -"GO:0021586","pons maturation" -"GO:2000277","positive regulation of oxidative phosphorylation uncoupler activity" -"GO:0001955","blood vessel maturation" -"GO:1903069","regulation of ER-associated ubiquitin-dependent protein catabolic process" -"GO:0021884","forebrain neuron development" -"GO:1904729","regulation of intestinal lipid absorption" -"GO:1902237","positive regulation of endoplasmic reticulum stress-induced intrinsic apoptotic signaling pathway" -"GO:1904414","positive regulation of cardiac ventricle development" -"GO:0036471","cellular response to glyoxal" -"GO:0090278","negative regulation of peptide hormone secretion" -"GO:0007558","regulation of juvenile hormone secretion" -"GO:2000812","regulation of barbed-end actin filament capping" -"GO:1903698","positive regulation of microvillus assembly" -"GO:0060571","morphogenesis of an epithelial fold" -"GO:0050676","negative regulation of urothelial cell proliferation" -"GO:0061245","establishment or maintenance of bipolar cell polarity" -"GO:1904114","positive regulation of muscle filament sliding" -"GO:1990442","intrinsic apoptotic signaling pathway in response to nitrosative stress" -"GO:2001268","negative regulation of cysteine-type endopeptidase activity involved in apoptotic signaling pathway" -"GO:0002852","regulation of T cell mediated cytotoxicity directed against tumor cell target" -"GO:0043366","beta selection" -"GO:0021506","anterior neuropore closure" -"GO:0034125","negative regulation of MyD88-dependent toll-like receptor signaling pathway" -"GO:0001839","neural plate morphogenesis" -"GO:0060146","host gene silencing in virus induced gene silencing" -"GO:0032125","micronucleus organization" -"GO:0032265","XMP salvage" -"GO:1905429","response to glycine" -"GO:0070377","negative regulation of ERK5 cascade" -"GO:0030513","positive regulation of BMP signaling pathway" -"GO:0003161","cardiac conduction system development" -"GO:0003222","ventricular trabecula myocardium morphogenesis" -"GO:0046157","siroheme catabolic process" -"GO:1900548","heme b catabolic process" -"GO:0072001","renal system development" -"GO:0042789","mRNA transcription by RNA polymerase II" -"GO:1904254","regulation of iron channel activity" -"GO:0008218","bioluminescence" -"GO:0033563","dorsal/ventral axon guidance" -"GO:0021998","neural plate mediolateral regionalization" -"GO:1903294","regulation of glutamate secretion, neurotransmission" -"GO:0010665","regulation of cardiac muscle cell apoptotic process" -"GO:0030221","basophil differentiation" -"GO:0001974","blood vessel remodeling" -"GO:0090134","cell migration involved in mesendoderm migration" -"GO:1904196","negative regulation of granulosa cell proliferation" -"GO:0060045","positive regulation of cardiac muscle cell proliferation" -"GO:1903755","positive regulation of SUMO transferase activity" -"GO:0007036","vacuolar calcium ion homeostasis" -"GO:0031668","cellular response to extracellular stimulus" -"GO:1903197","positive regulation of L-dopa biosynthetic process" -"GO:0030042","actin filament depolymerization" -"GO:0008015","blood circulation" -"GO:0055070","copper ion homeostasis" -"GO:1903454","regulation of androst-4-ene-3,17-dione biosynthetic process" -"GO:0060587","regulation of lipoprotein lipid oxidation" -"GO:0014058","negative regulation of acetylcholine secretion, neurotransmission" -"GO:0003186","tricuspid valve morphogenesis" -"GO:0044147","negative regulation of development of symbiont involved in interaction with host" -"GO:0010847","regulation of chromatin assembly" -"GO:0043535","regulation of blood vessel endothelial cell migration" -"GO:2000831","regulation of steroid hormone secretion" -"GO:2000420","negative regulation of eosinophil extravasation" -"GO:0050768","negative regulation of neurogenesis" -"GO:1990781","response to immobilization stress combined with electrical stimulus" -"GO:0061591","calcium activated galactosylceramide scrambling" -"GO:1905292","regulation of neural crest cell differentiation" -"GO:0045797","positive regulation of intestinal cholesterol absorption" -"GO:0061536","glycine secretion" -"GO:0003173","ventriculo bulbo valve development" -"GO:0043065","positive regulation of apoptotic process" -"GO:1904475","regulation of Ras GTPase binding" -"GO:1901339","regulation of store-operated calcium channel activity" -"GO:0010459","negative regulation of heart rate" -"GO:0032336","negative regulation of activin secretion" -"GO:0072088","nephron epithelium morphogenesis" -"GO:0035087","siRNA loading onto RISC involved in RNA interference" -"GO:0033327","Leydig cell differentiation" -"GO:0019347","GDP-alpha-D-mannosylchitobiosyldiphosphodolichol biosynthetic process" -"GO:0044126","regulation of growth of symbiont in host" -"GO:0010495","long-distance posttranscriptional gene silencing" -"GO:0030917","midbrain-hindbrain boundary development" -"GO:1990440","positive regulation of transcription from RNA polymerase II promoter in response to endoplasmic reticulum stress" -"GO:0030501","positive regulation of bone mineralization" -"GO:0003245","cardiac muscle tissue growth involved in heart morphogenesis" -"GO:0051798","positive regulation of hair follicle development" -"GO:0016049","cell growth" -"GO:0060128","corticotropin hormone secreting cell differentiation" -"GO:0061010","gall bladder development" -"GO:0010955","negative regulation of protein processing" -"GO:0010139","pyrimidine deoxyribonucleotide salvage" -"GO:0006983","ER overload response" -"GO:0002043","blood vessel endothelial cell proliferation involved in sprouting angiogenesis" -"GO:0003151","outflow tract morphogenesis" -"GO:0043620","regulation of DNA-templated transcription in response to stress" -"GO:0072367","regulation of lipid transport by regulation of transcription from RNA polymerase II promoter" -"GO:0014040","positive regulation of Schwann cell differentiation" -"GO:0097093","polyacyltrehalose biosynthetic process" -"GO:1903073","negative regulation of death-inducing signaling complex assembly" -"GO:0060520","activation of prostate induction by androgen receptor signaling pathway" -"GO:0003272","endocardial cushion formation" -"GO:0010754","negative regulation of cGMP-mediated signaling" -"GO:0001933","negative regulation of protein phosphorylation" -"GO:0010257","NADH dehydrogenase complex assembly" -"GO:0002668","negative regulation of T cell anergy" -"GO:0048568","embryonic organ development" -"GO:0036527","peptidyl-arginine deglycation" -"GO:0060841","venous blood vessel development" -"GO:0070072","vacuolar proton-transporting V-type ATPase complex assembly" -"GO:0061368","behavioral response to formalin induced pain" -"GO:0032371","regulation of sterol transport" -"GO:1903094","negative regulation of protein K48-linked deubiquitination" -"GO:0035207","negative regulation of hemocyte proliferation" -"GO:0060391","positive regulation of SMAD protein signal transduction" -"GO:0071386","cellular response to corticosterone stimulus" -"GO:0051728","cell cycle switching, mitotic to meiotic cell cycle" -"GO:0038130","ERBB4 signaling pathway" -"GO:0071407","cellular response to organic cyclic compound" -"GO:0007162","negative regulation of cell adhesion" -"GO:0044573","nitrogenase P cluster assembly" -"GO:1901216","positive regulation of neuron death" -"GO:0070059","intrinsic apoptotic signaling pathway in response to endoplasmic reticulum stress" -"GO:0008078","mesodermal cell migration" -"GO:2000016","negative regulation of determination of dorsal identity" -"GO:0021543","pallium development" -"GO:1902354","blood vessel endothelial cell delamination involved in blood vessel lumen ensheathment" -"GO:0010811","positive regulation of cell-substrate adhesion" -"GO:0003097","renal water transport" -"GO:0070156","mitochondrial phenylalanyl-tRNA aminoacylation" -"GO:1900758","negative regulation of D-amino-acid oxidase activity" -"GO:0032332","positive regulation of chondrocyte differentiation" -"GO:0061146","Peyer's patch morphogenesis" -"GO:0006423","cysteinyl-tRNA aminoacylation" -"GO:0015894","acriflavine transport" -"GO:0045966","positive regulation of ecdysteroid metabolic process" -"GO:0006275","regulation of DNA replication" -"GO:2000867","regulation of estrone secretion" -"GO:0016334","establishment or maintenance of polarity of follicular epithelium" -"GO:0098726","symmetric division of skeletal muscle satellite stem cell" -"GO:1902992","negative regulation of amyloid precursor protein catabolic process" -"GO:0014912","negative regulation of smooth muscle cell migration" -"GO:0106046","guanine deglycation, glyoxal removal" -"GO:0106044","guanine deglycation" -"GO:0009950","dorsal/ventral axis specification" -"GO:0097021","lymphocyte migration into lymphoid organs" -"GO:0019232","perception of rate of movement" -"GO:0060043","regulation of cardiac muscle cell proliferation" -"GO:0070149","mitochondrial glutamyl-tRNA aminoacylation" -"GO:0010724","regulation of definitive erythrocyte differentiation" -"GO:0030950","establishment or maintenance of actin cytoskeleton polarity" -"GO:1902177","positive regulation of oxidative stress-induced intrinsic apoptotic signaling pathway" -"GO:1903026","negative regulation of RNA polymerase II regulatory region sequence-specific DNA binding" -"GO:0046633","alpha-beta T cell proliferation" -"GO:0007179","transforming growth factor beta receptor signaling pathway" -"GO:0032927","positive regulation of activin receptor signaling pathway" -"GO:1902360","conversion of ds siRNA to ss siRNA involved in chromatin silencing by small RNA" -"GO:0060245","detection of cell density" -"GO:0035036","sperm-egg recognition" -"GO:0003338","metanephros morphogenesis" -"GO:0061024","membrane organization" -"GO:0034333","adherens junction assembly" -"GO:0000960","regulation of mitochondrial RNA catabolic process" -"GO:0099627","neurotransmitter receptor cycle" -"GO:1902813","negative regulation of BMP signaling pathway involved in determination of lateral mesoderm left/right asymmetry" -"GO:0038112","interleukin-8-mediated signaling pathway" -"GO:0010909","positive regulation of heparan sulfate proteoglycan biosynthetic process" -"GO:0006898","receptor-mediated endocytosis" -"GO:0009889","regulation of biosynthetic process" -"GO:0006089","lactate metabolic process" -"GO:0100064","negative regulation of filamentous growth of a population of unicellular organisms in response to starvation by transcription from RNA polymerase II promoter" -"GO:1900468","regulation of phosphatidylserine biosynthetic process" -"GO:0000745","nuclear migration involved in conjugation with mutual genetic exchange" -"GO:0051028","mRNA transport" -"GO:0044542","plasminogen activation in other organism" -"GO:0006810","transport" -"GO:0032733","positive regulation of interleukin-10 production" -"GO:0014002","astrocyte development" -"GO:0071073","positive regulation of phospholipid biosynthetic process" -"GO:0019550","glutamate catabolic process to aspartate" -"GO:2001245","regulation of phosphatidylcholine biosynthetic process" -"GO:0019438","aromatic compound biosynthetic process" -"GO:0055111","ingression involved in gastrulation with mouth forming second" -"GO:0045562","regulation of TRAIL receptor 2 biosynthetic process" -"GO:0097092","polyacyltrehalose metabolic process" -"GO:0048518","positive regulation of biological process" -"GO:0055019","negative regulation of cardiac muscle fiber development" -"GO:0048488","synaptic vesicle endocytosis" -"GO:0100056","negative regulation of phosphatidylserine biosynthetic process by transcription from RNA polymerase II promoter" -"GO:0048023","positive regulation of melanin biosynthetic process" -"GO:1904793","regulation of euchromatin binding" -"GO:0007323","peptide pheromone maturation" -"GO:0060126","somatotropin secreting cell differentiation" -"GO:0030101","natural killer cell activation" -"GO:0010572","positive regulation of platelet activation" -"GO:0043303","mast cell degranulation" -"GO:0006114","glycerol biosynthetic process" -"GO:0044324","regulation of transcription involved in anterior/posterior axis specification" -"GO:0034176","negative regulation of toll-like receptor 12 signaling pathway" -"GO:0006536","glutamate metabolic process" -"GO:0100041","positive regulation of pseudohyphal growth by transcription from RNA polymerase II promoter" -"GO:0038114","interleukin-21-mediated signaling pathway" -"GO:0060492","lung induction" -"GO:0051770","positive regulation of nitric-oxide synthase biosynthetic process" -"GO:0006533","aspartate catabolic process" -"GO:0061030","epithelial cell differentiation involved in mammary gland alveolus development" -"GO:0035548","negative regulation of interferon-beta secretion" -"GO:0030593","neutrophil chemotaxis" -"GO:0000379","tRNA-type intron splice site recognition and cleavage" -"GO:1905511","positive regulation of myosin II filament assembly" -"GO:0090236","regulation of transcription from RNA polymerase II promoter involved in somitogenesis" -"GO:0048797","swim bladder formation" -"GO:0030036","actin cytoskeleton organization" -"GO:1903428","positive regulation of reactive oxygen species biosynthetic process" -"GO:0100016","regulation of thiamine biosynthetic process by transcription from RNA polymerase II promoter" -"GO:0042129","regulation of T cell proliferation" -"GO:0034142","toll-like receptor 4 signaling pathway" -"GO:0046226","coumarin catabolic process" -"GO:0070101","positive regulation of chemokine-mediated signaling pathway" -"GO:1990974","actin-dependent nuclear migration" -"GO:0032607","interferon-alpha production" -"GO:0100037","positive regulation of cellular alcohol catabolic process by transcription from RNA polymerase II promoter" -"GO:0042116","macrophage activation" -"GO:0097019","neurotransmitter receptor catabolic process" -"GO:0060729","intestinal epithelial structure maintenance" -"GO:1904263","positive regulation of TORC1 signaling" -"GO:0002512","central T cell tolerance induction" -"GO:0030683","evasion or tolerance by virus of host immune response" -"GO:0001015","snoRNA transcription by RNA polymerase II" -"GO:0032604","granulocyte macrophage colony-stimulating factor production" -"GO:0098609","cell-cell adhesion" -"GO:1904471","negative regulation of endothelin secretion" -"GO:0051541","elastin metabolic process" -"GO:0006909","phagocytosis" -"GO:1900545","regulation of phenotypic switching by regulation of transcription from RNA polymerase II promoter" -"GO:0003340","negative regulation of mesenchymal to epithelial transition involved in metanephros morphogenesis" -"GO:0100005","positive regulation of ethanol catabolic process by transcription from RNA polymerase II promoter" -"GO:0010322","regulation of isopentenyl diphosphate biosynthetic process, methylerythritol 4-phosphate pathway" -"GO:0006532","aspartate biosynthetic process" -"GO:0070434","positive regulation of nucleotide-binding oligomerization domain containing 2 signaling pathway" -"GO:0032720","negative regulation of tumor necrosis factor production" -"GO:0036148","phosphatidylglycerol acyl-chain remodeling" -"GO:1905619","regulation of alpha-(1->3)-fucosyltransferase activity" -"GO:1904723","negative regulation of Wnt-Frizzled-LRP5/6 complex assembly" -"GO:0097720","calcineurin-mediated signaling" -"GO:0031338","regulation of vesicle fusion" -"GO:0098964","anterograde dendritic transport of messenger ribonucleoprotein complex" -"GO:1904649","regulation of fat cell apoptotic process" -"GO:0060988","lipid tube assembly" -"GO:0015994","chlorophyll metabolic process" -"GO:0075308","negative regulation of conidium formation" -"GO:0002330","pre-B cell receptor expression" -"GO:0010771","negative regulation of cell morphogenesis involved in differentiation" -"GO:0043057","backward locomotion" -"GO:2000295","regulation of hydrogen peroxide catabolic process" -"GO:0060907","positive regulation of macrophage cytokine production" -"GO:1900402","regulation of carbohydrate metabolic process by regulation of transcription from RNA polymerase II promoter" -"GO:0048065","male courtship behavior, veined wing extension" -"GO:0080009","mRNA methylation" -"GO:0010511","regulation of phosphatidylinositol biosynthetic process" -"GO:0016079","synaptic vesicle exocytosis" -"GO:1900167","negative regulation of glial cell-derived neurotrophic factor secretion" -"GO:1903715","regulation of aerobic respiration" -"GO:0045047","protein targeting to ER" -"GO:2000017","positive regulation of determination of dorsal identity" -"GO:0072270","metanephric short nephron development" -"GO:1901660","calcium ion export" -"GO:0001100","negative regulation of exit from mitosis" -"GO:0100045","negative regulation of arginine catabolic process by transcription from RNA polymerase II promoter" -"GO:0034160","negative regulation of toll-like receptor 8 signaling pathway" -"GO:0042119","neutrophil activation" -"GO:0015844","monoamine transport" -"GO:0002537","nitric oxide production involved in inflammatory response" -"GO:0032729","positive regulation of interferon-gamma production" -"GO:0100026","positive regulation of DNA repair by transcription from RNA polymerase II promoter" -"GO:0046886","positive regulation of hormone biosynthetic process" -"GO:0010239","chloroplast mRNA processing" -"GO:0072054","renal outer medulla development" -"GO:0061324","canonical Wnt signaling pathway involved in positive regulation of cardiac outflow tract cell proliferation" -"GO:0021941","negative regulation of cerebellar granule cell precursor proliferation" -"GO:0043931","ossification involved in bone maturation" -"GO:0006193","ITP catabolic process" -"GO:0006531","aspartate metabolic process" -"GO:0090019","regulation of transcription involved in anterior neural plate formation" -"GO:0042136","neurotransmitter biosynthetic process" -"GO:1903141","negative regulation of establishment of endothelial barrier" -"GO:0098792","xenophagy" -"GO:0036500","ATF6-mediated unfolded protein response" -"GO:0010189","vitamin E biosynthetic process" -"GO:0016046","detection of fungus" -"GO:0002760","positive regulation of antimicrobial humoral response" -"GO:1901351","regulation of phosphatidylglycerol biosynthetic process" -"GO:0100013","positive regulation of fatty acid beta-oxidation by transcription from RNA polymerase II promoter" -"GO:0051610","serotonin uptake" -"GO:0100032","positive regulation of phospholipid biosynthetic process by transcription from RNA polymerase II promoter" -"GO:0010893","positive regulation of steroid biosynthetic process" -"GO:1903223","positive regulation of oxidative stress-induced neuron death" -"GO:0030705","cytoskeleton-dependent intracellular transport" -"GO:1905451","positive regulation of Fc-gamma receptor signaling pathway involved in phagocytosis" -"GO:0097717","copper ion transport across blood-cerebrospinal fluid barrier" -"GO:0060304","regulation of phosphatidylinositol dephosphorylation" -"GO:1904948","midbrain dopaminergic neuron differentiation" -"GO:0042445","hormone metabolic process" -"GO:0032227","negative regulation of synaptic transmission, dopaminergic" -"GO:2001210","regulation of isopentenyl diphosphate biosynthetic process, mevalonate pathway" -"GO:0100040","negative regulation of invasive growth in response to glucose limitation by transcription from RNA polymerase II promoter" -"GO:0009685","gibberellin metabolic process" -"GO:0009227","nucleotide-sugar catabolic process" -"GO:0071223","cellular response to lipoteichoic acid" -"GO:0044078","positive regulation by symbiont of host receptor-mediated endocytosis" -"GO:1904247","positive regulation of polynucleotide adenylyltransferase activity" -"GO:0090067","regulation of thalamus size" -"GO:0035112","genitalia morphogenesis" -"GO:0000432","positive regulation of transcription from RNA polymerase II promoter by glucose" -"GO:0002758","innate immune response-activating signal transduction" -"GO:0097389","chemokine (C-C motif) ligand 21 production" -"GO:0032016","negative regulation of Ran protein signal transduction" -"GO:1901044","protein polyubiquitination involved in nucleus-associated proteasomal ubiquitin-dependent protein catabolic process" -"GO:0046634","regulation of alpha-beta T cell activation" -"GO:0010470","regulation of gastrulation" -"GO:0072053","renal inner medulla development" -"GO:0072173","metanephric tubule morphogenesis" -"GO:0006656","phosphatidylcholine biosynthetic process" -"GO:0060574","intestinal epithelial cell maturation" -"GO:0043321","regulation of natural killer cell degranulation" -"GO:0006996","organelle organization" -"GO:0045084","positive regulation of interleukin-12 biosynthetic process" -"GO:0061432","regulation of transcription from RNA polymerase II promoter in response to methionine" -"GO:0039501","suppression by virus of host type I interferon production" -"GO:0097210","response to gonadotropin-releasing hormone" -"GO:0014028","notochord formation" -"GO:0045429","positive regulation of nitric oxide biosynthetic process" -"GO:0033317","pantothenate biosynthetic process from valine" -"GO:0035666","TRIF-dependent toll-like receptor signaling pathway" -"GO:0046354","mannan biosynthetic process" -"GO:0042780","tRNA 3'-end processing" -"GO:0072647","interferon-epsilon production" -"GO:0030713","ovarian follicle cell stalk formation" -"GO:0006450","regulation of translational fidelity" -"GO:0060880","cell morphogenesis involved in semicircular canal fusion" -"GO:0030259","lipid glycosylation" -"GO:0046127","pyrimidine deoxyribonucleoside catabolic process" -"GO:0043586","tongue development" -"GO:0050860","negative regulation of T cell receptor signaling pathway" -"GO:1904113","negative regulation of muscle filament sliding" -"GO:0009835","fruit ripening" -"GO:0018336","peptidyl-tyrosine hydroxylation" -"GO:2001285","negative regulation of BMP secretion" -"GO:0021704","locus ceruleus morphogenesis" -"GO:2000224","regulation of testosterone biosynthetic process" -"GO:0009305","protein biotinylation" -"GO:0051714","positive regulation of cytolysis in other organism" -"GO:0015819","lysine transport" -"GO:0071654","positive regulation of chemokine (C-C motif) ligand 1 production" -"GO:0099153","synaptic transmission, serotonergic" -"GO:0035943","estrone secretion" -"GO:0007174","epidermal growth factor catabolic process" -"GO:0015828","tyrosine transport" -"GO:0038018","Wnt receptor catabolic process" -"GO:0010107","potassium ion import" -"GO:0071708","immunoglobulin light chain V-J recombination" -"GO:0110053","regulation of actin filament organization" -"GO:0036360","sorocarp stalk morphogenesis" -"GO:0032365","intracellular lipid transport" -"GO:0043950","positive regulation of cAMP-mediated signaling" -"GO:0014822","detection of wounding" -"GO:0035396","positive regulation of chemokine (C-X-C motif) ligand 9 production" -"GO:0021683","cerebellar granular layer morphogenesis" -"GO:0032402","melanosome transport" -"GO:0060371","regulation of atrial cardiac muscle cell membrane depolarization" -"GO:0100038","regulation of cellular response to oxidative stress by transcription from RNA polymerase II promoter" -"GO:1902774","late endosome to lysosome transport" -"GO:0002520","immune system development" -"GO:1904665","positive regulation of N-terminal peptidyl-methionine acetylation" -"GO:0010090","trichome morphogenesis" -"GO:0032724","positive regulation of fractalkine production" -"GO:0007556","regulation of juvenile hormone metabolic process" -"GO:1902583","multi-organism intracellular transport" -"GO:0071648","positive regulation of macrophage inflammatory protein-1 gamma production" -"GO:0070085","glycosylation" -"GO:0060621","negative regulation of cholesterol import" -"GO:0016071","mRNA metabolic process" -"GO:1900134","negative regulation of renin secretion into blood stream" -"GO:0007045","cell-substrate adherens junction assembly" -"GO:1990180","mitochondrial tRNA 3'-end processing" -"GO:0001680","tRNA 3'-terminal CCA addition" -"GO:0003085","negative regulation of systemic arterial blood pressure" -"GO:0070525","tRNA threonylcarbamoyladenosine metabolic process" -"GO:1903058","positive regulation of melanosome organization" -"GO:1905938","positive regulation of germ cell proliferation" -"GO:0055107","Golgi to secretory granule transport" -"GO:0061872","hepatic stellate cell contraction" -"GO:0048524","positive regulation of viral process" -"GO:1903638","positive regulation of protein import into mitochondrial outer membrane" -"GO:1902030","negative regulation of histone H3-K18 acetylation" -"GO:0038055","BMP secretion" -"GO:0035476","angioblast cell migration" -"GO:0021701","cerebellar Golgi cell differentiation" -"GO:0044856","plasma membrane raft localization" -"GO:0006693","prostaglandin metabolic process" -"GO:0099180","zinc ion import into synaptic vesicle" -"GO:1905162","regulation of phagosome maturation" -"GO:0046907","intracellular transport" -"GO:0034351","negative regulation of glial cell apoptotic process" -"GO:0140051","positive regulation of endocardial cushion to mesenchymal transition" -"GO:0032340","positive regulation of inhibin secretion" -"GO:1901387","positive regulation of voltage-gated calcium channel activity" -"GO:0010442","guard cell morphogenesis" -"GO:0038108","negative regulation of appetite by leptin-mediated signaling pathway" -"GO:0055065","metal ion homeostasis" -"GO:0090693","plant organ senescence" -"GO:1905469","negative regulation of clathrin-coated pit assembly" -"GO:0031110","regulation of microtubule polymerization or depolymerization" -"GO:0042790","nucleolar large rRNA transcription by RNA polymerase I" -"GO:0048895","lateral line nerve glial cell differentiation" -"GO:1901384","positive regulation of chorionic trophoblast cell proliferation" -"GO:2000299","negative regulation of Rho-dependent protein serine/threonine kinase activity" -"GO:0021951","chemoattraction involved in precerebellar neuron migration" -"GO:1904243","negative regulation of pancreatic trypsinogen secretion" -"GO:0090551","response to manganese starvation" -"GO:0044698","morphogenesis of symbiont in host cell" -"GO:0045459","iron incorporation into iron-sulfur cluster via tetrakis-L-cysteinyl triiron tetrasulfide" -"GO:0030473","nuclear migration along microtubule" -"GO:1902855","regulation of non-motile cilium assembly" -"GO:2000497","positive regulation of cell proliferation involved in compound eye morphogenesis" -"GO:0030500","regulation of bone mineralization" -"GO:0051083","'de novo' cotranslational protein folding" -"GO:1990089","response to nerve growth factor" -"GO:0035277","spiracle morphogenesis, open tracheal system" -"GO:1901647","positive regulation of synoviocyte proliferation" -"GO:1900390","regulation of iron ion import" -"GO:2000103","positive regulation of mammary stem cell proliferation" -"GO:0006478","peptidyl-tyrosine sulfation" -"GO:0036022","limb joint morphogenesis" -"GO:1901393","negative regulation of transforming growth factor beta1 activation" -"GO:0070232","regulation of T cell apoptotic process" -"GO:0051168","nuclear export" -"GO:0070295","renal water absorption" -"GO:0051390","inactivation of MAPKKK activity" -"GO:1902260","negative regulation of delayed rectifier potassium channel activity" -"GO:1903100","1-phosphatidyl-1D-myo-inositol 3,5-bisphosphate metabolic process" -"GO:0021764","amygdala development" -"GO:1990522","tail spike morphogenesis" -"GO:0097314","apoptosome assembly" -"GO:0006816","calcium ion transport" -"GO:0019853","L-ascorbic acid biosynthetic process" -"GO:0014908","myotube differentiation involved in skeletal muscle regeneration" -"GO:1904701","Wnt-Frizzled-LRP5/6 complex assembly" -"GO:0061797","pH-gated chloride channel activity" -"GO:1903818","positive regulation of voltage-gated potassium channel activity" -"GO:0001827","inner cell mass cell fate commitment" -"GO:0006024","glycosaminoglycan biosynthetic process" -"GO:0048379","positive regulation of lateral mesodermal cell fate specification" -"GO:0051225","spindle assembly" -"GO:1904763","chaperone-mediated autophagy translocation complex assembly" -"GO:0060438","trachea development" -"GO:0005975","carbohydrate metabolic process" -"GO:1904158","axonemal central apparatus assembly" -"GO:2001280","positive regulation of unsaturated fatty acid biosynthetic process" -"GO:1903117","regulation of actin filament organization involved in cytokinetic actomyosin contractile ring assembly" -"GO:0050435","amyloid-beta metabolic process" -"GO:0051987","positive regulation of attachment of spindle microtubules to kinetochore" -"GO:0050957","equilibrioception" -"GO:1905888","negative regulation of cellular response to very-low-density lipoprotein particle stimulus" -"GO:0009244","lipopolysaccharide core region biosynthetic process" -"GO:1904270","pyroptosome complex assembly" -"GO:0098961","dendritic transport of ribonucleoprotein complex" -"GO:0097603","temperature-gated ion channel activity" -"GO:0098707","ferrous iron import across plasma membrane" -"GO:0097202","activation of cysteine-type endopeptidase activity" -"GO:0072513","positive regulation of secondary heart field cardioblast proliferation" -"GO:0065005","protein-lipid complex assembly" -"GO:0006730","one-carbon metabolic process" -"GO:0015661","L-lysine efflux transmembrane transporter activity" -"GO:1901245","positive regulation of toll-like receptor 9 signaling pathway by B cell receptor internalization" -"GO:0071557","histone H3-K27 demethylation" -"GO:0048254","snoRNA localization" -"GO:0051821","dissemination or transmission of organism from other organism involved in symbiotic interaction" -"GO:0046753","non-lytic viral release" -"GO:0072746","cellular response to tetracycline" -"GO:0003045","regulation of systemic arterial blood pressure by physical factors" -"GO:0060361","flight" -"GO:0050650","chondroitin sulfate proteoglycan biosynthetic process" -"GO:0043085","positive regulation of catalytic activity" -"GO:0110008","ncRNA deadenylation" -"GO:0030838","positive regulation of actin filament polymerization" -"GO:0098596","imitative learning" -"GO:1904611","cellular response to 3,3',4,4',5-pentachlorobiphenyl" -"GO:0010587","miRNA catabolic process" -"GO:0090316","positive regulation of intracellular protein transport" -"GO:0015012","heparan sulfate proteoglycan biosynthetic process" -"GO:0061855","negative regulation of neuroblast migration" -"GO:0005228","intracellular sodium activated potassium channel activity" -"GO:0042792","mitochondrial rRNA transcription" -"GO:0005292","high-affinity lysine transmembrane transporter activity" -"GO:0006786","heme c biosynthetic process" -"GO:0032968","positive regulation of transcription elongation from RNA polymerase II promoter" -"GO:0048015","phosphatidylinositol-mediated signaling" -"GO:0010900","negative regulation of phosphatidylcholine catabolic process" -"GO:1903166","cellular response to polycyclic arene" -"GO:1905352","ciliary necklace assembly" -"GO:0001542","ovulation from ovarian follicle" -"GO:0002509","central tolerance induction to self antigen" -"GO:0071534","zf-TRAF domain-mediated complex assembly" -"GO:0046755","viral budding" -"GO:0019419","sulfate reduction" -"GO:0071493","cellular response to UV-B" -"GO:1903703","enterocyte differentiation" -"GO:0007051","spindle organization" -"GO:0071615","oxidative deethylation" -"GO:2001131","methane biosynthetic process from dimethyl sulfide" -"GO:1904600","actin fusion focus assembly" -"GO:0001715","ectodermal cell fate specification" -"GO:0061816","proteaphagy" -"GO:1901685","glutathione derivative metabolic process" -"GO:0048088","regulation of male pigmentation" -"GO:0000972","transcription-dependent tethering of RNA polymerase II gene DNA at nuclear periphery" -"GO:0097010","eukaryotic translation initiation factor 4F complex assembly" -"GO:1903617","positive regulation of mitotic cytokinesis, site selection" -"GO:0018885","carbon tetrachloride metabolic process" -"GO:0072096","negative regulation of branch elongation involved in ureteric bud branching" -"GO:0042732","D-xylose metabolic process" -"GO:0099505","regulation of presynaptic membrane potential" -"GO:0031033","myosin filament organization" -"GO:0097376","interneuron axon guidance" -"GO:0043645","cephalosporin metabolic process" -"GO:0051771","negative regulation of nitric-oxide synthase biosynthetic process" -"GO:0010824","regulation of centrosome duplication" -"GO:0042429","serotonin catabolic process" -"GO:0007147","female meiosis II" -"GO:1903916","regulation of endoplasmic reticulum stress-induced eIF2 alpha dephosphorylation" -"GO:0006643","membrane lipid metabolic process" -"GO:0046900","tetrahydrofolylpolyglutamate metabolic process" -"GO:0044272","sulfur compound biosynthetic process" -"GO:0070372","regulation of ERK1 and ERK2 cascade" -"GO:0016998","cell wall macromolecule catabolic process" -"GO:0043711","pilus organization" -"GO:0003325","pancreatic PP cell development" -"GO:0002684","positive regulation of immune system process" -"GO:0050856","regulation of T cell receptor signaling pathway" -"GO:0070781","response to biotin" -"GO:0044273","sulfur compound catabolic process" -"GO:0050655","dermatan sulfate proteoglycan metabolic process" -"GO:0002037","negative regulation of L-glutamate import across plasma membrane" -"GO:1905665","positive regulation of calcium ion import across plasma membrane" -"GO:0032484","Ral protein signal transduction" -"GO:0061755","positive regulation of circulating fibrinogen levels" -"GO:0018394","peptidyl-lysine acetylation" -"GO:0010761","fibroblast migration" -"GO:1905401","positive regulation of activated CD4-positive, alpha-beta T cell apoptotic process" -"GO:0060166","olfactory pit development" -"GO:0002699","positive regulation of immune effector process" -"GO:0035387","negative regulation of Roundabout signaling pathway" -"GO:0048389","intermediate mesoderm development" -"GO:1900148","negative regulation of Schwann cell migration" -"GO:0072737","response to diamide" -"GO:0045421","negative regulation of connective tissue growth factor biosynthetic process" -"GO:0070237","positive regulation of activation-induced cell death of T cells" -"GO:0019416","polythionate oxidation" -"GO:1904761","negative regulation of myofibroblast differentiation" -"GO:0090170","regulation of Golgi inheritance" -"GO:0070086","ubiquitin-dependent endocytosis" -"GO:0009745","sucrose mediated signaling" -"GO:0035383","thioester metabolic process" -"GO:1902307","positive regulation of sodium ion transmembrane transport" -"GO:0071460","cellular response to cell-matrix adhesion" -"GO:1904850","negative regulation of establishment of protein localization to telomere" -"GO:0000169","activation of MAPK activity involved in osmosensory signaling pathway" -"GO:0007014","actin ubiquitination" -"GO:1903473","positive regulation of mitotic actomyosin contractile ring contraction" -"GO:0035419","activation of MAPK activity involved in innate immune response" -"GO:0051673","membrane disruption in other organism" -"GO:0097120","receptor localization to synapse" -"GO:0033027","positive regulation of mast cell apoptotic process" -"GO:0032088","negative regulation of NF-kappaB transcription factor activity" -"GO:0014885","detection of injury involved in regulation of muscle adaptation" -"GO:0002696","positive regulation of leukocyte activation" -"GO:0034608","vulval location" -"GO:0071881","adenylate cyclase-inhibiting adrenergic receptor signaling pathway" -"GO:0051896","regulation of protein kinase B signaling" -"GO:0098974","postsynaptic actin cytoskeleton organization" -"GO:0045806","negative regulation of endocytosis" -"GO:0045898","regulation of RNA polymerase II transcriptional preinitiation complex assembly" -"GO:0017126","nucleologenesis" -"GO:0070664","negative regulation of leukocyte proliferation" -"GO:0048534","hematopoietic or lymphoid organ development" -"GO:0044878","mitotic cytokinesis checkpoint" -"GO:0010182","sugar mediated signaling pathway" -"GO:2000623","negative regulation of nuclear-transcribed mRNA catabolic process, nonsense-mediated decay" -"GO:1904262","negative regulation of TORC1 signaling" -"GO:0070926","regulation of ATP:ADP antiporter activity" -"GO:0048794","swim bladder development" -"GO:0097359","UDP-glucosylation" -"GO:0002210","behavioral response to wounding" -"GO:0035513","oxidative RNA demethylation" -"GO:0060244","negative regulation of cell proliferation involved in contact inhibition" -"GO:1903708","positive regulation of hemopoiesis" -"GO:1901905","response to tamsulosin" -"GO:0061847","response to cholecystokinin" -"GO:2000314","negative regulation of fibroblast growth factor receptor signaling pathway involved in neural plate anterior/posterior pattern formation" -"GO:0003324","pancreatic D cell development" -"GO:1990564","protein polyufmylation" -"GO:1990705","cholangiocyte proliferation" -"GO:2000841","negative regulation of dehydroepiandrosterone secretion" -"GO:0050976","detection of mechanical stimulus involved in sensory perception of touch" -"GO:0002636","positive regulation of germinal center formation" -"GO:0007185","transmembrane receptor protein tyrosine phosphatase signaling pathway" -"GO:0008582","regulation of synaptic growth at neuromuscular junction" -"GO:0019460","glutamine catabolic process to fumarate" -"GO:0050772","positive regulation of axonogenesis" -"GO:0061420","regulation of transcription from RNA polymerase II promoter in response to biotin starvation" -"GO:0051055","negative regulation of lipid biosynthetic process" -"GO:0042413","carnitine catabolic process" -"GO:0034441","plasma lipoprotein particle oxidation" -"GO:0072030","short nephron development" -"GO:0045612","positive regulation of hemocyte differentiation" -"GO:0071672","negative regulation of smooth muscle cell chemotaxis" -"GO:1902069","negative regulation of sphingolipid mediated signaling pathway" -"GO:1903800","positive regulation of production of miRNAs involved in gene silencing by miRNA" -"GO:0035511","oxidative DNA demethylation" -"GO:0061299","retina vasculature morphogenesis in camera-type eye" -"GO:0045078","positive regulation of interferon-gamma biosynthetic process" -"GO:0001710","mesodermal cell fate commitment" -"GO:0071508","activation of MAPK activity involved in conjugation with cellular fusion" -"GO:0070199","establishment of protein localization to chromosome" -"GO:0060770","negative regulation of epithelial cell proliferation involved in prostate gland development" -"GO:1900363","regulation of mRNA polyadenylation" -"GO:0090155","negative regulation of sphingolipid biosynthetic process" -"GO:0071110","histone biotinylation" -"GO:0048089","regulation of female pigmentation" -"GO:0099588","positive regulation of postsynaptic cytosolic calcium concentration" -"GO:0072332","intrinsic apoptotic signaling pathway by p53 class mediator" -"GO:0046852","positive regulation of bone remodeling" -"GO:0061453","interstitial cell of Cajal differentiation" -"GO:2000786","positive regulation of autophagosome assembly" -"GO:1904417","positive regulation of xenophagy" -"GO:0033212","iron assimilation" -"GO:0070267","oncosis" -"GO:0035048","splicing factor protein import into nucleus" -"GO:0046878","positive regulation of saliva secretion" -"GO:0061215","mesonephric nephron development" -"GO:0006470","protein dephosphorylation" -"GO:0051289","protein homotetramerization" -"GO:0010973","positive regulation of division septum assembly" -"GO:0043056","forward locomotion" -"GO:0002645","positive regulation of tolerance induction" -"GO:0032787","monocarboxylic acid metabolic process" -"GO:0046782","regulation of viral transcription" -"GO:1901699","cellular response to nitrogen compound" -"GO:0048136","male germ-line cyst formation" -"GO:0018977","1,1,1-trichloro-2,2-bis-(4-chlorophenyl)ethane metabolic process" -"GO:0072029","long nephron development" -"GO:0002778","antibacterial peptide production" -"GO:0098911","regulation of ventricular cardiac muscle cell action potential" -"GO:0019640","glucuronate catabolic process to xylulose 5-phosphate" -"GO:0099610","action potential initiation" -"GO:0016051","carbohydrate biosynthetic process" -"GO:0000280","nuclear division" -"GO:1900587","arugosin biosynthetic process" -"GO:0035208","positive regulation of hemocyte proliferation" -"GO:0060376","positive regulation of mast cell differentiation" -"GO:0000027","ribosomal large subunit assembly" -"GO:0021889","olfactory bulb interneuron differentiation" -"GO:0000477","generation of mature 5'-end of LSU-rRNA from tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:1902026","regulation of cartilage condensation" -"GO:0021818","modulation of the microfilament cytoskeleton involved in cell locomotion in cerebral cortex radial glia guided migration" -"GO:0019745","pentacyclic triterpenoid biosynthetic process" -"GO:0015840","urea transport" -"GO:0000199","activation of MAPK activity involved in cell wall organization or biogenesis" -"GO:1904236","negative regulation of substrate-dependent cell migration, cell attachment to substrate" -"GO:1900482","positive regulation of diacylglycerol biosynthetic process" -"GO:0002579","positive regulation of antigen processing and presentation" -"GO:0046701","insecticide catabolic process" -"GO:0043068","positive regulation of programmed cell death" -"GO:0044803","multi-organism membrane organization" -"GO:1904692","positive regulation of type B pancreatic cell proliferation" -"GO:0046598","positive regulation of viral entry into host cell" -"GO:0034204","lipid translocation" -"GO:0040040","thermosensory behavior" -"GO:0099630","postsynaptic neurotransmitter receptor cycle" -"GO:0044552","vasodilation in other organism" -"GO:0030651","peptide antibiotic biosynthetic process" -"GO:0045776","negative regulation of blood pressure" -"GO:0006041","glucosamine metabolic process" -"GO:0048071","sex-specific pigmentation" -"GO:1905784","regulation of anaphase-promoting complex-dependent catabolic process" -"GO:0002338","B-1b B cell differentiation" -"GO:0002736","regulation of plasmacytoid dendritic cell cytokine production" -"GO:0042968","homoserine transport" -"GO:0060820","inactivation of X chromosome by heterochromatin assembly" -"GO:1902559","3'-phospho-5'-adenylyl sulfate transmembrane transport" -"GO:0150019","basal dendrite morphogenesis" -"GO:0045792","negative regulation of cell size" -"GO:0045143","homologous chromosome segregation" -"GO:1901031","regulation of response to reactive oxygen species" -"GO:0090650","cellular response to oxygen-glucose deprivation" -"GO:0018315","molybdenum incorporation into molybdenum-molybdopterin complex" -"GO:0045762","positive regulation of adenylate cyclase activity" -"GO:0042823","pyridoxal phosphate biosynthetic process" -"GO:2001170","negative regulation of ATP biosynthetic process" -"GO:0043504","mitochondrial DNA repair" -"GO:0099703","induction of synaptic vesicle exocytosis by positive regulation of presynaptic cytosolic calcium ion concentration" -"GO:0090080","positive regulation of MAPKKK cascade by fibroblast growth factor receptor signaling pathway" -"GO:1904691","negative regulation of type B pancreatic cell proliferation" -"GO:0000196","MAPK cascade involved in cell wall organization or biogenesis" -"GO:0034392","negative regulation of smooth muscle cell apoptotic process" -"GO:0045611","negative regulation of hemocyte differentiation" -"GO:0061795","Golgi lumen acidification" -"GO:0034631","microtubule anchoring at spindle pole body" -"GO:0070903","mitochondrial tRNA thio-modification" -"GO:0060158","phospholipase C-activating dopamine receptor signaling pathway" -"GO:1901723","negative regulation of cell proliferation involved in kidney development" -"GO:1905094","regulation of apolipoprotein A-I-mediated signaling pathway" -"GO:0046786","viral replication complex formation and maintenance" -"GO:0030201","heparan sulfate proteoglycan metabolic process" -"GO:1904329","negative regulation of myofibroblast contraction" -"GO:0044082","modulation by symbiont of host small GTPase mediated signal transduction" -"GO:0002148","hypochlorous acid metabolic process" -"GO:0150011","regulation of neuron projection arborization" -"GO:0001545","primary ovarian follicle growth" -"GO:0006388","tRNA splicing, via endonucleolytic cleavage and ligation" -"GO:0051967","negative regulation of synaptic transmission, glutamatergic" -"GO:0042490","mechanoreceptor differentiation" -"GO:0010601","positive regulation of auxin biosynthetic process" -"GO:1901395","regulation of transforming growth factor beta2 activation" -"GO:0015739","sialic acid transport" -"GO:1990832","slow axonal transport" -"GO:1902883","negative regulation of response to oxidative stress" -"GO:0018228","peptidyl-S-geranylgeranyl-L-cysteine biosynthetic process from peptidyl-cysteine" -"GO:0098970","postsynaptic neurotransmitter receptor diffusion trapping" -"GO:2000102","negative regulation of mammary stem cell proliferation" -"GO:0015822","ornithine transport" -"GO:1904998","negative regulation of leukocyte adhesion to arterial endothelial cell" -"GO:0060983","epicardium-derived cardiac vascular smooth muscle cell differentiation" -"GO:1903508","positive regulation of nucleic acid-templated transcription" -"GO:0072165","anterior mesonephric tubule development" -"GO:0051976","lysine biosynthetic process via alpha-aminoadipate and N2-acetyl-alpha-aminoadipate" -"GO:1903566","positive regulation of protein localization to cilium" -"GO:1905154","negative regulation of membrane invagination" -"GO:0034260","negative regulation of GTPase activity" -"GO:0022602","ovulation cycle process" -"GO:0060289","compartment boundary maintenance" -"GO:0045038","protein import into chloroplast thylakoid membrane" -"GO:0045732","positive regulation of protein catabolic process" -"GO:0018401","peptidyl-proline hydroxylation to 4-hydroxy-L-proline" -"GO:0120116","glucagon processing" -"GO:0031223","auditory behavior" -"GO:2000089","positive regulation of mesonephric glomerulus development" -"GO:1901101","gramicidin S metabolic process" -"GO:1900168","positive regulation of glial cell-derived neurotrophic factor secretion" -"GO:2000088","negative regulation of mesonephric glomerulus development" -"GO:0040035","hermaphrodite genitalia development" -"GO:0006179","guanosine salvage" -"GO:1990079","cartilage homeostasis" -"GO:0002242","defense response to parasitic plant" -"GO:0071293","cellular response to tellurium ion" -"GO:0071371","cellular response to gonadotropin stimulus" -"GO:1901214","regulation of neuron death" -"GO:0070174","negative regulation of enamel mineralization" -"GO:1905886","chromatin remodeling involved in meiosis I" -"GO:0000076","DNA replication checkpoint" -"GO:0048319","axial mesoderm morphogenesis" -"GO:0070169","positive regulation of biomineral tissue development" -"GO:2001018","negative regulation of retrograde axon cargo transport" -"GO:0045848","positive regulation of nitrogen utilization" -"GO:0018396","peptidyl-lysine hydroxylation to 4-hydroxy-L-lysine" -"GO:1901659","glycosyl compound biosynthetic process" -"GO:0007484","imaginal disc-derived genitalia development" -"GO:0030488","tRNA methylation" -"GO:0002824","positive regulation of adaptive immune response based on somatic recombination of immune receptors built from immunoglobulin superfamily domains" -"GO:1903204","negative regulation of oxidative stress-induced neuron death" -"GO:0034231","islet amyloid polypeptide processing" -"GO:1901386","negative regulation of voltage-gated calcium channel activity" -"GO:0001510","RNA methylation" -"GO:0071373","cellular response to luteinizing hormone stimulus" -"GO:0046665","amnioserosa maintenance" -"GO:1904722","positive regulation of mRNA endonucleolytic cleavage involved in unfolded protein response" -"GO:0042700","luteinizing hormone signaling pathway" -"GO:0060130","thyroid-stimulating hormone-secreting cell development" -"GO:0120081","positive regulation of microfilament motor activity" -"GO:0000413","protein peptidyl-prolyl isomerization" -"GO:0045631","regulation of mechanoreceptor differentiation" -"GO:0050793","regulation of developmental process" -"GO:2001274","negative regulation of glucose import in response to insulin stimulus" -"GO:2000155","positive regulation of cilium-dependent cell motility" -"GO:0002391","platelet activating factor production involved in inflammatory response" -"GO:0085020","protein K6-linked ubiquitination" -"GO:1902839","negative regulation of nuclear migration along microtubule" -"GO:1904256","positive regulation of iron channel activity" -"GO:0042816","vitamin B6 metabolic process" -"GO:0006407","rRNA export from nucleus" -"GO:0033567","DNA replication, Okazaki fragment processing" -"GO:1903798","regulation of production of miRNAs involved in gene silencing by miRNA" -"GO:0051894","positive regulation of focal adhesion assembly" -"GO:0006048","UDP-N-acetylglucosamine biosynthetic process" -"GO:0006971","hypotonic response" -"GO:0086022","SA node cell-atrial cardiac muscle cell adhesion involved in cell communication" -"GO:0044395","protein targeting to vacuolar membrane" -"GO:0090211","positive regulation of establishment of blood-brain barrier" -"GO:0032956","regulation of actin cytoskeleton organization" -"GO:0046217","indole phytoalexin metabolic process" -"GO:0051570","regulation of histone H3-K9 methylation" -"GO:0039678","viral genome ejection through host cell envelope" -"GO:0060580","ventral spinal cord interneuron fate determination" -"GO:0051481","negative regulation of cytosolic calcium ion concentration" -"GO:1900238","regulation of metanephric mesenchymal cell migration by platelet-derived growth factor receptor-beta signaling pathway" -"GO:0110091","negative regulation of hippocampal neuron apoptotic process" -"GO:1905684","regulation of plasma membrane repair" -"GO:0061052","negative regulation of cell growth involved in cardiac muscle cell development" -"GO:0022025","leukemia inhibitory factor signaling pathway involved in forebrain neuron fate commitment" -"GO:0045571","negative regulation of imaginal disc growth" -"GO:0003286","atrial septum intermedium development" -"GO:0002041","intussusceptive angiogenesis" -"GO:0030837","negative regulation of actin filament polymerization" -"GO:0002866","positive regulation of acute inflammatory response to antigenic stimulus" -"GO:0032254","establishment of secretory granule localization" -"GO:0044034","multi-organism biosynthetic process" -"GO:0061478","response to platelet aggregation inhibitor" -"GO:1905866","positive regulation of Atg1/ULK1 kinase complex assembly" -"GO:0086048","membrane depolarization during bundle of His cell action potential" -"GO:1990771","clathrin-dependent extracellular exosome endocytosis" -"GO:0099586","release of sequestered calcium ion into postsynaptic cytosol" -"GO:1901192","positive regulation of formation of translation initiation ternary complex" -"GO:0052213","interaction with symbiont via secreted substance involved in symbiotic interaction" -"GO:0044580","butyryl-CoA catabolic process" -"GO:0044694","pore-mediated entry of viral genome into host cell" -"GO:0019677","NAD catabolic process" -"GO:0039667","viral entry into host cell via pilus retraction" -"GO:1902138","(-)-secoisolariciresinol biosynthetic process" -"GO:1903897","regulation of PERK-mediated unfolded protein response" -"GO:1905616","regulation of miRNA mediated inhibition of translation" -"GO:0060540","diaphragm morphogenesis" -"GO:0009720","detection of hormone stimulus" -"GO:0106058","positive regulation of calcineurin-mediated signaling" -"GO:1903636","regulation of protein import into mitochondrial outer membrane" -"GO:0075255","teliospore formation" -"GO:0031498","chromatin disassembly" -"GO:0061707","extracellular exosome macropinocytosis" -"GO:0009691","cytokinin biosynthetic process" -"GO:0070329","tRNA seleno-modification" -"GO:2001160","regulation of histone H3-K79 methylation" -"GO:0009562","embryo sac nuclear migration" -"GO:0007116","regulation of cell budding" -"GO:0043266","regulation of potassium ion transport" -"GO:0010606","positive regulation of cytoplasmic mRNA processing body assembly" -"GO:1904964","positive regulation of phytol biosynthetic process" -"GO:1903409","reactive oxygen species biosynthetic process" -"GO:0010715","regulation of extracellular matrix disassembly" -"GO:1990486","anaerobic fatty acid catabolic process" -"GO:0035641","locomotory exploration behavior" -"GO:1905561","positive regulation of kinetochore assembly" -"GO:0009640","photomorphogenesis" -"GO:0045185","maintenance of protein location" -"GO:1902608","positive regulation of large conductance calcium-activated potassium channel activity" -"GO:0045388","negative regulation of interleukin-20 biosynthetic process" -"GO:0003303","BMP signaling pathway involved in heart jogging" -"GO:0007598","blood coagulation, extrinsic pathway" -"GO:1904255","negative regulation of iron channel activity" -"GO:0010360","negative regulation of anion channel activity" -"GO:0009753","response to jasmonic acid" -"GO:0070616","regulation of thiamine diphosphate biosynthetic process" -"GO:0035129","post-embryonic hindlimb morphogenesis" -"GO:0042117","monocyte activation" -"GO:1903691","positive regulation of wound healing, spreading of epidermal cells" -"GO:1901880","negative regulation of protein depolymerization" -"GO:1902628","positive regulation of assembly of large subunit precursor of preribosome" -"GO:1902894","negative regulation of pri-miRNA transcription by RNA polymerase II" -"GO:0010848","regulation of chromatin disassembly" -"GO:0070179","D-serine biosynthetic process" -"GO:0006465","signal peptide processing" -"GO:1904199","positive regulation of regulation of vascular smooth muscle cell membrane depolarization" -"GO:1904865","positive regulation of beta-catenin-TCF complex assembly" -"GO:0098771","inorganic ion homeostasis" -"GO:1904372","positive regulation of protein localization to actin cortical patch" -"GO:0035386","regulation of Roundabout signaling pathway" -"GO:0033055","D-arginine metabolic process" -"GO:1903965","monounsaturated fatty acid catabolic process" -"GO:0071610","chemokine (C-C motif) ligand 1 production" -"GO:0008612","peptidyl-lysine modification to peptidyl-hypusine" -"GO:1900825","regulation of membrane depolarization during cardiac muscle cell action potential" -"GO:0002927","archaeosine-tRNA biosynthetic process" -"GO:1904712","positive regulation of Wnt-Frizzled-LRP5/6 complex assembly" -"GO:0014830","arteriole smooth muscle contraction" -"GO:0036077","intratendonous ossification" -"GO:0090659","walking behavior" -"GO:0000464","endonucleolytic cleavage in ITS1 upstream of 5.8S rRNA from tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:1900096","negative regulation of dosage compensation by inactivation of X chromosome" -"GO:0007380","specification of segmental identity, head" -"GO:0030177","positive regulation of Wnt signaling pathway" -"GO:0035781","CD86 biosynthetic process" -"GO:0071269","L-homocysteine biosynthetic process" -"GO:0009851","auxin biosynthetic process" -"GO:1905344","prostaglandin catabolic process" -"GO:1904193","negative regulation of cholangiocyte apoptotic process" -"GO:1900339","regulation of methane biosynthetic process from formic acid" -"GO:0044283","small molecule biosynthetic process" -"GO:0070094","positive regulation of glucagon secretion" -"GO:1904690","positive regulation of cytoplasmic translational initiation" -"GO:0042309","homoiothermy" -"GO:0048176","regulation of hepatocyte growth factor biosynthetic process" -"GO:0051089","constitutive protein ectodomain proteolysis" -"GO:0007586","digestion" -"GO:0140021","mitochondrial ADP transmembrane transport" -"GO:0032392","DNA geometric change" -"GO:1901576","organic substance biosynthetic process" -"GO:0090325","regulation of locomotion involved in locomotory behavior" -"GO:0090303","positive regulation of wound healing" -"GO:0000105","histidine biosynthetic process" -"GO:0006615","SRP-dependent cotranslational protein targeting to membrane, docking" -"GO:1901601","strigolactone biosynthetic process" -"GO:0045695","negative regulation of embryo sac egg cell differentiation" -"GO:0100039","regulation of pyrimidine nucleotide biosynthetic process by transcription from RNA polymerase II promoter" -"GO:1900454","positive regulation of long term synaptic depression" -"GO:0097480","establishment of synaptic vesicle localization" -"GO:0010039","response to iron ion" -"GO:0034696","response to prostaglandin F" -"GO:1904206","positive regulation of skeletal muscle hypertrophy" -"GO:0044541","zymogen activation in other organism" -"GO:1905602","positive regulation of receptor-mediated endocytosis involved in cholesterol transport" -"GO:1905795","cellular response to puromycin" -"GO:1905796","regulation of intraciliary anterograde transport" -"GO:0090279","regulation of calcium ion import" -"GO:0002031","G-protein coupled receptor internalization" -"GO:0006498","N-terminal protein lipidation" -"GO:1902638","neural crest cell differentiation involved in parathyroid gland development" -"GO:0070503","selenium-containing prosthetic group metabolic process" -"GO:1905445","positive regulation of clathrin coat assembly" -"GO:0006904","vesicle docking involved in exocytosis" -"GO:1990638","response to granulocyte colony-stimulating factor" -"GO:0070810","positive regulation of Hulle cell development" -"GO:0070857","regulation of bile acid biosynthetic process" -"GO:2000048","negative regulation of cell-cell adhesion mediated by cadherin" -"GO:2000757","negative regulation of peptidyl-lysine acetylation" -"GO:0120032","regulation of plasma membrane bounded cell projection assembly" -"GO:0009108","coenzyme biosynthetic process" -"GO:0009793","embryo development ending in seed dormancy" -"GO:0030336","negative regulation of cell migration" -"GO:2000439","positive regulation of monocyte extravasation" -"GO:0052405","negative regulation by host of symbiont molecular function" -"GO:0002644","negative regulation of tolerance induction" -"GO:1901465","positive regulation of tetrapyrrole biosynthetic process" -"GO:1903050","regulation of proteolysis involved in cellular protein catabolic process" -"GO:0100067","positive regulation of spinal cord association neuron differentiation by canonical Wnt signaling pathway" -"GO:0031060","regulation of histone methylation" -"GO:0007141","male meiosis I" -"GO:1903886","positive regulation of chemokine (C-C motif) ligand 20 production" -"GO:0043861","agmatine:putrescine antiporter activity" -"GO:0036060","slit diaphragm assembly" -"GO:0021510","spinal cord development" -"GO:0098694","regulation of synaptic vesicle budding from presynaptic endocytic zone membrane" -"GO:0033210","leptin-mediated signaling pathway" -"GO:0101023","vascular endothelial cell proliferation" -"GO:0060218","hematopoietic stem cell differentiation" -"GO:1904981","maltose transmembrane transport" -"GO:0009174","pyrimidine ribonucleoside monophosphate biosynthetic process" -"GO:1902708","response to plumbagin" -"GO:0010916","negative regulation of very-low-density lipoprotein particle clearance" -"GO:1900845","positive regulation of monodictyphenone biosynthetic process" -"GO:0051964","negative regulation of synapse assembly" -"GO:0044667","(R)-carnitine:4-(trimethylammonio)butanoate antiporter activity" -"GO:0043987","histone H3-S10 phosphorylation" -"GO:0045089","positive regulation of innate immune response" -"GO:1903460","mitotic DNA replication leading strand elongation" -"GO:0006370","7-methylguanosine mRNA capping" -"GO:0072286","metanephric connecting tubule development" -"GO:0002357","defense response to tumor cell" -"GO:0070908","tyrosine:tyramine antiporter activity" -"GO:1901492","positive regulation of lymphangiogenesis" -"GO:0048369","lateral mesoderm morphogenesis" -"GO:1900185","positive regulation of xanthone-containing compound biosynthetic process" -"GO:0036325","vascular endothelial growth factor receptor-3 signaling pathway" -"GO:0006106","fumarate metabolic process" -"GO:0014071","response to cycloalkane" -"GO:0061122","positive regulation of positive chemotaxis to cAMP" -"GO:0030810","positive regulation of nucleotide biosynthetic process" -"GO:0036290","protein trans-autophosphorylation" -"GO:0060911","cardiac cell fate commitment" -"GO:0034505","tooth mineralization" -"GO:1905209","positive regulation of cardiocyte differentiation" -"GO:0007129","synapsis" -"GO:1905287","positive regulation of G2/M transition of mitotic cell cycle involved in cellular response to nitrogen starvation" -"GO:0050834","molybdenum incorporation via L-cysteinyl copper sulfido molybdopterin cytosine dinucleotide" -"GO:0000712","resolution of meiotic recombination intermediates" -"GO:0052322","positive regulation of phytoalexin biosynthetic process" -"GO:0034155","regulation of toll-like receptor 7 signaling pathway" -"GO:0015308","amiloride:proton antiporter activity" -"GO:0003132","mesodermal-endodermal cell signaling involved in heart induction" -"GO:1905724","positive regulation of trypanothione biosynthetic process" -"GO:0070829","heterochromatin maintenance" -"GO:1901493","response to decalin" -"GO:1905355","spine apparatus assembly" -"GO:0015496","putrescine:ornithine antiporter activity" -"GO:1990258","histone glutamine methylation" -"GO:0110075","regulation of ferroptosis" -"GO:0071606","chemokine (C-C motif) ligand 4 production" -"GO:2000473","positive regulation of hematopoietic stem cell migration" -"GO:1900718","positive regulation of violaceol II biosynthetic process" -"GO:1901426","response to furfural" -"GO:0051620","norepinephrine uptake" -"GO:0021891","olfactory bulb interneuron development" -"GO:1905390","cellular response to leukotriene B4" -"GO:0071577","zinc ion transmembrane transport" -"GO:0070213","protein auto-ADP-ribosylation" -"GO:0010518","positive regulation of phospholipase activity" -"GO:0071579","regulation of zinc ion transport" -"GO:1903013","response to differentiation-inducing factor 1" -"GO:0097529","myeloid leukocyte migration" -"GO:1902761","positive regulation of chondrocyte development" -"GO:0071362","cellular response to ether" -"GO:2000448","positive regulation of macrophage migration inhibitory factor signaling pathway" -"GO:0060595","fibroblast growth factor receptor signaling pathway involved in mammary gland specification" -"GO:0033274","response to vitamin B2" -"GO:1900511","positive regulation of pentose catabolic process to ethanol" -"GO:0044565","dendritic cell proliferation" -"GO:0030727","germarium-derived female germ-line cyst formation" -"GO:0031449","regulation of slow-twitch skeletal muscle fiber contraction" -"GO:0035421","activation of MAPKK activity involved in innate immune response" -"GO:0010658","striated muscle cell apoptotic process" -"GO:0006885","regulation of pH" -"GO:1903945","positive regulation of hepatocyte apoptotic process" -"GO:0060754","positive regulation of mast cell chemotaxis" -"GO:0035604","fibroblast growth factor receptor signaling pathway involved in positive regulation of cell proliferation in bone marrow" -"GO:0001743","optic placode formation" -"GO:0061149","BMP signaling pathway involved in ureter morphogenesis" -"GO:0016331","morphogenesis of embryonic epithelium" -"GO:1904034","positive regulation of t-SNARE clustering" -"GO:0061768","magnesium:sodium antiporter activity" -"GO:0042459","octopine catabolic process to proline" -"GO:1900854","positive regulation of terrequinone A biosynthetic process" -"GO:0035901","cellular response to isolation stress" -"GO:1990443","peptidyl-threonine autophosphorylation" -"GO:0018964","propylene metabolic process" -"GO:0010583","response to cyclopentenone" -"GO:0045112","integrin biosynthetic process" -"GO:0046606","negative regulation of centrosome cycle" -"GO:0060537","muscle tissue development" -"GO:0003166","bundle of His development" -"GO:0050913","sensory perception of bitter taste" -"GO:0010043","response to zinc ion" -"GO:1900964","positive regulation of methanophenazine biosynthetic process" -"GO:0009566","fertilization" -"GO:2000773","negative regulation of cellular senescence" -"GO:1902995","positive regulation of phospholipid efflux" -"GO:0006295","nucleotide-excision repair, DNA incision, 3'-to lesion" -"GO:0048762","mesenchymal cell differentiation" -"GO:0099148","regulation of synaptic vesicle docking" -"GO:0000724","double-strand break repair via homologous recombination" -"GO:0035295","tube development" -"GO:1901990","regulation of mitotic cell cycle phase transition" -"GO:0045833","negative regulation of lipid metabolic process" -"GO:0043310","negative regulation of eosinophil degranulation" -"GO:0072505","divalent inorganic anion homeostasis" -"GO:0005451","monovalent cation:proton antiporter activity" -"GO:0032375","negative regulation of cholesterol transport" -"GO:1900038","negative regulation of cellular response to hypoxia" -"GO:0007140","male meiotic nuclear division" -"GO:1901679","nucleotide transmembrane transport" -"GO:1990679","histone H4-K12 deacetylation" -"GO:1903427","negative regulation of reactive oxygen species biosynthetic process" -"GO:0021835","chemoattraction involved in embryonic olfactory bulb interneuron precursor migration" -"GO:0060552","positive regulation of fructose 1,6-bisphosphate metabolic process" -"GO:0050925","negative regulation of negative chemotaxis" -"GO:0031954","positive regulation of protein autophosphorylation" -"GO:0006294","nucleotide-excision repair, preincision complex assembly" -"GO:0032289","central nervous system myelin formation" -"GO:0034165","positive regulation of toll-like receptor 9 signaling pathway" -"GO:0061756","leukocyte adhesion to vascular endothelial cell" -"GO:1990960","basophil homeostasis" -"GO:2000585","positive regulation of platelet-derived growth factor receptor-alpha signaling pathway" -"GO:1900508","positive regulation of iron-sulfur-molybdenum cofactor assembly" -"GO:0035393","chemokine (C-X-C motif) ligand 9 production" -"GO:0010069","zygote asymmetric cytokinesis in embryo sac" -"GO:0030949","positive regulation of vascular endothelial growth factor receptor signaling pathway" -"GO:2000633","positive regulation of pre-miRNA processing" -"GO:0008355","olfactory learning" -"GO:0015368","calcium:cation antiporter activity" -"GO:1905802","regulation of cellular response to manganese ion" -"GO:1900685","positive regulation of fumonisin biosynthetic process" -"GO:0051103","DNA ligation involved in DNA repair" -"GO:0042985","negative regulation of amyloid precursor protein biosynthetic process" -"GO:0046275","flavonoid catabolic process" -"GO:0006828","manganese ion transport" -"GO:0061088","regulation of sequestering of zinc ion" -"GO:0031290","retinal ganglion cell axon guidance" -"GO:0034384","high-density lipoprotein particle clearance" -"GO:1904730","negative regulation of intestinal lipid absorption" -"GO:0032412","regulation of ion transmembrane transporter activity" -"GO:0006797","polyphosphate metabolic process" -"GO:0035206","regulation of hemocyte proliferation" -"GO:0060615","mammary gland bud formation" -"GO:0051503","adenine nucleotide transport" -"GO:0035385","Roundabout signaling pathway" -"GO:2000451","positive regulation of CD8-positive, alpha-beta T cell extravasation" -"GO:0006824","cobalt ion transport" -"GO:2000309","positive regulation of tumor necrosis factor (ligand) superfamily member 11 production" -"GO:0051593","response to folic acid" -"GO:0048818","positive regulation of hair follicle maturation" -"GO:1900751","4-(trimethylammonio)butanoate transport" -"GO:1905116","positive regulation of lateral attachment of mitotic spindle microtubules to kinetochore" -"GO:1905283","negative regulation of epidermal growth factor receptor signaling pathway involved in heart process" -"GO:0042953","lipoprotein transport" -"GO:0006359","regulation of transcription by RNA polymerase III" -"GO:0034375","high-density lipoprotein particle remodeling" -"GO:0070907","histidine:histamine antiporter activity" -"GO:0003029","detection of hypoxic conditions in blood by carotid body chemoreceptor signaling" -"GO:0090138","regulation of actin cytoskeleton organization by cell-cell adhesion" -"GO:0003307","regulation of Wnt signaling pathway involved in heart development" -"GO:0036078","minus-end specific microtubule depolymerization" -"GO:0051224","negative regulation of protein transport" -"GO:2000008","regulation of protein localization to cell surface" -"GO:0070462","plus-end specific microtubule depolymerization" -"GO:0072312","metanephric glomerular epithelial cell differentiation" -"GO:1903461","Okazaki fragment processing involved in mitotic DNA replication" -"GO:2000269","regulation of fibroblast apoptotic process" -"GO:0043319","positive regulation of cytotoxic T cell degranulation" -"GO:1902057","(25S)-Delta(4)-dafachronate metabolic process" -"GO:0010920","negative regulation of inositol phosphate biosynthetic process" -"GO:0070227","lymphocyte apoptotic process" -"GO:2000302","positive regulation of synaptic vesicle exocytosis" -"GO:1901234","positive regulation of convergent extension involved in axis elongation" -"GO:0060055","angiogenesis involved in wound healing" -"GO:1900063","regulation of peroxisome organization" -"GO:0006805","xenobiotic metabolic process" -"GO:0006654","phosphatidic acid biosynthetic process" -"GO:0043244","regulation of protein complex disassembly" -"GO:0090034","regulation of chaperone-mediated protein complex assembly" -"GO:0016330","second mitotic wave involved in compound eye morphogenesis" -"GO:0021962","vestibulospinal tract morphogenesis" -"GO:0007499","ectoderm and mesoderm interaction" -"GO:0048511","rhythmic process" -"GO:0009584","detection of visible light" -"GO:0071231","cellular response to folic acid" -"GO:0050769","positive regulation of neurogenesis" -"GO:0009240","isopentenyl diphosphate biosynthetic process" -"GO:0002884","negative regulation of hypersensitivity" -"GO:0097551","mitochondrial double-strand break repair" -"GO:0045204","MAPK export from nucleus" -"GO:0014870","response to muscle inactivity" -"GO:0061399","positive regulation of transcription from RNA polymerase II promoter in response to cobalt ion" -"GO:0036339","lymphocyte adhesion to endothelial cell of high endothelial venule" -"GO:0031022","nuclear migration along microfilament" -"GO:1903910","negative regulation of receptor clustering" -"GO:0090022","regulation of neutrophil chemotaxis" -"GO:0090015","positive regulation of leaflet formation by auxin mediated signaling pathway" -"GO:1903743","negative regulation of anterograde synaptic vesicle transport" -"GO:0140140","mitochondrial guanine nucleotide transmembrane transport" -"GO:0040008","regulation of growth" -"GO:1901529","positive regulation of anion channel activity" -"GO:1905541","regulation of L-arginine import across plasma membrane" -"GO:0090149","mitochondrial membrane fission" -"GO:2000555","negative regulation of T-helper 1 cell cytokine production" -"GO:0045679","regulation of R8 cell differentiation" -"GO:0001315","age-dependent response to reactive oxygen species" -"GO:0097744","urate salt excretion" -"GO:1900215","negative regulation of apoptotic process involved in metanephric collecting duct development" -"GO:0038027","apolipoprotein A-I-mediated signaling pathway" -"GO:0051580","regulation of neurotransmitter uptake" -"GO:1990492","mitotic cell cycle checkpoint inhibiting CAR assembly" -"GO:0014037","Schwann cell differentiation" -"GO:0050828","regulation of liquid surface tension" -"GO:0060542","regulation of strand invasion" -"GO:0061760","antifungal innate immune response" -"GO:0046635","positive regulation of alpha-beta T cell activation" -"GO:0060970","embryonic heart tube dorsal/ventral pattern formation" -"GO:1904798","positive regulation of core promoter binding" -"GO:1902527","positive regulation of protein monoubiquitination" -"GO:0001060","transcription by RNA polymerase V" -"GO:1905180","positive regulation of cardiac muscle tissue regeneration" -"GO:0061400","positive regulation of transcription from RNA polymerase II promoter in response to calcium ion" -"GO:0050994","regulation of lipid catabolic process" -"GO:0007172","signal complex assembly" -"GO:0019413","acetate biosynthetic process" -"GO:1905750","negative regulation of endosome to plasma membrane protein transport" -"GO:0061410","positive regulation of transcription from RNA polymerase II promoter in response to ethanol" -"GO:2000479","regulation of cAMP-dependent protein kinase activity" -"GO:0001992","regulation of systemic arterial blood pressure by vasopressin" -"GO:0021612","facial nerve structural organization" -"GO:0002907","positive regulation of mature B cell apoptotic process" -"GO:0048574","long-day photoperiodism, flowering" -"GO:0072576","liver morphogenesis" -"GO:0042177","negative regulation of protein catabolic process" -"GO:0007638","mechanosensory behavior" -"GO:0007084","mitotic nuclear envelope reassembly" -"GO:0014899","cardiac muscle atrophy" -"GO:0061198","fungiform papilla formation" -"GO:0003400","regulation of COPII vesicle coating" -"GO:0032369","negative regulation of lipid transport" -"GO:1903432","regulation of TORC1 signaling" -"GO:0009757","hexose mediated signaling" -"GO:0038176","positive regulation of SREBP signaling pathway in response to decreased oxygen levels" -"GO:1903110","regulation of single-strand break repair via homologous recombination" -"GO:0071640","regulation of macrophage inflammatory protein 1 alpha production" -"GO:0045715","negative regulation of low-density lipoprotein particle receptor biosynthetic process" -"GO:0002324","natural killer cell proliferation involved in immune response" -"GO:0060479","lung cell differentiation" -"GO:0007143","female meiotic nuclear division" -"GO:1900189","positive regulation of cell adhesion involved in single-species biofilm formation" -"GO:0010925","positive regulation of inositol-polyphosphate 5-phosphatase activity" -"GO:0001840","neural plate development" -"GO:0021920","regulation of transcription from RNA polymerase II promoter involved in spinal cord association neuron specification" -"GO:0003177","pulmonary valve development" -"GO:0042636","negative regulation of hair cycle" -"GO:0070416","trehalose metabolism in response to water deprivation" -"GO:0106101","ER-dependent peroxisome localization" -"GO:0061806","regulation of DNA recombination at centromere" -"GO:0051137","negative regulation of NK T cell differentiation" -"GO:0048312","intracellular distribution of mitochondria" -"GO:0097323","B cell adhesion" -"GO:0016559","peroxisome fission" -"GO:0048215","positive regulation of Golgi vesicle fusion to target membrane" -"GO:0010520","regulation of reciprocal meiotic recombination" -"GO:0060734","regulation of endoplasmic reticulum stress-induced eIF2 alpha phosphorylation" -"GO:0050748","negative regulation of lipoprotein metabolic process" -"GO:0014807","regulation of somitogenesis" -"GO:0045911","positive regulation of DNA recombination" -"GO:0097327","response to antineoplastic agent" -"GO:0036466","synaptic vesicle recycling via endosome" -"GO:0031345","negative regulation of cell projection organization" -"GO:0009671","nitrate:proton symporter activity" -"GO:0044154","histone H3-K14 acetylation" -"GO:0007219","Notch signaling pathway" -"GO:0075522","IRES-dependent viral translational initiation" -"GO:0010373","negative regulation of gibberellin biosynthetic process" -"GO:0048874","homeostasis of number of cells in a free-living population" -"GO:0001788","antibody-dependent cellular cytotoxicity" -"GO:0006036","cuticle chitin catabolic process" -"GO:0006611","protein export from nucleus" -"GO:0018252","peptide cross-linking via L-seryl-5-imidazolinone glycine" -"GO:0072238","metanephric long nephron development" -"GO:0048285","organelle fission" -"GO:0060377","negative regulation of mast cell differentiation" -"GO:0019551","glutamate catabolic process to 2-oxoglutarate" -"GO:0001501","skeletal system development" -"GO:1904142","negative regulation of carotenoid biosynthetic process" -"GO:2000597","positive regulation of optic nerve formation" -"GO:1903942","positive regulation of respiratory gaseous exchange" -"GO:1900244","positive regulation of synaptic vesicle endocytosis" -"GO:0010324","membrane invagination" -"GO:1903538","regulation of meiotic cell cycle process involved in oocyte maturation" -"GO:0036483","neuron intrinsic apoptotic signaling pathway in response to endoplasmic reticulum stress" -"GO:0044806","G-quadruplex DNA unwinding" -"GO:0061550","cranial ganglion development" -"GO:0032459","regulation of protein oligomerization" -"GO:0009838","abscission" -"GO:0046545","development of primary female sexual characteristics" -"GO:1905842","cellular response to oxidopamine" -"GO:0032467","positive regulation of cytokinesis" -"GO:1904501","positive regulation of chromatin-mediated maintenance of transcription" -"GO:0050716","positive regulation of interleukin-1 secretion" -"GO:0071671","regulation of smooth muscle cell chemotaxis" -"GO:0039564","suppression by virus of host STAT2 activity" -"GO:0015732","prostaglandin transport" -"GO:1901754","vitamin D3 catabolic process" -"GO:1905443","regulation of clathrin coat assembly" -"GO:0002308","CD8-positive, alpha-beta cytotoxic T cell differentiation" -"GO:0060441","epithelial tube branching involved in lung morphogenesis" -"GO:0022615","protein to membrane docking" -"GO:1902637","neural crest cell differentiation involved in thymus development" -"GO:0016543","male courtship behavior, orientation prior to leg tapping and wing vibration" -"GO:0048698","negative regulation of collateral sprouting in absence of injury" -"GO:0031952","regulation of protein autophosphorylation" -"GO:0046960","sensitization" -"GO:0006647","phosphatidyl-N-monomethylethanolamine biosynthetic process" -"GO:0032277","negative regulation of gonadotropin secretion" -"GO:0061397","positive regulation of transcription from RNA polymerase II promoter in response to copper ion" -"GO:0052575","carbohydrate localization" -"GO:0006312","mitotic recombination" -"GO:0030278","regulation of ossification" -"GO:0035820","negative regulation of renal sodium excretion by angiotensin" -"GO:0021804","negative regulation of cell adhesion in ventricular zone" -"GO:0106104","regulation of glutamate receptor clustering" -"GO:0090727","positive regulation of brood size" -"GO:1900364","negative regulation of mRNA polyadenylation" -"GO:1990910","response to hypobaric hypoxia" -"GO:0060249","anatomical structure homeostasis" -"GO:1900249","positive regulation of cytoplasmic translational elongation" -"GO:0008627","intrinsic apoptotic signaling pathway in response to osmotic stress" -"GO:0061944","negative regulation of protein K48-linked ubiquitination" -"GO:0010938","cytoplasmic microtubule depolymerization" -"GO:0000730","DNA recombinase assembly" -"GO:0003374","dynamin family protein polymerization involved in mitochondrial fission" -"GO:1904760","regulation of myofibroblast differentiation" -"GO:0007622","rhythmic behavior" -"GO:1901340","negative regulation of store-operated calcium channel activity" -"GO:0072645","interferon-delta production" -"GO:1990466","protein autosumoylation" -"GO:0002182","cytoplasmic translational elongation" -"GO:1990755","mitotic spindle microtubule depolymerization" -"GO:1903872","regulation of DNA recombinase mediator complex assembly" -"GO:0016042","lipid catabolic process" -"GO:2000504","positive regulation of blood vessel remodeling" -"GO:0032932","negative regulation of astral microtubule depolymerization" -"GO:0050849","negative regulation of calcium-mediated signaling" -"GO:0021660","rhombomere 3 formation" -"GO:0052803","imidazole-containing compound metabolic process" -"GO:0051791","medium-chain fatty acid metabolic process" -"GO:1901266","cephalosporin C metabolic process" -"GO:0021709","cerebellar basket cell differentiation" -"GO:1900546","positive regulation of phenotypic switching by regulation of transcription from RNA polymerase II promoter" -"GO:0061612","galactose to glucose-1-phosphate metabolic process" -"GO:1904632","cellular response to glucoside" -"GO:0034472","snRNA 3'-end processing" -"GO:1905446","regulation of mitochondrial ATP synthesis coupled electron transport" -"GO:0070601","centromeric sister chromatid cohesion" -"GO:0110096","cellular response to aldehyde" -"GO:0021915","neural tube development" -"GO:0018938","2-nitropropane metabolic process" -"GO:0051178","meiotic chromosome decondensation" -"GO:0035512","hydrolytic DNA demethylation" -"GO:0060948","cardiac vascular smooth muscle cell development" -"GO:0010071","root meristem specification" -"GO:0045682","regulation of epidermis development" -"GO:0060378","regulation of brood size" -"GO:1900576","gerfelin metabolic process" -"GO:0070276","halogen metabolic process" -"GO:1903406","regulation of sodium:potassium-exchanging ATPase activity" -"GO:0046721","formic acid secretion" -"GO:0045364","negative regulation of interleukin-11 biosynthetic process" -"GO:0031145","anaphase-promoting complex-dependent catabolic process" -"GO:1902970","premeiotic DNA replication DNA duplex unwinding" -"GO:0048530","fruit morphogenesis" -"GO:0090448","glucosinolate:proton symporter activity" -"GO:0036268","swimming" -"GO:0044645","modulation of complement activation in other organism" -"GO:0002552","serotonin secretion by mast cell" -"GO:0019480","L-alanine oxidation to pyruvate via D-alanine" -"GO:1901654","response to ketone" -"GO:0002097","tRNA wobble base modification" -"GO:1900457","regulation of brassinosteroid mediated signaling pathway" -"GO:0002575","basophil chemotaxis" -"GO:0071903","protein N-linked N-acetylglucosaminylation via asparagine" -"GO:0044271","cellular nitrogen compound biosynthetic process" -"GO:0007535","donor selection" -"GO:0071658","regulation of IP-10 production" -"GO:0003160","endocardium morphogenesis" -"GO:1902036","regulation of hematopoietic stem cell differentiation" -"GO:0032605","hepatocyte growth factor production" -"GO:1903570","regulation of protein kinase D signaling" -"GO:0060114","vestibular receptor cell differentiation" -"GO:0021755","eurydendroid cell differentiation" -"GO:0042726","flavin-containing compound metabolic process" -"GO:0050810","regulation of steroid biosynthetic process" -"GO:0061372","activin receptor signaling pathway involved in heart jogging" -"GO:0036100","leukotriene catabolic process" -"GO:0021548","pons development" -"GO:0034304","actinomycete-type spore formation" -"GO:1901626","regulation of postsynaptic membrane organization" -"GO:0000209","protein polyubiquitination" -"GO:0072657","protein localization to membrane" -"GO:0071932","replication fork reversal" -"GO:0045501","regulation of sevenless signaling pathway" -"GO:0003244","radial growth involved in right ventricle morphogenesis" -"GO:0042430","indole-containing compound metabolic process" -"GO:0045040","protein import into mitochondrial outer membrane" -"GO:0002479","antigen processing and presentation of exogenous peptide antigen via MHC class I, TAP-dependent" -"GO:0010691","negative regulation of ribosomal protein gene transcription from RNA polymerase II promoter in response to nutrient levels" -"GO:0030381","chorion-containing eggshell pattern formation" -"GO:0080169","cellular response to boron-containing substance deprivation" -"GO:0071611","granulocyte colony-stimulating factor production" -"GO:0018876","benzonitrile metabolic process" -"GO:0071372","cellular response to follicle-stimulating hormone stimulus" -"GO:2001260","regulation of semaphorin-plexin signaling pathway" -"GO:0043574","peroxisomal transport" -"GO:0010695","regulation of mitotic spindle pole body separation" -"GO:0003157","endocardium development" -"GO:0036179","osteoclast maturation" -"GO:0043485","endosome to pigment granule transport" -"GO:0021539","subthalamus development" -"GO:0060194","regulation of antisense RNA transcription" -"GO:0140123","negative regulation of Lewy body formation" -"GO:0060411","cardiac septum morphogenesis" -"GO:0051562","negative regulation of mitochondrial calcium ion concentration" -"GO:0021712","candelabrum cell differentiation" -"GO:0015968","stringent response" -"GO:0010450","inflorescence meristem growth" -"GO:0031058","positive regulation of histone modification" -"GO:0035914","skeletal muscle cell differentiation" -"GO:0046864","isoprenoid transport" -"GO:1901965","endoplasmic reticulum to chloroplast transport" -"GO:0048523","negative regulation of cellular process" -"GO:1902841","regulation of netrin-activated signaling pathway" -"GO:0031321","ascospore-type prospore assembly" -"GO:0045144","meiotic sister chromatid segregation" -"GO:1901053","sarcosine catabolic process" -"GO:0005993","trehalose catabolic process" -"GO:0048819","regulation of hair follicle maturation" -"GO:0061640","cytoskeleton-dependent cytokinesis" -"GO:0002051","osteoblast fate commitment" -"GO:1901595","response to hesperadin" -"GO:0080187","floral organ senescence" -"GO:0042023","DNA endoreduplication" -"GO:0061450","trophoblast cell migration" -"GO:1901600","strigolactone metabolic process" -"GO:0071800","podosome assembly" -"GO:0061140","lung secretory cell differentiation" -"GO:0072161","mesenchymal cell differentiation involved in kidney development" -"GO:0000271","polysaccharide biosynthetic process" -"GO:0051292","nuclear pore complex assembly" -"GO:1903048","regulation of acetylcholine-gated cation channel activity" -"GO:0019686","purine nucleoside interconversion" -"GO:1900074","negative regulation of neuromuscular synaptic transmission" -"GO:0000462","maturation of SSU-rRNA from tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:0006577","amino-acid betaine metabolic process" -"GO:0048482","plant ovule morphogenesis" -"GO:0021711","cerebellar unipolar brush cell differentiation" -"GO:0002238","response to molecule of fungal origin" -"GO:1900828","D-tyrosine metabolic process" -"GO:0009148","pyrimidine nucleoside triphosphate biosynthetic process" -"GO:0071998","ascospore release from ascus" -"GO:0006108","malate metabolic process" -"GO:0060579","ventral spinal cord interneuron fate commitment" -"GO:0046370","fructose biosynthetic process" -"GO:0019554","glutamate catabolic process to oxaloacetate" -"GO:0001991","regulation of systemic arterial blood pressure by circulatory renin-angiotensin" -"GO:0002458","peripheral T cell tolerance induction" -"GO:0061048","negative regulation of branching involved in lung morphogenesis" -"GO:0010842","retina layer formation" -"GO:1905539","regulation of postsynapse to nucleus signaling pathway" -"GO:0052210","interaction with other organism via protein secreted by type III secretion system involved in symbiotic interaction" -"GO:0002437","inflammatory response to antigenic stimulus" -"GO:0036118","hyaluranon cable assembly" -"GO:0052211","interaction with other organism via protein secreted by type II secretion system involved in symbiotic interaction" -"GO:0044040","multi-organism carbohydrate metabolic process" -"GO:2000022","regulation of jasmonic acid mediated signaling pathway" -"GO:0035047","centrosomal and pronuclear rotation" -"GO:0003213","cardiac right atrium morphogenesis" -"GO:0086030","adenylate cyclase-activating adrenergic receptor signaling pathway involved in cardiac muscle relaxation" -"GO:0021680","cerebellar Purkinje cell layer development" -"GO:0042616","paclitaxel metabolic process" -"GO:0006521","regulation of cellular amino acid metabolic process" -"GO:0042487","regulation of odontogenesis of dentin-containing tooth" -"GO:0060567","negative regulation of DNA-templated transcription, termination" -"GO:0010582","floral meristem determinacy" -"GO:0060839","endothelial cell fate commitment" -"GO:0007386","compartment pattern specification" -"GO:0015859","intracellular nucleoside transport" -"GO:0097745","mitochondrial tRNA 5'-end processing" -"GO:0002033","angiotensin-mediated vasodilation involved in regulation of systemic arterial blood pressure" -"GO:1902427","regulation of water channel activity" -"GO:0035196","production of miRNAs involved in gene silencing by miRNA" -"GO:1903513","endoplasmic reticulum to cytosol transport" -"GO:0031146","SCF-dependent proteasomal ubiquitin-dependent protein catabolic process" -"GO:0035778","pronephric nephron tubule epithelial cell differentiation" -"GO:0016482","cytosolic transport" -"GO:0036353","histone H2A-K119 monoubiquitination" -"GO:0052212","modification of morphology or physiology of other organism via secreted substance involved in symbiotic interaction" -"GO:0042103","positive regulation of T cell homeostatic proliferation" -"GO:0045201","maintenance of neuroblast polarity" -"GO:0015953","pyrimidine nucleotide interconversion" -"GO:0032359","provirus excision" -"GO:0019499","cyanide metabolic process" -"GO:0019689","pyrimidine nucleoside interconversion" -"GO:0007309","oocyte axis specification" -"GO:0061988","karyosome formation" -"GO:0072521","purine-containing compound metabolic process" -"GO:0097315","response to N-acetyl-D-glucosamine" -"GO:0072732","cellular response to calcium ion starvation" -"GO:0120132","positive regulation of apoptotic process in bone marrow" -"GO:0010498","proteasomal protein catabolic process" -"GO:0048461","flower structural organization" -"GO:1904999","positive regulation of leukocyte adhesion to arterial endothelial cell" -"GO:0022012","subpallium cell proliferation in forebrain" -"GO:0003306","Wnt signaling pathway involved in heart development" -"GO:0090383","phagosome acidification" -"GO:0006747","FAD biosynthetic process" -"GO:0045619","regulation of lymphocyte differentiation" -"GO:0019332","aerobic respiration, using nitrite as electron donor" -"GO:2001074","regulation of metanephric ureteric bud development" -"GO:2000106","regulation of leukocyte apoptotic process" -"GO:0090343","positive regulation of cell aging" -"GO:1903401","L-lysine transmembrane transport" -"GO:0046505","sulfolipid metabolic process" -"GO:1903019","negative regulation of glycoprotein metabolic process" -"GO:2000642","negative regulation of early endosome to late endosome transport" -"GO:0043086","negative regulation of catalytic activity" -"GO:0072039","regulation of mesenchymal cell apoptotic process involved in nephron morphogenesis" -"GO:0060370","susceptibility to T cell mediated cytotoxicity" -"GO:0006391","transcription initiation from mitochondrial promoter" -"GO:0032701","negative regulation of interleukin-18 production" -"GO:0071499","cellular response to laminar fluid shear stress" -"GO:0071578","zinc ion import across plasma membrane" -"GO:1904520","regulation of myofibroblast cell apoptotic process" -"GO:0042271","susceptibility to natural killer cell mediated cytotoxicity" -"GO:0061433","cellular response to caloric restriction" -"GO:0042478","regulation of eye photoreceptor cell development" -"GO:0009264","deoxyribonucleotide catabolic process" -"GO:0010533","regulation of activation of Janus kinase activity" -"GO:0042870","D-glucarate transmembrane transport" -"GO:1990548","mitochondrial FAD transmembrane transport" -"GO:0034378","chylomicron assembly" -"GO:0048359","mucilage metabolic process involved in seed coat development" -"GO:0035855","megakaryocyte development" -"GO:0046601","positive regulation of centriole replication" -"GO:1904671","negative regulation of cell differentiation involved in stem cell population maintenance" -"GO:0120006","regulation of glutamatergic neuron differentiation" -"GO:0097067","cellular response to thyroid hormone stimulus" -"GO:0035518","histone H2A monoubiquitination" -"GO:1902738","regulation of chondrocyte differentiation involved in endochondral bone morphogenesis" -"GO:1903146","regulation of autophagy of mitochondrion" -"GO:1905130","carcinine import across plasma membrane" -"GO:0009626","plant-type hypersensitive response" -"GO:1900154","regulation of bone trabecula formation" -"GO:0015888","thiamine transport" -"GO:0044869","negative regulation by host of viral exo-alpha-sialidase activity" -"GO:1901477","benomyl transmembrane transport" -"GO:0071501","cellular response to sterol depletion" -"GO:0038109","Kit signaling pathway" -"GO:1903016","negative regulation of exo-alpha-sialidase activity" -"GO:1990933","microtubule cytoskeleton attachment to nuclear envelope" -"GO:0009266","response to temperature stimulus" -"GO:0035292","specification of segmental identity, trunk" -"GO:0042493","response to drug" -"GO:0033364","mast cell secretory granule organization" -"GO:0048261","negative regulation of receptor-mediated endocytosis" -"GO:0098924","retrograde trans-synaptic signaling by nitric oxide" -"GO:1904450","positive regulation of aspartate secretion" -"GO:1905554","negative regulation of vessel branching" -"GO:0048520","positive regulation of behavior" -"GO:1904556","L-tryptophan transmembrane transport" -"GO:0016128","phytosteroid metabolic process" -"GO:0051293","establishment of spindle localization" -"GO:2000495","regulation of cell proliferation involved in compound eye morphogenesis" -"GO:0046578","regulation of Ras protein signal transduction" -"GO:0031552","negative regulation of brain-derived neurotrophic factor-activated receptor activity" -"GO:0071409","cellular response to cycloheximide" -"GO:0033326","cerebrospinal fluid secretion" -"GO:1902599","sulfathiazole transmembrane transport" -"GO:0036460","cellular response to cell envelope stress" -"GO:0090256","regulation of cell proliferation involved in imaginal disc-derived wing morphogenesis" -"GO:0035962","response to interleukin-13" -"GO:0030255","protein secretion by the type IV secretion system" -"GO:1900600","endocrocin metabolic process" -"GO:1904343","positive regulation of colon smooth muscle contraction" -"GO:0019434","sophorosyloxydocosanoate metabolic process" -"GO:0046642","negative regulation of alpha-beta T cell proliferation" -"GO:2000354","regulation of ovarian follicle development" -"GO:0003339","regulation of mesenchymal to epithelial transition involved in metanephros morphogenesis" -"GO:0090083","regulation of inclusion body assembly" -"GO:0034629","cellular protein-containing complex localization" -"GO:0007518","myoblast fate determination" -"GO:0009725","response to hormone" -"GO:0007398","ectoderm development" -"GO:0030886","negative regulation of myeloid dendritic cell activation" -"GO:0098856","intestinal lipid absorption" -"GO:0061263","mesonephric glomerular mesangial cell development" -"GO:0015778","hexuronide transport" -"GO:1904781","positive regulation of protein localization to centrosome" -"GO:1903352","L-ornithine transmembrane transport" -"GO:0072368","regulation of lipid transport by negative regulation of transcription from RNA polymerase II promoter" -"GO:1905461","positive regulation of vascular associated smooth muscle cell apoptotic process" -"GO:0045357","regulation of interferon-beta biosynthetic process" -"GO:1902232","regulation of positive thymic T cell selection" -"GO:0089709","L-histidine transmembrane transport" -"GO:1901525","negative regulation of mitophagy" -"GO:0071392","cellular response to estradiol stimulus" -"GO:2000084","regulation of mesenchymal to epithelial transition involved in mesonephros morphogenesis" -"GO:1902550","lymphoid lineage cell migration into thymus involved in thymus epithelium morphogenesis" -"GO:1904916","transmembrane L-lysine transport from lysosomal lumen to cytosol" -"GO:0036447","cellular response to sugar-phosphate stress" -"GO:0001694","histamine biosynthetic process" -"GO:1901784","p-cresol metabolic process" -"GO:0032692","negative regulation of interleukin-1 production" -"GO:1902083","negative regulation of peptidyl-cysteine S-nitrosylation" -"GO:0006591","ornithine metabolic process" -"GO:0038162","erythropoietin-mediated signaling pathway" -"GO:0035377","transepithelial water transport" -"GO:0097339","glycolate transmembrane transport" -"GO:1903741","negative regulation of phosphatidate phosphatase activity" -"GO:0070208","protein heterotrimerization" -"GO:0030951","establishment or maintenance of microtubule cytoskeleton polarity" -"GO:0001523","retinoid metabolic process" -"GO:0070960","positive regulation of neutrophil mediated cytotoxicity" -"GO:0015383","sulfate:bicarbonate antiporter activity" -"GO:0019725","cellular homeostasis" -"GO:0090370","negative regulation of cholesterol efflux" -"GO:0032504","multicellular organism reproduction" -"GO:0052482","defense response by cell wall thickening" -"GO:0007200","phospholipase C-activating G-protein coupled receptor signaling pathway" -"GO:0035433","acetate transmembrane transport" -"GO:0000025","maltose catabolic process" -"GO:2000741","positive regulation of mesenchymal stem cell differentiation" -"GO:0006116","NADH oxidation" -"GO:0032762","mast cell cytokine production" -"GO:0032006","regulation of TOR signaling" -"GO:0046061","dATP catabolic process" -"GO:0042536","negative regulation of tumor necrosis factor biosynthetic process" -"GO:0046504","glycerol ether biosynthetic process" -"GO:0006583","melanin biosynthetic process from tyrosine" -"GO:2000004","regulation of metanephric S-shaped body morphogenesis" -"GO:1903785","L-valine transmembrane transport" -"GO:0001762","beta-alanine transport" -"GO:0030032","lamellipodium assembly" -"GO:0061545","tyramine secretion" -"GO:0006579","amino-acid betaine catabolic process" -"GO:0060697","positive regulation of phospholipid catabolic process" -"GO:0045676","regulation of R7 cell differentiation" -"GO:1990451","cellular stress response to acidic pH" -"GO:0042092","type 2 immune response" -"GO:0071426","ribonucleoprotein complex export from nucleus" -"GO:0045870","positive regulation of single stranded viral RNA replication via double stranded DNA intermediate" -"GO:0034724","DNA replication-independent nucleosome organization" -"GO:0003130","BMP signaling pathway involved in heart induction" -"GO:0007362","terminal region determination" -"GO:0071864","positive regulation of cell proliferation in bone marrow" -"GO:2000052","positive regulation of non-canonical Wnt signaling pathway" -"GO:0061975","articular cartilage development" -"GO:0045880","positive regulation of smoothened signaling pathway" -"GO:1903622","regulation of RNA polymerase III activity" -"GO:0019307","mannose biosynthetic process" -"GO:0050731","positive regulation of peptidyl-tyrosine phosphorylation" -"GO:0072278","metanephric comma-shaped body morphogenesis" -"GO:0046843","dorsal appendage formation" -"GO:1903445","protein transport from ciliary membrane to plasma membrane" -"GO:0015251","ammonium channel activity" -"GO:0048849","neurohypophysis formation" -"GO:0061068","urethra development" -"GO:0072284","metanephric S-shaped body morphogenesis" -"GO:0071435","potassium ion export" -"GO:0001922","B-1 B cell homeostasis" -"GO:0007349","cellularization" -"GO:0150021","apical dendrite morphogenesis" -"GO:0060048","cardiac muscle contraction" -"GO:0072262","metanephric glomerular mesangial cell proliferation involved in metanephros development" -"GO:1903062","regulation of reverse cholesterol transport" -"GO:0006271","DNA strand elongation involved in DNA replication" -"GO:0050951","sensory perception of temperature stimulus" -"GO:0031641","regulation of myelination" -"GO:0045453","bone resorption" -"GO:1905393","plant organ formation" -"GO:0021688","cerebellar molecular layer formation" -"GO:0035359","negative regulation of peroxisome proliferator activated receptor signaling pathway" -"GO:1900242","regulation of synaptic vesicle endocytosis" -"GO:0090280","positive regulation of calcium ion import" -"GO:0086009","membrane repolarization" -"GO:0035966","response to topologically incorrect protein" -"GO:0010447","response to acidic pH" -"GO:0042748","circadian sleep/wake cycle, non-REM sleep" -"GO:0070431","nucleotide-binding oligomerization domain containing 2 signaling pathway" -"GO:0014025","neural keel formation" -"GO:0044332","Wnt signaling pathway involved in dorsal/ventral axis specification" -"GO:0045990","carbon catabolite regulation of transcription" -"GO:0034144","negative regulation of toll-like receptor 4 signaling pathway" -"GO:0015866","ADP transport" -"GO:0000160","phosphorelay signal transduction system" -"GO:0046488","phosphatidylinositol metabolic process" -"GO:2000491","positive regulation of hepatic stellate cell activation" -"GO:0019309","mannose catabolic process" -"GO:0060437","lung growth" -"GO:0060659","nipple sheath formation" -"GO:0040007","growth" -"GO:0002431","Fc receptor mediated stimulatory signaling pathway" -"GO:1990859","cellular response to endothelin" -"GO:0072101","specification of ureteric bud anterior/posterior symmetry by BMP signaling pathway" -"GO:1901380","negative regulation of potassium ion transmembrane transport" -"GO:0120069","positive regulation of stomach fundus smooth muscle contraction" -"GO:0060306","regulation of membrane repolarization" -"GO:0060173","limb development" -"GO:1901211","negative regulation of cardiac chamber formation" -"GO:0033353","S-adenosylmethionine cycle" -"GO:0002899","negative regulation of central B cell deletion" -"GO:1901259","chloroplast rRNA processing" -"GO:0033128","negative regulation of histone phosphorylation" -"GO:0060981","cell migration involved in coronary angiogenesis" -"GO:0007293","germarium-derived egg chamber formation" -"GO:0035025","positive regulation of Rho protein signal transduction" -"GO:1900128","regulation of G-protein activated inward rectifier potassium channel activity" -"GO:1901631","positive regulation of presynaptic membrane organization" -"GO:0060675","ureteric bud morphogenesis" -"GO:0001869","negative regulation of complement activation, lectin pathway" -"GO:0010578","regulation of adenylate cyclase activity involved in G-protein coupled receptor signaling pathway" -"GO:0070716","mismatch repair involved in maintenance of fidelity involved in DNA-dependent DNA replication" -"GO:0051877","pigment granule aggregation in cell center" -"GO:0002915","negative regulation of central B cell anergy" -"GO:0061195","taste bud formation" -"GO:0034645","cellular macromolecule biosynthetic process" -"GO:1902205","regulation of interleukin-2-mediated signaling pathway" -"GO:0003277","apoptotic process involved in endocardial cushion morphogenesis" -"GO:0070096","mitochondrial outer membrane translocase complex assembly" -"GO:0007266","Rho protein signal transduction" -"GO:0061090","positive regulation of sequestering of zinc ion" -"GO:0030641","regulation of cellular pH" -"GO:1905268","negative regulation of chromatin organization" -"GO:0048460","flower formation" -"GO:1903180","negative regulation of dopamine biosynthetic process" -"GO:0008628","hormone-mediated apoptotic signaling pathway" -"GO:0061155","pulmonary artery endothelial tube morphogenesis" -"GO:0051458","corticotropin secretion" -"GO:0007370","ventral furrow formation" -"GO:0030509","BMP signaling pathway" -"GO:1900212","negative regulation of mesenchymal cell apoptotic process involved in metanephros development" -"GO:0048323","axial mesodermal cell fate determination" -"GO:0043418","homocysteine catabolic process" -"GO:1990744","primary miRNA methylation" -"GO:1902303","negative regulation of potassium ion export" -"GO:0035690","cellular response to drug" -"GO:0097623","potassium ion export across plasma membrane" -"GO:0038091","positive regulation of cell proliferation by VEGF-activated platelet derived growth factor receptor signaling pathway" -"GO:0033003","regulation of mast cell activation" -"GO:0010146","fructan biosynthetic process" -"GO:0034299","reproductive blastospore formation" -"GO:1903510","mucopolysaccharide metabolic process" -"GO:1900158","negative regulation of bone mineralization involved in bone maturation" -"GO:0033217","regulation of transcription from RNA polymerase II promoter in response to iron ion starvation" -"GO:1901381","positive regulation of potassium ion transmembrane transport" -"GO:0070667","negative regulation of mast cell proliferation" -"GO:1901196","positive regulation of calcium-mediated signaling involved in cellular response to salt stress" -"GO:2001283","Roundabout signaling pathway involved in muscle cell chemotaxis toward tendon cell" -"GO:0033329","kaempferol O-glucoside metabolic process" -"GO:0046203","spermidine catabolic process" -"GO:0140076","negative regulation of lipoprotein transport" -"GO:0001925","negative regulation of B-1 B cell differentiation" -"GO:0045751","negative regulation of Toll signaling pathway" -"GO:0010767","regulation of transcription from RNA polymerase II promoter in response to UV-induced DNA damage" -"GO:1990810","microtubule anchoring at mitotic spindle pole body" -"GO:0035992","tendon formation" -"GO:0086011","membrane repolarization during action potential" -"GO:0071107","response to parathyroid hormone" -"GO:2000402","negative regulation of lymphocyte migration" -"GO:0001126","bacterial-type RNA polymerase preinitiation complex assembly" -"GO:0021584","pons formation" -"GO:0039020","pronephric nephron tubule development" -"GO:0010966","regulation of phosphate transport" -"GO:0007350","blastoderm segmentation" -"GO:0014898","cardiac muscle hypertrophy in response to stress" -"GO:0035006","melanization defense response" -"GO:1901379","regulation of potassium ion transmembrane transport" -"GO:0006527","arginine catabolic process" -"GO:0090090","negative regulation of canonical Wnt signaling pathway" -"GO:2000587","negative regulation of platelet-derived growth factor receptor-beta signaling pathway" -"GO:0048656","anther wall tapetum formation" -"GO:0030823","regulation of cGMP metabolic process" -"GO:0042475","odontogenesis of dentin-containing tooth" -"GO:0035720","intraciliary anterograde transport" -"GO:0022011","myelination in peripheral nervous system" -"GO:0039695","DNA-templated viral transcription" -"GO:0048851","hypophysis formation" -"GO:0061087","positive regulation of histone H3-K27 methylation" -"GO:0072129","renal capsule formation" -"GO:0010863","positive regulation of phospholipase C activity" -"GO:0055093","response to hyperoxia" -"GO:2000890","cellodextrin catabolic process" -"GO:0021576","hindbrain formation" -"GO:0009968","negative regulation of signal transduction" -"GO:1901208","negative regulation of heart looping" -"GO:0035909","aorta morphogenesis" -"GO:0001177","regulation of transcriptional open complex formation at RNA polymerase II promoter" -"GO:0048569","post-embryonic animal organ development" -"GO:0042733","embryonic digit morphogenesis" -"GO:1904991","negative regulation of adenylate cyclase-inhibiting dopamine receptor signaling pathway" -"GO:1902976","premeiotic DNA replication preinitiation complex assembly" -"GO:1904042","negative regulation of cystathionine beta-synthase activity" -"GO:0100010","positive regulation of fever generation by prostaglandin biosynthetic process" -"GO:0097104","postsynaptic membrane assembly" -"GO:0043552","positive regulation of phosphatidylinositol 3-kinase activity" -"GO:0007567","parturition" -"GO:0060363","cranial suture morphogenesis" -"GO:0021501","prechordal plate formation" -"GO:0051124","synaptic growth at neuromuscular junction" -"GO:0006572","tyrosine catabolic process" -"GO:0021547","midbrain-hindbrain boundary initiation" -"GO:0061296","negative regulation of mesenchymal cell apoptotic process involved in mesonephric nephron morphogenesis" -"GO:0006950","response to stress" -"GO:0009271","phage shock" -"GO:1903364","positive regulation of cellular protein catabolic process" -"GO:0006712","mineralocorticoid catabolic process" -"GO:0045587","negative regulation of gamma-delta T cell differentiation" -"GO:0043032","positive regulation of macrophage activation" -"GO:0071803","positive regulation of podosome assembly" -"GO:1902966","positive regulation of protein localization to early endosome" -"GO:0006072","glycerol-3-phosphate metabolic process" -"GO:0030856","regulation of epithelial cell differentiation" -"GO:0045348","positive regulation of MHC class II biosynthetic process" -"GO:2000187","positive regulation of phosphate transmembrane transport" -"GO:1900580","(17Z)-protosta-17(20),24-dien-3beta-ol catabolic process" -"GO:0071939","vitamin A import" -"GO:1903295","negative regulation of glutamate secretion, neurotransmission" -"GO:0008611","ether lipid biosynthetic process" -"GO:1905123","regulation of glucosylceramidase activity" -"GO:0045198","establishment of epithelial cell apical/basal polarity" -"GO:0000961","negative regulation of mitochondrial RNA catabolic process" -"GO:0045648","positive regulation of erythrocyte differentiation" -"GO:0045745","positive regulation of G-protein coupled receptor protein signaling pathway" -"GO:0050718","positive regulation of interleukin-1 beta secretion" -"GO:0010359","regulation of anion channel activity" -"GO:0051461","positive regulation of corticotropin secretion" -"GO:0032819","positive regulation of natural killer cell proliferation" -"GO:0042098","T cell proliferation" -"GO:0075232","positive regulation of spore movement on or near host" -"GO:0001208","histone H2A-H2B dimer displacement" -"GO:0007257","activation of JUN kinase activity" -"GO:0034758","positive regulation of iron ion transport" -"GO:0043029","T cell homeostasis" -"GO:1900495","negative regulation of butyryl-CoA biosynthetic process from acetyl-CoA" -"GO:0010821","regulation of mitochondrion organization" -"GO:0070266","necroptotic process" -"GO:0072678","T cell migration" -"GO:0031663","lipopolysaccharide-mediated signaling pathway" -"GO:0055069","zinc ion homeostasis" -"GO:1902071","regulation of hypoxia-inducible factor-1alpha signaling pathway" -"GO:1901501","response to xylene" -"GO:0010803","regulation of tumor necrosis factor-mediated signaling pathway" -"GO:0045629","negative regulation of T-helper 2 cell differentiation" -"GO:0016130","phytosteroid catabolic process" -"GO:0032757","positive regulation of interleukin-8 production" -"GO:0045190","isotype switching" -"GO:0008211","glucocorticoid metabolic process" -"GO:0060827","regulation of canonical Wnt signaling pathway involved in neural plate anterior/posterior pattern formation" -"GO:0034128","negative regulation of MyD88-independent toll-like receptor signaling pathway" -"GO:0006103","2-oxoglutarate metabolic process" -"GO:0036367","light adaption" -"GO:0033685","negative regulation of luteinizing hormone secretion" -"GO:0071364","cellular response to epidermal growth factor stimulus" -"GO:2001261","negative regulation of semaphorin-plexin signaling pathway" -"GO:0097531","mast cell migration" -"GO:0042810","pheromone metabolic process" -"GO:0060336","negative regulation of interferon-gamma-mediated signaling pathway" -"GO:0045954","positive regulation of natural killer cell mediated cytotoxicity" -"GO:0046359","butyrate catabolic process" -"GO:0032755","positive regulation of interleukin-6 production" -"GO:0046745","viral capsid secondary envelopment" -"GO:0009436","glyoxylate catabolic process" -"GO:0110088","hippocampal neuron apoptotic process" -"GO:1904567","response to wortmannin" -"GO:0140050","negative regulation of endocardial cushion to mesenchymal transition" -"GO:0016127","sterol catabolic process" -"GO:0010268","brassinosteroid homeostasis" -"GO:0042776","mitochondrial ATP synthesis coupled proton transport" -"GO:0070670","response to interleukin-4" -"GO:0046724","oxalic acid secretion" -"GO:0060242","contact inhibition" -"GO:0071306","cellular response to vitamin E" -"GO:0010871","negative regulation of receptor biosynthetic process" -"GO:0042088","T-helper 1 type immune response" -"GO:0002322","B cell proliferation involved in immune response" -"GO:0050729","positive regulation of inflammatory response" -"GO:0099642","retrograde axonal protein transport" -"GO:0060620","regulation of cholesterol import" -"GO:0006713","glucocorticoid catabolic process" -"GO:0032727","positive regulation of interferon-alpha production" -"GO:0072186","metanephric cap morphogenesis" -"GO:0038111","interleukin-7-mediated signaling pathway" -"GO:0071314","cellular response to cocaine" -"GO:0050714","positive regulation of protein secretion" -"GO:0033591","response to L-ascorbic acid" -"GO:0031946","regulation of glucocorticoid biosynthetic process" -"GO:0140052","cellular response to oxidised low-density lipoprotein particle stimulus" -"GO:0019265","glycine biosynthetic process, by transamination of glyoxylate" -"GO:0030913","paranodal junction assembly" -"GO:0042866","pyruvate biosynthetic process" -"GO:0097096","facial suture morphogenesis" -"GO:1905593","positive regulation of optical nerve axon regeneration" -"GO:0071294","cellular response to zinc ion" -"GO:0060694","regulation of cholesterol transporter activity" -"GO:0099608","regulation of action potential firing pattern" -"GO:0035732","nitric oxide storage" -"GO:1901128","gentamycin metabolic process" -"GO:0045018","retrograde transport, vacuole to Golgi" -"GO:0098785","biofilm matrix assembly" -"GO:0035723","interleukin-15-mediated signaling pathway" -"GO:0071908","determination of intestine left/right asymmetry" -"GO:0031280","negative regulation of cyclase activity" -"GO:0061406","positive regulation of transcription from RNA polymerase II promoter in response to glucose starvation" -"GO:0048541","Peyer's patch development" -"GO:0046487","glyoxylate metabolic process" -"GO:0042431","indole metabolic process" -"GO:1905272","negative regulation of proton-transporting ATP synthase activity, rotational mechanism" -"GO:0002224","toll-like receptor signaling pathway" -"GO:0009690","cytokinin metabolic process" -"GO:0040018","positive regulation of multicellular organism growth" -"GO:0061143","alveolar primary septum development" -"GO:0061620","glycolytic process through glucose-6-phosphate" -"GO:0097698","telomere maintenance via base-excision repair" -"GO:0002755","MyD88-dependent toll-like receptor signaling pathway" -"GO:0042853","L-alanine catabolic process" -"GO:1903764","regulation of potassium ion export across plasma membrane" -"GO:0046114","guanosine biosynthetic process" -"GO:0051613","positive regulation of serotonin uptake" -"GO:0034488","basic amino acid transmembrane export from vacuole" -"GO:1905166","negative regulation of lysosomal protein catabolic process" -"GO:0006101","citrate metabolic process" -"GO:0015802","basic amino acid transport" -"GO:0046543","development of secondary female sexual characteristics" -"GO:1990049","retrograde neuronal dense core vesicle transport" -"GO:0022024","BMP signaling pathway involved in forebrain neuron fate commitment" -"GO:0060027","convergent extension involved in gastrulation" -"GO:1903543","positive regulation of exosomal secretion" -"GO:0099611","regulation of action potential firing threshold" -"GO:1903449","androst-4-ene-3,17-dione biosynthetic process" -"GO:0034489","neutral amino acid transmembrane export from vacuole" -"GO:1901003","negative regulation of fermentation" -"GO:2000167","regulation of planar cell polarity pathway involved in neural tube closure" -"GO:0032237","activation of store-operated calcium channel activity" -"GO:1904462","ergosteryl 3-beta-D-glucoside catabolic process" -"GO:0042772","DNA damage response, signal transduction resulting in transcription" -"GO:0072734","cellular response to staurosporine" -"GO:2000353","positive regulation of endothelial cell apoptotic process" -"GO:0002874","regulation of chronic inflammatory response to antigenic stimulus" -"GO:0051201","negative regulation of prosthetic group metabolic process" -"GO:0001771","immunological synapse formation" -"GO:0007060","male meiosis chromosome segregation" -"GO:0045713","low-density lipoprotein particle receptor biosynthetic process" -"GO:0008208","C21-steroid hormone catabolic process" -"GO:0060803","BMP signaling pathway involved in mesodermal cell fate specification" -"GO:0006009","glucose 1-phosphate phosphorylation" -"GO:0071681","cellular response to indole-3-methanol" -"GO:0001779","natural killer cell differentiation" -"GO:1903632","positive regulation of aminoacyl-tRNA ligase activity" -"GO:0045456","ecdysteroid biosynthetic process" -"GO:0048305","immunoglobulin secretion" -"GO:0000727","double-strand break repair via break-induced replication" -"GO:0008361","regulation of cell size" -"GO:0006549","isoleucine metabolic process" -"GO:1905326","positive regulation of meiosis I spindle assembly checkpoint" -"GO:1900009","positive regulation of extrachromosomal rDNA circle accumulation involved in replicative cell aging" -"GO:0002540","leukotriene production involved in inflammatory response" -"GO:0014714","myoblast fate commitment in head" -"GO:0035095","behavioral response to nicotine" -"GO:0044787","bacterial-type DNA replication" -"GO:0046621","negative regulation of organ growth" -"GO:1905851","negative regulation of backward locomotion" -"GO:1900135","positive regulation of renin secretion into blood stream" -"GO:1903279","regulation of calcium:sodium antiporter activity" -"GO:1990108","protein linear deubiquitination" -"GO:0050873","brown fat cell differentiation" -"GO:1905849","negative regulation of forward locomotion" -"GO:2001242","regulation of intrinsic apoptotic signaling pathway" -"GO:0032688","negative regulation of interferon-beta production" -"GO:0015680","intracellular copper ion transport" -"GO:1904989","positive regulation of endothelial cell activation" -"GO:0072141","renal interstitial fibroblast development" -"GO:0038040","cross-receptor activation within G-protein coupled receptor heterodimer" -"GO:0072050","S-shaped body morphogenesis" -"GO:1900052","regulation of retinoic acid biosynthetic process" -"GO:1904562","phosphatidylinositol 5-phosphate metabolic process" -"GO:0070239","regulation of activated T cell autonomous cell death" -"GO:0042264","peptidyl-aspartic acid hydroxylation" -"GO:0051204","protein insertion into mitochondrial membrane" -"GO:1990792","cellular response to glial cell derived neurotrophic factor" -"GO:0051583","dopamine uptake involved in synaptic transmission" -"GO:0070173","regulation of enamel mineralization" -"GO:0070154","mitochondrial lysyl-tRNA aminoacylation" -"GO:1905913","negative regulation of calcium ion export across plasma membrane" -"GO:0060164","regulation of timing of neuron differentiation" -"GO:0070148","mitochondrial glutaminyl-tRNA aminoacylation" -"GO:0001544","initiation of primordial ovarian follicle growth" -"GO:2000541","positive regulation of protein geranylgeranylation" -"GO:0070613","regulation of protein processing" -"GO:0008086","light-activated voltage-gated calcium channel activity" -"GO:1905068","positive regulation of canonical Wnt signaling pathway involved in heart development" -"GO:0030573","bile acid catabolic process" -"GO:0071225","cellular response to muramyl dipeptide" -"GO:0014715","myoblast fate commitment in trunk" -"GO:0003347","epicardial cell to mesenchymal cell transition" -"GO:0007297","ovarian follicle cell migration" -"GO:0036482","neuron intrinsic apoptotic signaling pathway in response to hydrogen peroxide" -"GO:0042313","protein kinase C deactivation" -"GO:0071210","protein insertion into membrane raft" -"GO:0006837","serotonin transport" -"GO:0003334","keratinocyte development" -"GO:1902523","positive regulation of protein K63-linked ubiquitination" -"GO:0086092","regulation of the force of heart contraction by cardiac conduction" -"GO:0006825","copper ion transport" -"GO:1903507","negative regulation of nucleic acid-templated transcription" -"GO:2000227","negative regulation of pancreatic A cell differentiation" -"GO:0031646","positive regulation of neurological system process" -"GO:0050961","detection of temperature stimulus involved in sensory perception" -"GO:0002463","central tolerance induction to nonself antigen" -"GO:0033056","D-ornithine metabolic process" -"GO:0021557","oculomotor nerve development" -"GO:1901076","positive regulation of engulfment of apoptotic cell" -"GO:1900165","negative regulation of interleukin-6 secretion" -"GO:0034243","regulation of transcription elongation from RNA polymerase II promoter" -"GO:0008207","C21-steroid hormone metabolic process" -"GO:0043011","myeloid dendritic cell differentiation" -"GO:0086003","cardiac muscle cell contraction" -"GO:0000270","peptidoglycan metabolic process" -"GO:1990401","embryonic lung development" -"GO:0001813","regulation of antibody-dependent cellular cytotoxicity" -"GO:0070151","mitochondrial histidyl-tRNA aminoacylation" -"GO:0075157","positive regulation of G-protein coupled receptor protein signaling pathway in response to host" -"GO:0036085","GDP-fucose import into Golgi lumen" -"GO:1900832","D-leucine catabolic process" -"GO:0009229","thiamine diphosphate biosynthetic process" -"GO:0046350","galactosaminoglycan metabolic process" -"GO:0052542","defense response by callose deposition" -"GO:0051944","positive regulation of catecholamine uptake involved in synaptic transmission" -"GO:0021867","neuron-producing asymmetric radial glial cell division in forebrain" -"GO:0002449","lymphocyte mediated immunity" -"GO:0030317","flagellated sperm motility" -"GO:2000081","positive regulation of canonical Wnt signaling pathway involved in controlling type B pancreatic cell proliferation" -"GO:0071878","negative regulation of adenylate cyclase-activating adrenergic receptor signaling pathway" -"GO:0014014","negative regulation of gliogenesis" -"GO:0033630","positive regulation of cell adhesion mediated by integrin" -"GO:0051182","coenzyme transport" -"GO:0006144","purine nucleobase metabolic process" -"GO:1902715","positive regulation of interferon-gamma secretion" -"GO:0033159","negative regulation of protein import into nucleus, translocation" -"GO:0045916","negative regulation of complement activation" -"GO:0032978","protein insertion into membrane from inner side" -"GO:1902623","negative regulation of neutrophil migration" -"GO:0043508","negative regulation of JUN kinase activity" -"GO:1902629","regulation of mRNA stability involved in cellular response to UV" -"GO:0051249","regulation of lymphocyte activation" -"GO:0019508","2,5-dihydroxypyridine catabolic process to fumarate" -"GO:0010864","positive regulation of protein histidine kinase activity" -"GO:0060691","epithelial cell maturation involved in salivary gland development" -"GO:0009083","branched-chain amino acid catabolic process" -"GO:0060642","white fat cell differentiation involved in mammary gland fat development" -"GO:0032709","negative regulation of interleukin-25 production" -"GO:0075200","negative regulation of symbiont haustorium neck formation for entry into host" -"GO:0030041","actin filament polymerization" -"GO:0014836","myoblast fate commitment involved in skeletal muscle regeneration" -"GO:0060849","regulation of transcription involved in lymphatic endothelial cell fate commitment" -"GO:2000516","positive regulation of CD4-positive, alpha-beta T cell activation" -"GO:0014064","positive regulation of serotonin secretion" -"GO:0031948","positive regulation of glucocorticoid biosynthetic process" -"GO:1905692","endoplasmic reticulum disassembly" -"GO:0097188","dentin mineralization" -"GO:0099046","clearance of foreign intracellular nucleic acids" -"GO:0070614","tungstate ion transport" -"GO:1905868","regulation of 3'-UTR-mediated mRNA stabilization" -"GO:0032431","activation of phospholipase A2 activity" -"GO:0000483","endonucleolytic cleavage of tetracistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, 2S rRNA, LSU-rRNA)" -"GO:0050774","negative regulation of dendrite morphogenesis" -"GO:0070152","mitochondrial isoleucyl-tRNA aminoacylation" -"GO:0110074","positive regulation of apical constriction involved in ventral furrow formation" -"GO:0044528","regulation of mitochondrial mRNA stability" -"GO:1905515","non-motile cilium assembly" -"GO:0035644","phosphoanandamide dephosphorylation" -"GO:0006001","fructose catabolic process" -"GO:0051208","sequestering of calcium ion" -"GO:0051463","negative regulation of cortisol secretion" -"GO:0075088","positive regulation by host of symbiont G-protein coupled receptor protein signal transduction" -"GO:0007507","heart development" -"GO:1901026","ripoptosome assembly involved in necroptotic process" -"GO:0019445","tyrosine catabolic process to fumarate" -"GO:0002689","negative regulation of leukocyte chemotaxis" -"GO:1903935","response to sodium arsenite" -"GO:0070433","negative regulation of nucleotide-binding oligomerization domain containing 2 signaling pathway" -"GO:0072381","positive regulation of canonical Wnt signaling pathway involved in neural crest cell differentiation" -"GO:0055114","oxidation-reduction process" -"GO:0007368","determination of left/right symmetry" -"GO:0033498","galactose catabolic process via D-galactonate" -"GO:0010940","positive regulation of necrotic cell death" -"GO:0033015","tetrapyrrole catabolic process" -"GO:0031017","exocrine pancreas development" -"GO:1904935","positive regulation of cell proliferation in midbrain" -"GO:0002089","lens morphogenesis in camera-type eye" -"GO:0070928","regulation of mRNA stability, ncRNA-mediated" -"GO:0034630","RITS complex localization" -"GO:0010610","regulation of mRNA stability involved in response to stress" -"GO:0042325","regulation of phosphorylation" -"GO:1903639","regulation of gastrin-induced gastric acid secretion" -"GO:0060538","skeletal muscle organ development" -"GO:1905585","regulation of outer hair cell apoptotic process" -"GO:0042713","sperm ejaculation" -"GO:0030821","negative regulation of cAMP catabolic process" -"GO:1903753","negative regulation of p38MAPK cascade" -"GO:1901980","positive regulation of inward rectifier potassium channel activity" -"GO:0042905","9-cis-retinoic acid metabolic process" -"GO:0110034","negative regulation of adenylate cyclase-activating glucose-activated G-protein coupled receptor signaling pathway" -"GO:0002213","defense response to insect" -"GO:1901472","regulation of Golgi calcium ion export" -"GO:0050680","negative regulation of epithelial cell proliferation" -"GO:0035735","intraciliary transport involved in cilium assembly" -"GO:0044351","macropinocytosis" -"GO:0002455","humoral immune response mediated by circulating immunoglobulin" -"GO:0034145","positive regulation of toll-like receptor 4 signaling pathway" -"GO:0042073","intraciliary transport" -"GO:0070870","heterochromatin maintenance involved in chromatin silencing" -"GO:0039634","killing by virus of host cell during superinfection exclusion" -"GO:0022604","regulation of cell morphogenesis" -"GO:0098737","protein insertion into plasma membrane" -"GO:0075204","negative regulation of symbiont penetration hypha formation for entry into host" -"GO:1903475","mitotic actomyosin contractile ring assembly" -"GO:1904088","positive regulation of epiboly involved in gastrulation with mouth forming second" -"GO:0060345","spleen trabecula formation" -"GO:0003232","bulbus arteriosus development" -"GO:0014875","detection of muscle activity involved in regulation of muscle adaptation" -"GO:0070147","mitochondrial cysteinyl-tRNA aminoacylation" -"GO:1904313","response to methamphetamine hydrochloride" -"GO:0045048","protein insertion into ER membrane" -"GO:0045632","negative regulation of mechanoreceptor differentiation" -"GO:0045933","positive regulation of muscle contraction" -"GO:0060651","regulation of epithelial cell proliferation involved in mammary gland bud elongation" -"GO:0075051","negative regulation of symbiont cell wall strengthening involved in entry into host" -"GO:0050658","RNA transport" -"GO:0075233","negative regulation of spore movement on or near host" -"GO:2000707","positive regulation of dense core granule biogenesis" -"GO:0033387","putrescine biosynthetic process from ornithine" -"GO:0046688","response to copper ion" -"GO:0035794","positive regulation of mitochondrial membrane permeability" -"GO:0006482","protein demethylation" -"GO:0032228","regulation of synaptic transmission, GABAergic" -"GO:0010808","positive regulation of synaptic vesicle priming" -"GO:1905165","regulation of lysosomal protein catabolic process" -"GO:1904167","regulation of thyroid hormone receptor activity" -"GO:0048792","spontaneous exocytosis of neurotransmitter" -"GO:0007194","negative regulation of adenylate cyclase activity" -"GO:0022612","gland morphogenesis" -"GO:0002290","gamma-delta T cell activation involved in immune response" -"GO:0001942","hair follicle development" -"GO:0003308","negative regulation of Wnt signaling pathway involved in heart development" -"GO:0021984","adenohypophysis development" -"GO:0071720","sodium-independent prostaglandin transport" -"GO:2000866","positive regulation of estradiol secretion" -"GO:0006897","endocytosis" -"GO:0001828","inner cell mass cellular morphogenesis" -"GO:0071394","cellular response to testosterone stimulus" -"GO:0098583","learned vocalization behavior" -"GO:1905485","positive regulation of motor neuron migration" -"GO:0045563","negative regulation of TRAIL receptor biosynthetic process" -"GO:2000401","regulation of lymphocyte migration" -"GO:0006710","androgen catabolic process" -"GO:1902996","regulation of neurofibrillary tangle assembly" -"GO:0021769","orbitofrontal cortex development" -"GO:0042722","alpha-beta T cell activation by superantigen" -"GO:0003142","cardiogenic plate morphogenesis" -"GO:0042256","mature ribosome assembly" -"GO:0010138","pyrimidine ribonucleotide salvage" -"GO:1904043","positive regulation of cystathionine beta-synthase activity" -"GO:1900771","fumitremorgin B catabolic process" -"GO:0090429","detection of endogenous biotic stimulus" -"GO:0051309","female meiosis chromosome separation" -"GO:0050709","negative regulation of protein secretion" -"GO:0003271","smoothened signaling pathway involved in regulation of secondary heart field cardioblast proliferation" -"GO:0030421","defecation" -"GO:0060725","regulation of coreceptor activity" -"GO:0006882","cellular zinc ion homeostasis" -"GO:0018021","peptidyl-histidine methylation" -"GO:0048850","hypophysis morphogenesis" -"GO:0030540","female genitalia development" -"GO:0002677","negative regulation of chronic inflammatory response" -"GO:0050771","negative regulation of axonogenesis" -"GO:0003083","negative regulation of renal output by angiotensin" -"GO:1903074","TRAIL death-inducing signaling complex assembly" -"GO:0035821","modification of morphology or physiology of other organism" -"GO:0001976","neurological system process involved in regulation of systemic arterial blood pressure" -"GO:0060913","cardiac cell fate determination" -"GO:0014046","dopamine secretion" -"GO:0043049","otic placode formation" -"GO:1990938","peptidyl-aspartic acid autophosphorylation" -"GO:0021853","cerebral cortex GABAergic interneuron migration" -"GO:0018364","peptidyl-glutamine methylation" -"GO:0006890","retrograde vesicle-mediated transport, Golgi to ER" -"GO:0042694","muscle cell fate specification" -"GO:0007159","leukocyte cell-cell adhesion" -"GO:1900806","ergot alkaloid catabolic process" -"GO:0070075","tear secretion" -"GO:0033615","mitochondrial proton-transporting ATP synthase complex assembly" -"GO:0036149","phosphatidylinositol acyl-chain remodeling" -"GO:1901014","3alpha(S)-strictosidine catabolic process" -"GO:0032926","negative regulation of activin receptor signaling pathway" -"GO:0006402","mRNA catabolic process" -"GO:0070633","transepithelial transport" -"GO:0002017","regulation of blood volume by renal aldosterone" -"GO:0042321","negative regulation of circadian sleep/wake cycle, sleep" -"GO:1901078","negative regulation of relaxation of muscle" -"GO:1904395","positive regulation of skeletal muscle acetylcholine-gated channel clustering" -"GO:1903667","regulation of chemorepellent activity" -"GO:0003348","cardiac endothelial cell differentiation" -"GO:0072527","pyrimidine-containing compound metabolic process" -"GO:0061370","testosterone biosynthetic process" -"GO:0003381","epithelial cell morphogenesis involved in gastrulation" -"GO:0019695","choline metabolic process" -"GO:0015694","mercury ion transport" -"GO:1902531","regulation of intracellular signal transduction" -"GO:0007610","behavior" -"GO:0007625","grooming behavior" -"GO:0060436","bronchiole morphogenesis" -"GO:0061028","establishment of endothelial barrier" -"GO:0007608","sensory perception of smell" -"GO:0050687","negative regulation of defense response to virus" -"GO:0072765","centromere localization" -"GO:0031109","microtubule polymerization or depolymerization" -"GO:0097105","presynaptic membrane assembly" -"GO:0106040","regulation of GABA-A receptor activity" -"GO:0009999","negative regulation of auditory receptor cell fate specification" -"GO:1905747","negative regulation of saliva secretion" -"GO:0060807","regulation of transcription from RNA polymerase II promoter involved in definitive endodermal cell fate specification" -"GO:0098735","positive regulation of the force of heart contraction" -"GO:0034599","cellular response to oxidative stress" -"GO:1905748","hard palate morphogenesis" -"GO:0002631","regulation of granuloma formation" -"GO:0048025","negative regulation of mRNA splicing, via spliceosome" -"GO:0072688","SHREC complex localization" -"GO:0034345","negative regulation of type III interferon production" -"GO:0032463","negative regulation of protein homooligomerization" -"GO:0044106","cellular amine metabolic process" -"GO:0042662","negative regulation of mesodermal cell fate specification" -"GO:0097734","extracellular exosome biogenesis" -"GO:0090339","negative regulation of formin-nucleated actin cable assembly" -"GO:0050808","synapse organization" -"GO:0071959","maintenance of mitotic sister chromatid cohesion, arms" -"GO:0046877","regulation of saliva secretion" -"GO:0030279","negative regulation of ossification" -"GO:0050482","arachidonic acid secretion" -"GO:0090053","positive regulation of chromatin silencing at centromere" -"GO:1903112","positive regulation of single-strand break repair via homologous recombination" -"GO:0051290","protein heterotetramerization" -"GO:0003235","sinus venosus development" -"GO:0072524","pyridine-containing compound metabolic process" -"GO:1901687","glutathione derivative biosynthetic process" -"GO:0036278","positive regulation of transcription from RNA polymerase II promoter in response to nitrogen starvation" -"GO:0071436","sodium ion export" -"GO:0016243","regulation of autophagosome size" -"GO:0044382","CLRC ubiquitin ligase complex localization to heterochromatin" -"GO:1900984","vindoline catabolic process" -"GO:0036037","CD8-positive, alpha-beta T cell activation" -"GO:0072047","proximal/distal pattern formation involved in nephron development" -"GO:0006147","guanine catabolic process" -"GO:0019409","aerobic respiration, using ammonia as electron donor" -"GO:0071626","mastication" -"GO:0008615","pyridoxine biosynthetic process" -"GO:0070146","mitochondrial aspartyl-tRNA aminoacylation" -"GO:0006480","N-terminal protein amino acid methylation" -"GO:2000043","regulation of cardiac cell fate specification" -"GO:0099403","maintenance of mitotic sister chromatid cohesion, telomeric" -"GO:0036001","'de novo' pyridoxal 5'-phosphate biosynthetic process" -"GO:2000643","positive regulation of early endosome to late endosome transport" -"GO:1904184","positive regulation of pyruvate dehydrogenase activity" -"GO:0009820","alkaloid metabolic process" -"GO:1900774","fumiquinazoline catabolic process" -"GO:1904346","positive regulation of gastric mucosal blood circulation" -"GO:0046676","negative regulation of insulin secretion" -"GO:0014723","regulation of skeletal muscle contraction by modulation of calcium ion sensitivity of myofibril" -"GO:0006452","translational frameshifting" -"GO:0070929","trans-translation" -"GO:0001014","snoRNA transcription by RNA polymerase III" -"GO:0007597","blood coagulation, intrinsic pathway" -"GO:1901084","pyrrolizidine alkaloid catabolic process" -"GO:0033602","negative regulation of dopamine secretion" -"GO:0070489","T cell aggregation" -"GO:1901985","positive regulation of protein acetylation" -"GO:0060160","negative regulation of dopamine receptor signaling pathway" -"GO:0002880","regulation of chronic inflammatory response to non-antigenic stimulus" -"GO:0140122","regulation of Lewy body formation" -"GO:0018894","dibenzo-p-dioxin metabolic process" -"GO:0042100","B cell proliferation" -"GO:0022614","membrane to membrane docking" -"GO:1904714","regulation of chaperone-mediated autophagy" -"GO:0051919","positive regulation of fibrinolysis" -"GO:1901086","benzylpenicillin metabolic process" -"GO:0019618","protocatechuate catabolic process, ortho-cleavage" -"GO:0070817","P-TEFb-cap methyltransferase complex localization" -"GO:2000510","positive regulation of dendritic cell chemotaxis" -"GO:0014854","response to inactivity" -"GO:0050776","regulation of immune response" -"GO:0052721","regulation of apurinic/apyrimidinic endodeoxyribonuclease activity" -"GO:1901693","negative regulation of compound eye retinal cell apoptotic process" -"GO:1904538","regulation of glycolytic process through fructose-6-phosphate" -"GO:0021591","ventricular system development" -"GO:0086072","AV node cell-bundle of His cell adhesion involved in cell communication" -"GO:1905037","autophagosome organization" -"GO:0060496","mesenchymal-epithelial cell signaling involved in lung development" -"GO:0046132","pyrimidine ribonucleoside biosynthetic process" -"GO:0061158","3'-UTR-mediated mRNA destabilization" -"GO:0032800","receptor biosynthetic process" -"GO:0070131","positive regulation of mitochondrial translation" -"GO:0051305","chromosome movement towards spindle pole" -"GO:0044270","cellular nitrogen compound catabolic process" -"GO:0015891","siderophore transport" -"GO:0051586","positive regulation of dopamine uptake involved in synaptic transmission" -"GO:0072742","SAGA complex localization to transcription regulatory region" -"GO:0006879","cellular iron ion homeostasis" -"GO:0051823","regulation of synapse structural plasticity" -"GO:0006703","estrogen biosynthetic process" -"GO:0071287","cellular response to manganese ion" -"GO:0009403","toxin biosynthetic process" -"GO:0002769","natural killer cell inhibitory signaling pathway" -"GO:0031144","proteasome localization" -"GO:1904004","positive regulation of sebum secreting cell proliferation" -"GO:0006481","C-terminal protein methylation" -"GO:0036342","post-anal tail morphogenesis" -"GO:0003428","chondrocyte intercalation involved in growth plate cartilage morphogenesis" -"GO:0060078","regulation of postsynaptic membrane potential" -"GO:0060392","negative regulation of SMAD protein signal transduction" -"GO:0060309","elastin catabolic process" -"GO:0045696","positive regulation of embryo sac egg cell differentiation" -"GO:1901842","negative regulation of high voltage-gated calcium channel activity" -"GO:1902010","negative regulation of translation in response to endoplasmic reticulum stress" -"GO:1902957","negative regulation of mitochondrial electron transport, NADH to ubiquinone" -"GO:1903955","positive regulation of protein targeting to mitochondrion" -"GO:1905129","endocannabinoid signaling pathway involved in trans-synaptic signaling" -"GO:0070368","positive regulation of hepatocyte differentiation" -"GO:0021559","trigeminal nerve development" -"GO:0007354","zygotic determination of anterior/posterior axis, embryo" -"GO:0021994","progression of neural tube closure" -"GO:0031554","regulation of DNA-templated transcription, termination" -"GO:1990164","histone H2A phosphorylation" -"GO:0007619","courtship behavior" -"GO:0042797","tRNA transcription by RNA polymerase III" -"GO:0035420","MAPK cascade involved in innate immune response" -"GO:1902366","regulation of Notch signaling pathway involved in somitogenesis" -"GO:0050928","negative regulation of positive chemotaxis" -"GO:0097185","cellular response to azide" -"GO:1902913","positive regulation of neuroepithelial cell differentiation" -"GO:0072146","DCT cell fate commitment" -"GO:1904553","negative regulation of chemotaxis to arachidonic acid" -"GO:0015826","threonine transport" -"GO:0015818","isoleucine transport" -"GO:0002798","negative regulation of antibacterial peptide secretion" -"GO:0045737","positive regulation of cyclin-dependent protein serine/threonine kinase activity" -"GO:0015821","methionine transport" -"GO:0033119","negative regulation of RNA splicing" -"GO:0042676","compound eye cone cell fate commitment" -"GO:0097402","neuroblast migration" -"GO:0071587","CAAX-box protein modification" -"GO:2001282","negative regulation of muscle cell chemotaxis toward tendon cell" -"GO:0061624","fructose catabolic process to hydroxyacetone phosphate and glyceraldehyde-3-phosphate" -"GO:0048384","retinoic acid receptor signaling pathway" -"GO:0015825","L-serine transport" -"GO:0036385","nucleoid DNA packaging" -"GO:0048047","mating behavior, sex discrimination" -"GO:0090671","telomerase RNA localization to Cajal body" -"GO:1905402","regulation of activated CD8-positive, alpha-beta T cell apoptotic process" -"GO:0019882","antigen processing and presentation" -"GO:0050434","positive regulation of viral transcription" -"GO:0046084","adenine biosynthetic process" -"GO:0042769","DNA damage response, detection of DNA damage" -"GO:1903914","negative regulation of fusion of virus membrane with host plasma membrane" -"GO:0070987","error-free translesion synthesis" -"GO:1903695","MAPK cascade involved in ascospore formation" -"GO:0052565","response to defense-related host nitric oxide production" -"GO:0002870","T cell anergy" -"GO:0031287","positive regulation of sorocarp stalk cell differentiation" -"GO:1905211","negative regulation of fibroblast chemotaxis" -"GO:0061058","regulation of peptidoglycan recognition protein signaling pathway" -"GO:0060581","cell fate commitment involved in pattern specification" -"GO:0046085","adenosine metabolic process" -"GO:0007498","mesoderm development" -"GO:0150023","apical dendrite arborization" -"GO:1905051","regulation of base-excision repair" -"GO:0035524","proline transmembrane transport" -"GO:0043521","regulation of myosin II filament disassembly" -"GO:1904369","positive regulation of sclerenchyma cell differentiation" -"GO:2000459","negative regulation of astrocyte chemotaxis" -"GO:0040039","inductive cell migration" -"GO:0001667","ameboidal-type cell migration" -"GO:0044839","cell cycle G2/M phase transition" -"GO:1903441","protein localization to ciliary membrane" -"GO:0071246","cellular response to chlorate" -"GO:2001037","positive regulation of tongue muscle cell differentiation" -"GO:0031920","pyridoxal transport" -"GO:1900035","negative regulation of cellular response to heat" -"GO:0060180","female mating behavior" -"GO:0035977","protein deglycosylation involved in glycoprotein catabolic process" -"GO:0014021","secondary neural tube formation" -"GO:0006176","dATP biosynthetic process from ADP" -"GO:0061073","ciliary body morphogenesis" -"GO:0006868","glutamine transport" -"GO:2000728","regulation of mRNA export from nucleus in response to heat stress" -"GO:1900821","orlandin biosynthetic process" -"GO:0072150","juxtaglomerulus cell fate commitment" -"GO:0032252","secretory granule localization" -"GO:1900007","regulation of extrachromosomal rDNA circle accumulation involved in replicative cell aging" -"GO:0014812","muscle cell migration" -"GO:0030706","germarium-derived oocyte differentiation" -"GO:1900137","negative regulation of chemokine activity" -"GO:0072154","proximal convoluted tubule segment 1 cell fate commitment" -"GO:1900596","(+)-kotanin biosynthetic process" -"GO:0048925","lateral line system development" -"GO:0019448","L-cysteine catabolic process" -"GO:0003096","renal sodium ion transport" -"GO:0106090","positive regulation of cell adhesion involved in sprouting angiogenesis" -"GO:0090074","negative regulation of protein homodimerization activity" -"GO:0045173","O-sialoglycoprotein catabolic process" -"GO:0071799","cellular response to prostaglandin D stimulus" -"GO:0045693","positive regulation of embryo sac central cell differentiation" -"GO:0015808","L-alanine transport" -"GO:0006296","nucleotide-excision repair, DNA incision, 5'-to lesion" -"GO:0060980","cell migration involved in coronary vasculogenesis" -"GO:0043476","pigment accumulation" -"GO:0032782","bile acid secretion" -"GO:0001505","regulation of neurotransmitter levels" -"GO:0006552","leucine catabolic process" -"GO:0090106","pancreatic E cell fate commitment" -"GO:0015823","phenylalanine transport" -"GO:0018883","caprolactam metabolic process" -"GO:2000410","regulation of thymocyte migration" -"GO:0031000","response to caffeine" -"GO:0002768","immune response-regulating cell surface receptor signaling pathway" -"GO:1902194","2-methylbut-2-enoyl-CoA(4-) biosynthetic process" -"GO:0033368","protease localization to mast cell secretory granule" -"GO:0001756","somitogenesis" -"GO:0090120","lysosome to ER cholesterol transport" -"GO:0051612","negative regulation of serotonin uptake" -"GO:0032329","serine transport" -"GO:1900578","gerfelin biosynthetic process" -"GO:0042276","error-prone translesion synthesis" -"GO:0032649","regulation of interferon-gamma production" -"GO:0010377","guard cell fate commitment" -"GO:0019985","translesion synthesis" -"GO:0048883","neuromast primordium migration" -"GO:0097466","ubiquitin-dependent glycoprotein ERAD pathway" -"GO:0019941","modification-dependent protein catabolic process" -"GO:0051758","homologous chromosome movement towards spindle pole involved in homologous chromosome segregation" -"GO:0032416","negative regulation of sodium:proton antiporter activity" -"GO:0015829","valine transport" -"GO:0071507","MAPK cascade involved in conjugation with cellular fusion" -"GO:0030711","positive regulation of border follicle cell delamination" -"GO:0002194","hepatocyte cell migration" -"GO:1902609","(R)-2-hydroxy-alpha-linolenic acid biosynthetic process" -"GO:0000161","MAPK cascade involved in osmosensory signaling pathway" -"GO:0072512","trivalent inorganic cation transport" -"GO:2000047","regulation of cell-cell adhesion mediated by cadherin" -"GO:2000228","positive regulation of pancreatic A cell differentiation" -"GO:0022416","chaeta development" -"GO:1904267","negative regulation of Schwann cell chemotaxis" -"GO:0043587","tongue morphogenesis" -"GO:0000122","negative regulation of transcription by RNA polymerase II" -"GO:1902107","positive regulation of leukocyte differentiation" -"GO:0015824","proline transport" -"GO:0061723","glycophagy" -"GO:0043217","myelin maintenance" -"GO:1903781","positive regulation of cardiac conduction" -"GO:0006688","glycosphingolipid biosynthetic process" -"GO:1904990","regulation of adenylate cyclase-inhibiting dopamine receptor signaling pathway" -"GO:0070308","lens fiber cell fate commitment" -"GO:0022883","zinc efflux transmembrane transporter activity" -"GO:1900264","positive regulation of DNA-directed DNA polymerase activity" -"GO:0015191","L-methionine transmembrane transporter activity" -"GO:0033373","maintenance of protease location in mast cell secretory granule" -"GO:1904746","negative regulation of apoptotic process involved in development" -"GO:0090024","negative regulation of neutrophil chemotaxis" -"GO:0046738","active induction of innate immune response in host by virus" -"GO:1904650","negative regulation of fat cell apoptotic process" -"GO:0002261","mucosal lymphocyte homeostasis" -"GO:0070995","NADPH oxidation" -"GO:0071530","FHA domain-mediated complex assembly" -"GO:0007286","spermatid development" -"GO:0006739","NADP metabolic process" -"GO:0099099","G-protein gated ion channel activity" -"GO:1903040","exon-exon junction complex assembly" -"GO:1905426","positive regulation of Wnt-mediated midbrain dopaminergic neuron differentiation" -"GO:0032461","positive regulation of protein oligomerization" -"GO:0060032","notochord regression" -"GO:1900721","positive regulation of uterine smooth muscle relaxation" -"GO:0032732","positive regulation of interleukin-1 production" -"GO:0071965","multicellular organismal locomotion" -"GO:0032785","negative regulation of DNA-templated transcription, elongation" -"GO:1902605","heterotrimeric G-protein complex assembly" -"GO:0070060","'de novo' actin filament nucleation" -"GO:0010989","negative regulation of low-density lipoprotein particle clearance" -"GO:1900869","tatiopterin metabolic process" -"GO:0052192","movement in environment of other organism involved in symbiotic interaction" -"GO:1904748","regulation of apoptotic process involved in development" -"GO:0015742","alpha-ketoglutarate transport" -"GO:0005997","xylulose metabolic process" -"GO:1904895","ESCRT complex assembly" -"GO:0007220","Notch receptor processing" -"GO:0097536","thymus epithelium morphogenesis" -"GO:0018298","protein-chromophore linkage" -"GO:0038012","negative regulation of Wnt signaling pathway by Wnt receptor internalization" -"GO:0015651","quaternary ammonium group transmembrane transporter activity" -"GO:0005229","intracellular calcium activated chloride channel activity" -"GO:0031669","cellular response to nutrient levels" -"GO:0019236","response to pheromone" -"GO:0042428","serotonin metabolic process" -"GO:0006400","tRNA modification" -"GO:1905075","positive regulation of occluding junction disassembly" -"GO:0031442","positive regulation of mRNA 3'-end processing" -"GO:1990760","osmolarity-sensing cation channel activity" -"GO:0050651","dermatan sulfate proteoglycan biosynthetic process" -"GO:0002385","mucosal immune response" -"GO:0034698","response to gonadotropin" -"GO:0042494","detection of bacterial lipoprotein" -"GO:0030204","chondroitin sulfate metabolic process" -"GO:0097254","renal tubular secretion" -"GO:0016338","calcium-independent cell-cell adhesion via plasma membrane cell-adhesion molecules" -"GO:0008381","mechanosensitive ion channel activity" -"GO:0051086","chaperone mediated protein folding independent of cofactor" -"GO:0023022","termination of T cell signal transduction" -"GO:0042483","negative regulation of odontogenesis" -"GO:0061512","protein localization to cilium" -"GO:0036279","positive regulation of protein export from nucleus in response to glucose starvation" -"GO:1905353","ciliary transition fiber assembly" -"GO:0051494","negative regulation of cytoskeleton organization" -"GO:0070089","chloride-activated potassium channel activity" -"GO:0061114","branching involved in pancreas morphogenesis" -"GO:1901307","positive regulation of spermidine biosynthetic process" -"GO:0010727","negative regulation of hydrogen peroxide metabolic process" -"GO:0033523","histone H2B ubiquitination" -"GO:0006196","AMP catabolic process" -"GO:1904745","Atg1/ULK1 kinase complex assembly" -"GO:0034377","plasma lipoprotein particle assembly" -"GO:1903783","negative regulation of sodium ion import across plasma membrane" -"GO:0050934","late stripe melanocyte differentiation" -"GO:0034197","triglyceride transport" -"GO:0000366","intergenic mRNA trans splicing" -"GO:0044768","NMS complex assembly" -"GO:0045397","negative regulation of interleukin-23 biosynthetic process" -"GO:0006605","protein targeting" -"GO:0010618","aerenchyma formation" -"GO:0043093","FtsZ-dependent cytokinesis" -"GO:1903137","regulation of MAPK cascade involved in cell wall organization or biogenesis" -"GO:0090135","actin filament branching" -"GO:0071730","beak formation" -"GO:0061000","negative regulation of dendritic spine development" -"GO:0072014","proximal tubule development" -"GO:0009852","auxin catabolic process" -"GO:0035807","positive regulation of blood coagulation in other organism" -"GO:0021580","medulla oblongata formation" -"GO:1903619","negative regulation of transdifferentiation" -"GO:0099116","tRNA 5'-end processing" -"GO:0048437","floral organ development" -"GO:2000304","positive regulation of ceramide biosynthetic process" -"GO:1903205","regulation of hydrogen peroxide-induced cell death" -"GO:0036492","eiF2alpha phosphorylation in response to endoplasmic reticulum stress" -"GO:0071288","cellular response to mercury ion" -"GO:0022016","pallium glioblast division" -"GO:0060343","trabecula formation" -"GO:1902280","regulation of ATP-dependent RNA helicase activity" -"GO:1905164","positive regulation of phagosome maturation" -"GO:0033552","response to vitamin B3" -"GO:2000265","positive regulation of blood coagulation, extrinsic pathway" -"GO:0007540","sex determination, establishment of X:A ratio" -"GO:0006684","sphingomyelin metabolic process" -"GO:0009259","ribonucleotide metabolic process" -"GO:0010868","negative regulation of triglyceride biosynthetic process" -"GO:1990785","response to water-immersion restraint stress" -"GO:1990181","acetyl-CoA biosynthetic process from pantothenate" -"GO:0030185","nitric oxide transport" -"GO:0006787","porphyrin-containing compound catabolic process" -"GO:1903046","meiotic cell cycle process" -"GO:1902749","regulation of cell cycle G2/M phase transition" -"GO:0071673","positive regulation of smooth muscle cell chemotaxis" -"GO:0048444","floral organ morphogenesis" -"GO:0016133","brassinosteroid catabolic process" -"GO:0045057","cisternal progression" -"GO:1905139","apical ectodermal ridge formation" -"GO:1904539","negative regulation of glycolytic process through fructose-6-phosphate" -"GO:1904080","positive regulation of transcription from RNA polymerase II promoter involved in neuron fate specification" -"GO:0035378","carbon dioxide transmembrane transport" -"GO:0006849","plasma membrane pyruvate transport" -"GO:0060661","submandibular salivary gland formation" -"GO:0042472","inner ear morphogenesis" -"GO:0045633","positive regulation of mechanoreceptor differentiation" -"GO:1903610","regulation of calcium-dependent ATPase activity" -"GO:1905695","positive regulation of phosphatidic acid biosynthetic process" -"GO:0045647","negative regulation of erythrocyte differentiation" -"GO:1904677","positive regulation of somatic stem cell division" -"GO:0072073","kidney epithelium development" -"GO:1904122","positive regulation of fatty acid beta-oxidation by octopamine signaling pathway" -"GO:0035474","selective angioblast sprouting" -"GO:1990390","protein K33-linked ubiquitination" -"GO:2000482","regulation of interleukin-8 secretion" -"GO:0007097","nuclear migration" -"GO:0032085","regulation of Type II site-specific deoxyribonuclease activity" -"GO:0045634","regulation of melanocyte differentiation" -"GO:0045532","negative regulation of interleukin-24 biosynthetic process" -"GO:0045450","bicoid mRNA localization" -"GO:0110027","negative regulation of DNA strand resection involved in replication fork processing" -"GO:0032792","negative regulation of CREB transcription factor activity" -"GO:0051726","regulation of cell cycle" -"GO:1901564","organonitrogen compound metabolic process" -"GO:1990774","tumor necrosis factor secretion" -"GO:0032084","regulation of Type I site-specific deoxyribonuclease activity" -"GO:0030149","sphingolipid catabolic process" -"GO:0021556","central nervous system formation" -"GO:0000770","peptide pheromone export" -"GO:1905271","regulation of proton-transporting ATP synthase activity, rotational mechanism" -"GO:0051229","meiotic spindle disassembly" -"GO:0043145","snoRNA 3'-end cleavage" -"GO:0071241","cellular response to inorganic substance" -"GO:0080128","anther septum development" -"GO:0072564","blood microparticle formation" -"GO:0021715","inferior olivary nucleus formation" -"GO:1903311","regulation of mRNA metabolic process" -"GO:0007303","cytoplasmic transport, nurse cell to oocyte" -"GO:1902977","mitotic DNA replication preinitiation complex assembly" -"GO:0005984","disaccharide metabolic process" -"GO:0015696","ammonium transport" -"GO:1904554","positive regulation of chemotaxis to arachidonic acid" -"GO:0042367","biotin catabolic process" -"GO:0061948","premature acrosome loss" -"GO:0061111","epithelial-mesenchymal cell signaling involved in lung development" -"GO:0033077","T cell differentiation in thymus" -"GO:0015670","carbon dioxide transport" -"GO:0070909","glutamate:gamma-aminobutyric acid antiporter activity" -"GO:0038189","neuropilin signaling pathway" -"GO:0007120","axial cellular bud site selection" -"GO:1900019","regulation of protein kinase C activity" -"GO:0044828","negative regulation by host of viral genome replication" -"GO:0032086","regulation of Type III site-specific deoxyribonuclease activity" -"GO:0072123","intraglomerular mesangial cell proliferation" -"GO:0006397","mRNA processing" -"GO:0052095","formation of specialized structure for nutrient acquisition from other organism involved in symbiotic interaction" -"GO:2001200","positive regulation of dendritic cell differentiation" -"GO:0048538","thymus development" -"GO:0007121","bipolar cellular bud site selection" -"GO:0070050","neuron cellular homeostasis" -"GO:0007285","primary spermatocyte growth" -"GO:0046827","positive regulation of protein export from nucleus" -"GO:0021958","gracilis tract morphogenesis" -"GO:0019087","transformation of host cell by virus" -"GO:0048481","plant ovule development" -"GO:0032057","negative regulation of translational initiation in response to stress" -"GO:0000055","ribosomal large subunit export from nucleus" -"GO:0009823","cytokinin catabolic process" -"GO:1904035","regulation of epithelial cell apoptotic process" -"GO:0042908","xenobiotic transport" -"GO:0030261","chromosome condensation" -"GO:0021963","spinothalamic tract morphogenesis" -"GO:0030157","pancreatic juice secretion" -"GO:0100053","positive regulation of sulfate assimilation by transcription from RNA polymerase II promoter" -"GO:0097167","circadian regulation of translation" -"GO:1902654","aromatic primary alcohol metabolic process" -"GO:0032635","interleukin-6 production" -"GO:0051988","regulation of attachment of spindle microtubules to kinetochore" -"GO:0070429","negative regulation of nucleotide-binding oligomerization domain containing 1 signaling pathway" -"GO:0061355","Wnt protein secretion" -"GO:0031951","positive regulation of glucocorticoid catabolic process" -"GO:0010838","positive regulation of keratinocyte proliferation" -"GO:0061043","regulation of vascular wound healing" -"GO:0032880","regulation of protein localization" -"GO:0021773","striatal medium spiny neuron differentiation" -"GO:0032342","aldosterone biosynthetic process" -"GO:0061424","positive regulation of peroxisome organization by positive regulation of transcription from RNA polymerase II promoter" -"GO:0035957","positive regulation of starch catabolic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:0106030","neuron projection fasciculation" -"GO:0050872","white fat cell differentiation" -"GO:0007340","acrosome reaction" -"GO:0006631","fatty acid metabolic process" -"GO:0100004","positive regulation of peroxisome organization by transcription from RNA polymerase II promoter" -"GO:0048149","behavioral response to ethanol" -"GO:0051490","negative regulation of filopodium assembly" -"GO:0070262","peptidyl-serine dephosphorylation" -"GO:0034771","histone H4-K20 monomethylation" -"GO:0018149","peptide cross-linking" -"GO:0070240","negative regulation of activated T cell autonomous cell death" -"GO:0034651","cortisol biosynthetic process" -"GO:0051946","regulation of glutamate uptake involved in transmission of nerve impulse" -"GO:0045787","positive regulation of cell cycle" -"GO:0051715","cytolysis in other organism" -"GO:0034148","negative regulation of toll-like receptor 5 signaling pathway" -"GO:0072573","tolerance induction to lipopolysaccharide" -"GO:0016057","regulation of membrane potential in photoreceptor cell" -"GO:0061107","seminal vesicle development" -"GO:0098662","inorganic cation transmembrane transport" -"GO:0051041","positive regulation of calcium-independent cell-cell adhesion" -"GO:0009416","response to light stimulus" -"GO:0060125","negative regulation of growth hormone secretion" -"GO:0030153","bacteriocin immunity" -"GO:0006464","cellular protein modification process" -"GO:0062002","regulation of all-trans-retinyl-ester hydrolase, 11-cis retinol forming activity" -"GO:0032208","negative regulation of telomere maintenance via recombination" -"GO:0042754","negative regulation of circadian rhythm" -"GO:0019088","immortalization of host cell by virus" -"GO:1900404","positive regulation of DNA repair by positive regulation of transcription from RNA polymerase II promoter" -"GO:0019388","galactose catabolic process" -"GO:0070932","histone H3 deacetylation" -"GO:0016185","synaptic vesicle budding from presynaptic endocytic zone membrane" -"GO:0035871","protein K11-linked deubiquitination" -"GO:0034139","regulation of toll-like receptor 3 signaling pathway" -"GO:0009299","mRNA transcription" -"GO:0050767","regulation of neurogenesis" -"GO:0046647","negative regulation of gamma-delta T cell proliferation" -"GO:0016056","rhodopsin mediated signaling pathway" -"GO:0045824","negative regulation of innate immune response" -"GO:0055014","atrial cardiac muscle cell development" -"GO:0098731","skeletal muscle satellite stem cell maintenance involved in skeletal muscle regeneration" -"GO:1904510","positive regulation of protein localization to basolateral plasma membrane" -"GO:0042941","D-alanine transport" -"GO:0050830","defense response to Gram-positive bacterium" -"GO:1902630","regulation of membrane hyperpolarization" -"GO:0031077","post-embryonic camera-type eye development" -"GO:1990504","dense core granule exocytosis" -"GO:1902510","regulation of apoptotic DNA fragmentation" -"GO:1905282","regulation of epidermal growth factor receptor signaling pathway involved in heart process" -"GO:1902924","poly(hydroxyalkanoate) biosynthetic process from glucose" -"GO:0060478","acrosomal vesicle exocytosis" -"GO:0072666","establishment of protein localization to vacuole" -"GO:0033129","positive regulation of histone phosphorylation" -"GO:0002316","follicular B cell differentiation" -"GO:0015887","pantothenate transmembrane transport" -"GO:0070345","negative regulation of fat cell proliferation" -"GO:1903126","negative regulation of centriole-centriole cohesion" -"GO:0019402","galactitol metabolic process" -"GO:0071678","olfactory bulb axon guidance" -"GO:0042752","regulation of circadian rhythm" -"GO:0052787","alpha-linked polysaccharide catabolism to maltopentaose" -"GO:0061623","glycolytic process from galactose" -"GO:0061224","mesonephric glomerulus development" -"GO:2000349","negative regulation of CD40 signaling pathway" -"GO:0002578","negative regulation of antigen processing and presentation" -"GO:0007623","circadian rhythm" -"GO:0031214","biomineral tissue development" -"GO:0031640","killing of cells of other organism" -"GO:0060124","positive regulation of growth hormone secretion" -"GO:0045116","protein neddylation" -"GO:0060012","synaptic transmission, glycinergic" -"GO:0036507","protein demannosylation" -"GO:0043603","cellular amide metabolic process" -"GO:0060429","epithelium development" -"GO:0007506","gonadal mesoderm development" -"GO:0046602","regulation of mitotic centrosome separation" -"GO:0046959","habituation" -"GO:0048252","lauric acid metabolic process" -"GO:0018266","GPI anchor biosynthetic process via N-aspartyl-glycosylphosphatidylinositolethanolamine" -"GO:0000070","mitotic sister chromatid segregation" -"GO:0016038","absorption of visible light" -"GO:0010522","regulation of calcium ion transport into cytosol" -"GO:0031323","regulation of cellular metabolic process" -"GO:0090714","innate immunity memory response" -"GO:0002502","peptide antigen assembly with MHC class I protein complex" -"GO:0051209","release of sequestered calcium ion into cytosol" -"GO:0100043","negative regulation of cellular response to alkaline pH by transcription from RNA polymerase II promoter" -"GO:0048755","branching morphogenesis of a nerve" -"GO:1900413","positive regulation of phospholipid biosynthetic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:1901341","positive regulation of store-operated calcium channel activity" -"GO:0042795","snRNA transcription by RNA polymerase II" -"GO:0019229","regulation of vasoconstriction" -"GO:0071947","protein deubiquitination involved in ubiquitin-dependent protein catabolic process" -"GO:0036095","positive regulation of invasive growth in response to glucose limitation by positive regulation of transcription from RNA polymerase II promoter" -"GO:2000678","negative regulation of transcription regulatory region DNA binding" -"GO:0090663","galanin-activated signaling pathway" -"GO:0071880","adenylate cyclase-activating adrenergic receptor signaling pathway" -"GO:0021545","cranial nerve development" -"GO:0016339","calcium-dependent cell-cell adhesion via plasma membrane cell adhesion molecules" -"GO:0031142","induction of conjugation upon nitrogen starvation" -"GO:0009258","10-formyltetrahydrofolate catabolic process" -"GO:0035865","cellular response to potassium ion" -"GO:1903900","regulation of viral life cycle" -"GO:1904081","positive regulation of transcription from RNA polymerase II promoter involved in neuron differentiation" -"GO:0034776","response to histamine" -"GO:0061538","histamine secretion, neurotransmission" -"GO:0034114","regulation of heterotypic cell-cell adhesion" -"GO:2000347","positive regulation of hepatocyte proliferation" -"GO:1903215","negative regulation of protein targeting to mitochondrion" -"GO:0039722","suppression by virus of host toll-like receptor signaling pathway" -"GO:0010880","regulation of release of sequestered calcium ion into cytosol by sarcoplasmic reticulum" -"GO:1903757","positive regulation of transcription from RNA polymerase II promoter by histone modification" -"GO:0032922","circadian regulation of gene expression" -"GO:0006012","galactose metabolic process" -"GO:0034136","negative regulation of toll-like receptor 2 signaling pathway" -"GO:0043153","entrainment of circadian clock by photoperiod" -"GO:0021939","extracellular matrix-granule cell signaling involved in regulation of granule cell precursor proliferation" -"GO:0048659","smooth muscle cell proliferation" -"GO:0006123","mitochondrial electron transport, cytochrome c to oxygen" -"GO:0070966","nuclear-transcribed mRNA catabolic process, no-go decay" -"GO:0009395","phospholipid catabolic process" -"GO:0003178","coronary sinus valve development" -"GO:2001270","regulation of cysteine-type endopeptidase activity involved in execution phase of apoptosis" -"GO:0035627","ceramide transport" -"GO:0018870","anaerobic 2-aminobenzoate metabolic process" -"GO:1904045","cellular response to aldosterone" -"GO:0014059","regulation of dopamine secretion" -"GO:0018418","nickel incorporation into iron-sulfur cluster via tris-L-cysteinyl L-cysteine persulfido L-glutamato L-histidino L-serinyl nickel triiron disulfide trioxide" -"GO:0097723","amoeboid sperm motility" -"GO:0002356","peripheral B cell negative selection" -"GO:0010026","trichome differentiation" -"GO:0002820","negative regulation of adaptive immune response" -"GO:0140041","cellular detoxification of methylglyoxal" -"GO:1904419","negative regulation of telomeric loop formation" -"GO:0002441","histamine secretion involved in inflammatory response" -"GO:0001824","blastocyst development" -"GO:0010528","regulation of transposition" -"GO:0050858","negative regulation of antigen receptor-mediated signaling pathway" -"GO:0035684","helper T cell extravasation" -"GO:0045627","positive regulation of T-helper 1 cell differentiation" -"GO:0051299","centrosome separation" -"GO:1990927","calcium ion regulated lysosome exocytosis" -"GO:0048597","post-embryonic camera-type eye morphogenesis" -"GO:1905396","cellular response to flavonoid" -"GO:0019627","urea metabolic process" -"GO:0010044","response to aluminum ion" -"GO:0019730","antimicrobial humoral response" -"GO:0070424","regulation of nucleotide-binding oligomerization domain containing signaling pathway" -"GO:0010033","response to organic substance" -"GO:0006606","protein import into nucleus" -"GO:2001016","positive regulation of skeletal muscle cell differentiation" -"GO:1903060","negative regulation of protein lipidation" -"GO:0010837","regulation of keratinocyte proliferation" -"GO:0046520","sphingoid biosynthetic process" -"GO:0019249","lactate biosynthetic process" -"GO:1904598","positive regulation of connective tissue replacement involved in inflammatory response wound healing" -"GO:0061162","establishment of monopolar cell polarity" -"GO:0048205","COPI coating of Golgi vesicle" -"GO:0100046","positive regulation of arginine biosynthetic process by transcription from RNA polymerase II promoter" -"GO:0070899","mitochondrial tRNA wobble uridine modification" -"GO:2000575","negative regulation of microtubule motor activity" -"GO:0070297","regulation of phosphorelay signal transduction system" -"GO:0048741","skeletal muscle fiber development" -"GO:0090385","phagosome-lysosome fusion" -"GO:0075174","regulation of cAMP-mediated signaling in response to host" -"GO:0072511","divalent inorganic cation transport" -"GO:0070100","negative regulation of chemokine-mediated signaling pathway" -"GO:0098649","response to peptidyl-dipeptidase A inhibitor" -"GO:0046152","ommochrome metabolic process" -"GO:0022001","negative regulation of anterior neural cell fate commitment of the neural plate" -"GO:0035874","cellular response to copper ion starvation" -"GO:0019250","aerobic cobalamin biosynthetic process" -"GO:0007008","outer mitochondrial membrane organization" -"GO:0071251","cellular response to silicon dioxide" -"GO:0075205","modulation by host of symbiont cAMP-mediated signal transduction" -"GO:0015194","L-serine transmembrane transporter activity" -"GO:0035938","estradiol secretion" -"GO:0010660","regulation of muscle cell apoptotic process" -"GO:0021518","spinal cord commissural neuron specification" -"GO:0018965","s-triazine compound metabolic process" -"GO:1902830","negative regulation of spinal cord association neuron differentiation" -"GO:1900816","ochratoxin A metabolic process" -"GO:1905934","negative regulation of cell fate determination" -"GO:0060251","regulation of glial cell proliferation" -"GO:0045620","negative regulation of lymphocyte differentiation" -"GO:0072592","oxygen metabolic process" -"GO:0036399","TCR signalosome assembly" -"GO:0031044","O-glycan processing, core 8" -"GO:0047497","mitochondrion transport along microtubule" -"GO:0043373","CD4-positive, alpha-beta T cell lineage commitment" -"GO:0048873","homeostasis of number of cells within a tissue" -"GO:0015880","coenzyme A transport" -"GO:0098884","postsynaptic neurotransmitter receptor internalization" -"GO:0006110","regulation of glycolytic process" -"GO:0043328","protein transport to vacuole involved in ubiquitin-dependent protein catabolic process via the multivesicular body sorting pathway" -"GO:0072274","metanephric glomerular basement membrane development" -"GO:0033013","tetrapyrrole metabolic process" -"GO:0002676","regulation of chronic inflammatory response" -"GO:2000788","negative regulation of venous endothelial cell fate commitment" -"GO:0098713","leucine import across plasma membrane" -"GO:0014863","detection of inactivity" -"GO:0033859","furaldehyde metabolic process" -"GO:2001224","positive regulation of neuron migration" -"GO:0034401","chromatin organization involved in regulation of transcription" -"GO:0010823","negative regulation of mitochondrion organization" -"GO:0019549","glutamate catabolic process to succinate via succinate semialdehyde" -"GO:1902870","negative regulation of amacrine cell differentiation" -"GO:0098670","entry receptor-mediated virion attachment to host cell" -"GO:0014805","smooth muscle adaptation" -"GO:1901334","lactone metabolic process" -"GO:0035714","cellular response to nitrogen dioxide" -"GO:0044083","modulation by symbiont of host Rho protein signal transduction" -"GO:0019570","L-arabinose catabolic process to 2-oxoglutarate" -"GO:1903970","negative regulation of response to macrophage colony-stimulating factor" -"GO:0009996","negative regulation of cell fate specification" -"GO:0031152","aggregation involved in sorocarp development" -"GO:1904659","glucose transmembrane transport" -"GO:0071252","cellular response to sulfur dioxide" -"GO:0097212","lysosomal membrane organization" -"GO:0010438","cellular response to sulfur starvation" -"GO:2000248","negative regulation of establishment or maintenance of neuroblast polarity" -"GO:0007392","initiation of dorsal closure" -"GO:0030887","positive regulation of myeloid dendritic cell activation" -"GO:0000747","conjugation with cellular fusion" -"GO:0036223","cellular response to adenine starvation" -"GO:0019660","glycolytic fermentation" -"GO:2000183","negative regulation of progesterone biosynthetic process" -"GO:0060162","negative regulation of phospholipase C-activating dopamine receptor signaling pathway" -"GO:0016129","phytosteroid biosynthetic process" -"GO:2001053","regulation of mesenchymal cell apoptotic process" -"GO:0097091","synaptic vesicle clustering" -"GO:0006183","GTP biosynthetic process" -"GO:0032916","positive regulation of transforming growth factor beta3 production" -"GO:0019288","isopentenyl diphosphate biosynthetic process, methylerythritol 4-phosphate pathway" -"GO:0046518","octamethylcyclotetrasiloxane metabolic process" -"GO:1990263","MAPK cascade in response to starvation" -"GO:0032120","ascospore-type prospore membrane assembly" -"GO:0032769","negative regulation of monooxygenase activity" -"GO:0060726","regulation of coreceptor activity involved in epidermal growth factor receptor signaling pathway" -"GO:0045343","regulation of MHC class I biosynthetic process" -"GO:1900788","pseurotin A metabolic process" -"GO:0050924","positive regulation of negative chemotaxis" -"GO:0070837","dehydroascorbic acid transport" -"GO:0044845","chain elongation of O-linked mannose residue" -"GO:0048677","axon extension involved in regeneration" -"GO:0071525","pyrrolysine metabolic process" -"GO:0051044","positive regulation of membrane protein ectodomain proteolysis" -"GO:1902243","copal-8-ol diphosphate(3-) biosynthetic process" -"GO:0071249","cellular response to nitrate" -"GO:0034371","chylomicron remodeling" -"GO:0015734","taurine transport" -"GO:1904016","response to Thyroglobulin triiodothyronine" -"GO:0097035","regulation of membrane lipid distribution" -"GO:0019954","asexual reproduction" -"GO:0033318","pantothenate biosynthetic process from 2-dehydropantolactone" -"GO:0036110","cellular response to inositol starvation" -"GO:0045410","positive regulation of interleukin-6 biosynthetic process" -"GO:0070233","negative regulation of T cell apoptotic process" -"GO:0072750","cellular response to leptomycin B" -"GO:0120007","negative regulation of glutamatergic neuron differentiation" -"GO:1901296","negative regulation of canonical Wnt signaling pathway involved in cardiac muscle cell fate commitment" -"GO:1905080","negative regulation of cerebellar neuron development" -"GO:0032383","regulation of intracellular cholesterol transport" -"GO:0035505","positive regulation of myosin light chain kinase activity" -"GO:1902225","negative regulation of acrosome reaction" -"GO:0071262","regulation of translational initiation in response to starvation" -"GO:0046448","tropane alkaloid metabolic process" -"GO:0034107","negative regulation of erythrocyte clearance" -"GO:1905606","regulation of presynapse assembly" -"GO:0051618","positive regulation of histamine uptake" -"GO:1901949","5alpha,9alpha,10beta-labda-8(20),13-dien-15-yl diphosphate biosynthetic process" -"GO:0060425","lung morphogenesis" -"GO:1904859","positive regulation of endothelial cell chemotaxis to vascular endothelial growth factor" -"GO:0035436","triose phosphate transmembrane transport" -"GO:0055091","phospholipid homeostasis" -"GO:1990786","cellular response to dsDNA" -"GO:0050992","dimethylallyl diphosphate biosynthetic process" -"GO:0070487","monocyte aggregation" -"GO:1903575","cornified envelope assembly" -"GO:0042046","W-molybdopterin cofactor metabolic process" -"GO:1902414","protein localization to cell junction" -"GO:1904052","negative regulation of protein targeting to vacuole involved in autophagy" -"GO:0061718","glucose catabolic process to pyruvate" -"GO:0033069","ansamycin metabolic process" -"GO:0050995","negative regulation of lipid catabolic process" -"GO:0034350","regulation of glial cell apoptotic process" -"GO:1900033","negative regulation of trichome patterning" -"GO:0075208","modulation by symbiont of host cAMP-mediated signal transduction" -"GO:0006826","iron ion transport" -"GO:1903041","regulation of chondrocyte hypertrophy" -"GO:0018363","peroxidase-heme linkage via dihydroxyheme-L-aspartyl ester-L-glutamyl ester-L-methionine sulfonium" -"GO:0098671","adhesion receptor-mediated virion attachment to host cell" -"GO:0033521","phytyl diphosphate biosynthetic process" -"GO:0033049","clavulanic acid metabolic process" -"GO:0000478","endonucleolytic cleavage involved in rRNA processing" -"GO:0039524","suppression by virus of host mRNA processing" -"GO:0031328","positive regulation of cellular biosynthetic process" -"GO:0036242","glutamate catabolic process to succinate via 2-oxoglutarate-dependent GABA-transaminase activity" -"GO:1905224","clathrin-coated pit assembly" -"GO:1900629","methanophenazine metabolic process" -"GO:0061105","regulation of stomach neuroendocrine cell differentiation" -"GO:0014018","neuroblast fate specification" -"GO:0019536","vibriobactin metabolic process" -"GO:2001308","gliotoxin metabolic process" -"GO:1904849","positive regulation of cell chemotaxis to fibroblast growth factor" -"GO:1902084","fumagillin metabolic process" -"GO:0061404","positive regulation of transcription from RNA polymerase II promoter in response to increased salt" -"GO:1905912","regulation of calcium ion export across plasma membrane" -"GO:0060430","lung saccule development" -"GO:0034106","regulation of erythrocyte clearance" -"GO:0034428","nuclear-transcribed mRNA catabolic process, exonucleolytic, 5'-3'" -"GO:2000721","positive regulation of transcription from RNA polymerase II promoter involved in smooth muscle cell differentiation" -"GO:0007632","visual behavior" -"GO:1904444","regulation of establishment of Sertoli cell barrier" -"GO:0044761","negative regulation by symbiont of host cholinergic synaptic transmission" -"GO:0009970","cellular response to sulfate starvation" -"GO:0000715","nucleotide-excision repair, DNA damage recognition" -"GO:0097289","alpha-ribazole metabolic process" -"GO:0061754","negative regulation of circulating fibrinogen levels" -"GO:0009646","response to absence of light" -"GO:0040012","regulation of locomotion" -"GO:0019450","L-cysteine catabolic process to pyruvate" -"GO:0061678","Entner-Doudoroff pathway" -"GO:1900117","regulation of execution phase of apoptosis" -"GO:1901246","regulation of lung ciliated cell differentiation" -"GO:0010350","cellular response to magnesium starvation" -"GO:0010944","negative regulation of transcription by competitive promoter binding" -"GO:1904528","positive regulation of microtubule binding" -"GO:1902709","cellular response to plumbagin" -"GO:0072413","signal transduction involved in mitotic cell cycle checkpoint" -"GO:0061716","miRNA export from nucleus" -"GO:0070164","negative regulation of adiponectin secretion" -"GO:0001979","regulation of systemic arterial blood pressure by chemoreceptor signaling" -"GO:0005989","lactose biosynthetic process" -"GO:0010827","regulation of glucose transmembrane transport" -"GO:0070294","renal sodium ion absorption" -"GO:0033363","secretory granule organization" -"GO:0036228","protein localization to nuclear inner membrane" -"GO:0019852","L-ascorbic acid metabolic process" -"GO:1904281","positive regulation of transcription by RNA polymerase V" -"GO:0043617","cellular response to sucrose starvation" -"GO:0044028","DNA hypomethylation" -"GO:0071247","cellular response to chromate" -"GO:0018416","nickel incorporation into iron-sulfur cluster via tris-L-cysteinyl L-cysteine persulfido bis-L-glutamato L-histidino nickel triiron disulfide trioxide" -"GO:1900594","(+)-kotanin metabolic process" -"GO:1901831","all-trans-neoxanthin metabolic process" -"GO:0014737","positive regulation of muscle atrophy" -"GO:0010575","positive regulation of vascular endothelial growth factor production" -"GO:0006500","N-terminal protein palmitoylation" -"GO:0015723","bilirubin transport" -"GO:0009404","toxin metabolic process" -"GO:0010728","regulation of hydrogen peroxide biosynthetic process" -"GO:1903626","positive regulation of DNA catabolic process" -"GO:0061249","mesonephric glomerular capillary formation" -"GO:0044622","negative regulation of cell migration in other organism" -"GO:0030824","negative regulation of cGMP metabolic process" -"GO:1903061","positive regulation of protein lipidation" -"GO:0042860","achromobactin metabolic process" -"GO:0061059","positive regulation of peptidoglycan recognition protein signaling pathway" -"GO:0002632","negative regulation of granuloma formation" -"GO:1903066","regulation of protein localization to cell tip" -"GO:1903031","regulation of microtubule plus-end binding" -"GO:0034067","protein localization to Golgi apparatus" -"GO:1990359","stress response to zinc ion" -"GO:1902363","regulation of protein localization to spindle pole body" -"GO:0008631","intrinsic apoptotic signaling pathway in response to oxidative stress" -"GO:0044827","modulation by host of viral genome replication" -"GO:0021971","corticospinal neuron axon guidance through the medullary pyramid" -"GO:0033542","fatty acid beta-oxidation, unsaturated, even number" -"GO:0097492","sympathetic neuron axon guidance" -"GO:0009994","oocyte differentiation" -"GO:0021970","corticospinal neuron axon guidance through the basilar pons" -"GO:0010794","regulation of dolichol biosynthetic process" -"GO:0043243","positive regulation of protein complex disassembly" -"GO:1990922","hepatic stellate cell proliferation" -"GO:2000395","regulation of ubiquitin-dependent endocytosis" -"GO:0061011","hepatic duct development" -"GO:0021827","postnatal olfactory bulb interneuron migration" -"GO:0046709","IDP catabolic process" -"GO:0070202","regulation of establishment of protein localization to chromosome" -"GO:0034671","retinoic acid receptor signaling pathway involved in pronephros anterior/posterior pattern specification" -"GO:0019234","sensory perception of fast pain" -"GO:1903769","negative regulation of cell proliferation in bone marrow" -"GO:0036473","cell death in response to oxidative stress" -"GO:0033370","maintenance of protein location in mast cell secretory granule" -"GO:1903972","regulation of cellular response to macrophage colony-stimulating factor stimulus" -"GO:1904146","positive regulation of meiotic cell cycle process involved in oocyte maturation" -"GO:0007127","meiosis I" -"GO:1990396","single-strand break repair via homologous recombination" -"GO:1903355","negative regulation of distal tip cell migration" -"GO:0048885","neuromast deposition" -"GO:0046466","membrane lipid catabolic process" -"GO:2000230","negative regulation of pancreatic stellate cell proliferation" -"GO:1902814","positive regulation of BMP signaling pathway involved in determination of lateral mesoderm left/right asymmetry" -"GO:0043542","endothelial cell migration" -"GO:0071582","negative regulation of zinc ion transport" -"GO:0003071","renal system process involved in regulation of systemic arterial blood pressure" -"GO:0042664","negative regulation of endodermal cell fate specification" -"GO:1990731","UV-damage excision repair, DNA incision" -"GO:1901639","XDP catabolic process" -"GO:1903562","microtubule bundle formation involved in mitotic spindle midzone assembly" -"GO:0021722","superior olivary nucleus maturation" -"GO:2000785","regulation of autophagosome assembly" -"GO:1904457","positive regulation of neuronal action potential" -"GO:1905550","regulation of protein localization to endoplasmic reticulum" -"GO:0071624","positive regulation of granulocyte chemotaxis" -"GO:0042067","establishment of ommatidial planar polarity" -"GO:0010154","fruit development" -"GO:1905475","regulation of protein localization to membrane" -"GO:2000472","negative regulation of hematopoietic stem cell migration" -"GO:0006614","SRP-dependent cotranslational protein targeting to membrane" -"GO:1904234","positive regulation of aconitate hydratase activity" -"GO:1904191","positive regulation of cyclin-dependent protein serine/threonine kinase activity involved in meiotic nuclear division" -"GO:0070649","formin-nucleated actin cable assembly" -"GO:0021816","extension of a leading process involved in cell motility in cerebral cortex radial glia guided migration" -"GO:0019083","viral transcription" -"GO:2000156","regulation of retrograde vesicle-mediated transport, Golgi to ER" -"GO:0002282","microglial cell activation involved in immune response" -"GO:0060720","spongiotrophoblast cell proliferation" -"GO:0060139","positive regulation of apoptotic process by virus" -"GO:0140131","positive regulation of lymphocyte chemotaxis" -"GO:0015971","guanosine tetraphosphate catabolic process" -"GO:0051254","positive regulation of RNA metabolic process" -"GO:0008585","female gonad development" -"GO:0033561","regulation of water loss via skin" -"GO:0061866","negative regulation of histone H3-S10 phosphorylation" -"GO:0019889","pteridine metabolic process" -"GO:0070078","histone H3-R2 demethylation" -"GO:0009867","jasmonic acid mediated signaling pathway" -"GO:0090625","mRNA cleavage involved in gene silencing by siRNA" -"GO:1902428","negative regulation of water channel activity" -"GO:0043104","positive regulation of GTP cyclohydrolase I activity" -"GO:0018893","dibenzofuran metabolic process" -"GO:0042794","plastid rRNA transcription" -"GO:0002295","T-helper cell lineage commitment" -"GO:0021968","corticospinal neuron axon guidance through the internal capsule" -"GO:0032608","interferon-beta production" -"GO:0051838","cytolysis by host of symbiont cells" -"GO:0009250","glucan biosynthetic process" -"GO:0072718","response to cisplatin" -"GO:0000019","regulation of mitotic recombination" -"GO:0009736","cytokinin-activated signaling pathway" -"GO:0061014","positive regulation of mRNA catabolic process" -"GO:0032413","negative regulation of ion transmembrane transporter activity" -"GO:0042852","L-alanine biosynthetic process" -"GO:0042574","retinal metabolic process" -"GO:0050724","negative regulation of interleukin-1 beta biosynthetic process" -"GO:1900494","regulation of butyryl-CoA biosynthetic process from acetyl-CoA" -"GO:0060750","epithelial cell proliferation involved in mammary gland duct elongation" -"GO:0033541","fatty acid beta-oxidation, unsaturated, odd number" -"GO:0009954","proximal/distal pattern formation" -"GO:0006891","intra-Golgi vesicle-mediated transport" -"GO:1903644","regulation of chaperone-mediated protein folding" -"GO:0006833","water transport" -"GO:1903286","regulation of potassium ion import" -"GO:0008493","tetracycline transmembrane transporter activity" -"GO:1903799","negative regulation of production of miRNAs involved in gene silencing by miRNA" -"GO:0002220","innate immune response activating cell surface receptor signaling pathway" -"GO:0060178","regulation of exocyst localization" -"GO:0034438","lipoprotein amino acid oxidation" -"GO:0051081","nuclear envelope disassembly" -"GO:0097214","positive regulation of lysosomal membrane permeability" -"GO:0060745","mammary gland branching involved in pregnancy" -"GO:0034168","negative regulation of toll-like receptor 10 signaling pathway" -"GO:0000707","meiotic DNA recombinase assembly" -"GO:1905321","negative regulation of mesenchymal stem cell migration" -"GO:0072595","maintenance of protein localization in organelle" -"GO:0030518","intracellular steroid hormone receptor signaling pathway" -"GO:0000349","generation of catalytic spliceosome for first transesterification step" -"GO:0046646","regulation of gamma-delta T cell proliferation" -"GO:2000266","regulation of blood coagulation, intrinsic pathway" -"GO:1990371","process resulting in tolerance to phenol" -"GO:0002456","T cell mediated immunity" -"GO:1903927","response to cyanide" -"GO:0090094","metanephric cap mesenchymal cell proliferation involved in metanephros development" -"GO:0046512","sphingosine biosynthetic process" -"GO:0061304","retinal blood vessel morphogenesis" -"GO:0071652","regulation of chemokine (C-C motif) ligand 1 production" -"GO:0001547","antral ovarian follicle growth" -"GO:0045742","positive regulation of epidermal growth factor receptor signaling pathway" -"GO:0021967","corticospinal neuron axon guidance through the cerebral cortex" -"GO:1905043","positive regulation of epithelium regeneration" -"GO:0035262","gonad morphogenesis" -"GO:0030150","protein import into mitochondrial matrix" -"GO:0010722","regulation of ferrochelatase activity" -"GO:0002022","detection of dietary excess" -"GO:0045899","positive regulation of RNA polymerase II transcriptional preinitiation complex assembly" -"GO:0001822","kidney development" -"GO:0097066","response to thyroid hormone" -"GO:1904337","positive regulation of ductus arteriosus closure" -"GO:0034121","regulation of toll-like receptor signaling pathway" -"GO:0001503","ossification" -"GO:0023021","termination of signal transduction" -"GO:0006071","glycerol metabolic process" -"GO:0032479","regulation of type I interferon production" -"GO:1903052","positive regulation of proteolysis involved in cellular protein catabolic process" -"GO:0032268","regulation of cellular protein metabolic process" -"GO:0032780","negative regulation of ATPase activity" -"GO:0006725","cellular aromatic compound metabolic process" -"GO:0009734","auxin-activated signaling pathway" -"GO:0043941","positive regulation of sexual sporulation resulting in formation of a cellular spore" -"GO:1903843","cellular response to arsenite ion" -"GO:1902831","positive regulation of spinal cord association neuron differentiation" -"GO:2000872","positive regulation of progesterone secretion" -"GO:1903216","regulation of protein processing involved in protein targeting to mitochondrion" -"GO:0032722","positive regulation of chemokine production" -"GO:1903238","positive regulation of leukocyte tethering or rolling" -"GO:0061619","glycolytic process from mannose through fructose-6-phosphate" -"GO:0045623","negative regulation of T-helper cell differentiation" -"GO:0048246","macrophage chemotaxis" -"GO:0086042","cardiac muscle cell-cardiac muscle cell adhesion" -"GO:0006198","cAMP catabolic process" -"GO:0055060","asymmetric neuroblast division resulting in ganglion mother cell formation" -"GO:0070947","neutrophil mediated killing of fungus" -"GO:0050854","regulation of antigen receptor-mediated signaling pathway" -"GO:0048178","negative regulation of hepatocyte growth factor biosynthetic process" -"GO:0000281","mitotic cytokinesis" -"GO:0044763","single-organism cellular process" -"GO:0000389","mRNA 3'-splice site recognition" -"GO:0016101","diterpenoid metabolic process" -"GO:0071140","resolution of mitotic recombination intermediates" -"GO:0033605","positive regulation of catecholamine secretion" -"GO:0061029","eyelid development in camera-type eye" -"GO:0042036","negative regulation of cytokine biosynthetic process" -"GO:0032196","transposition" -"GO:0089718","amino acid import across plasma membrane" -"GO:0048245","eosinophil chemotaxis" -"GO:0043629","ncRNA polyadenylation" -"GO:0035948","positive regulation of gluconeogenesis by positive regulation of transcription from RNA polymerase II promoter" -"GO:0045359","positive regulation of interferon-beta biosynthetic process" -"GO:0045418","negative regulation of interleukin-9 biosynthetic process" -"GO:0030073","insulin secretion" -"GO:0060560","developmental growth involved in morphogenesis" -"GO:0032974","amino acid transmembrane export from vacuole" -"GO:0055025","positive regulation of cardiac muscle tissue development" -"GO:0032497","detection of lipopolysaccharide" -"GO:0007215","glutamate receptor signaling pathway" -"GO:0030029","actin filament-based process" -"GO:0045535","negative regulation of interleukin-27 biosynthetic process" -"GO:0019222","regulation of metabolic process" -"GO:0090485","chromosome number maintenance" -"GO:0051446","positive regulation of meiotic cell cycle" -"GO:1903899","positive regulation of PERK-mediated unfolded protein response" -"GO:0014730","skeletal muscle regeneration at neuromuscular junction" -"GO:1905649","negative regulation of shell calcification" -"GO:0050922","negative regulation of chemotaxis" -"GO:0120008","positive regulation of glutamatergic neuron differentiation" -"GO:0022406","membrane docking" -"GO:0009142","nucleoside triphosphate biosynthetic process" -"GO:1905590","fibronectin fibril organization" -"GO:1901077","regulation of relaxation of muscle" -"GO:0090219","negative regulation of lipid kinase activity" -"GO:2000671","regulation of motor neuron apoptotic process" -"GO:0042699","follicle-stimulating hormone signaling pathway" -"GO:0048145","regulation of fibroblast proliferation" -"GO:1905480","positive regulation of glutamate-ammonia ligase activity" -"GO:0019279","L-methionine biosynthetic process from L-homoserine via cystathionine" -"GO:0007631","feeding behavior" -"GO:0090618","DNA clamp unloading" -"GO:2000325","regulation of ligand-dependent nuclear receptor transcription coactivator activity" -"GO:0001775","cell activation" -"GO:0043152","induction of bacterial agglutination" -"GO:0090271","positive regulation of fibroblast growth factor production" -"GO:0034487","vacuolar amino acid transmembrane transport" -"GO:0042851","L-alanine metabolic process" -"GO:0036005","response to macrophage colony-stimulating factor" -"GO:0100008","regulation of fever generation by prostaglandin biosynthetic process" -"GO:0060536","cartilage morphogenesis" -"GO:0034093","positive regulation of maintenance of sister chromatid cohesion" -"GO:0022402","cell cycle process" -"GO:0070862","negative regulation of protein exit from endoplasmic reticulum" -"GO:0009386","translational attenuation" -"GO:2000252","negative regulation of feeding behavior" -"GO:0007272","ensheathment of neurons" -"GO:0032728","positive regulation of interferon-beta production" -"GO:0043149","stress fiber assembly" -"GO:0032973","amino acid export across plasma membrane" -"GO:1903012","positive regulation of bone development" -"GO:0006104","succinyl-CoA metabolic process" -"GO:0042559","pteridine-containing compound biosynthetic process" -"GO:0090095","regulation of metanephric cap mesenchymal cell proliferation" -"GO:2000610","negative regulation of thyroid hormone generation" -"GO:0044073","modulation by symbiont of host translation" -"GO:0070098","chemokine-mediated signaling pathway" -"GO:0035549","positive regulation of interferon-beta secretion" -"GO:0010048","vernalization response" -"GO:1900400","regulation of iron ion import by regulation of transcription from RNA polymerase II promoter" -"GO:1904669","ATP export" -"GO:1990748","cellular detoxification" -"GO:0097390","chemokine (C-X-C motif) ligand 12 production" -"GO:0048639","positive regulation of developmental growth" -"GO:0070478","nuclear-transcribed mRNA catabolic process, 3'-5' exonucleolytic nonsense-mediated decay" -"GO:0002914","regulation of central B cell anergy" -"GO:0046011","regulation of oskar mRNA translation" -"GO:1902764","positive regulation of embryonic skeletal joint development" -"GO:1902686","mitochondrial outer membrane permeabilization involved in programmed cell death" -"GO:1902838","regulation of nuclear migration along microtubule" -"GO:0019220","regulation of phosphate metabolic process" -"GO:0002273","plasmacytoid dendritic cell differentiation" -"GO:1902544","regulation of DNA N-glycosylase activity" -"GO:1904296","negative regulation of osmolarity-sensing cation channel activity" -"GO:0021850","subpallium glioblast cell division" -"GO:2001050","negative regulation of tendon cell differentiation" -"GO:1990297","renal amino acid absorption" -"GO:0006987","activation of signaling protein activity involved in unfolded protein response" -"GO:0010267","production of ta-siRNAs involved in RNA interference" -"GO:0061919","process utilizing autophagic mechanism" -"GO:1902871","positive regulation of amacrine cell differentiation" -"GO:0006105","succinate metabolic process" -"GO:0045775","positive regulation of beta 2 integrin biosynthetic process" -"GO:0006555","methionine metabolic process" -"GO:0060094","positive regulation of synaptic transmission, glycinergic" -"GO:0036008","sucrose catabolic process to fructose-6-phosphate and glucose-6-phosphate" -"GO:0010818","T cell chemotaxis" -"GO:0061254","mesonephric glomerular parietal epithelial cell development" -"GO:0060216","definitive hemopoiesis" -"GO:0034337","RNA folding" -"GO:0099566","regulation of postsynaptic cytosolic calcium ion concentration" -"GO:1903497","cellular response to 11-deoxycorticosterone" -"GO:0033006","regulation of mast cell activation involved in immune response" -"GO:2000185","regulation of phosphate transmembrane transport" -"GO:0006701","progesterone biosynthetic process" -"GO:0019934","cGMP-mediated signaling" -"GO:0045415","negative regulation of interleukin-8 biosynthetic process" -"GO:0050908","detection of light stimulus involved in visual perception" -"GO:0048247","lymphocyte chemotaxis" -"GO:0046500","S-adenosylmethionine metabolic process" -"GO:0097251","leukotriene B4 biosynthetic process" -"GO:0010563","negative regulation of phosphorus metabolic process" -"GO:0098900","regulation of action potential" -"GO:0019414","aerobic respiration, using sulfur or sulfate as electron donor" -"GO:0001878","response to yeast" -"GO:0032975","amino acid transmembrane import into vacuole" -"GO:0010905","negative regulation of UDP-glucose catabolic process" -"GO:0016037","light absorption" -"GO:0043484","regulation of RNA splicing" -"GO:0100022","regulation of iron ion import by transcription from RNA polymerase II promoter" -"GO:0002175","protein localization to paranode region of axon" -"GO:1902804","negative regulation of synaptic vesicle transport" -"GO:1902255","positive regulation of intrinsic apoptotic signaling pathway by p53 class mediator" -"GO:0006276","plasmid maintenance" -"GO:1901608","regulation of vesicle transport along microtubule" -"GO:1903936","cellular response to sodium arsenite" -"GO:0140029","exocytic process" -"GO:0035437","maintenance of protein localization in endoplasmic reticulum" -"GO:1902296","DNA strand elongation involved in cell cycle DNA replication" -"GO:0006111","regulation of gluconeogenesis" -"GO:0021822","negative regulation of cell motility involved in cerebral cortex radial glia guided migration" -"GO:1903608","protein localization to cytoplasmic stress granule" -"GO:0060011","Sertoli cell proliferation" -"GO:0040020","regulation of meiotic nuclear division" -"GO:2000407","regulation of T cell extravasation" -"GO:0060316","positive regulation of ryanodine-sensitive calcium-release channel activity" -"GO:0048024","regulation of mRNA splicing, via spliceosome" -"GO:1904268","positive regulation of Schwann cell chemotaxis" -"GO:0002812","biosynthetic process of antibacterial peptides active against Gram-negative bacteria" -"GO:1903581","regulation of basophil degranulation" -"GO:0090267","positive regulation of mitotic cell cycle spindle assembly checkpoint" -"GO:0045534","negative regulation of interleukin-26 biosynthetic process" -"GO:1905238","cellular response to cyclosporin A" -"GO:1900087","positive regulation of G1/S transition of mitotic cell cycle" -"GO:0010776","meiotic mismatch repair involved in meiotic gene conversion" -"GO:0072199","regulation of mesenchymal cell proliferation involved in ureter development" -"GO:0007292","female gamete generation" -"GO:0019379","sulfate assimilation, phosphoadenylyl sulfate reduction by phosphoadenylyl-sulfate reductase (thioredoxin)" -"GO:0051422","negative regulation of endo-1,4-beta-xylanase activity" -"GO:0070945","neutrophil mediated killing of gram-negative bacterium" -"GO:0070170","regulation of tooth mineralization" -"GO:0019836","hemolysis by symbiont of host erythrocytes" -"GO:1900427","regulation of cellular response to oxidative stress by regulation of transcription from RNA polymerase II promoter" -"GO:0072358","cardiovascular system development" -"GO:2000765","regulation of cytoplasmic translation" -"GO:0032259","methylation" -"GO:0110083","positive regulation of protein localization to cell division site involved in mitotic actomyosin contractile ring assembly" -"GO:0046365","monosaccharide catabolic process" -"GO:0018420","peptide cross-linking via N6-(L-isoaspartyl)-L-lysine" -"GO:1901190","regulation of formation of translation initiation ternary complex" -"GO:0006047","UDP-N-acetylglucosamine metabolic process" -"GO:2000245","negative regulation of FtsZ-dependent cytokinesis" -"GO:0003199","endocardial cushion to mesenchymal transition involved in heart valve formation" -"GO:0001410","chlamydospore formation" -"GO:0032627","interleukin-23 production" -"GO:0032388","positive regulation of intracellular transport" -"GO:0072142","juxtaglomerulus cell development" -"GO:0031549","negative regulation of brain-derived neurotrophic factor receptor signaling pathway" -"GO:0046825","regulation of protein export from nucleus" -"GO:0046804","peptide cross-linking via (2S,3S,4Xi,6R)-3-methyl-lanthionine sulfoxide" -"GO:0032309","icosanoid secretion" -"GO:0072143","mesangial cell development" -"GO:2000411","negative regulation of thymocyte migration" -"GO:1905902","regulation of mesoderm formation" -"GO:0035660","MyD88-dependent toll-like receptor 4 signaling pathway" -"GO:0051357","peptide cross-linking via 3-(2-methylthio)ethyl-6-(4-hydroxybenzylidene)-5-iminopiperazin-2-one" -"GO:0022401","negative adaptation of signaling pathway" -"GO:0072530","purine-containing compound transmembrane transport" -"GO:0019927","peptide cross-linking via 4'-(S-L-cysteinyl)-L-tryptophyl quinone" -"GO:0090073","positive regulation of protein homodimerization activity" -"GO:0035661","MyD88-dependent toll-like receptor 2 signaling pathway" -"GO:0100054","positive regulation of flocculation via cell wall protein-carbohydrate interaction by transcription from RNA polymerase II promoter" -"GO:1903224","regulation of endodermal cell differentiation" -"GO:2000432","negative regulation of cytokinesis, actomyosin contractile ring assembly" -"GO:0030437","ascospore formation" -"GO:0036531","glutathione deglycation" -"GO:1904709","negative regulation of granulosa cell apoptotic process" -"GO:0044747","mature miRNA 3'-end processing" -"GO:0018124","peptide cross-linking via 5'-(N6-L-lysine)-L-topaquinone" -"GO:0007438","oenocyte development" -"GO:0071846","actin filament debranching" -"GO:2000894","cellotriose catabolic process" -"GO:0046925","peptide cross-linking via 2-(S-L-cysteinyl)-D-phenylalanine" -"GO:0038089","positive regulation of cell migration by vascular endothelial growth factor signaling pathway" -"GO:0018274","peptide cross-linking via L-lysinoalanine" -"GO:0050739","peptide cross-linking via S-[5'-(L-tryptoph-6'-yl)-L-tyrosin-3'-yl]-L-methionin-S-ium" -"GO:0001817","regulation of cytokine production" -"GO:1904634","negative regulation of glomerular visceral epithelial cell apoptotic process" -"GO:0050667","homocysteine metabolic process" -"GO:0099518","vesicle cytoskeletal trafficking" -"GO:1905662","negative regulation of telomerase RNA reverse transcriptase activity" -"GO:0090508","phenylethylamine biosynthetic process involved in synaptic transmission" -"GO:1904407","positive regulation of nitric oxide metabolic process" -"GO:1904461","ergosteryl 3-beta-D-glucoside metabolic process" -"GO:0048135","female germ-line cyst formation" -"GO:0044575","cellulosome assembly" -"GO:0042491","inner ear auditory receptor cell differentiation" -"GO:0019749","cytoskeleton-dependent cytoplasmic transport, nurse cell to oocyte" -"GO:0002000","detection of renal blood flow" -"GO:0003392","cell adhesion involved in retrograde extension" -"GO:1903949","positive regulation of atrial cardiac muscle cell action potential" -"GO:0016584","nucleosome positioning" -"GO:0044387","negative regulation of protein kinase activity by regulation of protein phosphorylation" -"GO:0007168","receptor guanylyl cyclase signaling pathway" -"GO:0048869","cellular developmental process" -"GO:0075210","negative regulation by symbiont of host cAMP-mediated signal transduction" -"GO:0097399","interleukin-32-mediated signaling pathway" -"GO:1900022","regulation of D-erythro-sphingosine kinase activity" -"GO:0061528","aspartate secretion" -"GO:2000542","negative regulation of gastrulation" -"GO:0050679","positive regulation of epithelial cell proliferation" -"GO:0030959","peptide cross-linking via 3'-(3'-L-tyrosinyl)-L-tyrosine" -"GO:0098751","bone cell development" -"GO:0090638","phosphatidylcholine biosynthesis from phosphatidylethanolamine" -"GO:0046984","regulation of hemoglobin biosynthetic process" -"GO:0007516","hemocyte development" -"GO:1904445","negative regulation of establishment of Sertoli cell barrier" -"GO:1901250","negative regulation of lung goblet cell differentiation" -"GO:0002370","natural killer cell cytokine production" -"GO:0099515","actin filament-based transport" -"GO:0002429","immune response-activating cell surface receptor signaling pathway" -"GO:0022400","regulation of rhodopsin mediated signaling pathway" -"GO:0046926","peptide cross-linking via 2-(S-L-cysteinyl)-D-allo-threonine" -"GO:0097394","telomeric repeat-containing RNA transcription by RNA polymerase II" -"GO:0070192","chromosome organization involved in meiotic cell cycle" -"GO:0030725","germline ring canal formation" -"GO:0090364","regulation of proteasome assembly" -"GO:0055006","cardiac cell development" -"GO:0031553","positive regulation of brain-derived neurotrophic factor-activated receptor activity" -"GO:0042432","indole biosynthetic process" -"GO:0007256","activation of JNKK activity" -"GO:1901649","negative regulation of actomyosin contractile ring localization" -"GO:0110073","regulation of apical constriction involved in ventral furrow formation" -"GO:1903697","negative regulation of microvillus assembly" -"GO:0080147","root hair cell development" -"GO:1901892","negative regulation of cell septum assembly" -"GO:0060519","cell adhesion involved in prostatic bud elongation" -"GO:1904103","regulation of convergent extension involved in gastrulation" -"GO:0090167","Golgi distribution to daughter cells" -"GO:0046068","cGMP metabolic process" -"GO:1902413","negative regulation of mitotic cytokinesis" -"GO:1903750","regulation of intrinsic apoptotic signaling pathway in response to hydrogen peroxide" -"GO:0034429","tectobulbar tract morphogenesis" -"GO:0034773","histone H4-K20 trimethylation" -"GO:0044063","modulation by symbiont of host neurological system process" -"GO:1905087","positive regulation of bioluminescence" -"GO:0060719","chorionic trophoblast cell development" -"GO:0032063","negative regulation of translational initiation in response to osmotic stress" -"GO:0046629","gamma-delta T cell activation" -"GO:1904086","regulation of epiboly involved in gastrulation with mouth forming second" -"GO:1904711","regulation of Wnt-Frizzled-LRP5/6 complex assembly" -"GO:2001161","negative regulation of histone H3-K79 methylation" -"GO:0018234","peptide cross-linking via 3'-(S-L-cysteinyl)-L-tyrosine" -"GO:0001306","age-dependent response to oxidative stress" -"GO:0060920","cardiac pacemaker cell differentiation" -"GO:0002444","myeloid leukocyte mediated immunity" -"GO:1903944","negative regulation of hepatocyte apoptotic process" -"GO:0090640","phosphatidylcholine biosynthesis from sn-glycero-3-phosphocholine" -"GO:0072393","microtubule anchoring at microtubule organizing center" -"GO:0035126","post-embryonic genitalia morphogenesis" -"GO:2000341","regulation of chemokine (C-X-C motif) ligand 2 production" -"GO:0070727","cellular macromolecule localization" -"GO:1905586","negative regulation of outer hair cell apoptotic process" -"GO:0060131","corticotropin hormone secreting cell development" -"GO:1903277","negative regulation of sodium ion export across plasma membrane" -"GO:0035260","internal genitalia morphogenesis" -"GO:2000075","negative regulation of cytokinesis, site selection" -"GO:1904068","G-protein coupled receptor signaling pathway involved in social behavior" -"GO:0097680","double-strand break repair via classical nonhomologous end joining" -"GO:0048627","myoblast development" -"GO:0043123","positive regulation of I-kappaB kinase/NF-kappaB signaling" -"GO:1904155","DN2 thymocyte differentiation" -"GO:0048806","genitalia development" -"GO:0042942","D-serine transport" -"GO:0036075","replacement ossification" -"GO:0098532","histone H3-K27 trimethylation" -"GO:0071222","cellular response to lipopolysaccharide" -"GO:0055002","striated muscle cell development" -"GO:2000440","regulation of toll-like receptor 15 signaling pathway" -"GO:0070751","negative regulation of interleukin-35 biosynthetic process" -"GO:0061514","interleukin-34-mediated signaling pathway" -"GO:0070171","negative regulation of tooth mineralization" -"GO:0060101","negative regulation of phagocytosis, engulfment" -"GO:0000415","negative regulation of histone H3-K36 methylation" -"GO:1902197","isovaleryl-CoA(4-) biosynthetic process" -"GO:0120078","cell adhesion involved in sprouting angiogenesis" -"GO:0046723","malic acid secretion" -"GO:0052320","positive regulation of phytoalexin metabolic process" -"GO:0072261","metanephric extraglomerular mesangial cell proliferation involved in metanephros development" -"GO:0018151","peptide cross-linking via L-histidyl-L-tyrosine" -"GO:0070587","regulation of cell-cell adhesion involved in gastrulation" -"GO:0002143","tRNA wobble position uridine thiolation" -"GO:1902842","negative regulation of netrin-activated signaling pathway" -"GO:0042433","indole catabolic process" -"GO:0060035","notochord cell development" -"GO:0014814","axon regeneration at neuromuscular junction" -"GO:0010441","guard cell development" -"GO:0018253","peptide cross-linking via 5-imidazolinone glycine" -"GO:0003195","tricuspid valve formation" -"GO:0018233","peptide cross-linking via 2'-(S-L-cysteinyl)-L-histidine" -"GO:0000435","positive regulation of transcription from RNA polymerase II promoter by galactose" -"GO:1904411","positive regulation of secretory granule organization" -"GO:0002036","regulation of L-glutamate import across plasma membrane" -"GO:0002803","positive regulation of antibacterial peptide production" -"GO:0038173","interleukin-17A-mediated signaling pathway" -"GO:1904242","regulation of pancreatic trypsinogen secretion" -"GO:0120045","stereocilium maintenance" -"GO:2000275","regulation of oxidative phosphorylation uncoupler activity" -"GO:0090013","regulation of transforming growth factor beta receptor signaling pathway involved in primitive streak formation" -"GO:1900342","regulation of methane biosynthetic process from dimethyl sulfide" -"GO:0007557","regulation of juvenile hormone biosynthetic process" -"GO:0009938","negative regulation of gibberellic acid mediated signaling pathway" -"GO:1903034","regulation of response to wounding" -"GO:1903088","5-amino-1-ribofuranosylimidazole-4-carboxamide transmembrane transport" -"GO:1901093","regulation of protein homotetramerization" -"GO:0003333","amino acid transmembrane transport" -"GO:1904136","regulation of convergent extension involved in notochord morphogenesis" -"GO:0010669","epithelial structure maintenance" -"GO:0060888","limb epidermis stratification" -"GO:1903400","L-arginine transmembrane transport" -"GO:0050765","negative regulation of phagocytosis" -"GO:1990539","fructose import across plasma membrane" -"GO:0010886","positive regulation of cholesterol storage" -"GO:0042682","regulation of compound eye cone cell fate specification" -"GO:0031568","G1 cell size control checkpoint" -"GO:0097326","melanocyte adhesion" -"GO:0003283","atrial septum development" -"GO:0034115","negative regulation of heterotypic cell-cell adhesion" -"GO:2000546","positive regulation of endothelial cell chemotaxis to fibroblast growth factor" -"GO:0050959","echolocation" -"GO:1903208","negative regulation of hydrogen peroxide-induced neuron death" -"GO:0003159","morphogenesis of an endothelium" -"GO:0009081","branched-chain amino acid metabolic process" -"GO:1904706","negative regulation of vascular smooth muscle cell proliferation" -"GO:1904200","iodide transmembrane transport" -"GO:1903438","positive regulation of mitotic cytokinetic process" -"GO:2000348","regulation of CD40 signaling pathway" -"GO:0090501","RNA phosphodiester bond hydrolysis" -"GO:2000726","negative regulation of cardiac muscle cell differentiation" -"GO:0034633","retinol transport" -"GO:0090064","activation of microtubule nucleation" -"GO:2000006","regulation of metanephric comma-shaped body morphogenesis" -"GO:1903222","quinolinic acid transmembrane transport" -"GO:0060563","neuroepithelial cell differentiation" -"GO:0002551","mast cell chemotaxis" -"GO:0042695","thelarche" -"GO:0060307","regulation of ventricular cardiac muscle cell membrane repolarization" -"GO:1902739","regulation of interferon-alpha secretion" -"GO:0003377","regulation of apoptosis by sphingosine-1-phosphate signaling pathway" -"GO:0048170","positive regulation of long-term neuronal synaptic plasticity" -"GO:0098534","centriole assembly" -"GO:0019255","glucose 1-phosphate metabolic process" -"GO:0070662","mast cell proliferation" -"GO:0015816","glycine transport" -"GO:0044251","protein catabolic process by pepsin" -"GO:0034172","negative regulation of toll-like receptor 11 signaling pathway" -"GO:0006000","fructose metabolic process" -"GO:1903710","spermine transmembrane transport" -"GO:0030521","androgen receptor signaling pathway" -"GO:2000986","negative regulation of behavioral fear response" -"GO:0080064","4,4-dimethyl-9beta,19-cyclopropylsterol oxidation" -"GO:0045088","regulation of innate immune response" -"GO:0002312","B cell activation involved in immune response" -"GO:0060092","regulation of synaptic transmission, glycinergic" -"GO:1901695","tyramine biosynthetic process" -"GO:1905544","L-methionine import across plasma membrane" -"GO:0048334","regulation of mesodermal cell fate determination" -"GO:2000093","regulation of mesonephric nephron tubule epithelial cell differentiation" -"GO:0051475","glucosylglycerol transport" -"GO:0010640","regulation of platelet-derived growth factor receptor signaling pathway" -"GO:0045660","positive regulation of neutrophil differentiation" -"GO:1903673","mitotic cleavage furrow formation" -"GO:1990791","dorsal root ganglion development" -"GO:1902108","regulation of mitochondrial membrane permeability involved in apoptotic process" -"GO:0006954","inflammatory response" -"GO:0090025","regulation of monocyte chemotaxis" -"GO:0021555","midbrain-hindbrain boundary morphogenesis" -"GO:0046736","active induction of humoral immune response in host by virus" -"GO:0019700","organic phosphonate catabolic process" -"GO:0034113","heterotypic cell-cell adhesion" -"GO:0048195","Golgi membrane priming complex assembly" -"GO:0031069","hair follicle morphogenesis" -"GO:0009114","hypoxanthine catabolic process" -"GO:0031925","pyridoxal transmembrane transporter activity" -"GO:0070734","histone H3-K27 methylation" -"GO:0042397","phosphagen catabolic process" -"GO:1990636","reproductive senescence" -"GO:0006651","diacylglycerol biosynthetic process" -"GO:0009810","stilbene metabolic process" -"GO:0015240","amiloride transmembrane transporter activity" -"GO:0060352","cell adhesion molecule production" -"GO:0001546","preantral ovarian follicle growth" -"GO:0097659","nucleic acid-templated transcription" -"GO:0000728","gene conversion at mating-type locus, DNA double-strand break formation" -"GO:0006700","C21-steroid hormone biosynthetic process" -"GO:0070071","proton-transporting two-sector ATPase complex assembly" -"GO:0048813","dendrite morphogenesis" -"GO:0032959","inositol trisphosphate biosynthetic process" -"GO:0033090","positive regulation of extrathymic T cell differentiation" -"GO:1902532","negative regulation of intracellular signal transduction" -"GO:0050901","leukocyte tethering or rolling" -"GO:0032186","cellular bud neck septin ring organization" -"GO:0071281","cellular response to iron ion" -"GO:0075004","adhesion of symbiont spore to host" -"GO:0048685","negative regulation of collateral sprouting of intact axon in response to injury" -"GO:0018419","protein catenane formation" -"GO:2001039","negative regulation of cellular response to drug" -"GO:0000103","sulfate assimilation" -"GO:0009132","nucleoside diphosphate metabolic process" -"GO:1905615","positive regulation of developmental vegetative growth" -"GO:0006590","thyroid hormone generation" -"GO:0007548","sex differentiation" -"GO:1902029","positive regulation of histone H3-K18 acetylation" -"GO:0100050","negative regulation of mating type switching by transcription from RNA polymerase II promoter" -"GO:0071830","triglyceride-rich lipoprotein particle clearance" -"GO:1901279","D-ribose 5-phosphate catabolic process" -"GO:0016457","dosage compensation complex assembly involved in dosage compensation by hyperactivation of X chromosome" -"GO:0072685","Mre11 complex assembly" -"GO:0014746","regulation of tonic skeletal muscle contraction" -"GO:0090716","adaptive immune memory response" -"GO:1901676","positive regulation of histone H3-K27 acetylation" -"GO:0018334","enzyme active site formation via O4'-phospho-L-tyrosine" -"GO:0021687","cerebellar molecular layer morphogenesis" -"GO:1904897","regulation of hepatic stellate cell proliferation" -"GO:0019932","second-messenger-mediated signaling" -"GO:1904530","negative regulation of actin filament binding" -"GO:0032498","detection of muramyl dipeptide" -"GO:0060997","dendritic spine morphogenesis" -"GO:0001816","cytokine production" -"GO:0007530","sex determination" -"GO:0044407","single-species biofilm formation in or on host organism" -"GO:0050940","regulation of late stripe melanocyte differentiation" -"GO:0035975","carbamoyl phosphate catabolic process" -"GO:0072689","MCM complex assembly" -"GO:0014070","response to organic cyclic compound" -"GO:1990155","Dsc E3 ubiquitin ligase complex assembly" -"GO:0019353","protoporphyrinogen IX biosynthetic process from glutamate" -"GO:0007450","dorsal/ventral pattern formation, imaginal disc" -"GO:0051667","establishment of plastid localization" -"GO:2000345","regulation of hepatocyte proliferation" -"GO:0002269","leukocyte activation involved in inflammatory response" -"GO:1990114","RNA polymerase II core complex assembly" -"GO:2001241","positive regulation of extrinsic apoptotic signaling pathway in absence of ligand" -"GO:0035199","salt aversion" -"GO:0060022","hard palate development" -"GO:0052256","modulation by organism of inflammatory response of other organism involved in symbiotic interaction" -"GO:1904695","positive regulation of vascular smooth muscle contraction" -"GO:0000319","sulfite transmembrane transporter activity" -"GO:0030721","spectrosome organization" -"GO:0034760","negative regulation of iron ion transmembrane transport" -"GO:0016062","adaptation of rhodopsin mediated signaling" -"GO:0035628","cystic duct development" -"GO:0071663","positive regulation of granzyme B production" -"GO:0031294","lymphocyte costimulation" -"GO:0002774","Fc receptor mediated inhibitory signaling pathway" -"GO:1990113","RNA polymerase I assembly" -"GO:0045590","negative regulation of regulatory T cell differentiation" -"GO:0019452","L-cysteine catabolic process to taurine" -"GO:0018027","peptidyl-lysine dimethylation" -"GO:0046386","deoxyribose phosphate catabolic process" -"GO:0006617","SRP-dependent cotranslational protein targeting to membrane, signal sequence recognition" -"GO:0002339","B cell selection" -"GO:1904201","regulation of iodide transport" -"GO:0042412","taurine biosynthetic process" -"GO:0070349","positive regulation of brown fat cell proliferation" -"GO:0019071","viral DNA cleavage involved in viral genome maturation" -"GO:0072175","epithelial tube formation" -"GO:0031324","negative regulation of cellular metabolic process" -"GO:0048202","clathrin coating of Golgi vesicle" -"GO:0071047","polyadenylation-dependent mRNA catabolic process" -"GO:0072203","cell proliferation involved in metanephros development" -"GO:1901090","regulation of protein tetramerization" -"GO:0002726","positive regulation of T cell cytokine production" -"GO:0060030","dorsal convergence" -"GO:0022002","negative regulation of anterior neural cell fate commitment of the neural plate by Wnt signaling pathway" -"GO:0051255","spindle midzone assembly" -"GO:1901284","5,6,7,8-tetrahydromethanopterin catabolic process" -"GO:0006672","ceramide metabolic process" -"GO:0035357","peroxisome proliferator activated receptor signaling pathway" -"GO:0003053","circadian regulation of heart rate" -"GO:0052864","1-deoxy-D-xylulose 5-phosphate catabolic process" -"GO:0006236","cytidine salvage" -"GO:0010819","regulation of T cell chemotaxis" -"GO:0051016","barbed-end actin filament capping" -"GO:0000902","cell morphogenesis" -"GO:0014072","response to isoquinoline alkaloid" -"GO:0032222","regulation of synaptic transmission, cholinergic" -"GO:1903947","positive regulation of ventricular cardiac muscle cell action potential" -"GO:0002270","plasmacytoid dendritic cell activation" -"GO:0060431","primary lung bud formation" -"GO:1904006","negative regulation of phospholipase D activity" -"GO:1902961","positive regulation of aspartic-type endopeptidase activity involved in amyloid precursor protein catabolic process" -"GO:0036017","response to erythropoietin" -"GO:0072212","regulation of transcription from RNA polymerase II promoter involved in metanephros development" -"GO:0018241","protein O-linked glycosylation via hydroxylysine" -"GO:0090158","endoplasmic reticulum membrane organization" -"GO:0030536","larval feeding behavior" -"GO:0021924","cell proliferation in external granule layer" -"GO:0001887","selenium compound metabolic process" -"GO:0015780","nucleotide-sugar transmembrane transport" -"GO:0009790","embryo development" -"GO:0072191","ureter smooth muscle development" -"GO:1905205","positive regulation of connective tissue replacement" -"GO:0042360","vitamin E metabolic process" -"GO:0006673","inositol phosphoceramide metabolic process" -"GO:0043046","DNA methylation involved in gamete generation" -"GO:0031494","regulation of mating type switching" -"GO:0009070","serine family amino acid biosynthetic process" -"GO:0033477","S-methylmethionine metabolic process" -"GO:1904616","regulation of actin binding" -"GO:0101010","pulmonary blood vessel remodeling" -"GO:0038007","netrin-activated signaling pathway" -"GO:0106015","negative regulation of inflammatory response to wounding" -"GO:0071571","LRR domain-mediated complex assembly" -"GO:0061242","mesonephric nephron tubule development" -"GO:0043393","regulation of protein binding" -"GO:1903357","regulation of transcription initiation from RNA polymerase I promoter" -"GO:0003255","endocardial precursor cell differentiation" -"GO:0050821","protein stabilization" -"GO:1904210","VCP-NPL4-UFD1 AAA ATPase complex assembly" -"GO:0019918","peptidyl-arginine methylation, to symmetrical-dimethyl arginine" -"GO:0045662","negative regulation of myoblast differentiation" -"GO:0046161","heme a catabolic process" -"GO:0002536","respiratory burst involved in inflammatory response" -"GO:0007080","mitotic metaphase plate congression" -"GO:0070426","positive regulation of nucleotide-binding oligomerization domain containing signaling pathway" -"GO:0046163","heme c catabolic process" -"GO:0042480","negative regulation of eye photoreceptor cell development" -"GO:0048723","clypeus development" -"GO:1905395","response to flavonoid" -"GO:0009257","10-formyltetrahydrofolate biosynthetic process" -"GO:0009859","pollen hydration" -"GO:1904861","excitatory synapse assembly" -"GO:1905635","FACT complex assembly" -"GO:0061038","uterus morphogenesis" -"GO:0071484","cellular response to light intensity" -"GO:0008630","intrinsic apoptotic signaling pathway in response to DNA damage" -"GO:0051042","negative regulation of calcium-independent cell-cell adhesion" -"GO:1904579","cellular response to thapsigargin" -"GO:0015516","tartrate:succinate antiporter activity" -"GO:1902506","positive regulation of signal transduction involved in mitotic G2 DNA damage checkpoint" -"GO:0061448","connective tissue development" -"GO:0002319","memory B cell differentiation" -"GO:0033120","positive regulation of RNA splicing" -"GO:0048010","vascular endothelial growth factor receptor signaling pathway" -"GO:0035090","maintenance of apical/basal cell polarity" -"GO:0060054","positive regulation of epithelial cell proliferation involved in wound healing" -"GO:0014074","response to purine-containing compound" -"GO:0018160","peptidyl-pyrromethane cofactor linkage" -"GO:0044751","cellular response to human chorionic gonadotropin stimulus" -"GO:0046369","galactose biosynthetic process" -"GO:0019493","arginine catabolic process to proline" -"GO:0048653","anther development" -"GO:1901295","regulation of canonical Wnt signaling pathway involved in cardiac muscle cell fate commitment" -"GO:1904100","positive regulation of protein O-linked glycosylation" -"GO:0035659","Wnt signaling pathway involved in wound healing, spreading of epidermal cells" -"GO:0018216","peptidyl-arginine methylation" -"GO:0071533","ankyrin repeat-mediated complex assembly" -"GO:0070129","regulation of mitochondrial translation" -"GO:0045553","TRAIL biosynthetic process" -"GO:0071413","cellular response to hydroxyisoflavone" -"GO:0045167","asymmetric protein localization involved in cell fate determination" -"GO:0002393","lysosomal enzyme production involved in inflammatory response" -"GO:0006349","regulation of gene expression by genetic imprinting" -"GO:0032509","endosome transport via multivesicular body sorting pathway" -"GO:0046668","regulation of retinal cell programmed cell death" -"GO:1905660","mitotic checkpoint complex assembly" -"GO:0071391","cellular response to estrogen stimulus" -"GO:0043985","histone H4-R3 methylation" -"GO:0060385","axonogenesis involved in innervation" -"GO:0070585","protein localization to mitochondrion" -"GO:0021865","symmetric radial glial cell division in forebrain" -"GO:0035547","regulation of interferon-beta secretion" -"GO:0042235","interleukin-17 biosynthetic process" -"GO:0009086","methionine biosynthetic process" -"GO:1901414","negative regulation of tetrapyrrole biosynthetic process from glycine and succinyl-CoA" -"GO:0000973","posttranscriptional tethering of RNA polymerase II gene DNA at nuclear periphery" -"GO:0001079","nitrogen catabolite regulation of transcription from RNA polymerase II promoter" -"GO:0006679","glucosylceramide biosynthetic process" -"GO:0060396","growth hormone receptor signaling pathway" -"GO:0044574","starch utilization system complex assembly" -"GO:0019346","transsulfuration" -"GO:0009113","purine nucleobase biosynthetic process" -"GO:0014834","skeletal muscle satellite cell maintenance involved in skeletal muscle regeneration" -"GO:0021707","cerebellar granule cell differentiation" -"GO:0061117","negative regulation of heart growth" -"GO:0051492","regulation of stress fiber assembly" -"GO:0070681","glutaminyl-tRNAGln biosynthesis via transamidation" -"GO:0065006","protein-carbohydrate complex assembly" -"GO:0030207","chondroitin sulfate catabolic process" -"GO:0007458","progression of morphogenetic furrow involved in compound eye morphogenesis" -"GO:0043156","chromatin remodeling in response to cation stress" -"GO:0060063","Spemann organizer formation at the embryonic shield" -"GO:0021885","forebrain cell migration" -"GO:0002351","serotonin production involved in inflammatory response" -"GO:0060573","cell fate specification involved in pattern specification" -"GO:1990671","vesicle fusion with Golgi medial cisterna membrane" -"GO:0043133","hindgut contraction" -"GO:0016571","histone methylation" -"GO:0010637","negative regulation of mitochondrial fusion" -"GO:2000830","positive regulation of parathyroid hormone secretion" -"GO:0000387","spliceosomal snRNP assembly" -"GO:0031536","positive regulation of exit from mitosis" -"GO:0048385","regulation of retinoic acid receptor signaling pathway" -"GO:0007064","mitotic sister chromatid cohesion" -"GO:0042225","interleukin-5 biosynthetic process" -"GO:0060606","tube closure" -"GO:1990691","cis-Golgi-derived vesicle fusion with Golgi medial cisterna membrane" -"GO:1905350","Y-shaped link assembly" -"GO:0042237","interleukin-20 biosynthetic process" -"GO:0021538","epithalamus development" -"GO:0032712","negative regulation of interleukin-3 production" -"GO:0008625","extrinsic apoptotic signaling pathway via death domain receptors" -"GO:0045016","mitochondrial magnesium ion transmembrane transport" -"GO:0035999","tetrahydrofolate interconversion" -"GO:0035672","oligopeptide transmembrane transport" -"GO:0019919","peptidyl-arginine methylation, to asymmetrical-dimethyl arginine" -"GO:0071922","regulation of cohesin loading" -"GO:1905669","TORC1 complex assembly" -"GO:0035582","sequestering of BMP in extracellular matrix" -"GO:0061374","mammillothalamic axonal tract development" -"GO:0001768","establishment of T cell polarity" -"GO:0071811","positive regulation of fever generation by positive regulation of prostaglandin biosynthesis" -"GO:1905386","positive regulation of protein localization to presynapse" -"GO:0061329","Malpighian tubule principal cell differentiation" -"GO:0035769","B cell chemotaxis across high endothelial venule" -"GO:0033054","D-glutamate metabolic process" -"GO:2001201","regulation of transforming growth factor-beta secretion" -"GO:1900145","regulation of nodal signaling pathway involved in determination of left/right asymmetry" -"GO:0006164","purine nucleotide biosynthetic process" -"GO:0046720","citric acid secretion" -"GO:0030903","notochord development" -"GO:0006720","isoprenoid metabolic process" -"GO:1904467","regulation of tumor necrosis factor secretion" -"GO:0001678","cellular glucose homeostasis" -"GO:1905880","negative regulation of oogenesis" -"GO:0007062","sister chromatid cohesion" -"GO:0048702","embryonic neurocranium morphogenesis" -"GO:1900245","positive regulation of MDA-5 signaling pathway" -"GO:0071712","ER-associated misfolded protein catabolic process" -"GO:0043653","mitochondrial fragmentation involved in apoptotic process" -"GO:0033554","cellular response to stress" -"GO:0015812","gamma-aminobutyric acid transport" -"GO:0002355","detection of tumor cell" -"GO:0001780","neutrophil homeostasis" -"GO:0060605","tube lumen cavitation" -"GO:1903359","lateral cortical node assembly" -"GO:1901836","regulation of transcription of nucleolar large rRNA by RNA polymerase I" -"GO:0003200","endocardial cushion to mesenchymal transition involved in heart chamber septation" -"GO:0007076","mitotic chromosome condensation" -"GO:0021866","asymmetric radial glial cell division in forebrain" -"GO:1902481","gamma-tubulin complex assembly" -"GO:0010753","positive regulation of cGMP-mediated signaling" -"GO:0021767","mammillary body development" -"GO:0032525","somite rostral/caudal axis specification" -"GO:0008637","apoptotic mitochondrial changes" -"GO:0061172","regulation of establishment of bipolar cell polarity" -"GO:0002538","arachidonic acid metabolite production involved in inflammatory response" -"GO:0060066","oviduct development" -"GO:0036146","cellular response to mycotoxin" -"GO:1904594","regulation of termination of RNA polymerase II transcription" -"GO:0090009","primitive streak formation" -"GO:1902572","negative regulation of serine-type peptidase activity" -"GO:1903578","regulation of ATP metabolic process" -"GO:0002901","mature B cell apoptotic process" -"GO:0048703","embryonic viscerocranium morphogenesis" -"GO:1902561","origin recognition complex assembly" -"GO:0038096","Fc-gamma receptor signaling pathway involved in phagocytosis" -"GO:0031131","reception of an inductive signal" -"GO:0061395","positive regulation of transcription from RNA polymerase II promoter in response to arsenic-containing substance" -"GO:0050690","regulation of defense response to virus by virus" -"GO:0051452","intracellular pH reduction" -"GO:0031987","locomotion involved in locomotory behavior" -"GO:0035940","negative regulation of peptidase activity in other organism" -"GO:0070285","pigment cell development" -"GO:0071531","Rel homology domain-mediated complex assembly" -"GO:0071537","C3HC4-type RING finger domain-mediated complex assembly" -"GO:2000523","regulation of T cell costimulation" -"GO:0031121","equatorial microtubule organization" -"GO:1990692","trans-Golgi-derived vesicle fusion with Golgi medial cisterna membrane" -"GO:0070806","negative regulation of phialide development" -"GO:0097089","methyl-branched fatty acid metabolic process" -"GO:0034969","histone arginine methylation" -"GO:0048058","compound eye corneal lens development" -"GO:0098883","synapse disassembly" -"GO:0007178","transmembrane receptor protein serine/threonine kinase signaling pathway" -"GO:0019502","stachydrine metabolic process" -"GO:0015948","methanogenesis" -"GO:0035028","leading edge cell fate determination" -"GO:1900842","positive regulation of helvolic acid biosynthetic process" -"GO:0060530","smooth muscle cell differentiation involved in prostate glandular acinus development" -"GO:1905492","positive regulation of branching morphogenesis of a nerve" -"GO:1903281","positive regulation of calcium:sodium antiporter activity" -"GO:0000303","response to superoxide" -"GO:2000253","positive regulation of feeding behavior" -"GO:0061344","regulation of cell adhesion involved in heart morphogenesis" -"GO:0010749","regulation of nitric oxide mediated signal transduction" -"GO:0006432","phenylalanyl-tRNA aminoacylation" -"GO:1990542","mitochondrial transmembrane transport" -"GO:1904077","negative regulation of estrogen biosynthetic process" -"GO:0002378","immunoglobulin biosynthetic process" -"GO:0007425","epithelial cell fate determination, open tracheal system" -"GO:0002807","positive regulation of antimicrobial peptide biosynthetic process" -"GO:1903898","negative regulation of PERK-mediated unfolded protein response" -"GO:0007192","adenylate cyclase-activating serotonin receptor signaling pathway" -"GO:0030854","positive regulation of granulocyte differentiation" -"GO:1902576","negative regulation of nuclear cell cycle DNA replication" -"GO:1900381","positive regulation of asperthecin biosynthetic process" -"GO:0003436","regulation of cell adhesion involved in growth plate cartilage morphogenesis" -"GO:0106089","negative regulation of cell adhesion involved in sprouting angiogenesis" -"GO:0002881","negative regulation of chronic inflammatory response to non-antigenic stimulus" -"GO:1903645","negative regulation of chaperone-mediated protein folding" -"GO:1902856","negative regulation of non-motile cilium assembly" -"GO:1901752","leukotriene A4 catabolic process" -"GO:0071468","cellular response to acidic pH" -"GO:0043379","memory T cell differentiation" -"GO:1904209","positive regulation of chemokine (C-C motif) ligand 2 secretion" -"GO:1990739","granulosa cell proliferation" -"GO:1901083","pyrrolizidine alkaloid metabolic process" -"GO:1902879","negative regulation of BMP signaling pathway involved in spinal cord association neuron specification" -"GO:0042063","gliogenesis" -"GO:0061141","lung ciliated cell differentiation" -"GO:0060706","cell differentiation involved in embryonic placenta development" -"GO:0048297","negative regulation of isotype switching to IgA isotypes" -"GO:0006039","cell wall chitin catabolic process" -"GO:0035791","platelet-derived growth factor receptor-beta signaling pathway" -"GO:0032213","regulation of telomere maintenance via semi-conservative replication" -"GO:0051565","negative regulation of smooth endoplasmic reticulum calcium ion concentration" -"GO:0097166","lens epithelial cell proliferation" -"GO:2000079","regulation of canonical Wnt signaling pathway involved in controlling type B pancreatic cell proliferation" -"GO:0072575","epithelial cell proliferation involved in liver morphogenesis" -"GO:0090420","naphthalene-containing compound metabolic process" -"GO:0060259","regulation of feeding behavior" -"GO:0009821","alkaloid biosynthetic process" -"GO:0001952","regulation of cell-matrix adhesion" -"GO:0048175","hepatocyte growth factor biosynthetic process" -"GO:0052106","quorum sensing involved in interaction with host" -"GO:1902389","ceramide 1-phosphate transport" -"GO:0045728","respiratory burst after phagocytosis" -"GO:0072075","metanephric mesenchyme development" -"GO:0071174","mitotic spindle checkpoint" -"GO:0075050","positive regulation of symbiont cell wall strengthening involved in entry into host" -"GO:0015693","magnesium ion transport" -"GO:0044598","doxorubicin metabolic process" -"GO:0015014","heparan sulfate proteoglycan biosynthetic process, polysaccharide chain biosynthetic process" -"GO:0060781","mesenchymal cell proliferation involved in prostate gland development" -"GO:0071106","adenosine 3',5'-bisphosphate transmembrane transport" -"GO:0072425","signal transduction involved in G2 DNA damage checkpoint" -"GO:0060480","lung goblet cell differentiation" -"GO:0030716","oocyte fate determination" -"GO:0060582","cell fate determination involved in pattern specification" -"GO:0097624","UDP-galactose transmembrane import into Golgi lumen" -"GO:0030030","cell projection organization" -"GO:2000323","negative regulation of glucocorticoid receptor signaling pathway" -"GO:0032219","cell wall macromolecule catabolic process involved in cytogamy" -"GO:0017148","negative regulation of translation" -"GO:0048086","negative regulation of developmental pigmentation" -"GO:0060135","maternal process involved in female pregnancy" -"GO:0060848","endothelial cell fate determination" -"GO:1905650","positive regulation of shell calcification" -"GO:0070427","nucleotide-binding oligomerization domain containing 1 signaling pathway" -"GO:0051930","regulation of sensory perception of pain" -"GO:0097588","archaeal or bacterial-type flagellum-dependent cell motility" -"GO:0072748","cellular response to tacrolimus" -"GO:0032091","negative regulation of protein binding" -"GO:1903402","regulation of renal phosphate excretion" -"GO:0006433","prolyl-tRNA aminoacylation" -"GO:0044097","secretion by the type IV secretion system" -"GO:1905523","positive regulation of macrophage migration" -"GO:0048867","stem cell fate determination" -"GO:0061359","regulation of Wnt signaling pathway by Wnt protein secretion" -"GO:0046845","branched duct epithelial cell fate determination, open tracheal system" -"GO:0008343","adult feeding behavior" -"GO:0031460","glycine betaine transport" -"GO:0106088","regulation of cell adhesion involved in sprouting angiogenesis" -"GO:1903142","positive regulation of establishment of endothelial barrier" -"GO:0060291","long-term synaptic potentiation" -"GO:0050857","positive regulation of antigen receptor-mediated signaling pathway" -"GO:0044497","positive regulation of blood pressure in other organism" -"GO:0001697","histamine-induced gastric acid secretion" -"GO:0001915","negative regulation of T cell mediated cytotoxicity" -"GO:0002264","endothelial cell activation involved in immune response" -"GO:0031281","positive regulation of cyclase activity" -"GO:0009814","defense response, incompatible interaction" -"GO:1990863","acinar cell proliferation" -"GO:1901148","gene expression involved in extracellular matrix organization" -"GO:0044770","cell cycle phase transition" -"GO:0044246","regulation of multicellular organismal metabolic process" -"GO:0035858","eosinophil fate determination" -"GO:0038066","p38MAPK cascade" -"GO:0032606","type I interferon production" -"GO:0043635","methylnaphthalene catabolic process" -"GO:0046446","purine alkaloid metabolic process" -"GO:0097749","membrane tubulation" -"GO:0007278","pole cell fate determination" -"GO:0071408","cellular response to cycloalkane" -"GO:0071234","cellular response to phenylalanine" -"GO:0010223","secondary shoot formation" -"GO:0051865","protein autoubiquitination" -"GO:0042231","interleukin-13 biosynthetic process" -"GO:0072326","vulval cell fate determination" -"GO:2001184","positive regulation of interleukin-12 secretion" -"GO:0048935","peripheral nervous system neuron development" -"GO:1990789","thyroid gland epithelial cell proliferation" -"GO:0098720","succinate import across plasma membrane" -"GO:0060767","epithelial cell proliferation involved in prostate gland development" -"GO:1903442","response to lipoic acid" -"GO:0044597","daunorubicin metabolic process" -"GO:0071410","cellular response to cyclopentenone" -"GO:0061932","negative regulation of erythrocyte enucleation" -"GO:0000750","pheromone-dependent signal transduction involved in conjugation with cellular fusion" -"GO:0002379","immunoglobulin biosynthetic process involved in immune response" -"GO:0007604","phototransduction, UV" -"GO:0071616","acyl-CoA biosynthetic process" -"GO:1900162","negative regulation of phospholipid scramblase activity" -"GO:0036089","cleavage furrow formation" -"GO:0010390","histone monoubiquitination" -"GO:0010184","cytokinin transport" -"GO:0036255","response to methylamine" -"GO:1901218","negative regulation of holin activity" -"GO:0044783","G1 DNA damage checkpoint" -"GO:1990369","process resulting in tolerance to ketone" -"GO:0030643","cellular phosphate ion homeostasis" -"GO:1903014","cellular response to differentiation-inducing factor 1" -"GO:0008593","regulation of Notch signaling pathway" -"GO:0061883","clathrin-dependent endocytosis involved in vitellogenesis" -"GO:0045670","regulation of osteoclast differentiation" -"GO:0006589","octopamine biosynthetic process" -"GO:0042417","dopamine metabolic process" -"GO:0071607","macrophage inflammatory protein-1 gamma production" -"GO:0051826","negative regulation of synapse structural plasticity" -"GO:0015897","organomercurial transport" -"GO:0050868","negative regulation of T cell activation" -"GO:2001027","negative regulation of endothelial cell chemotaxis" -"GO:2001222","regulation of neuron migration" -"GO:0003241","growth involved in heart morphogenesis" -"GO:1901485","positive regulation of transcription factor catabolic process" -"GO:0032817","regulation of natural killer cell proliferation" -"GO:0021749","ventral cochlear nucleus development" -"GO:0120127","response to zinc ion starvation" -"GO:0046427","positive regulation of JAK-STAT cascade" -"GO:0010965","regulation of mitotic sister chromatid separation" -"GO:0003270","Notch signaling pathway involved in regulation of secondary heart field cardioblast proliferation" -"GO:2001294","malonyl-CoA catabolic process" -"GO:0033518","myo-inositol hexakisphosphate dephosphorylation" -"GO:1903280","negative regulation of calcium:sodium antiporter activity" -"GO:0018258","protein O-linked glycosylation via hydroxyproline" -"GO:2001236","regulation of extrinsic apoptotic signaling pathway" -"GO:0045747","positive regulation of Notch signaling pathway" -"GO:0001672","regulation of chromatin assembly or disassembly" -"GO:1900333","regulation of methane biosynthetic process from 3-(methylthio)propionic acid" -"GO:1902124","(+)-pinoresinol metabolic process" -"GO:0032367","intracellular cholesterol transport" -"GO:0050981","detection of electrical stimulus" -"GO:0046321","positive regulation of fatty acid oxidation" -"GO:0097692","histone H3-K4 monomethylation" -"GO:1905311","negative regulation of cardiac neural crest cell migration involved in outflow tract morphogenesis" -"GO:0046685","response to arsenic-containing substance" -"GO:0003162","atrioventricular node development" -"GO:0036299","non-recombinational interstrand cross-link repair" -"GO:0015770","sucrose transport" -"GO:0039696","RNA-templated viral transcription" -"GO:0042424","catecholamine catabolic process" -"GO:1904622","negative regulation of actin-dependent ATPase activity" -"GO:0090188","negative regulation of pancreatic juice secretion" -"GO:1904848","negative regulation of cell chemotaxis to fibroblast growth factor" -"GO:1990116","ribosome-associated ubiquitin-dependent protein catabolic process" -"GO:0048718","cibarial fish-trap bristle morphogenesis" -"GO:0032489","regulation of Cdc42 protein signal transduction" -"GO:1902462","positive regulation of mesenchymal stem cell proliferation" -"GO:0014844","myoblast proliferation involved in skeletal muscle regeneration" -"GO:0060868","regulation of vesicle-mediated transport involved in floral organ abscission by small GTPase mediated signal transduction" -"GO:0000038","very long-chain fatty acid metabolic process" -"GO:0050855","regulation of B cell receptor signaling pathway" -"GO:0045988","negative regulation of striated muscle contraction" -"GO:1902808","positive regulation of cell cycle G1/S phase transition" -"GO:0045618","positive regulation of keratinocyte differentiation" -"GO:2001141","regulation of RNA biosynthetic process" -"GO:0044829","positive regulation by host of viral genome replication" -"GO:0043578","nuclear matrix organization" -"GO:0061419","positive regulation of transcription from RNA polymerase II promoter in response to hypoxia" -"GO:0048081","positive regulation of cuticle pigmentation" -"GO:0060155","platelet dense granule organization" -"GO:0072390","phenol metabolic process" -"GO:0050835","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl S-adenosylmethion-N,O-diyl tetrairon tetrasulfide" -"GO:0014031","mesenchymal cell development" -"GO:1905503","regulation of motile cilium assembly" -"GO:0070541","response to platinum ion" -"GO:1990546","mitochondrial tricarboxylic acid transmembrane transport" -"GO:1902068","regulation of sphingolipid mediated signaling pathway" -"GO:0090261","positive regulation of inclusion body assembly" -"GO:0061384","heart trabecula morphogenesis" -"GO:0072077","renal vesicle morphogenesis" -"GO:0048749","compound eye development" -"GO:0048310","nucleus inheritance" -"GO:1903138","negative regulation of MAPK cascade involved in cell wall organization or biogenesis" -"GO:0061642","chemoattraction of axon" -"GO:1990559","mitochondrial coenzyme A transmembrane transport" -"GO:0015744","succinate transport" -"GO:1905629","positive regulation of serotonin biosynthetic process" -"GO:0001927","exocyst assembly" -"GO:1900108","negative regulation of nodal signaling pathway" -"GO:0010887","negative regulation of cholesterol storage" -"GO:0002443","leukocyte mediated immunity" -"GO:0042135","neurotransmitter catabolic process" -"GO:0002637","regulation of immunoglobulin production" -"GO:0002086","diaphragm contraction" -"GO:1901201","regulation of extracellular matrix assembly" -"GO:0002612","positive regulation of plasmacytoid dendritic cell antigen processing and presentation" -"GO:0070359","actin polymerization-dependent cell motility involved in migration of symbiont in host" -"GO:0036352","histone H2A-K15 ubiquitination" -"GO:0043401","steroid hormone mediated signaling pathway" -"GO:0002724","regulation of T cell cytokine production" -"GO:0035795","negative regulation of mitochondrial membrane permeability" -"GO:1903849","positive regulation of aorta morphogenesis" -"GO:0060016","granulosa cell development" -"GO:1904591","positive regulation of protein import" -"GO:0032837","distributive segregation" -"GO:1905671","regulation of lysosome organization" -"GO:0035040","sperm nuclear envelope removal" -"GO:0033955","mitochondrial DNA inheritance" -"GO:0036363","transforming growth factor beta activation" -"GO:2000974","negative regulation of pro-B cell differentiation" -"GO:1901415","positive regulation of tetrapyrrole biosynthetic process from glycine and succinyl-CoA" -"GO:0060466","activation of meiosis involved in egg activation" -"GO:1902172","regulation of keratinocyte apoptotic process" -"GO:1903922","negative regulation of protein processing in phagocytic vesicle" -"GO:0032110","regulation of protein histidine kinase activity" -"GO:0033539","fatty acid beta-oxidation using acyl-CoA dehydrogenase" -"GO:0006310","DNA recombination" -"GO:0003207","cardiac chamber formation" -"GO:0070165","positive regulation of adiponectin secretion" -"GO:0042062","long-term strengthening of neuromuscular junction" -"GO:1901717","positive regulation of gamma-aminobutyric acid catabolic process" -"GO:0045955","negative regulation of calcium ion-dependent exocytosis" -"GO:0044336","canonical Wnt signaling pathway involved in negative regulation of apoptotic process" -"GO:0072044","collecting duct development" -"GO:1901222","regulation of NIK/NF-kappaB signaling" -"GO:0009792","embryo development ending in birth or egg hatching" -"GO:0097201","negative regulation of transcription from RNA polymerase II promoter in response to stress" -"GO:0031998","regulation of fatty acid beta-oxidation" -"GO:0035089","establishment of apical/basal cell polarity" -"GO:0006267","pre-replicative complex assembly involved in nuclear cell cycle DNA replication" -"GO:1901145","mesenchymal cell apoptotic process involved in nephron morphogenesis" -"GO:0002227","innate immune response in mucosa" -"GO:1904752","regulation of vascular associated smooth muscle cell migration" -"GO:0072673","lamellipodium morphogenesis" -"GO:0061025","membrane fusion" -"GO:0016318","ommatidial rotation" -"GO:0042715","dosage compensation complex assembly involved in dosage compensation by hypoactivation of X chromosome" -"GO:0072604","interleukin-6 secretion" -"GO:0006903","vesicle targeting" -"GO:0001541","ovarian follicle development" -"GO:0090168","Golgi reassembly" -"GO:1905034","regulation of antifungal innate immune response" -"GO:0060330","regulation of response to interferon-gamma" -"GO:0002268","follicular dendritic cell differentiation" -"GO:0051303","establishment of chromosome localization" -"GO:0005977","glycogen metabolic process" -"GO:0140201","urea import across plasma membrane" -"GO:0044341","sodium-dependent phosphate transport" -"GO:0009408","response to heat" -"GO:0006506","GPI anchor biosynthetic process" -"GO:0060561","apoptotic process involved in morphogenesis" -"GO:0010446","response to alkaline pH" -"GO:0051591","response to cAMP" -"GO:0006413","translational initiation" -"GO:0060019","radial glial cell differentiation" -"GO:0097352","autophagosome maturation" -"GO:0120060","regulation of gastric emptying" -"GO:0014857","regulation of skeletal muscle cell proliferation" -"GO:0042843","D-xylose catabolic process" -"GO:0071896","protein localization to adherens junction" -"GO:0051023","regulation of immunoglobulin secretion" -"GO:0070367","negative regulation of hepatocyte differentiation" -"GO:0001868","regulation of complement activation, lectin pathway" -"GO:0034167","regulation of toll-like receptor 10 signaling pathway" -"GO:0060890","limb spinous cell differentiation" -"GO:1904248","regulation of age-related resistance" -"GO:1900200","mesenchymal cell apoptotic process involved in metanephros development" -"GO:0120094","negative regulation of peptidyl-lysine crotonylation" -"GO:0010112","regulation of systemic acquired resistance" -"GO:0039685","rolling hairpin viral DNA replication" -"GO:0034486","vacuolar transmembrane transport" -"GO:0009297","pilus assembly" -"GO:0051901","positive regulation of mitochondrial depolarization" -"GO:0018892","cyclohexylsulfamate metabolic process" -"GO:1903039","positive regulation of leukocyte cell-cell adhesion" -"GO:0071033","nuclear retention of pre-mRNA at the site of transcription" -"GO:0042552","myelination" -"GO:0038033","positive regulation of endothelial cell chemotaxis by VEGF-activated vascular endothelial growth factor receptor signaling pathway" -"GO:0030210","heparin biosynthetic process" -"GO:1904664","negative regulation of N-terminal peptidyl-methionine acetylation" -"GO:0000350","generation of catalytic spliceosome for second transesterification step" -"GO:0051078","meiotic nuclear envelope disassembly" -"GO:0051712","positive regulation of killing of cells of other organism" -"GO:0006427","histidyl-tRNA aminoacylation" -"GO:2000593","negative regulation of metanephric DCT cell differentiation" -"GO:0010763","positive regulation of fibroblast migration" -"GO:2001214","positive regulation of vasculogenesis" -"GO:0039502","suppression by virus of host type I interferon-mediated signaling pathway" -"GO:0072155","epithelial cell migration involved in nephron tubule morphogenesis" -"GO:1902906","proteasome storage granule assembly" -"GO:0036236","acyl glucuronidation" -"GO:0007171","activation of transmembrane receptor protein tyrosine kinase activity" -"GO:1903174","fatty alcohol catabolic process" -"GO:0033235","positive regulation of protein sumoylation" -"GO:0051616","regulation of histamine uptake" -"GO:0033634","positive regulation of cell-cell adhesion mediated by integrin" -"GO:1904173","regulation of histone demethylase activity (H3-K4 specific)" -"GO:1990010","compound eye retinal cell apoptotic process" -"GO:0008272","sulfate transport" -"GO:1905499","trichome papilla formation" -"GO:1903746","positive regulation of pharyngeal pumping" -"GO:0060671","epithelial cell differentiation involved in embryonic placenta development" -"GO:0001554","luteolysis" -"GO:0015031","protein transport" -"GO:0090108","positive regulation of high-density lipoprotein particle assembly" -"GO:0019331","anaerobic respiration, using ammonium as electron donor" -"GO:0033625","positive regulation of integrin activation" -"GO:0038011","negative regulation of signal transduction by receptor internalization" -"GO:1903752","positive regulation of intrinsic apoptotic signaling pathway in response to hydrogen peroxide" -"GO:0035725","sodium ion transmembrane transport" -"GO:0039563","suppression by virus of host STAT1 activity" -"GO:0032804","negative regulation of low-density lipoprotein particle receptor catabolic process" -"GO:0090050","positive regulation of cell migration involved in sprouting angiogenesis" -"GO:0043930","primary ovarian follicle growth involved in primary follicle stage" -"GO:1990758","mitotic sister chromatid biorientation" -"GO:1901642","nucleoside transmembrane transport" -"GO:1903588","negative regulation of blood vessel endothelial cell proliferation involved in sprouting angiogenesis" -"GO:0072606","interleukin-8 secretion" -"GO:0031629","synaptic vesicle fusion to presynaptic active zone membrane" -"GO:0070193","synaptonemal complex organization" -"GO:0120031","plasma membrane bounded cell projection assembly" -"GO:0090382","phagosome maturation" -"GO:0042474","middle ear morphogenesis" -"GO:0046126","pyrimidine deoxyribonucleoside biosynthetic process" -"GO:1901035","negative regulation of L-glutamine import across plasma membrane" -"GO:1990678","histone H4-K16 deacetylation" -"GO:1905463","negative regulation of DNA duplex unwinding" -"GO:0019722","calcium-mediated signaling" -"GO:0060902","regulation of hair cycle by BMP signaling pathway" -"GO:0016240","autophagosome membrane docking" -"GO:0090615","mitochondrial mRNA processing" -"GO:1904812","rRNA acetylation involved in maturation of SSU-rRNA" -"GO:0032224","positive regulation of synaptic transmission, cholinergic" -"GO:0001912","positive regulation of leukocyte mediated cytotoxicity" -"GO:0090374","oligopeptide export from mitochondrion" -"GO:0050927","positive regulation of positive chemotaxis" -"GO:0039686","bidirectional double-stranded viral DNA replication" -"GO:0033869","nucleoside bisphosphate catabolic process" -"GO:0044780","bacterial-type flagellum assembly" -"GO:0061456","mesenchymal stem cell migration involved in uteric bud morphogenesis" -"GO:0051683","establishment of Golgi localization" -"GO:0006814","sodium ion transport" -"GO:0032310","prostaglandin secretion" -"GO:0045417","regulation of interleukin-9 biosynthetic process" -"GO:0044579","butyryl-CoA biosynthetic process from acetyl-CoA" -"GO:0090328","regulation of olfactory learning" -"GO:1901130","gentamycin biosynthetic process" -"GO:1901613","negative regulation of terminal button organization" -"GO:0002741","positive regulation of cytokine secretion involved in immune response" -"GO:0039688","viral double stranded DNA replication via reverse transcription" -"GO:0006906","vesicle fusion" -"GO:0097083","vascular smooth muscle cell fate determination" -"GO:0098968","neurotransmitter receptor transport postsynaptic membrane to endosome" -"GO:0031645","negative regulation of neurological system process" -"GO:0098976","excitatory chemical synaptic transmission" -"GO:0016082","synaptic vesicle priming" -"GO:0007131","reciprocal meiotic recombination" -"GO:0051931","regulation of sensory perception" -"GO:0098887","neurotransmitter receptor transport, endosome to postsynaptic membrane" -"GO:2000367","regulation of acrosomal vesicle exocytosis" -"GO:0051284","positive regulation of sequestering of calcium ion" -"GO:0015398","high-affinity secondary active ammonium transmembrane transporter activity" -"GO:0060576","intestinal epithelial cell development" -"GO:0051886","negative regulation of timing of anagen" -"GO:0044807","macrophage migration inhibitory factor production" -"GO:2000118","regulation of sodium-dependent phosphate transport" -"GO:0090159","sphingolipid biosynthesis involved in endoplasmic reticulum membrane organization" -"GO:0060285","cilium-dependent cell motility" -"GO:0072103","glomerulus vasculature morphogenesis" -"GO:1902186","regulation of viral release from host cell" -"GO:0039687","viral DNA strand displacement replication" -"GO:1902164","positive regulation of DNA damage response, signal transduction by p53 class mediator resulting in transcription of p21 class mediator" -"GO:1904211","membrane protein proteolysis involved in retrograde protein transport, ER to cytosol" -"GO:0002672","positive regulation of B cell anergy" -"GO:0061537","glycine secretion, neurotransmission" -"GO:0036481","intrinsic apoptotic signaling pathway in response to hydrogen peroxide" -"GO:0030451","regulation of complement activation, alternative pathway" -"GO:0060271","cilium assembly" -"GO:0043927","exonucleolytic nuclear-transcribed mRNA catabolic process involved in endonucleolytic cleavage-dependent decay" -"GO:0015860","purine nucleoside transmembrane transport" -"GO:0006887","exocytosis" -"GO:1905373","ceramide phosphoethanolamine biosynthetic process" -"GO:0016254","preassembly of GPI anchor in ER membrane" -"GO:0001767","establishment of lymphocyte polarity" -"GO:0001964","startle response" -"GO:0097553","calcium ion transmembrane import into cytosol" -"GO:0060866","leaf abscission" -"GO:0034975","protein folding in endoplasmic reticulum" -"GO:0001812","positive regulation of type I hypersensitivity" -"GO:0007376","cephalic furrow formation" -"GO:1902022","L-lysine transport" -"GO:0009567","double fertilization forming a zygote and endosperm" -"GO:0071385","cellular response to glucocorticoid stimulus" -"GO:0042414","epinephrine metabolic process" -"GO:0006032","chitin catabolic process" -"GO:0032043","mitochondrial DNA catabolic process" -"GO:0060404","axonemal microtubule depolymerization" -"GO:0035116","embryonic hindlimb morphogenesis" -"GO:1901811","beta-carotene catabolic process" -"GO:0021720","superior olivary nucleus formation" -"GO:0042891","antibiotic transport" -"GO:0018295","protein-FAD linkage via 3'-(8alpha-FAD)-L-histidine" -"GO:0033575","protein glycosylation at cell surface" -"GO:0060788","ectodermal placode formation" -"GO:0090668","endothelial cell chemotaxis to vascular endothelial growth factor" -"GO:1990776","response to angiotensin" -"GO:1905705","cellular response to paclitaxel" -"GO:1904349","positive regulation of small intestine smooth muscle contraction" -"GO:0002154","thyroid hormone mediated signaling pathway" -"GO:0035264","multicellular organism growth" -"GO:1902400","intracellular signal transduction involved in G1 DNA damage checkpoint" -"GO:0070839","divalent metal ion export" -"GO:1905243","cellular response to 3,3',5-triiodo-L-thyronine" -"GO:0007606","sensory perception of chemical stimulus" -"GO:0040037","negative regulation of fibroblast growth factor receptor signaling pathway" -"GO:0060867","fruit abscission" -"GO:0070934","CRD-mediated mRNA stabilization" -"GO:1904800","negative regulation of neuron remodeling" -"GO:0075076","positive regulation by host of symbiont adenylate cyclase activity" -"GO:0045672","positive regulation of osteoclast differentiation" -"GO:0031664","regulation of lipopolysaccharide-mediated signaling pathway" -"GO:1904213","negative regulation of iodide transmembrane transport" -"GO:0042258","molybdenum incorporation via L-serinyl molybdopterin guanine dinucleotide" -"GO:0002695","negative regulation of leukocyte activation" -"GO:0007576","nucleolar fragmentation" -"GO:0045701","negative regulation of spermatid nuclear differentiation" -"GO:0007191","adenylate cyclase-activating dopamine receptor signaling pathway" -"GO:0021594","rhombomere formation" -"GO:0045342","MHC class II biosynthetic process" -"GO:0021563","glossopharyngeal nerve development" -"GO:0001580","detection of chemical stimulus involved in sensory perception of bitter taste" -"GO:0016070","RNA metabolic process" -"GO:1990729","primary miRNA modification" -"GO:1904480","positive regulation of intestinal absorption" -"GO:1905270","Meynert cell differentiation" -"GO:0060509","Type I pneumocyte differentiation" -"GO:0075015","formation of infection structure on or near host" -"GO:0018187","molybdenum incorporation via L-cysteinyl molybdopterin guanine dinucleotide" -"GO:1903847","regulation of aorta morphogenesis" -"GO:0071279","cellular response to cobalt ion" -"GO:0072010","glomerular epithelium development" -"GO:0035202","tracheal pit formation in open tracheal system" -"GO:1901548","positive regulation of synaptic vesicle lumen acidification" -"GO:1905241","positive regulation of canonical Wnt signaling pathway involved in osteoblast differentiation" -"GO:1901534","positive regulation of hematopoietic progenitor cell differentiation" -"GO:0035667","TRIF-dependent toll-like receptor 4 signaling pathway" -"GO:0018294","protein-FAD linkage via S-(8alpha-FAD)-L-cysteine" -"GO:0021561","facial nerve development" -"GO:1901673","regulation of mitotic spindle assembly" -"GO:0043009","chordate embryonic development" -"GO:2000828","regulation of parathyroid hormone secretion" -"GO:0038093","Fc receptor signaling pathway" -"GO:0009048","dosage compensation by inactivation of X chromosome" -"GO:1903106","positive regulation of insulin receptor signaling pathway involved in determination of adult lifespan" -"GO:0021504","neural fold hinge point formation" -"GO:0048701","embryonic cranial skeleton morphogenesis" -"GO:0019377","glycolipid catabolic process" -"GO:2000373","positive regulation of DNA topoisomerase (ATP-hydrolyzing) activity" -"GO:0071049","nuclear retention of pre-mRNA with aberrant 3'-ends at the site of transcription" -"GO:0071514","genetic imprinting" -"GO:0045292","mRNA cis splicing, via spliceosome" -"GO:0032337","positive regulation of activin secretion" -"GO:0021914","negative regulation of smoothened signaling pathway involved in ventral spinal cord patterning" -"GO:0045008","depyrimidination" -"GO:0042168","heme metabolic process" -"GO:0015628","protein secretion by the type II secretion system" -"GO:0033032","regulation of myeloid cell apoptotic process" -"GO:0072003","kidney rudiment formation" -"GO:0097548","seed abscission" -"GO:1904575","positive regulation of selenocysteine insertion sequence binding" -"GO:0035234","ectopic germ cell programmed cell death" -"GO:1905691","lipid droplet disassembly" -"GO:0048593","camera-type eye morphogenesis" -"GO:0061311","cell surface receptor signaling pathway involved in heart development" -"GO:0018297","protein-FAD linkage via 1'-(8alpha-FAD)-L-histidine" -"GO:0042994","cytoplasmic sequestering of transcription factor" -"GO:1902257","negative regulation of apoptotic process involved in outflow tract morphogenesis" -"GO:0035670","plant-type ovary development" -"GO:0016259","selenocysteine metabolic process" -"GO:0045007","depurination" -"GO:0043517","positive regulation of DNA damage response, signal transduction by p53 class mediator" -"GO:0010376","stomatal complex formation" -"GO:0048070","regulation of developmental pigmentation" -"GO:0010172","embryonic body morphogenesis" -"GO:0002371","dendritic cell cytokine production" -"GO:0033173","calcineurin-NFAT signaling cascade" -"GO:0007188","adenylate cyclase-modulating G-protein coupled receptor signaling pathway" -"GO:1905707","negative regulation of mitochondrial ATP synthesis coupled proton transport" -"GO:1904484","cloacal gland development" -"GO:0046844","micropyle formation" -"GO:0061385","fibroblast proliferation involved in heart morphogenesis" -"GO:0072181","mesonephric duct formation" -"GO:0120072","positive regulation of pyloric antrum smooth muscle contraction" -"GO:2000192","negative regulation of fatty acid transport" -"GO:0007227","signal transduction downstream of smoothened" -"GO:1904972","negative regulation of viral translation" -"GO:0018292","molybdenum incorporation via L-cysteinyl molybdopterin" -"GO:0070592","cell wall polysaccharide biosynthetic process" -"GO:0034589","hydroxyproline transport" -"GO:1901113","erythromycin metabolic process" -"GO:0071717","thromboxane transport" -"GO:0021684","cerebellar granular layer formation" -"GO:1902113","nucleotide phosphorylation involved in DNA repair" -"GO:0009214","cyclic nucleotide catabolic process" -"GO:0002381","immunoglobulin production involved in immunoglobulin mediated immune response" -"GO:0055013","cardiac muscle cell development" -"GO:0035852","horizontal cell localization" -"GO:1990864","response to growth hormone-releasing hormone" -"GO:0006584","catecholamine metabolic process" -"GO:0031274","positive regulation of pseudopodium assembly" -"GO:0001714","endodermal cell fate specification" -"GO:0045644","negative regulation of eosinophil differentiation" -"GO:0065004","protein-DNA complex assembly" -"GO:1901291","negative regulation of double-strand break repair via single-strand annealing" -"GO:0099644","protein localization to presynaptic membrane" -"GO:1904959","regulation of cytochrome-c oxidase activity" -"GO:0044857","plasma membrane raft organization" -"GO:0061017","hepatoblast differentiation" -"GO:0051686","establishment of ER localization" -"GO:0043421","anthranilate catabolic process" -"GO:0021990","neural plate formation" -"GO:0010996","response to auditory stimulus" -"GO:1902001","fatty acid transmembrane transport" -"GO:0031028","septation initiation signaling" -"GO:0045972","negative regulation of juvenile hormone secretion" -"GO:1905632","protein localization to euchromatin" -"GO:0018909","dodecyl sulfate metabolic process" -"GO:0042663","regulation of endodermal cell fate specification" -"GO:0032836","glomerular basement membrane development" -"GO:1903485","positive regulation of maintenance of mitotic actomyosin contractile ring localization" -"GO:0090125","cell-cell adhesion involved in synapse maturation" -"GO:0007066","female meiosis sister chromatid cohesion" -"GO:0030703","eggshell formation" -"GO:0070425","negative regulation of nucleotide-binding oligomerization domain containing signaling pathway" -"GO:0033158","regulation of protein import into nucleus, translocation" -"GO:0006790","sulfur compound metabolic process" -"GO:0015912","short-chain fatty acid transport" -"GO:2001049","regulation of tendon cell differentiation" -"GO:0051072","4,6-pyruvylated galactose residue biosynthetic process" -"GO:0061554","ganglion formation" -"GO:0075107","positive regulation by symbiont of host adenylate cyclase activity" -"GO:0030222","eosinophil differentiation" -"GO:0019886","antigen processing and presentation of exogenous peptide antigen via MHC class II" -"GO:0072095","regulation of branch elongation involved in ureteric bud branching" -"GO:0021881","Wnt-activated signaling pathway involved in forebrain neuron fate commitment" -"GO:0006112","energy reserve metabolic process" -"GO:0045006","DNA deamination" -"GO:0061168","regulation of hair follicle placode formation" -"GO:0060261","positive regulation of transcription initiation from RNA polymerase II promoter" -"GO:0050890","cognition" -"GO:0018890","cyanamide metabolic process" -"GO:0048892","lateral line nerve development" -"GO:0060464","lung lobe formation" -"GO:1902373","negative regulation of mRNA catabolic process" -"GO:0036206","regulation of histone gene expression" -"GO:0006386","termination of RNA polymerase III transcription" -"GO:1904750","negative regulation of protein localization to nucleolus" -"GO:0050852","T cell receptor signaling pathway" -"GO:0021566","hypoglossal nerve development" -"GO:1905686","positive regulation of plasma membrane repair" -"GO:0043069","negative regulation of programmed cell death" -"GO:2000173","negative regulation of branching morphogenesis of a nerve" -"GO:0031335","regulation of sulfur amino acid metabolic process" -"GO:0060714","labyrinthine layer formation" -"GO:2000143","negative regulation of DNA-templated transcription, initiation" -"GO:0072594","establishment of protein localization to organelle" -"GO:0015707","nitrite transport" -"GO:0043610","regulation of carbohydrate utilization" -"GO:0031427","response to methotrexate" -"GO:0002369","T cell cytokine production" -"GO:1900169","regulation of glucocorticoid mediated signaling pathway" -"GO:0097324","melanocyte migration" -"GO:2000232","regulation of rRNA processing" -"GO:0060333","interferon-gamma-mediated signaling pathway" -"GO:0031295","T cell costimulation" -"GO:0051681","6-alpha-maltosylglucose catabolic process" -"GO:0051457","maintenance of protein location in nucleus" -"GO:0060348","bone development" -"GO:2000235","regulation of tRNA processing" -"GO:0048513","animal organ development" -"GO:0003290","atrial septum secundum morphogenesis" -"GO:0035847","uterine epithelium development" -"GO:0042076","protein phosphate-linked glycosylation" -"GO:0060971","embryonic heart tube left/right pattern formation" -"GO:1904188","negative regulation of transformation of host cell by virus" -"GO:0075297","negative regulation of ascospore formation" -"GO:0120077","angiogenic sprout fusion" -"GO:1903839","positive regulation of mRNA 3'-UTR binding" -"GO:0048458","floral whorl formation" -"GO:0014023","neural rod formation" -"GO:1903860","negative regulation of dendrite extension" -"GO:0050882","voluntary musculoskeletal movement" -"GO:0006955","immune response" -"GO:0090082","positive regulation of heart induction by negative regulation of canonical Wnt signaling pathway" -"GO:1903901","negative regulation of viral life cycle" -"GO:2000484","positive regulation of interleukin-8 secretion" -"GO:0033673","negative regulation of kinase activity" -"GO:1990659","sequestering of manganese ion" -"GO:0034726","DNA replication-independent nucleosome disassembly" -"GO:0009766","primary charge separation" -"GO:0039021","pronephric glomerulus development" -"GO:0007279","pole cell formation" -"GO:0072384","organelle transport along microtubule" -"GO:0006880","intracellular sequestering of iron ion" -"GO:0090014","leaflet formation" -"GO:0035042","fertilization, exchange of chromosomal proteins" -"GO:0090376","seed trichome differentiation" -"GO:0035764","dorsal motor nucleus of vagus nerve formation" -"GO:0033058","directional locomotion" -"GO:0060368","regulation of Fc receptor mediated stimulatory signaling pathway" -"GO:0060524","dichotomous subdivision of prostate epithelial cord terminal unit" -"GO:0021571","rhombomere 5 development" -"GO:2000371","regulation of DNA topoisomerase (ATP-hydrolyzing) activity" -"GO:0016479","negative regulation of transcription by RNA polymerase I" -"GO:0030709","border follicle cell delamination" -"GO:0048066","developmental pigmentation" -"GO:0032929","negative regulation of superoxide anion generation" -"GO:1905195","regulation of ATPase activity, uncoupled" -"GO:0090017","anterior neural plate formation" -"GO:0045771","negative regulation of autophagosome size" -"GO:0008380","RNA splicing" -"GO:0002077","acrosome matrix dispersal" -"GO:0039520","induction by virus of host autophagy" -"GO:0061130","pancreatic bud formation" -"GO:0071264","positive regulation of translational initiation in response to starvation" -"GO:0007423","sensory organ development" -"GO:1904621","regulation of actin-dependent ATPase activity" -"GO:0032784","regulation of DNA-templated transcription, elongation" -"GO:0099563","modification of synaptic structure" -"GO:0072092","ureteric bud invasion" -"GO:0002332","transitional stage B cell differentiation" -"GO:0035069","larval midgut histolysis" -"GO:0085018","maintenance of symbiont-containing vacuole by host" -"GO:0061931","positive regulation of erythrocyte enucleation" -"GO:1900248","negative regulation of cytoplasmic translational elongation" -"GO:0043371","negative regulation of CD4-positive, alpha-beta T cell differentiation" -"GO:0019081","viral translation" -"GO:0021509","roof plate formation" -"GO:0006719","juvenile hormone catabolic process" -"GO:0000753","cell morphogenesis involved in conjugation with cellular fusion" -"GO:2000210","positive regulation of anoikis" -"GO:0051132","NK T cell activation" -"GO:0007379","segment specification" -"GO:0043466","pyrimidine nucleobase fermentation" -"GO:1903827","regulation of cellular protein localization" -"GO:0007378","amnioserosa formation" -"GO:0071472","cellular response to salt stress" -"GO:0010849","regulation of proton-transporting ATPase activity, rotational mechanism" -"GO:0072409","detection of stimulus involved in meiotic cell cycle checkpoint" -"GO:0090011","Wnt signaling pathway involved in primitive streak formation" -"GO:0021974","trigeminothalamic tract morphogenesis" -"GO:0010830","regulation of myotube differentiation" -"GO:0060294","cilium movement involved in cell motility" -"GO:0032488","Cdc42 protein signal transduction" -"GO:0015565","threonine efflux transmembrane transporter activity" -"GO:0021572","rhombomere 6 development" -"GO:1905212","positive regulation of fibroblast chemotaxis" -"GO:0032425","positive regulation of mismatch repair" -"GO:0030098","lymphocyte differentiation" -"GO:0003315","heart rudiment formation" -"GO:0003291","atrial septum intermedium morphogenesis" -"GO:0048847","adenohypophysis formation" -"GO:0006323","DNA packaging" -"GO:1902397","detection of stimulus involved in meiotic spindle checkpoint" -"GO:0051097","negative regulation of helicase activity" -"GO:0021599","abducens nerve formation" -"GO:0021964","rubrospinal tract morphogenesis" -"GO:0090519","anoxia protection" -"GO:0071338","positive regulation of hair follicle cell proliferation" -"GO:0010998","regulation of translational initiation by eIF2 alpha phosphorylation" -"GO:0033151","V(D)J recombination" -"GO:0030576","Cajal body organization" -"GO:0031382","mating projection assembly" -"GO:0030853","negative regulation of granulocyte differentiation" -"GO:0060881","basal lamina disassembly" -"GO:0044702","single organism reproductive process" -"GO:0034293","sexual sporulation" -"GO:0071511","inactivation of MAPK activity involved in conjugation with cellular fusion" -"GO:0061583","colon epithelial cell chemotaxis" -"GO:1905273","positive regulation of proton-transporting ATP synthase activity, rotational mechanism" -"GO:0090274","positive regulation of somatostatin secretion" -"GO:0032055","negative regulation of translation in response to stress" -"GO:0003363","lamellipodium assembly involved in ameboidal cell migration" -"GO:0032596","protein transport into membrane raft" -"GO:0042438","melanin biosynthetic process" -"GO:0051855","recognition of symbiont" -"GO:0002865","negative regulation of acute inflammatory response to antigenic stimulus" -"GO:0033033","negative regulation of myeloid cell apoptotic process" -"GO:0045813","positive regulation of Wnt signaling pathway, calcium modulating pathway" -"GO:0043419","urea catabolic process" -"GO:0052700","ergothioneine catabolic process" -"GO:0006910","phagocytosis, recognition" -"GO:0035127","post-embryonic limb morphogenesis" -"GO:0044849","estrous cycle" -"GO:0060383","positive regulation of DNA strand elongation" -"GO:0010899","regulation of phosphatidylcholine catabolic process" -"GO:0072431","signal transduction involved in mitotic G1 DNA damage checkpoint" -"GO:0009585","red, far-red light phototransduction" -"GO:0043030","regulation of macrophage activation" -"GO:0051850","acquisition of nutrients from symbiont" -"GO:0000028","ribosomal small subunit assembly" -"GO:0006726","eye pigment biosynthetic process" -"GO:0098756","response to interleukin-21" -"GO:0070200","establishment of protein localization to telomere" -"GO:0060266","negative regulation of respiratory burst involved in inflammatory response" -"GO:0031927","pyridoxamine transmembrane transporter activity" -"GO:0035722","interleukin-12-mediated signaling pathway" -"GO:0097211","cellular response to gonadotropin-releasing hormone" -"GO:1904046","negative regulation of vascular endothelial growth factor production" -"GO:0051937","catecholamine transport" -"GO:2001286","regulation of caveolin-mediated endocytosis" -"GO:0071303","cellular response to vitamin B3" -"GO:0072578","neurotransmitter-gated ion channel clustering" -"GO:1905143","eukaryotic translation initiation factor 2 complex assembly" -"GO:1904037","positive regulation of epithelial cell apoptotic process" -"GO:0045818","negative regulation of glycogen catabolic process" -"GO:1904618","positive regulation of actin binding" -"GO:0071536","RING-like zinc finger domain-mediated complex assembly" -"GO:0006660","phosphatidylserine catabolic process" -"GO:0006777","Mo-molybdopterin cofactor biosynthetic process" -"GO:0061097","regulation of protein tyrosine kinase activity" -"GO:1902451","positive regulation of ATP-dependent DNA helicase activity" -"GO:0061204","paramyosin filament assembly or disassembly" -"GO:0051851","modification by host of symbiont morphology or physiology" -"GO:1990823","response to leukemia inhibitory factor" -"GO:0005300","high-affinity tryptophan transmembrane transporter activity" -"GO:0046454","dimethylsilanediol metabolic process" -"GO:0019752","carboxylic acid metabolic process" -"GO:0034203","glycolipid translocation" -"GO:0097343","ripoptosome assembly" -"GO:0050916","sensory perception of sweet taste" -"GO:0003401","axis elongation" -"GO:0032401","establishment of melanosome localization" -"GO:0050805","negative regulation of synaptic transmission" -"GO:0045379","negative regulation of interleukin-17 biosynthetic process" -"GO:0021771","lateral geniculate nucleus development" -"GO:0002360","T cell lineage commitment" -"GO:0038172","interleukin-33-mediated signaling pathway" -"GO:1905144","response to acetylcholine" -"GO:0008033","tRNA processing" -"GO:1902396","protein localization to bicellular tight junction" -"GO:0070413","trehalose metabolism in response to stress" -"GO:1905935","positive regulation of cell fate determination" -"GO:0051862","translocation of molecules into symbiont" -"GO:1904477","positive regulation of Ras GTPase binding" -"GO:1905774","regulation of DNA helicase activity" -"GO:0007363","positive regulation of terminal gap gene transcription" -"GO:0032870","cellular response to hormone stimulus" -"GO:0098921","retrograde trans-synaptic signaling by endocannabinoid" -"GO:0033484","nitric oxide homeostasis" -"GO:0031296","B cell costimulation" -"GO:0019653","anaerobic purine nucleobase catabolic process" -"GO:0097681","double-strand break repair via alternative nonhomologous end joining" -"GO:0090344","negative regulation of cell aging" -"GO:0035232","germ cell attraction" -"GO:1902569","negative regulation of activation of Janus kinase activity" -"GO:0060968","regulation of gene silencing" -"GO:0010817","regulation of hormone levels" -"GO:0060976","coronary vasculature development" -"GO:0038156","interleukin-3-mediated signaling pathway" -"GO:0032731","positive regulation of interleukin-1 beta production" -"GO:0043314","negative regulation of neutrophil degranulation" -"GO:0046033","AMP metabolic process" -"GO:0051893","regulation of focal adhesion assembly" -"GO:0032000","positive regulation of fatty acid beta-oxidation" -"GO:0090291","negative regulation of osteoclast proliferation" -"GO:0015938","coenzyme A catabolic process" -"GO:0045074","regulation of interleukin-10 biosynthetic process" -"GO:0099614","protein localization to spore cell wall" -"GO:0010717","regulation of epithelial to mesenchymal transition" -"GO:0061569","UDP phosphorylation" -"GO:1903977","positive regulation of glial cell migration" -"GO:0061371","determination of heart left/right asymmetry" -"GO:0006325","chromatin organization" -"GO:0009946","proximal/distal axis specification" -"GO:0030200","heparan sulfate proteoglycan catabolic process" -"GO:0006368","transcription elongation from RNA polymerase II promoter" -"GO:0060644","mammary gland epithelial cell differentiation" -"GO:0009818","defense response to protozoan, incompatible interaction" -"GO:1900220","semaphorin-plexin signaling pathway involved in bone trabecula morphogenesis" -"GO:0070306","lens fiber cell differentiation" -"GO:0032264","IMP salvage" -"GO:1901738","regulation of vitamin A metabolic process" -"GO:0009230","thiamine catabolic process" -"GO:1905441","response to chondroitin 4'-sulfate" -"GO:0071165","GINS complex assembly" -"GO:0043326","chemotaxis to folate" -"GO:0031340","positive regulation of vesicle fusion" -"GO:0061727","methylglyoxal catabolic process to lactate" -"GO:0060556","regulation of vitamin D biosynthetic process" -"GO:0097474","retinal cone cell apoptotic process" -"GO:1903637","negative regulation of protein import into mitochondrial outer membrane" -"GO:0014036","neural crest cell fate specification" -"GO:0048320","axial mesoderm formation" -"GO:0031551","regulation of brain-derived neurotrophic factor-activated receptor activity" -"GO:0010694","positive regulation of alkaline phosphatase activity" -"GO:0097052","L-kynurenine metabolic process" -"GO:0010164","response to cesium ion" -"GO:1904965","regulation of vitamin E biosynthetic process" -"GO:0006499","N-terminal protein myristoylation" -"GO:0051418","microtubule nucleation by microtubule organizing center" -"GO:0019517","L-threonine catabolic process to D-lactate" -"GO:0021797","forebrain anterior/posterior pattern specification" -"GO:0072724","response to 4-nitroquinoline N-oxide" -"GO:2000082","regulation of L-ascorbic acid biosynthetic process" -"GO:0031937","positive regulation of chromatin silencing" -"GO:1900448","regulation of pyrimidine nucleotide biosynthetic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:1903803","L-glutamine import across plasma membrane" -"GO:0021909","regulation of transcription from RNA polymerase II promoter involved in spinal cord anterior-posterior patterning" -"GO:0034613","cellular protein localization" -"GO:1990399","epithelium regeneration" -"GO:0006335","DNA replication-dependent nucleosome assembly" -"GO:1904585","response to putrescine" -"GO:0035394","regulation of chemokine (C-X-C motif) ligand 9 production" -"GO:0090322","regulation of superoxide metabolic process" -"GO:0032725","positive regulation of granulocyte macrophage colony-stimulating factor production" -"GO:0048263","determination of dorsal identity" -"GO:0032869","cellular response to insulin stimulus" -"GO:1901592","negative regulation of double-strand break repair via break-induced replication" -"GO:0080026","response to indolebutyric acid" -"GO:0019266","asparagine biosynthetic process from oxaloacetate" -"GO:0036274","response to lapatinib" -"GO:1905645","negative regulation of FACT complex assembly" -"GO:0006858","extracellular transport" -"GO:0046851","negative regulation of bone remodeling" -"GO:2001275","positive regulation of glucose import in response to insulin stimulus" -"GO:1903107","insulin receptor signaling pathway involved in dauer larval development" -"GO:1904418","regulation of telomeric loop formation" -"GO:0008286","insulin receptor signaling pathway" -"GO:1905367","positive regulation of intralumenal vesicle formation" -"GO:0021560","abducens nerve development" -"GO:1901675","negative regulation of histone H3-K27 acetylation" -"GO:0043182","vacuolar sequestering of sodium ion" -"GO:0045405","regulation of interleukin-5 biosynthetic process" -"GO:1900010","regulation of corticotropin-releasing hormone receptor activity" -"GO:0018955","phenanthrene metabolic process" -"GO:0036145","dendritic cell homeostasis" -"GO:2000054","negative regulation of Wnt signaling pathway involved in dorsal/ventral axis specification" -"GO:0071105","response to interleukin-11" -"GO:0036253","response to amiloride" -"GO:0046137","negative regulation of vitamin metabolic process" -"GO:2000752","regulation of glucosylceramide catabolic process" -"GO:0009799","specification of symmetry" -"GO:1902692","regulation of neuroblast proliferation" -"GO:1900406","regulation of conjugation with cellular fusion by regulation of transcription from RNA polymerase II promoter" -"GO:0051883","killing of cells in other organism involved in symbiotic interaction" -"GO:2001026","regulation of endothelial cell chemotaxis" -"GO:0097281","immune complex formation" -"GO:1900500","regulation of butyryl-CoA catabolic process to butyrate" -"GO:2000147","positive regulation of cell motility" -"GO:0007444","imaginal disc development" -"GO:0090037","positive regulation of protein kinase C signaling" -"GO:0021993","initiation of neural tube closure" -"GO:0051123","RNA polymerase II transcriptional preinitiation complex assembly" -"GO:0014016","neuroblast differentiation" -"GO:0060568","regulation of peptide hormone processing" -"GO:0097094","craniofacial suture morphogenesis" -"GO:0015116","sulfate transmembrane transporter activity" -"GO:0006476","protein deacetylation" -"GO:0036151","phosphatidylcholine acyl-chain remodeling" -"GO:1904488","regulation of reactive oxygen species metabolic process by positive regulation of transcription from RNA polymerase II promoter" -"GO:0042540","hemoglobin catabolic process" -"GO:0003313","heart rudiment development" -"GO:0002070","epithelial cell maturation" -"GO:0090497","mesenchymal cell migration" -"GO:0036016","cellular response to interleukin-3" -"GO:0045921","positive regulation of exocytosis" -"GO:0035846","oviduct epithelium development" -"GO:1901325","response to antimycin A" -"GO:1905307","response to miconazole" -"GO:1905077","negative regulation of interleukin-17 secretion" -"GO:1901622","positive regulation of smoothened signaling pathway involved in dorsal/ventral neural tube patterning" -"GO:0036152","phosphatidylethanolamine acyl-chain remodeling" -"GO:0070623","regulation of thiamine biosynthetic process" -"GO:0071486","cellular response to high light intensity" -"GO:0032776","DNA methylation on cytosine" -"GO:1903351","cellular response to dopamine" -"GO:1904065","G-protein coupled acetylcholine receptor signaling pathway involved in positive regulation of acetylcholine secretion, neurotransmission" -"GO:0072722","response to amitrole" -"GO:0045037","protein import into chloroplast stroma" -"GO:0046401","lipopolysaccharide core region metabolic process" -"GO:0015911","plasma membrane long-chain fatty acid transport" -"GO:0038043","interleukin-5-mediated signaling pathway" -"GO:0002516","B cell deletion" -"GO:1904489","regulation of reactive oxygen species metabolic process by negative regulation of transcription from RNA polymerase II promoter" -"GO:0072726","response to CCCP" -"GO:0021537","telencephalon development" -"GO:1900204","apoptotic process involved in metanephric collecting duct development" -"GO:1904101","response to acadesine" -"GO:0019731","antibacterial humoral response" -"GO:0071643","regulation of chemokine (C-C motif) ligand 4 production" -"GO:0072314","glomerular epithelial cell fate commitment" -"GO:0045725","positive regulation of glycogen biosynthetic process" -"GO:0001700","embryonic development via the syncytial blastoderm" -"GO:0044800","multi-organism membrane fusion" -"GO:0003404","optic vesicle morphogenesis" -"GO:0008643","carbohydrate transport" -"GO:1903093","regulation of protein K48-linked deubiquitination" -"GO:2000778","positive regulation of interleukin-6 secretion" -"GO:0046587","positive regulation of calcium-dependent cell-cell adhesion" -"GO:1903493","response to clopidogrel" -"GO:0003002","regionalization" -"GO:0043619","regulation of transcription from RNA polymerase II promoter in response to oxidative stress" -"GO:0035146","tube fusion" -"GO:0090207","regulation of triglyceride metabolic process" -"GO:0061071","urethra epithelium development" -"GO:0060268","negative regulation of respiratory burst" -"GO:1904402","response to nocodazole" -"GO:0003257","positive regulation of transcription from RNA polymerase II promoter involved in myocardial precursor cell differentiation" -"GO:1900205","apoptotic process involved in metanephric nephron tubule development" -"GO:0061074","regulation of neural retina development" -"GO:1900181","negative regulation of protein localization to nucleus" -"GO:0048340","paraxial mesoderm morphogenesis" -"GO:0097755","positive regulation of blood vessel diameter" -"GO:0051090","regulation of DNA binding transcription factor activity" -"GO:2001180","negative regulation of interleukin-10 secretion" -"GO:0042692","muscle cell differentiation" -"GO:0002335","mature B cell differentiation" -"GO:0002445","type II hypersensitivity" -"GO:1901987","regulation of cell cycle phase transition" -"GO:0098773","skin epidermis development" -"GO:0097282","immunoglobulin-mediated neutralization" -"GO:0038129","ERBB3 signaling pathway" -"GO:1990519","pyrimidine nucleotide import into mitochondrion" -"GO:0048512","circadian behavior" -"GO:0032775","DNA methylation on adenine" -"GO:0106005","RNA 5'-cap (guanine-N7)-methylation" -"GO:0060235","lens induction in camera-type eye" -"GO:0045444","fat cell differentiation" -"GO:1900155","negative regulation of bone trabecula formation" -"GO:1903845","negative regulation of cellular response to transforming growth factor beta stimulus" -"GO:0097473","retinal rod cell apoptotic process" -"GO:1904481","response to tetrahydrofolate" -"GO:2000359","regulation of binding of sperm to zona pellucida" -"GO:0001802","type III hypersensitivity" -"GO:0048351","negative regulation of paraxial mesodermal cell fate specification" -"GO:0090020","regulation of transcription involved in posterior neural plate formation" -"GO:1902491","negative regulation of sperm capacitation" -"GO:0060597","regulation of transcription from RNA polymerase II promoter involved in mammary gland formation" -"GO:0002349","histamine production involved in inflammatory response" -"GO:0033037","polysaccharide localization" -"GO:0055113","epiboly involved in gastrulation with mouth forming second" -"GO:2000092","positive regulation of mesonephric glomerular mesangial cell proliferation" -"GO:0061108","seminal vesicle epithelium development" -"GO:0015986","ATP synthesis coupled proton transport" -"GO:0061837","neuropeptide processing" -"GO:0043649","dicarboxylic acid catabolic process" -"GO:0090076","relaxation of skeletal muscle" -"GO:1903465","positive regulation of mitotic cell cycle DNA replication" -"GO:0032786","positive regulation of DNA-templated transcription, elongation" -"GO:0030330","DNA damage response, signal transduction by p53 class mediator" -"GO:0045487","gibberellin catabolic process" -"GO:0002155","regulation of thyroid hormone mediated signaling pathway" -"GO:1903322","positive regulation of protein modification by small protein conjugation or removal" -"GO:0002906","negative regulation of mature B cell apoptotic process" -"GO:0009246","enterobacterial common antigen biosynthetic process" -"GO:0043157","response to cation stress" -"GO:0110076","negative regulation of ferroptosis" -"GO:0097173","N-acetylmuramic acid catabolic process" -"GO:2000536","negative regulation of entry of bacterium into host cell" -"GO:0061041","regulation of wound healing" -"GO:0010739","positive regulation of protein kinase A signaling" -"GO:0018218","peptidyl-cysteine phosphorylation" -"GO:1905685","negative regulation of plasma membrane repair" -"GO:1990736","regulation of vascular smooth muscle cell membrane depolarization" -"GO:1900540","fumonisin catabolic process" -"GO:1905114","cell surface receptor signaling pathway involved in cell-cell signaling" -"GO:0019061","uncoating of virus" -"GO:0090198","negative regulation of chemokine secretion" -"GO:0007569","cell aging" -"GO:1902951","negative regulation of dendritic spine maintenance" -"GO:0019588","anaerobic glycerol catabolic process" -"GO:2000222","positive regulation of pseudohyphal growth" -"GO:2000854","positive regulation of corticosterone secretion" -"GO:1903390","positive regulation of synaptic vesicle uncoating" -"GO:1990262","anti-Mullerian hormone signaling pathway" -"GO:0042223","interleukin-3 biosynthetic process" -"GO:0098630","aggregation of unicellular organisms" -"GO:1903346","positive regulation of protein polyglycylation" -"GO:0007616","long-term memory" -"GO:1905438","non-canonical Wnt signaling pathway involved in midbrain dopaminergic neuron differentiation" -"GO:0021666","rhombomere 5 formation" -"GO:0035699","T-helper 17 cell extravasation" -"GO:1905038","regulation of membrane lipid metabolic process" -"GO:0016321","female meiosis chromosome segregation" -"GO:1902622","regulation of neutrophil migration" -"GO:1901292","nucleoside phosphate catabolic process" -"GO:1902120","negative regulation of meiotic spindle elongation" -"GO:0010867","positive regulation of triglyceride biosynthetic process" -"GO:0034772","histone H4-K20 dimethylation" -"GO:0006680","glucosylceramide catabolic process" -"GO:0051169","nuclear transport" -"GO:1902430","negative regulation of amyloid-beta formation" -"GO:0009397","folic acid-containing compound catabolic process" -"GO:0021859","pyramidal neuron differentiation" -"GO:0031860","telomeric 3' overhang formation" -"GO:1905690","nucleus disassembly" -"GO:0072416","signal transduction involved in spindle checkpoint" -"GO:0048146","positive regulation of fibroblast proliferation" -"GO:0045689","negative regulation of antipodal cell differentiation" -"GO:1901146","mesenchymal cell apoptotic process involved in mesonephric nephron morphogenesis" -"GO:0061341","non-canonical Wnt signaling pathway involved in heart development" -"GO:0035587","purinergic receptor signaling pathway" -"GO:0007634","optokinetic behavior" -"GO:0060379","cardiac muscle cell myoblast differentiation" -"GO:0042369","vitamin D catabolic process" -"GO:0061078","positive regulation of prostaglandin secretion involved in immune response" -"GO:0042308","negative regulation of protein import into nucleus" -"GO:0000718","nucleotide-excision repair, DNA damage removal" -"GO:1902938","regulation of intracellular calcium activated chloride channel activity" -"GO:1902657","protein localization to prospore membrane" -"GO:1903078","positive regulation of protein localization to plasma membrane" -"GO:0032730","positive regulation of interleukin-1 alpha production" -"GO:1903646","positive regulation of chaperone-mediated protein folding" -"GO:0042102","positive regulation of T cell proliferation" -"GO:1905314","semi-lunar valve development" -"GO:0032760","positive regulation of tumor necrosis factor production" -"GO:2000065","negative regulation of cortisol biosynthetic process" -"GO:0072506","trivalent inorganic anion homeostasis" -"GO:0010733","positive regulation of protein glutathionylation" -"GO:0031648","protein destabilization" -"GO:0032811","negative regulation of epinephrine secretion" -"GO:0001516","prostaglandin biosynthetic process" -"GO:0032348","negative regulation of aldosterone biosynthetic process" -"GO:0039698","polyadenylation of viral mRNA by polymerase stuttering" -"GO:1903380","positive regulation of mitotic chromosome condensation" -"GO:0061992","ATP-dependent chaperone mediated protein folding" -"GO:0010760","negative regulation of macrophage chemotaxis" -"GO:0061057","peptidoglycan recognition protein signaling pathway" -"GO:0097062","dendritic spine maintenance" -"GO:0070885","negative regulation of calcineurin-NFAT signaling cascade" -"GO:0030520","intracellular estrogen receptor signaling pathway" -"GO:1901067","ferulate catabolic process" -"GO:1990507","ATP-independent chaperone mediated protein folding" -"GO:0050918","positive chemotaxis" -"GO:0002841","negative regulation of T cell mediated immune response to tumor cell" -"GO:1903488","negative regulation of lactation" -"GO:0061098","positive regulation of protein tyrosine kinase activity" -"GO:0010831","positive regulation of myotube differentiation" -"GO:0050900","leukocyte migration" -"GO:0021982","pineal gland development" -"GO:0046007","negative regulation of activated T cell proliferation" -"GO:1904808","positive regulation of protein oxidation" -"GO:0031848","protection from non-homologous end joining at telomere" -"GO:0036164","cell-abiotic substrate adhesion" -"GO:0006303","double-strand break repair via nonhomologous end joining" -"GO:0021988","olfactory lobe development" -"GO:0060753","regulation of mast cell chemotaxis" -"GO:2000636","positive regulation of primary miRNA processing" -"GO:0071280","cellular response to copper ion" -"GO:0030844","positive regulation of intermediate filament depolymerization" -"GO:0036073","perichondral ossification" -"GO:0014808","release of sequestered calcium ion into cytosol by sarcoplasmic reticulum" -"GO:1901523","icosanoid catabolic process" -"GO:0060963","positive regulation of ribosomal protein gene transcription by RNA polymerase II" -"GO:0051615","histamine uptake" -"GO:0071157","negative regulation of cell cycle arrest" -"GO:0098506","polynucleotide 3' dephosphorylation" -"GO:0042322","negative regulation of circadian sleep/wake cycle, REM sleep" -"GO:0048785","hatching gland development" -"GO:0007035","vacuolar acidification" -"GO:1904123","positive regulation of fatty acid beta-oxidation by serotonin receptor signaling pathway" -"GO:1900577","gerfelin catabolic process" -"GO:0033626","positive regulation of integrin activation by cell surface receptor linked signal transduction" -"GO:0034166","toll-like receptor 10 signaling pathway" -"GO:2000706","negative regulation of dense core granule biogenesis" -"GO:2001033","negative regulation of double-strand break repair via nonhomologous end joining" -"GO:1901729","monensin A catabolic process" -"GO:0031666","positive regulation of lipopolysaccharide-mediated signaling pathway" -"GO:0007526","larval somatic muscle development" -"GO:0008050","female courtship behavior" -"GO:0046334","octopamine catabolic process" -"GO:0010906","regulation of glucose metabolic process" -"GO:0043433","negative regulation of DNA binding transcription factor activity" -"GO:0006659","phosphatidylserine biosynthetic process" -"GO:0003012","muscle system process" -"GO:0009871","jasmonic acid and ethylene-dependent systemic resistance, ethylene mediated signaling pathway" -"GO:0009805","coumarin biosynthetic process" -"GO:0019622","3-(3-hydroxy)phenylpropionate catabolic process" -"GO:0032824","negative regulation of natural killer cell differentiation" -"GO:0050715","positive regulation of cytokine secretion" -"GO:0042862","achromobactin catabolic process" -"GO:2000853","negative regulation of corticosterone secretion" -"GO:0001924","regulation of B-1 B cell differentiation" -"GO:0023035","CD40 signaling pathway" -"GO:1900356","positive regulation of methanofuran metabolic process" -"GO:1902256","regulation of apoptotic process involved in outflow tract morphogenesis" -"GO:0090238","positive regulation of arachidonic acid secretion" -"GO:0038184","cell surface bile acid receptor signaling pathway" -"GO:0031639","plasminogen activation" -"GO:0019564","aerobic glycerol catabolic process" -"GO:0060792","sweat gland development" -"GO:2000740","negative regulation of mesenchymal stem cell differentiation" -"GO:0090305","nucleic acid phosphodiester bond hydrolysis" -"GO:1905664","regulation of calcium ion import across plasma membrane" -"GO:0046154","rhodopsin metabolic process" -"GO:0090323","prostaglandin secretion involved in immune response" -"GO:0052702","cellular modified histidine catabolic process" -"GO:0002257","negative regulation of kinin cascade" -"GO:0030253","protein secretion by the type I secretion system" -"GO:1902166","negative regulation of intrinsic apoptotic signaling pathway in response to DNA damage by p53 class mediator" -"GO:2000293","negative regulation of defecation" -"GO:0030890","positive regulation of B cell proliferation" -"GO:0010825","positive regulation of centrosome duplication" -"GO:1901267","cephalosporin C catabolic process" -"GO:0016233","telomere capping" -"GO:0014909","smooth muscle cell migration" -"GO:0070207","protein homotrimerization" -"GO:0000075","cell cycle checkpoint" -"GO:0043518","negative regulation of DNA damage response, signal transduction by p53 class mediator" -"GO:0030953","astral microtubule organization" -"GO:2000733","regulation of glial cell-derived neurotrophic factor receptor signaling pathway involved in ureteric bud formation" -"GO:0072352","tricarboxylic acid catabolic process" -"GO:1905744","regulation of mRNA cis splicing, via spliceosome" -"GO:0071570","cement gland development" -"GO:0050972","detection of mechanical stimulus involved in echolocation" -"GO:1905397","activated CD8-positive, alpha-beta T cell apoptotic process" -"GO:0070459","prolactin secretion" -"GO:0061882","negative regulation of anterograde axonal transport of mitochondrion" -"GO:0099018","restriction-modification system evasion by virus" -"GO:0031113","regulation of microtubule polymerization" -"GO:0042440","pigment metabolic process" -"GO:1905464","positive regulation of DNA duplex unwinding" -"GO:0006013","mannose metabolic process" -"GO:0061060","negative regulation of peptidoglycan recognition protein signaling pathway" -"GO:0048002","antigen processing and presentation of peptide antigen" -"GO:0045736","negative regulation of cyclin-dependent protein serine/threonine kinase activity" -"GO:0002021","response to dietary excess" -"GO:2000545","negative regulation of endothelial cell chemotaxis to fibroblast growth factor" -"GO:0022893","low-affinity tryptophan transmembrane transporter activity" -"GO:0002828","regulation of type 2 immune response" -"GO:0061183","regulation of dermatome development" -"GO:1904738","vascular associated smooth muscle cell migration" -"GO:0072334","UDP-galactose transmembrane transport" -"GO:0045945","positive regulation of transcription by RNA polymerase III" -"GO:0035986","senescence-associated heterochromatin focus assembly" -"GO:0010912","positive regulation of isomerase activity" -"GO:0031572","G2 DNA damage checkpoint" -"GO:0018331","enzyme active site formation via O-phospho-L-serine" -"GO:1901902","tyrocidine metabolic process" -"GO:0006876","cellular cadmium ion homeostasis" -"GO:0010735","positive regulation of transcription via serum response element binding" -"GO:0007492","endoderm development" -"GO:1904922","positive regulation of MAPK cascade involved in axon regeneration" -"GO:0007400","neuroblast fate determination" -"GO:0060134","prepulse inhibition" -"GO:0033377","maintenance of protein location in T cell secretory granule" -"GO:1902824","positive regulation of late endosome to lysosome transport" -"GO:0001705","ectoderm formation" -"GO:0035816","renal water absorption involved in negative regulation of urine volume" -"GO:0045678","positive regulation of R7 cell differentiation" -"GO:0003278","apoptotic process involved in heart morphogenesis" -"GO:0099514","synaptic vesicle cytoskeletal transport" -"GO:0015520","tetracycline:proton antiporter activity" -"GO:0043686","co-translational protein modification" -"GO:0030168","platelet activation" -"GO:0033520","phytol biosynthetic process" -"GO:2000551","regulation of T-helper 2 cell cytokine production" -"GO:0035669","TRAM-dependent toll-like receptor 4 signaling pathway" -"GO:1904911","negative regulation of establishment of RNA localization to telomere" -"GO:0006477","protein sulfation" -"GO:0072395","signal transduction involved in cell cycle checkpoint" -"GO:0006666","3-keto-sphinganine metabolic process" -"GO:0051361","peptide cross-linking via L-lysine 5-imidazolinone glycine" -"GO:1990801","protein phosphorylation involved in mitotic spindle assembly" -"GO:1904118","regulation of otic vesicle morphogenesis" -"GO:0090199","regulation of release of cytochrome c from mitochondria" -"GO:2001203","positive regulation of transforming growth factor-beta secretion" -"GO:0001954","positive regulation of cell-matrix adhesion" -"GO:0097118","neuroligin clustering involved in postsynaptic membrane assembly" -"GO:1905652","negative regulation of artery morphogenesis" -"GO:0045605","negative regulation of epidermal cell differentiation" -"GO:0032482","Rab protein signal transduction" -"GO:0001832","blastocyst growth" -"GO:2000239","negative regulation of tRNA export from nucleus" -"GO:0009937","regulation of gibberellic acid mediated signaling pathway" -"GO:0090122","cholesterol ester hydrolysis involved in cholesterol transport" -"GO:0072245","metanephric glomerular parietal epithelial cell differentiation" -"GO:0071282","cellular response to iron(II) ion" -"GO:0044237","cellular metabolic process" -"GO:1905749","regulation of endosome to plasma membrane protein transport" -"GO:1901275","tartrate metabolic process" -"GO:1904391","response to ciliary neurotrophic factor" -"GO:0034393","positive regulation of smooth muscle cell apoptotic process" -"GO:1905425","negative regulation of Wnt-mediated midbrain dopaminergic neuron differentiation" -"GO:0061216","regulation of transcription from RNA polymerase II promoter involved in mesonephros development" -"GO:0019748","secondary metabolic process" -"GO:2000463","positive regulation of excitatory postsynaptic potential" -"GO:0044315","protein secretion by the type VII secretion system" -"GO:1902085","fumagillin catabolic process" -"GO:0015491","cation:cation antiporter activity" -"GO:0060607","cell-cell adhesion involved in sealing an epithelial fold" -"GO:0061386","closure of optic fissure" -"GO:0021782","glial cell development" -"GO:0072248","metanephric glomerular visceral epithelial cell differentiation" -"GO:0008645","hexose transmembrane transport" -"GO:0002642","positive regulation of immunoglobulin biosynthetic process" -"GO:2001232","positive regulation of protein localization to prospore membrane" -"GO:0044033","multi-organism metabolic process" -"GO:2000774","positive regulation of cellular senescence" -"GO:0086071","atrial cardiac muscle cell-AV node cell adhesion involved in cell communication" -"GO:0042666","negative regulation of ectodermal cell fate specification" -"GO:0099580","ion antiporter activity involved in regulation of postsynaptic membrane potential" -"GO:0035352","NAD transmembrane transport" -"GO:1902421","hydrogen metabolic process" -"GO:0048934","peripheral nervous system neuron differentiation" -"GO:0061987","negative regulation of transcription from RNA polymerase II promoter by glucose" -"GO:0001835","blastocyst hatching" -"GO:0014894","response to denervation involved in regulation of muscle adaptation" -"GO:0099520","ion antiporter activity involved in regulation of presynaptic membrane potential" -"GO:0071704","organic substance metabolic process" -"GO:2000328","regulation of T-helper 17 cell lineage commitment" -"GO:0045062","extrathymic T cell selection" -"GO:0045600","positive regulation of fat cell differentiation" -"GO:0032632","interleukin-3 production" -"GO:1902045","negative regulation of Fas signaling pathway" -"GO:1903105","negative regulation of insulin receptor signaling pathway involved in determination of adult lifespan" -"GO:1990853","histone H2A SQE motif phosphorylation" -"GO:0061178","regulation of insulin secretion involved in cellular response to glucose stimulus" -"GO:1905933","regulation of cell fate determination" -"GO:0060864","positive regulation of floral organ abscission by small GTPase mediated signal transduction" -"GO:0035479","angioblast cell migration from lateral mesoderm to midline" -"GO:0036475","neuron death in response to oxidative stress" -"GO:0043551","regulation of phosphatidylinositol 3-kinase activity" -"GO:0061253","mesonephric glomerular parietal epithelial cell differentiation" -"GO:1903434","negative regulation of constitutive secretory pathway" -"GO:2000838","negative regulation of androstenedione secretion" -"GO:0050703","interleukin-1 alpha secretion" -"GO:0099017","maintenance of protein localization at cell tip" -"GO:2000865","negative regulation of estradiol secretion" -"GO:0003342","proepicardium development" -"GO:0023015","signal transduction by cis-phosphorylation" -"GO:0010792","DNA double-strand break processing involved in repair via single-strand annealing" -"GO:0032623","interleukin-2 production" -"GO:0006817","phosphate ion transport" -"GO:0051891","positive regulation of cardioblast differentiation" -"GO:2000111","positive regulation of macrophage apoptotic process" -"GO:0051154","negative regulation of striated muscle cell differentiation" -"GO:0034765","regulation of ion transmembrane transport" -"GO:0010456","cell proliferation in dorsal spinal cord" -"GO:1902875","regulation of embryonic pattern specification" -"GO:0061875","negative regulation of hepatic stellate cell contraction" -"GO:0072658","maintenance of protein location in membrane" -"GO:0000731","DNA synthesis involved in DNA repair" -"GO:0086074","Purkinje myocyte-ventricular cardiac muscle cell adhesion involved in cell communication" -"GO:2000821","regulation of grooming behavior" -"GO:0030514","negative regulation of BMP signaling pathway" -"GO:0042326","negative regulation of phosphorylation" -"GO:0031631","negative regulation of synaptic vesicle fusion to presynaptic active zone membrane" -"GO:0034108","positive regulation of erythrocyte clearance" -"GO:0021682","nerve maturation" -"GO:0050678","regulation of epithelial cell proliferation" -"GO:0038002","endocrine signaling" -"GO:0003402","planar cell polarity pathway involved in axis elongation" -"GO:0009056","catabolic process" -"GO:0090410","malonate catabolic process" -"GO:0072069","DCT cell differentiation" -"GO:0035332","positive regulation of hippo signaling" -"GO:0003112","positive regulation of heart rate by neuronal epinephrine" -"GO:0032065","cortical protein anchoring" -"GO:0021956","central nervous system interneuron axonogenesis" -"GO:0007528","neuromuscular junction development" -"GO:0100057","regulation of phenotypic switching by transcription from RNA polymerase II promoter" -"GO:0040002","collagen and cuticulin-based cuticle development" -"GO:1905420","vascular smooth muscle cell differentiation involved in phenotypic switching" -"GO:0034959","endothelin maturation" -"GO:0061190","regulation of sclerotome development" -"GO:1904185","equatorial microtubule organizing center assembly" -"GO:0044486","modulation of transmission of nerve impulse in other organism" -"GO:0002279","mast cell activation involved in immune response" -"GO:0090129","positive regulation of synapse maturation" -"GO:1905127","negative regulation of axo-dendritic protein transport" -"GO:0051709","regulation of killing of cells of other organism" -"GO:0035893","negative regulation of platelet aggregation in other organism" -"GO:0003168","Purkinje myocyte differentiation" -"GO:0043132","NAD transport" -"GO:1903358","regulation of Golgi organization" -"GO:0071980","cell surface adhesin-mediated gliding motility" -"GO:0043516","regulation of DNA damage response, signal transduction by p53 class mediator" -"GO:0007269","neurotransmitter secretion" -"GO:0010453","regulation of cell fate commitment" -"GO:1903996","negative regulation of non-membrane spanning protein tyrosine kinase activity" -"GO:0006172","ADP biosynthetic process" -"GO:0140125","thiamine import across plasma membrane" -"GO:2000255","negative regulation of male germ cell proliferation" -"GO:0030099","myeloid cell differentiation" -"GO:0044710","single-organism metabolic process" -"GO:0002309","T cell proliferation involved in immune response" -"GO:0010466","negative regulation of peptidase activity" -"GO:1900020","positive regulation of protein kinase C activity" -"GO:1904429","regulation of t-circle formation" -"GO:0061481","response to TNF agonist" -"GO:1990090","cellular response to nerve growth factor stimulus" -"GO:0000725","recombinational repair" -"GO:0051415","microtubule nucleation by interphase microtubule organizing center" -"GO:0050803","regulation of synapse structure or activity" -"GO:0071340","skeletal muscle acetylcholine-gated channel clustering" -"GO:0097350","neutrophil clearance" -"GO:0009373","regulation of transcription by pheromones" -"GO:1990882","rRNA acetylation" -"GO:0040038","polar body extrusion after meiotic divisions" -"GO:0086029","Purkinje myocyte to ventricular cardiac muscle cell signaling" -"GO:0042327","positive regulation of phosphorylation" -"GO:0014809","regulation of skeletal muscle contraction by regulation of release of sequestered calcium ion" -"GO:1990962","drug transport across blood-brain barrier" -"GO:0043622","cortical microtubule organization" -"GO:0019638","6-hydroxycineole metabolic process" -"GO:1905029","positive regulation of membrane depolarization during AV node cell action potential" -"GO:0018120","peptidyl-arginine ADP-ribosylation" -"GO:1901151","vistamycin catabolic process" -"GO:0080029","cellular response to boron-containing substance levels" -"GO:0065002","intracellular protein transmembrane transport" -"GO:0006203","dGTP catabolic process" -"GO:0060326","cell chemotaxis" -"GO:1900461","positive regulation of pseudohyphal growth by positive regulation of transcription from RNA polymerase II promoter" -"GO:0070588","calcium ion transmembrane transport" -"GO:0008088","axo-dendritic transport" -"GO:0048562","embryonic organ morphogenesis" -"GO:0051702","interaction with symbiont" -"GO:0048630","skeletal muscle tissue growth" -"GO:0031547","brain-derived neurotrophic factor receptor signaling pathway" -"GO:0035822","gene conversion" -"GO:0071476","cellular hypotonic response" -"GO:0090043","regulation of tubulin deacetylation" -"GO:1902037","negative regulation of hematopoietic stem cell differentiation" -"GO:0018123","peptidyl-cysteine ADP-ribosylation" -"GO:0001826","inner cell mass cell differentiation" -"GO:0071651","positive regulation of chemokine (C-C motif) ligand 5 production" -"GO:0045595","regulation of cell differentiation" -"GO:0010430","fatty acid omega-oxidation" -"GO:0036168","filamentous growth of a population of unicellular organisms in response to heat" -"GO:0044818","mitotic G2/M transition checkpoint" -"GO:0016358","dendrite development" -"GO:0010959","regulation of metal ion transport" -"GO:0050982","detection of mechanical stimulus" -"GO:0014835","myoblast differentiation involved in skeletal muscle regeneration" -"GO:0001552","ovarian follicle atresia" -"GO:0001967","suckling behavior" -"GO:0060225","positive regulation of retinal rod cell fate commitment" -"GO:0048009","insulin-like growth factor receptor signaling pathway" -"GO:1903533","regulation of protein targeting" -"GO:0034670","chemotaxis to arachidonic acid" -"GO:0045665","negative regulation of neuron differentiation" -"GO:0046395","carboxylic acid catabolic process" -"GO:0035358","regulation of peroxisome proliferator activated receptor signaling pathway" -"GO:0033690","positive regulation of osteoblast proliferation" -"GO:0051924","regulation of calcium ion transport" -"GO:0035711","T-helper 1 cell activation" -"GO:0043124","negative regulation of I-kappaB kinase/NF-kappaB signaling" -"GO:0051106","positive regulation of DNA ligation" -"GO:0051898","negative regulation of protein kinase B signaling" -"GO:1901771","daunorubicin biosynthetic process" -"GO:0061077","chaperone-mediated protein folding" -"GO:0060465","pharynx development" -"GO:0042660","positive regulation of cell fate specification" -"GO:0031401","positive regulation of protein modification process" -"GO:2000340","positive regulation of chemokine (C-X-C motif) ligand 1 production" -"GO:0072308","negative regulation of metanephric nephron tubule epithelial cell differentiation" -"GO:0002265","astrocyte activation involved in immune response" -"GO:0071711","basement membrane organization" -"GO:0030103","vasopressin secretion" -"GO:0002024","diet induced thermogenesis" -"GO:0046626","regulation of insulin receptor signaling pathway" -"GO:0046458","hexadecanal metabolic process" -"GO:0045063","T-helper 1 cell differentiation" -"GO:1905414","negative regulation of dense core granule exocytosis" -"GO:0047484","regulation of response to osmotic stress" -"GO:0002842","positive regulation of T cell mediated immune response to tumor cell" -"GO:0018312","peptidyl-serine ADP-ribosylation" -"GO:0010992","ubiquitin recycling" -"GO:0048143","astrocyte activation" -"GO:0070172","positive regulation of tooth mineralization" -"GO:0035456","response to interferon-beta" -"GO:0035825","homologous recombination" -"GO:0001773","myeloid dendritic cell activation" -"GO:0050881","musculoskeletal movement" -"GO:0038128","ERBB2 signaling pathway" -"GO:0033108","mitochondrial respiratory chain complex assembly" -"GO:0044240","multicellular organismal lipid catabolic process" -"GO:0045874","positive regulation of sevenless signaling pathway" -"GO:0030801","positive regulation of cyclic nucleotide metabolic process" -"GO:0008359","regulation of bicoid mRNA localization" -"GO:0046434","organophosphate catabolic process" -"GO:0019391","glucuronoside catabolic process" -"GO:0090630","activation of GTPase activity" -"GO:0060023","soft palate development" -"GO:1904390","cone retinal bipolar cell differentiation" -"GO:0000910","cytokinesis" -"GO:0032400","melanosome localization" -"GO:0006313","transposition, DNA-mediated" -"GO:0007176","regulation of epidermal growth factor-activated receptor activity" -"GO:0019444","tryptophan catabolic process to catechol" -"GO:0016444","somatic cell DNA recombination" -"GO:0034644","cellular response to UV" -"GO:0051611","regulation of serotonin uptake" -"GO:0060844","arterial endothelial cell fate commitment" -"GO:0038127","ERBB signaling pathway" -"GO:0010288","response to lead ion" -"GO:1902941","regulation of voltage-gated chloride channel activity" -"GO:0045721","negative regulation of gluconeogenesis" -"GO:1905237","response to cyclosporin A" -"GO:0070512","positive regulation of histone H4-K20 methylation" -"GO:0030100","regulation of endocytosis" -"GO:0043951","negative regulation of cAMP-mediated signaling" -"GO:0050891","multicellular organismal water homeostasis" -"GO:0002484","antigen processing and presentation of endogenous peptide antigen via MHC class I via ER pathway" -"GO:0043271","negative regulation of ion transport" -"GO:1903591","negative regulation of lysozyme activity" -"GO:0070153","mitochondrial leucyl-tRNA aminoacylation" -"GO:0003354","negative regulation of cilium movement" -"GO:1904478","regulation of intestinal absorption" -"GO:0042538","hyperosmotic salinity response" -"GO:0060602","branch elongation of an epithelium" -"GO:0061582","intestinal epithelial cell migration" -"GO:0010748","negative regulation of plasma membrane long-chain fatty acid transport" -"GO:0045108","regulation of intermediate filament polymerization or depolymerization" -"GO:0051321","meiotic cell cycle" -"GO:0006919","activation of cysteine-type endopeptidase activity involved in apoptotic process" -"GO:0019441","tryptophan catabolic process to kynurenine" -"GO:0015865","purine nucleotide transport" -"GO:0060351","cartilage development involved in endochondral bone morphogenesis" -"GO:0010952","positive regulation of peptidase activity" -"GO:0015077","monovalent inorganic cation transmembrane transporter activity" -"GO:0002840","regulation of T cell mediated immune response to tumor cell" -"GO:0006878","cellular copper ion homeostasis" -"GO:0018424","peptidyl-glutamic acid poly-ADP-ribosylation" -"GO:0071874","cellular response to norepinephrine stimulus" -"GO:0031117","positive regulation of microtubule depolymerization" -"GO:0050829","defense response to Gram-negative bacterium" -"GO:0002115","store-operated calcium entry" -"GO:0032430","positive regulation of phospholipase A2 activity" -"GO:0043491","protein kinase B signaling" -"GO:1903430","negative regulation of cell maturation" -"GO:0044061","modulation by symbiont of host excretion" -"GO:0009896","positive regulation of catabolic process" -"GO:0006873","cellular ion homeostasis" -"GO:1904963","regulation of phytol biosynthetic process" -"GO:0035565","regulation of pronephros size" -"GO:0046284","anthocyanin-containing compound catabolic process" -"GO:0007020","microtubule nucleation" -"GO:1990963","establishment of blood-retinal barrier" -"GO:0007317","regulation of pole plasm oskar mRNA localization" -"GO:1901189","positive regulation of ephrin receptor signaling pathway" -"GO:0043277","apoptotic cell clearance" -"GO:0045458","recombination within rDNA repeats" -"GO:0034445","negative regulation of plasma lipoprotein oxidation" -"GO:0021969","corticospinal neuron axon guidance through the cerebral peduncle" -"GO:0045931","positive regulation of mitotic cell cycle" -"GO:1901557","response to fenofibrate" -"GO:2000829","negative regulation of parathyroid hormone secretion" -"GO:0036092","phosphatidylinositol-3-phosphate biosynthetic process" -"GO:0055007","cardiac muscle cell differentiation" -"GO:1905943","negative regulation of formation of growth cone in injured axon" -"GO:0043215","daunorubicin transport" -"GO:1901033","positive regulation of response to reactive oxygen species" -"GO:0002643","regulation of tolerance induction" -"GO:1900193","regulation of oocyte maturation" -"GO:0016136","saponin catabolic process" -"GO:0065003","protein-containing complex assembly" -"GO:0097101","blood vessel endothelial cell fate specification" -"GO:0016239","positive regulation of macroautophagy" -"GO:0031122","cytoplasmic microtubule organization" -"GO:1905235","response to quercetin" -"GO:1990535","neuron projection maintenance" -"GO:0061326","renal tubule development" -"GO:1900273","positive regulation of long-term synaptic potentiation" -"GO:0051928","positive regulation of calcium ion transport" -"GO:0060856","establishment of blood-brain barrier" -"GO:0010977","negative regulation of neuron projection development" -"GO:0090315","negative regulation of protein targeting to membrane" -"GO:0060295","regulation of cilium movement involved in cell motility" -"GO:0061211","mesonephric collecting duct development" -"GO:0010826","negative regulation of centrosome duplication" -"GO:0071642","positive regulation of macrophage inflammatory protein 1 alpha production" -"GO:0032007","negative regulation of TOR signaling" -"GO:0002028","regulation of sodium ion transport" -"GO:0010907","positive regulation of glucose metabolic process" -"GO:0009914","hormone transport" -"GO:0014067","negative regulation of phosphatidylinositol 3-kinase signaling" -"GO:0030649","aminoglycoside antibiotic catabolic process" -"GO:1903444","negative regulation of brown fat cell differentiation" -"GO:1901186","positive regulation of ERBB signaling pathway" -"GO:0061765","modulation by virus of host NIK/NF-kappaB signaling" -"GO:0003409","optic cup structural organization" -"GO:1901228","positive regulation of transcription from RNA polymerase II promoter involved in heart development" -"GO:0006487","protein N-linked glycosylation" -"GO:1901120","tobramycin catabolic process" -"GO:0031539","positive regulation of anthocyanin metabolic process" -"GO:0045651","positive regulation of macrophage differentiation" -"GO:0071477","cellular hypotonic salinity response" -"GO:1900103","positive regulation of endoplasmic reticulum unfolded protein response" -"GO:0033577","protein glycosylation in endoplasmic reticulum" -"GO:0045054","constitutive secretory pathway" -"GO:1903940","negative regulation of TORC2 signaling" -"GO:0031496","positive regulation of mating type switching" -"GO:0048884","neuromast development" -"GO:0010800","positive regulation of peptidyl-threonine phosphorylation" -"GO:1905233","response to codeine" -"GO:0030178","negative regulation of Wnt signaling pathway" -"GO:0061890","positive regulation of astrocyte activation" -"GO:0002487","antigen processing and presentation of endogenous peptide antigen via MHC class I via endolysosomal pathway" -"GO:0051298","centrosome duplication" -"GO:0044091","membrane biogenesis" -"GO:0033277","abortive mitotic cell cycle" -"GO:1900116","extracellular negative regulation of signal transduction" -"GO:0039612","modulation by virus of host protein phosphorylation" -"GO:1901757","butirosin catabolic process" -"GO:0090496","mesenchyme migration involved in limb bud formation" -"GO:0017055","negative regulation of RNA polymerase II transcriptional preinitiation complex assembly" -"GO:0051468","detection of glucocorticoid hormone stimulus" -"GO:1904888","cranial skeletal system development" -"GO:0008063","Toll signaling pathway" -"GO:1990067","intrachromosomal DNA recombination" -"GO:0006884","cell volume homeostasis" -"GO:0030209","dermatan sulfate catabolic process" -"GO:2000422","regulation of eosinophil chemotaxis" -"GO:0072499","photoreceptor cell axon guidance" -"GO:0010918","positive regulation of mitochondrial membrane potential" -"GO:0006627","protein processing involved in protein targeting to mitochondrion" -"GO:0140066","peptidyl-lysine crotonylation" -"GO:1901881","positive regulation of protein depolymerization" -"GO:1902270","(R)-carnitine transmembrane transport" -"GO:2001145","negative regulation of phosphatidylinositol-3,4,5-trisphosphate 5-phosphatase activity" -"GO:0001314","replication of extrachromosomal circular DNA involved in replicative cell aging" -"GO:0046184","aldehyde biosynthetic process" -"GO:1904126","convergent extension involved in notochord morphogenesis" -"GO:0010188","response to microbial phytotoxin" -"GO:0039019","pronephric nephron development" -"GO:1905462","regulation of DNA duplex unwinding" -"GO:0051228","mitotic spindle disassembly" -"GO:0060591","chondroblast differentiation" -"GO:0036495","negative regulation of translation initiation in response to endoplasmic reticulum stress" -"GO:0099638","endosome to plasma membrane protein transport" -"GO:1900153","positive regulation of nuclear-transcribed mRNA catabolic process, deadenylation-dependent decay" -"GO:0048920","posterior lateral line neuromast primordium migration" -"GO:0016188","synaptic vesicle maturation" -"GO:0035409","histone H3-Y41 phosphorylation" -"GO:0048168","regulation of neuronal synaptic plasticity" -"GO:0045162","clustering of voltage-gated sodium channels" -"GO:0045642","positive regulation of basophil differentiation" -"GO:0071467","cellular response to pH" -"GO:0034653","retinoic acid catabolic process" -"GO:0007156","homophilic cell adhesion via plasma membrane adhesion molecules" -"GO:0030960","peptide cross-linking via 3'-(O4'-L-tyrosinyl)-L-tyrosine" -"GO:0051708","intracellular protein transport in other organism involved in symbiotic interaction" -"GO:0035564","regulation of kidney size" -"GO:1990034","calcium ion export across plasma membrane" -"GO:0033559","unsaturated fatty acid metabolic process" -"GO:1905955","negative regulation of endothelial tube morphogenesis" -"GO:1990280","RNA localization to chromatin" -"GO:0033376","establishment of protein localization to T cell secretory granule" -"GO:1905279","regulation of retrograde transport, endosome to Golgi" -"GO:0070671","response to interleukin-12" -"GO:0048007","antigen processing and presentation, exogenous lipid antigen via MHC class Ib" -"GO:0060640","positive regulation of dentin-containing tooth bud formation by mesenchymal-epithelial signaling" -"GO:0043932","ossification involved in bone remodeling" -"GO:0035606","peptidyl-cysteine S-trans-nitrosylation" -"GO:0010074","maintenance of meristem identity" -"GO:1900567","chanoclavine-I aldehyde metabolic process" -"GO:0001662","behavioral fear response" -"GO:0099613","protein localization to cell wall" -"GO:0015869","protein-DNA complex transport" -"GO:0031959","mineralocorticoid receptor signaling pathway" -"GO:0150013","negative regulation of neuron projection arborization" -"GO:1903468","positive regulation of DNA replication initiation" -"GO:2000984","negative regulation of ATP citrate synthase activity" -"GO:0007281","germ cell development" -"GO:0002373","plasmacytoid dendritic cell cytokine production" -"GO:0061938","protein localization to somatodendritic compartment" -"GO:0043442","acetoacetic acid catabolic process" -"GO:0018969","thiocyanate metabolic process" -"GO:0033369","establishment of protein localization to mast cell secretory granule" -"GO:0038188","cholecystokinin signaling pathway" -"GO:0038195","urokinase plasminogen activator signaling pathway" -"GO:0033087","negative regulation of immature T cell proliferation" -"GO:0071384","cellular response to corticosteroid stimulus" -"GO:0048499","synaptic vesicle membrane organization" -"GO:0060497","mesenchymal-endodermal cell signaling" -"GO:2000474","regulation of opioid receptor signaling pathway" -"GO:0048284","organelle fusion" -"GO:1902679","negative regulation of RNA biosynthetic process" -"GO:1990637","response to prolactin" -"GO:0060617","positive regulation of mammary placode formation by mesenchymal-epithelial signaling" -"GO:0061722","sulphoglycolysis" -"GO:0043503","skeletal muscle fiber adaptation" -"GO:0006766","vitamin metabolic process" -"GO:1990625","negative regulation of cytoplasmic translational initiation in response to stress" -"GO:0070843","misfolded protein transport" -"GO:0016575","histone deacetylation" -"GO:1990236","proteasome core complex import into nucleus" -"GO:0060637","positive regulation of lactation by mesenchymal-epithelial cell signaling" -"GO:2000121","regulation of removal of superoxide radicals" -"GO:2000172","regulation of branching morphogenesis of a nerve" -"GO:0070079","histone H4-R3 demethylation" -"GO:0072659","protein localization to plasma membrane" -"GO:0010165","response to X-ray" -"GO:0051692","cellular oligosaccharide catabolic process" -"GO:0007038","endocytosed protein transport to vacuole" -"GO:0051697","protein delipidation" -"GO:0044571","[2Fe-2S] cluster assembly" -"GO:0032830","negative regulation of CD4-positive, CD25-positive, alpha-beta regulatory T cell differentiation" -"GO:0018262","isopeptide cross-linking" -"GO:0010632","regulation of epithelial cell migration" -"GO:1903125","negative regulation of thioredoxin peroxidase activity by peptidyl-threonine phosphorylation" -"GO:0099112","microtubule polymerization based protein transport" -"GO:2001193","positive regulation of gamma-delta T cell activation involved in immune response" -"GO:0019048","modulation by virus of host morphology or physiology" -"GO:0070844","polyubiquitinated protein transport" -"GO:0061394","regulation of transcription from RNA polymerase II promoter in response to arsenic-containing substance" -"GO:0060399","positive regulation of growth hormone receptor signaling pathway" -"GO:1990959","eosinophil homeostasis" -"GO:0061231","mesonephric glomerulus vasculature development" -"GO:0098749","cerebellar neuron development" -"GO:0060159","regulation of dopamine receptor signaling pathway" -"GO:1902499","positive regulation of protein autoubiquitination" -"GO:2000798","negative regulation of amniotic stem cell differentiation" -"GO:0070255","regulation of mucus secretion" -"GO:0010631","epithelial cell migration" -"GO:0018125","peptidyl-cysteine methylation" -"GO:0034769","basement membrane disassembly" -"GO:0033157","regulation of intracellular protein transport" -"GO:1990737","response to manganese-induced endoplasmic reticulum stress" -"GO:0032594","protein transport within lipid bilayer" -"GO:0060161","positive regulation of dopamine receptor signaling pathway" -"GO:0072045","convergent extension involved in nephron morphogenesis" -"GO:0009819","drought recovery" -"GO:1902823","negative regulation of late endosome to lysosome transport" -"GO:0050911","detection of chemical stimulus involved in sensory perception of smell" -"GO:1902235","regulation of endoplasmic reticulum stress-induced intrinsic apoptotic signaling pathway" -"GO:0018157","peptide cross-linking via an oxazole or thiazole" -"GO:0071031","nuclear mRNA surveillance of mRNA 3'-end processing" -"GO:0072249","metanephric glomerular visceral epithelial cell development" -"GO:1904699","positive regulation of acinar cell proliferation" -"GO:0072702","response to methyl methanesulfonate" -"GO:0048292","isotype switching to IgD isotypes" -"GO:0043922","negative regulation by host of viral transcription" -"GO:0072701","cellular response to bismuth" -"GO:0140084","sexual macrocyst formation" -"GO:1903657","negative regulation of type IV pilus biogenesis" -"GO:0021894","cerebral cortex GABAergic interneuron development" -"GO:1990643","cellular response to granulocyte colony-stimulating factor" -"GO:0090300","positive regulation of neural crest formation" -"GO:1904421","response to D-galactosamine" -"GO:0019485","beta-alanine catabolic process to L-alanine" -"GO:0000003","reproduction" -"GO:0002426","immunoglobulin production in mucosal tissue" -"GO:0014041","regulation of neuron maturation" -"GO:0014015","positive regulation of gliogenesis" -"GO:0048172","regulation of short-term neuronal synaptic plasticity" -"GO:0043396","corticotropin-releasing hormone secretion" -"GO:0060639","positive regulation of salivary gland formation by mesenchymal-epithelial signaling" -"GO:0009777","photosynthetic phosphorylation" -"GO:0030718","germ-line stem cell population maintenance" -"GO:0061580","colon epithelial cell migration" -"GO:1903555","regulation of tumor necrosis factor superfamily cytokine production" -"GO:0060808","positive regulation of mesodermal to mesenchymal transition involved in gastrulation" -"GO:0018020","peptidyl-glutamic acid methylation" -"GO:1990115","RNA polymerase III assembly" -"GO:0019683","glyceraldehyde-3-phosphate catabolic process" -"GO:0048886","neuromast hair cell differentiation" -"GO:0051816","acquisition of nutrients from other organism during symbiotic interaction" -"GO:0090140","regulation of mitochondrial fission" -"GO:0038099","nodal receptor complex assembly" -"GO:0035941","androstenedione secretion" -"GO:0051754","meiotic sister chromatid cohesion, centromeric" -"GO:0051567","histone H3-K9 methylation" -"GO:0072733","response to staurosporine" -"GO:0002949","tRNA threonylcarbamoyladenosine modification" -"GO:0061209","cell proliferation involved in mesonephros development" -"GO:0039015","cell proliferation involved in pronephros development" -"GO:0099049","clathrin coat assembly involved in endocytosis" -"GO:0010384","cell wall proteoglycan metabolic process" -"GO:0009604","detection of symbiotic bacterium" -"GO:0090718","adaptive immune effector response" -"GO:0051232","meiotic spindle elongation" -"GO:0036034","mediator complex assembly" -"GO:0032528","microvillus organization" -"GO:2000363","positive regulation of prostaglandin-E synthase activity" -"GO:1990641","response to iron ion starvation" -"GO:0006556","S-adenosylmethionine biosynthetic process" -"GO:0014073","response to tropane" -"GO:1901542","regulation of ent-pimara-8(14),15-diene biosynthetic process" -"GO:2001059","D-tagatose 6-phosphate catabolic process" -"GO:1901846","positive regulation of cell communication by electrical coupling involved in cardiac conduction" -"GO:0086036","regulation of cardiac muscle cell membrane potential" -"GO:0090549","response to carbon starvation" -"GO:0072110","glomerular mesangial cell proliferation" -"GO:0050958","magnetoreception" -"GO:0001655","urogenital system development" -"GO:0001926","positive regulation of B-1 B cell differentiation" -"GO:0002459","adaptive immune response based on somatic recombination of immune receptors built from leucine-rich repeat domains" -"GO:0019339","parathion catabolic process" -"GO:0030277","maintenance of gastrointestinal epithelium" -"GO:0140059","dendrite arborization" -"GO:0099605","regulation of action potential firing rate" -"GO:2000355","negative regulation of ovarian follicle development" -"GO:0060483","lobar bronchus mesenchyme development" -"GO:0001116","protein-DNA-RNA complex assembly" -"GO:0010649","regulation of cell communication by electrical coupling" -"GO:1900345","regulation of methane biosynthetic process from methanethiol" -"GO:0050427","3'-phosphoadenosine 5'-phosphosulfate metabolic process" -"GO:0001909","leukocyte mediated cytotoxicity" -"GO:0070183","mitochondrial tryptophanyl-tRNA aminoacylation" -"GO:0016567","protein ubiquitination" -"GO:0090096","positive regulation of metanephric cap mesenchymal cell proliferation" -"GO:1905917","positive regulation of cell differentiation involved in phenotypic switching" -"GO:0042333","chemotaxis to oxidizable substrate" -"GO:0032954","regulation of cytokinetic process" -"GO:0048542","lymph gland development" -"GO:0015902","carbonyl cyanide m-chlorophenylhydrazone transport" -"GO:0001757","somite specification" -"GO:0019396","gallate catabolic process" -"GO:1990874","vascular smooth muscle cell proliferation" -"GO:0032930","positive regulation of superoxide anion generation" -"GO:0006265","DNA topological change" -"GO:0006691","leukotriene metabolic process" -"GO:0046244","salicylic acid catabolic process" -"GO:0010604","positive regulation of macromolecule metabolic process" -"GO:0030239","myofibril assembly" -"GO:0044319","wound healing, spreading of cells" -"GO:0042944","D-alanine transmembrane transporter activity" -"GO:0032263","GMP salvage" -"GO:0045964","positive regulation of dopamine metabolic process" -"GO:0045598","regulation of fat cell differentiation" -"GO:0140157","ammonium import across plasma membrane" -"GO:0072761","cellular response to capsazepine" -"GO:0071240","cellular response to food" -"GO:2000058","regulation of ubiquitin-dependent protein catabolic process" -"GO:0002942","tRNA m2,2-guanine biosynthesis" -"GO:0019720","Mo-molybdopterin cofactor metabolic process" -"GO:0035787","cell migration involved in kidney development" -"GO:0051631","regulation of acetylcholine uptake" -"GO:1905319","mesenchymal stem cell migration" -"GO:0035967","cellular response to topologically incorrect protein" -"GO:0010633","negative regulation of epithelial cell migration" -"GO:0043162","ubiquitin-dependent protein catabolic process via the multivesicular body sorting pathway" -"GO:1900188","negative regulation of cell adhesion involved in single-species biofilm formation" -"GO:1902490","regulation of sperm capacitation" -"GO:0008037","cell recognition" -"GO:0061334","cell rearrangement involved in Malpighian tubule morphogenesis" -"GO:0042190","vanillin catabolic process" -"GO:0032717","negative regulation of interleukin-8 production" -"GO:0042867","pyruvate catabolic process" -"GO:0061459","L-arginine transmembrane transporter activity" -"GO:0018002","N-terminal peptidyl-glutamic acid acetylation" -"GO:0021502","neural fold elevation formation" -"GO:0051045","negative regulation of membrane protein ectodomain proteolysis" -"GO:0002682","regulation of immune system process" -"GO:1905737","positive regulation of L-proline import across plasma membrane" -"GO:0051354","negative regulation of oxidoreductase activity" -"GO:0009063","cellular amino acid catabolic process" -"GO:0045927","positive regulation of growth" -"GO:1901462","positive regulation of response to formic acid" -"GO:0060713","labyrinthine layer morphogenesis" -"GO:0060050","positive regulation of protein glycosylation" -"GO:1900574","emodin catabolic process" -"GO:0090042","tubulin deacetylation" -"GO:0021855","hypothalamus cell migration" -"GO:0042442","melatonin catabolic process" -"GO:0045913","positive regulation of carbohydrate metabolic process" -"GO:0006929","substrate-dependent cell migration" -"GO:1900928","positive regulation of L-threonine import across plasma membrane" -"GO:0045854","positive regulation of bicoid mRNA localization" -"GO:0061193","taste bud development" -"GO:1905701","positive regulation of drug transmembrane export" -"GO:0031585","regulation of inositol 1,4,5-trisphosphate-sensitive calcium-release channel activity" -"GO:0019344","cysteine biosynthetic process" -"GO:0018106","peptidyl-histidine phosphorylation" -"GO:0002940","tRNA N2-guanine methylation" -"GO:0032714","negative regulation of interleukin-5 production" -"GO:0010766","negative regulation of sodium ion transport" -"GO:0036227","mitotic G2 cell cycle arrest in response to glucose starvation" -"GO:0044650","adhesion of symbiont to host cell" -"GO:0072214","metanephric cortex development" -"GO:0002215","defense response to nematode" -"GO:0045834","positive regulation of lipid metabolic process" -"GO:1902378","VEGF-activated neuropilin signaling pathway involved in axon guidance" -"GO:0061446","endocardial cushion cell fate determination" -"GO:0060315","negative regulation of ryanodine-sensitive calcium-release channel activity" -"GO:0045903","positive regulation of translational fidelity" -"GO:1905070","anterior visceral endoderm cell migration" -"GO:0106004","tRNA (guanine-N7)-methylation" -"GO:2001209","positive regulation of transcription elongation from RNA polymerase I promoter" -"GO:0034334","adherens junction maintenance" -"GO:0071527","semaphorin-plexin signaling pathway involved in outflow tract morphogenesis" -"GO:0070846","Hsp90 deacetylation" -"GO:0021535","cell migration in hindbrain" -"GO:0051173","positive regulation of nitrogen compound metabolic process" -"GO:0031057","negative regulation of histone modification" -"GO:0019608","nicotine catabolic process" -"GO:0045900","negative regulation of translational elongation" -"GO:0060302","negative regulation of cytokine activity" -"GO:0005289","high-affinity arginine transmembrane transporter activity" -"GO:0008347","glial cell migration" -"GO:0031667","response to nutrient levels" -"GO:0021908","retinoic acid receptor signaling pathway involved in spinal cord anterior/posterior pattern formation" -"GO:1902766","skeletal muscle satellite cell migration" -"GO:0015966","diadenosine tetraphosphate biosynthetic process" -"GO:0050801","ion homeostasis" -"GO:1900798","cordyol C catabolic process" -"GO:0045117","azole transport" -"GO:0051788","response to misfolded protein" -"GO:0015749","monosaccharide transport" -"GO:0097048","dendritic cell apoptotic process" -"GO:0043568","positive regulation of insulin-like growth factor receptor signaling pathway" -"GO:0044465","modulation of sensory perception of pain in other organism" -"GO:0045930","negative regulation of mitotic cell cycle" -"GO:1905262","negative regulation of meiotic DNA double-strand break formation involved in reciprocal meiotic recombination" -"GO:1990802","protein phosphorylation involved in DNA double-strand break processing" -"GO:0035099","hemocyte migration" -"GO:0097534","lymphoid lineage cell migration" -"GO:0043242","negative regulation of protein complex disassembly" -"GO:1901418","positive regulation of response to ethanol" -"GO:0030948","negative regulation of vascular endothelial growth factor receptor signaling pathway" -"GO:0002030","inhibitory G-protein coupled receptor phosphorylation" -"GO:0051659","maintenance of mitochondrion location" -"GO:0045902","negative regulation of translational fidelity" -"GO:0042183","formate catabolic process" -"GO:0061734","parkin-mediated stimulation of mitophagy in response to mitochondrial depolarization" -"GO:0019080","viral gene expression" -"GO:0007319","negative regulation of oskar mRNA translation" -"GO:1990803","protein phosphorylation involved in protein localization to spindle microtubule" -"GO:0000256","allantoin catabolic process" -"GO:0046136","positive regulation of vitamin metabolic process" -"GO:1903826","arginine transmembrane transport" -"GO:2000719","negative regulation of maintenance of mitotic sister chromatid cohesion, centromeric" -"GO:0044074","negative regulation by symbiont of host translation" -"GO:0010536","positive regulation of activation of Janus kinase activity" -"GO:1901750","leukotriene D4 biosynthetic process" -"GO:0017198","N-terminal peptidyl-serine acetylation" -"GO:0099558","maintenance of synapse structure" -"GO:0050794","regulation of cellular process" -"GO:0097590","archaeal-type flagellum-dependent cell motility" -"GO:0040029","regulation of gene expression, epigenetic" -"GO:0038035","G-protein coupled receptor signaling in absence of ligand" -"GO:0045729","respiratory burst at fertilization" -"GO:0018109","peptidyl-arginine phosphorylation" -"GO:0032414","positive regulation of ion transmembrane transporter activity" -"GO:0045764","positive regulation of cellular amino acid metabolic process" -"GO:0032352","positive regulation of hormone metabolic process" -"GO:0045396","regulation of interleukin-23 biosynthetic process" -"GO:1901047","insulin receptor signaling pathway involved in determination of adult lifespan" -"GO:0051482","positive regulation of cytosolic calcium ion concentration involved in phospholipase C-activating G-protein coupled signaling pathway" -"GO:0051454","intracellular pH elevation" -"GO:0014056","regulation of acetylcholine secretion, neurotransmission" -"GO:0002875","negative regulation of chronic inflammatory response to antigenic stimulus" -"GO:2000256","positive regulation of male germ cell proliferation" -"GO:2000657","negative regulation of apolipoprotein binding" -"GO:0090248","cell migration involved in somitogenic axis elongation" -"GO:0019272","L-alanine biosynthetic process from pyruvate" -"GO:0061442","cardiac muscle cell fate determination" -"GO:0051694","pointed-end actin filament capping" -"GO:0060973","cell migration involved in heart development" -"GO:0010888","negative regulation of lipid storage" -"GO:0006751","glutathione catabolic process" -"GO:0007510","cardioblast cell fate determination" -"GO:0035701","hematopoietic stem cell migration" -"GO:0060632","regulation of microtubule-based movement" -"GO:0032826","regulation of natural killer cell differentiation involved in immune response" -"GO:0042869","aldarate transmembrane transport" -"GO:1901050","atropine catabolic process" -"GO:1902943","positive regulation of voltage-gated chloride channel activity" -"GO:2000257","regulation of protein activation cascade" -"GO:0097628","distal tip cell migration" -"GO:0071973","bacterial-type flagellum-dependent cell motility" -"GO:0010745","negative regulation of macrophage derived foam cell differentiation" -"GO:0032445","fructose import" -"GO:0070842","aggresome assembly" -"GO:0008291","acetylcholine metabolic process" -"GO:0034140","negative regulation of toll-like receptor 3 signaling pathway" -"GO:0007196","adenylate cyclase-inhibiting G-protein coupled glutamate receptor signaling pathway" -"GO:0008354","germ cell migration" -"GO:1902305","regulation of sodium ion transmembrane transport" -"GO:1904381","Golgi apparatus mannose trimming" -"GO:0019244","lactate biosynthetic process from pyruvate" -"GO:0035441","cell migration involved in vasculogenesis" -"GO:1905674","regulation of adaptive immune memory response" -"GO:0032072","regulation of restriction endodeoxyribonuclease activity" -"GO:2000426","negative regulation of apoptotic cell clearance" -"GO:0006796","phosphate-containing compound metabolic process" -"GO:0002634","regulation of germinal center formation" -"GO:0003276","apoptotic process involved in heart valve morphogenesis" -"GO:1903890","positive regulation of plant epidermal cell differentiation" -"GO:1903217","negative regulation of protein processing involved in protein targeting to mitochondrion" -"GO:1990804","protein phosphorylation involved in double-strand break repair via nonhomologous end joining" -"GO:0070690","L-threonine catabolic process to acetyl-CoA" -"GO:0099089","establishment of endoplasmic reticulum localization to postsynapse" -"GO:0097756","negative regulation of blood vessel diameter" -"GO:2000452","regulation of CD8-positive, alpha-beta cytotoxic T cell extravasation" -"GO:0009437","carnitine metabolic process" -"GO:0022014","radial glial cell division in subpallium" -"GO:0050843","S-adenosylmethionine catabolic process" -"GO:2001051","positive regulation of tendon cell differentiation" -"GO:0071882","phospholipase C-activating adrenergic receptor signaling pathway" -"GO:0061444","endocardial cushion cell development" -"GO:0090346","cellular organofluorine metabolic process" -"GO:0060283","negative regulation of oocyte development" -"GO:0019617","protocatechuate catabolic process, meta-cleavage" -"GO:0002208","somatic diversification of immunoglobulins involved in immune response" -"GO:1902297","cell cycle DNA replication DNA unwinding" -"GO:0016052","carbohydrate catabolic process" -"GO:0140147","zinc ion export from vacuole" -"GO:1902161","positive regulation of cyclic nucleotide-gated ion channel activity" -"GO:0046147","tetrahydrobiopterin catabolic process" -"GO:0009891","positive regulation of biosynthetic process" -"GO:1902002","protein phosphorylation involved in cellular protein catabolic process" -"GO:1904010","response to Aroclor 1254" -"GO:0050847","progesterone receptor signaling pathway" -"GO:0001699","acetylcholine-induced gastric acid secretion" -"GO:0030206","chondroitin sulfate biosynthetic process" -"GO:0000738","DNA catabolic process, exonucleolytic" -"GO:0051012","microtubule sliding" -"GO:0002092","positive regulation of receptor internalization" -"GO:0061457","mesonephric cell migration involved in male gonad development" -"GO:0070845","polyubiquitinated misfolded protein transport" -"GO:0002845","positive regulation of tolerance induction to tumor cell" -"GO:0031638","zymogen activation" -"GO:1900990","scopolamine catabolic process" -"GO:0070977","bone maturation" -"GO:0098869","cellular oxidant detoxification" -"GO:0002740","negative regulation of cytokine secretion involved in immune response" -"GO:0072156","distal tubule morphogenesis" -"GO:0071257","cellular response to electrical stimulus" -"GO:0002407","dendritic cell chemotaxis" -"GO:1903399","positive regulation of m7G(5')pppN diphosphatase activity" -"GO:2001264","negative regulation of C-C chemokine binding" -"GO:0033388","putrescine biosynthetic process from arginine" -"GO:0009303","rRNA transcription" -"GO:0045901","positive regulation of translational elongation" -"GO:0045010","actin nucleation" -"GO:0060670","branching involved in labyrinthine layer morphogenesis" -"GO:1900910","positive regulation of olefin metabolic process" -"GO:1905351","pericyte cell migration" -"GO:1900949","positive regulation of isoprene biosynthetic process" -"GO:0045746","negative regulation of Notch signaling pathway" -"GO:0061356","regulation of Wnt protein secretion" -"GO:2001205","negative regulation of osteoclast development" -"GO:0046660","female sex differentiation" -"GO:0070961","positive regulation of neutrophil mediated killing of symbiont cell" -"GO:2001284","regulation of BMP secretion" -"GO:0042996","regulation of Golgi to plasma membrane protein transport" -"GO:0072336","negative regulation of canonical Wnt signaling pathway involved in neural crest cell differentiation" -"GO:1904582","positive regulation of intracellular mRNA localization" -"GO:0051680","6-alpha-maltosylglucose biosynthetic process" -"GO:0033152","immunoglobulin V(D)J recombination" -"GO:1905223","epicardium morphogenesis" -"GO:0009263","deoxyribonucleotide biosynthetic process" -"GO:0003316","establishment of myocardial progenitor cell apical/basal polarity" -"GO:0050892","intestinal absorption" -"GO:0036359","renal potassium excretion" -"GO:0060612","adipose tissue development" -"GO:0071572","histone H3-K56 deacetylation" -"GO:0051126","negative regulation of actin nucleation" -"GO:0046869","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl-L-aspartato diiron disulfide" -"GO:0071510","activation of MAPKKK activity involved in conjugation with cellular fusion" -"GO:1904914","negative regulation of establishment of protein-containing complex localization to telomere" -"GO:0051246","regulation of protein metabolic process" -"GO:0032981","mitochondrial respiratory chain complex I assembly" -"GO:0070980","biphenyl catabolic process" -"GO:1903028","positive regulation of opsonization" -"GO:0046710","GDP metabolic process" -"GO:0046893","iron incorporation into hydrogenase diiron subcluster via L-cysteine ligation" -"GO:0051279","regulation of release of sequestered calcium ion into cytosol" -"GO:0030816","positive regulation of cAMP metabolic process" -"GO:0009101","glycoprotein biosynthetic process" -"GO:0051341","regulation of oxidoreductase activity" -"GO:0009069","serine family amino acid metabolic process" -"GO:0090559","regulation of membrane permeability" -"GO:0048694","positive regulation of collateral sprouting of injured axon" -"GO:0061535","glutamate secretion, neurotransmission" -"GO:1905596","negative regulation of low-density lipoprotein particle receptor binding" -"GO:0070627","ferrous iron import" -"GO:0018306","iron incorporation into iron-sulfur cluster via bis-L-cysteinyl-L-N3'-histidino-L-serinyl tetrairon tetrasulfide" -"GO:0007520","myoblast fusion" -"GO:0097277","cellular urea homeostasis" -"GO:0046010","positive regulation of circadian sleep/wake cycle, non-REM sleep" -"GO:0098977","inhibitory chemical synaptic transmission" -"GO:0090182","regulation of secretion of lysosomal enzymes" -"GO:1905135","biotin import across plasma membrane" -"GO:0090127","positive regulation of synapse maturation by synaptic transmission" -"GO:0150032","positive regulation of protein localization to lysosome" -"GO:0035739","CD4-positive, alpha-beta T cell proliferation" -"GO:2000568","positive regulation of memory T cell activation" -"GO:0007274","neuromuscular synaptic transmission" -"GO:1904951","positive regulation of establishment of protein localization" -"GO:0032288","myelin assembly" -"GO:0015705","iodide transport" -"GO:0090435","protein localization to nuclear envelope" -"GO:0043062","extracellular structure organization" -"GO:0060133","somatotropin secreting cell development" -"GO:0009432","SOS response" -"GO:1905069","allantois development" -"GO:0044554","modulation of heart rate in other organism" -"GO:0035329","hippo signaling" -"GO:0046664","dorsal closure, amnioserosa morphology change" -"GO:0001746","Bolwig's organ morphogenesis" -"GO:1900409","positive regulation of cellular response to oxidative stress" -"GO:0060446","branching involved in open tracheal system development" -"GO:0035021","negative regulation of Rac protein signal transduction" -"GO:0032344","regulation of aldosterone metabolic process" -"GO:0018304","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl-L-aspartato tetrairon tetrasulfide" -"GO:0019859","thymine metabolic process" -"GO:0071379","cellular response to prostaglandin stimulus" -"GO:0035007","regulation of melanization defense response" -"GO:1902896","terminal web assembly" -"GO:0009455","redox taxis" -"GO:0007635","chemosensory behavior" -"GO:0036445","neuronal stem cell division" -"GO:0019548","arginine catabolic process to spermine" -"GO:0045939","negative regulation of steroid metabolic process" -"GO:0015655","alanine:sodium symporter activity" -"GO:0006210","thymine catabolic process" -"GO:0048683","regulation of collateral sprouting of intact axon in response to injury" -"GO:0050799","cocaine biosynthetic process" -"GO:1904464","regulation of matrix metallopeptidase secretion" -"GO:0002857","positive regulation of natural killer cell mediated immune response to tumor cell" -"GO:0080159","zygote elongation" -"GO:0070574","cadmium ion transmembrane transport" -"GO:1905580","positive regulation of ERBB3 signaling pathway" -"GO:0018415","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl L-cysteine persulfido bis-L-glutamato L-histidino nickel triiron disulfide trioxide" -"GO:0098814","spontaneous synaptic transmission" -"GO:1903018","regulation of glycoprotein metabolic process" -"GO:0032529","follicle cell microvillus organization" -"GO:0007027","negative regulation of axonemal microtubule depolymerization" -"GO:1903292","protein localization to Golgi membrane" -"GO:0048491","retrograde synaptic vesicle transport" -"GO:0000365","mRNA trans splicing, via spliceosome" -"GO:0015367","oxoglutarate:malate antiporter activity" -"GO:0010978","gene silencing involved in chronological cell aging" -"GO:0031086","nuclear-transcribed mRNA catabolic process, deadenylation-independent decay" -"GO:0043327","chemotaxis to cAMP" -"GO:0021897","forebrain astrocyte development" -"GO:1903778","protein localization to vacuolar membrane" -"GO:0060384","innervation" -"GO:1902276","regulation of pancreatic amylase secretion" -"GO:0018303","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl-L-N3'-histidino tetrairon tetrasulfide" -"GO:1904246","negative regulation of polynucleotide adenylyltransferase activity" -"GO:0000954","methionine catabolic process to 3-methylthiopropanoate" -"GO:0140026","contractile vacuole dissociation from plasma membrane" -"GO:0050653","chondroitin sulfate proteoglycan biosynthetic process, polysaccharide chain biosynthetic process" -"GO:0018288","iron incorporation into iron-sulfur cluster via tetrakis-L-cysteinyl tetrairon tetrasulfide" -"GO:1905858","regulation of heparan sulfate proteoglycan binding" -"GO:0050725","positive regulation of interleukin-1 beta biosynthetic process" -"GO:0061502","early endosome to recycling endosome transport" -"GO:0019709","iron incorporation into iron-sulfur cluster via pentakis-L-cysteinyl L-histidino nickel tetrairon pentasulfide" -"GO:0097535","lymphoid lineage cell migration into thymus" -"GO:0035434","copper ion transmembrane transport" -"GO:0019352","protoporphyrinogen IX biosynthetic process from glycine" -"GO:2000127","positive regulation of octopamine or tyramine signaling pathway" -"GO:0006574","valine catabolic process" -"GO:0009607","response to biotic stimulus" -"GO:0046928","regulation of neurotransmitter secretion" -"GO:0090342","regulation of cell aging" -"GO:0042775","mitochondrial ATP synthesis coupled electron transport" -"GO:0018441","iron incorporation into iron-sulfur cluster via hexakis-L-cysteinyl L-serinyl octairon heptasulfide" -"GO:0050877","nervous system process" -"GO:0018301","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl-L-cysteine persulfido-bis-L-glutamato-L-histidino tetrairon" -"GO:0043486","histone exchange" -"GO:0031642","negative regulation of myelination" -"GO:0046037","GMP metabolic process" -"GO:0070163","regulation of adiponectin secretion" -"GO:1903874","ferrous iron transmembrane transport" -"GO:0098655","cation transmembrane transport" -"GO:0048211","Golgi vesicle docking" -"GO:0021932","hindbrain radial glia guided cell migration" -"GO:0060896","neural plate pattern specification" -"GO:1905322","positive regulation of mesenchymal stem cell migration" -"GO:0007271","synaptic transmission, cholinergic" -"GO:0010122","arginine catabolic process to alanine via ornithine" -"GO:0006120","mitochondrial electron transport, NADH to ubiquinone" -"GO:0007542","primary sex determination, germ-line" -"GO:0048875","chemical homeostasis within a tissue" -"GO:0035094","response to nicotine" -"GO:0031032","actomyosin structure organization" -"GO:1901835","positive regulation of deadenylation-independent decapping of nuclear-transcribed mRNA" -"GO:0006573","valine metabolic process" -"GO:0097276","cellular creatinine homeostasis" -"GO:0007390","germ-band shortening" -"GO:0052522","positive regulation by organism of phagocytosis in other organism involved in symbiotic interaction" -"GO:0015684","ferrous iron transport" -"GO:1903092","pyridoxine transmembrane transport" -"GO:0043267","negative regulation of potassium ion transport" -"GO:1990911","response to psychosocial stress" -"GO:0045940","positive regulation of steroid metabolic process" -"GO:0035892","modulation of platelet aggregation in other organism" -"GO:0098781","ncRNA transcription" -"GO:0045893","positive regulation of transcription, DNA-templated" -"GO:0015692","lead ion transport" -"GO:0046761","viral budding from plasma membrane" -"GO:1901799","negative regulation of proteasomal protein catabolic process" -"GO:0018108","peptidyl-tyrosine phosphorylation" -"GO:0010064","embryonic shoot morphogenesis" -"GO:0016340","calcium-dependent cell-matrix adhesion" -"GO:1905208","negative regulation of cardiocyte differentiation" -"GO:1905513","negative regulation of short-term synaptic potentiation" -"GO:0048669","collateral sprouting in absence of injury" -"GO:1902730","positive regulation of proteoglycan biosynthetic process" -"GO:0015722","canalicular bile acid transport" -"GO:0001895","retina homeostasis" -"GO:0014005","microglia development" -"GO:0042819","vitamin B6 biosynthetic process" -"GO:1904970","brush border assembly" -"GO:0007017","microtubule-based process" -"GO:1901262","negative regulation of sorocarp spore cell differentiation" -"GO:0071517","maintenance of imprinting at mating-type locus" -"GO:0035897","proteolysis in other organism" -"GO:0044406","adhesion of symbiont to host" -"GO:1904909","positive regulation of maintenance of mitotic sister chromatid cohesion, telomeric" -"GO:1902620","positive regulation of microtubule minus-end binding" -"GO:0051180","vitamin transport" -"GO:0007403","glial cell fate determination" -"GO:0072553","terminal button organization" -"GO:0051486","isopentenyl diphosphate biosynthetic process, mevalonate pathway involved in terpenoid biosynthetic process" -"GO:1905259","negative regulation of nitrosative stress-induced intrinsic apoptotic signaling pathway" -"GO:0042787","protein ubiquitination involved in ubiquitin-dependent protein catabolic process" -"GO:0032023","trypsinogen activation" -"GO:2001233","regulation of apoptotic signaling pathway" -"GO:1905908","positive regulation of amyloid fibril formation" -"GO:0006274","DNA replication termination" -"GO:0030111","regulation of Wnt signaling pathway" -"GO:0036275","response to 5-fluorouracil" -"GO:0032816","positive regulation of natural killer cell activation" -"GO:0015746","citrate transport" -"GO:0080040","positive regulation of cellular response to phosphate starvation" -"GO:0006949","syncytium formation" -"GO:0000187","activation of MAPK activity" -"GO:2000639","negative regulation of SREBP signaling pathway" -"GO:0019606","2-oxobutyrate catabolic process" -"GO:0060575","intestinal epithelial cell differentiation" -"GO:0070315","G1 to G0 transition involved in cell differentiation" -"GO:0030491","heteroduplex formation" -"GO:1990370","process resulting in tolerance to aldehyde" -"GO:0050787","detoxification of mercury ion" -"GO:1903905","positive regulation of establishment of T cell polarity" -"GO:0002156","negative regulation of thyroid hormone mediated signaling pathway" -"GO:0000050","urea cycle" -"GO:0071515","genetic imprinting at mating-type locus" -"GO:0040014","regulation of multicellular organism growth" -"GO:1903980","positive regulation of microglial cell activation" -"GO:0042147","retrograde transport, endosome to Golgi" -"GO:1900272","negative regulation of long-term synaptic potentiation" -"GO:0031043","O-glycan processing, core 7" -"GO:0006306","DNA methylation" -"GO:0046295","glycolate biosynthetic process" -"GO:0001325","formation of extrachromosomal circular DNA" -"GO:0051091","positive regulation of DNA binding transcription factor activity" -"GO:0045080","positive regulation of chemokine biosynthetic process" -"GO:0010971","positive regulation of G2/M transition of mitotic cell cycle" -"GO:0120009","intermembrane lipid transfer" -"GO:0060440","trachea formation" -"GO:0043137","DNA replication, removal of RNA primer" -"GO:0009168","purine ribonucleoside monophosphate biosynthetic process" -"GO:0071034","CUT catabolic process" -"GO:0061792","secretory granule maturation" -"GO:0060324","face development" -"GO:0072015","glomerular visceral epithelial cell development" -"GO:0018323","enzyme active site formation via L-cysteine sulfinic acid" -"GO:0042416","dopamine biosynthetic process" -"GO:0045041","protein import into mitochondrial intermembrane space" -"GO:0060020","Bergmann glial cell differentiation" -"GO:0002576","platelet degranulation" -"GO:2000684","negative regulation of cellular response to X-ray" -"GO:1990000","amyloid fibril formation" -"GO:0035702","monocyte homeostasis" -"GO:0033036","macromolecule localization" -"GO:0071902","positive regulation of protein serine/threonine kinase activity" -"GO:0032505","reproduction of a single-celled organism" -"GO:0034063","stress granule assembly" -"GO:0045087","innate immune response" -"GO:0014004","microglia differentiation" -"GO:0019267","asparagine biosynthetic process from cysteine" -"GO:0030216","keratinocyte differentiation" -"GO:0031049","programmed DNA elimination" -"GO:0008285","negative regulation of cell proliferation" -"GO:1902817","negative regulation of protein localization to microtubule" -"GO:0048026","positive regulation of mRNA splicing, via spliceosome" -"GO:0046457","prostanoid biosynthetic process" -"GO:0060711","labyrinthine layer development" -"GO:0016063","rhodopsin biosynthetic process" -"GO:0000720","pyrimidine dimer repair by nucleotide-excision repair" -"GO:0010904","regulation of UDP-glucose catabolic process" -"GO:0090629","lagging strand initiation" -"GO:0050708","regulation of protein secretion" -"GO:0032410","negative regulation of transporter activity" -"GO:1903688","positive regulation of border follicle cell migration" -"GO:0009645","response to low light intensity stimulus" -"GO:0031041","O-glycan processing, core 5" -"GO:1901674","regulation of histone H3-K27 acetylation" -"GO:0016199","axon midline choice point recognition" -"GO:0110045","negative regulation of cell cycle switching, mitotic to meiotic cell cycle" -"GO:0009630","gravitropism" -"GO:0045560","regulation of TRAIL receptor biosynthetic process" -"GO:0099133","ATP hydrolysis coupled anion transmembrane transport" -"GO:0061674","gap filling involved in double-strand break repair via nonhomologous end joining" -"GO:0060655","branching involved in mammary gland cord morphogenesis" -"GO:0010756","positive regulation of plasminogen activation" -"GO:0006935","chemotaxis" -"GO:0048821","erythrocyte development" -"GO:0030321","transepithelial chloride transport" -"GO:0060796","regulation of transcription involved in primary germ layer cell fate commitment" -"GO:1905345","protein localization to cleavage furrow" -"GO:0016269","O-glycan processing, core 3" -"GO:0050870","positive regulation of T cell activation" -"GO:0021618","hypoglossal nerve morphogenesis" -"GO:0045220","positive regulation of FasL biosynthetic process" -"GO:0006378","mRNA polyadenylation" -"GO:0006304","DNA modification" -"GO:0042058","regulation of epidermal growth factor receptor signaling pathway" -"GO:0061880","regulation of anterograde axonal transport of mitochondrion" -"GO:1904533","regulation of telomeric loop disassembly" -"GO:0035633","maintenance of permeability of blood-brain barrier" -"GO:1901412","positive regulation of tetrapyrrole biosynthetic process from glutamate" -"GO:0099527","postsynapse to nucleus signaling pathway" -"GO:0044349","DNA excision" -"GO:1901879","regulation of protein depolymerization" -"GO:0032481","positive regulation of type I interferon production" -"GO:2000641","regulation of early endosome to late endosome transport" -"GO:2000042","negative regulation of double-strand break repair via homologous recombination" -"GO:0006933","negative regulation of cell adhesion involved in substrate-bound cell migration" -"GO:0071516","establishment of imprinting at mating-type locus" -"GO:0010876","lipid localization" -"GO:0001892","embryonic placenta development" -"GO:0007026","negative regulation of microtubule depolymerization" -"GO:0006458","'de novo' protein folding" -"GO:0050764","regulation of phagocytosis" -"GO:0032872","regulation of stress-activated MAPK cascade" -"GO:0001934","positive regulation of protein phosphorylation" -"GO:0010544","negative regulation of platelet activation" -"GO:0035229","positive regulation of glutamate-cysteine ligase activity" -"GO:0019680","L-methylmalonyl-CoA biosynthetic process" -"GO:0050730","regulation of peptidyl-tyrosine phosphorylation" -"GO:0099590","neurotransmitter receptor internalization" -"GO:0090494","dopamine uptake" -"GO:0006417","regulation of translation" -"GO:0021935","cerebellar granule cell precursor tangential migration" -"GO:0071630","nuclear protein quality control by the ubiquitin-proteasome system" -"GO:0072176","nephric duct development" -"GO:1903568","negative regulation of protein localization to ciliary membrane" -"GO:0048771","tissue remodeling" -"GO:2000832","negative regulation of steroid hormone secretion" -"GO:0002232","leukocyte chemotaxis involved in inflammatory response" -"GO:0003146","heart jogging" -"GO:0009987","cellular process" -"GO:0098502","DNA dephosphorylation" -"GO:0042766","nucleosome mobilization" -"GO:0090212","negative regulation of establishment of blood-brain barrier" -"GO:0110025","DNA strand resection involved in replication fork processing" -"GO:0030900","forebrain development" -"GO:0150003","regulation of spontaneous synaptic transmission" -"GO:1901074","regulation of engulfment of apoptotic cell" -"GO:0034224","cellular response to zinc ion starvation" -"GO:0033258","plastid DNA metabolic process" -"GO:0090299","regulation of neural crest formation" -"GO:0018341","peptidyl-lysine modification to peptidyl-N6-pyruvic acid 2-iminyl-L-lysine" -"GO:0071836","nectar secretion" -"GO:0080144","amino acid homeostasis" -"GO:0042273","ribosomal large subunit biogenesis" -"GO:0014878","response to electrical stimulus involved in regulation of muscle adaptation" -"GO:1905061","negative regulation of cardioblast proliferation" -"GO:0018054","peptidyl-lysine biotinylation" -"GO:0015950","purine nucleotide interconversion" -"GO:0071305","cellular response to vitamin D" -"GO:1905039","carboxylic acid transmembrane transport" -"GO:0036050","peptidyl-lysine succinylation" -"GO:1902173","negative regulation of keratinocyte apoptotic process" -"GO:0021966","corticospinal neuron axon guidance" -"GO:1904639","cellular response to resveratrol" -"GO:0018238","peptidyl-lysine carboxyethylation" -"GO:1904570","negative regulation of selenocysteine incorporation" -"GO:0048050","post-embryonic eye morphogenesis" -"GO:1901184","regulation of ERBB signaling pathway" -"GO:0010478","chlororespiration" -"GO:0046418","nopaline metabolic process" -"GO:0009750","response to fructose" -"GO:0021882","regulation of transcription from RNA polymerase II promoter involved in forebrain neuron fate commitment" -"GO:2000097","regulation of smooth muscle cell-matrix adhesion" -"GO:0000266","mitochondrial fission" -"GO:2000656","regulation of apolipoprotein binding" -"GO:0051917","regulation of fibrinolysis" -"GO:0019805","quinolinate biosynthetic process" -"GO:0048633","positive regulation of skeletal muscle tissue growth" -"GO:0050950","positive regulation of late stripe melanocyte differentiation" -"GO:0021780","glial cell fate specification" -"GO:0070705","RNA nucleotide insertion" -"GO:0034332","adherens junction organization" -"GO:0060298","positive regulation of sarcomere organization" -"GO:0009211","pyrimidine deoxyribonucleoside triphosphate metabolic process" -"GO:0005980","glycogen catabolic process" -"GO:0072580","bacterial-type EF-P lysine modification" -"GO:1902829","regulation of spinal cord association neuron differentiation" -"GO:0098746","fast, calcium ion-dependent exocytosis of neurotransmitter" -"GO:2000556","positive regulation of T-helper 1 cell cytokine production" -"GO:0086047","membrane depolarization during Purkinje myocyte cell action potential" -"GO:1904629","response to diterpene" -"GO:0009204","deoxyribonucleoside triphosphate catabolic process" -"GO:0046477","glycosylceramide catabolic process" -"GO:0018276","isopeptide cross-linking via N6-glycyl-L-lysine" -"GO:0006930","substrate-dependent cell migration, cell extension" -"GO:1901857","positive regulation of cellular respiration" -"GO:1904627","response to phorbol 13-acetate 12-myristate" -"GO:0010921","regulation of phosphatase activity" -"GO:0097049","motor neuron apoptotic process" -"GO:0044070","regulation of anion transport" -"GO:0002218","activation of innate immune response" -"GO:0046603","negative regulation of mitotic centrosome separation" -"GO:0050685","positive regulation of mRNA processing" -"GO:0036049","peptidyl-lysine desuccinylation" -"GO:0060978","angiogenesis involved in coronary vascular morphogenesis" -"GO:0042448","progesterone metabolic process" -"GO:1901984","negative regulation of protein acetylation" -"GO:0045616","regulation of keratinocyte differentiation" -"GO:0014910","regulation of smooth muscle cell migration" -"GO:0033522","histone H2A ubiquitination" -"GO:0001553","luteinization" -"GO:1900157","regulation of bone mineralization involved in bone maturation" -"GO:0019227","neuronal action potential propagation" -"GO:0035640","exploration behavior" -"GO:0043302","positive regulation of leukocyte degranulation" -"GO:0046544","development of secondary male sexual characteristics" -"GO:0060453","regulation of gastric acid secretion" -"GO:0035576","retinoic acid receptor signaling pathway involved in pronephric field specification" -"GO:1990416","cellular response to brain-derived neurotrophic factor stimulus" -"GO:0045588","positive regulation of gamma-delta T cell differentiation" -"GO:0043201","response to leucine" -"GO:0048861","leukemia inhibitory factor signaling pathway" -"GO:0000255","allantoin metabolic process" -"GO:0032941","secretion by tissue" -"GO:0071360","cellular response to exogenous dsRNA" -"GO:1903515","calcium ion transport from cytosol to endoplasmic reticulum" -"GO:0051029","rRNA transport" -"GO:0090136","epithelial cell-cell adhesion" -"GO:0048571","long-day photoperiodism" -"GO:1903368","regulation of foraging behavior" -"GO:1904574","negative regulation of selenocysteine insertion sequence binding" -"GO:1901863","positive regulation of muscle tissue development" -"GO:1905790","regulation of mechanosensory behavior" -"GO:0018185","poly-N-methyl-propylamination" -"GO:0071250","cellular response to nitrite" -"GO:1905387","response to beta-carotene" -"GO:0009242","colanic acid biosynthetic process" -"GO:0046605","regulation of centrosome cycle" -"GO:0060623","regulation of chromosome condensation" -"GO:0023051","regulation of signaling" -"GO:0006749","glutathione metabolic process" -"GO:0042749","regulation of circadian sleep/wake cycle" -"GO:0034498","early endosome to Golgi transport" -"GO:2000237","positive regulation of tRNA processing" -"GO:0046415","urate metabolic process" -"GO:0018116","peptidyl-lysine adenylylation" -"GO:1903011","negative regulation of bone development" -"GO:0051084","'de novo' posttranslational protein folding" -"GO:1901527","abscisic acid-activated signaling pathway involved in stomatal movement" -"GO:0070706","RNA nucleotide deletion" -"GO:2001225","regulation of chloride transport" -"GO:1904321","response to forskolin" -"GO:0009215","purine deoxyribonucleoside triphosphate metabolic process" -"GO:0006405","RNA export from nucleus" -"GO:0010378","temperature compensation of the circadian clock" -"GO:0016055","Wnt signaling pathway" -"GO:0045321","leukocyte activation" -"GO:0006406","mRNA export from nucleus" -"GO:0051146","striated muscle cell differentiation" -"GO:0106096","response to ceramide" -"GO:0000289","nuclear-transcribed mRNA poly(A) tail shortening" -"GO:0008053","mitochondrial fusion" -"GO:0003314","heart rudiment morphogenesis" -"GO:0032637","interleukin-8 production" -"GO:0043279","response to alkaloid" -"GO:1902252","positive regulation of erythrocyte apoptotic process" -"GO:0034462","small-subunit processome assembly" -"GO:0140048","manganese ion export across plasma membrane" -"GO:0034014","response to triglyceride" -"GO:0000184","nuclear-transcribed mRNA catabolic process, nonsense-mediated decay" -"GO:0018028","peptidyl-lysine myristoylation" -"GO:0008306","associative learning" -"GO:1905399","regulation of activated CD4-positive, alpha-beta T cell apoptotic process" -"GO:0045579","positive regulation of B cell differentiation" -"GO:0010617","circadian regulation of calcium ion oscillation" -"GO:0033132","negative regulation of glucokinase activity" -"GO:2001135","regulation of endocytic recycling" -"GO:0003427","regulation of cytoskeleton polarization involved in growth plate cartilage chondrocyte division" -"GO:0046874","quinolinate metabolic process" -"GO:2000404","regulation of T cell migration" -"GO:0019530","taurine metabolic process" -"GO:0040033","negative regulation of translation, ncRNA-mediated" -"GO:0072351","tricarboxylic acid biosynthetic process" -"GO:2001150","positive regulation of dipeptide transmembrane transport" -"GO:0019915","lipid storage" -"GO:0036047","peptidyl-lysine demalonylation" -"GO:0070206","protein trimerization" -"GO:0032874","positive regulation of stress-activated MAPK cascade" -"GO:0051552","flavone metabolic process" -"GO:0018360","protein-heme P460 linkage via heme P460-bis-L-cysteine-L-lysine" -"GO:0010519","negative regulation of phospholipase activity" -"GO:1905836","response to triterpenoid" -"GO:1902884","positive regulation of response to oxidative stress" -"GO:0090174","organelle membrane fusion" -"GO:0000060","protein import into nucleus, translocation" -"GO:0060931","sinoatrial node cell development" -"GO:1904531","positive regulation of actin filament binding" -"GO:0071363","cellular response to growth factor stimulus" -"GO:0098501","polynucleotide dephosphorylation" -"GO:0090394","negative regulation of excitatory postsynaptic potential" -"GO:0048278","vesicle docking" -"GO:0072581","protein-N6-(L-lysyl)-L-lysine modification to protein-N6-(beta-lysyl)-L-lysine" -"GO:1903004","regulation of protein K63-linked deubiquitination" -"GO:0009739","response to gibberellin" -"GO:0072715","cellular response to selenite ion" -"GO:0070236","negative regulation of activation-induced cell death of T cells" -"GO:0040011","locomotion" -"GO:0060534","trachea cartilage development" -"GO:0002027","regulation of heart rate" -"GO:0019439","aromatic compound catabolic process" -"GO:1904637","cellular response to ionomycin" -"GO:0003052","circadian regulation of systemic arterial blood pressure" -"GO:0035635","entry of bacterium into host cell" -"GO:0000380","alternative mRNA splicing, via spliceosome" -"GO:0031124","mRNA 3'-end processing" -"GO:0006600","creatine metabolic process" -"GO:0043179","rhythmic excitation" -"GO:0072730","response to papulacandin B" -"GO:1903705","positive regulation of production of siRNA involved in RNA interference" -"GO:0018029","peptidyl-lysine palmitoylation" -"GO:1901135","carbohydrate derivative metabolic process" -"GO:0006369","termination of RNA polymerase II transcription" -"GO:1990540","mitochondrial manganese ion transmembrane transport" -"GO:0072385","minus-end-directed organelle transport along microtubule" -"GO:0031657","regulation of cyclin-dependent protein serine/threonine kinase activity involved in G1/S transition of mitotic cell cycle" -"GO:0003247","post-embryonic cardiac muscle cell growth involved in heart morphogenesis" -"GO:0010501","RNA secondary structure unwinding" -"GO:2000080","negative regulation of canonical Wnt signaling pathway involved in controlling type B pancreatic cell proliferation" -"GO:0002624","positive regulation of B cell antigen processing and presentation" -"GO:0009741","response to brassinosteroid" -"GO:0050783","cocaine metabolic process" -"GO:0072355","histone H3-T3 phosphorylation" -"GO:0002230","positive regulation of defense response to virus by host" -"GO:0018261","peptidyl-lysine guanylylation" -"GO:0019121","peptidoglycan-protein cross-linking via N6-mureinyl-L-lysine" -"GO:1901555","response to paclitaxel" -"GO:0009202","deoxyribonucleoside triphosphate biosynthetic process" -"GO:0001959","regulation of cytokine-mediated signaling pathway" -"GO:0015662","ATPase activity, coupled to transmembrane movement of ions, phosphorylative mechanism" -"GO:0071297","cellular response to cobalamin" -"GO:0051650","establishment of vesicle localization" -"GO:0009062","fatty acid catabolic process" -"GO:0032718","negative regulation of interleukin-9 production" -"GO:0075118","modulation by symbiont of host G-protein coupled receptor protein signal transduction" -"GO:0038041","cross-receptor inhibition within G-protein coupled receptor heterodimer" -"GO:0071278","cellular response to cesium ion" -"GO:0010336","gibberellic acid homeostasis" -"GO:0044496","negative regulation of blood pressure in other organism" -"GO:1903314","regulation of nitrogen cycle metabolic process" -"GO:0021879","forebrain neuron differentiation" -"GO:1901920","peptidyl-tyrosine dephosphorylation involved in activation of protein kinase activity" -"GO:0090227","regulation of red or far-red light signaling pathway" -"GO:0071870","cellular response to catecholamine stimulus" -"GO:2001172","positive regulation of glycolytic fermentation to ethanol" -"GO:0071519","actomyosin contractile ring actin filament bundle assembly" -"GO:1904107","protein localization to microvillus membrane" -"GO:0072619","interleukin-21 secretion" -"GO:0051172","negative regulation of nitrogen compound metabolic process" -"GO:0043151","DNA synthesis involved in double-strand break repair via single-strand annealing" -"GO:0001841","neural tube formation" -"GO:2001054","negative regulation of mesenchymal cell apoptotic process" -"GO:0006019","deoxyribose 5-phosphate phosphorylation" -"GO:0032708","negative regulation of interleukin-24 production" -"GO:0072221","metanephric distal convoluted tubule development" -"GO:1902075","cellular response to salt" -"GO:2000390","negative regulation of neutrophil extravasation" -"GO:0036177","filamentous growth of a population of unicellular organisms in response to pH" -"GO:0002554","serotonin secretion by platelet" -"GO:0016572","histone phosphorylation" -"GO:1905382","positive regulation of snRNA transcription by RNA polymerase II" -"GO:0002428","antigen processing and presentation of peptide antigen via MHC class Ib" -"GO:0048592","eye morphogenesis" -"GO:0021847","ventricular zone neuroblast division" -"GO:1990670","vesicle fusion with Golgi cis cisterna membrane" -"GO:0032716","negative regulation of interleukin-7 production" -"GO:0039003","pronephric field specification" -"GO:0032683","negative regulation of connective tissue growth factor production" -"GO:0002786","regulation of antibacterial peptide production" -"GO:1905546","cellular response to phenylpropanoid" -"GO:0017156","calcium ion regulated exocytosis" -"GO:0031632","positive regulation of synaptic vesicle fusion to presynaptic active zone membrane" -"GO:0097151","positive regulation of inhibitory postsynaptic potential" -"GO:0032698","negative regulation of interleukin-15 production" -"GO:0060800","regulation of cell differentiation involved in embryonic placenta development" -"GO:0070875","positive regulation of glycogen metabolic process" -"GO:0015377","cation:chloride symporter activity" -"GO:0003046","regulation of systemic arterial blood pressure by stress relaxation" -"GO:0001698","gastrin-induced gastric acid secretion" -"GO:0030038","contractile actin filament bundle assembly" -"GO:1903933","negative regulation of DNA primase activity" -"GO:0034721","histone H3-K4 demethylation, trimethyl-H3-K4-specific" -"GO:0031134","sister chromatid biorientation" -"GO:0090286","cytoskeletal anchoring at nuclear membrane" -"GO:0061182","negative regulation of chondrocyte development" -"GO:0072080","nephron tubule development" -"GO:0033576","protein glycosylation in cytosol" -"GO:0002372","myeloid dendritic cell cytokine production" -"GO:0042068","regulation of pteridine metabolic process" -"GO:0034135","regulation of toll-like receptor 2 signaling pathway" -"GO:0048279","vesicle fusion with endoplasmic reticulum" -"GO:0035372","protein localization to microtubule" -"GO:0032697","negative regulation of interleukin-14 production" -"GO:2000779","regulation of double-strand break repair" -"GO:0075087","modulation by host of symbiont G-protein coupled receptor protein signal transduction" -"GO:1904984","regulation of quinolinate biosynthetic process" -"GO:0042543","protein N-linked glycosylation via arginine" -"GO:0099521","ATPase coupled ion transmembrane transporter activity involved in regulation of presynaptic membrane potential" -"GO:1901401","regulation of tetrapyrrole metabolic process" -"GO:0035566","regulation of metanephros size" -"GO:0046775","suppression by virus of host cytokine production" -"GO:0072005","maintenance of kidney identity" -"GO:0009846","pollen germination" -"GO:0099016","DNA end degradation evasion by virus" -"GO:0044769","ATPase activity, coupled to transmembrane movement of ions, rotational mechanism" -"GO:1901217","regulation of holin activity" -"GO:0100042","negative regulation of pseudohyphal growth by transcription from RNA polymerase II promoter" -"GO:1904740","positive regulation of filamentous growth of a population of unicellular organisms in response to starvation by transcription from RNA polymerase II promoter" -"GO:1990048","anterograde neuronal dense core vesicle transport" -"GO:0072300","positive regulation of metanephric glomerulus development" -"GO:0035929","steroid hormone secretion" -"GO:0019404","galactitol catabolic process" -"GO:0051316","attachment of spindle microtubules to kinetochore involved in meiotic chromosome segregation" -"GO:0048073","regulation of eye pigmentation" -"GO:1900348","regulation of methane biosynthetic process from methylamine" -"GO:0008512","sulfate:proton symporter activity" -"GO:0060121","vestibular receptor cell stereocilium organization" -"GO:0072307","regulation of metanephric nephron tubule epithelial cell differentiation" -"GO:0071483","cellular response to blue light" -"GO:0003288","ventricular septum intermedium morphogenesis" -"GO:0070560","protein secretion by platelet" -"GO:2000454","positive regulation of CD8-positive, alpha-beta cytotoxic T cell extravasation" -"GO:1901854","5,6,7,8-tetrahydrosarcinapterin catabolic process" -"GO:0030502","negative regulation of bone mineralization" -"GO:0032706","negative regulation of interleukin-22 production" -"GO:0034501","protein localization to kinetochore" -"GO:1990557","mitochondrial sulfate transmembrane transport" -"GO:0110061","regulation of angiotensin-activated signaling pathway" -"GO:0001983","baroreceptor response to increased systemic arterial blood pressure" -"GO:0010969","regulation of pheromone-dependent signal transduction involved in conjugation with cellular fusion" -"GO:0042125","protein galactosylation" -"GO:0000454","snoRNA guided rRNA pseudouridine synthesis" -"GO:0001879","detection of yeast" -"GO:0090237","regulation of arachidonic acid secretion" -"GO:0019817","vesicle fusion with peroxisome" -"GO:0019219","regulation of nucleobase-containing compound metabolic process" -"GO:0072706","response to sodium dodecyl sulfate" -"GO:0032702","negative regulation of interleukin-19 production" -"GO:1905839","negative regulation of telomeric D-loop disassembly" -"GO:0072289","metanephric nephron tubule formation" -"GO:1900736","regulation of phospholipase C-activating G-protein coupled receptor signaling pathway" -"GO:1900822","regulation of ergot alkaloid biosynthetic process" -"GO:0032615","interleukin-12 production" -"GO:0048791","calcium ion-regulated exocytosis of neurotransmitter" -"GO:0048852","diencephalon morphogenesis" -"GO:0050850","positive regulation of calcium-mediated signaling" -"GO:1905149","positive regulation of smooth muscle hypertrophy" -"GO:1900036","positive regulation of cellular response to heat" -"GO:0072207","metanephric epithelium development" -"GO:0007406","negative regulation of neuroblast proliferation" -"GO:0002719","negative regulation of cytokine production involved in immune response" -"GO:1900288","regulation of coenzyme F420-dependent bicyclic nitroimidazole catabolic process" -"GO:0001312","replication of extrachromosomal rDNA circles involved in replicative cell aging" -"GO:0002525","acute inflammatory response to non-antigenic stimulus" -"GO:0048570","notochord morphogenesis" -"GO:2000125","regulation of octopamine or tyramine signaling pathway" -"GO:2000755","positive regulation of sphingomyelin catabolic process" -"GO:0032694","negative regulation of interleukin-11 production" -"GO:0009663","plasmodesma organization" -"GO:0045055","regulated exocytosis" -"GO:1902043","positive regulation of extrinsic apoptotic signaling pathway via death domain receptors" -"GO:0050732","negative regulation of peptidyl-tyrosine phosphorylation" -"GO:0035495","regulation of SNARE complex disassembly" -"GO:0003089","positive regulation of the force of heart contraction by circulating epinephrine-norepinephrine" -"GO:0099581","ATPase coupled ion transmembrane transporter activity involved in regulation of postsynaptic membrane potential" -"GO:0002072","optic cup morphogenesis involved in camera-type eye development" -"GO:1903305","regulation of regulated secretory pathway" -"GO:0055049","astral spindle assembly" -"GO:0002206","gene conversion of immunoglobulin genes" -"GO:0000056","ribosomal small subunit export from nucleus" -"GO:0014748","negative regulation of tonic skeletal muscle contraction" -"GO:0035629","N-terminal protein amino acid N-linked glycosylation" -"GO:0032928","regulation of superoxide anion generation" -"GO:1903172","cellular carbon dioxide homeostasis" -"GO:2000790","regulation of mesenchymal cell proliferation involved in lung development" -"GO:0007359","posterior abdomen determination" -"GO:1900318","regulation of methane biosynthetic process from dimethylamine" -"GO:0034248","regulation of cellular amide metabolic process" -"GO:0033238","regulation of cellular amine metabolic process" -"GO:1900032","regulation of trichome patterning" -"GO:1900218","negative regulation of apoptotic process involved in metanephric nephron tubule development" -"GO:1902947","regulation of tau-protein kinase activity" -"GO:1902832","negative regulation of cell proliferation in dorsal spinal cord" -"GO:0030047","actin modification" -"GO:1900695","regulation of N',N'',N'''-triacetylfusarinine C biosynthetic process" -"GO:0051710","regulation of cytolysis in other organism" -"GO:0090666","scaRNA localization to Cajal body" -"GO:0070942","neutrophil mediated cytotoxicity" -"GO:0072002","Malpighian tubule development" -"GO:1900977","regulation of tatiopterin metabolic process" -"GO:0098672","evasion by virus of CRISPR-cas system" -"GO:0015373","anion:sodium symporter activity" -"GO:0045918","negative regulation of cytolysis" -"GO:0070950","regulation of neutrophil mediated killing of bacterium" -"GO:0032699","negative regulation of interleukin-16 production" -"GO:0060901","regulation of hair cycle by canonical Wnt signaling pathway" -"GO:0060215","primitive hemopoiesis" -"GO:1905914","positive regulation of calcium ion export across plasma membrane" -"GO:0035470","positive regulation of vascular wound healing" -"GO:0090103","cochlea morphogenesis" -"GO:1905722","regulation of trypanothione biosynthetic process" -"GO:0009731","detection of sucrose stimulus" -"GO:1904837","beta-catenin-TCF complex assembly" -"GO:0075156","regulation of G-protein coupled receptor protein signaling pathway in response to host" -"GO:1904020","regulation of G-protein coupled receptor internalization" -"GO:0031031","positive regulation of septation initiation signaling" -"GO:0048142","germarium-derived cystoblast division" -"GO:1900276","regulation of proteinase activated receptor activity" -"GO:0061347","planar cell polarity pathway involved in outflow tract morphogenesis" -"GO:2000753","positive regulation of glucosylceramide catabolic process" -"GO:1903225","negative regulation of endodermal cell differentiation" -"GO:1904441","regulation of thyroid gland epithelial cell proliferation" -"GO:0019829","cation-transporting ATPase activity" -"GO:0010046","response to mycotoxin" -"GO:0045039","protein import into mitochondrial inner membrane" -"GO:0060859","regulation of vesicle-mediated transport involved in floral organ abscission" -"GO:0044333","Wnt signaling pathway involved in digestive tract morphogenesis" -"GO:2000579","positive regulation of ATP-dependent microtubule motor activity, minus-end-directed" -"GO:0032269","negative regulation of cellular protein metabolic process" -"GO:1903207","regulation of hydrogen peroxide-induced neuron death" -"GO:0050869","negative regulation of B cell activation" -"GO:0050871","positive regulation of B cell activation" -"GO:0098760","response to interleukin-7" -"GO:0036196","zymosterol metabolic process" -"GO:0032211","negative regulation of telomere maintenance via telomerase" -"GO:0046546","development of primary male sexual characteristics" -"GO:0032112","negative regulation of protein histidine kinase activity" -"GO:1903693","regulation of mitotic G1 cell cycle arrest in response to nitrogen starvation" -"GO:0071166","ribonucleoprotein complex localization" -"GO:1903203","regulation of oxidative stress-induced neuron death" -"GO:0010835","regulation of protein ADP-ribosylation" -"GO:0033623","regulation of integrin activation" -"GO:0061518","microglial cell proliferation" -"GO:0009743","response to carbohydrate" -"GO:0072338","cellular lactam metabolic process" -"GO:0035668","TRAM-dependent toll-like receptor signaling pathway" -"GO:0010764","negative regulation of fibroblast migration" -"GO:0061300","cerebellum vasculature development" -"GO:0120084","endothelial tip cell filopodium assembly" -"GO:1904623","positive regulation of actin-dependent ATPase activity" -"GO:1905776","positive regulation of DNA helicase activity" -"GO:0060267","positive regulation of respiratory burst" -"GO:0095500","acetylcholine receptor signaling pathway" -"GO:0051974","negative regulation of telomerase activity" -"GO:0051436","negative regulation of ubiquitin-protein ligase activity involved in mitotic cell cycle" -"GO:0008090","retrograde axonal transport" -"GO:0060918","auxin transport" -"GO:1904453","positive regulation of potassium:proton exchanging ATPase activity" -"GO:0045773","positive regulation of axon extension" -"GO:1900023","positive regulation of D-erythro-sphingosine kinase activity" -"GO:1990751","Schwann cell chemotaxis" -"GO:0051442","obsolete negative regulation of ubiquitin-protein ligase activity involved in meiotic cell cycle" -"GO:0090173","regulation of synaptonemal complex assembly" -"GO:1901390","positive regulation of transforming growth factor beta activation" -"GO:0030828","positive regulation of cGMP biosynthetic process" -"GO:0046929","negative regulation of neurotransmitter secretion" -"GO:1901231","positive regulation of non-canonical Wnt signaling pathway via JNK cascade" -"GO:0071552","RIP homotypic interaction motif-mediated complex assembly" -"GO:0032210","regulation of telomere maintenance via telomerase" -"GO:0036119","response to platelet-derived growth factor" -"GO:2001265","positive regulation of C-C chemokine binding" -"GO:0061820","telomeric D-loop disassembly" -"GO:0002878","negative regulation of acute inflammatory response to non-antigenic stimulus" -"GO:0044629","negative regulation of complement activation, classical pathway in other organism" -"GO:0018186","peroxidase-heme linkage" -"GO:0051096","positive regulation of helicase activity" -"GO:0030091","protein repair" -"GO:0048150","behavioral response to ether" -"GO:0002299","alpha-beta intraepithelial T cell differentiation" -"GO:0002084","protein depalmitoylation" -"GO:1902277","negative regulation of pancreatic amylase secretion" -"GO:2000001","regulation of DNA damage checkpoint" -"GO:0002192","IRES-dependent translational initiation of linear mRNA" -"GO:0046319","positive regulation of glucosylceramide biosynthetic process" -"GO:1901716","negative regulation of gamma-aminobutyric acid catabolic process" -"GO:0032876","negative regulation of DNA endoreduplication" -"GO:0043282","pharyngeal muscle development" -"GO:2000658","positive regulation of apolipoprotein binding" -"GO:0035540","positive regulation of SNARE complex disassembly" -"GO:0097056","selenocysteinyl-tRNA(Sec) biosynthetic process" -"GO:0001944","vasculature development" -"GO:0042320","regulation of circadian sleep/wake cycle, REM sleep" -"GO:0097115","neurexin clustering involved in presynaptic membrane assembly" -"GO:0031289","actin phosphorylation" -"GO:0032825","positive regulation of natural killer cell differentiation" -"GO:0010777","meiotic mismatch repair involved in reciprocal meiotic recombination" -"GO:0035700","astrocyte chemotaxis" -"GO:0051025","negative regulation of immunoglobulin secretion" -"GO:1904227","negative regulation of glycogen synthase activity, transferring glucose-1-phosphate" -"GO:0032324","molybdopterin cofactor biosynthetic process" -"GO:0033086","negative regulation of extrathymic T cell differentiation" -"GO:2000343","positive regulation of chemokine (C-X-C motif) ligand 2 production" -"GO:0042053","regulation of dopamine metabolic process" -"GO:0046879","hormone secretion" -"GO:0071434","cell chemotaxis to angiotensin" -"GO:0032225","regulation of synaptic transmission, dopaminergic" -"GO:0060144","host cellular process involved in virus induced gene silencing" -"GO:0051085","chaperone cofactor-dependent protein refolding" -"GO:0034210","sterol deacetylation" -"GO:0021972","corticospinal neuron axon guidance through spinal cord" -"GO:0051351","positive regulation of ligase activity" -"GO:1903612","positive regulation of calcium-dependent ATPase activity" -"GO:0060491","regulation of cell projection assembly" -"GO:0098775","curli assembly" -"GO:1903640","negative regulation of gastrin-induced gastric acid secretion" -"GO:1901668","regulation of superoxide dismutase activity" -"GO:0046292","formaldehyde metabolic process" -"GO:0046464","acylglycerol catabolic process" -"GO:1905196","positive regulation of ATPase activity, uncoupled" -"GO:1905206","positive regulation of hydrogen peroxide-induced cell death" -"GO:0006911","phagocytosis, engulfment" -"GO:0061081","positive regulation of myeloid leukocyte cytokine production involved in immune response" -"GO:0032202","telomere assembly" -"GO:0043406","positive regulation of MAP kinase activity" -"GO:0016266","O-glycan processing" -"GO:0060712","spongiotrophoblast layer development" -"GO:0071449","cellular response to lipid hydroperoxide" -"GO:0048880","sensory system development" -"GO:0033488","cholesterol biosynthetic process via 24,25-dihydrolanosterol" -"GO:0072172","mesonephric tubule formation" -"GO:1903701","substantia propria of cornea development" -"GO:0001997","positive regulation of the force of heart contraction by epinephrine-norepinephrine" -"GO:0002044","blood vessel endothelial cell migration involved in intussusceptive angiogenesis" -"GO:0060462","lung lobe development" -"GO:0035625","epidermal growth factor-activated receptor transactivation by G-protein coupled receptor signaling pathway" -"GO:0034051","negative regulation of plant-type hypersensitive response" -"GO:0008058","ocellus pigment granule organization" -"GO:0032351","negative regulation of hormone metabolic process" -"GO:1904331","regulation of error-prone translesion synthesis" -"GO:0015489","putrescine transmembrane transporter activity" -"GO:0060522","inductive mesenchymal to epithelial cell signaling" -"GO:0019376","galactolipid catabolic process" -"GO:0006348","chromatin silencing at telomere" -"GO:0002467","germinal center formation" -"GO:1903866","palisade mesophyll development" -"GO:0048713","regulation of oligodendrocyte differentiation" -"GO:0021989","olfactory cortex development" -"GO:1905150","regulation of voltage-gated sodium channel activity" -"GO:1900773","fumiquinazoline metabolic process" -"GO:0061079","left horn of sinus venosus development" -"GO:0035391","maintenance of chromatin silencing at silent mating-type cassette" -"GO:0046521","sphingoid catabolic process" -"GO:0018922","iprodione metabolic process" -"GO:1900992","(-)-secologanin metabolic process" -"GO:0045741","positive regulation of epidermal growth factor-activated receptor activity" -"GO:0046484","oxazole or thiazole metabolic process" -"GO:0034315","regulation of Arp2/3 complex-mediated actin nucleation" -"GO:0021922","Wnt signaling pathway involved in regulation of cell proliferation in dorsal spinal cord" -"GO:1904061","positive regulation of locomotor rhythm" -"GO:0009235","cobalamin metabolic process" -"GO:0010758","regulation of macrophage chemotaxis" -"GO:1905338","negative regulation of cohesin unloading" -"GO:0048138","germ-line cyst encapsulation" -"GO:0070314","G1 to G0 transition" -"GO:0061644","protein localization to CENP-A containing chromatin" -"GO:1900819","orlandin metabolic process" -"GO:0018866","adamantanone metabolic process" -"GO:0009238","enterobactin metabolic process" -"GO:0052645","F420-0 metabolic process" -"GO:0007588","excretion" -"GO:0032298","positive regulation of DNA-dependent DNA replication initiation" -"GO:2001043","positive regulation of cell separation after cytokinesis" -"GO:1900037","regulation of cellular response to hypoxia" -"GO:0043001","Golgi to plasma membrane protein transport" -"GO:0002506","polysaccharide assembly with MHC class II protein complex" -"GO:0044632","negative regulation of complement activation, lectin pathway in other organism" -"GO:0072728","response to Gentian violet" -"GO:2000694","regulation of phragmoplast microtubule organization" -"GO:0060514","prostate induction" -"GO:0000734","gene conversion at mating-type locus, DNA repair synthesis" -"GO:1905288","vascular associated smooth muscle cell apoptotic process" -"GO:0042247","establishment of planar polarity of follicular epithelium" -"GO:0002446","neutrophil mediated immunity" -"GO:0061853","regulation of neuroblast migration" -"GO:0021550","medulla oblongata development" -"GO:0006430","lysyl-tRNA aminoacylation" -"GO:1900144","positive regulation of BMP secretion" -"GO:0015889","cobalamin transport" -"GO:0052490","negative regulation by organism of programmed cell death in other organism involved in symbiotic interaction" -"GO:0072665","protein localization to vacuole" -"GO:0071039","nuclear polyadenylation-dependent CUT catabolic process" -"GO:0018130","heterocycle biosynthetic process" -"GO:0001996","positive regulation of heart rate by epinephrine-norepinephrine" -"GO:0031649","heat generation" -"GO:0072193","ureter smooth muscle cell differentiation" -"GO:0042402","cellular biogenic amine catabolic process" -"GO:0046287","isoflavonoid metabolic process" -"GO:0045433","male courtship behavior, veined wing generated song production" -"GO:1903299","regulation of hexokinase activity" -"GO:0061551","trigeminal ganglion development" -"GO:0031123","RNA 3'-end processing" -"GO:0072013","glomus development" -"GO:1904153","negative regulation of retrograde protein transport, ER to cytosol" -"GO:0036245","cellular response to menadione" -"GO:0042702","uterine wall growth" -"GO:0048536","spleen development" -"GO:2000613","negative regulation of thyroid-stimulating hormone secretion" -"GO:1904062","regulation of cation transmembrane transport" -"GO:0071403","cellular response to high density lipoprotein particle stimulus" -"GO:1904772","response to tetrachloromethane" -"GO:0046885","regulation of hormone biosynthetic process" -"GO:0039009","rectal diverticulum development" -"GO:0045333","cellular respiration" -"GO:0048210","Golgi vesicle fusion to target membrane" -"GO:0071728","beak development" -"GO:0035477","regulation of angioblast cell migration involved in selective angioblast sprouting" -"GO:0033091","positive regulation of immature T cell proliferation" -"GO:1901790","3-(2,3-dihydroxyphenyl)propanoate metabolic process" -"GO:0043098","purine deoxyribonucleoside salvage" -"GO:1903265","positive regulation of tumor necrosis factor-mediated signaling pathway" -"GO:0061375","mammillotectal axonal tract development" -"GO:0002025","norepinephrine-epinephrine-mediated vasodilation involved in regulation of systemic arterial blood pressure" -"GO:0021610","facial nerve morphogenesis" -"GO:0018884","carbazole metabolic process" -"GO:2001136","negative regulation of endocytic recycling" -"GO:0003298","physiological muscle hypertrophy" -"GO:1903946","negative regulation of ventricular cardiac muscle cell action potential" -"GO:0002690","positive regulation of leukocyte chemotaxis" -"GO:0097287","7-cyano-7-deazaguanine metabolic process" -"GO:0002276","basophil activation involved in immune response" -"GO:0061269","mesonephric glomerular mesangial cell proliferation involved in mesonephros development" -"GO:1901376","organic heteropentacyclic compound metabolic process" -"GO:0034284","response to monosaccharide" -"GO:0021546","rhombomere development" -"GO:0043096","purine nucleobase salvage" -"GO:0031659","positive regulation of cyclin-dependent protein serine/threonine kinase activity involved in G1/S transition of mitotic cell cycle" -"GO:0051794","regulation of timing of catagen" -"GO:1905320","regulation of mesenchymal stem cell migration" -"GO:1901781","p-cumate metabolic process" -"GO:1901107","granaticin metabolic process" -"GO:0060618","nipple development" -"GO:0019630","quinate metabolic process" -"GO:0033025","regulation of mast cell apoptotic process" -"GO:0006535","cysteine biosynthetic process from serine" -"GO:0019632","shikimate metabolic process" -"GO:0009051","pentose-phosphate shunt, oxidative branch" -"GO:1902682","protein localization to nuclear pericentric heterochromatin" -"GO:0046700","heterocycle catabolic process" -"GO:0090354","regulation of auxin metabolic process" -"GO:0000288","nuclear-transcribed mRNA catabolic process, deadenylation-dependent decay" -"GO:1903975","regulation of glial cell migration" -"GO:0007173","epidermal growth factor receptor signaling pathway" -"GO:0030910","olfactory placode formation" -"GO:2001281","regulation of muscle cell chemotaxis toward tendon cell" -"GO:0014013","regulation of gliogenesis" -"GO:2001119","methanofuran metabolic process" -"GO:0060494","inductive mesenchymal-endodermal cell signaling" -"GO:0001951","intestinal D-glucose absorption" -"GO:1902953","positive regulation of ER to Golgi vesicle-mediated transport" -"GO:0018930","3-methylquinoline metabolic process" -"GO:1905857","positive regulation of pentose-phosphate shunt" -"GO:0018094","protein polyglycylation" -"GO:0099402","plant organ development" -"GO:0060666","dichotomous subdivision of terminal units involved in salivary gland branching" -"GO:0006563","L-serine metabolic process" -"GO:0052649","coenzyme gamma-F420-2 metabolic process" -"GO:0061805","mitotic spindle elongation during mitotic anaphase" -"GO:0010254","nectary development" -"GO:0030183","B cell differentiation" -"GO:1904857","regulation of endothelial cell chemotaxis to vascular endothelial growth factor" -"GO:0042262","DNA protection" -"GO:0006844","acyl carnitine transport" -"GO:1903354","regulation of distal tip cell migration" -"GO:0034983","peptidyl-lysine deacetylation" -"GO:0046453","dipyrrin metabolic process" -"GO:0021916","inductive cell-cell signaling between paraxial mesoderm and motor neuron precursors" -"GO:1900597","demethylkotanin metabolic process" -"GO:0071707","immunoglobulin heavy chain V-D-J recombination" -"GO:1903516","regulation of single strand break repair" -"GO:0010002","cardioblast differentiation" -"GO:0051905","establishment of pigment granule localization" -"GO:0045399","regulation of interleukin-3 biosynthetic process" -"GO:0060152","microtubule-based peroxisome localization" -"GO:0046014","negative regulation of T cell homeostatic proliferation" -"GO:1905528","positive regulation of Golgi lumen acidification" -"GO:0070301","cellular response to hydrogen peroxide" -"GO:1901322","response to chloramphenicol" -"GO:0099095","ligand-gated anion channel activity" -"GO:0042761","very long-chain fatty acid biosynthetic process" -"GO:2000776","histone H4 acetylation involved in response to DNA damage stimulus" -"GO:0072610","interleukin-12 secretion" -"GO:0010700","negative regulation of norepinephrine secretion" -"GO:0002606","positive regulation of dendritic cell antigen processing and presentation" -"GO:0061115","lung proximal/distal axis specification" -"GO:0097498","endothelial tube lumen extension" -"GO:1902351","response to imidacloprid" -"GO:0016081","synaptic vesicle docking" -"GO:1904527","negative regulation of microtubule binding" -"GO:2000174","regulation of pro-T cell differentiation" -"GO:1904587","response to glycoprotein" -"GO:0097150","neuronal stem cell population maintenance" -"GO:0046476","glycosylceramide biosynthetic process" -"GO:0060851","vascular endothelial growth factor receptor signaling pathway involved in lymphatic endothelial cell fate commitment" -"GO:2000110","negative regulation of macrophage apoptotic process" -"GO:0044623","positive regulation of cell migration in other organism" -"GO:0097711","ciliary basal body-plasma membrane docking" -"GO:1901561","response to benomyl" -"GO:0035045","sperm plasma membrane disassembly" -"GO:0003066","positive regulation of heart rate by norepinephrine" -"GO:2001032","regulation of double-strand break repair via nonhomologous end joining" -"GO:0035636","multi-organism signaling" -"GO:0045565","negative regulation of TRAIL receptor 1 biosynthetic process" -"GO:0060098","membrane reorganization involved in phagocytosis, engulfment" -"GO:0070352","positive regulation of white fat cell proliferation" -"GO:0035350","FAD transmembrane transport" -"GO:1901559","response to ribavirin" -"GO:0072510","trivalent inorganic cation transmembrane transporter activity" -"GO:0035071","salivary gland cell autophagic cell death" -"GO:0018290","iron and molybdenum incorporation into iron-molybdenum-sulfur cluster via L-cysteinyl homocitryl molybdenum-heptairon-nonasulfide" -"GO:0006756","AMP phosphorylation" -"GO:0036170","filamentous growth of a population of unicellular organisms in response to starvation" -"GO:0030252","growth hormone secretion" -"GO:1901327","response to tacrolimus" -"GO:0043609","regulation of carbon utilization" -"GO:0060025","regulation of synaptic activity" -"GO:0002408","myeloid dendritic cell chemotaxis" -"GO:0008360","regulation of cell shape" -"GO:0008358","maternal determination of anterior/posterior axis, embryo" -"GO:0072275","metanephric glomerulus morphogenesis" -"GO:1904842","response to nitroglycerin" -"GO:0097724","sperm flagellum movement" -"GO:1901299","negative regulation of hydrogen peroxide-mediated programmed cell death" -"GO:0061144","alveolar secondary septum development" -"GO:0072166","posterior mesonephric tubule development" -"GO:1904316","response to 2-O-acetyl-1-O-hexadecyl-sn-glycero-3-phosphocholine" -"GO:0048206","vesicle targeting, cis-Golgi to rough ER" -"GO:0032354","response to follicle-stimulating hormone" -"GO:0060879","semicircular canal fusion" -"GO:0034444","regulation of plasma lipoprotein oxidation" -"GO:0043708","cell adhesion involved in biofilm formation" -"GO:0002697","regulation of immune effector process" -"GO:2000177","regulation of neural precursor cell proliferation" -"GO:0001703","gastrulation with mouth forming first" -"GO:0045411","regulation of interleukin-7 biosynthetic process" -"GO:0045923","positive regulation of fatty acid metabolic process" -"GO:1901614","positive regulation of terminal button organization" -"GO:1904619","response to dimethyl sulfoxide" -"GO:0046655","folic acid metabolic process" -"GO:0099105","ion channel modulating, G-protein coupled receptor signaling pathway" -"GO:1904008","response to monosodium glutamate" -"GO:0032511","late endosome to vacuole transport via multivesicular body sorting pathway" -"GO:0061033","secretion by lung epithelial cell involved in lung growth" -"GO:0055094","response to lipoprotein particle" -"GO:0071732","cellular response to nitric oxide" -"GO:1903350","response to dopamine" -"GO:0061764","late endosome to lysosome transport via multivesicular body sorting pathway" -"GO:0010508","positive regulation of autophagy" -"GO:0007095","mitotic G2 DNA damage checkpoint" -"GO:0021754","facial nucleus development" -"GO:0001956","positive regulation of neurotransmitter secretion" -"GO:0021839","interneuron-substratum interaction involved in interneuron migration from the subpallium to the cortex" -"GO:0060585","positive regulation of prostaglandin-endoperoxide synthase activity" -"GO:0048401","negative regulation of intermediate mesodermal cell fate specification" -"GO:0006308","DNA catabolic process" -"GO:0021833","cell-matrix adhesion involved in tangential migration using cell-cell interactions" -"GO:0005225","volume-sensitive anion channel activity" -"GO:0097369","sodium ion import" -"GO:0016045","detection of bacterium" -"GO:1905062","positive regulation of cardioblast proliferation" -"GO:1901950","dense core granule transport" -"GO:0032532","regulation of microvillus length" -"GO:0097154","GABAergic neuron differentiation" -"GO:0046637","regulation of alpha-beta T cell differentiation" -"GO:2000819","regulation of nucleotide-excision repair" -"GO:0097022","lymphocyte migration into lymph node" -"GO:0098967","exocytic insertion of neurotransmitter receptor to postsynaptic membrane" -"GO:1904610","response to 3,3',4,4',5-pentachlorobiphenyl" -"GO:2000356","regulation of kidney smooth muscle cell differentiation" -"GO:0072712","response to thiabendazole" -"GO:0061476","response to anticoagulant" -"GO:0033084","regulation of immature T cell proliferation in thymus" -"GO:0060665","regulation of branching involved in salivary gland morphogenesis by mesenchymal-epithelial signaling" -"GO:0032873","negative regulation of stress-activated MAPK cascade" -"GO:0036288","response to ximelagatran" -"GO:0071919","G-quadruplex DNA formation" -"GO:0072662","protein localization to peroxisome" -"GO:0035947","regulation of gluconeogenesis by regulation of transcription from RNA polymerase II promoter" -"GO:0060925","ventricular cardiac muscle cell fate commitment" -"GO:0070417","cellular response to cold" -"GO:1903422","negative regulation of synaptic vesicle recycling" -"GO:0036271","response to methylphenidate" -"GO:0005254","chloride channel activity" -"GO:0006962","male-specific antibacterial humoral response" -"GO:1904050","positive regulation of spontaneous neurotransmitter secretion" -"GO:0045387","regulation of interleukin-20 biosynthetic process" -"GO:0060539","diaphragm development" -"GO:1901609","negative regulation of vesicle transport along microtubule" -"GO:1904844","response to L-glutamine" -"GO:0034119","negative regulation of erythrocyte aggregation" -"GO:1990314","cellular response to insulin-like growth factor stimulus" -"GO:1905558","negative regulation of mitotic nuclear envelope disassembly" -"GO:0051353","positive regulation of oxidoreductase activity" -"GO:0042945","D-serine transmembrane transporter activity" -"GO:1904947","folic acid import into mitochondrion" -"GO:0071924","chemokine (C-C motif) ligand 22 production" -"GO:0071139","resolution of recombination intermediates" -"GO:0036272","response to gemcitabine" -"GO:0045722","positive regulation of gluconeogenesis" -"GO:0048012","hepatocyte growth factor receptor signaling pathway" -"GO:0050677","positive regulation of urothelial cell proliferation" -"GO:0050674","urothelial cell proliferation" -"GO:0090049","regulation of cell migration involved in sprouting angiogenesis" -"GO:1990054","response to temozolomide" -"GO:0120058","positive regulation of small intestinal transit" -"GO:0045583","regulation of cytotoxic T cell differentiation" -"GO:0044356","clearance of foreign intracellular DNA by conversion of DNA cytidine to uridine" -"GO:0055045","antipodal cell degeneration" -"GO:0021681","cerebellar granular layer development" -"GO:0021874","Wnt signaling pathway involved in forebrain neuroblast division" -"GO:1901597","response to carbendazim" -"GO:0035983","response to trichostatin A" -"GO:0006931","substrate-dependent cell migration, cell attachment to substrate" -"GO:0021549","cerebellum development" -"GO:1905302","negative regulation of macropinocytosis" -"GO:1903587","regulation of blood vessel endothelial cell proliferation involved in sprouting angiogenesis" -"GO:2000525","positive regulation of T cell costimulation" -"GO:1903243","negative regulation of cardiac muscle hypertrophy in response to stress" -"GO:0006544","glycine metabolic process" -"GO:2000377","regulation of reactive oxygen species metabolic process" -"GO:0070384","Harderian gland development" -"GO:0010807","regulation of synaptic vesicle priming" -"GO:0060994","regulation of transcription from RNA polymerase II promoter involved in kidney development" -"GO:0046873","metal ion transmembrane transporter activity" -"GO:1903183","negative regulation of SUMO transferase activity" -"GO:0072287","metanephric distal tubule morphogenesis" -"GO:1903072","regulation of death-inducing signaling complex assembly" -"GO:0045036","protein targeting to chloroplast" -"GO:0019056","modulation by virus of host transcription" -"GO:0051711","negative regulation of killing of cells of other organism" -"GO:0090616","mitochondrial mRNA 3'-end processing" -"GO:0010975","regulation of neuron projection development" -"GO:0016574","histone ubiquitination" -"GO:0060325","face morphogenesis" -"GO:0003196","ventriculo bulbo valve formation" -"GO:0046101","hypoxanthine biosynthetic process" -"GO:0061091","regulation of phospholipid translocation" -"GO:0061736","engulfment of target by autophagosome" -"GO:0070760","positive regulation of interleukin-35-mediated signaling pathway" -"GO:0009156","ribonucleoside monophosphate biosynthetic process" -"GO:0007197","adenylate cyclase-inhibiting G-protein coupled acetylcholine receptor signaling pathway" -"GO:0003215","cardiac right ventricle morphogenesis" -"GO:0032349","positive regulation of aldosterone biosynthetic process" -"GO:0007187","G-protein coupled receptor signaling pathway, coupled to cyclic nucleotide second messenger" -"GO:0036304","umbilical cord morphogenesis" -"GO:0072643","interferon-gamma secretion" -"GO:2000332","regulation of blood microparticle formation" -"GO:1900998","nitrobenzene catabolic process" -"GO:0072177","mesonephric duct development" -"GO:0099641","anterograde axonal protein transport" -"GO:0010706","ganglioside biosynthetic process via lactosylceramide" -"GO:0045582","positive regulation of T cell differentiation" -"GO:0007614","short-term memory" -"GO:2000114","regulation of establishment of cell polarity" -"GO:0045779","negative regulation of bone resorption" -"GO:0045061","thymic T cell selection" -"GO:1903496","response to 11-deoxycorticosterone" -"GO:0042081","GSI anchor metabolic process" -"GO:0043317","regulation of cytotoxic T cell degranulation" -"GO:0072174","metanephric tubule formation" -"GO:0046204","nor-spermidine metabolic process" -"GO:1901992","positive regulation of mitotic cell cycle phase transition" -"GO:2000617","positive regulation of histone H3-K9 acetylation" -"GO:0002176","male germ cell proliferation" -"GO:0048091","positive regulation of female pigmentation" -"GO:1990095","positive regulation of transcription from RNA polymerase II promoter in response to reactive oxygen species" -"GO:0044727","DNA demethylation of male pronucleus" -"GO:0045471","response to ethanol" -"GO:0097095","frontonasal suture morphogenesis" -"GO:0010549","regulation of membrane disassembly" -"GO:0010894","negative regulation of steroid biosynthetic process" -"GO:2000526","positive regulation of glycoprotein biosynthetic process involved in immunological synapse formation" -"GO:0061692","cellular detoxification of hydrogen peroxide" -"GO:0033609","oxalate metabolic process" -"GO:0032920","putrescine acetylation" -"GO:0090691","formation of plant organ boundary" -"GO:0033080","immature T cell proliferation in thymus" -"GO:0008016","regulation of heart contraction" -"GO:0006798","polyphosphate catabolic process" -"GO:1900660","positive regulation of emericellamide biosynthetic process" -"GO:0072164","mesonephric tubule development" -"GO:2000547","regulation of dendritic cell dendrite assembly" -"GO:0060470","positive regulation of cytosolic calcium ion concentration involved in egg activation" -"GO:0035235","ionotropic glutamate receptor signaling pathway" -"GO:0051145","smooth muscle cell differentiation" -"GO:0072034","renal vesicle induction" -"GO:0002088","lens development in camera-type eye" -"GO:0072205","metanephric collecting duct development" -"GO:0072178","nephric duct morphogenesis" -"GO:0071353","cellular response to interleukin-4" -"GO:0060236","regulation of mitotic spindle organization" -"GO:1901976","regulation of cell cycle checkpoint" -"GO:1902056","(25S)-Delta(7)-dafachronate metabolic process" -"GO:0048646","anatomical structure formation involved in morphogenesis" -"GO:0000390","spliceosomal complex disassembly" -"GO:0071344","diphosphate metabolic process" -"GO:0002879","positive regulation of acute inflammatory response to non-antigenic stimulus" -"GO:0022407","regulation of cell-cell adhesion" -"GO:1905204","negative regulation of connective tissue replacement" -"GO:0030218","erythrocyte differentiation" -"GO:0034097","response to cytokine" -"GO:0007396","suture of dorsal opening" -"GO:0035728","response to hepatocyte growth factor" -"GO:1905063","regulation of vascular smooth muscle cell differentiation" -"GO:0097355","protein localization to heterochromatin" -"GO:0036270","response to diuretic" -"GO:0060065","uterus development" -"GO:1903186","regulation of vitellogenesis" -"GO:1901315","negative regulation of histone H2A K63-linked ubiquitination" -"GO:0031440","regulation of mRNA 3'-end processing" -"GO:0032971","regulation of muscle filament sliding" -"GO:0007343","egg activation" -"GO:0015833","peptide transport" -"GO:0000301","retrograde transport, vesicle recycling within Golgi" -"GO:0048468","cell development" -"GO:1904749","regulation of protein localization to nucleolus" -"GO:1902066","regulation of cell wall pectin metabolic process" -"GO:0019221","cytokine-mediated signaling pathway" -"GO:0070900","mitochondrial tRNA modification" -"GO:1905073","regulation of occluding junction disassembly" -"GO:0072162","metanephric mesenchymal cell differentiation" -"GO:0002045","regulation of cell adhesion involved in intussusceptive angiogenesis" -"GO:1901544","positive regulation of ent-pimara-8(14),15-diene biosynthetic process" -"GO:0018912","1,4-dichlorobenzene metabolic process" -"GO:0003366","cell-matrix adhesion involved in ameboidal cell migration" -"GO:0007213","G-protein coupled acetylcholine receptor signaling pathway" -"GO:0061407","positive regulation of transcription from RNA polymerase II promoter in response to hydrogen peroxide" -"GO:2000522","positive regulation of immunological synapse formation" -"GO:0086021","SA node cell to atrial cardiac muscle cell communication by electrical coupling" -"GO:2000664","positive regulation of interleukin-5 secretion" -"GO:0010980","positive regulation of vitamin D 24-hydroxylase activity" -"GO:0045772","positive regulation of autophagosome size" -"GO:0072273","metanephric nephron morphogenesis" -"GO:0014852","regulation of skeletal muscle contraction by neural stimulation via neuromuscular junction" -"GO:0018533","peptidyl-cysteine acetylation" -"GO:2000683","regulation of cellular response to X-ray" -"GO:0009653","anatomical structure morphogenesis" -"GO:0033043","regulation of organelle organization" -"GO:2000787","regulation of venous endothelial cell fate commitment" -"GO:0018285","iron incorporation into iron-sulfur cluster via tetrakis-L-cysteinyl diiron disulfide" -"GO:0007596","blood coagulation" -"GO:0030241","skeletal muscle myosin thick filament assembly" -"GO:0070922","small RNA loading onto RISC" -"GO:1905081","positive regulation of cerebellar neuron development" -"GO:1904595","positive regulation of termination of RNA polymerase II transcription" -"GO:0050836","iron incorporation into iron-sulfur cluster via tris-L-cysteinyl L-arginyl diiron disulfide" -"GO:0042421","norepinephrine biosynthetic process" -"GO:2000732","positive regulation of termination of RNA polymerase I transcription" -"GO:0023061","signal release" -"GO:0034222","regulation of cell wall chitin metabolic process" -"GO:0034609","spicule insertion" -"GO:0045113","regulation of integrin biosynthetic process" -"GO:0072033","renal vesicle formation" -"GO:0090250","cell-cell adhesion involved in establishment of planar polarity" -"GO:0018119","peptidyl-cysteine S-nitrosylation" -"GO:0060017","parathyroid gland development" -"GO:0036303","lymph vessel morphogenesis" -"GO:0044691","tooth eruption" -"GO:0090318","regulation of chylomicron remodeling" -"GO:0048093","positive regulation of male pigmentation" -"GO:0061205","paramesonephric duct development" -"GO:0014724","regulation of twitch skeletal muscle contraction" -"GO:0072218","metanephric ascending thin limb development" -"GO:0018171","peptidyl-cysteine oxidation" -"GO:0072237","metanephric proximal tubule development" -"GO:1901890","positive regulation of cell junction assembly" -"GO:0090244","Wnt signaling pathway involved in somitogenesis" -"GO:0019184","nonribosomal peptide biosynthetic process" -"GO:1901733","quercetin catabolic process" -"GO:0001572","lactosylceramide biosynthetic process" -"GO:0000290","deadenylation-dependent decapping of nuclear-transcribed mRNA" -"GO:0046296","glycolate catabolic process" -"GO:1902125","(+)-pinoresinol catabolic process" -"GO:0031938","regulation of chromatin silencing at telomere" -"GO:0032918","spermidine acetylation" -"GO:0014864","detection of muscle activity" -"GO:0050831","male-specific defense response to bacterium" -"GO:1902137","(-)-secoisolariciresinol catabolic process" -"GO:0014848","urinary tract smooth muscle contraction" -"GO:1900795","terrequinone A catabolic process" -"GO:0000168","activation of MAPKK activity involved in osmosensory signaling pathway" -"GO:1902952","positive regulation of dendritic spine maintenance" -"GO:0006767","water-soluble vitamin metabolic process" -"GO:0072392","phenol catabolic process" -"GO:0030419","nicotianamine catabolic process" -"GO:0035261","external genitalia morphogenesis" -"GO:0007280","pole cell migration" -"GO:0090137","epithelial cell-cell adhesion involved in epithelium migration" -"GO:1902866","regulation of retina development in camera-type eye" -"GO:0060886","clearance of cells from fusion plate by epithelial to mesenchymal transition" -"GO:1901868","ecgonine methyl ester catabolic process" -"GO:0046285","flavonoid phytoalexin metabolic process" -"GO:0001906","cell killing" -"GO:0009414","response to water deprivation" -"GO:0090045","positive regulation of deacetylase activity" -"GO:1904105","positive regulation of convergent extension involved in gastrulation" -"GO:0021991","neural plate thickening" -"GO:0032673","regulation of interleukin-4 production" -"GO:0045460","sterigmatocystin metabolic process" -"GO:0110032","positive regulation of G2/MI transition of meiotic cell cycle" -"GO:0046320","regulation of fatty acid oxidation" -"GO:0045922","negative regulation of fatty acid metabolic process" -"GO:0009234","menaquinone biosynthetic process" -"GO:2000055","positive regulation of Wnt signaling pathway involved in dorsal/ventral axis specification" -"GO:0097332","response to antipsychotic drug" -"GO:0035553","oxidative single-stranded RNA demethylation" -"GO:0051423","positive regulation of endo-1,4-beta-xylanase activity" -"GO:0018406","protein C-linked glycosylation via 2'-alpha-mannosyl-L-tryptophan" -"GO:0060026","convergent extension" -"GO:0070241","positive regulation of activated T cell autonomous cell death" -"GO:0021528","commissural neuron differentiation in spinal cord" -"GO:1904386","response to L-phenylalanine derivative" -"GO:1900729","regulation of adenylate cyclase-inhibiting opioid receptor signaling pathway" -"GO:0090118","receptor-mediated endocytosis involved in cholesterol transport" -"GO:0031529","ruffle organization" -"GO:1903429","regulation of cell maturation" -"GO:0009850","auxin metabolic process" -"GO:0060535","trachea cartilage morphogenesis" -"GO:0042366","cobalamin catabolic process" -"GO:1903749","positive regulation of establishment of protein localization to mitochondrion" -"GO:0042739","endogenous drug catabolic process" -"GO:0006124","ferredoxin metabolic process" -"GO:0042373","vitamin K metabolic process" -"GO:0045213","neurotransmitter receptor metabolic process" -"GO:2001181","positive regulation of interleukin-10 secretion" -"GO:1990547","mitochondrial phosphate ion transmembrane transport" -"GO:1905719","protein localization to perinuclear region of cytoplasm" -"GO:1901154","paromomycin catabolic process" -"GO:0045381","regulation of interleukin-18 biosynthetic process" -"GO:0032487","regulation of Rap protein signal transduction" -"GO:0016189","synaptic vesicle to endosome fusion" -"GO:0050696","trichloroethylene catabolic process" -"GO:0042667","auditory receptor cell fate specification" -"GO:0048674","collateral sprouting of injured axon" -"GO:0007299","ovarian follicle cell-cell adhesion" -"GO:2001190","positive regulation of T cell activation via T cell receptor contact with antigen bound to MHC molecule on antigen presenting cell" -"GO:0097029","mature conventional dendritic cell differentiation" -"GO:1905916","negative regulation of cell differentiation involved in phenotypic switching" -"GO:2000184","positive regulation of progesterone biosynthetic process" -"GO:0014821","phasic smooth muscle contraction" -"GO:1901126","candicidin catabolic process" -"GO:0071509","activation of MAPKK activity involved in conjugation with cellular fusion" -"GO:0010690","negative regulation of ribosomal protein gene transcription from RNA polymerase II promoter in response to stress" -"GO:0044340","canonical Wnt signaling pathway involved in regulation of cell proliferation" -"GO:2000562","negative regulation of CD4-positive, alpha-beta T cell proliferation" -"GO:0032674","regulation of interleukin-5 production" -"GO:0003318","cell migration to the midline involved in heart development" -"GO:0044335","canonical Wnt signaling pathway involved in neural crest cell differentiation" -"GO:0090044","positive regulation of tubulin deacetylation" -"GO:0036006","cellular response to macrophage colony-stimulating factor stimulus" -"GO:0090504","epiboly" -"GO:0098729","germline stem cell symmetric division" -"GO:0042838","D-glucarate catabolic process" -"GO:1901704","L-glutamine biosynthetic process" -"GO:0072370","histone H2A-S121 phosphorylation" -"GO:0098810","neurotransmitter reuptake" -"GO:0060015","granulosa cell fate commitment" -"GO:0007615","anesthesia-resistant memory" -"GO:0021693","cerebellar Purkinje cell layer structural organization" -"GO:0034292","pinholin activity" -"GO:0009628","response to abiotic stimulus" -"GO:1990770","small intestine smooth muscle contraction" -"GO:0070472","regulation of uterine smooth muscle contraction" -"GO:1903722","regulation of centriole elongation" -"GO:0019477","L-lysine catabolic process" -"GO:0042371","vitamin K biosynthetic process" -"GO:0071688","striated muscle myosin thick filament assembly" -"GO:1901762","oxytetracycline catabolic process" -"GO:0048743","positive regulation of skeletal muscle fiber development" -"GO:2000670","positive regulation of dendritic cell apoptotic process" -"GO:0075206","positive regulation by host of symbiont cAMP-mediated signal transduction" -"GO:1903044","protein localization to membrane raft" -"GO:0000198","activation of MAPKK activity involved in cell wall organization or biogenesis" -"GO:0009149","pyrimidine nucleoside triphosphate catabolic process" -"GO:0021685","cerebellar granular layer structural organization" -"GO:0046631","alpha-beta T cell activation" -"GO:0002478","antigen processing and presentation of exogenous peptide antigen" -"GO:0046115","guanosine catabolic process" -"GO:2000045","regulation of G1/S transition of mitotic cell cycle" -"GO:0044029","hypomethylation of CpG island" -"GO:0019619","3,4-dihydroxybenzoate catabolic process" -"GO:0009146","purine nucleoside triphosphate catabolic process" -"GO:0072246","metanephric glomerular parietal epithelial cell development" -"GO:0042693","muscle cell fate commitment" -"GO:0097532","stress response to acid chemical" -"GO:0032194","ubiquinone biosynthetic process via 3,4-dihydroxy-5-polyprenylbenzoate" -"GO:1903045","neural crest cell migration involved in sympathetic nervous system development" -"GO:1900239","regulation of phenotypic switching" -"GO:0090151","establishment of protein localization to mitochondrial membrane" -"GO:0030262","apoptotic nuclear changes" -"GO:0016078","tRNA catabolic process" -"GO:0071549","cellular response to dexamethasone stimulus" -"GO:0097490","sympathetic neuron projection extension" -"GO:1905175","negative regulation of vascular smooth muscle cell dedifferentiation" -"GO:2000564","regulation of CD8-positive, alpha-beta T cell proliferation" -"GO:0034129","positive regulation of MyD88-independent toll-like receptor signaling pathway" -"GO:1903356","positive regulation of distal tip cell migration" -"GO:1901345","response to L-thialysine" -"GO:0071377","cellular response to glucagon stimulus" -"GO:0003425","establishment of mitotic spindle orientation involved in growth plate cartilage chondrocyte division" -"GO:1905785","negative regulation of anaphase-promoting complex-dependent catabolic process" -"GO:0072383","plus-end-directed vesicle transport along microtubule" -"GO:0009265","2'-deoxyribonucleotide biosynthetic process" -"GO:1904194","positive regulation of cholangiocyte apoptotic process" -"GO:0071816","tail-anchored membrane protein insertion into ER membrane" -"GO:0051046","regulation of secretion" -"GO:0048632","negative regulation of skeletal muscle tissue growth" -"GO:0010707","globoside biosynthetic process via lactosylceramide" -"GO:0045769","negative regulation of asymmetric cell division" -"GO:0090265","positive regulation of immune complex clearance by monocytes and macrophages" -"GO:0060927","cardiac pacemaker cell fate commitment" -"GO:0061670","evoked neurotransmitter secretion" -"GO:0071300","cellular response to retinoic acid" -"GO:0048097","long-term maintenance of gene activation" -"GO:0036205","histone catabolic process" -"GO:0071399","cellular response to linoleic acid" -"GO:1903394","protein localization to kinetochore involved in kinetochore assembly" -"GO:0090306","spindle assembly involved in meiosis" -"GO:0090324","negative regulation of oxidative phosphorylation" -"GO:0006107","oxaloacetate metabolic process" -"GO:1903959","regulation of anion transmembrane transport" -"GO:0052223","negative chemotaxis in environment of other organism involved in symbiotic interaction" -"GO:0043536","positive regulation of blood vessel endothelial cell migration" -"GO:0006189","'de novo' IMP biosynthetic process" -"GO:0021785","branchiomotor neuron axon guidance" -"GO:0000096","sulfur amino acid metabolic process" -"GO:0150020","basal dendrite arborization" -"GO:0031936","negative regulation of chromatin silencing" -"GO:0019415","acetate biosynthetic process from carbon monoxide" -"GO:0042255","ribosome assembly" -"GO:0043111","replication fork arrest" -"GO:0035593","positive regulation of Wnt signaling pathway by establishment of Wnt protein localization to extracellular region" -"GO:0009314","response to radiation" -"GO:0006167","AMP biosynthetic process" -"GO:0009785","blue light signaling pathway" -"GO:0010820","positive regulation of T cell chemotaxis" -"GO:0070307","lens fiber cell development" -"GO:0060891","limb granular cell differentiation" -"GO:0061402","positive regulation of transcription from RNA polymerase II promoter in response to acidic pH" -"GO:0014860","neurotransmitter secretion involved in regulation of skeletal muscle contraction" -"GO:0001408","guanine nucleotide transport" -"GO:0015189","L-lysine transmembrane transporter activity" -"GO:0060924","atrial cardiac muscle cell fate commitment" -"GO:0050819","negative regulation of coagulation" -"GO:0007010","cytoskeleton organization" -"GO:0001682","tRNA 5'-leader removal" -"GO:1900076","regulation of cellular response to insulin stimulus" -"GO:0061921","peptidyl-lysine propionylation" -"GO:0061529","epinephrine secretion, neurotransmission" -"GO:1903891","regulation of ATF6-mediated unfolded protein response" -"GO:0009060","aerobic respiration" -"GO:1902812","regulation of BMP signaling pathway involved in determination of lateral mesoderm left/right asymmetry" -"GO:0043438","acetoacetic acid metabolic process" -"GO:0061564","axon development" -"GO:0010961","cellular magnesium ion homeostasis" -"GO:0001881","receptor recycling" -"GO:0014823","response to activity" -"GO:0048673","collateral sprouting of intact axon in response to injury" -"GO:0043410","positive regulation of MAPK cascade" -"GO:0045468","regulation of R8 cell spacing in compound eye" -"GO:0048841","regulation of axon extension involved in axon guidance" -"GO:2000274","regulation of epithelial cell migration, open tracheal system" -"GO:0051257","meiotic spindle midzone assembly" -"GO:1904927","cellular response to palmitoleic acid" -"GO:0051088","PMA-inducible membrane protein ectodomain proteolysis" -"GO:0002250","adaptive immune response" -"GO:0097267","omega-hydroxylase P450 pathway" -"GO:0002837","regulation of immune response to tumor cell" -"GO:1990550","mitochondrial alpha-ketoglutarate transmembrane transport" -"GO:0071456","cellular response to hypoxia" -"GO:0006082","organic acid metabolic process" -"GO:0032438","melanosome organization" -"GO:0061262","mesonephric renal vesicle formation" -"GO:0070292","N-acylphosphatidylethanolamine metabolic process" -"GO:0030512","negative regulation of transforming growth factor beta receptor signaling pathway" -"GO:0070741","response to interleukin-6" -"GO:0097491","sympathetic neuron projection guidance" -"GO:1905653","positive regulation of artery morphogenesis" -"GO:1900533","palmitic acid metabolic process" -"GO:1905067","negative regulation of canonical Wnt signaling pathway involved in heart development" -"GO:0010950","positive regulation of endopeptidase activity" -"GO:0071812","positive regulation of fever generation by positive regulation of prostaglandin secretion" -"GO:0050761","depsipeptide metabolic process" -"GO:0070803","negative regulation of metula development" -"GO:0033993","response to lipid" -"GO:0061527","dopamine secretion, neurotransmission" -"GO:2000818","negative regulation of myoblast proliferation" -"GO:0043969","histone H2B acetylation" -"GO:0046903","secretion" -"GO:0052359","catabolism by organism of glucan in other organism involved in symbiotic interaction" -"GO:0042182","ketone catabolic process" -"GO:0038013","positive regulation of Wnt signaling pathway by Wnt receptor internalization" -"GO:1902725","negative regulation of satellite cell differentiation" -"GO:0060096","serotonin secretion, neurotransmission" -"GO:2000649","regulation of sodium ion transmembrane transporter activity" -"GO:0035857","eosinophil fate specification" -"GO:1904292","regulation of ERAD pathway" -"GO:0006421","asparaginyl-tRNA aminoacylation" -"GO:0030031","cell projection assembly" -"GO:0044208","'de novo' AMP biosynthetic process" -"GO:0046327","glycerol biosynthetic process from pyruvate" -"GO:0071600","otic vesicle morphogenesis" -"GO:1902321","methyl-branched fatty acid biosynthetic process" -"GO:1901389","negative regulation of transforming growth factor beta activation" -"GO:0006475","internal protein amino acid acetylation" -"GO:1905564","positive regulation of vascular endothelial cell proliferation" -"GO:0051365","cellular response to potassium ion starvation" -"GO:0009961","response to 1-aminocyclopropane-1-carboxylic acid" -"GO:0033564","anterior/posterior axon guidance" -"GO:0032008","positive regulation of TOR signaling" -"GO:0021873","forebrain neuroblast division" -"GO:0036486","ventral trunk neural crest cell migration" -"GO:1904693","midbrain morphogenesis" -"GO:0051445","regulation of meiotic cell cycle" -"GO:0036388","pre-replicative complex assembly" -"GO:0038161","prolactin signaling pathway" -"GO:0022618","ribonucleoprotein complex assembly" -"GO:0033693","neurofilament bundle assembly" -"GO:1904309","response to cordycepin" -"GO:0019543","propionate catabolic process" -"GO:0032945","negative regulation of mononuclear cell proliferation" -"GO:0061533","norepinephrine secretion, neurotransmission" -"GO:0046619","optic placode formation involved in camera-type eye formation" -"GO:1902287","semaphorin-plexin signaling pathway involved in axon guidance" -"GO:0035990","tendon cell differentiation" -"GO:0034177","positive regulation of toll-like receptor 12 signaling pathway" -"GO:0001886","endothelial cell morphogenesis" -"GO:0046986","negative regulation of hemoglobin biosynthetic process" -"GO:0051653","spindle localization" -"GO:2000850","negative regulation of glucocorticoid secretion" -"GO:0070365","hepatocyte differentiation" -"GO:0030511","positive regulation of transforming growth factor beta receptor signaling pathway" -"GO:0042738","exogenous drug catabolic process" -"GO:0071333","cellular response to glucose stimulus" -"GO:0010238","response to proline" -"GO:0002496","proteolysis associated with antigen processing and presentation" -"GO:1904382","mannose trimming involved in glycoprotein ERAD pathway" -"GO:1902647","negative regulation of 1-phosphatidyl-1D-myo-inositol 4,5-bisphosphate biosynthetic process" -"GO:1903375","facioacoustic ganglion development" -"GO:0080052","response to histidine" -"GO:0061383","trabecula morphogenesis" -"GO:0030307","positive regulation of cell growth" -"GO:0045610","regulation of hemocyte differentiation" -"GO:0090055","positive regulation of chromatin silencing at silent mating-type cassette" -"GO:0071298","cellular response to L-ascorbic acid" -"GO:0048522","positive regulation of cellular process" -"GO:0021828","gonadotrophin-releasing hormone neuronal migration to the hypothalamus" -"GO:0021637","trigeminal nerve structural organization" -"GO:0048846","axon extension involved in axon guidance" -"GO:1902513","regulation of organelle transport along microtubule" -"GO:0051272","positive regulation of cellular component movement" -"GO:0032457","fast endocytic recycling" -"GO:1902539","multi-organism macropinocytosis" -"GO:0036066","protein O-linked fucosylation" -"GO:0034355","NAD salvage" -"GO:0030719","P granule organization" -"GO:0032331","negative regulation of chondrocyte differentiation" -"GO:0032056","positive regulation of translation in response to stress" -"GO:0044269","glycerol ether catabolic process" -"GO:0033331","ent-kaurene metabolic process" -"GO:0001713","ectodermal cell fate determination" -"GO:0022611","dormancy process" -"GO:0099084","postsynaptic specialization organization" -"GO:0006986","response to unfolded protein" -"GO:0061588","calcium activated phospholipid scrambling" -"GO:0010878","cholesterol storage" -"GO:0010543","regulation of platelet activation" -"GO:0051761","sesquiterpene metabolic process" -"GO:0046439","L-cysteine metabolic process" -"GO:0072538","T-helper 17 type immune response" -"GO:0070832","phosphatidylcholine biosynthesis from phosphoryl-ethanolamine via N-dimethylethanolamine phosphate and CDP-choline" -"GO:0034263","positive regulation of autophagy in response to ER overload" -"GO:0048532","anatomical structure arrangement" -"GO:0040017","positive regulation of locomotion" -"GO:0019240","citrulline biosynthetic process" -"GO:0016446","somatic hypermutation of immunoglobulin genes" -"GO:0034174","toll-like receptor 12 signaling pathway" -"GO:0098727","maintenance of cell number" -"GO:0051131","chaperone-mediated protein complex assembly" -"GO:0071656","negative regulation of granulocyte colony-stimulating factor production" -"GO:0072423","response to DNA damage checkpoint signaling" -"GO:0080119","ER body organization" -"GO:0097704","cellular response to oscillatory fluid shear stress" -"GO:0019248","D-lactate biosynthetic process from methylglyoxal via (R)-lactaldehyde" -"GO:0120062","positive regulation of gastric emptying" -"GO:0005277","acetylcholine transmembrane transporter activity" -"GO:0070834","phosphatidylcholine biosynthesis from phosphoryl-ethanolamine via N-dimethylethanolamine phosphate and CDP-N-dimethylethanolamine" -"GO:0097111","endoplasmic reticulum-Golgi intermediate compartment organization" -"GO:1901998","toxin transport" -"GO:0071977","bacterial-type flagellum-dependent swimming motility" -"GO:0021615","glossopharyngeal nerve morphogenesis" -"GO:0010245","radial microtubular system formation" -"GO:0035480","regulation of Notch signaling pathway involved in heart induction" -"GO:0002930","trabecular meshwork development" -"GO:2000254","regulation of male germ cell proliferation" -"GO:0046963","3'-phosphoadenosine 5'-phosphosulfate transport" -"GO:1990255","subsynaptic reticulum organization" -"GO:0006207","'de novo' pyrimidine nucleobase biosynthetic process" -"GO:0003224","left ventricular compact myocardium morphogenesis" -"GO:0002757","immune response-activating signal transduction" -"GO:0046835","carbohydrate phosphorylation" -"GO:0001782","B cell homeostasis" -"GO:2000675","negative regulation of type B pancreatic cell apoptotic process" -"GO:0008202","steroid metabolic process" -"GO:1905100","regulation of apoptosome assembly" -"GO:0044725","chromatin reprogramming in the zygote" -"GO:1904496","positive regulation of substance P secretion, neurotransmission" -"GO:0006809","nitric oxide biosynthetic process" -"GO:0061112","negative regulation of bud outgrowth involved in lung branching" -"GO:0046209","nitric oxide metabolic process" -"GO:0042026","protein refolding" -"GO:1905639","positive regulation of mitochondrial mRNA catabolic process" -"GO:1990580","regulation of cytoplasmic translational termination" -"GO:0009590","detection of gravity" -"GO:0022616","DNA strand elongation" -"GO:0042894","fosmidomycin transport" -"GO:1904688","regulation of cytoplasmic translational initiation" -"GO:0010014","meristem initiation" -"GO:0003187","ventriculo bulbo valve morphogenesis" -"GO:0043550","regulation of lipid kinase activity" -"GO:0034605","cellular response to heat" -"GO:0042928","ferrichrome transport" -"GO:0044781","bacterial-type flagellum organization" -"GO:0006705","mineralocorticoid biosynthetic process" -"GO:0070409","carbamoyl phosphate biosynthetic process" -"GO:0006054","N-acetylneuraminate metabolic process" -"GO:0009657","plastid organization" -"GO:0002756","MyD88-independent toll-like receptor signaling pathway" -"GO:0044111","development involved in symbiotic interaction" -"GO:0015015","heparan sulfate proteoglycan biosynthetic process, enzymatic modification" -"GO:2000515","negative regulation of CD4-positive, alpha-beta T cell activation" -"GO:2000291","regulation of myoblast proliferation" -"GO:0019373","epoxygenase P450 pathway" -"GO:0070212","protein poly-ADP-ribosylation" -"GO:0006807","nitrogen compound metabolic process" -"GO:0031068","positive regulation of histone deacetylation at centromere" -"GO:0097737","acquisition of mycelium reproductive competence" -"GO:0046247","terpene catabolic process" -"GO:0006045","N-acetylglucosamine biosynthetic process" -"GO:0061592","phosphatidylserine exposure on osteoblast involved in bone mineralization" -"GO:0045478","fusome organization" -"GO:0009153","purine deoxyribonucleotide biosynthetic process" -"GO:0002519","natural killer cell tolerance induction" -"GO:0032613","interleukin-10 production" -"GO:0090639","phosphatidylcholine biosynthesis from choline and CDP-diacylglycerol" -"GO:0021923","cell proliferation in hindbrain ventricular zone" -"GO:0006004","fucose metabolic process" -"GO:0016099","monoterpenoid biosynthetic process" -"GO:0090362","positive regulation of platelet-derived growth factor production" -"GO:0051134","negative regulation of NK T cell activation" -"GO:0035682","toll-like receptor 21 signaling pathway" -"GO:1900163","positive regulation of phospholipid scramblase activity" -"GO:0070833","phosphatidylcholine biosynthesis from phosphoryl-ethanolamine via CDP-N-methylethanolamine" -"GO:0071603","endothelial cell-cell adhesion" -"GO:0034454","microtubule anchoring at centrosome" -"GO:0034178","toll-like receptor 13 signaling pathway" -"GO:0060588","negative regulation of lipoprotein lipid oxidation" -"GO:0072040","negative regulation of mesenchymal cell apoptotic process involved in nephron morphogenesis" -"GO:0070973","protein localization to endoplasmic reticulum exit site" -"GO:1903718","cellular response to ammonia" -"GO:0035806","modulation of blood coagulation in other organism" -"GO:0070925","organelle assembly" -"GO:0090719","adaptive immune effector response involving T cells and B lineage cells" -"GO:0051050","positive regulation of transport" -"GO:0003182","coronary sinus valve morphogenesis" -"GO:1905431","microcystin transport" -"GO:0010264","myo-inositol hexakisphosphate biosynthetic process" -"GO:0006560","proline metabolic process" -"GO:0090717","adaptive immune memory response involving T cells and B cells" -"GO:0042052","rhabdomere development" -"GO:0007549","dosage compensation" -"GO:0021700","developmental maturation" -"GO:0002859","negative regulation of natural killer cell mediated cytotoxicity directed against tumor cell target" -"GO:0097340","inhibition of cysteine-type endopeptidase activity" -"GO:0048308","organelle inheritance" -"GO:0140196","positive regulation of adenylate cyclase-activating adrenergic receptor signaling pathway involved in heart process" -"GO:0007571","age-dependent general metabolic decline" -"GO:0071400","cellular response to oleic acid" -"GO:0035681","toll-like receptor 15 signaling pathway" -"GO:1904442","negative regulation of thyroid gland epithelial cell proliferation" -"GO:0051217","molybdenum incorporation via L-aspartyl molybdenum bis(molybdopterin guanine dinucleotide)" -"GO:0030889","negative regulation of B cell proliferation" -"GO:1903008","organelle disassembly" -"GO:1900965","regulation of methanophenazine metabolic process" -"GO:0090667","cell chemotaxis to vascular endothelial growth factor" -"GO:0071471","cellular response to non-ionic osmotic stress" -"GO:0089705","protein localization to outer membrane" -"GO:0009152","purine ribonucleotide biosynthetic process" -"GO:1900852","regulation of terrequinone A biosynthetic process" -"GO:0002461","tolerance induction dependent upon immune response" -"GO:1905050","positive regulation of metallopeptidase activity" -"GO:1900125","regulation of hyaluronan biosynthetic process" -"GO:0031412","gas vesicle organization" -"GO:0034170","toll-like receptor 11 signaling pathway" -"GO:0002244","hematopoietic progenitor cell differentiation" -"GO:0031394","positive regulation of prostaglandin biosynthetic process" -"GO:0002284","myeloid dendritic cell differentiation involved in immune response" -"GO:0009714","chalcone metabolic process" -"GO:0071332","cellular response to fructose stimulus" -"GO:0034620","cellular response to unfolded protein" -"GO:0001549","cumulus cell differentiation" -"GO:0048398","intermediate mesodermal cell fate specification" -"GO:0034415","tRNA 3'-trailer cleavage, exonucleolytic" -"GO:0046722","lactic acid secretion" -"GO:0044238","primary metabolic process" -"GO:0090721","primary adaptive immune response involving T cells and B cells" -"GO:0030817","regulation of cAMP biosynthetic process" -"GO:0008089","anterograde axonal transport" -"GO:1902590","multi-organism organelle organization" -"GO:0043921","modulation by host of viral transcription" -"GO:1900980","regulation of phenazine biosynthetic process" -"GO:0097301","regulation of potassium ion concentration by positive regulation of transcription from RNA polymerase II promoter" -"GO:1904053","positive regulation of protein targeting to vacuole involved in autophagy" -"GO:0001865","NK T cell differentiation" -"GO:0097403","cellular response to raffinose" -"GO:0031103","axon regeneration" -"GO:0045064","T-helper 2 cell differentiation" -"GO:0009164","nucleoside catabolic process" -"GO:0038134","ERBB2-EGFR signaling pathway" -"GO:0014065","phosphatidylinositol 3-kinase signaling" -"GO:0006277","DNA amplification" -"GO:0019481","L-alanine catabolic process, by transamination" -"GO:0021832","cell-cell adhesion involved in cerebral cortex tangential migration using cell-cell interactions" -"GO:0048013","ephrin receptor signaling pathway" -"GO:0009304","tRNA transcription" -"GO:0043704","photoreceptor cell fate specification" -"GO:0035600","tRNA methylthiolation" -"GO:0006664","glycolipid metabolic process" -"GO:0046648","positive regulation of gamma-delta T cell proliferation" -"GO:0098759","cellular response to interleukin-8" -"GO:0071395","cellular response to jasmonic acid stimulus" -"GO:0045212","neurotransmitter receptor biosynthetic process" -"GO:0071805","potassium ion transmembrane transport" -"GO:0032456","endocytic recycling" -"GO:0010743","regulation of macrophage derived foam cell differentiation" -"GO:0060674","placenta blood vessel development" -"GO:1902187","negative regulation of viral release from host cell" -"GO:0003064","regulation of heart rate by hormone" -"GO:0071773","cellular response to BMP stimulus" -"GO:0034117","erythrocyte aggregation" -"GO:2000200","regulation of ribosomal subunit export from nucleus" -"GO:0060037","pharyngeal system development" -"GO:0006234","TTP biosynthetic process" -"GO:0046597","negative regulation of viral entry into host cell" -"GO:0006813","potassium ion transport" -"GO:0045058","T cell selection" -"GO:0002023","reduction of food intake in response to dietary excess" -"GO:1902027","positive regulation of cartilage condensation" -"GO:0001919","regulation of receptor recycling" -"GO:1900621","regulation of transcription from RNA polymerase II promoter by calcium-mediated signaling" -"GO:0070305","response to cGMP" -"GO:0030878","thyroid gland development" -"GO:0006581","acetylcholine catabolic process" -"GO:0097397","cellular response to interleukin-32" -"GO:0007601","visual perception" -"GO:2000553","positive regulation of T-helper 2 cell cytokine production" -"GO:0019321","pentose metabolic process" -"GO:0071355","cellular response to interleukin-9" -"GO:0043547","positive regulation of GTPase activity" -"GO:0030322","stabilization of membrane potential" -"GO:0070586","cell-cell adhesion involved in gastrulation" -"GO:0006686","sphingomyelin biosynthetic process" -"GO:0036216","cellular response to stem cell factor stimulus" -"GO:1905146","lysosomal protein catabolic process" -"GO:0006436","tryptophanyl-tRNA aminoacylation" -"GO:0018188","peptidyl-proline di-hydroxylation" -"GO:0035696","monocyte extravasation" -"GO:0061726","mitochondrion disassembly" -"GO:0045944","positive regulation of transcription by RNA polymerase II" -"GO:0110098","positive regulation of calcium import into the mitochondrion" -"GO:0006258","UDP-glucose catabolic process" -"GO:0060608","cell-cell adhesion involved in neural tube closure" -"GO:0035162","embryonic hemopoiesis" -"GO:0051056","regulation of small GTPase mediated signal transduction" -"GO:0015811","L-cystine transport" -"GO:0033499","galactose catabolic process via UDP-galactose" -"GO:0010292","GTP:GDP antiporter activity" -"GO:0071867","response to monoamine" -"GO:0009967","positive regulation of signal transduction" -"GO:0002791","regulation of peptide secretion" -"GO:0061728","GDP-mannose biosynthetic process from mannose" -"GO:0009454","aerotaxis" -"GO:0090102","cochlea development" -"GO:0014728","regulation of the force of skeletal muscle contraction" -"GO:0032303","regulation of icosanoid secretion" -"GO:0070428","regulation of nucleotide-binding oligomerization domain containing 1 signaling pathway" -"GO:0140159","borate export across plasma membrane" -"GO:0071349","cellular response to interleukin-12" -"GO:0034642","mitochondrion migration along actin filament" -"GO:0046051","UTP metabolic process" -"GO:0000416","positive regulation of histone H3-K36 methylation" -"GO:1902429","positive regulation of water channel activity" -"GO:0010619","adenylate cyclase-activating glucose-activated G-protein coupled receptor signaling pathway" -"GO:1905887","autoinducer AI-2 transmembrane transport" -"GO:0043087","regulation of GTPase activity" -"GO:0070534","protein K63-linked ubiquitination" -"GO:0090398","cellular senescence" -"GO:0075331","negative regulation of arbuscule formation for nutrient acquisition from host" -"GO:1904995","negative regulation of leukocyte adhesion to vascular endothelial cell" -"GO:0002221","pattern recognition receptor signaling pathway" -"GO:0140067","peptidyl-lysine butyrylation" -"GO:0097398","cellular response to interleukin-17" -"GO:2000238","regulation of tRNA export from nucleus" -"GO:0046041","ITP metabolic process" -"GO:0060502","epithelial cell proliferation involved in lung morphogenesis" -"GO:0046511","sphinganine biosynthetic process" -"GO:0006366","transcription by RNA polymerase II" -"GO:0061913","positive regulation of growth plate cartilage chondrocyte proliferation" -"GO:1903815","negative regulation of collecting lymphatic vessel constriction" -"GO:0001507","acetylcholine catabolic process in synaptic cleft" -"GO:0007042","lysosomal lumen acidification" -"GO:0032223","negative regulation of synaptic transmission, cholinergic" -"GO:0061290","canonical Wnt signaling pathway involved in metanephric kidney development" -"GO:0042174","negative regulation of sporulation resulting in formation of a cellular spore" -"GO:0090245","axis elongation involved in somitogenesis" -"GO:0071352","cellular response to interleukin-2" -"GO:0006011","UDP-glucose metabolic process" -"GO:0003367","cell-cell adhesion involved in ameboidal cell migration" -"GO:1903595","positive regulation of histamine secretion by mast cell" -"GO:0048679","regulation of axon regeneration" -"GO:0051148","negative regulation of muscle cell differentiation" -"GO:0042558","pteridine-containing compound metabolic process" -"GO:0035989","tendon development" -"GO:0035397","helper T cell enhancement of adaptive immune response" -"GO:0052501","positive regulation by organism of apoptotic process in other organism involved in symbiotic interaction" -"GO:0070371","ERK1 and ERK2 cascade" -"GO:0070897","DNA-templated transcriptional preinitiation complex assembly" -"GO:0090592","DNA synthesis involved in DNA replication" -"GO:0044110","growth involved in symbiotic interaction" -"GO:0006959","humoral immune response" -"GO:0003317","cardioblast cell midline fusion" -"GO:0006122","mitochondrial electron transport, ubiquinol to cytochrome c" -"GO:0045657","positive regulation of monocyte differentiation" -"GO:0072602","interleukin-4 secretion" -"GO:0035271","ring gland development" -"GO:0009887","animal organ morphogenesis" -"GO:0006384","transcription initiation from RNA polymerase III promoter" -"GO:0001654","eye development" -"GO:0050770","regulation of axonogenesis" -"GO:0015790","UDP-xylose transmembrane transport" -"GO:0090235","regulation of metaphase plate congression" -"GO:1902624","positive regulation of neutrophil migration" -"GO:1990058","fruit replum development" -"GO:0034141","positive regulation of toll-like receptor 3 signaling pathway" -"GO:0002100","tRNA wobble adenosine to inosine editing" -"GO:0008635","activation of cysteine-type endopeptidase activity involved in apoptotic process by cytochrome c" -"GO:0033133","positive regulation of glucokinase activity" -"GO:0009415","response to water" -"GO:0072302","negative regulation of metanephric glomerular mesangial cell proliferation" -"GO:0044863","modulation by virus of host cell division" -"GO:0032203","telomere formation via telomerase" -"GO:1905136","dethiobiotin import across plasma membrane" -"GO:1902558","5'-adenylyl sulfate transmembrane transport" -"GO:1990045","sclerotium development" -"GO:0033030","negative regulation of neutrophil apoptotic process" -"GO:0060475","positive regulation of actin filament polymerization involved in acrosome reaction" -"GO:0002524","hypersensitivity" -"GO:0021507","posterior neuropore closure" -"GO:1903717","response to ammonia" -"GO:0009651","response to salt stress" -"GO:0034225","regulation of transcription from RNA polymerase II promoter in response to zinc ion starvation" -"GO:0033394","beta-alanine biosynthetic process via 1,3 diaminopropane" -"GO:0060138","fetal process involved in parturition" -"GO:0007624","ultradian rhythm" -"GO:0052646","alditol phosphate metabolic process" -"GO:0048624","plantlet formation on parent plant" -"GO:0010524","positive regulation of calcium ion transport into cytosol" -"GO:0060923","cardiac muscle cell fate commitment" -"GO:0080182","histone H3-K4 trimethylation" -"GO:1901349","glucosinolate transport" -"GO:0072056","pyramid development" -"GO:0000212","meiotic spindle organization" -"GO:1900186","negative regulation of clathrin-dependent endocytosis" -"GO:1903896","positive regulation of IRE1-mediated unfolded protein response" -"GO:0048561","establishment of animal organ orientation" -"GO:0060806","negative regulation of cell differentiation involved in embryonic placenta development" -"GO:0015789","UDP-N-acetylgalactosamine transmembrane transport" -"GO:1902625","negative regulation of induction of conjugation with cellular fusion by negative regulation of transcription from RNA polymerase II promoter" -"GO:0090010","transforming growth factor beta receptor signaling pathway involved in primitive streak formation" -"GO:0019099","female germ-line sex determination" -"GO:0016525","negative regulation of angiogenesis" -"GO:1901281","fructoselysine catabolic process" -"GO:0060802","epiblast cell-extraembryonic ectoderm cell signaling involved in anterior/posterior axis specification" -"GO:0045730","respiratory burst" -"GO:0034628","'de novo' NAD biosynthetic process from aspartate" -"GO:2000805","negative regulation of termination of RNA polymerase II transcription, poly(A)-coupled" -"GO:0055004","atrial cardiac myofibril assembly" -"GO:0030163","protein catabolic process" -"GO:0006598","polyamine catabolic process" -"GO:0031215","shell calcification" -"GO:1901164","negative regulation of trophoblast cell migration" -"GO:0070914","UV-damage excision repair" -"GO:1903684","regulation of border follicle cell migration" -"GO:1901536","negative regulation of DNA demethylation" -"GO:0072428","signal transduction involved in intra-S DNA damage checkpoint" -"GO:1900471","negative regulation of inositol biosynthetic process by negative regulation of transcription from RNA polymerase II promoter" -"GO:0030574","collagen catabolic process" -"GO:0060147","regulation of posttranscriptional gene silencing" -"GO:0017192","N-terminal peptidyl-glutamine acetylation" -"GO:2000669","negative regulation of dendritic cell apoptotic process" -"GO:1904089","negative regulation of neuron apoptotic process by negative regulation of transcription from RNA polymerase II promoter" -"GO:1905476","negative regulation of protein localization to membrane" -"GO:0002693","positive regulation of cellular extravasation" -"GO:2000396","negative regulation of ubiquitin-dependent endocytosis" -"GO:0017187","peptidyl-glutamic acid carboxylation" -"GO:0043362","nucleate erythrocyte maturation" -"GO:0002573","myeloid leukocyte differentiation" -"GO:0071244","cellular response to carbon dioxide" -"GO:0044065","regulation of respiratory system process" -"GO:2001012","mesenchymal cell differentiation involved in renal system development" -"GO:0010255","glucose mediated signaling pathway" -"GO:0043627","response to estrogen" -"GO:1901219","regulation of cardiac chamber morphogenesis" -"GO:0006637","acyl-CoA metabolic process" -"GO:0002085","inhibition of neuroepithelial cell differentiation" -"GO:0033622","integrin activation" -"GO:0000955","amino acid catabolic process via Ehrlich pathway" -"GO:0036508","protein alpha-1,2-demannosylation" -"GO:0045299","otolith mineralization" -"GO:0003352","regulation of cilium movement" -"GO:0010883","regulation of lipid storage" -"GO:0032292","peripheral nervous system axon ensheathment" -"GO:1905215","negative regulation of RNA binding" -"GO:0002365","gamma-delta T cell lineage commitment" -"GO:0003281","ventricular septum development" -"GO:0048589","developmental growth" -"GO:0046638","positive regulation of alpha-beta T cell differentiation" -"GO:0075606","transport of viral material towards nucleus" -"GO:0033366","protein localization to secretory granule" -"GO:1903601","thermospermine metabolic process" -"GO:0021871","forebrain regionalization" -"GO:0071457","cellular response to ozone" -"GO:0001183","transcription elongation from RNA polymerase I promoter for nuclear large rRNA transcript" -"GO:0051569","regulation of histone H3-K4 methylation" -"GO:1900170","negative regulation of glucocorticoid mediated signaling pathway" -"GO:0070350","regulation of white fat cell proliferation" -"GO:0086073","bundle of His cell-Purkinje myocyte adhesion involved in cell communication" -"GO:0017195","N-terminal peptidyl-lysine N2-acetylation" -"GO:0015798","myo-inositol transport" -"GO:1902213","positive regulation of prolactin signaling pathway" -"GO:0080189","primary growth" -"GO:0048477","oogenesis" -"GO:0007086","vesicle fusion with nuclear membrane involved in mitotic nuclear envelope reassembly" -"GO:0009888","tissue development" -"GO:0006307","DNA dealkylation involved in DNA repair" -"GO:1901606","alpha-amino acid catabolic process" -"GO:0065007","biological regulation" -"GO:0048469","cell maturation" -"GO:0046015","regulation of transcription by glucose" -"GO:0072182","regulation of nephron tubule epithelial cell differentiation" -"GO:0010477","response to sulfur dioxide" -"GO:0018001","N-terminal peptidyl-valine acetylation" -"GO:1903683","positive regulation of epithelial cell-cell adhesion involved in epithelium migration" -"GO:0075519","microtubule-dependent intracellular transport of viral material" -"GO:0046950","cellular ketone body metabolic process" -"GO:2000611","positive regulation of thyroid hormone generation" -"GO:0042554","superoxide anion generation" -"GO:1904425","negative regulation of GTP binding" -"GO:0016270","O-glycan processing, core 4" -"GO:0051965","positive regulation of synapse assembly" -"GO:0035020","regulation of Rac protein signal transduction" -"GO:0042245","RNA repair" -"GO:0010085","polarity specification of proximal/distal axis" -"GO:0036340","chitin-based cuticle sclerotization by biomineralization" -"GO:0035530","chemokine (C-C motif) ligand 6 production" -"GO:0048486","parasympathetic nervous system development" -"GO:0032753","positive regulation of interleukin-4 production" -"GO:1904169","positive regulation of thyroid hormone receptor activity" -"GO:1904465","negative regulation of matrix metallopeptidase secretion" -"GO:1905697","negative regulation of polysome binding" -"GO:0048295","positive regulation of isotype switching to IgE isotypes" -"GO:0008064","regulation of actin polymerization or depolymerization" -"GO:0048275","N-terminal peptidyl-arginine acetylation" -"GO:0002674","negative regulation of acute inflammatory response" -"GO:1903851","negative regulation of cristae formation" -"GO:0033505","floor plate morphogenesis" -"GO:0000820","regulation of glutamine family amino acid metabolic process" -"GO:0010721","negative regulation of cell development" -"GO:1905854","negative regulation of heparan sulfate binding" -"GO:1903556","negative regulation of tumor necrosis factor superfamily cytokine production" -"GO:0007445","determination of imaginal disc primordium" -"GO:0032636","interleukin-7 production" -"GO:0045853","negative regulation of bicoid mRNA localization" -"GO:0150033","negative regulation of protein localization to lysosome" -"GO:0000461","endonucleolytic cleavage to generate mature 3'-end of SSU-rRNA from (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:2000278","regulation of DNA biosynthetic process" -"GO:0110084","negative regulation of protein localization to cell division site involved in mitotic actomyosin contractile ring assembly" -"GO:1904727","negative regulation of replicative senescence" -"GO:0048327","axial mesodermal cell fate specification" -"GO:0090033","positive regulation of filamentous growth" -"GO:0010332","response to gamma radiation" -"GO:1903761","negative regulation of voltage-gated potassium channel activity involved in ventricular cardiac muscle cell action potential repolarization" -"GO:0050966","detection of mechanical stimulus involved in sensory perception of pain" -"GO:1903067","negative regulation of protein localization to cell tip" -"GO:0000012","single strand break repair" -"GO:0035799","ureter maturation" -"GO:0008584","male gonad development" -"GO:0052330","positive regulation by organism of programmed cell death in other organism involved in symbiotic interaction" -"GO:0031115","negative regulation of microtubule polymerization" -"GO:1905170","negative regulation of protein localization to phagocytic vesicle" -"GO:0018873","atrazine metabolic process" -"GO:0006968","cellular defense response" -"GO:0070145","mitochondrial asparaginyl-tRNA aminoacylation" -"GO:0036511","trimming of first mannose on A branch" -"GO:0032209","positive regulation of telomere maintenance via recombination" -"GO:1900099","negative regulation of plasma cell differentiation" -"GO:0010121","arginine catabolic process to proline via ornithine" -"GO:0022029","telencephalon cell migration" -"GO:0006794","phosphorus utilization" -"GO:0016268","O-glycan processing, core 2" -"GO:1905667","negative regulation of protein localization to endosome" -"GO:0050965","detection of temperature stimulus involved in sensory perception of pain" -"GO:2000679","positive regulation of transcription regulatory region DNA binding" -"GO:0060265","positive regulation of respiratory burst involved in inflammatory response" -"GO:0140194","negative regulation of adenylate cyclase-inhibiting adrenergic receptor signaling pathway involved in heart process" -"GO:0039595","induction by virus of catabolism of host mRNA" -"GO:1990627","mitochondrial inner membrane fusion" -"GO:0001766","membrane raft polarization" -"GO:0098754","detoxification" -"GO:0001920","negative regulation of receptor recycling" -"GO:0045599","negative regulation of fat cell differentiation" -"GO:0007021","tubulin complex assembly" -"GO:0097206","nephrocyte filtration" -"GO:1904780","negative regulation of protein localization to centrosome" -"GO:1905527","negative regulation of Golgi lumen acidification" -"GO:0000447","endonucleolytic cleavage in ITS1 to separate SSU-rRNA from 5.8S rRNA and LSU-rRNA from tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:0045716","positive regulation of low-density lipoprotein particle receptor biosynthetic process" -"GO:0061085","regulation of histone H3-K27 methylation" -"GO:0032917","polyamine acetylation" -"GO:0045594","positive regulation of cumulus cell differentiation" -"GO:1904597","negative regulation of connective tissue replacement involved in inflammatory response wound healing" -"GO:1905551","negative regulation of protein localization to endoplasmic reticulum" -"GO:0002438","acute inflammatory response to antigenic stimulus" -"GO:0071599","otic vesicle development" -"GO:0034640","establishment of mitochondrion localization by microtubule attachment" -"GO:0070809","negative regulation of Hulle cell development" -"GO:0043370","regulation of CD4-positive, alpha-beta T cell differentiation" -"GO:1904433","negative regulation of ferrous iron binding" -"GO:0099188","postsynaptic cytoskeleton organization" -"GO:0036509","trimming of terminal mannose on B branch" -"GO:0050930","induction of positive chemotaxis" -"GO:0009203","ribonucleoside triphosphate catabolic process" -"GO:2000734","negative regulation of glial cell-derived neurotrophic factor receptor signaling pathway involved in ureteric bud formation" -"GO:0031042","O-glycan processing, core 6" -"GO:0001910","regulation of leukocyte mediated cytotoxicity" -"GO:0009074","aromatic amino acid family catabolic process" -"GO:1903235","positive regulation of calcium ion-dependent exocytosis of neurotransmitter" -"GO:0018275","N-terminal peptidyl-cysteine acetylation" -"GO:0072676","lymphocyte migration" -"GO:0042596","fear response" -"GO:0030010","establishment of cell polarity" -"GO:0035552","oxidative single-stranded DNA demethylation" -"GO:1903387","positive regulation of homophilic cell adhesion" -"GO:1902902","negative regulation of autophagosome assembly" -"GO:1904996","positive regulation of leukocyte adhesion to vascular endothelial cell" -"GO:0099087","anterograde axonal transport of messenger ribonucleoprotein complex" -"GO:1990478","response to ultrasound" -"GO:0034214","protein hexamerization" -"GO:0006449","regulation of translational termination" -"GO:1900175","regulation of nodal signaling pathway involved in determination of lateral mesoderm left/right asymmetry" -"GO:0044718","siderophore transmembrane transport" -"GO:1902596","negative regulation of DNA replication origin binding" -"GO:0060966","regulation of gene silencing by RNA" -"GO:0000077","DNA damage checkpoint" -"GO:0061548","ganglion development" -"GO:2000884","glucomannan catabolic process" -"GO:0045187","regulation of circadian sleep/wake cycle, sleep" -"GO:0009791","post-embryonic development" -"GO:0086102","adenylate cyclase-inhibiting G-protein coupled acetylcholine receptor signaling pathway involved in negative regulation of heart rate" -"GO:0001831","trophectodermal cellular morphogenesis" -"GO:0015884","folic acid transport" -"GO:0036512","trimming of second mannose on A branch" -"GO:0075732","viral penetration into host nucleus" -"GO:0021519","spinal cord association neuron specification" -"GO:1904420","positive regulation of telomeric loop formation" -"GO:0060516","primary prostatic bud elongation" -"GO:0097338","response to clozapine" -"GO:0042152","RNA-mediated DNA recombination" -"GO:0009583","detection of light stimulus" -"GO:0048391","intermediate mesoderm formation" -"GO:2000601","positive regulation of Arp2/3 complex-mediated actin nucleation" -"GO:0014008","positive regulation of microglia differentiation" -"GO:1903232","melanosome assembly" -"GO:0051975","lysine biosynthetic process via alpha-aminoadipate and saccharopine" -"GO:0070229","negative regulation of lymphocyte apoptotic process" -"GO:1990256","signal clustering" -"GO:0001751","compound eye photoreceptor cell differentiation" -"GO:0010701","positive regulation of norepinephrine secretion" -"GO:2001311","lysobisphosphatidic acid metabolic process" -"GO:1903850","regulation of cristae formation" -"GO:0048303","negative regulation of isotype switching to IgG isotypes" -"GO:0002125","maternal aggressive behavior" -"GO:0000912","assembly of actomyosin apparatus involved in cytokinesis" -"GO:0043952","protein transport by the Sec complex" -"GO:0045925","positive regulation of female receptivity" -"GO:0036214","contractile ring localization" -"GO:0015490","cadaverine transmembrane transporter activity" -"GO:0019440","tryptophan catabolic process to indole-3-acetate" -"GO:0070432","regulation of nucleotide-binding oligomerization domain containing 2 signaling pathway" -"GO:1903660","negative regulation of complement-dependent cytotoxicity" -"GO:0040030","regulation of molecular function, epigenetic" -"GO:0006723","cuticle hydrocarbon biosynthetic process" -"GO:0002495","antigen processing and presentation of peptide antigen via MHC class II" -"GO:0043288","apocarotenoid metabolic process" -"GO:0034150","toll-like receptor 6 signaling pathway" -"GO:0060179","male mating behavior" -"GO:0035065","regulation of histone acetylation" -"GO:1901546","regulation of synaptic vesicle lumen acidification" -"GO:0001774","microglial cell activation" -"GO:0050707","regulation of cytokine secretion" -"GO:0002158","osteoclast proliferation" -"GO:0051276","chromosome organization" -"GO:0045472","response to ether" -"GO:0019403","galactitol biosynthetic process" -"GO:1901251","positive regulation of lung goblet cell differentiation" -"GO:0031643","positive regulation of myelination" -"GO:0090297","positive regulation of mitochondrial DNA replication" -"GO:1905148","negative regulation of smooth muscle hypertrophy" -"GO:0015599","glutamine-importing ATPase activity" -"GO:0055022","negative regulation of cardiac muscle tissue growth" -"GO:1904376","negative regulation of protein localization to cell periphery" -"GO:1905677","regulation of adaptive immune effector response" -"GO:0060410","negative regulation of acetylcholine metabolic process" -"GO:1904892","regulation of STAT cascade" -"GO:0000950","branched-chain amino acid catabolic process to alcohol via Ehrlich pathway" -"GO:0042265","peptidyl-asparagine hydroxylation" -"GO:0051251","positive regulation of lymphocyte activation" -"GO:0010175","sphingosine transmembrane transporter activity" -"GO:1901247","negative regulation of lung ciliated cell differentiation" -"GO:0002390","platelet activating factor production" -"GO:1903001","negative regulation of lipid transport across blood brain barrier" -"GO:1904684","negative regulation of metalloendopeptidase activity" -"GO:0042179","nicotine biosynthetic process" -"GO:1901581","negative regulation of telomeric RNA transcription from RNA pol II promoter" -"GO:1901051","atropine biosynthetic process" -"GO:0045189","connective tissue growth factor biosynthetic process" -"GO:0038094","Fc-gamma receptor signaling pathway" -"GO:0002138","retinoic acid biosynthetic process" -"GO:1904670","actin filament polymerization involved in mitotic actomyosin contractile ring assembly" -"GO:0006027","glycosaminoglycan catabolic process" -"GO:0051654","establishment of mitochondrion localization" -"GO:0015330","high-affinity glutamine transmembrane transporter activity" -"GO:0032074","negative regulation of nuclease activity" -"GO:0070998","sensory perception of gravity" -"GO:1901230","negative regulation of non-canonical Wnt signaling pathway via JNK cascade" -"GO:0060628","regulation of ER to Golgi vesicle-mediated transport" -"GO:0050909","sensory perception of taste" -"GO:1904614","response to biphenyl" -"GO:1903824","negative regulation of telomere single strand break repair" -"GO:0060450","positive regulation of hindgut contraction" -"GO:0044592","response to pullulan" -"GO:0001969","regulation of activation of membrane attack complex" -"GO:0060007","linear vestibuloocular reflex" -"GO:0048264","determination of ventral identity" -"GO:0043538","regulation of actin phosphorylation" -"GO:0007105","cytokinesis, site selection" -"GO:2000231","positive regulation of pancreatic stellate cell proliferation" -"GO:0060455","negative regulation of gastric acid secretion" -"GO:1904205","negative regulation of skeletal muscle hypertrophy" -"GO:0042711","maternal behavior" -"GO:1901904","tyrocidine biosynthetic process" -"GO:2000763","positive regulation of transcription from RNA polymerase II promoter involved in norepinephrine biosynthetic process" -"GO:0060341","regulation of cellular localization" -"GO:0098509","sensory perception of humidity" -"GO:0060821","inactivation of X chromosome by DNA methylation" -"GO:0046230","2-aminobenzenesulfonate catabolic process" -"GO:0030382","sperm mitochondrion organization" -"GO:0010155","regulation of proton transport" -"GO:0008300","isoprenoid catabolic process" -"GO:1904380","endoplasmic reticulum mannose trimming" -"GO:0086049","membrane repolarization during AV node cell action potential" -"GO:0034285","response to disaccharide" -"GO:1902621","actomyosin contractile ring disassembly" -"GO:0034695","response to prostaglandin E" -"GO:0043040","tRNA aminoacylation for nonribosomal peptide biosynthetic process" -"GO:0006058","mannoprotein catabolic process" -"GO:0098874","spike train" -"GO:0009639","response to red or far red light" -"GO:0032723","positive regulation of connective tissue growth factor production" -"GO:0099185","postsynaptic intermediate filament cytoskeleton organization" -"GO:0060406","positive regulation of penile erection" -"GO:0070680","asparaginyl-tRNAAsn biosynthesis via transamidation" -"GO:1900112","regulation of histone H3-K9 trimethylation" -"GO:0010555","response to mannitol" -"GO:0030965","plasma membrane electron transport, NADH to quinone" -"GO:0038001","paracrine signaling" -"GO:0050753","negative regulation of fractalkine biosynthetic process" -"GO:1904463","ergosteryl 3-beta-D-glucoside biosynthetic process" -"GO:0034123","positive regulation of toll-like receptor signaling pathway" -"GO:0043335","protein unfolding" -"GO:2000151","negative regulation of planar cell polarity pathway involved in cardiac muscle tissue morphogenesis" -"GO:0051466","positive regulation of corticotropin-releasing hormone secretion" -"GO:0070235","regulation of activation-induced cell death of T cells" -"GO:0075251","uredospore formation" -"GO:0014711","regulation of branchiomeric skeletal muscle development" -"GO:0071635","negative regulation of transforming growth factor beta production" -"GO:0098828","modulation of inhibitory postsynaptic potential" -"GO:0060816","random inactivation of X chromosome" -"GO:0034112","positive regulation of homotypic cell-cell adhesion" -"GO:0036138","peptidyl-histidine hydroxylation" -"GO:1903960","negative regulation of anion transmembrane transport" -"GO:1902364","negative regulation of protein localization to spindle pole body" -"GO:0060526","prostate glandular acinus morphogenesis" -"GO:0007289","spermatid nucleus differentiation" -"GO:0097581","lamellipodium organization" -"GO:0032424","negative regulation of mismatch repair" -"GO:0098736","negative regulation of the force of heart contraction" -"GO:0009730","detection of carbohydrate stimulus" -"GO:0015220","choline transmembrane transporter activity" -"GO:0043584","nose development" -"GO:0006419","alanyl-tRNA aminoacylation" -"GO:1901394","positive regulation of transforming growth factor beta1 activation" -"GO:0035811","negative regulation of urine volume" -"GO:0032434","regulation of proteasomal ubiquitin-dependent protein catabolic process" -"GO:0090162","establishment of epithelial cell polarity" -"GO:0051559","phlobaphene biosynthetic process" -"GO:1904525","positive regulation of DNA amplification" -"GO:1900270","positive regulation of reverse transcription" -"GO:0010590","regulation of cell separation after cytokinesis" -"GO:0000953","branched-chain amino acid catabolic process to carboxylic acid via Ehrlich pathway" -"GO:0090277","positive regulation of peptide hormone secretion" -"GO:1903484","negative regulation of maintenance of mitotic actomyosin contractile ring localization" -"GO:0015222","serotonin transmembrane transporter activity" -"GO:0034146","toll-like receptor 5 signaling pathway" -"GO:0097018","renal albumin absorption" -"GO:0061431","cellular response to methionine" -"GO:0050952","sensory perception of electrical stimulus" -"GO:1901277","tartrate biosynthetic process" -"GO:1903301","positive regulation of hexokinase activity" -"GO:0015985","energy coupled proton transport, down electrochemical gradient" -"GO:0043632","modification-dependent macromolecule catabolic process" -"GO:0042756","drinking behavior" -"GO:0044249","cellular biosynthetic process" -"GO:0071452","cellular response to singlet oxygen" -"GO:1902322","regulation of methyl-branched fatty acid biosynthetic process" -"GO:2001271","negative regulation of cysteine-type endopeptidase activity involved in execution phase of apoptosis" -"GO:0046008","regulation of female receptivity, post-mating" -"GO:0014916","regulation of lung blood pressure" -"GO:0005329","dopamine transmembrane transporter activity" -"GO:0033861","negative regulation of NAD(P)H oxidase activity" -"GO:0015606","spermidine transmembrane transporter activity" -"GO:1902422","hydrogen biosynthetic process" -"GO:0010216","maintenance of DNA methylation" -"GO:0022000","forebrain induction by the anterior neural ridge" -"GO:0034228","ethanolamine transmembrane transporter activity" -"GO:2000240","positive regulation of tRNA export from nucleus" -"GO:0071605","monocyte chemotactic protein-1 production" -"GO:0002818","intracellular defense response" -"GO:0046493","lipid A metabolic process" -"GO:1903377","negative regulation of oxidative stress-induced neuron intrinsic apoptotic signaling pathway" -"GO:0060708","spongiotrophoblast differentiation" -"GO:0048824","pigment cell precursor differentiation" -"GO:1905459","regulation of vascular associated smooth muscle cell apoptotic process" -"GO:0071868","cellular response to monoamine stimulus" -"GO:0032603","fractalkine production" -"GO:0030435","sporulation resulting in formation of a cellular spore" -"GO:0030865","cortical cytoskeleton organization" -"GO:0071323","cellular response to chitin" -"GO:2000971","negative regulation of detection of glucose" -"GO:2000760","negative regulation of N-terminal peptidyl-lysine acetylation" -"GO:0072566","chemokine (C-X-C motif) ligand 1 production" -"GO:1900246","positive regulation of RIG-I signaling pathway" -"GO:0032124","macronucleus organization" -"GO:0044328","canonical Wnt signaling pathway involved in positive regulation of endothelial cell migration" -"GO:0061843","Sertoli cell barrier remodeling" -"GO:0030728","ovulation" -"GO:1904392","cellular response to ciliary neurotrophic factor" -"GO:0046133","pyrimidine ribonucleoside catabolic process" -"GO:0032507","maintenance of protein location in cell" -"GO:0090189","regulation of branching involved in ureteric bud morphogenesis" -"GO:0021815","modulation of microtubule cytoskeleton involved in cerebral cortex radial glia guided migration" -"GO:0048268","clathrin coat assembly" -"GO:0098903","regulation of membrane repolarization during action potential" -"GO:1904482","cellular response to tetrahydrofolate" -"GO:0048657","anther wall tapetum cell differentiation" -"GO:0033500","carbohydrate homeostasis" -"GO:0045907","positive regulation of vasoconstriction" -"GO:0072747","cellular response to chloramphenicol" -"GO:1904098","regulation of protein O-linked glycosylation" -"GO:0051682","galactomannan catabolic process" -"GO:0070299","positive regulation of phosphorelay signal transduction system" -"GO:0033385","geranylgeranyl diphosphate metabolic process" -"GO:0072711","cellular response to hydroxyurea" -"GO:0061885","positive regulation of mini excitatory postsynaptic potential" -"GO:1901734","quercetin biosynthetic process" -"GO:0032372","negative regulation of sterol transport" -"GO:0048235","pollen sperm cell differentiation" -"GO:1990227","paranodal junction maintenance" -"GO:0002011","morphogenesis of an epithelial sheet" -"GO:0061132","pancreas induction" -"GO:0070142","synaptic vesicle budding" -"GO:0033137","negative regulation of peptidyl-serine phosphorylation" -"GO:0006718","juvenile hormone biosynthetic process" -"GO:0099113","negative regulation of presynaptic cytosolic calcium concentration" -"GO:0030857","negative regulation of epithelial cell differentiation" -"GO:0009693","ethylene biosynthetic process" -"GO:0035051","cardiocyte differentiation" -"GO:1904317","cellular response to 2-O-acetyl-1-O-hexadecyl-sn-glycero-3-phosphocholine" -"GO:0098990","AMPA selective glutamate receptor signaling pathway" -"GO:0046765","viral budding from nuclear membrane" -"GO:0072584","caveolin-mediated endocytosis" -"GO:0051414","response to cortisol" -"GO:0050993","dimethylallyl diphosphate metabolic process" -"GO:1900199","positive regulation of protein export from nucleus during meiotic anaphase II" -"GO:1902909","negative regulation of melanosome transport" -"GO:0072361","regulation of glycolytic process by regulation of transcription from RNA polymerase II promoter" -"GO:0048889","neuromast support cell differentiation" -"GO:0034477","U6 snRNA 3'-end processing" -"GO:0035895","modulation of mast cell degranulation in other organism" -"GO:1904261","positive regulation of basement membrane assembly involved in embryonic body morphogenesis" -"GO:0009251","glucan catabolic process" -"GO:0043278","response to morphine" -"GO:0051899","membrane depolarization" -"GO:1902191","2-methylbutanoyl-CoA(4-) biosynthetic process" -"GO:1901741","positive regulation of myoblast fusion" -"GO:0072725","cellular response to 4-nitroquinoline N-oxide" -"GO:0071612","IP-10 production" -"GO:0000921","septin ring assembly" -"GO:0046185","aldehyde catabolic process" -"GO:1902998","positive regulation of neurofibrillary tangle assembly" -"GO:2000032","regulation of secondary shoot formation" -"GO:0051546","keratinocyte migration" -"GO:0046490","isopentenyl diphosphate metabolic process" -"GO:0097391","chemokine (C-X-C motif) ligand 13 production" -"GO:1904586","cellular response to putrescine" -"GO:0044532","modulation of apoptotic process in other organism" -"GO:0034151","regulation of toll-like receptor 6 signaling pathway" -"GO:1902126","(+)-pinoresinol biosynthetic process" -"GO:1904679","myo-inositol import across plasma membrane" -"GO:0003057","regulation of the force of heart contraction by chemical signal" -"GO:1904238","pericyte cell differentiation" -"GO:1900115","extracellular regulation of signal transduction" -"GO:0072567","chemokine (C-X-C motif) ligand 2 production" -"GO:0050999","regulation of nitric-oxide synthase activity" -"GO:0006668","sphinganine-1-phosphate metabolic process" -"GO:0033383","geranyl diphosphate metabolic process" -"GO:0019659","glucose catabolic process to lactate" -"GO:1905716","negative regulation of cornification" -"GO:1904102","cellular response to acadesine" -"GO:0019324","L-lyxose metabolic process" -"GO:1905603","regulation of maintenance of permeability of blood-brain barrier" -"GO:0016064","immunoglobulin mediated immune response" -"GO:0070304","positive regulation of stress-activated protein kinase signaling cascade" -"GO:0009697","salicylic acid biosynthetic process" -"GO:0043158","heterocyst differentiation" -"GO:1905440","cellular response to chondroitin 6'-sulfate" -"GO:0019217","regulation of fatty acid metabolic process" -"GO:0031426","polycistronic mRNA processing" -"GO:1905572","ganglioside GM1 transport to membrane" -"GO:0035167","larval lymph gland hemopoiesis" -"GO:0061382","Malpighian tubule tip cell differentiation" -"GO:0045986","negative regulation of smooth muscle contraction" -"GO:0072126","positive regulation of glomerular mesangial cell proliferation" -"GO:0002532","production of molecular mediator involved in inflammatory response" -"GO:1905120","cellular response to haloperidol" -"GO:0000915","actomyosin contractile ring assembly" -"GO:0034101","erythrocyte homeostasis" -"GO:0031149","sorocarp stalk cell differentiation" -"GO:1990799","mitochondrial tRNA wobble position uridine thiolation" -"GO:1902746","regulation of lens fiber cell differentiation" -"GO:0036254","cellular response to amiloride" -"GO:0030879","mammary gland development" -"GO:1903498","bundle sheath cell differentiation" -"GO:1905892","negative regulation of cellular response to thapsigargin" -"GO:0021899","fibroblast growth factor receptor signaling pathway involved in forebrain neuron fate commitment" -"GO:0010673","positive regulation of transcription from RNA polymerase II promoter involved in meiotic cell cycle" -"GO:0060829","negative regulation of canonical Wnt signaling pathway involved in neural plate anterior/posterior pattern formation" -"GO:0097392","chemokine (C-X-C motif) ligand 16 production" -"GO:1902350","cellular response to chloroquine" -"GO:0097388","chemokine (C-C motif) ligand 19 production" -"GO:0060051","negative regulation of protein glycosylation" -"GO:1902241","copal-8-ol diphosphate(3-) metabolic process" -"GO:1903361","protein localization to basolateral plasma membrane" -"GO:0035771","interleukin-4-mediated signaling pathway" -"GO:0045370","negative regulation of interleukin-14 biosynthetic process" -"GO:0031623","receptor internalization" -"GO:0003218","cardiac left ventricle formation" -"GO:0048449","floral organ formation" -"GO:0071454","cellular response to anoxia" -"GO:0009559","embryo sac central cell differentiation" -"GO:0042113","B cell activation" -"GO:0048761","collenchyma cell differentiation" -"GO:0061313","fibroblast growth factor receptor signaling pathway involved in heart development" -"GO:1901947","5alpha,9alpha,10beta-labda-8(20),13-dien-15-yl diphosphate metabolic process" -"GO:0071063","sensory perception of wind" -"GO:1903884","regulation of chemokine (C-C motif) ligand 20 production" -"GO:0042832","defense response to protozoan" -"GO:0043126","regulation of 1-phosphatidylinositol 4-kinase activity" -"GO:0080173","male-female gamete recognition during double fertilization forming a zygote and endosperm" -"GO:1903758","negative regulation of transcription from RNA polymerase II promoter by histone modification" -"GO:0086098","angiotensin-activated signaling pathway involved in heart process" -"GO:0060787","positive regulation of posterior neural plate formation by fibroblast growth factor receptor signaling pathway" -"GO:0072727","cellular response to CCCP" -"GO:0090197","positive regulation of chemokine secretion" -"GO:0046426","negative regulation of JAK-STAT cascade" -"GO:1905308","cellular response to miconazole" -"GO:0018350","protein esterification" -"GO:0035860","glial cell-derived neurotrophic factor receptor signaling pathway" -"GO:1901759","beta-L-Ara4N-lipid A metabolic process" -"GO:0003135","fibroblast growth factor receptor signaling pathway involved in heart induction" -"GO:1900041","negative regulation of interleukin-2 secretion" -"GO:1905895","negative regulation of cellular response to tunicamycin" -"GO:1904403","cellular response to nocodazole" -"GO:0071478","cellular response to radiation" -"GO:1902680","positive regulation of RNA biosynthetic process" -"GO:0046737","active induction of cell-mediated immune response in host by virus" -"GO:0051024","positive regulation of immunoglobulin secretion" -"GO:0090243","fibroblast growth factor receptor signaling pathway involved in somitogenesis" -"GO:0106057","negative regulation of calcineurin-mediated signaling" -"GO:1900085","negative regulation of peptidyl-tyrosine autophosphorylation" -"GO:2000202","positive regulation of ribosomal subunit export from nucleus" -"GO:1901310","positive regulation of sterol regulatory element binding protein cleavage" -"GO:0044860","protein localization to plasma membrane raft" -"GO:0051037","regulation of transcription involved in meiotic cell cycle" -"GO:1905177","tracheary element differentiation" -"GO:0072697","protein localization to cell cortex" -"GO:0071375","cellular response to peptide hormone stimulus" -"GO:0071414","cellular response to methotrexate" -"GO:0051156","glucose 6-phosphate metabolic process" -"GO:0097656","cell-cell self recognition" -"GO:0020028","endocytic hemoglobin import" -"GO:0045490","pectin catabolic process" -"GO:0046465","dolichyl diphosphate metabolic process" -"GO:0060499","fibroblast growth factor receptor signaling pathway involved in lung induction" -"GO:1902847","regulation of neuronal signal transduction" -"GO:0048533","sporocyte differentiation" -"GO:0021531","spinal cord radial glial cell differentiation" -"GO:0007599","hemostasis" -"GO:0002639","positive regulation of immunoglobulin production" -"GO:0090368","regulation of ornithine metabolic process" -"GO:0051469","vesicle fusion with vacuole" -"GO:1901652","response to peptide" -"GO:1905562","regulation of vascular endothelial cell proliferation" -"GO:0032200","telomere organization" -"GO:0006338","chromatin remodeling" -"GO:1900107","regulation of nodal signaling pathway" -"GO:0051501","diterpene phytoalexin metabolic process" -"GO:0001701","in utero embryonic development" -"GO:0006083","acetate metabolic process" -"GO:0099500","vesicle fusion to plasma membrane" -"GO:0051649","establishment of localization in cell" -"GO:0110010","basolateral protein secretion" -"GO:0002849","regulation of peripheral T cell tolerance induction" -"GO:0022004","midbrain-hindbrain boundary maturation during brain development" -"GO:0060527","prostate epithelial cord arborization involved in prostate glandular acinus morphogenesis" -"GO:0098689","latency-replication decision" -"GO:0061782","vesicle fusion with vesicle" -"GO:0046444","FMN metabolic process" -"GO:0090340","positive regulation of secretion of lysosomal enzymes" -"GO:0035936","testosterone secretion" -"GO:0002109","maturation of SSU-rRNA from tricistronic rRNA transcript (SSU-rRNA, LSU-rRNA,5S)" -"GO:0060903","positive regulation of meiosis I" -"GO:1903042","negative regulation of chondrocyte hypertrophy" -"GO:0098045","virus baseplate assembly" -"GO:1904515","positive regulation of TORC2 signaling" -"GO:0035457","cellular response to interferon-alpha" -"GO:0061911","amphisome-lysosome fusion" -"GO:0022408","negative regulation of cell-cell adhesion" -"GO:0038005","peptide bond cleavage involved in epidermal growth factor receptor ligand maturation" -"GO:1990152","protein localization to telomeric heterochromatin" -"GO:0036086","positive regulation of transcription from RNA polymerase II promoter in response to iron ion starvation" -"GO:0019084","middle viral transcription" -"GO:1903002","positive regulation of lipid transport across blood brain barrier" -"GO:0032703","negative regulation of interleukin-2 production" -"GO:0002545","chronic inflammatory response to non-antigenic stimulus" -"GO:0009218","pyrimidine ribonucleotide metabolic process" -"GO:0009615","response to virus" -"GO:0050688","regulation of defense response to virus" -"GO:0060689","cell differentiation involved in salivary gland development" -"GO:1902844","positive regulation of spinal cord association neuron differentiation by negative regulation of canonical Wnt signaling pathway" -"GO:0051940","regulation of catecholamine uptake involved in synaptic transmission" -"GO:0019082","viral protein processing" -"GO:0042221","response to chemical" -"GO:0043128","positive regulation of 1-phosphatidylinositol 4-kinase activity" -"GO:2000352","negative regulation of endothelial cell apoptotic process" -"GO:0061422","positive regulation of transcription from RNA polymerase II promoter in response to alkaline pH" -"GO:0043523","regulation of neuron apoptotic process" -"GO:0019072","viral genome packaging" -"GO:0006952","defense response" -"GO:0100044","negative regulation of cellular hyperosmotic salinity response by transcription from RNA polymerase II promoter" -"GO:0045835","negative regulation of meiotic nuclear division" -"GO:0036520","astrocyte-dopaminergic neuron signaling" -"GO:0086097","phospholipase C-activating angiotensin-activated signaling pathway" -"GO:0090209","negative regulation of triglyceride metabolic process" -"GO:1905772","positive regulation of mesodermal cell differentiation" -"GO:0045821","positive regulation of glycolytic process" -"GO:0097236","positive regulation of transcription from RNA polymerase II promoter in response to zinc ion starvation" -"GO:0000321","re-entry into mitotic cell cycle after pheromone arrest" -"GO:0045593","negative regulation of cumulus cell differentiation" -"GO:0061910","autophagosome-endosome fusion" -"GO:0044077","modulation by symbiont of host receptor-mediated endocytosis" -"GO:0000376","RNA splicing, via transesterification reactions with guanosine as nucleophile" -"GO:2000020","positive regulation of male gonad development" -"GO:0052216","chemotaxis in environment of other organism involved in symbiotic interaction" -"GO:0001709","cell fate determination" -"GO:2000822","regulation of behavioral fear response" -"GO:0010625","positive regulation of Schwann cell proliferation" -"GO:0030035","microspike assembly" -"GO:0001806","type IV hypersensitivity" -"GO:0098669","superinfection exclusion" -"GO:0032462","regulation of protein homooligomerization" -"GO:0019045","latent virus replication" -"GO:0008298","intracellular mRNA localization" -"GO:0039665","permeabilization of host organelle membrane involved in viral entry into host cell" -"GO:1904953","Wnt signaling pathway involved in midbrain dopaminergic neuron differentiation" -"GO:0060743","epithelial cell maturation involved in prostate gland development" -"GO:0034517","ribophagy" -"GO:2000146","negative regulation of cell motility" -"GO:0019069","viral capsid assembly" -"GO:0035898","parathyroid hormone secretion" -"GO:1990773","matrix metallopeptidase secretion" -"GO:0075523","viral translational frameshifting" -"GO:0006540","glutamate decarboxylation to succinate" -"GO:0039664","lysis of host organelle involved in viral entry into host cell" -"GO:0061184","positive regulation of dermatome development" -"GO:0060009","Sertoli cell development" -"GO:0075524","ribosomal skipping" -"GO:1901628","positive regulation of postsynaptic membrane organization" -"GO:1905869","negative regulation of 3'-UTR-mediated mRNA stabilization" -"GO:0009260","ribonucleotide biosynthetic process" -"GO:0007360","positive regulation of posterior gap gene transcription" -"GO:0070249","positive regulation of natural killer cell apoptotic process" -"GO:0031929","TOR signaling" -"GO:0048688","negative regulation of sprouting of injured axon" -"GO:0097496","blood vessel lumen ensheathment" -"GO:0018958","phenol-containing compound metabolic process" -"GO:0033600","negative regulation of mammary gland epithelial cell proliferation" -"GO:0009450","gamma-aminobutyric acid catabolic process" -"GO:0000578","embryonic axis specification" -"GO:0021588","cerebellum formation" -"GO:2000624","positive regulation of nuclear-transcribed mRNA catabolic process, nonsense-mediated decay" -"GO:1905906","regulation of amyloid fibril formation" -"GO:0046794","transport of virus" -"GO:0000377","RNA splicing, via transesterification reactions with bulged adenosine as nucleophile" -"GO:0071302","cellular response to vitamin B2" -"GO:0033342","negative regulation of collagen binding" -"GO:1902459","positive regulation of stem cell population maintenance" -"GO:0071442","positive regulation of histone H3-K14 acetylation" -"GO:0042659","regulation of cell fate specification" -"GO:0051396","positive regulation of nerve growth factor receptor activity" -"GO:0098677","virion maturation" -"GO:0045165","cell fate commitment" -"GO:2000769","regulation of establishment or maintenance of cell polarity regulating cell shape" -"GO:2000637","positive regulation of gene silencing by miRNA" -"GO:0002722","negative regulation of B cell cytokine production" -"GO:0060008","Sertoli cell differentiation" -"GO:1902479","positive regulation of defense response to bacterium, incompatible interaction" -"GO:0060231","mesenchymal to epithelial transition" -"GO:0031591","wybutosine biosynthetic process" -"GO:0051600","regulation of endocytosis by exocyst localization" -"GO:0061317","canonical Wnt signaling pathway involved in cardiac muscle cell fate commitment" -"GO:1905818","regulation of chromosome separation" -"GO:0035913","ventral aorta morphogenesis" -"GO:0098005","viral head-tail joining" -"GO:0090246","convergent extension involved in somitogenesis" -"GO:0036252","positive regulation of transcription from RNA polymerase II promoter in response to menadione" -"GO:0042159","lipoprotein catabolic process" -"GO:2000667","positive regulation of interleukin-13 secretion" -"GO:1905633","establishment of protein localization to euchromatin" -"GO:0019075","virus maturation" -"GO:0061411","positive regulation of transcription from RNA polymerase II promoter in response to cold" -"GO:0051511","negative regulation of unidimensional cell growth" -"GO:0061405","positive regulation of transcription from RNA polymerase II promoter in response to hydrostatic pressure" -"GO:2000588","positive regulation of platelet-derived growth factor receptor-beta signaling pathway" -"GO:0046661","male sex differentiation" -"GO:0075526","cap snatching" -"GO:0071931","positive regulation of transcription involved in G1/S transition of mitotic cell cycle" -"GO:0051897","positive regulation of protein kinase B signaling" -"GO:0009150","purine ribonucleotide metabolic process" -"GO:0030579","ubiquitin-dependent SMAD protein catabolic process" -"GO:0061393","positive regulation of transcription from RNA polymerase II promoter in response to osmotic stress" -"GO:1905584","outer hair cell apoptotic process" -"GO:0060533","bronchus cartilage morphogenesis" -"GO:0030238","male sex determination" -"GO:0019070","viral genome maturation" -"GO:0075527","viral RNA editing" -"GO:0100033","regulation of fungal-type cell wall biogenesis by transcription from RNA polymerase II promoter" -"GO:2000703","negative regulation of fibroblast growth factor receptor signaling pathway involved in ureteric bud formation" -"GO:0045424","negative regulation of granulocyte macrophage colony-stimulating factor biosynthetic process" -"GO:0071291","cellular response to selenium ion" -"GO:1905082","regulation of mitochondrial translational elongation" -"GO:0090282","positive regulation of transcription involved in G2/M transition of mitotic cell cycle" -"GO:0046815","genome retention in viral capsid" -"GO:0002885","positive regulation of hypersensitivity" -"GO:1905860","positive regulation of heparan sulfate proteoglycan binding" -"GO:0009261","ribonucleotide catabolic process" -"GO:0050728","negative regulation of inflammatory response" -"GO:0030034","microvillar actin bundle assembly" -"GO:0043966","histone H3 acetylation" -"GO:0036114","medium-chain fatty-acyl-CoA catabolic process" -"GO:1904093","negative regulation of autophagic cell death" -"GO:0042267","natural killer cell mediated cytotoxicity" -"GO:0044343","canonical Wnt signaling pathway involved in regulation of type B pancreatic cell proliferation" -"GO:0140013","meiotic nuclear division" -"GO:0097368","establishment of Sertoli cell barrier" -"GO:1904522","positive regulation of myofibroblast cell apoptotic process" -"GO:0045557","TRAIL receptor biosynthetic process" -"GO:0090529","cell septum assembly" -"GO:1904139","regulation of microglial cell migration" -"GO:0030982","adventurous gliding motility" -"GO:0043990","histone H2A-S1 phosphorylation" -"GO:0060609","apoptotic process involved in tube lumen cavitation" -"GO:1990768","gastric mucosal blood circulation" -"GO:1903720","negative regulation of I-kappaB phosphorylation" -"GO:0016476","regulation of embryonic cell shape" -"GO:1903917","positive regulation of endoplasmic reticulum stress-induced eIF2 alpha dephosphorylation" -"GO:0006663","platelet activating factor biosynthetic process" -"GO:0036292","DNA rewinding" -"GO:0031584","activation of phospholipase D activity" -"GO:0002380","immunoglobulin secretion involved in immune response" -"GO:0002093","auditory receptor cell morphogenesis" -"GO:1902268","negative regulation of polyamine transmembrane transport" -"GO:0031283","negative regulation of guanylate cyclase activity" -"GO:0018395","peptidyl-lysine hydroxylation to 5-hydroxy-L-lysine" -"GO:0010661","positive regulation of muscle cell apoptotic process" -"GO:0043402","glucocorticoid mediated signaling pathway" -"GO:0045859","regulation of protein kinase activity" -"GO:0021886","hypothalamus gonadotrophin-releasing hormone neuron differentiation" -"GO:0051300","spindle pole body organization" -"GO:0035830","palmatine metabolic process" -"GO:0031991","regulation of actomyosin contractile ring contraction" -"GO:1902954","regulation of early endosome to recycling endosome transport" -"GO:0060423","foregut regionalization" -"GO:0007087","mitotic nuclear pore complex reassembly" -"GO:0071272","morphine metabolic process" -"GO:0007276","gamete generation" -"GO:0002410","plasmacytoid dendritic cell chemotaxis" -"GO:0021996","lamina terminalis formation" -"GO:0060427","lung connective tissue development" -"GO:0055129","L-proline biosynthetic process" -"GO:0030420","establishment of competence for transformation" -"GO:0034096","positive regulation of maintenance of meiotic sister chromatid cohesion" -"GO:1902310","positive regulation of peptidyl-serine dephosphorylation" -"GO:1904876","negative regulation of DNA ligase activity" -"GO:1905239","regulation of canonical Wnt signaling pathway involved in osteoblast differentiation" -"GO:2001250","positive regulation of ammonia assimilation cycle" -"GO:0035883","enteroendocrine cell differentiation" -"GO:0046445","benzyl isoquinoline alkaloid metabolic process" -"GO:0110099","negative regulation of calcium import into the mitochondrion" -"GO:0033692","cellular polysaccharide biosynthetic process" -"GO:0014874","response to stimulus involved in regulation of muscle adaptation" -"GO:1902714","negative regulation of interferon-gamma secretion" -"GO:0010762","regulation of fibroblast migration" -"GO:0032633","interleukin-4 production" -"GO:0044873","lipoprotein localization to membrane" -"GO:1901986","response to ketamine" -"GO:0050915","sensory perception of sour taste" -"GO:0003326","pancreatic A cell fate commitment" -"GO:0032747","positive regulation of interleukin-23 production" -"GO:0070858","negative regulation of bile acid biosynthetic process" -"GO:0099560","synaptic membrane adhesion" -"GO:0038185","intracellular bile acid receptor signaling pathway" -"GO:2000011","regulation of adaxial/abaxial pattern formation" -"GO:0036212","contractile ring maintenance" -"GO:2000370","positive regulation of clathrin-dependent endocytosis" -"GO:0032075","positive regulation of nuclease activity" -"GO:0001123","transcription initiation from bacterial-type RNA polymerase promoter" -"GO:0021508","floor plate formation" -"GO:1901007","(S)-scoulerine metabolic process" -"GO:1903792","negative regulation of anion transport" -"GO:0003329","pancreatic PP cell fate commitment" -"GO:0019422","disproportionation of elemental sulfur" -"GO:1903547","regulation of growth hormone activity" -"GO:0035964","COPI-coated vesicle budding" -"GO:0009589","detection of UV" -"GO:0055110","involution involved in gastrulation with mouth forming second" -"GO:0060887","limb epidermis development" -"GO:0002098","tRNA wobble uridine modification" -"GO:1901873","regulation of post-translational protein modification" -"GO:0043058","regulation of backward locomotion" -"GO:0018244","protein N-linked glycosylation via tryptophan" -"GO:0033275","actin-myosin filament sliding" -"GO:0072139","glomerular parietal epithelial cell differentiation" -"GO:1904747","positive regulation of apoptotic process involved in development" -"GO:0001080","nitrogen catabolite activation of transcription from RNA polymerase II promoter" -"GO:0016973","poly(A)+ mRNA export from nucleus" -"GO:0045766","positive regulation of angiogenesis" -"GO:0034352","positive regulation of glial cell apoptotic process" -"GO:0019400","alditol metabolic process" -"GO:0097119","postsynaptic density protein 95 clustering" -"GO:1901694","positive regulation of compound eye retinal cell apoptotic process" -"GO:0033075","isoquinoline alkaloid biosynthetic process" -"GO:0035812","renal sodium excretion" -"GO:2000213","positive regulation of glutamate metabolic process" -"GO:0007158","neuron cell-cell adhesion" -"GO:1903893","positive regulation of ATF6-mediated unfolded protein response" -"GO:0097116","gephyrin clustering involved in postsynaptic density assembly" -"GO:0055080","cation homeostasis" -"GO:0036150","phosphatidylserine acyl-chain remodeling" -"GO:0032185","septin cytoskeleton organization" -"GO:1904009","cellular response to monosodium glutamate" -"GO:0043967","histone H4 acetylation" -"GO:0003296","apoptotic process involved in atrial ventricular junction remodeling" -"GO:0038202","TORC1 signaling" -"GO:1904735","regulation of fatty acid beta-oxidation using acyl-CoA dehydrogenase" -"GO:0043988","histone H3-S28 phosphorylation" -"GO:0060136","embryonic process involved in female pregnancy" -"GO:0002494","lipid antigen transport" -"GO:1990656","t-SNARE clustering" -"GO:0071925","thymic stromal lymphopoietin production" -"GO:1904021","negative regulation of G-protein coupled receptor internalization" -"GO:2000201","negative regulation of ribosomal subunit export from nucleus" -"GO:0051230","spindle disassembly" -"GO:0031106","septin ring organization" -"GO:1902204","positive regulation of hepatocyte growth factor receptor signaling pathway" -"GO:1902295","synthesis of RNA primer involved in cell cycle DNA replication" -"GO:0046155","rhodopsin catabolic process" -"GO:1904521","negative regulation of myofibroblast cell apoptotic process" -"GO:0072377","blood coagulation, common pathway" -"GO:0002513","tolerance induction to self antigen" -"GO:0042310","vasoconstriction" -"GO:0072356","chromosome passenger complex localization to kinetochore" -"GO:0097503","sialylation" -"GO:1904057","negative regulation of sensory perception of pain" -"GO:0061570","dCDP phosphorylation" -"GO:0072608","interleukin-10 secretion" -"GO:0060192","negative regulation of lipase activity" -"GO:0070895","negative regulation of transposon integration" -"GO:1901670","negative regulation of superoxide dismutase activity" -"GO:0002451","peripheral B cell tolerance induction" -"GO:0060965","negative regulation of gene silencing by miRNA" -"GO:0090006","regulation of linear element assembly" -"GO:0014047","glutamate secretion" -"GO:1904230","negative regulation of succinate dehydrogenase activity" -"GO:0007007","inner mitochondrial membrane organization" -"GO:0060715","syncytiotrophoblast cell differentiation involved in labyrinthine layer development" -"GO:1904183","negative regulation of pyruvate dehydrogenase activity" -"GO:2000099","regulation of establishment or maintenance of bipolar cell polarity" -"GO:1990410","adrenomedullin receptor signaling pathway" -"GO:0014062","regulation of serotonin secretion" -"GO:0061549","sympathetic ganglion development" -"GO:0016197","endosomal transport" -"GO:0090253","convergent extension involved in imaginal disc-derived wing morphogenesis" -"GO:1904326","negative regulation of circadian sleep/wake cycle, wakefulness" -"GO:0042306","regulation of protein import into nucleus" -"GO:0043154","negative regulation of cysteine-type endopeptidase activity involved in apoptotic process" -"GO:0071677","positive regulation of mononuclear cell migration" -"GO:1903857","negative regulation of cytokinin dehydrogenase activity" -"GO:0019049","evasion or tolerance of host defenses by virus" -"GO:0015109","chromate transmembrane transporter activity" -"GO:0048483","autonomic nervous system development" -"GO:0055078","sodium ion homeostasis" -"GO:0045971","positive regulation of juvenile hormone catabolic process" -"GO:0018273","protein-chromophore linkage via peptidyl-N6-retinal-L-lysine" -"GO:1902074","response to salt" -"GO:0007043","cell-cell junction assembly" -"GO:0010526","negative regulation of transposition, RNA-mediated" -"GO:1905418","positive regulation of amoeboid sperm motility" -"GO:0009097","isoleucine biosynthetic process" -"GO:0090672","telomerase RNA localization" -"GO:2000469","negative regulation of peroxidase activity" -"GO:0019896","axonal transport of mitochondrion" -"GO:0001573","ganglioside metabolic process" -"GO:0071425","hematopoietic stem cell proliferation" -"GO:0000470","maturation of LSU-rRNA" -"GO:0035462","determination of left/right asymmetry in diencephalon" -"GO:0034196","acylglycerol transport" -"GO:0015834","peptidoglycan-associated peptide transport" -"GO:1900152","negative regulation of nuclear-transcribed mRNA catabolic process, deadenylation-dependent decay" -"GO:1905232","cellular response to L-glutamate" -"GO:0045740","positive regulation of DNA replication" -"GO:0002716","negative regulation of natural killer cell mediated immunity" -"GO:0045542","positive regulation of cholesterol biosynthetic process" -"GO:0090084","negative regulation of inclusion body assembly" -"GO:0007296","vitellogenesis" -"GO:0110058","positive regulation of blood vessel endothelial cell differentiation" -"GO:0035810","diuresis" -"GO:0071650","negative regulation of chemokine (C-C motif) ligand 5 production" -"GO:0003420","regulation of growth plate cartilage chondrocyte proliferation" -"GO:0017199","N-terminal peptidyl-threonine acetylation" -"GO:0046883","regulation of hormone secretion" -"GO:0030490","maturation of SSU-rRNA" -"GO:0051938","L-glutamate import" -"GO:0071585","detoxification of cadmium ion" -"GO:0007253","cytoplasmic sequestering of NF-kappaB" -"GO:0060710","chorio-allantoic fusion" -"GO:0015098","molybdate ion transmembrane transporter activity" -"GO:0034110","regulation of homotypic cell-cell adhesion" -"GO:0007316","pole plasm RNA localization" -"GO:0042893","polymyxin transport" -"GO:0036315","cellular response to sterol" -"GO:1902664","positive regulation of peptidyl-L-cysteine S-palmitoylation" -"GO:0051301","cell division" -"GO:0018293","protein-FAD linkage" -"GO:0009631","cold acclimation" -"GO:0075180","regulation of transcription in response to host" -"GO:0009817","defense response to fungus, incompatible interaction" -"GO:0002452","B cell receptor editing" -"GO:0043605","cellular amide catabolic process" -"GO:0051296","establishment of meiotic spindle orientation" -"GO:0045191","regulation of isotype switching" -"GO:0048870","cell movement" -"GO:1904871","positive regulation of protein localization to Cajal body" -"GO:0090550","response to molybdenum starvation" -"GO:0046039","GTP metabolic process" -"GO:0046732","active induction of host immune response by virus" -"GO:1904733","negative regulation of electron transfer activity" -"GO:0030504","inorganic diphosphate transmembrane transporter activity" -"GO:0043213","bacteriocin transport" -"GO:1903672","positive regulation of sprouting angiogenesis" -"GO:0010719","negative regulation of epithelial to mesenchymal transition" -"GO:0061962","negative regulation of heme oxygenase activity" -"GO:0042884","microcin transport" -"GO:0036444","calcium import into the mitochondrion" -"GO:0035790","platelet-derived growth factor receptor-alpha signaling pathway" -"GO:0030595","leukocyte chemotaxis" -"GO:0075203","positive regulation of symbiont penetration hypha formation for entry into host" -"GO:0032886","regulation of microtubule-based process" -"GO:0006121","mitochondrial electron transport, succinate to ubiquinone" -"GO:0003116","regulation of vasoconstriction by norepinephrine" -"GO:0001661","conditioned taste aversion" -"GO:0010233","phloem transport" -"GO:0060717","chorion development" -"GO:0050807","regulation of synapse organization" -"GO:0071993","phytochelatin transport" -"GO:0046834","lipid phosphorylation" -"GO:1901203","positive regulation of extracellular matrix assembly" -"GO:0015111","iodide transmembrane transporter activity" -"GO:0090031","positive regulation of steroid hormone biosynthetic process" -"GO:0034465","response to carbon monoxide" -"GO:0051417","microtubule nucleation by spindle pole body" -"GO:0010113","negative regulation of systemic acquired resistance" -"GO:1903659","regulation of complement-dependent cytotoxicity" -"GO:0019093","mitochondrial RNA localization" -"GO:1900034","regulation of cellular response to heat" -"GO:0046210","nitric oxide catabolic process" -"GO:0035729","cellular response to hepatocyte growth factor stimulus" -"GO:0051280","negative regulation of release of sequestered calcium ion into cytosol" -"GO:0003358","noradrenergic neuron development" -"GO:0098712","L-glutamate import across plasma membrane" -"GO:0071692","protein localization to extracellular region" -"GO:0014042","positive regulation of neuron maturation" -"GO:1904885","beta-catenin destruction complex assembly" -"GO:0060390","regulation of SMAD protein signal transduction" -"GO:0043117","positive regulation of vascular permeability" -"GO:0006174","dADP phosphorylation" -"GO:1903869","negative regulation of methylenetetrahydrofolate reductase (NAD(P)H) activity" -"GO:0009115","xanthine catabolic process" -"GO:0006857","oligopeptide transport" -"GO:0015075","ion transporter activity" -"GO:0046265","thiocyanate catabolic process" -"GO:0018393","internal peptidyl-lysine acetylation" -"GO:0071877","regulation of adenylate cyclase-inhibiting adrenergic receptor signaling pathway" -"GO:0019079","viral replication" -"GO:0051263","microcin E492 biosynthetic process by siderophore ester modification of peptidyl-serine" -"GO:0060817","inactivation of paternal X chromosome" -"GO:0044531","modulation of programmed cell death in other organism" -"GO:0061568","GDP phosphorylation" -"GO:0021723","medullary reticular formation development" -"GO:0140009","L-aspartate import across plasma membrane" -"GO:0061571","TDP phosphorylation" -"GO:0019665","anaerobic amino acid catabolic process" -"GO:0090610","bundle sheath cell fate specification" -"GO:0090195","chemokine secretion" -"GO:0045347","negative regulation of MHC class II biosynthetic process" -"GO:0034553","mitochondrial respiratory chain complex II assembly" -"GO:2000739","regulation of mesenchymal stem cell differentiation" -"GO:0015105","arsenite transmembrane transporter activity" -"GO:0036462","TRAIL-activated apoptotic signaling pathway" -"GO:0002904","positive regulation of B cell apoptotic process" -"GO:0018439","peptidyl-L-leucine methyl ester biosynthetic process from peptidyl-leucine" -"GO:2001216","negative regulation of hydroxymethylglutaryl-CoA reductase (NADPH) activity" -"GO:0001982","baroreceptor response to decreased systemic arterial blood pressure" -"GO:2000171","negative regulation of dendrite development" -"GO:2000338","regulation of chemokine (C-X-C motif) ligand 1 production" -"GO:1903276","regulation of sodium ion export across plasma membrane" -"GO:0019263","adamantanone catabolic process" -"GO:0033393","homogalacturonan catabolic process" -"GO:0018226","peptidyl-S-farnesyl-L-cysteine biosynthetic process from peptidyl-cysteine" -"GO:0097627","high-affinity L-ornithine transmembrane transporter activity" -"GO:0042137","sequestering of neurotransmitter" -"GO:0097320","plasma membrane tubulation" -"GO:0010676","positive regulation of cellular carbohydrate metabolic process" -"GO:0000245","spliceosomal complex assembly" -"GO:1903791","uracil transmembrane transport" -"GO:0006435","threonyl-tRNA aminoacylation" -"GO:1990834","response to odorant" -"GO:0046831","regulation of RNA export from nucleus" -"GO:1901715","regulation of gamma-aminobutyric acid catabolic process" -"GO:0034247","snoRNA splicing" -"GO:0006985","positive regulation of NF-kappaB transcription factor activity by ER overload response" -"GO:0045717","negative regulation of fatty acid biosynthetic process" -"GO:0019335","3-methylquinoline catabolic process" -"GO:0046239","phthalate catabolic process" -"GO:0016126","sterol biosynthetic process" -"GO:0060419","heart growth" -"GO:0019629","propionate catabolic process, 2-methylcitrate cycle" -"GO:0060408","regulation of acetylcholine metabolic process" -"GO:0042204","s-triazine compound catabolic process" -"GO:1990384","hyaloid vascular plexus regression" -"GO:0032417","positive regulation of sodium:proton antiporter activity" -"GO:0007039","protein catabolic process in the vacuole" -"GO:2000267","negative regulation of blood coagulation, intrinsic pathway" -"GO:0048242","epinephrine secretion" -"GO:2000885","galactoglucomannan catabolic process" -"GO:0042216","phenanthrene catabolic process" -"GO:1902309","negative regulation of peptidyl-serine dephosphorylation" -"GO:0046726","positive regulation by virus of viral protein levels in host cell" -"GO:2000616","negative regulation of histone H3-K9 acetylation" -"GO:0006175","dATP biosynthetic process" -"GO:0019639","6-hydroxycineole catabolic process" -"GO:1901413","regulation of tetrapyrrole biosynthetic process from glycine and succinyl-CoA" -"GO:1904279","regulation of transcription by RNA polymerase V" -"GO:0015169","glycerol-3-phosphate transmembrane transporter activity" -"GO:0080164","regulation of nitric oxide metabolic process" -"GO:0042208","propylene catabolic process" -"GO:0002664","regulation of T cell tolerance induction" -"GO:0072621","interleukin-23 secretion" -"GO:0019802","cyclization of glutamine involved in intein-mediated protein splicing" -"GO:0002283","neutrophil activation involved in immune response" -"GO:0071211","protein targeting to vacuole involved in autophagy" -"GO:2000468","regulation of peroxidase activity" -"GO:0018399","peptidyl-phenylalanine bromination to L-4'-bromophenylalanine" -"GO:0032460","negative regulation of protein oligomerization" -"GO:0002234","detection of endoplasmic reticulum overloading" -"GO:0006309","apoptotic DNA fragmentation" -"GO:0002673","regulation of acute inflammatory response" -"GO:0046213","methyl ethyl ketone catabolic process" -"GO:1901829","zeaxanthin bis(beta-D-glucoside) catabolic process" -"GO:0021965","spinal cord ventral commissure morphogenesis" -"GO:0046228","2,4,5-trichlorophenoxyacetic acid catabolic process" -"GO:0075147","regulation of signal transduction in response to host" -"GO:0018141","peptide cross-linking via L-lysine thiazolecarboxylic acid" -"GO:1990986","DNA recombinase disassembly" -"GO:0045626","negative regulation of T-helper 1 cell differentiation" -"GO:1902119","regulation of meiotic spindle elongation" -"GO:0018397","peptidyl-phenylalanine bromination to L-2'-bromophenylalanine" -"GO:1901439","positive regulation of toluene metabolic process" -"GO:0046551","retinal cone cell fate commitment" -"GO:0031222","arabinan catabolic process" -"GO:0043900","regulation of multi-organism process" -"GO:1901605","alpha-amino acid metabolic process" -"GO:0071948","activation-induced B cell apoptotic process" -"GO:0010124","phenylacetate catabolic process" -"GO:0032911","negative regulation of transforming growth factor beta1 production" -"GO:0045957","negative regulation of complement activation, alternative pathway" -"GO:0010129","anaerobic cyclohexane-1-carboxylate catabolic process" -"GO:1990544","mitochondrial ATP transmembrane transport" -"GO:0060947","cardiac vascular smooth muscle cell differentiation" -"GO:0043519","regulation of myosin II filament organization" -"GO:0097006","regulation of plasma lipoprotein particle levels" -"GO:0002926","tRNA wobble base 5-methoxycarbonylmethyl-2-thiouridinylation" -"GO:0070105","positive regulation of interleukin-6-mediated signaling pathway" -"GO:1902466","positive regulation of histone H3-K27 trimethylation" -"GO:0002263","cell activation involved in immune response" -"GO:0090515","L-glutamate transmembrane import into vacuole" -"GO:0019728","peptidyl-allysine oxidation to 2-aminoadipic acid" -"GO:0032469","endoplasmic reticulum calcium ion homeostasis" -"GO:1900262","regulation of DNA-directed DNA polymerase activity" -"GO:0043038","amino acid activation" -"GO:0045604","regulation of epidermal cell differentiation" -"GO:0045454","cell redox homeostasis" -"GO:0046705","CDP biosynthetic process" -"GO:0080122","AMP transmembrane transporter activity" -"GO:0072170","metanephric tubule development" -"GO:0044247","cellular polysaccharide catabolic process" -"GO:1903709","uterine gland development" -"GO:0033195","response to alkyl hydroperoxide" -"GO:0019545","arginine catabolic process to succinate" -"GO:0032879","regulation of localization" -"GO:0061729","GDP-mannose biosynthetic process from fructose-6-phosphate" -"GO:2000973","regulation of pro-B cell differentiation" -"GO:2000944","positive regulation of amylopectin metabolic process" -"GO:1990961","drug transmembrane export" -"GO:0070948","regulation of neutrophil mediated cytotoxicity" -"GO:0045653","negative regulation of megakaryocyte differentiation" -"GO:0090296","regulation of mitochondrial DNA replication" -"GO:0007358","establishment of central gap gene boundaries" -"GO:0043250","sodium-dependent organic anion transmembrane transporter activity" -"GO:1900919","positive regulation of octadecene metabolic process" -"GO:0061870","positive regulation of hepatic stellate cell migration" -"GO:0072330","monocarboxylic acid biosynthetic process" -"GO:1903017","positive regulation of exo-alpha-sialidase activity" -"GO:0021562","vestibulocochlear nerve development" -"GO:0009695","jasmonic acid biosynthetic process" -"GO:0042987","amyloid precursor protein catabolic process" -"GO:1903447","geraniol catabolic process" -"GO:0009900","dehiscence" -"GO:0045585","positive regulation of cytotoxic T cell differentiation" -"GO:1904280","negative regulation of transcription by RNA polymerase V" -"GO:0072378","blood coagulation, fibrin clot formation" -"GO:0044774","mitotic DNA integrity checkpoint" -"GO:0090187","positive regulation of pancreatic juice secretion" -"GO:0045894","negative regulation of mating-type specific transcription, DNA-templated" -"GO:0097333","response to olanzapine" -"GO:0120030","positive regulation of cilium beat frequency involved in ciliary motility" -"GO:1905768","negative regulation of double-stranded telomeric DNA binding" -"GO:0072344","rescue of stalled ribosome" -"GO:0045561","regulation of TRAIL receptor 1 biosynthetic process" -"GO:0060885","clearance of cells from fusion plate by apoptotic process" -"GO:0035963","cellular response to interleukin-13" -"GO:0090176","microtubule cytoskeleton organization involved in establishment of planar polarity" -"GO:0034021","response to silicon dioxide" -"GO:0032849","positive regulation of cellular pH reduction" -"GO:0043269","regulation of ion transport" -"GO:0097370","protein O-GlcNAcylation via threonine" -"GO:1990379","lipid transport across blood brain barrier" -"GO:1990068","seed dehydration" -"GO:0021952","central nervous system projection neuron axonogenesis" -"GO:0038166","angiotensin-activated signaling pathway" -"GO:0086093","G-protein coupled acetylcholine receptor signaling pathway involved in heart process" -"GO:0001905","activation of membrane attack complex" -"GO:0097250","mitochondrial respiratory chain supercomplex assembly" -"GO:0014020","primary neural tube formation" -"GO:0016480","negative regulation of transcription by RNA polymerase III" -"GO:0090298","negative regulation of mitochondrial DNA replication" -"GO:0031056","regulation of histone modification" -"GO:1904357","negative regulation of telomere maintenance via telomere lengthening" -"GO:0097239","positive regulation of transcription from RNA polymerase II promoter in response to methylglyoxal" -"GO:0090419","negative regulation of transcription involved in G2/M transition of mitotic cell cycle" -"GO:0048251","elastic fiber assembly" -"GO:0090295","nitrogen catabolite repression of transcription" -"GO:0045373","negative regulation of interleukin-15 biosynthetic process" -"GO:0051939","gamma-aminobutyric acid import" -"GO:0016139","glycoside catabolic process" -"GO:1901703","protein localization involved in auxin polar transport" -"GO:0033135","regulation of peptidyl-serine phosphorylation" -"GO:0051977","lysophospholipid transport" -"GO:1902342","xylitol export" -"GO:0090664","response to high population density" -"GO:0051038","negative regulation of transcription involved in meiotic cell cycle" -"GO:0002009","morphogenesis of an epithelium" -"GO:0045013","carbon catabolite repression of transcription" -"GO:0045188","regulation of circadian sleep/wake cycle, non-REM sleep" -"GO:1903336","negative regulation of vacuolar transport" -"GO:0051258","protein polymerization" -"GO:0010116","positive regulation of abscisic acid biosynthetic process" -"GO:1905247","positive regulation of aspartic-type peptidase activity" -"GO:0097336","response to risperidone" -"GO:0035037","sperm entry" -"GO:0035704","helper T cell chemotaxis" -"GO:0035333","Notch receptor processing, ligand-dependent" -"GO:1990441","negative regulation of transcription from RNA polymerase II promoter in response to endoplasmic reticulum stress" -"GO:0048250","iron import into the mitochondrion" -"GO:1990215","negative regulation by symbiont of host intracellular transport" -"GO:1904289","regulation of mitotic DNA damage checkpoint" -"GO:0000920","cell separation after cytokinesis" -"GO:0051640","organelle localization" -"GO:0016059","deactivation of rhodopsin mediated signaling" -"GO:2001248","regulation of ammonia assimilation cycle" -"GO:1904094","positive regulation of autophagic cell death" -"GO:0032205","negative regulation of telomere maintenance" -"GO:0044211","CTP salvage" -"GO:1901255","nucleotide-excision repair involved in interstrand cross-link repair" -"GO:0036123","histone H3-K9 dimethylation" -"GO:0010620","negative regulation of transcription by transcription factor catabolism" -"GO:0045996","negative regulation of transcription by pheromones" -"GO:0097335","response to quetiapine" -"GO:0001319","inheritance of oxidatively modified proteins involved in replicative cell aging" -"GO:0014810","positive regulation of skeletal muscle contraction by regulation of release of sequestered calcium ion" -"GO:0010621","negative regulation of transcription by transcription factor localization" -"GO:0009411","response to UV" -"GO:0006509","membrane protein ectodomain proteolysis" -"GO:0036345","platelet maturation" -"GO:0002376","immune system process" -"GO:0010678","negative regulation of cellular carbohydrate metabolic process by negative regulation of transcription, DNA-templated" -"GO:2000003","positive regulation of DNA damage checkpoint" -"GO:0060195","negative regulation of antisense RNA transcription" -"GO:0035949","positive regulation of gluconeogenesis by negative regulation of transcription from RNA polymerase II promoter" -"GO:1904460","positive regulation of substance P secretion" -"GO:1903431","positive regulation of cell maturation" -"GO:1904388","negative regulation of ncRNA transcription associated with protein coding gene TSS/TES" -"GO:0120027","regulation of osmosensory signaling pathway" -"GO:0010716","negative regulation of extracellular matrix disassembly" -"GO:0061508","CDP phosphorylation" -"GO:0038044","transforming growth factor-beta secretion" -"GO:1903545","cellular response to butyrate" -"GO:0051651","maintenance of location in cell" -"GO:1900490","positive regulation of hydroxymethylglutaryl-CoA reductase (NADPH) activity" -"GO:0034446","substrate adhesion-dependent cell spreading" -"GO:0060486","Clara cell differentiation" -"GO:0034474","U2 snRNA 3'-end processing" -"GO:1903220","positive regulation of malate dehydrogenase (decarboxylating) (NADP+) activity" -"GO:0007206","phospholipase C-activating G-protein coupled glutamate receptor signaling pathway" -"GO:0051004","regulation of lipoprotein lipase activity" -"GO:1901408","negative regulation of phosphorylation of RNA polymerase II C-terminal domain" -"GO:0099179","regulation of synaptic membrane adhesion" -"GO:0015851","nucleobase transport" -"GO:0060116","vestibular receptor cell morphogenesis" -"GO:2000346","negative regulation of hepatocyte proliferation" -"GO:0046098","guanine metabolic process" -"GO:0035066","positive regulation of histone acetylation" -"GO:0034159","regulation of toll-like receptor 8 signaling pathway" -"GO:0051983","regulation of chromosome segregation" -"GO:0048496","maintenance of animal organ identity" -"GO:1903661","positive regulation of complement-dependent cytotoxicity" -"GO:0036071","N-glycan fucosylation" -"GO:0075720","establishment of episomal latency" -"GO:0099633","protein localization to postsynaptic specialization membrane" -"GO:1905855","positive regulation of heparan sulfate binding" -"GO:0051656","establishment of organelle localization" -"GO:0006601","creatine biosynthetic process" -"GO:0009309","amine biosynthetic process" -"GO:0006624","vacuolar protein processing" -"GO:0009104","lipopolysaccharide catabolic process" -"GO:0006683","galactosylceramide catabolic process" -"GO:1903579","negative regulation of ATP metabolic process" -"GO:0045216","cell-cell junction organization" -"GO:0070963","positive regulation of neutrophil mediated killing of gram-negative bacterium" -"GO:0021834","chemorepulsion involved in embryonic olfactory bulb interneuron precursor migration" -"GO:1905809","negative regulation of synapse organization" -"GO:0070481","nuclear-transcribed mRNA catabolic process, non-stop decay" -"GO:0072081","specification of nephron tubule identity" -"GO:1900799","cordyol C biosynthetic process" -"GO:0090114","COPII-coated vesicle budding" -"GO:0030908","protein splicing" -"GO:0045851","pH reduction" -"GO:0048296","regulation of isotype switching to IgA isotypes" -"GO:2000178","negative regulation of neural precursor cell proliferation" -"GO:1905636","positive regulation of RNA polymerase II regulatory region sequence-specific DNA binding" -"GO:0032805","positive regulation of low-density lipoprotein particle receptor catabolic process" -"GO:0034329","cell junction assembly" -"GO:0032015","regulation of Ran protein signal transduction" -"GO:1902200","3-methylbut-2-enoyl-CoA(4-) biosynthetic process" -"GO:1901629","regulation of presynaptic membrane organization" -"GO:0051238","sequestering of metal ion" -"GO:0019290","siderophore biosynthetic process" -"GO:2000470","positive regulation of peroxidase activity" -"GO:0046032","ADP catabolic process" -"GO:0010650","positive regulation of cell communication by electrical coupling" -"GO:2001046","positive regulation of integrin-mediated signaling pathway" -"GO:0072660","maintenance of protein location in plasma membrane" -"GO:0010570","regulation of filamentous growth" -"GO:0021605","cranial nerve maturation" -"GO:0071709","membrane assembly" -"GO:1904396","regulation of neuromuscular junction development" -"GO:0034971","histone H3-R17 methylation" -"GO:0034606","response to hermaphrodite contact" -"GO:0061839","ferrous ion transmembrane transport" -"GO:1905005","regulation of epithelial to mesenchymal transition involved in endocardial cushion formation" -"GO:1900749","(R)-carnitine transport" -"GO:1903580","positive regulation of ATP metabolic process" -"GO:0075046","positive regulation of formation by symbiont of haustorium for nutrient acquisition from host" -"GO:0006741","NADP biosynthetic process" -"GO:0006850","mitochondrial pyruvate transmembrane transport" -"GO:0035503","ureter part of ureteric bud development" -"GO:2000264","negative regulation of blood coagulation, extrinsic pathway" -"GO:1905843","regulation of cellular response to gamma radiation" -"GO:0010877","lipid transport involved in lipid storage" -"GO:0048299","regulation of isotype switching to IgD isotypes" -"GO:0042457","ethylene catabolic process" -"GO:1904950","negative regulation of establishment of protein localization" -"GO:1900221","regulation of amyloid-beta clearance" -"GO:1900581","(17Z)-protosta-17(20),24-dien-3beta-ol biosynthetic process" -"GO:1903870","positive regulation of methylenetetrahydrofolate reductase (NAD(P)H) activity" -"GO:0043949","regulation of cAMP-mediated signaling" -"GO:2000429","negative regulation of neutrophil aggregation" -"GO:0035268","protein mannosylation" -"GO:2001130","methane biosynthetic process from trimethylamine" -"GO:0090222","centrosome-templated microtubule nucleation" -"GO:1900624","negative regulation of monocyte aggregation" -"GO:0006090","pyruvate metabolic process" -"GO:0046534","positive regulation of photoreceptor cell differentiation" -"GO:0033621","nuclear-transcribed mRNA catabolic process, meiosis-specific transcripts" -"GO:1904576","response to tunicamycin" -"GO:0046001","negative regulation of preblastoderm mitotic cell cycle" -"GO:0042318","penicillin biosynthetic process" -"GO:0060629","regulation of homologous chromosome segregation" -"GO:0061333","renal tubule morphogenesis" -"GO:1904734","positive regulation of electron transfer activity" -"GO:0030639","polyketide biosynthetic process" -"GO:1900802","cspyrone B1 biosynthetic process" -"GO:1905782","positive regulation of phosphatidylserine exposure on apoptotic cell surface" -"GO:0044255","cellular lipid metabolic process" -"GO:0060122","inner ear receptor cell stereocilium organization" -"GO:0061961","positive regulation of heme oxygenase activity" -"GO:0046498","S-adenosylhomocysteine metabolic process" -"GO:0042811","pheromone biosynthetic process" -"GO:0044537","regulation of circulating fibrinogen levels" -"GO:1900759","positive regulation of D-amino-acid oxidase activity" -"GO:1905118","positive regulation of ribonucleoside-diphosphate reductase activity" -"GO:0006186","dGDP phosphorylation" -"GO:0044342","type B pancreatic cell proliferation" -"GO:1900796","terrequinone A biosynthetic process" -"GO:0099175","regulation of postsynapse organization" -"GO:1900599","demethylkotanin biosynthetic process" -"GO:0006192","IDP phosphorylation" -"GO:0002507","tolerance induction" -"GO:0034720","histone H3-K4 demethylation" -"GO:1903978","regulation of microglial cell activation" -"GO:0045541","negative regulation of cholesterol biosynthetic process" -"GO:2000399","negative regulation of thymocyte aggregation" -"GO:0030516","regulation of axon extension" -"GO:0045855","negative regulation of pole plasm oskar mRNA localization" -"GO:0060852","regulation of transcription involved in venous endothelial cell fate commitment" -"GO:1990185","regulation of lymphatic vascular permeability" -"GO:0071044","histone mRNA catabolic process" -"GO:0099174","regulation of presynapse organization" -"GO:1900602","endocrocin biosynthetic process" -"GO:0030851","granulocyte differentiation" -"GO:0075330","positive regulation of arbuscule formation for nutrient acquisition from host" -"GO:0071883","activation of MAPK activity by adrenergic receptor signaling pathway" -"GO:0060118","vestibular receptor cell development" -"GO:0051972","regulation of telomerase activity" -"GO:1900605","tensidol A biosynthetic process" -"GO:0032483","regulation of Rab protein signal transduction" -"GO:0006269","DNA replication, synthesis of RNA primer" -"GO:0045141","meiotic telomere clustering" -"GO:1901630","negative regulation of presynaptic membrane organization" -"GO:0050746","regulation of lipoprotein metabolic process" -"GO:1905806","regulation of synapse disassembly" -"GO:0019758","glycosinolate biosynthetic process" -"GO:0034255","regulation of urea metabolic process" -"GO:0061725","cytosolic lipolysis" -"GO:0030265","phospholipase C-activating rhodopsin mediated signaling pathway" -"GO:0043252","sodium-independent organic anion transport" -"GO:0052698","ergothioneine metabolic process" -"GO:0006194","dIDP phosphorylation" -"GO:0061732","mitochondrial acetyl-CoA biosynthetic process from pyruvate" -"GO:0017158","regulation of calcium ion-dependent exocytosis" -"GO:0046069","cGMP catabolic process" -"GO:0072615","interleukin-17 secretion" -"GO:1904960","positive regulation of cytochrome-c oxidase activity" -"GO:1904978","regulation of endosome organization" -"GO:2001129","methane biosynthetic process from dimethylamine" -"GO:0019068","virion assembly" -"GO:0030148","sphingolipid biosynthetic process" -"GO:2000603","regulation of secondary growth" -"GO:0110023","negative regulation of cardiac muscle myoblast proliferation" -"GO:0035092","sperm chromatin condensation" -"GO:0009893","positive regulation of metabolic process" -"GO:0045998","positive regulation of ecdysteroid biosynthetic process" -"GO:0072531","pyrimidine-containing compound transmembrane transport" -"GO:1900827","positive regulation of membrane depolarization during cardiac muscle cell action potential" -"GO:0031029","regulation of septation initiation signaling" -"GO:1900766","emericellin biosynthetic process" -"GO:0003386","amphid sensory organ development" -"GO:1902437","positive regulation of male mating behavior" -"GO:0070868","heterochromatin organization involved in chromatin silencing" -"GO:2001169","regulation of ATP biosynthetic process" -"GO:0007209","phospholipase C-activating tachykinin receptor signaling pathway" -"GO:1901163","regulation of trophoblast cell migration" -"GO:0051642","centrosome localization" -"GO:0061771","response to caloric restriction" -"GO:0032485","regulation of Ral protein signal transduction" -"GO:0072434","signal transduction involved in mitotic G2 DNA damage checkpoint" -"GO:0009310","amine catabolic process" -"GO:0046938","phytochelatin biosynthetic process" -"GO:1900815","monodictyphenone biosynthetic process" -"GO:1903721","positive regulation of I-kappaB phosphorylation" -"GO:1905951","mitochondrion DNA recombination" -"GO:2001154","regulation of glycolytic fermentation to ethanol" -"GO:1901422","response to butan-1-ol" -"GO:0006681","galactosylceramide metabolic process" -"GO:0001935","endothelial cell proliferation" -"GO:0019724","B cell mediated immunity" -"GO:0061435","positive regulation of transcription from a mobile element promoter" -"GO:0010932","regulation of macrophage tolerance induction" -"GO:0035767","endothelial cell chemotaxis" -"GO:1900082","negative regulation of arginine catabolic process" -"GO:0061234","mesonephric glomerulus morphogenesis" -"GO:0001575","globoside metabolic process" -"GO:0019457","methionine catabolic process to succinyl-CoA" -"GO:0060374","mast cell differentiation" -"GO:0042680","compound eye cone cell fate determination" -"GO:0016447","somatic recombination of immunoglobulin gene segments" -"GO:0006782","protoporphyrinogen IX biosynthetic process" -"GO:0072179","nephric duct formation" -"GO:0021863","forebrain neuroblast differentiation" -"GO:0060469","positive regulation of transcription involved in egg activation" -"GO:0003180","aortic valve morphogenesis" -"GO:1904054","regulation of cholangiocyte proliferation" -"GO:0014022","neural plate elongation" -"GO:0045400","negative regulation of interleukin-3 biosynthetic process" -"GO:0140193","regulation of adenylate cyclase-inhibiting adrenergic receptor signaling pathway involved in heart process" -"GO:0042133","neurotransmitter metabolic process" -"GO:0046352","disaccharide catabolic process" -"GO:0046341","CDP-diacylglycerol metabolic process" -"GO:0003144","embryonic heart tube formation" -"GO:0046339","diacylglycerol metabolic process" -"GO:0003137","Notch signaling pathway involved in heart induction" -"GO:0003154","BMP signaling pathway involved in determination of left/right symmetry" -"GO:0020035","cytoadherence to microvasculature, mediated by symbiont protein" -"GO:0045455","ecdysteroid metabolic process" -"GO:0048380","negative regulation of lateral mesodermal cell fate specification" -"GO:0061888","regulation of astrocyte activation" -"GO:0019935","cyclic-nucleotide-mediated signaling" -"GO:0010595","positive regulation of endothelial cell migration" -"GO:0021880","Notch signaling pathway involved in forebrain neuron fate commitment" -"GO:0035336","long-chain fatty-acyl-CoA metabolic process" -"GO:0060113","inner ear receptor cell differentiation" -"GO:0000337","regulation of transposition, DNA-mediated" -"GO:0035776","pronephric proximal tubule development" -"GO:1902359","Notch signaling pathway involved in somitogenesis" -"GO:0052260","negative regulation by organism of inflammatory response of other organism involved in symbiotic interaction" -"GO:0090294","nitrogen catabolite activation of transcription" -"GO:0005994","melibiose metabolic process" -"GO:0019950","SMT3-dependent protein catabolic process" -"GO:1905890","regulation of cellular response to very-low-density lipoprotein particle stimulus" -"GO:0002646","regulation of central tolerance induction" -"GO:1990502","dense core granule maturation" -"GO:0032823","regulation of natural killer cell differentiation" -"GO:0043583","ear development" -"GO:0000710","meiotic mismatch repair" -"GO:0045128","negative regulation of reciprocal meiotic recombination" -"GO:2000891","cellobiose metabolic process" -"GO:1903211","mitotic recombination involved in replication fork processing" -"GO:0090685","RNA localization to nucleus" -"GO:0018230","peptidyl-L-cysteine S-palmitoylation" -"GO:0015809","arginine transport" -"GO:0052149","modulation by symbiont of host peptidase activity" -"GO:0001823","mesonephros development" -"GO:0051387","negative regulation of neurotrophin TRK receptor signaling pathway" -"GO:1900738","positive regulation of phospholipase C-activating G-protein coupled receptor signaling pathway" -"GO:0010206","photosystem II repair" -"GO:0002649","regulation of tolerance induction to self antigen" -"GO:0031025","equatorial microtubule organizing center disassembly" -"GO:0018345","protein palmitoylation" -"GO:0035752","lysosomal lumen pH elevation" -"GO:0048014","Tie signaling pathway" -"GO:1905001","negative regulation of membrane repolarization during atrial cardiac muscle cell action potential" -"GO:0003434","BMP signaling pathway involved in growth plate cartilage chondrocyte development" -"GO:1904108","protein localization to ciliary inversin compartment" -"GO:0002871","regulation of natural killer cell tolerance induction" -"GO:0042572","retinol metabolic process" -"GO:0072426","response to G2 DNA damage checkpoint signaling" -"GO:0002572","pro-T cell differentiation" -"GO:0046294","formaldehyde catabolic process" -"GO:0060227","Notch signaling pathway involved in camera-type eye photoreceptor fate commitment" -"GO:1990051","activation of protein kinase C activity" -"GO:0042035","regulation of cytokine biosynthetic process" -"GO:0097510","base-excision repair, AP site formation via deaminated base removal" -"GO:1902665","response to isobutanol" -"GO:0002762","negative regulation of myeloid leukocyte differentiation" -"GO:0052746","inositol phosphorylation" -"GO:2000223","regulation of BMP signaling pathway involved in heart jogging" -"GO:0048742","regulation of skeletal muscle fiber development" -"GO:0061586","positive regulation of transcription by transcription factor localization" -"GO:0006364","rRNA processing" -"GO:0045873","negative regulation of sevenless signaling pathway" -"GO:0021876","Notch signaling pathway involved in forebrain neuroblast division" -"GO:1905048","regulation of metallopeptidase activity" -"GO:0007072","positive regulation of transcription involved in exit from mitosis" -"GO:1903190","glyoxal catabolic process" -"GO:0019643","reductive tricarboxylic acid cycle" -"GO:0072388","flavin adenine dinucleotide biosynthetic process" -"GO:0051036","regulation of endosome size" -"GO:0090285","negative regulation of protein glycosylation in Golgi" -"GO:0001508","action potential" -"GO:0060853","Notch signaling pathway involved in arterial endothelial cell fate commitment" -"GO:2000581","negative regulation of ATP-dependent microtubule motor activity, plus-end-directed" -"GO:0009398","FMN biosynthetic process" -"GO:0035406","histone-tyrosine phosphorylation" -"GO:2000792","positive regulation of mesenchymal cell proliferation involved in lung development" -"GO:2001121","coenzyme gamma-F420-2 biosynthetic process" -"GO:0046187","acetaldehyde catabolic process" -"GO:0007128","meiotic prophase I" -"GO:0044862","protein transport out of plasma membrane raft" -"GO:0052427","modulation by host of symbiont peptidase activity" -"GO:0006678","glucosylceramide metabolic process" -"GO:0032689","negative regulation of interferon-gamma production" -"GO:0010148","transpiration" -"GO:1902571","regulation of serine-type peptidase activity" -"GO:0090111","regulation of COPII vesicle uncoating" -"GO:0016068","type I hypersensitivity" -"GO:0006119","oxidative phosphorylation" -"GO:1903804","glycine import across plasma membrane" -"GO:0046351","disaccharide biosynthetic process" -"GO:0034443","negative regulation of lipoprotein oxidation" -"GO:0006301","postreplication repair" -"GO:0007136","meiotic prophase II" -"GO:0060449","bud elongation involved in lung branching" -"GO:0007539","primary sex determination, soma" -"GO:0072006","nephron development" -"GO:0034131","regulation of toll-like receptor 1 signaling pathway" -"GO:0002118","aggressive behavior" -"GO:2000351","regulation of endothelial cell apoptotic process" -"GO:0009371","positive regulation of transcription by pheromones" -"GO:1904018","positive regulation of vasculature development" -"GO:0043114","regulation of vascular permeability" -"GO:0021570","rhombomere 4 development" -"GO:0003111","positive regulation of heart rate by circulating epinephrine" -"GO:0003435","smoothened signaling pathway involved in growth plate cartilage chondrocyte development" -"GO:1902865","positive regulation of embryonic camera-type eye development" -"GO:0051136","regulation of NK T cell differentiation" -"GO:0006783","heme biosynthetic process" -"GO:0002911","regulation of lymphocyte anergy" -"GO:2000607","negative regulation of cell proliferation involved in mesonephros development" -"GO:0023019","signal transduction involved in regulation of gene expression" -"GO:0055085","transmembrane transport" -"GO:0000088","mitotic prophase" -"GO:0042059","negative regulation of epidermal growth factor receptor signaling pathway" -"GO:0048634","regulation of muscle organ development" -"GO:0045895","positive regulation of mating-type specific transcription, DNA-templated" -"GO:1902878","regulation of BMP signaling pathway involved in spinal cord association neuron specification" -"GO:0021817","nucleokinesis involved in cell motility in cerebral cortex radial glia guided migration" -"GO:1903531","negative regulation of secretion by cell" -"GO:2000053","regulation of Wnt signaling pathway involved in dorsal/ventral axis specification" -"GO:0060119","inner ear receptor cell development" -"GO:1902775","mitochondrial large ribosomal subunit assembly" -"GO:0090660","cerebrospinal fluid circulation" -"GO:0033082","regulation of extrathymic T cell differentiation" -"GO:0031333","negative regulation of protein complex assembly" -"GO:0052001","Type IV pili-dependent localized adherence to host" -"GO:0097205","renal filtration" -"GO:2000796","Notch signaling pathway involved in negative regulation of venous endothelial cell fate commitment" -"GO:0009145","purine nucleoside triphosphate biosynthetic process" -"GO:0033060","ocellus pigmentation" -"GO:0061353","BMP signaling pathway involved in Malpighian tubule cell chemotaxis" -"GO:0070254","mucus secretion" -"GO:0031247","actin rod assembly" -"GO:0090461","glutamate homeostasis" -"GO:0060912","cardiac cell fate specification" -"GO:0090366","positive regulation of mRNA modification" -"GO:0003179","heart valve morphogenesis" -"GO:0070555","response to interleukin-1" -"GO:0003095","pressure natriuresis" -"GO:0010269","response to selenium ion" -"GO:0006069","ethanol oxidation" -"GO:0036101","leukotriene B4 catabolic process" -"GO:0038146","chemokine (C-X-C motif) ligand 12 signaling pathway" -"GO:0072065","long descending thin limb bend development" -"GO:0042377","vitamin K catabolic process" -"GO:0060086","circadian temperature homeostasis" -"GO:0051572","negative regulation of histone H3-K4 methylation" -"GO:0045993","negative regulation of translational initiation by iron" -"GO:0048535","lymph node development" -"GO:0018279","protein N-linked glycosylation via asparagine" -"GO:0070490","protein pupylation" -"GO:0015915","fatty-acyl group transport" -"GO:0060654","mammary gland cord elongation" -"GO:0019262","N-acetylneuraminate catabolic process" -"GO:0038150","C-C chemokine receptor CCR2 signaling pathway" -"GO:0034397","telomere localization" -"GO:0100069","negative regulation of neuron apoptotic process by transcription from RNA polymerase II promoter" -"GO:2001303","lipoxin A4 biosynthetic process" -"GO:1901165","positive regulation of trophoblast cell migration" -"GO:0016202","regulation of striated muscle tissue development" -"GO:0070166","enamel mineralization" -"GO:1904559","cellular response to dextromethorphan" -"GO:1905179","negative regulation of cardiac muscle tissue regeneration" -"GO:1905234","cellular response to codeine" -"GO:0002548","monocyte chemotaxis" -"GO:0015868","purine ribonucleotide transport" -"GO:1901048","transforming growth factor beta receptor signaling pathway involved in regulation of multicellular organism growth" -"GO:0010936","negative regulation of macrophage cytokine production" -"GO:0090331","negative regulation of platelet aggregation" -"GO:0006607","NLS-bearing protein import into nucleus" -"GO:0003121","epinephrine-mediated vasodilation" -"GO:1901233","negative regulation of convergent extension involved in axis elongation" -"GO:0045652","regulation of megakaryocyte differentiation" -"GO:1900026","positive regulation of substrate adhesion-dependent cell spreading" -"GO:1903520","negative regulation of mammary gland involution" -"GO:0050779","RNA destabilization" -"GO:0019655","glycolytic fermentation to ethanol" -"GO:0010613","positive regulation of cardiac muscle hypertrophy" -"GO:0045785","positive regulation of cell adhesion" -"GO:0043417","negative regulation of skeletal muscle tissue regeneration" -"GO:1990402","embryonic liver development" -"GO:0051121","hepoxilin metabolic process" -"GO:0038152","C-C chemokine receptor CCR4 signaling pathway" -"GO:0032695","negative regulation of interleukin-12 production" -"GO:0030007","cellular potassium ion homeostasis" -"GO:0072114","pronephros morphogenesis" -"GO:0036446","myofibroblast differentiation" -"GO:0006856","eye pigment precursor transport" -"GO:0043507","positive regulation of JUN kinase activity" -"GO:1903822","signal transduction involved in morphogenesis checkpoint" -"GO:0060081","membrane hyperpolarization" -"GO:0060826","transforming growth factor beta receptor signaling pathway involved in neural plate anterior/posterior pattern formation" -"GO:0071915","protein-lysine lysylation" -"GO:0044392","peptidyl-lysine malonylation" -"GO:0015857","uracil transport" -"GO:1904676","negative regulation of somatic stem cell division" -"GO:0060749","mammary gland alveolus development" -"GO:0044331","cell-cell adhesion mediated by cadherin" -"GO:0031439","positive regulation of mRNA cleavage" -"GO:1905496","regulation of triplex DNA binding" -"GO:0061035","regulation of cartilage development" -"GO:0060327","cytoplasmic actin-based contraction involved in cell motility" -"GO:0009744","response to sucrose" -"GO:1905042","negative regulation of epithelium regeneration" -"GO:1904742","regulation of telomeric DNA binding" -"GO:0035689","chemokine (C-C motif) ligand 5 signaling pathway" -"GO:0060835","transforming growth factor receptor beta signaling pathway involved in oral/aboral axis specification" -"GO:0072032","proximal convoluted tubule segment 2 development" -"GO:0099504","synaptic vesicle cycle" -"GO:0002460","adaptive immune response based on somatic recombination of immune receptors built from immunoglobulin superfamily domains" -"GO:0000305","response to oxygen radical" -"GO:0061774","cohesin unloading" -"GO:2000677","regulation of transcription regulatory region DNA binding" -"GO:0018235","peptidyl-lysine carboxylation" -"GO:0090115","C-5 methylation on cytosine involved in chromatin silencing" -"GO:2001279","regulation of unsaturated fatty acid biosynthetic process" -"GO:0032496","response to lipopolysaccharide" -"GO:0001659","temperature homeostasis" -"GO:0071580","regulation of zinc ion transmembrane transport" -"GO:0039534","negative regulation of MDA-5 signaling pathway" -"GO:0036161","calcitonin secretion" -"GO:1905614","negative regulation of developmental vegetative growth" -"GO:0086099","phospholipase C-activating angiotensin-activated signaling pathway involved in heart process" -"GO:1904333","positive regulation of error-prone translesion synthesis" -"GO:0039536","negative regulation of RIG-I signaling pathway" -"GO:0031018","endocrine pancreas development" -"GO:1905494","negative regulation of G-quadruplex DNA binding" -"GO:0008069","dorsal/ventral axis specification, ovarian follicular epithelium" -"GO:0075071","autophagy involved in symbiotic interaction" -"GO:0071727","cellular response to triacyl bacterial lipopeptide" -"GO:2000724","positive regulation of cardiac vascular smooth muscle cell differentiation" -"GO:0042948","salicin transport" -"GO:1904743","negative regulation of telomeric DNA binding" -"GO:1903642","regulation of recombination hotspot binding" -"GO:0055005","ventricular cardiac myofibril assembly" -"GO:0019330","aldoxime metabolic process" -"GO:0044765","single-organism transport" -"GO:0061789","dense core granule priming" -"GO:0097345","mitochondrial outer membrane permeabilization" -"GO:0038115","chemokine (C-C motif) ligand 19 signaling pathway" -"GO:0018045","C-terminal peptidyl-lysine amidation" -"GO:0031567","mitotic cell size control checkpoint" -"GO:0035407","histone H3-T11 phosphorylation" -"GO:0072714","response to selenite ion" -"GO:0000002","mitochondrial genome maintenance" -"GO:0050806","positive regulation of synaptic transmission" -"GO:0015878","biotin transport" -"GO:0044663","establishment or maintenance of cell type involved in phenotypic switching" -"GO:0060120","inner ear receptor cell fate commitment" -"GO:0085029","extracellular matrix assembly" -"GO:0019395","fatty acid oxidation" -"GO:0070474","positive regulation of uterine smooth muscle contraction" -"GO:0055023","positive regulation of cardiac muscle tissue growth" -"GO:1905343","regulation of cohesin unloading" -"GO:0032238","adenosine transport" -"GO:0071847","TNFSF11-mediated signaling pathway" -"GO:0060797","transforming growth factor beta receptor signaling pathway involved in primary germ layer cell fate commitment" -"GO:0071848","positive regulation of ERK1 and ERK2 cascade via TNFSF11-mediated signaling" -"GO:2001306","lipoxin B4 biosynthetic process" -"GO:1902438","response to vanadate(3-)" -"GO:2001301","lipoxin biosynthetic process" -"GO:0080136","priming of cellular response to stress" -"GO:0051568","histone H3-K4 methylation" -"GO:0019559","histidine catabolic process to imidazol-5-yl-lactate" -"GO:0090023","positive regulation of neutrophil chemotaxis" -"GO:0046687","response to chromate" -"GO:0003383","apical constriction" -"GO:0071277","cellular response to calcium ion" -"GO:2000412","positive regulation of thymocyte migration" -"GO:0006066","alcohol metabolic process" -"GO:2000212","negative regulation of glutamate metabolic process" -"GO:0051152","positive regulation of smooth muscle cell differentiation" -"GO:0036162","oxytocin secretion" -"GO:0039521","suppression by virus of host autophagy" -"GO:0097184","response to azide" -"GO:0031651","negative regulation of heat generation" -"GO:0010656","negative regulation of muscle cell apoptotic process" -"GO:0030388","fructose 1,6-bisphosphate metabolic process" -"GO:0046503","glycerolipid catabolic process" -"GO:0039023","pronephric duct morphogenesis" -"GO:0100052","negative regulation of G1/S transition of mitotic cell cycle by transcription from RNA polymerase II promoter" -"GO:1905493","regulation of G-quadruplex DNA binding" -"GO:0006068","ethanol catabolic process" -"GO:0032308","positive regulation of prostaglandin secretion" -"GO:0030316","osteoclast differentiation" -"GO:1902618","cellular response to fluoride" -"GO:0034612","response to tumor necrosis factor" -"GO:0015733","shikimate transmembrane transport" -"GO:1990764","myofibroblast contraction" -"GO:0005986","sucrose biosynthetic process" -"GO:0051602","response to electrical stimulus" -"GO:0060062","Spemann organizer formation at the dorsal lip of the blastopore" -"GO:0071419","cellular response to amphetamine" -"GO:0015720","allantoin transport" -"GO:1905045","negative regulation of Schwann cell proliferation involved in axon regeneration" -"GO:0070162","adiponectin secretion" -"GO:0038123","toll-like receptor TLR1:TLR2 signaling pathway" -"GO:0070375","ERK5 cascade" -"GO:0010910","positive regulation of heparan sulfate proteoglycan biosynthesis by positive regulation of epimerase activity" -"GO:0035348","acetyl-CoA transmembrane transport" -"GO:0043247","telomere maintenance in response to DNA damage" -"GO:1901751","leukotriene A4 metabolic process" -"GO:0033272","myo-inositol hexakisphosphate transport" -"GO:0045820","negative regulation of glycolytic process" -"GO:0060744","mammary gland branching involved in thelarche" -"GO:0002577","regulation of antigen processing and presentation" -"GO:0090390","phagosome acidification involved in apoptotic cell clearance" -"GO:0042127","regulation of cell proliferation" -"GO:0006848","pyruvate transport" -"GO:0032965","regulation of collagen biosynthetic process" -"GO:0002413","tolerance induction to tumor cell" -"GO:0048642","negative regulation of skeletal muscle tissue development" -"GO:0042376","phylloquinone catabolic process" -"GO:0006473","protein acetylation" -"GO:0071411","cellular response to fluoxetine" -"GO:0035463","transforming growth factor beta receptor signaling pathway involved in determination of left/right asymmetry" -"GO:0007560","imaginal disc morphogenesis" -"GO:0030431","sleep" -"GO:0018257","peptidyl-lysine formylation" -"GO:1990144","intrinsic apoptotic signaling pathway in response to hypoxia" -"GO:2000584","negative regulation of platelet-derived growth factor receptor-alpha signaling pathway" -"GO:1905313","transforming growth factor beta receptor signaling pathway involved in heart development" -"GO:0072743","cellular response to erythromycin" -"GO:1903055","positive regulation of extracellular matrix organization" -"GO:0019408","dolichol biosynthetic process" -"GO:0090165","regulation of secretion by asymmetric Golgi ribbon formation" -"GO:0002647","negative regulation of central tolerance induction" -"GO:0060485","mesenchyme development" -"GO:0018425","O3-(N-acetylglucosamine-1-phosphoryl)-L-serine biosynthetic process" -"GO:2001251","negative regulation of chromosome organization" -"GO:1904864","negative regulation of beta-catenin-TCF complex assembly" -"GO:0040031","snRNA modification" -"GO:0015106","bicarbonate transmembrane transporter activity" -"GO:0061610","glycerol to glycerone phosphate metabolic process" -"GO:0071444","cellular response to pheromone" -"GO:1990884","RNA acetylation" -"GO:0072707","cellular response to sodium dodecyl sulfate" -"GO:0072239","metanephric glomerulus vasculature development" -"GO:0032690","negative regulation of interleukin-1 alpha production" -"GO:1901369","cyclic 2,3-bisphospho-D-glycerate biosynthetic process" -"GO:0071322","cellular response to carbohydrate stimulus" -"GO:1904051","regulation of protein targeting to vacuole involved in autophagy" -"GO:0045368","positive regulation of interleukin-13 biosynthetic process" -"GO:0021587","cerebellum morphogenesis" -"GO:0007502","digestive tract mesoderm development" -"GO:0003042","vasoconstriction of artery involved in carotid body chemoreceptor response to lowering of systemic arterial blood pressure" -"GO:0002416","IgG immunoglobulin transcytosis in epithelial cells mediated by FcRn immunoglobulin receptor" -"GO:1900557","emericellamide biosynthetic process" -"GO:0010968","regulation of microtubule nucleation" -"GO:0006941","striated muscle contraction" -"GO:1904906","positive regulation of endothelial cell-matrix adhesion via fibronectin" -"GO:0006166","purine ribonucleoside salvage" -"GO:0009699","phenylpropanoid biosynthetic process" -"GO:0032538","regulation of host-seeking behavior" -"GO:0001173","DNA-templated transcriptional start site selection" -"GO:0045795","positive regulation of cell volume" -"GO:0046662","regulation of oviposition" -"GO:0035837","ergot alkaloid biosynthetic process" -"GO:0019509","L-methionine salvage from methylthioadenosine" -"GO:0060892","limb basal epidermal cell fate specification" -"GO:0032682","negative regulation of chemokine production" -"GO:0072738","cellular response to diamide" -"GO:0090380","seed trichome maturation" -"GO:0007314","oocyte anterior/posterior axis specification" -"GO:0048764","trichoblast maturation" -"GO:0007310","oocyte dorsal/ventral axis specification" -"GO:0031424","keratinization" -"GO:2001113","negative regulation of cellular response to hepatocyte growth factor stimulus" -"GO:0008055","ocellus pigment biosynthetic process" -"GO:0045361","negative regulation of interleukin-1 biosynthetic process" -"GO:1900864","mitochondrial RNA modification" -"GO:0030847","termination of RNA polymerase II transcription, exosome-dependent" -"GO:1900584","o-orsellinic acid biosynthetic process" -"GO:1904125","convergent extension involved in rhombomere morphogenesis" -"GO:0055122","response to very low light intensity stimulus" -"GO:1903435","positive regulation of constitutive secretory pathway" -"GO:1905852","positive regulation of backward locomotion" -"GO:0009652","thigmotropism" -"GO:0045702","positive regulation of spermatid nuclear differentiation" -"GO:0016143","S-glycoside metabolic process" -"GO:1903724","positive regulation of centriole elongation" -"GO:0072760","cellular response to GW 7647" -"GO:0032980","keratinocyte activation" -"GO:0048619","embryonic hindgut morphogenesis" -"GO:0001989","positive regulation of the force of heart contraction involved in baroreceptor response to decreased systemic arterial blood pressure" -"GO:1990417","snoRNA release from pre-rRNA" -"GO:0072736","cellular response to t-BOOH" -"GO:0002503","peptide antigen assembly with MHC class II protein complex" -"GO:0003330","regulation of extracellular matrix constituent secretion" -"GO:0036333","hepatocyte homeostasis" -"GO:1903889","negative regulation of plant epidermal cell differentiation" -"GO:0045655","regulation of monocyte differentiation" -"GO:0002912","negative regulation of lymphocyte anergy" -"GO:1903553","positive regulation of extracellular exosome assembly" -"GO:1905240","negative regulation of canonical Wnt signaling pathway involved in osteoblast differentiation" -"GO:1904764","chaperone-mediated autophagy translocation complex disassembly" -"GO:1900572","diorcinol biosynthetic process" -"GO:0097316","cellular response to N-acetyl-D-glucosamine" -"GO:0045380","positive regulation of interleukin-17 biosynthetic process" -"GO:0007283","spermatogenesis" -"GO:0046689","response to mercury ion" -"GO:0060904","regulation of protein folding in endoplasmic reticulum" -"GO:0048882","lateral line development" -"GO:0071311","cellular response to acetate" -"GO:0072703","cellular response to methyl methanesulfonate" -"GO:0097278","complement-dependent cytotoxicity" -"GO:1903680","acinar cell of sebaceous gland differentiation" -"GO:1990182","exosomal secretion" -"GO:1902435","regulation of male mating behavior" -"GO:1900552","asperfuranone metabolic process" -"GO:0048006","antigen processing and presentation, endogenous lipid antigen via MHC class Ib" -"GO:0015598","arginine-importing ATPase activity" -"GO:0051646","mitochondrion localization" -"GO:0045989","positive regulation of striated muscle contraction" -"GO:0043316","cytotoxic T cell degranulation" -"GO:0072729","cellular response to Gentian violet" -"GO:0043545","molybdopterin cofactor metabolic process" -"GO:0003056","regulation of vascular smooth muscle contraction" -"GO:1900575","emodin biosynthetic process" -"GO:2000797","regulation of amniotic stem cell differentiation" -"GO:0061901","regulation of 1-phosphatidylinositol-3-kinase activity" -"GO:1900389","regulation of glucose import by regulation of transcription from RNA polymerase II promoter" -"GO:0000705","achiasmate meiosis I" -"GO:0036257","multivesicular body organization" -"GO:2001034","positive regulation of double-strand break repair via nonhomologous end joining" -"GO:0018003","peptidyl-lysine N6-acetylation" -"GO:0045875","negative regulation of sister chromatid cohesion" -"GO:0099612","protein localization to axon" -"GO:1900793","shamixanthone biosynthetic process" -"GO:0048537","mucosal-associated lymphoid tissue development" -"GO:1905168","positive regulation of double-strand break repair via homologous recombination" -"GO:1900551","N',N'',N'''-triacetylfusarinine C biosynthetic process" -"GO:1990632","branching involved in submandibular gland morphogenesis" -"GO:0007308","oocyte construction" -"GO:1901330","negative regulation of odontoblast differentiation" -"GO:0002662","negative regulation of B cell tolerance induction" -"GO:0030834","regulation of actin filament depolymerization" -"GO:1903611","negative regulation of calcium-dependent ATPase activity" -"GO:2000095","regulation of Wnt signaling pathway, planar cell polarity pathway" -"GO:0030219","megakaryocyte differentiation" -"GO:0031503","protein-containing complex localization" -"GO:1904026","regulation of collagen fibril organization" -"GO:0035789","metanephric mesenchymal cell migration" -"GO:0044655","phagosome reneutralization" -"GO:0010086","embryonic root morphogenesis" -"GO:1900805","brevianamide F biosynthetic process" -"GO:0072700","response to bismuth" -"GO:0060894","limb spinous cell fate specification" -"GO:0048521","negative regulation of behavior" -"GO:0007503","fat body development" -"GO:0048628","myoblast maturation" -"GO:0042669","regulation of inner ear auditory receptor cell fate specification" -"GO:0006489","dolichyl diphosphate biosynthetic process" -"GO:0043270","positive regulation of ion transport" -"GO:0035435","phosphate ion transmembrane transport" -"GO:0043456","regulation of pentose-phosphate shunt" -"GO:0015916","fatty-acyl-CoA transport" -"GO:0050670","regulation of lymphocyte proliferation" -"GO:0003174","mitral valve development" -"GO:0010167","response to nitrate" -"GO:0042940","D-amino acid transport" -"GO:0048793","pronephros development" -"GO:0070863","positive regulation of protein exit from endoplasmic reticulum" -"GO:0035263","genital disc sexually dimorphic development" -"GO:2001115","methanopterin-containing compound metabolic process" -"GO:0061080","right horn of sinus venosus development" -"GO:0061721","6-sulfoquinovose(1-) catabolic process to 3-sulfopropanediol(1-)" -"GO:0046622","positive regulation of organ growth" -"GO:0006056","mannoprotein metabolic process" -"GO:0048438","floral whorl development" -"GO:0006791","sulfur utilization" -"GO:0060546","negative regulation of necroptotic process" -"GO:0001407","glycerophosphodiester transmembrane transport" -"GO:0006599","phosphagen metabolic process" -"GO:0070731","cGMP transport" -"GO:0048367","shoot system development" -"GO:0072066","prebend segment development" -"GO:1901859","negative regulation of mitochondrial DNA metabolic process" -"GO:1904866","ventral tegmental area development" -"GO:0060058","positive regulation of apoptotic process involved in mammary gland involution" -"GO:0010431","seed maturation" -"GO:1902807","negative regulation of cell cycle G1/S phase transition" -"GO:0019562","phenylalanine catabolic process to phosphoenolpyruvate" -"GO:0032415","regulation of sodium:proton antiporter activity" -"GO:0098910","regulation of atrial cardiac muscle cell action potential" -"GO:0075055","positive regulation of symbiont penetration peg formation for entry into host" -"GO:0035603","fibroblast growth factor receptor signaling pathway involved in hemopoiesis" -"GO:1901261","regulation of sorocarp spore cell differentiation" -"GO:0035315","hair cell differentiation" -"GO:0080121","AMP transport" -"GO:0060684","epithelial-mesenchymal cell signaling" -"GO:0019302","D-ribose biosynthetic process" -"GO:0001844","protein insertion into mitochondrial membrane involved in apoptotic signaling pathway" -"GO:0039018","nephrostome development" -"GO:0052863","1-deoxy-D-xylulose 5-phosphate metabolic process" -"GO:0072116","pronephros formation" -"GO:0072429","response to intra-S DNA damage checkpoint signaling" -"GO:0090035","positive regulation of chaperone-mediated protein complex assembly" -"GO:0043251","sodium-dependent organic anion transport" -"GO:0006808","regulation of nitrogen utilization" -"GO:1903842","response to arsenite ion" -"GO:1902964","positive regulation of metalloendopeptidase activity involved in amyloid precursor protein catabolic process" -"GO:0060421","positive regulation of heart growth" -"GO:0098989","NMDA selective glutamate receptor signaling pathway" -"GO:0006602","creatinine catabolic process" -"GO:0150008","bulk synaptic vesicle endocytosis" -"GO:0006592","ornithine biosynthetic process" -"GO:2000826","regulation of heart morphogenesis" -"GO:0015715","nucleotide-sulfate transport" -"GO:0061225","mesonephric extraglomerular mesangial cell proliferation involved in mesonephros development" -"GO:0010948","negative regulation of cell cycle process" -"GO:1905600","regulation of receptor-mediated endocytosis involved in cholesterol transport" -"GO:1990561","regulation of transcription from RNA polymerase II promoter in response to copper ion starvation" -"GO:0072360","vascular cord development" -"GO:1901840","negative regulation of RNA polymerase I regulatory region sequence-specific DNA binding" -"GO:0051799","negative regulation of hair follicle development" -"GO:0006003","fructose 2,6-bisphosphate metabolic process" -"GO:0061027","umbilical cord development" -"GO:0002358","B cell homeostatic proliferation" -"GO:0042930","enterobactin transport" -"GO:0030329","prenylcysteine metabolic process" -"GO:0080168","abscisic acid transport" -"GO:0019283","L-methionine biosynthetic process from O-phospho-L-homoserine and cystathionine" -"GO:0042635","positive regulation of hair cycle" -"GO:0061113","pancreas morphogenesis" -"GO:1903867","extraembryonic membrane development" -"GO:2001287","negative regulation of caveolin-mediated endocytosis" -"GO:0043207","response to external biotic stimulus" -"GO:1990248","regulation of transcription from RNA polymerase II promoter in response to DNA damage" -"GO:1905607","negative regulation of presynapse assembly" -"GO:0014707","branchiomeric skeletal muscle development" -"GO:0031947","negative regulation of glucocorticoid biosynthetic process" -"GO:0007356","thorax and anterior abdomen determination" -"GO:0048736","appendage development" -"GO:0010870","positive regulation of receptor biosynthetic process" -"GO:0032738","positive regulation of interleukin-15 production" -"GO:0045796","negative regulation of intestinal cholesterol absorption" -"GO:1905608","positive regulation of presynapse assembly" -"GO:0072353","cellular age-dependent response to reactive oxygen species" -"GO:1901198","positive regulation of calcium ion transport into cytosol involved in cellular response to calcium ion" -"GO:0019574","sucrose catabolic process via 3'-ketosucrose" -"GO:0003115","regulation of vasoconstriction by epinephrine" -"GO:0019446","tyrosine catabolic process to phosphoenolpyruvate" -"GO:1902262","apoptotic process involved in blood vessel morphogenesis" -"GO:0051451","myoblast migration" -"GO:1904311","response to gold(3+)" -"GO:1905274","regulation of modification of postsynaptic actin cytoskeleton" -"GO:0086053","AV node cell to bundle of His cell communication by electrical coupling" -"GO:0046942","carboxylic acid transport" -"GO:0021679","cerebellar molecular layer development" -"GO:0061833","protein localization to tricellular tight junction" -"GO:0051603","proteolysis involved in cellular protein catabolic process" -"GO:0048515","spermatid differentiation" -"GO:0033271","myo-inositol phosphate transport" -"GO:0032472","Golgi calcium ion transport" -"GO:0016319","mushroom body development" -"GO:0030916","otic vesicle formation" -"GO:0046690","response to tellurium ion" -"GO:1903621","protein localization to photoreceptor connecting cilium" -"GO:0015794","glycerol-3-phosphate transmembrane transport" -"GO:1901948","5alpha,9alpha,10beta-labda-8(20),13-dien-15-yl diphosphate catabolic process" -"GO:1904867","protein localization to Cajal body" -"GO:0032976","release of matrix enzymes from mitochondria" -"GO:0010162","seed dormancy process" -"GO:0021696","cerebellar cortex morphogenesis" -"GO:0010049","acquisition of plant reproductive competence" -"GO:2001289","lipid X metabolic process" -"GO:0048036","central complex development" -"GO:0006753","nucleoside phosphate metabolic process" -"GO:0046692","sperm competition" -"GO:1901424","response to toluene" -"GO:0022605","oogenesis stage" -"GO:0042357","thiamine diphosphate metabolic process" -"GO:0035349","coenzyme A transmembrane transport" -"GO:0080086","stamen filament development" -"GO:0002352","B cell negative selection" -"GO:0007371","ventral midline determination" -"GO:0061956","penetration of cumulus oophorus" -"GO:0015904","tetracycline transport" -"GO:0061720","6-sulfoquinovose(1-) catabolic process to glycerone phosphate and 3-sulfolactaldehyde" -"GO:0007421","stomatogastric nervous system development" -"GO:0019682","glyceraldehyde-3-phosphate metabolic process" -"GO:0032468","Golgi calcium ion homeostasis" -"GO:0015687","ferric-hydroxamate transport" -"GO:0036474","cell death in response to hydrogen peroxide" -"GO:2001076","positive regulation of metanephric ureteric bud development" -"GO:0080033","response to nitrite" -"GO:1905518","regulation of presynaptic active zone assembly" -"GO:0048854","brain morphogenesis" -"GO:0060653","epithelial cell differentiation involved in mammary gland cord morphogenesis" -"GO:0051167","xylulose 5-phosphate metabolic process" -"GO:0046666","retinal cell programmed cell death" -"GO:0042822","pyridoxal phosphate metabolic process" -"GO:1904817","serous membrane development" -"GO:0061790","dense core granule docking" -"GO:0043249","erythrocyte maturation" -"GO:0035864","response to potassium ion" -"GO:0061032","visceral serous pericardium development" -"GO:0019692","deoxyribose phosphate metabolic process" -"GO:0043084","penile erection" -"GO:2001244","positive regulation of intrinsic apoptotic signaling pathway" -"GO:0090166","Golgi disassembly" -"GO:0003105","negative regulation of glomerular filtration" -"GO:0097468","programmed cell death in response to reactive oxygen species" -"GO:0002424","T cell mediated immune response to tumor cell" -"GO:1902511","negative regulation of apoptotic DNA fragmentation" -"GO:0070408","carbamoyl phosphate metabolic process" -"GO:0035609","C-terminal protein deglutamylation" -"GO:0032629","interleukin-25 production" -"GO:0045586","regulation of gamma-delta T cell differentiation" -"GO:0000304","response to singlet oxygen" -"GO:0018952","parathion metabolic process" -"GO:0014075","response to amine" -"GO:1905328","plant septum development" -"GO:0002347","response to tumor cell" -"GO:1904886","beta-catenin destruction complex disassembly" -"GO:0006225","UDP biosynthetic process" -"GO:1901530","response to hypochlorite" -"GO:2001058","D-tagatose 6-phosphate metabolic process" -"GO:0002423","natural killer cell mediated immune response to tumor cell" -"GO:0071354","cellular response to interleukin-6" -"GO:0046478","lactosylceramide metabolic process" -"GO:0099547","regulation of translation at synapse, modulating synaptic transmission" -"GO:0039633","killing by virus of host cell" -"GO:0018984","naphthalenesulfonate metabolic process" -"GO:0014832","urinary bladder smooth muscle contraction" -"GO:0044241","lipid digestion" -"GO:0042368","vitamin D biosynthetic process" -"GO:1990926","short-term synaptic potentiation" -"GO:0007030","Golgi organization" -"GO:0070861","regulation of protein exit from endoplasmic reticulum" -"GO:0048383","mesectoderm development" -"GO:0002588","positive regulation of antigen processing and presentation of peptide antigen via MHC class II" -"GO:0052547","regulation of peptidase activity" -"GO:0000769","syncytium formation by mitosis without cytokinesis" -"GO:0090558","plant epidermis development" -"GO:0002564","alternate splicing of immunoglobulin genes" -"GO:0009780","photosynthetic NADP+ reduction" -"GO:0035617","stress granule disassembly" -"GO:0009439","cyanate metabolic process" -"GO:0006099","tricarboxylic acid cycle" -"GO:0015400","low-affinity secondary active ammonium transmembrane transporter activity" -"GO:0070351","negative regulation of white fat cell proliferation" -"GO:0051307","meiotic chromosome separation" -"GO:0016054","organic acid catabolic process" -"GO:0050846","teichuronic acid metabolic process" -"GO:0030962","peptidyl-arginine dihydroxylation to peptidyl-3,4-dihydroxy-L-arginine" -"GO:1903643","positive regulation of recombination hotspot binding" -"GO:0048507","meristem development" -"GO:0034433","steroid esterification" -"GO:0044657","pore formation in membrane of other organism during symbiotic interaction" -"GO:0010479","stele development" -"GO:0006272","leading strand elongation" -"GO:0002570","somatic diversification of immunoglobulin genes by N region addition" -"GO:0051310","metaphase plate congression" -"GO:0072389","flavin adenine dinucleotide catabolic process" -"GO:0036154","diacylglycerol acyl-chain remodeling" -"GO:0000018","regulation of DNA recombination" -"GO:0046901","tetrahydrofolylpolyglutamate biosynthetic process" -"GO:0043973","histone H3-K4 acetylation" -"GO:0010363","regulation of plant-type hypersensitive response" -"GO:1902065","response to L-glutamate" -"GO:0042074","cell migration involved in gastrulation" -"GO:0061589","calcium activated phosphatidylserine scrambling" -"GO:0045917","positive regulation of complement activation" -"GO:1905342","positive regulation of protein localization to kinetochore" -"GO:0070859","positive regulation of bile acid biosynthetic process" -"GO:0071548","response to dexamethasone" -"GO:0072012","glomerulus vasculature development" -"GO:0035303","regulation of dephosphorylation" -"GO:1902449","regulation of ATP-dependent DNA helicase activity" -"GO:0018102","peptidyl-arginine hydroxylation to peptidyl-4-hydroxy-L-arginine" -"GO:1905682","positive regulation of innate immunity memory response" -"GO:0042532","negative regulation of tyrosine phosphorylation of STAT protein" -"GO:0048478","replication fork protection" -"GO:0036213","contractile ring contraction" -"GO:0010885","regulation of cholesterol storage" -"GO:0045609","positive regulation of inner ear auditory receptor cell differentiation" -"GO:0000729","DNA double-strand break processing" -"GO:0006266","DNA ligation" -"GO:0099646","neurotransmitter receptor transport, plasma membrane to endosome" -"GO:1900064","positive regulation of peroxisome organization" -"GO:0015910","peroxisomal long-chain fatty acid import" -"GO:0051360","peptide cross-linking via L-asparagine 5-imidazolinone glycine" -"GO:1903082","positive regulation of C-C chemokine receptor CCR7 signaling pathway" -"GO:0033624","negative regulation of integrin activation" -"GO:0006669","sphinganine-1-phosphate biosynthetic process" -"GO:0010337","regulation of salicylic acid metabolic process" -"GO:1904915","positive regulation of establishment of protein-containing complex localization to telomere" -"GO:0060748","tertiary branching involved in mammary gland duct morphogenesis" -"GO:0006414","translational elongation" -"GO:0045630","positive regulation of T-helper 2 cell differentiation" -"GO:0021872","forebrain generation of neurons" -"GO:0070392","detection of lipoteichoic acid" -"GO:0034641","cellular nitrogen compound metabolic process" -"GO:1901532","regulation of hematopoietic progenitor cell differentiation" -"GO:0045019","negative regulation of nitric oxide biosynthetic process" -"GO:0051259","protein complex oligomerization" -"GO:0044027","hypermethylation of CpG island" -"GO:0071674","mononuclear cell migration" -"GO:0061857","endoplasmic reticulum stress-induced pre-emptive quality control" -"GO:0015727","lactate transport" -"GO:0006086","acetyl-CoA biosynthetic process from pyruvate" -"GO:0018972","toluene-4-sulfonate metabolic process" -"GO:1900073","regulation of neuromuscular synaptic transmission" -"GO:0000354","cis assembly of pre-catalytic spliceosome" -"GO:0009125","nucleoside monophosphate catabolic process" -"GO:1905435","regulation of histone H3-K4 trimethylation" -"GO:0019065","receptor-mediated endocytosis of virus by host cell" -"GO:0098962","regulation of postsynaptic neurotransmitter receptor activity" -"GO:0006893","Golgi to plasma membrane transport" -"GO:0039599","cleavage by virus of host mRNA" -"GO:1903007","positive regulation of Lys63-specific deubiquitinase activity" -"GO:0016053","organic acid biosynthetic process" -"GO:0060742","epithelial cell differentiation involved in prostate gland development" -"GO:0098717","pantothenate import across plasma membrane" -"GO:0003282","ventricular septum intermedium development" -"GO:0031388","organic acid phosphorylation" -"GO:0032499","detection of peptidoglycan" -"GO:0033579","protein galactosylation in endoplasmic reticulum" -"GO:0019054","modulation by virus of host process" -"GO:0021589","cerebellum structural organization" -"GO:0120036","plasma membrane bounded cell projection organization" -"GO:0045720","negative regulation of integrin biosynthetic process" -"GO:0002233","leukocyte chemotaxis involved in immune response" -"GO:0010193","response to ozone" -"GO:0031407","oxylipin metabolic process" -"GO:0097477","lateral motor column neuron migration" -"GO:0033144","negative regulation of intracellular steroid hormone receptor signaling pathway" -"GO:0090472","dibasic protein processing" -"GO:0060599","lateral sprouting involved in mammary gland duct morphogenesis" -"GO:0060668","regulation of branching involved in salivary gland morphogenesis by extracellular matrix-epithelial cell signaling" -"GO:0042760","very long-chain fatty acid catabolic process" -"GO:1903932","regulation of DNA primase activity" -"GO:1902336","positive regulation of retinal ganglion cell axon guidance" -"GO:0021911","retinoic acid metabolic process in spinal cord anterior-posterior patterning" -"GO:0032510","endosome to lysosome transport via multivesicular body sorting pathway" -"GO:0010510","regulation of acetyl-CoA biosynthetic process from pyruvate" -"GO:0048808","male genitalia morphogenesis" -"GO:2001304","lipoxin B4 metabolic process" -"GO:0043383","negative T cell selection" -"GO:0021942","radial glia guided migration of Purkinje cell" -"GO:0016577","histone demethylation" -"GO:0032077","positive regulation of deoxyribonuclease activity" -"GO:0048072","compound eye pigmentation" -"GO:0090008","hypoblast development" -"GO:0019102","male somatic sex determination" -"GO:0060056","mammary gland involution" -"GO:0090234","regulation of kinetochore assembly" -"GO:0014842","regulation of skeletal muscle satellite cell proliferation" -"GO:0070446","negative regulation of oligodendrocyte progenitor proliferation" -"GO:1905778","negative regulation of exonuclease activity" -"GO:1900027","regulation of ruffle assembly" -"GO:2000350","positive regulation of CD40 signaling pathway" -"GO:0021813","cell-cell adhesion involved in neuronal-glial interactions involved in cerebral cortex radial glia guided migration" -"GO:0018076","N-terminal peptidyl-lysine acetylation" -"GO:0034970","histone H3-R2 methylation" -"GO:0021517","ventral spinal cord development" -"GO:0019348","dolichol metabolic process" -"GO:0032049","cardiolipin biosynthetic process" -"GO:0065009","regulation of molecular function" -"GO:1902214","regulation of interleukin-4-mediated signaling pathway" -"GO:0017183","peptidyl-diphthamide biosynthetic process from peptidyl-histidine" -"GO:0099171","presynaptic modulation of chemical synaptic transmission" -"GO:1902776","6-sulfoquinovose(1-) metabolic process" -"GO:0000480","endonucleolytic cleavage in 5'-ETS of tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:1904534","negative regulation of telomeric loop disassembly" -"GO:1903512","phytanic acid metabolic process" -"GO:0019681","acetyl-CoA assimilation pathway" -"GO:0045726","positive regulation of integrin biosynthetic process" -"GO:0048638","regulation of developmental growth" -"GO:1900039","positive regulation of cellular response to hypoxia" -"GO:0070933","histone H4 deacetylation" -"GO:0031168","ferrichrome metabolic process" -"GO:0019694","alkanesulfonate metabolic process" -"GO:0000083","regulation of transcription involved in G1/S transition of mitotic cell cycle" -"GO:0060736","prostate gland growth" -"GO:0006398","mRNA 3'-end processing by stem-loop binding and cleavage" -"GO:0036090","cleavage furrow ingression" -"GO:0051149","positive regulation of muscle cell differentiation" -"GO:0010087","phloem or xylem histogenesis" -"GO:0060854","branching involved in lymph vessel morphogenesis" -"GO:0006006","glucose metabolic process" -"GO:0009117","nucleotide metabolic process" -"GO:0015756","fucose transmembrane transport" -"GO:0006888","ER to Golgi vesicle-mediated transport" -"GO:0048712","negative regulation of astrocyte differentiation" -"GO:0090205","positive regulation of cholesterol metabolic process" -"GO:1901092","positive regulation of protein tetramerization" -"GO:1990170","stress response to cadmium ion" -"GO:0051852","disruption by host of symbiont cells" -"GO:0090128","regulation of synapse maturation" -"GO:0043436","oxoacid metabolic process" -"GO:0031441","negative regulation of mRNA 3'-end processing" -"GO:0080060","integument development" -"GO:0110011","regulation of basement membrane organization" -"GO:0035590","purinergic nucleotide receptor signaling pathway" -"GO:0051304","chromosome separation" -"GO:1901202","negative regulation of extracellular matrix assembly" -"GO:0007538","primary sex determination" -"GO:0071786","endoplasmic reticulum tubular network organization" -"GO:0002310","alpha-beta T cell proliferation involved in immune response" -"GO:1903881","regulation of interleukin-17-mediated signaling pathway" -"GO:0010889","regulation of sequestering of triglyceride" -"GO:0099170","postsynaptic modulation of chemical synaptic transmission" -"GO:0009960","endosperm development" -"GO:0006508","proteolysis" -"GO:1901844","regulation of cell communication by electrical coupling involved in cardiac conduction" -"GO:0051951","positive regulation of glutamate uptake involved in transmission of nerve impulse" -"GO:0051047","positive regulation of secretion" -"GO:1902798","positive regulation of snoRNA processing" -"GO:0060610","mesenchymal cell differentiation involved in mammary gland development" -"GO:0009154","purine ribonucleotide catabolic process" -"GO:1904513","negative regulation of initiation of premeiotic DNA replication" -"GO:1902939","negative regulation of intracellular calcium activated chloride channel activity" -"GO:0097696","STAT cascade" -"GO:0034379","very-low-density lipoprotein particle assembly" -"GO:2000573","positive regulation of DNA biosynthetic process" -"GO:2001247","positive regulation of phosphatidylcholine biosynthetic process" -"GO:0010266","response to vitamin B1" -"GO:0055016","hypochord development" -"GO:0044524","protein sulfhydration" -"GO:0048171","negative regulation of long-term neuronal synaptic plasticity" -"GO:0060505","epithelial cell proliferation involved in lung bud dilation" -"GO:0035523","protein K29-linked deubiquitination" -"GO:0033469","gibberellin 12 metabolic process" -"GO:0098004","virus tail fiber assembly" -"GO:0071265","L-methionine biosynthetic process" -"GO:1905293","negative regulation of neural crest cell differentiation" -"GO:0050973","detection of mechanical stimulus involved in equilibrioception" -"GO:0061009","common bile duct development" -"GO:0098003","viral tail assembly" -"GO:0046832","negative regulation of RNA export from nucleus" -"GO:1904904","regulation of endothelial cell-matrix adhesion via fibronectin" -"GO:0036065","fucosylation" -"GO:0042361","menaquinone catabolic process" -"GO:0002735","positive regulation of myeloid dendritic cell cytokine production" -"GO:1903828","negative regulation of cellular protein localization" -"GO:0046449","creatinine metabolic process" -"GO:1902771","positive regulation of choline O-acetyltransferase activity" -"GO:0050971","detection of mechanical stimulus involved in magnetoreception" -"GO:0071905","protein N-linked glucosylation via asparagine" -"GO:0097712","vesicle targeting, trans-Golgi to periciliary membrane compartment" -"GO:0002738","positive regulation of plasmacytoid dendritic cell cytokine production" -"GO:0010833","telomere maintenance via telomere lengthening" -"GO:0042418","epinephrine biosynthetic process" -"GO:1904431","positive regulation of t-circle formation" -"GO:0006754","ATP biosynthetic process" -"GO:0090326","positive regulation of locomotion involved in locomotory behavior" -"GO:0051262","protein tetramerization" -"GO:0060709","glycogen cell differentiation involved in embryonic placenta development" -"GO:0003390","dendrite development by retrograde extension" -"GO:0009825","multidimensional cell growth" -"GO:0070134","positive regulation of mitochondrial translational initiation" -"GO:0018963","phthalate metabolic process" -"GO:0061357","positive regulation of Wnt protein secretion" -"GO:1900159","positive regulation of bone mineralization involved in bone maturation" -"GO:1902948","negative regulation of tau-protein kinase activity" -"GO:1900892","positive regulation of pentadecane metabolic process" -"GO:0051211","anisotropic cell growth" -"GO:0055003","cardiac myofibril assembly" -"GO:0044401","multi-species biofilm formation in or on host organism" -"GO:0038008","TRAF-mediated signal transduction" -"GO:1903109","positive regulation of transcription from mitochondrial promoter" -"GO:0090307","mitotic spindle assembly" -"GO:0007427","epithelial cell migration, open tracheal system" -"GO:1901658","glycosyl compound catabolic process" -"GO:1905295","regulation of neural crest cell fate specification" -"GO:0033304","chlorophyll a metabolic process" -"GO:1904858","negative regulation of endothelial cell chemotaxis to vascular endothelial growth factor" -"GO:0071284","cellular response to lead ion" -"GO:1903455","negative regulation of androst-4-ene-3,17-dione biosynthetic process" -"GO:0098722","asymmetric stem cell division" -"GO:0019044","maintenance of viral latency" -"GO:0042542","response to hydrogen peroxide" -"GO:0032902","nerve growth factor production" -"GO:0014866","skeletal myofibril assembly" -"GO:0051176","positive regulation of sulfur metabolic process" -"GO:0021524","visceral motor neuron differentiation" -"GO:0098678","viral tropism switching" -"GO:0048008","platelet-derived growth factor receptor signaling pathway" -"GO:1905182","positive regulation of urease activity" -"GO:0035054","embryonic heart tube anterior/posterior pattern specification" -"GO:0044555","negative regulation of heart rate in other organism" -"GO:0039707","pore formation by virus in membrane of host cell" -"GO:0032304","negative regulation of icosanoid secretion" -"GO:1903938","cellular response to acrylamide" -"GO:0061352","cell chemotaxis involved in Malpighian tubule morphogenesis" -"GO:1903801","L-leucine import across plasma membrane" -"GO:1901625","cellular response to ergosterol" -"GO:0070999","detection of mechanical stimulus involved in sensory perception of gravity" -"GO:0045065","cytotoxic T cell differentiation" -"GO:0001985","negative regulation of heart rate involved in baroreceptor response to increased systemic arterial blood pressure" -"GO:0033148","positive regulation of intracellular estrogen receptor signaling pathway" -"GO:0048390","intermediate mesoderm morphogenesis" -"GO:0046807","viral scaffold assembly and maintenance" -"GO:0046006","regulation of activated T cell proliferation" -"GO:0010018","far-red light signaling pathway" -"GO:0000429","carbon catabolite regulation of transcription from RNA polymerase II promoter" -"GO:0006585","dopamine biosynthetic process from tyrosine" -"GO:0034514","mitochondrial unfolded protein response" -"GO:0099009","viral genome circularization" -"GO:0006422","aspartyl-tRNA aminoacylation" -"GO:1903806","L-isoleucine import across plasma membrane" -"GO:0016137","glycoside metabolic process" -"GO:0046799","recruitment of helicase-primase complex to DNA lesions" -"GO:1905294","positive regulation of neural crest cell differentiation" -"GO:0042214","terpene metabolic process" -"GO:0090232","positive regulation of spindle checkpoint" -"GO:0010892","positive regulation of mitochondrial translation in response to stress" -"GO:0048174","negative regulation of short-term neuronal synaptic plasticity" -"GO:0042407","cristae formation" -"GO:0002101","tRNA wobble cytosine modification" -"GO:1900961","positive regulation of 17-methylnonadec-1-ene metabolic process" -"GO:0034405","response to fluid shear stress" -"GO:0072263","metanephric intraglomerular mesangial cell proliferation" -"GO:0008103","oocyte microtubule cytoskeleton polarization" -"GO:1901620","regulation of smoothened signaling pathway involved in dorsal/ventral neural tube patterning" -"GO:0003225","left ventricular trabecular myocardium morphogenesis" -"GO:0035562","negative regulation of chromatin binding" -"GO:1904145","negative regulation of meiotic cell cycle process involved in oocyte maturation" -"GO:0032121","meiotic attachment of telomeric heterochromatin to spindle pole body" -"GO:1902997","negative regulation of neurofibrillary tangle assembly" -"GO:0085017","symbiont entry into host cell forming a symbiont-containing vacuole" -"GO:0035902","response to immobilization stress" -"GO:1903807","L-threonine import across plasma membrane" -"GO:0110046","signal transduction involved in cell cycle switching, mitotic to meiotic cell cycle" -"GO:0045991","carbon catabolite activation of transcription" -"GO:1904968","positive regulation of attachment of spindle microtubules to kinetochore involved in homologous chromosome segregation" -"GO:0032291","axon ensheathment in central nervous system" -"GO:0055089","fatty acid homeostasis" -"GO:0019242","methylglyoxal biosynthetic process" -"GO:1990880","cellular detoxification of copper ion" -"GO:0035900","response to isolation stress" -"GO:0048103","somatic stem cell division" -"GO:0044826","viral genome integration into host DNA" -"GO:0009826","unidimensional cell growth" -"GO:0019042","viral latency" -"GO:0007161","calcium-independent cell-matrix adhesion" -"GO:0035793","positive regulation of metanephric mesenchymal cell migration by platelet-derived growth factor receptor-beta signaling pathway" -"GO:0003063","negative regulation of heart rate by acetylcholine" -"GO:0051194","positive regulation of cofactor metabolic process" -"GO:0001576","globoside biosynthetic process" -"GO:0032025","response to cobalt ion" -"GO:0002415","immunoglobulin transcytosis in epithelial cells mediated by polymeric immunoglobulin receptor" -"GO:0060196","positive regulation of antisense RNA transcription" -"GO:0035338","long-chain fatty-acyl-CoA biosynthetic process" -"GO:2000990","positive regulation of hemicellulose catabolic process" -"GO:1901087","benzylpenicillin catabolic process" -"GO:0015375","glycine:sodium symporter activity" -"GO:0043312","neutrophil degranulation" -"GO:0002528","regulation of vascular permeability involved in acute inflammatory response" -"GO:0043942","negative regulation of sexual sporulation resulting in formation of a cellular spore" -"GO:1902963","negative regulation of metalloendopeptidase activity involved in amyloid precursor protein catabolic process" -"GO:0042745","circadian sleep/wake cycle" -"GO:0048588","developmental cell growth" -"GO:0036120","cellular response to platelet-derived growth factor stimulus" -"GO:0060969","negative regulation of gene silencing" -"GO:0044313","protein K6-linked deubiquitination" -"GO:0048386","positive regulation of retinoic acid receptor signaling pathway" -"GO:0071389","cellular response to mineralocorticoid stimulus" -"GO:0050921","positive regulation of chemotaxis" -"GO:1902648","positive regulation of 1-phosphatidyl-1D-myo-inositol 4,5-bisphosphate biosynthetic process" -"GO:0005981","regulation of glycogen catabolic process" -"GO:0098913","membrane depolarization during ventricular cardiac muscle cell action potential" -"GO:0052066","entry of symbiont into host cell by promotion of host phagocytosis" -"GO:0048017","inositol lipid-mediated signaling" -"GO:0072335","regulation of canonical Wnt signaling pathway involved in neural crest cell differentiation" -"GO:0014915","regulation of muscle filament sliding speed involved in regulation of the velocity of shortening in skeletal muscle contraction" -"GO:0033574","response to testosterone" -"GO:0031627","telomeric loop formation" -"GO:1905427","intracellular signal transduction involved in positive regulation of cell growth" -"GO:0051210","isotropic cell growth" -"GO:0046105","thymidine biosynthetic process" -"GO:1902955","positive regulation of early endosome to recycling endosome transport" -"GO:0071670","smooth muscle cell chemotaxis" -"GO:0048077","negative regulation of compound eye pigmentation" -"GO:1901994","negative regulation of meiotic cell cycle phase transition" -"GO:1902960","negative regulation of aspartic-type endopeptidase activity involved in amyloid precursor protein catabolic process" -"GO:0002658","regulation of peripheral tolerance induction" -"GO:1902306","negative regulation of sodium ion transmembrane transport" -"GO:1902410","mitotic cytokinetic process" -"GO:0009816","defense response to bacterium, incompatible interaction" -"GO:0042704","uterine wall breakdown" -"GO:0090193","positive regulation of glomerulus development" -"GO:0043374","CD8-positive, alpha-beta T cell differentiation" -"GO:0060672","epithelial cell morphogenesis involved in placental branching" -"GO:0006728","pteridine biosynthetic process" -"GO:0032262","pyrimidine nucleotide salvage" -"GO:0008295","spermidine biosynthetic process" -"GO:0014862","regulation of skeletal muscle contraction by chemo-mechanical energy conversion" -"GO:1901621","negative regulation of smoothened signaling pathway involved in dorsal/ventral neural tube patterning" -"GO:0003054","circadian regulation of systemic arterial blood pressure by the suprachiasmatic nucleus" -"GO:0003243","circumferential growth involved in left ventricle morphogenesis" -"GO:0040010","positive regulation of growth rate" -"GO:0061907","negative regulation of AMPA receptor activity" -"GO:0003019","central nervous system control of baroreceptor feedback" -"GO:0019285","glycine betaine biosynthetic process from choline" -"GO:0045406","negative regulation of interleukin-5 biosynthetic process" -"GO:0030242","autophagy of peroxisome" -"GO:0009446","putrescine biosynthetic process" -"GO:0060741","prostate gland stromal morphogenesis" -"GO:1901016","regulation of potassium ion transmembrane transporter activity" -"GO:0006081","cellular aldehyde metabolic process" -"GO:0002010","excitation of vasomotor center by baroreceptor signaling" -"GO:1990579","peptidyl-serine trans-autophosphorylation" -"GO:1901899","positive regulation of relaxation of cardiac muscle" -"GO:2001116","methanopterin-containing compound biosynthetic process" -"GO:0001696","gastric acid secretion" -"GO:0006513","protein monoubiquitination" -"GO:0061856","Golgi calcium ion transmembrane transport" -"GO:0033206","meiotic cytokinesis" -"GO:1903226","positive regulation of endodermal cell differentiation" -"GO:0061819","telomeric DNA-containing double minutes formation" -"GO:0042426","choline catabolic process" -"GO:0100049","negative regulation of phosphatidylcholine biosynthetic process by transcription from RNA polymerase II promoter" -"GO:0060855","venous endothelial cell migration involved in lymph vessel development" -"GO:0002008","excitation of vasomotor center by chemoreceptor signaling" -"GO:1901356","beta-D-galactofuranose metabolic process" -"GO:0051291","protein heterooligomerization" -"GO:0003025","regulation of systemic arterial blood pressure by baroreceptor feedback" -"GO:0002433","immune response-regulating cell surface receptor signaling pathway involved in phagocytosis" -"GO:0009682","induced systemic resistance" -"GO:0008340","determination of adult lifespan" -"GO:0035780","CD80 biosynthetic process" -"GO:0100025","negative regulation of cellular amino acid biosynthetic process by transcription from RNA polymerase II promoter" -"GO:0031506","cell wall glycoprotein biosynthetic process" -"GO:0003026","regulation of systemic arterial blood pressure by aortic arch baroreceptor feedback" -"GO:0046725","negative regulation by virus of viral protein levels in host cell" -"GO:0070849","response to epidermal growth factor" -"GO:0001978","regulation of systemic arterial blood pressure by carotid sinus baroreceptor feedback" -"GO:0035910","ascending aorta morphogenesis" -"GO:0100001","regulation of skeletal muscle contraction by action potential" -"GO:0010586","miRNA metabolic process" -"GO:1903670","regulation of sprouting angiogenesis" -"GO:0032423","regulation of mismatch repair" -"GO:0060487","lung epithelial cell differentiation" -"GO:0050904","diapedesis" -"GO:0001706","endoderm formation" -"GO:1903861","positive regulation of dendrite extension" -"GO:2000751","histone H3-T3 phosphorylation involved in chromosome passenger complex localization to kinetochore" -"GO:0097053","L-kynurenine catabolic process" -"GO:1902464","regulation of histone H3-K27 trimethylation" -"GO:0003230","cardiac atrium development" -"GO:1903628","negative regulation of dUTP diphosphatase activity" -"GO:0070309","lens fiber cell morphogenesis" -"GO:0034227","tRNA thio-modification" -"GO:0072382","minus-end-directed vesicle transport along microtubule" -"GO:2000009","negative regulation of protein localization to cell surface" -"GO:0006046","N-acetylglucosamine catabolic process" -"GO:0045312","nor-spermidine biosynthetic process" -"GO:0002035","brain renin-angiotensin system" -"GO:0051005","negative regulation of lipoprotein lipase activity" -"GO:0061056","sclerotome development" -"GO:0035351","heme transmembrane transport" -"GO:0035724","CD24 biosynthetic process" -"GO:0043378","positive regulation of CD8-positive, alpha-beta T cell differentiation" -"GO:2000650","negative regulation of sodium ion transmembrane transporter activity" -"GO:0046654","tetrahydrofolate biosynthetic process" -"GO:0045807","positive regulation of endocytosis" -"GO:0006057","mannoprotein biosynthetic process" -"GO:1905006","negative regulation of epithelial to mesenchymal transition involved in endocardial cushion formation" -"GO:1903033","positive regulation of microtubule plus-end binding" -"GO:0009396","folic acid-containing compound biosynthetic process" -"GO:2001288","positive regulation of caveolin-mediated endocytosis" -"GO:0100068","positive regulation of pyrimidine-containing compound salvage by transcription from RNA polymerase II promoter" -"GO:0100036","positive regulation of purine nucleotide biosynthetic process by transcription from RNA polymerase II promoter" -"GO:1905765","negative regulation of protection from non-homologous end joining at telomere" -"GO:0042176","regulation of protein catabolic process" -"GO:1900870","tatiopterin biosynthetic process" -"GO:0032193","ubiquinone biosynthetic process via 2-polyprenylphenol" -"GO:1903723","negative regulation of centriole elongation" -"GO:0071979","cytoskeleton-mediated cell swimming" -"GO:0003359","noradrenergic neuron fate commitment" -"GO:0100028","regulation of conjugation with cellular fusion by transcription from RNA polymerase II promoter" -"GO:0046452","dihydrofolate metabolic process" -"GO:0061104","adrenal chromaffin cell differentiation" -"GO:1901017","negative regulation of potassium ion transmembrane transporter activity" -"GO:0010038","response to metal ion" -"GO:0021520","spinal cord motor neuron cell fate specification" -"GO:1904715","negative regulation of chaperone-mediated autophagy" -"GO:0070570","regulation of neuron projection regeneration" -"GO:0002534","cytokine production involved in inflammatory response" -"GO:0043400","cortisol secretion" -"GO:1902375","nuclear tRNA 3'-trailer cleavage, endonucleolytic" -"GO:0060876","semicircular canal formation" -"GO:0034376","conversion of discoidal high-density lipoprotein particle to spherical high-density lipoprotein particle" -"GO:1903603","thermospermine biosynthetic process" -"GO:0036298","recombinational interstrand cross-link repair" -"GO:0009444","pyruvate oxidation" -"GO:0030820","regulation of cAMP catabolic process" -"GO:0006554","lysine catabolic process" -"GO:1904416","negative regulation of xenophagy" -"GO:0003070","regulation of systemic arterial blood pressure by neurotransmitter" -"GO:0030104","water homeostasis" -"GO:2000270","negative regulation of fibroblast apoptotic process" -"GO:0070602","regulation of centromeric sister chromatid cohesion" -"GO:0019058","viral life cycle" -"GO:0002728","negative regulation of natural killer cell cytokine production" -"GO:0014816","skeletal muscle satellite cell differentiation" -"GO:0035321","maintenance of imaginal disc-derived wing hair orientation" -"GO:0007605","sensory perception of sound" -"GO:0034516","response to vitamin B6" -"GO:1902573","positive regulation of serine-type peptidase activity" -"GO:0002853","negative regulation of T cell mediated cytotoxicity directed against tumor cell target" -"GO:2000249","regulation of actin cytoskeleton reorganization" -"GO:0009116","nucleoside metabolic process" -"GO:0090132","epithelium migration" -"GO:1901057","trimethylenediamine biosynthetic process" -"GO:0006738","nicotinamide riboside catabolic process" -"GO:0019367","fatty acid elongation, saturated fatty acid" -"GO:0030901","midbrain development" -"GO:0043602","nitrate catabolic process" -"GO:0009953","dorsal/ventral pattern formation" -"GO:0045650","negative regulation of macrophage differentiation" -"GO:0034659","isopropylmalate transport" -"GO:1903219","negative regulation of malate dehydrogenase (decarboxylating) (NADP+) activity" -"GO:2000659","regulation of interleukin-1-mediated signaling pathway" -"GO:0019343","cysteine biosynthetic process via cystathionine" -"GO:0033194","response to hydroperoxide" -"GO:0022035","rhombomere cell migration" -"GO:0021533","cell differentiation in hindbrain" -"GO:1902788","response to isooctane" -"GO:0031100","animal organ regeneration" -"GO:0034164","negative regulation of toll-like receptor 9 signaling pathway" -"GO:0031945","positive regulation of glucocorticoid metabolic process" -"GO:0097194","execution phase of apoptosis" -"GO:0045367","negative regulation of interleukin-13 biosynthetic process" -"GO:0046684","response to pyrethroid" -"GO:1901166","neural crest cell migration involved in autonomic nervous system development" -"GO:0036314","response to sterol" -"GO:0002004","secretion of vasopressin involved in fast regulation of systemic arterial blood pressure" -"GO:0006636","unsaturated fatty acid biosynthetic process" -"GO:1905169","regulation of protein localization to phagocytic vesicle" -"GO:0072680","extracellular matrix-dependent thymocyte migration" -"GO:0018000","N-terminal peptidyl-tyrosine acetylation" -"GO:0048545","response to steroid hormone" -"GO:0021551","central nervous system morphogenesis" -"GO:2000717","positive regulation of maintenance of mitotic sister chromatid cohesion, arms" -"GO:0003345","proepicardium cell migration involved in pericardium morphogenesis" -"GO:0071764","nuclear outer membrane organization" -"GO:0035481","positive regulation of Notch signaling pathway involved in heart induction" -"GO:0070893","transposon integration" -"GO:0009787","regulation of abscisic acid-activated signaling pathway" -"GO:0060481","lobar bronchus epithelium development" -"GO:0021944","neuronal-glial interaction involved in hindbrain glial-mediated radial cell migration" -"GO:1902226","regulation of macrophage colony-stimulating factor signaling pathway" -"GO:1903491","response to simvastatin" -"GO:0019464","glycine decarboxylation via glycine cleavage system" -"GO:0021522","spinal cord motor neuron differentiation" -"GO:1903911","positive regulation of receptor clustering" -"GO:1900142","negative regulation of oligodendrocyte apoptotic process" -"GO:0046099","guanine biosynthetic process" -"GO:0099150","regulation of postsynaptic specialization assembly" -"GO:0032772","negative regulation of monophenol monooxygenase activity" -"GO:0002638","negative regulation of immunoglobulin production" -"GO:1905230","response to borneol" -"GO:0010371","regulation of gibberellin biosynthetic process" -"GO:0002320","lymphoid progenitor cell differentiation" -"GO:1905316","superior endocardial cushion morphogenesis" -"GO:0002291","T cell activation via T cell receptor contact with antigen bound to MHC molecule on antigen presenting cell" -"GO:1900803","brevianamide F metabolic process" -"GO:1901055","trimethylenediamine metabolic process" -"GO:1990437","snRNA 2'-O-methylation" -"GO:0097195","pilomotor reflex" -"GO:0070723","response to cholesterol" -"GO:0003140","determination of left/right asymmetry in lateral mesoderm" -"GO:0060498","retinoic acid receptor signaling pathway involved in lung bud formation" -"GO:0052163","modulation by symbiont of defense-related host nitric oxide production" -"GO:0021934","hindbrain tangential cell migration" -"GO:0038165","oncostatin-M-mediated signaling pathway" -"GO:0034625","fatty acid elongation, monounsaturated fatty acid" -"GO:0093002","response to nematicide" -"GO:0032323","lipoate catabolic process" -"GO:0030952","establishment or maintenance of cytoskeleton polarity" -"GO:2000977","regulation of forebrain neuron differentiation" -"GO:0032820","regulation of natural killer cell proliferation involved in immune response" -"GO:0046639","negative regulation of alpha-beta T cell differentiation" -"GO:0060389","pathway-restricted SMAD protein phosphorylation" -"GO:0015787","UDP-glucuronic acid transmembrane transport" -"GO:0051549","positive regulation of keratinocyte migration" -"GO:0002326","B cell lineage commitment" -"GO:0017190","N-terminal peptidyl-aspartic acid acetylation" -"GO:0061715","miRNA 2'-O-methylation" -"GO:0021536","diencephalon development" -"GO:2001309","gliotoxin catabolic process" -"GO:0045196","establishment or maintenance of neuroblast polarity" -"GO:0016336","establishment or maintenance of polarity of larval imaginal disc epithelium" -"GO:2000492","regulation of interleukin-18-mediated signaling pathway" -"GO:1902888","protein localization to astral microtubule" -"GO:0033527","tetrapyrrole biosynthetic process from glycine and succinyl-CoA" -"GO:0030902","hindbrain development" -"GO:0003181","atrioventricular valve morphogenesis" -"GO:0042476","odontogenesis" -"GO:0048664","neuron fate determination" -"GO:0043090","amino acid import" -"GO:0002087","regulation of respiratory gaseous exchange by neurological system process" -"GO:0002128","tRNA nucleoside ribose methylation" -"GO:1900234","regulation of Kit signaling pathway" -"GO:0090355","positive regulation of auxin metabolic process" -"GO:0017197","N-terminal peptidyl-proline acetylation" -"GO:0089703","L-aspartate transmembrane export from vacuole" -"GO:0001569","branching involved in blood vessel morphogenesis" -"GO:0071963","establishment or maintenance of cell polarity regulating cell shape" -"GO:0002321","natural killer cell progenitor differentiation" -"GO:0019074","viral RNA genome packaging" -"GO:0036059","nephrocyte diaphragm assembly" -"GO:0007405","neuroblast proliferation" -"GO:2000358","positive regulation of kidney smooth muscle cell differentiation" -"GO:0016332","establishment or maintenance of polarity of embryonic epithelium" -"GO:0006896","Golgi to vacuole transport" -"GO:0003274","endocardial cushion fusion" -"GO:0015804","neutral amino acid transport" -"GO:0005988","lactose metabolic process" -"GO:0017193","N-terminal peptidyl-glycine acetylation" -"GO:0101024","nuclear membrane organization involved in mitotic nuclear division" -"GO:1905372","ceramide phosphoethanolamine catabolic process" -"GO:2001229","negative regulation of response to gamma radiation" -"GO:0044759","negative regulation by symbiont of host synaptic transmission" -"GO:2000379","positive regulation of reactive oxygen species metabolic process" -"GO:0070099","regulation of chemokine-mediated signaling pathway" -"GO:0060312","regulation of blood vessel remodeling" -"GO:0048672","positive regulation of collateral sprouting" -"GO:0030961","peptidyl-arginine hydroxylation" -"GO:0045564","positive regulation of TRAIL receptor biosynthetic process" -"GO:2000605","positive regulation of secondary growth" -"GO:0106047","polyamine deacetylation" -"GO:0009445","putrescine metabolic process" -"GO:0003430","growth plate cartilage chondrocyte growth" -"GO:0046514","ceramide catabolic process" -"GO:0010198","synergid death" -"GO:0009595","detection of biotic stimulus" -"GO:1901666","positive regulation of NAD+ ADP-ribosyltransferase activity" -"GO:0006546","glycine catabolic process" -"GO:0048894","efferent axon development in a lateral line nerve" -"GO:0071266","'de novo' L-methionine biosynthetic process" -"GO:0002483","antigen processing and presentation of endogenous peptide antigen" -"GO:0048678","response to axon injury" -"GO:0007369","gastrulation" -"GO:0044794","positive regulation by host of viral process" -"GO:0033278","cell proliferation in midbrain" -"GO:0015782","CMP-N-acetylneuraminate transmembrane transport" -"GO:0070028","regulation of transcription by carbon monoxide" -"GO:0061452","retrotrapezoid nucleus neuron differentiation" -"GO:0080178","5-carbamoylmethyl uridine residue modification" -"GO:0001986","negative regulation of the force of heart contraction involved in baroreceptor response to increased systemic arterial blood pressure" -"GO:0017189","N-terminal peptidyl-alanine acetylation" -"GO:0061163","endoplasmic reticulum polarization" -"GO:0006561","proline biosynthetic process" -"GO:0060484","lung-associated mesenchyme development" -"GO:0002666","positive regulation of T cell tolerance induction" -"GO:0030328","prenylcysteine catabolic process" -"GO:0008216","spermidine metabolic process" -"GO:0070758","regulation of interleukin-35-mediated signaling pathway" -"GO:0031016","pancreas development" -"GO:1902893","regulation of pri-miRNA transcription by RNA polymerase II" -"GO:1900539","fumonisin metabolic process" -"GO:0071542","dopaminergic neuron differentiation" -"GO:0010718","positive regulation of epithelial to mesenchymal transition" -"GO:1901243","ATPase-coupled methionine transmembrane transporter activity" -"GO:0002939","tRNA N1-guanine methylation" -"GO:1905841","response to oxidopamine" -"GO:0075199","positive regulation of symbiont haustorium neck formation for entry into host" -"GO:0035490","regulation of leukotriene production involved in inflammatory response" -"GO:0021513","spinal cord dorsal/ventral patterning" -"GO:1904565","response to 1-oleoyl-sn-glycerol 3-phosphate" -"GO:0060434","bronchus morphogenesis" -"GO:0021825","substrate-dependent cerebral cortex tangential migration" -"GO:0048598","embryonic morphogenesis" -"GO:1905702","regulation of inhibitory synapse assembly" -"GO:1902211","regulation of prolactin signaling pathway" -"GO:1902347","response to strigolactone" -"GO:0017194","N-terminal peptidyl-isoleucine acetylation" -"GO:0072147","glomerular parietal epithelial cell fate commitment" -"GO:1904339","negative regulation of dopaminergic neuron differentiation" -"GO:0008215","spermine metabolic process" -"GO:0045935","positive regulation of nucleobase-containing compound metabolic process" -"GO:1900934","positive regulation of nonadec-1-ene metabolic process" -"GO:0048714","positive regulation of oligodendrocyte differentiation" -"GO:0008065","establishment of blood-nerve barrier" -"GO:0033526","tetrapyrrole biosynthetic process from glutamate" -"GO:2000446","regulation of macrophage migration inhibitory factor signaling pathway" -"GO:0000494","box C/D snoRNA 3'-end processing" -"GO:0070103","regulation of interleukin-6-mediated signaling pathway" -"GO:1903177","negative regulation of tyrosine 3-monooxygenase activity" -"GO:0002651","positive regulation of tolerance induction to self antigen" -"GO:0002900","positive regulation of central B cell deletion" -"GO:1903615","positive regulation of protein tyrosine phosphatase activity" -"GO:0045596","negative regulation of cell differentiation" -"GO:0051598","meiotic recombination checkpoint" -"GO:2000729","positive regulation of mesenchymal cell proliferation involved in ureter development" -"GO:0002946","tRNA C5-cytosine methylation" -"GO:0030162","regulation of proteolysis" -"GO:0002325","natural killer cell differentiation involved in immune response" -"GO:1904644","cellular response to curcumin" -"GO:1901499","response to hexane" -"GO:0021856","hypothalamic tangential migration using cell-axon interactions" -"GO:1904059","regulation of locomotor rhythm" -"GO:0046882","negative regulation of follicle-stimulating hormone secretion" -"GO:0098743","cell aggregation" -"GO:0120080","negative regulation of microfilament motor activity" -"GO:0061339","establishment or maintenance of monopolar cell polarity" -"GO:0051138","positive regulation of NK T cell differentiation" -"GO:0070107","regulation of interleukin-27-mediated signaling pathway" -"GO:0042178","xenobiotic catabolic process" -"GO:0097051","establishment of protein localization to endoplasmic reticulum membrane" -"GO:1900785","naphtho-gamma-pyrone metabolic process" -"GO:0000717","nucleotide-excision repair, DNA duplex unwinding" -"GO:0090329","regulation of DNA-dependent DNA replication" -"GO:0043390","aflatoxin B1 metabolic process" -"GO:0007117","budding cell bud growth" -"GO:0018882","(+)-camphor metabolic process" -"GO:0061772","drug transport across blood-nerve barrier" -"GO:0001777","T cell homeostatic proliferation" -"GO:1900603","tensidol A metabolic process" -"GO:0008334","histone mRNA metabolic process" -"GO:0097084","vascular smooth muscle cell development" -"GO:0034088","maintenance of mitotic sister chromatid cohesion" -"GO:1901870","ecgonone methyl ester metabolic process" -"GO:1904044","response to aldosterone" -"GO:0071550","death-inducing signaling complex assembly" -"GO:0098876","vesicle-mediated transport to the plasma membrane" -"GO:0043388","positive regulation of DNA binding" -"GO:0032276","regulation of gonadotropin secretion" -"GO:1905222","atrioventricular canal morphogenesis" -"GO:0061738","late endosomal microautophagy" -"GO:0061744","motor behavior" -"GO:0000735","removal of nonhomologous ends" -"GO:0043305","negative regulation of mast cell degranulation" -"GO:0070175","positive regulation of enamel mineralization" -"GO:0009670","triose-phosphate:phosphate antiporter activity" -"GO:1902020","negative regulation of cilium-dependent cell motility" -"GO:1904839","negative regulation of male germ-line stem cell asymmetric division" -"GO:0061031","endodermal digestive tract morphogenesis" -"GO:0071930","negative regulation of transcription involved in G1/S transition of mitotic cell cycle" -"GO:0032335","regulation of activin secretion" -"GO:1904589","regulation of protein import" -"GO:0051256","mitotic spindle midzone assembly" -"GO:0030046","parallel actin filament bundle assembly" -"GO:0086101","endothelin receptor signaling pathway involved in heart process" -"GO:0043320","natural killer cell degranulation" -"GO:0043353","enucleate erythrocyte differentiation" -"GO:1902975","mitotic DNA replication initiation" -"GO:0071622","regulation of granulocyte chemotaxis" -"GO:0048293","regulation of isotype switching to IgE isotypes" -"GO:0036072","direct ossification" -"GO:0046618","drug export" -"GO:1900810","helvolic acid metabolic process" -"GO:0018916","nitrobenzene metabolic process" -"GO:1902049","neosartoricin catabolic process" -"GO:0045829","negative regulation of isotype switching" -"GO:0002246","wound healing involved in inflammatory response" -"GO:0043497","regulation of protein heterodimerization activity" -"GO:1905335","regulation of aggrephagy" -"GO:1904832","negative regulation of removal of superoxide radicals" -"GO:0032882","regulation of chitin metabolic process" -"GO:0044872","lipoprotein localization" -"GO:1903373","positive regulation of endoplasmic reticulum tubular network organization" -"GO:0051955","regulation of amino acid transport" -"GO:0090119","vesicle-mediated cholesterol transport" -"GO:0061100","lung neuroendocrine cell differentiation" -"GO:1904106","protein localization to microvillus" -"GO:0097296","activation of cysteine-type endopeptidase activity involved in apoptotic signaling pathway" -"GO:1901257","negative regulation of macrophage colony-stimulating factor production" -"GO:2000250","negative regulation of actin cytoskeleton reorganization" -"GO:0007318","pole plasm protein localization" -"GO:1904415","regulation of xenophagy" -"GO:0015695","organic cation transport" -"GO:0033396","beta-alanine biosynthetic process via 3-ureidopropionate" -"GO:0106064","regulation of cobalamin metabolic process" -"GO:0015893","drug transport" -"GO:0071048","nuclear retention of unspliced pre-mRNA at the site of transcription" -"GO:0080188","RNA-directed DNA methylation" -"GO:2001305","xanthone-containing compound metabolic process" -"GO:0002262","myeloid cell homeostasis" -"GO:0018284","iron incorporation into protein via tetrakis-L-cysteinyl iron" -"GO:1900383","regulation of synaptic plasticity by receptor localization to synapse" -"GO:0071466","cellular response to xenobiotic stimulus" -"GO:1901030","positive regulation of mitochondrial outer membrane permeabilization involved in apoptotic signaling pathway" -"GO:0003106","negative regulation of glomerular filtration by angiotensin" -"GO:0006169","adenosine salvage" -"GO:0060165","regulation of timing of subpallium neuron differentiation" -"GO:0098927","vesicle-mediated transport between endosomal compartments" -"GO:0060858","vesicle-mediated transport involved in floral organ abscission" -"GO:0061613","glycolytic process from glycerol" -"GO:0048820","hair follicle maturation" -"GO:0048087","positive regulation of developmental pigmentation" -"GO:0016488","farnesol catabolic process" -"GO:0036305","ameloblast differentiation" -"GO:0030282","bone mineralization" -"GO:0014895","smooth muscle hypertrophy" -"GO:0021530","spinal cord oligodendrocyte cell fate specification" -"GO:0035106","operant conditioning" -"GO:0045149","acetoin metabolic process" -"GO:0046326","positive regulation of glucose import" -"GO:0032471","negative regulation of endoplasmic reticulum calcium ion concentration" -"GO:1905024","regulation of membrane repolarization during ventricular cardiac muscle cell action potential" -"GO:1904719","positive regulation of AMPA glutamate receptor clustering" -"GO:2000372","negative regulation of DNA topoisomerase (ATP-hydrolyzing) activity" -"GO:1902512","positive regulation of apoptotic DNA fragmentation" -"GO:0038145","macrophage colony-stimulating factor signaling pathway" -"GO:0060163","subpallium neuron fate commitment" -"GO:0009650","UV protection" -"GO:0071459","protein localization to chromosome, centromeric region" -"GO:0032377","regulation of intracellular lipid transport" -"GO:1902445","regulation of mitochondrial membrane permeability involved in programmed necrotic cell death" -"GO:0061103","carotid body glomus cell differentiation" -"GO:0061641","CENP-A containing chromatin organization" -"GO:0071479","cellular response to ionizing radiation" -"GO:0051550","aurone metabolic process" -"GO:1904924","negative regulation of mitophagy in response to mitochondrial depolarization" -"GO:0002650","negative regulation of tolerance induction to self antigen" -"GO:0002761","regulation of myeloid leukocyte differentiation" -"GO:0034727","piecemeal microautophagy of the nucleus" -"GO:0015820","leucine transport" -"GO:1990117","B cell receptor apoptotic signaling pathway" -"GO:0090594","inflammatory response to wounding" -"GO:0072757","cellular response to camptothecin" -"GO:0032341","aldosterone metabolic process" -"GO:0050985","peptidyl-threonine sulfation" -"GO:1904502","regulation of lipophagy" -"GO:0000733","DNA strand renaturation" -"GO:1901719","regulation of NMS complex assembly" -"GO:1903649","regulation of cytoplasmic transport" -"GO:0015898","amiloride transport" -"GO:0021750","vestibular nucleus development" -"GO:0010812","negative regulation of cell-substrate adhesion" -"GO:1900840","regulation of helvolic acid biosynthetic process" -"GO:1905417","negative regulation of amoeboid sperm motility" -"GO:0090276","regulation of peptide hormone secretion" -"GO:0052230","modulation of intracellular transport in other organism involved in symbiotic interaction" -"GO:0014063","negative regulation of serotonin secretion" -"GO:2000661","positive regulation of interleukin-1-mediated signaling pathway" -"GO:1902201","negative regulation of bacterial-type flagellum-dependent cell motility" -"GO:0019476","D-lysine catabolic process" -"GO:2000182","regulation of progesterone biosynthetic process" -"GO:1903335","regulation of vacuolar transport" -"GO:0070641","vitamin D4 metabolic process" -"GO:1904962","plastid to vacuole vesicle-mediated transport" -"GO:1900131","negative regulation of lipid binding" -"GO:0071573","shelterin complex assembly" -"GO:0098881","exocytic insertion of neurotransmitter receptor to plasma membrane" -"GO:0051170","import into nucleus" -"GO:1905555","positive regulation blood vessel branching" -"GO:0050939","regulation of early stripe melanocyte differentiation" -"GO:2001316","kojic acid metabolic process" -"GO:0051684","maintenance of Golgi location" -"GO:0014060","regulation of epinephrine secretion" -"GO:0110077","vesicle-mediated intercellular transport" -"GO:0080181","lateral root branching" -"GO:0006727","ommochrome biosynthetic process" -"GO:0006293","nucleotide-excision repair, preincision complex stabilization" -"GO:1902790","undecan-2-one metabolic process" -"GO:2000979","positive regulation of forebrain neuron differentiation" -"GO:2000444","negative regulation of toll-like receptor 21 signaling pathway" -"GO:0061102","stomach neuroendocrine cell differentiation" -"GO:0070642","vitamin D5 metabolic process" -"GO:0018146","keratan sulfate biosynthetic process" -"GO:1905221","positive regulation of platelet formation" -"GO:0110097","regulation of calcium import into the mitochondrion" -"GO:0002457","T cell antigen processing and presentation" -"GO:0032338","regulation of inhibin secretion" -"GO:0045394","negative regulation of interleukin-22 biosynthetic process" -"GO:0072653","interferon-omega production" -"GO:0042181","ketone biosynthetic process" -"GO:0033524","sinapate ester metabolic process" -"GO:0042633","hair cycle" -"GO:0045124","regulation of bone resorption" -"GO:0071259","cellular response to magnetism" -"GO:0045217","cell-cell junction maintenance" -"GO:0070906","aspartate:alanine antiporter activity" -"GO:0009861","jasmonic acid and ethylene-dependent systemic resistance" -"GO:0099003","vesicle-mediated transport in synapse" -"GO:0018245","protein O-linked glycosylation via tyrosine" -"GO:0015886","heme transport" -"GO:0036334","epidermal stem cell homeostasis" -"GO:0019538","protein metabolic process" -"GO:0016198","axon choice point recognition" -"GO:0042353","fucose biosynthetic process" -"GO:1905157","positive regulation of photosynthesis" -"GO:0061886","negative regulation of mini excitatory postsynaptic potential" -"GO:1902537","multi-organism pinocytosis" -"GO:0032287","peripheral nervous system myelin maintenance" -"GO:0042984","regulation of amyloid precursor protein biosynthetic process" -"GO:1904503","negative regulation of lipophagy" -"GO:1901782","p-cumate catabolic process" -"GO:0072523","purine-containing compound catabolic process" -"GO:1905455","positive regulation of myeloid progenitor cell differentiation" -"GO:0071787","endoplasmic reticulum tubular network formation" -"GO:0098581","detection of external biotic stimulus" -"GO:0018954","pentaerythritol tetranitrate metabolic process" -"GO:1903020","positive regulation of glycoprotein metabolic process" -"GO:1900598","demethylkotanin catabolic process" -"GO:0100011","positive regulation of fever generation by prostaglandin secretion" -"GO:0038135","ERBB2-ERBB4 signaling pathway" -"GO:0042358","thiamine diphosphate catabolic process" -"GO:2001057","reactive nitrogen species metabolic process" -"GO:0045719","negative regulation of glycogen biosynthetic process" -"GO:0071962","mitotic sister chromatid cohesion, centromeric" -"GO:0075509","endocytosis involved in viral entry into host cell" -"GO:0019596","mandelate catabolic process" -"GO:0018992","germ-line sex determination" -"GO:0032346","positive regulation of aldosterone metabolic process" -"GO:0007553","regulation of ecdysteroid metabolic process" -"GO:0051892","negative regulation of cardioblast differentiation" -"GO:0002561","basophil degranulation" -"GO:0061196","fungiform papilla development" -"GO:1904843","cellular response to nitroglycerin" -"GO:1903038","negative regulation of leukocyte cell-cell adhesion" -"GO:0031587","positive regulation of inositol 1,4,5-trisphosphate-sensitive calcium-release channel activity" -"GO:1902180","verruculogen catabolic process" -"GO:0140074","cardiac endothelial to mesenchymal transition" -"GO:2001153","positive regulation of renal water transport" -"GO:1902778","response to alkane" -"GO:0046451","diaminopimelate metabolic process" -"GO:0045624","positive regulation of T-helper cell differentiation" -"GO:1901875","positive regulation of post-translational protein modification" -"GO:0061884","regulation of mini excitatory postsynaptic potential" -"GO:0006526","arginine biosynthetic process" -"GO:1904378","maintenance of unfolded protein involved in ERAD pathway" -"GO:1904899","positive regulation of hepatic stellate cell proliferation" -"GO:2000261","negative regulation of blood coagulation, common pathway" -"GO:0001712","ectodermal cell fate commitment" -"GO:0042725","thiamine-containing compound catabolic process" -"GO:1900485","positive regulation of protein targeting to vacuolar membrane" -"GO:0090700","maintenance of plant organ identity" -"GO:0045869","negative regulation of single stranded viral RNA replication via double stranded DNA intermediate" -"GO:0097694","establishment of RNA localization to telomere" -"GO:2001002","positive regulation of xylan catabolic process" -"GO:1905640","response to acetaldehyde" -"GO:1903593","regulation of histamine secretion by mast cell" -"GO:0046271","phenylpropanoid catabolic process" -"GO:0050914","sensory perception of salty taste" -"GO:1901858","regulation of mitochondrial DNA metabolic process" -"GO:1904287","positive regulation of protein-pyridoxal-5-phosphate linkage" -"GO:0039637","catabolism by virus of host DNA" -"GO:1904253","positive regulation of bile acid metabolic process" -"GO:0051926","negative regulation of calcium ion transport" -"GO:1904603","regulation of advanced glycation end-product receptor activity" -"GO:1904293","negative regulation of ERAD pathway" -"GO:1900996","benzene catabolic process" -"GO:0006065","UDP-glucuronate biosynthetic process" -"GO:1904237","positive regulation of substrate-dependent cell migration, cell attachment to substrate" -"GO:0043043","peptide biosynthetic process" -"GO:0150007","clathrin-dependent synaptic vesicle endocytosis" -"GO:0008335","female germline ring canal stabilization" -"GO:0071292","cellular response to silver ion" -"GO:1905458","positive regulation of lymphoid progenitor cell differentiation" -"GO:0010829","negative regulation of glucose transmembrane transport" -"GO:0006209","cytosine catabolic process" -"GO:1903348","positive regulation of bicellular tight junction assembly" -"GO:0086043","bundle of His cell action potential" -"GO:0042355","L-fucose catabolic process" -"GO:0035161","imaginal disc lineage restriction" -"GO:0001941","postsynaptic membrane organization" -"GO:0097178","ruffle assembly" -"GO:1900820","orlandin catabolic process" -"GO:0002854","positive regulation of T cell mediated cytotoxicity directed against tumor cell target" -"GO:0070997","neuron death" -"GO:0044837","actomyosin contractile ring organization" -"GO:0005979","regulation of glycogen biosynthetic process" -"GO:1900955","positive regulation of 18-methylnonadec-1-ene metabolic process" -"GO:0042403","thyroid hormone metabolic process" -"GO:0072078","nephron tubule morphogenesis" -"GO:1901848","nicotinate catabolic process" -"GO:0009966","regulation of signal transduction" -"GO:0042354","L-fucose metabolic process" -"GO:0071772","response to BMP" -"GO:0046153","ommochrome catabolic process" -"GO:0019317","fucose catabolic process" -"GO:0051497","negative regulation of stress fiber assembly" -"GO:1903894","regulation of IRE1-mediated unfolded protein response" -"GO:0002368","B cell cytokine production" -"GO:1901309","negative regulation of sterol regulatory element binding protein cleavage" -"GO:0060847","endothelial cell fate specification" -"GO:2000466","negative regulation of glycogen (starch) synthase activity" -"GO:2000558","positive regulation of immunoglobulin production in mucosal tissue" -"GO:0042436","indole-containing compound catabolic process" -"GO:0036261","7-methylguanosine cap hypermethylation" -"GO:0060679","trifid subdivision of terminal units involved in ureteric bud branching" -"GO:0039519","modulation by virus of host autophagy" -"GO:0019261","1,4-dichlorobenzene catabolic process" -"GO:0035305","negative regulation of dephosphorylation" -"GO:0046221","pyridine catabolic process" -"GO:0070593","dendrite self-avoidance" -"GO:0007443","Malpighian tubule morphogenesis" -"GO:0071274","isoquinoline alkaloid catabolic process" -"GO:0008039","synaptic target recognition" -"GO:0002848","positive regulation of T cell tolerance induction to tumor cell" -"GO:0048900","anterior lateral line neuromast primordium migration" -"GO:0002327","immature B cell differentiation" -"GO:0036265","RNA (guanine-N7)-methylation" -"GO:1900139","negative regulation of arachidonic acid secretion" -"GO:1990387","isogloboside biosynthetic process" -"GO:0120076","negative regulation of endocardial cushion cell differentiation" -"GO:0032307","negative regulation of prostaglandin secretion" -"GO:1901770","daunorubicin catabolic process" -"GO:0034094","regulation of maintenance of meiotic sister chromatid cohesion" -"GO:0046167","glycerol-3-phosphate biosynthetic process" -"GO:0046302","2-chloro-N-isopropylacetanilide catabolic process" -"GO:0010335","response to non-ionic osmotic stress" -"GO:0039532","negative regulation of viral-induced cytoplasmic pattern recognition receptor signaling pathway" -"GO:1904327","protein localization to cytosolic proteasome complex" -"GO:0120133","negative regulation of actin cortical patch assembly" -"GO:1900336","regulation of methane biosynthetic process from carbon monoxide" -"GO:0035239","tube morphogenesis" -"GO:0046232","carbazole catabolic process" -"GO:0006543","glutamine catabolic process" -"GO:0006924","activation-induced cell death of T cells" -"GO:0046455","organosilicon catabolic process" -"GO:0045493","xylan catabolic process" -"GO:0048671","negative regulation of collateral sprouting" -"GO:1904580","regulation of intracellular mRNA localization" -"GO:0046310","1,3-dichloro-2-propanol catabolic process" -"GO:0000737","DNA catabolic process, endonucleolytic" -"GO:0052312","modulation of transcription in other organism involved in symbiotic interaction" -"GO:0042898","fosmidomycin transmembrane transporter activity" -"GO:0043171","peptide catabolic process" -"GO:0052786","alpha-linked polysaccharide catabolism to maltotriose" -"GO:1900993","(-)-secologanin catabolic process" -"GO:1902218","regulation of intrinsic apoptotic signaling pathway in response to osmotic stress" -"GO:0042404","thyroid hormone catabolic process" -"GO:0010623","programmed cell death involved in cell development" -"GO:0044533","positive regulation of apoptotic process in other organism" -"GO:1902434","sulfate import across plasma membrane" -"GO:0000481","maturation of 5S rRNA" -"GO:0019487","anaerobic acetylene catabolic process" -"GO:0035306","positive regulation of dephosphorylation" -"GO:0061003","positive regulation of dendritic spine morphogenesis" -"GO:0046125","pyrimidine deoxyribonucleoside metabolic process" -"GO:2000241","regulation of reproductive process" -"GO:0034241","positive regulation of macrophage fusion" -"GO:0034374","low-density lipoprotein particle remodeling" -"GO:0035817","renal sodium ion absorption involved in negative regulation of renal sodium excretion" -"GO:0019384","caprolactam catabolic process" -"GO:0006259","DNA metabolic process" -"GO:0034250","positive regulation of cellular amide metabolic process" -"GO:1903782","regulation of sodium ion import across plasma membrane" -"GO:0043306","positive regulation of mast cell degranulation" -"GO:0010634","positive regulation of epithelial cell migration" -"GO:0042184","xylene catabolic process" -"GO:1900005","positive regulation of serine-type endopeptidase activity" -"GO:0043445","acetone biosynthetic process" -"GO:0010933","positive regulation of macrophage tolerance induction" -"GO:0018402","protein-chondroitin sulfate linkage via chondroitin sulfate D-glucuronyl-D-galactosyl-D-galactosyl-D-xylosyl-L-serine" -"GO:0034126","positive regulation of MyD88-dependent toll-like receptor signaling pathway" -"GO:0050910","detection of mechanical stimulus involved in sensory perception of sound" -"GO:1905833","negative regulation of microtubule nucleation" -"GO:0033509","glutamate catabolic process to propionate" -"GO:0046964","3'-phosphoadenosine 5'-phosphosulfate transmembrane transporter activity" -"GO:0016261","selenocysteine catabolic process" -"GO:0106028","neuron projection retraction" -"GO:0021973","corticospinal neuron axon decussation" -"GO:0032244","positive regulation of nucleoside transport" -"GO:0005368","taurine transmembrane transporter activity" -"GO:1901508","positive regulation of acylglycerol transport" -"GO:0090293","nitrogen catabolite regulation of transcription" -"GO:0045106","intermediate filament depolymerization" -"GO:1902557","5'-adenylyl sulfate transmembrane transporter activity" -"GO:0030070","insulin processing" -"GO:1905654","regulation of artery smooth muscle contraction" -"GO:1900912","negative regulation of olefin biosynthetic process" -"GO:0003250","regulation of cell proliferation involved in heart valve morphogenesis" -"GO:1904277","negative regulation of wax biosynthetic process" -"GO:0006539","glutamate catabolic process via 2-oxoglutarate" -"GO:0008407","chaeta morphogenesis" -"GO:2000258","negative regulation of protein activation cascade" -"GO:0009643","photosynthetic acclimation" -"GO:1903423","positive regulation of synaptic vesicle recycling" -"GO:0061316","canonical Wnt signaling pathway involved in heart development" -"GO:0097213","regulation of lysosomal membrane permeability" -"GO:0002721","regulation of B cell cytokine production" -"GO:0000053","argininosuccinate metabolic process" -"GO:0021503","neural fold bending" -"GO:0030325","adrenal gland development" -"GO:1903466","regulation of mitotic DNA replication initiation" -"GO:0098957","anterograde axonal transport of mitochondrion" -"GO:0046325","negative regulation of glucose import" -"GO:0034157","positive regulation of toll-like receptor 7 signaling pathway" -"GO:0031062","positive regulation of histone methylation" -"GO:0051389","inactivation of MAPKK activity" -"GO:0032900","negative regulation of neurotrophin production" -"GO:0032233","positive regulation of actin filament bundle assembly" -"GO:0003152","morphogenesis of an epithelial fold involved in embryonic heart tube formation" -"GO:0045973","positive regulation of juvenile hormone secretion" -"GO:0009692","ethylene metabolic process" -"GO:0019542","propionate biosynthetic process" -"GO:2000445","positive regulation of toll-like receptor 21 signaling pathway" -"GO:0098742","cell-cell adhesion via plasma-membrane adhesion molecules" -"GO:0072601","interleukin-3 secretion" -"GO:0086052","membrane repolarization during SA node cell action potential" -"GO:0080153","negative regulation of reductive pentose-phosphate cycle" -"GO:0005462","UDP-N-acetylglucosamine transmembrane transporter activity" -"GO:1905167","positive regulation of lysosomal protein catabolic process" -"GO:2000197","regulation of ribonucleoprotein complex localization" -"GO:1900045","negative regulation of protein K63-linked ubiquitination" -"GO:0032912","negative regulation of transforming growth factor beta2 production" -"GO:0034133","positive regulation of toll-like receptor 1 signaling pathway" -"GO:0061223","mesonephric mesenchymal cell differentiation" -"GO:1904889","regulation of excitatory synapse assembly" -"GO:0016546","male courtship behavior, proboscis-mediated licking" -"GO:0035153","epithelial cell type specification, open tracheal system" -"GO:1902910","positive regulation of melanosome transport" -"GO:0061156","pulmonary artery morphogenesis" -"GO:0038034","signal transduction in absence of ligand" -"GO:1905349","ciliary transition zone assembly" -"GO:0031076","embryonic camera-type eye development" -"GO:1905505","positive regulation of motile cilium assembly" -"GO:0008056","ocellus development" -"GO:0001814","negative regulation of antibody-dependent cellular cytotoxicity" -"GO:0016573","histone acetylation" -"GO:0060512","prostate gland morphogenesis" -"GO:1903765","negative regulation of potassium ion export across plasma membrane" -"GO:0035499","carnosine biosynthetic process" -"GO:0019089","transmission of virus" -"GO:0006437","tyrosyl-tRNA aminoacylation" -"GO:0009870","defense response signaling pathway, resistance gene-dependent" -"GO:1900132","positive regulation of lipid binding" -"GO:0006748","lipoamide metabolic process" -"GO:0045827","negative regulation of isoprenoid metabolic process" -"GO:0045576","mast cell activation" -"GO:0051311","meiotic metaphase plate congression" -"GO:0036197","zymosterol biosynthetic process" -"GO:2000170","positive regulation of peptidyl-cysteine S-nitrosylation" -"GO:0061365","positive regulation of triglyceride lipase activity" -"GO:0060830","ciliary receptor clustering involved in smoothened signaling pathway" -"GO:0070121","Kupffer's vesicle development" -"GO:0009738","abscisic acid-activated signaling pathway" -"GO:0085033","positive regulation by symbiont of host I-kappaB kinase/NF-kappaB cascade" -"GO:0061930","regulation of erythrocyte enucleation" -"GO:0046713","borate transport" -"GO:0046450","dethiobiotin metabolic process" -"GO:0038170","somatostatin signaling pathway" -"GO:0036351","histone H2A-K13 ubiquitination" -"GO:0010001","glial cell differentiation" -"GO:0018221","peptidyl-serine palmitoylation" -"GO:0003016","respiratory system process" -"GO:0042471","ear morphogenesis" -"GO:0019495","proline catabolic process to 2-oxoglutarate" -"GO:1901129","gentamycin catabolic process" -"GO:0018868","2-aminobenzenesulfonate metabolic process" -"GO:1901772","lincomycin metabolic process" -"GO:1904588","cellular response to glycoprotein" -"GO:0002436","immune complex clearance by monocytes and macrophages" -"GO:0043318","negative regulation of cytotoxic T cell degranulation" -"GO:0099159","regulation of modification of postsynaptic structure" -"GO:1904721","negative regulation of mRNA endonucleolytic cleavage involved in unfolded protein response" -"GO:0042820","vitamin B6 catabolic process" -"GO:1905898","positive regulation of response to endoplasmic reticulum stress" -"GO:1990167","protein K27-linked deubiquitination" -"GO:1901776","mitomycin C catabolic process" -"GO:2000689","actomyosin contractile ring assembly actin filament organization" -"GO:1901814","astaxanthin catabolic process" -"GO:1905497","negative regulation of triplex DNA binding" -"GO:0006784","heme a biosynthetic process" -"GO:0061804","mitotic spindle elongation during mitotic prophase" -"GO:0030862","positive regulation of polarized epithelial cell differentiation" -"GO:0048612","post-embryonic ectodermal digestive tract development" -"GO:0009733","response to auxin" -"GO:0008406","gonad development" -"GO:0035844","cloaca development" -"GO:0045407","positive regulation of interleukin-5 biosynthetic process" -"GO:0035483","gastric emptying" -"GO:1904443","positive regulation of thyroid gland epithelial cell proliferation" -"GO:0060284","regulation of cell development" -"GO:0017085","response to insecticide" -"GO:0065001","specification of axis polarity" -"GO:0019510","S-adenosylhomocysteine catabolic process" -"GO:1904036","negative regulation of epithelial cell apoptotic process" -"GO:1904314","cellular response to methamphetamine hydrochloride" -"GO:0060683","regulation of branching involved in salivary gland morphogenesis by epithelial-mesenchymal signaling" -"GO:1905578","regulation of ERBB3 signaling pathway" -"GO:0055123","digestive system development" -"GO:1904141","positive regulation of microglial cell migration" -"GO:1900564","chanoclavine-I metabolic process" -"GO:0002195","2-methylthio-N-6-(cis-hydroxy)isopentenyl adenosine-tRNA biosynthesis" -"GO:2000521","negative regulation of immunological synapse formation" -"GO:0042044","fluid transport" -"GO:0002439","chronic inflammatory response to antigenic stimulus" -"GO:0032764","negative regulation of mast cell cytokine production" -"GO:0010457","centriole-centriole cohesion" -"GO:1900829","D-tyrosine catabolic process" -"GO:0035304","regulation of protein dephosphorylation" -"GO:0001738","morphogenesis of a polarized epithelium" -"GO:0034643","establishment of mitochondrion localization, microtubule-mediated" -"GO:0060335","positive regulation of interferon-gamma-mediated signaling pathway" -"GO:2000120","positive regulation of sodium-dependent phosphate transport" -"GO:0002313","mature B cell differentiation involved in immune response" -"GO:0071319","cellular response to benzoic acid" -"GO:0070486","leukocyte aggregation" -"GO:0048769","sarcomerogenesis" -"GO:0039666","virion attachment to host cell pilus" -"GO:0045428","regulation of nitric oxide biosynthetic process" -"GO:0060731","positive regulation of intestinal epithelial structure maintenance" -"GO:0001893","maternal placenta development" -"GO:0075045","regulation of formation by symbiont of haustorium for nutrient acquisition from host" -"GO:1901684","arsenate ion transmembrane transport" -"GO:1902514","regulation of calcium ion transmembrane transport via high voltage-gated calcium channel" -"GO:0035105","sterol regulatory element binding protein import into nucleus" -"GO:0031665","negative regulation of lipopolysaccharide-mediated signaling pathway" -"GO:0097716","copper ion transport across blood-brain barrier" -"GO:0075329","regulation of arbuscule formation for nutrient acquisition from host" -"GO:1903928","cellular response to cyanide" -"GO:2001158","positive regulation of proline catabolic process to glutamate" -"GO:0009873","ethylene-activated signaling pathway" -"GO:0042399","ectoine metabolic process" -"GO:0036018","cellular response to erythropoietin" -"GO:0098740","multi organism cell adhesion" -"GO:2000813","negative regulation of barbed-end actin filament capping" -"GO:2000699","fibroblast growth factor receptor signaling pathway involved in ureteric bud formation" -"GO:0072365","regulation of cellular ketone metabolic process by negative regulation of transcription from RNA polymerase II promoter" -"GO:0061055","myotome development" -"GO:1905229","cellular response to thyrotropin-releasing hormone" -"GO:0002759","regulation of antimicrobial humoral response" -"GO:0019860","uracil metabolic process" -"GO:0007504","larval fat body development" -"GO:0019558","histidine catabolic process to 2-oxoglutarate" -"GO:1903998","regulation of eating behavior" -"GO:2000538","positive regulation of B cell chemotaxis" -"GO:1902950","regulation of dendritic spine maintenance" -"GO:0002686","negative regulation of leukocyte migration" -"GO:0035721","intraciliary retrograde transport" -"GO:1904873","negative regulation of telomerase RNA localization to Cajal body" -"GO:0007113","endomitotic cell cycle" -"GO:0008302","female germline ring canal formation, actin assembly" -"GO:1905579","negative regulation of ERBB3 signaling pathway" -"GO:1905920","positive regulation of CoA-transferase activity" -"GO:0070689","L-threonine catabolic process to propionate" -"GO:0046501","protoporphyrinogen IX metabolic process" -"GO:0071691","cardiac muscle thin filament assembly" -"GO:1904064","positive regulation of cation transmembrane transport" -"GO:0090241","negative regulation of histone H4 acetylation" -"GO:0006715","farnesol biosynthetic process" -"GO:0060831","smoothened signaling pathway involved in dorsal/ventral neural tube patterning" -"GO:0048034","heme O biosynthetic process" -"GO:0048599","oocyte development" -"GO:0051597","response to methylmercury" -"GO:1904890","negative regulation of excitatory synapse assembly" -"GO:0086018","SA node cell to atrial cardiac muscle cell signaling" -"GO:1902724","positive regulation of skeletal muscle satellite cell proliferation" -"GO:0043067","regulation of programmed cell death" -"GO:1905219","regulation of platelet formation" -"GO:0061034","olfactory bulb mitral cell layer development" -"GO:0045793","positive regulation of cell size" -"GO:0002223","stimulatory C-type lectin receptor signaling pathway" -"GO:0008608","attachment of spindle microtubules to kinetochore" -"GO:0031023","microtubule organizing center organization" -"GO:0033599","regulation of mammary gland epithelial cell proliferation" -"GO:0010972","negative regulation of G2/M transition of mitotic cell cycle" -"GO:0071960","maintenance of mitotic sister chromatid cohesion, centromeric" -"GO:1905090","negative regulation of parkin-mediated stimulation of mitophagy in response to mitochondrial depolarization" -"GO:0070141","response to UV-A" -"GO:0001578","microtubule bundle formation" -"GO:0090678","cell dedifferentiation involved in phenotypic switching" -"GO:0042270","protection from natural killer cell mediated cytotoxicity" -"GO:2000119","negative regulation of sodium-dependent phosphate transport" -"GO:1901702","salt transmembrane transporter activity" -"GO:0016267","O-glycan processing, core 1" -"GO:0070108","negative regulation of interleukin-27-mediated signaling pathway" -"GO:1904294","positive regulation of ERAD pathway" -"GO:2001249","negative regulation of ammonia assimilation cycle" -"GO:0016132","brassinosteroid biosynthetic process" -"GO:0072720","response to dithiothreitol" -"GO:0033355","ascorbate glutathione cycle" -"GO:0055092","sterol homeostasis" -"GO:0002075","somitomeric trunk muscle development" -"GO:0016579","protein deubiquitination" -"GO:1902215","negative regulation of interleukin-4-mediated signaling pathway" -"GO:0002732","positive regulation of dendritic cell cytokine production" -"GO:1902661","positive regulation of glucose mediated signaling pathway" -"GO:0043666","regulation of phosphoprotein phosphatase activity" -"GO:0006895","Golgi to endosome transport" -"GO:0022853","active ion transmembrane transporter activity" -"GO:0003043","vasoconstriction of artery involved in aortic body chemoreceptor response to lowering of systemic arterial blood pressure" -"GO:1990418","response to insulin-like growth factor stimulus" -"GO:1902533","positive regulation of intracellular signal transduction" -"GO:0086016","AV node cell action potential" -"GO:0039694","viral RNA genome replication" -"GO:0003411","cell motility involved in camera-type eye morphogenesis" -"GO:0007094","mitotic spindle assembly checkpoint" -"GO:1905861","intranuclear rod assembly" -"GO:1903653","modulation by symbiont of host cell motility" -"GO:0008509","anion transmembrane transporter activity" -"GO:0033594","response to hydroxyisoflavone" -"GO:0071971","extracellular exosome assembly" -"GO:0045053","protein retention in Golgi apparatus" -"GO:0038095","Fc-epsilon receptor signaling pathway" -"GO:1900745","positive regulation of p38MAPK cascade" -"GO:0140027","establishment of contractile vacuole localization" -"GO:0015083","aluminum ion transmembrane transporter activity" -"GO:0070759","negative regulation of interleukin-35-mediated signaling pathway" -"GO:0106007","microtubule anchoring at cell cortex of cell tip" -"GO:1901185","negative regulation of ERBB signaling pathway" -"GO:0015301","anion:anion antiporter activity" -"GO:0007508","larval heart development" -"GO:1903306","negative regulation of regulated secretory pathway" -"GO:0072093","metanephric renal vesicle formation" -"GO:1903489","positive regulation of lactation" -"GO:0071593","lymphocyte aggregation" -"GO:0031670","cellular response to nutrient" -"GO:1990830","cellular response to leukemia inhibitory factor" -"GO:0015094","lead ion transmembrane transporter activity" -"GO:1903882","negative regulation of interleukin-17-mediated signaling pathway" -"GO:0007486","imaginal disc-derived female genitalia development" -"GO:0060504","positive regulation of epithelial cell proliferation involved in lung bud dilation" -"GO:0016031","tRNA import into mitochondrion" -"GO:0006990","positive regulation of transcription from RNA polymerase II promoter involved in unfolded protein response" -"GO:0032466","negative regulation of cytokinesis" -"GO:0046890","regulation of lipid biosynthetic process" -"GO:0070835","chromium ion transmembrane transporter activity" -"GO:0043063","intercellular bridge organization" -"GO:0021906","hindbrain-spinal cord boundary formation" -"GO:0006289","nucleotide-excision repair" -"GO:0110054","regulation of actin filament annealing" -"GO:0070076","histone lysine demethylation" -"GO:1902021","regulation of bacterial-type flagellum-dependent cell motility" -"GO:0034626","fatty acid elongation, polyunsaturated fatty acid" -"GO:0036113","very long-chain fatty-acyl-CoA catabolic process" -"GO:0045225","negative regulation of CD4 biosynthetic process" -"GO:0035694","mitochondrial protein catabolic process" -"GO:1903565","negative regulation of protein localization to cilium" -"GO:1902019","regulation of cilium-dependent cell motility" -"GO:0008514","organic anion transmembrane transporter activity" -"GO:1902900","gut granule assembly" -"GO:0021814","cell motility involved in cerebral cortex radial glia guided migration" -"GO:1900100","positive regulation of plasma cell differentiation" -"GO:0002367","cytokine production involved in immune response" -"GO:0008324","cation transmembrane transporter activity" -"GO:1901399","negative regulation of transforming growth factor beta3 activation" -"GO:2000493","negative regulation of interleukin-18-mediated signaling pathway" -"GO:0046328","regulation of JNK cascade" -"GO:0005216","ion channel activity" -"GO:0090266","regulation of mitotic cell cycle spindle assembly checkpoint" -"GO:0007527","adult somatic muscle development" -"GO:0106077","histone succinylation" -"GO:0021695","cerebellar cortex development" -"GO:1902212","negative regulation of prolactin signaling pathway" -"GO:0046600","negative regulation of centriole replication" -"GO:0060071","Wnt signaling pathway, planar cell polarity pathway" -"GO:0032696","negative regulation of interleukin-13 production" -"GO:1904379","protein localization to cytosolic proteasome complex involved in ERAD pathway" -"GO:0015103","inorganic anion transmembrane transporter activity" -"GO:0060525","prostate glandular acinus development" -"GO:0043444","acetone catabolic process" -"GO:0035356","cellular triglyceride homeostasis" -"GO:0031116","positive regulation of microtubule polymerization" -"GO:0046323","glucose import" -"GO:0070104","negative regulation of interleukin-6-mediated signaling pathway" -"GO:0070143","mitochondrial alanyl-tRNA aminoacylation" -"GO:1902394","positive regulation of exodeoxyribonuclease activity" -"GO:0042743","hydrogen peroxide metabolic process" -"GO:0086027","AV node cell to bundle of His cell signaling" -"GO:2000544","regulation of endothelial cell chemotaxis to fibroblast growth factor" -"GO:1901317","regulation of flagellated sperm motility" -"GO:0045476","nurse cell apoptotic process" -"GO:0033299","secretion of lysosomal enzymes" -"GO:0010765","positive regulation of sodium ion transport" -"GO:0009410","response to xenobiotic stimulus" -"GO:0006750","glutathione biosynthetic process" -"GO:0022028","tangential migration from the subventricular zone to the olfactory bulb" -"GO:0071809","regulation of fever generation by regulation of prostaglandin biosynthesis" -"GO:1901411","negative regulation of tetrapyrrole biosynthetic process from glutamate" -"GO:0030829","regulation of cGMP catabolic process" -"GO:0071976","cell gliding" -"GO:0098702","adenine import across plasma membrane" -"GO:0010045","response to nickel cation" -"GO:2000524","negative regulation of T cell costimulation" -"GO:0043006","activation of phospholipase A2 activity by calcium-mediated signaling" -"GO:2000447","negative regulation of macrophage migration inhibitory factor signaling pathway" -"GO:0006623","protein targeting to vacuole" -"GO:0010499","proteasomal ubiquitin-independent protein catabolic process" -"GO:0036498","IRE1-mediated unfolded protein response" -"GO:0070391","response to lipoteichoic acid" -"GO:1901683","arsenate ion transmembrane transporter activity" -"GO:0051186","cofactor metabolic process" -"GO:0051306","mitotic sister chromatid separation" -"GO:0061418","regulation of transcription from RNA polymerase II promoter in response to hypoxia" -"GO:0071239","cellular response to streptomycin" -"GO:1905046","positive regulation of Schwann cell proliferation involved in axon regeneration" -"GO:0036244","cellular response to neutral pH" -"GO:0099516","ion antiporter activity" -"GO:0097079","selenite:proton symporter activity" -"GO:0038061","NIK/NF-kappaB signaling" -"GO:0007033","vacuole organization" -"GO:0043107","type IV pilus-dependent motility" -"GO:0006734","NADH metabolic process" -"GO:0046645","positive regulation of gamma-delta T cell activation" -"GO:1902206","negative regulation of interleukin-2-mediated signaling pathway" -"GO:1905134","positive regulation of meiotic chromosome separation" -"GO:0072762","cellular response to carbendazim" -"GO:0040025","vulval development" -"GO:0006151","xanthine oxidation" -"GO:0039693","viral DNA genome replication" -"GO:0045856","positive regulation of pole plasm oskar mRNA localization" -"GO:0045104","intermediate filament cytoskeleton organization" -"GO:0051205","protein insertion into membrane" -"GO:0090263","positive regulation of canonical Wnt signaling pathway" -"GO:0043488","regulation of mRNA stability" -"GO:0071030","nuclear mRNA surveillance of spliceosomal pre-mRNA splicing" -"GO:0071469","cellular response to alkaline pH" -"GO:1902227","negative regulation of macrophage colony-stimulating factor signaling pathway" -"GO:1900235","negative regulation of Kit signaling pathway" -"GO:0097499","protein localization to non-motile cilium" -"GO:1903378","positive regulation of oxidative stress-induced neuron intrinsic apoptotic signaling pathway" -"GO:0015803","branched-chain amino acid transport" -"GO:1903549","positive regulation of growth hormone activity" -"GO:0048625","myoblast fate commitment" -"GO:0046850","regulation of bone remodeling" -"GO:0043553","negative regulation of phosphatidylinositol 3-kinase activity" -"GO:1903258","sorbose import across plasma membrane" -"GO:0021917","somatic motor neuron fate commitment" -"GO:0097385","programmed necrotic cell death in response to starvation" -"GO:1902940","positive regulation of intracellular calcium activated chloride channel activity" -"GO:1904736","negative regulation of fatty acid beta-oxidation using acyl-CoA dehydrogenase" -"GO:0021807","motogenic signaling initiating cell movement in cerebral cortex" -"GO:0048539","bone marrow development" -"GO:0006043","glucosamine catabolic process" -"GO:0002765","immune response-inhibiting signal transduction" -"GO:0006534","cysteine metabolic process" -"GO:0061525","hindgut development" -"GO:0045401","positive regulation of interleukin-3 biosynthetic process" -"GO:0033007","negative regulation of mast cell activation involved in immune response" -"GO:0061232","mesonephric glomerular epithelium development" -"GO:0015874","norepinephrine transport" -"GO:0036166","phenotypic switching" -"GO:1901123","bacitracin A catabolic process" -"GO:0018442","peptidyl-glutamic acid esterification" -"GO:1900229","negative regulation of single-species biofilm formation in or on host organism" -"GO:2000433","positive regulation of cytokinesis, actomyosin contractile ring assembly" -"GO:0030652","peptide antibiotic catabolic process" -"GO:0044258","intestinal lipid catabolic process" -"GO:0033216","ferric iron import" -"GO:1900408","negative regulation of cellular response to oxidative stress" -"GO:0043129","surfactant homeostasis" -"GO:0002074","extraocular skeletal muscle development" -"GO:0070898","RNA polymerase III transcriptional preinitiation complex assembly" -"GO:1900267","positive regulation of substance P receptor binding" -"GO:0042415","norepinephrine metabolic process" -"GO:0045828","positive regulation of isoprenoid metabolic process" -"GO:0018351","peptidyl-cysteine esterification" -"GO:0019370","leukotriene biosynthetic process" -"GO:2000552","negative regulation of T-helper 2 cell cytokine production" -"GO:1902140","response to inositol" -"GO:0000409","regulation of transcription by galactose" -"GO:0061325","cell proliferation involved in outflow tract morphogenesis" -"GO:0015758","glucose transport" -"GO:0048783","positive regulation of cyanophore differentiation" -"GO:0051797","regulation of hair follicle development" -"GO:0051409","response to nitrosative stress" -"GO:0010866","regulation of triglyceride biosynthetic process" -"GO:0021710","cerebellar stellate cell differentiation" -"GO:2000246","positive regulation of FtsZ-dependent cytokinesis" -"GO:2000490","negative regulation of hepatic stellate cell activation" -"GO:0003171","atrioventricular valve development" -"GO:0060625","regulation of protein deneddylation" -"GO:0003251","positive regulation of cell proliferation involved in heart valve morphogenesis" -"GO:0055009","atrial cardiac muscle tissue morphogenesis" -"GO:0100002","negative regulation of protein kinase activity by protein phosphorylation" -"GO:0009050","glycopeptide catabolic process" -"GO:0051031","tRNA transport" -"GO:0060301","positive regulation of cytokine activity" -"GO:0019931","protein-chromophore linkage via peptidyl-N6-3-dehydroretinal-L-lysine" -"GO:0006811","ion transport" -"GO:0061072","iris morphogenesis" -"GO:0035426","extracellular matrix-cell signaling" -"GO:0045005","DNA-dependent DNA replication maintenance of fidelity" -"GO:0042118","endothelial cell activation" -"GO:2000078","positive regulation of type B pancreatic cell development" -"GO:1901749","leukotriene D4 catabolic process" -"GO:0036116","long-chain fatty-acyl-CoA catabolic process" -"GO:0043974","histone H3-K27 acetylation" -"GO:0050880","regulation of blood vessel size" -"GO:0003009","skeletal muscle contraction" -"GO:0051098","regulation of binding" -"GO:0002228","natural killer cell mediated immunity" -"GO:1905783","CENP-A containing nucleosome disassembly" -"GO:0043971","histone H3-K18 acetylation" -"GO:0070102","interleukin-6-mediated signaling pathway" -"GO:0060033","anatomical structure regression" -"GO:0086051","membrane repolarization during Purkinje myocyte action potential" -"GO:1903233","regulation of calcium ion-dependent exocytosis of neurotransmitter" -"GO:0007543","sex determination, somatic-gonadal interaction" -"GO:1905845","positive regulation of cellular response to gamma radiation" -"GO:1902202","regulation of hepatocyte growth factor receptor signaling pathway" -"GO:2000839","positive regulation of androstenedione secretion" -"GO:0061013","regulation of mRNA catabolic process" -"GO:0060372","regulation of atrial cardiac muscle cell membrane repolarization" -"GO:0060258","negative regulation of filamentous growth" -"GO:2001162","positive regulation of histone H3-K79 methylation" -"GO:0006655","phosphatidylglycerol biosynthetic process" -"GO:0042492","gamma-delta T cell differentiation" -"GO:1901893","positive regulation of cell septum assembly" -"GO:0075056","negative regulation of symbiont penetration peg formation for entry into host" -"GO:0060042","retina morphogenesis in camera-type eye" -"GO:0046678","response to bacteriocin" -"GO:0086065","cell communication involved in cardiac conduction" -"GO:0019287","isopentenyl diphosphate biosynthetic process, mevalonate pathway" -"GO:0003010","voluntary skeletal muscle contraction" -"GO:0033141","positive regulation of peptidyl-serine phosphorylation of STAT protein" -"GO:0072560","type B pancreatic cell maturation" -"GO:0050942","positive regulation of pigment cell differentiation" -"GO:1990840","response to lectin" -"GO:1901921","phosphorylation of RNA polymerase II C-terminal domain involved in recruitment of 3'-end processing factors to RNA polymerase II holoenzyme complex" -"GO:1902106","negative regulation of leukocyte differentiation" -"GO:0007338","single fertilization" -"GO:0021838","motogenic signaling involved in interneuron migration from the subpallium to the cortex" -"GO:0034181","positive regulation of toll-like receptor 13 signaling pathway" -"GO:1905638","negative regulation of mitochondrial mRNA catabolic process" -"GO:1900480","regulation of diacylglycerol biosynthetic process" -"GO:0060883","regulation of basal lamina disassembly involved in semicircular canal fusion by cell communication" -"GO:0043975","histone H3-K36 acetylation" -"GO:1901650","positive regulation of actomyosin contractile ring localization" -"GO:0021837","motogenic signaling involved in postnatal olfactory bulb interneuron migration" -"GO:0045864","positive regulation of pteridine metabolic process" -"GO:0048733","sebaceous gland development" -"GO:1990036","calcium ion import into sarcoplasmic reticulum" -"GO:0043976","histone H3-K79 acetylation" -"GO:0106056","regulation of calcineurin-mediated signaling" -"GO:0072151","mesangial cell fate commitment" -"GO:0072011","glomerular endothelium development" -"GO:0046679","response to streptomycin" -"GO:0015762","rhamnose transmembrane transport" -"GO:0007183","SMAD protein complex assembly" -"GO:1902616","acyl carnitine transmembrane transport" -"GO:2000035","regulation of stem cell division" -"GO:0042670","retinal cone cell differentiation" -"GO:0042489","negative regulation of odontogenesis of dentin-containing tooth" -"GO:0000756","response to pheromone regulating conjugation with mutual genetic exchange" -"GO:2000076","positive regulation cytokinesis, site selection" -"GO:1904473","response to L-dopa" -"GO:0098840","protein transport along microtubule" -"GO:0043052","thermotaxis" -"GO:0009875","pollen-pistil interaction" -"GO:0003198","epithelial to mesenchymal transition involved in endocardial cushion formation" -"GO:0072749","cellular response to cytochalasin B" -"GO:0033081","regulation of T cell differentiation in thymus" -"GO:0050762","depsipeptide catabolic process" -"GO:0015761","mannose transmembrane transport" -"GO:0003011","involuntary skeletal muscle contraction" -"GO:0000959","mitochondrial RNA metabolic process" -"GO:0015754","allose transmembrane transport" -"GO:0006007","glucose catabolic process" -"GO:0080120","CAAX-box protein maturation" -"GO:0031331","positive regulation of cellular catabolic process" -"GO:0002518","lymphocyte chemotaxis across high endothelial venule" -"GO:1905305","negative regulation of cardiac myofibril assembly" -"GO:0061004","pattern specification involved in kidney development" -"GO:0061614","pri-miRNA transcription by RNA polymerase II" -"GO:0010813","neuropeptide catabolic process" -"GO:0021946","deep nuclear neuron cell migration" -"GO:0071810","regulation of fever generation by regulation of prostaglandin secretion" -"GO:1900967","positive regulation of methanophenazine metabolic process" -"GO:0021564","vagus nerve development" -"GO:0072133","metanephric mesenchyme morphogenesis" -"GO:0051792","medium-chain fatty acid biosynthetic process" -"GO:0015711","organic anion transport" -"GO:0032790","ribosome disassembly" -"GO:0006613","cotranslational protein targeting to membrane" -"GO:1903669","positive regulation of chemorepellent activity" -"GO:0070296","sarcoplasmic reticulum calcium ion transport" -"GO:0099006","viral entry via permeabilization of endosomal membrane" -"GO:1901522","positive regulation of transcription from RNA polymerase II promoter involved in cellular response to chemical stimulus" -"GO:0033240","positive regulation of cellular amine metabolic process" -"GO:0093001","glycolysis from storage polysaccharide through glucose-1-phosphate" -"GO:2000666","negative regulation of interleukin-13 secretion" -"GO:1900804","brevianamide F catabolic process" -"GO:0032470","positive regulation of endoplasmic reticulum calcium ion concentration" -"GO:2000663","negative regulation of interleukin-5 secretion" -"GO:1901102","gramicidin S catabolic process" -"GO:1900535","palmitic acid biosynthetic process" -"GO:0048216","negative regulation of Golgi vesicle fusion to target membrane" -"GO:1903202","negative regulation of oxidative stress-induced cell death" -"GO:1905298","regulation of intestinal epithelial cell development" -"GO:0033153","T cell receptor V(D)J recombination" -"GO:0048829","root cap development" -"GO:2000799","positive regulation of amniotic stem cell differentiation" -"GO:1904504","positive regulation of lipophagy" -"GO:0038192","gastric inhibitory peptide signaling pathway" -"GO:0003299","muscle hypertrophy in response to stress" -"GO:0033071","vancomycin metabolic process" -"GO:0060137","maternal process involved in parturition" -"GO:0071894","histone H2B conserved C-terminal lysine ubiquitination" -"GO:0046199","cresol catabolic process" -"GO:0071430","pre-miRNA-containing ribonucleoprotein complex export from nucleus" -"GO:0097156","fasciculation of motor neuron axon" -"GO:1902416","positive regulation of mRNA binding" -"GO:0007000","nucleolus organization" -"GO:2001231","regulation of protein localization to prospore membrane" -"GO:2000378","negative regulation of reactive oxygen species metabolic process" -"GO:0044790","negative regulation by host of viral release from host cell" -"GO:0070989","oxidative demethylation" -"GO:0061380","superior colliculus development" -"GO:0033052","cyanoamino acid metabolic process" -"GO:0001836","release of cytochrome c from mitochondria" -"GO:0044848","biological phase" -"GO:0019429","fluorene catabolic process" -"GO:0003227","right ventricular trabecular myocardium morphogenesis" -"GO:1901727","positive regulation of histone deacetylase activity" -"GO:0007006","mitochondrial membrane organization" -"GO:0006855","drug transmembrane transport" -"GO:0010957","negative regulation of vitamin D biosynthetic process" -"GO:0061643","chemorepulsion of axon" -"GO:0099578","regulation of translation at postsynapse, modulating synaptic transmission" -"GO:1903711","spermidine transmembrane transport" -"GO:0051179","localization" -"GO:0045592","regulation of cumulus cell differentiation" -"GO:0045947","negative regulation of translational initiation" -"GO:0048887","cupula development" -"GO:1901136","carbohydrate derivative catabolic process" -"GO:1900453","negative regulation of long term synaptic depression" -"GO:1900923","regulation of glycine import across plasma membrane" -"GO:0017143","insecticide metabolic process" -"GO:0006706","steroid catabolic process" -"GO:0038203","TORC2 signaling" -"GO:0051704","multi-organism process" -"GO:0033490","cholesterol biosynthetic process via lathosterol" -"GO:0030299","intestinal cholesterol absorption" -"GO:0042859","chrysobactin catabolic process" -"GO:1903852","positive regulation of cristae formation" -"GO:0051489","regulation of filopodium assembly" -"GO:1905071","occluding junction disassembly" -"GO:0015914","phospholipid transport" -"GO:1903939","regulation of TORC2 signaling" -"GO:0048727","posterior cibarial plate development" -"GO:2000896","amylopectin metabolic process" -"GO:0006778","porphyrin-containing compound metabolic process" -"GO:1903597","negative regulation of gap junction assembly" -"GO:0009225","nucleotide-sugar metabolic process" -"GO:0071431","tRNA-containing ribonucleoprotein complex export from nucleus" -"GO:0002793","positive regulation of peptide secretion" -"GO:1904818","visceral peritoneum development" -"GO:0075259","spore-bearing structure development" -"GO:0030097","hemopoiesis" -"GO:2000766","negative regulation of cytoplasmic translation" -"GO:0018896","dibenzothiophene catabolic process" -"GO:0006022","aminoglycan metabolic process" -"GO:1904544","positive regulation of free ubiquitin chain polymerization" -"GO:0030394","fructoseglycine metabolic process" -"GO:0003336","corneocyte desquamation" -"GO:0019740","nitrogen utilization" -"GO:0021896","forebrain astrocyte differentiation" -"GO:0006776","vitamin A metabolic process" -"GO:0051881","regulation of mitochondrial membrane potential" -"GO:1904291","positive regulation of mitotic DNA damage checkpoint" -"GO:0002019","regulation of renal output by angiotensin" -"GO:1900098","regulation of plasma cell differentiation" -"GO:2000301","negative regulation of synaptic vesicle exocytosis" -"GO:0090258","negative regulation of mitochondrial fission" -"GO:0036378","calcitriol biosynthetic process from calciol" -"GO:2000696","regulation of epithelial cell differentiation involved in kidney development" -"GO:0042207","styrene catabolic process" -"GO:0061152","trachea submucosa development" -"GO:0014052","regulation of gamma-aminobutyric acid secretion" -"GO:1902767","isoprenoid biosynthetic process via mevalonate" -"GO:0042737","drug catabolic process" -"GO:0009413","response to flooding" -"GO:1902033","regulation of hematopoietic stem cell proliferation" -"GO:0043289","apocarotenoid biosynthetic process" -"GO:0015957","bis(5'-nucleosidyl) oligophosphate biosynthetic process" -"GO:0001732","formation of cytoplasmic translation initiation complex" -"GO:0032501","multicellular organismal process" -"GO:0042573","retinoic acid metabolic process" -"GO:0045724","positive regulation of cilium assembly" -"GO:0006040","amino sugar metabolic process" -"GO:0035335","peptidyl-tyrosine dephosphorylation" -"GO:0019062","virion attachment to host cell" -"GO:0046483","heterocycle metabolic process" -"GO:0000132","establishment of mitotic spindle orientation" -"GO:0030166","proteoglycan biosynthetic process" -"GO:0010865","stipule development" -"GO:0010310","regulation of hydrogen peroxide metabolic process" -"GO:1905244","regulation of modification of synaptic structure" -"GO:0071429","snRNA-containing ribonucleoprotein complex export from nucleus" -"GO:0010224","response to UV-B" -"GO:0016114","terpenoid biosynthetic process" -"GO:0061403","positive regulation of transcription from RNA polymerase II promoter in response to nitrosative stress" -"GO:0106036","assembly of apicomedial cortex actomyosin" -"GO:1901114","erythromycin catabolic process" -"GO:1902760","Mo(VI)-molybdopterin cytosine dinucleotide biosynthetic process" -"GO:0031573","intra-S DNA damage checkpoint" -"GO:0033184","positive regulation of histone ubiquitination" -"GO:0035733","hepatic stellate cell activation" -"GO:0071428","rRNA-containing ribonucleoprotein complex export from nucleus" -"GO:0048724","epistomal sclerite development" -"GO:0060177","regulation of angiotensin metabolic process" -"GO:1905840","positive regulation of telomeric D-loop disassembly" -"GO:1900573","emodin metabolic process" -"GO:0046329","negative regulation of JNK cascade" -"GO:0031293","membrane protein intracellular domain proteolysis" -"GO:0071347","cellular response to interleukin-1" -"GO:0003353","positive regulation of cilium movement" -"GO:0015960","diadenosine polyphosphate biosynthetic process" -"GO:2000044","negative regulation of cardiac cell fate specification" -"GO:2000072","regulation of defense response to fungus, incompatible interaction" -"GO:0052287","positive regulation by organism of defense-related calcium-dependent protein kinase pathway in other organism involved in symbiotic interaction" -"GO:0010041","response to iron(III) ion" -"GO:0046378","enterobacterial common antigen metabolic process" -"GO:0007477","notum development" -"GO:0035307","positive regulation of protein dephosphorylation" -"GO:0009804","coumarin metabolic process" -"GO:0018267","GPI anchor biosynthetic process via N-cysteinyl-glycosylphosphatidylinositolethanolamine" -"GO:0072651","interferon-tau production" -"GO:0072059","cortical collecting duct development" -"GO:0048318","axial mesoderm development" -"GO:1904507","positive regulation of telomere maintenance in response to DNA damage" -"GO:0009758","carbohydrate utilization" -"GO:0072656","maintenance of protein location in mitochondrion" -"GO:0010949","negative regulation of intestinal phytosterol absorption" -"GO:0007053","spindle assembly involved in male meiosis" -"GO:0030048","actin filament-based movement" -"GO:0018321","protein glucuronylation" -"GO:0015976","carbon utilization" -"GO:0009767","photosynthetic electron transport chain" -"GO:0007207","phospholipase C-activating G-protein coupled acetylcholine receptor signaling pathway" -"GO:0021729","superior reticular formation development" -"GO:0046550","(3-aminopropyl)(L-aspartyl-1-amino)phosphoryl-5'-adenosine biosynthetic process from asparagine" -"GO:0051581","negative regulation of neurotransmitter uptake" -"GO:1901254","positive regulation of intracellular transport of viral material" -"GO:0039012","pronephric sinus development" -"GO:1905668","positive regulation of protein localization to endosome" -"GO:0047496","vesicle transport along microtubule" -"GO:2001243","negative regulation of intrinsic apoptotic signaling pathway" -"GO:0030393","fructoselysine metabolic process" -"GO:0001748","optic lobe placode development" -"GO:0016098","monoterpenoid metabolic process" -"GO:0010884","positive regulation of lipid storage" -"GO:0018366","chiral amino acid racemization" -"GO:0097237","cellular response to toxic substance" -"GO:2001292","codeine catabolic process" -"GO:0032675","regulation of interleukin-6 production" -"GO:0048213","Golgi vesicle prefusion complex stabilization" -"GO:0043173","nucleotide salvage" -"GO:0048609","multicellular organismal reproductive process" -"GO:2000313","regulation of fibroblast growth factor receptor signaling pathway involved in neural plate anterior/posterior pattern formation" -"GO:0019341","dibenzo-p-dioxin catabolic process" -"GO:0019340","dibenzofuran catabolic process" -"GO:0042447","hormone catabolic process" -"GO:0060825","fibroblast growth factor receptor signaling pathway involved in neural plate anterior/posterior pattern formation" -"GO:0018398","peptidyl-phenylalanine bromination to L-3'-bromophenylalanine" -"GO:0120029","proton export across plasma membrane" -"GO:0000903","regulation of cell shape during vegetative growth phase" -"GO:2000845","positive regulation of testosterone secretion" -"GO:0098908","regulation of neuronal action potential" -"GO:0051188","cofactor biosynthetic process" -"GO:0061737","leukotriene signaling pathway" -"GO:0009822","alkaloid catabolic process" -"GO:0042215","anaerobic phenol-containing compound metabolic process" -"GO:0002003","angiotensin maturation" -"GO:1904783","positive regulation of NMDA glutamate receptor activity" -"GO:0071359","cellular response to dsRNA" -"GO:0099074","mitochondrion to lysosome transport" -"GO:1902885","regulation of proteasome-activating ATPase activity" -"GO:0099531","presynaptic process involved in chemical synaptic transmission" -"GO:0051941","regulation of amino acid uptake involved in synaptic transmission" -"GO:0071783","endoplasmic reticulum cisternal network organization" -"GO:0060730","regulation of intestinal epithelial structure maintenance" -"GO:0046300","2,4-dichlorophenoxyacetic acid catabolic process" -"GO:0048479","style development" -"GO:1902758","bis(molybdopterin guanine dinucleotide)molybdenum biosynthetic process" -"GO:0044830","modulation by host of viral RNA genome replication" -"GO:1902768","isoprenoid biosynthetic process via 1-deoxy-D-xylulose 5-phosphate" -"GO:0046377","colanic acid metabolic process" -"GO:0044699","single-organism process" -"GO:0060959","cardiac neuron development" -"GO:0060570","negative regulation of peptide hormone processing" -"GO:0009201","ribonucleoside triphosphate biosynthetic process" -"GO:1901110","actinorhodin metabolic process" -"GO:0071427","mRNA-containing ribonucleoprotein complex export from nucleus" -"GO:0000422","autophagy of mitochondrion" -"GO:0031047","gene silencing by RNA" -"GO:0099565","chemical synaptic transmission, postsynaptic" -"GO:0075521","microtubule-dependent intracellular transport of viral material towards nucleus" -"GO:0032943","mononuclear cell proliferation" -"GO:0030860","regulation of polarized epithelial cell differentiation" -"GO:0021727","intermediate reticular formation development" -"GO:0046374","teichoic acid metabolic process" -"GO:0045412","negative regulation of interleukin-7 biosynthetic process" -"GO:2000050","regulation of non-canonical Wnt signaling pathway" -"GO:0033489","cholesterol biosynthetic process via desmosterol" -"GO:1903302","regulation of pyruvate kinase activity" -"GO:0110033","regulation of adenylate cyclase-activating glucose-activated G-protein coupled receptor signaling pathway" -"GO:0080166","stomium development" -"GO:0048348","paraxial mesodermal cell fate specification" -"GO:0060998","regulation of dendritic spine development" -"GO:1905337","positive regulation of aggrephagy" -"GO:0061648","tooth replacement" -"GO:0010751","negative regulation of nitric oxide mediated signal transduction" -"GO:2000496","negative regulation of cell proliferation involved in compound eye morphogenesis" -"GO:2000191","regulation of fatty acid transport" -"GO:0071218","cellular response to misfolded protein" -"GO:0034143","regulation of toll-like receptor 4 signaling pathway" -"GO:0034763","negative regulation of transmembrane transport" -"GO:0060365","coronal suture morphogenesis" -"GO:0033260","nuclear DNA replication" -"GO:0036503","ERAD pathway" -"GO:0007361","establishment of posterior gap gene boundaries" -"GO:0010810","regulation of cell-substrate adhesion" -"GO:0008045","motor neuron axon guidance" -"GO:0046579","positive regulation of Ras protein signal transduction" -"GO:0035675","neuromast hair cell development" -"GO:0044087","regulation of cellular component biogenesis" -"GO:0061391","negative regulation of direction of cell growth" -"GO:0060687","regulation of branching involved in prostate gland morphogenesis" -"GO:0003086","regulation of systemic arterial blood pressure by local renal renin-angiotensin" -"GO:2001204","regulation of osteoclast development" -"GO:1902546","positive regulation of DNA N-glycosylase activity" -"GO:0034442","regulation of lipoprotein oxidation" -"GO:0061181","regulation of chondrocyte development" -"GO:1902565","positive regulation of neutrophil activation" -"GO:0072104","glomerular capillary formation" -"GO:0060243","negative regulation of cell growth involved in contact inhibition" -"GO:0061314","Notch signaling involved in heart development" -"GO:0071273","morphine catabolic process" -"GO:0010917","negative regulation of mitochondrial membrane potential" -"GO:0044821","meiotic telomere tethering at nuclear periphery" -"GO:0015747","urate transport" -"GO:0032095","regulation of response to food" -"GO:0097252","oligodendrocyte apoptotic process" -"GO:0048583","regulation of response to stimulus" -"GO:0031291","Ran protein signal transduction" -"GO:0014043","negative regulation of neuron maturation" -"GO:0033044","regulation of chromosome organization" -"GO:1902099","regulation of metaphase/anaphase transition of cell cycle" -"GO:0006999","nuclear pore organization" -"GO:2000409","positive regulation of T cell extravasation" -"GO:2000443","regulation of toll-like receptor 21 signaling pathway" -"GO:0097435","supramolecular fiber organization" -"GO:0034180","negative regulation of toll-like receptor 13 signaling pathway" -"GO:1903748","negative regulation of establishment of protein localization to mitochondrion" -"GO:0036287","response to iloperidone" -"GO:0002069","columnar/cuboidal epithelial cell maturation" -"GO:0045337","farnesyl diphosphate biosynthetic process" -"GO:0019544","arginine catabolic process to glutamate" -"GO:0006721","terpenoid metabolic process" -"GO:0070536","protein K63-linked deubiquitination" -"GO:1902631","negative regulation of membrane hyperpolarization" -"GO:0072386","plus-end-directed organelle transport along microtubule" -"GO:1902117","positive regulation of organelle assembly" -"GO:0046849","bone remodeling" -"GO:0072735","response to t-BOOH" -"GO:0060413","atrial septum morphogenesis" -"GO:0034209","sterol acetylation" -"GO:1901963","regulation of cell proliferation involved in outflow tract morphogenesis" -"GO:0036015","response to interleukin-3" -"GO:0019628","urate catabolic process" -"GO:1990839","response to endothelin" -"GO:0050848","regulation of calcium-mediated signaling" -"GO:0022006","zona limitans intrathalamica formation" -"GO:0021762","substantia nigra development" -"GO:0045023","G0 to G1 transition" -"GO:0003184","pulmonary valve morphogenesis" -"GO:0071350","cellular response to interleukin-15" -"GO:0006537","glutamate biosynthetic process" -"GO:0007488","histoblast morphogenesis" -"GO:0048519","negative regulation of biological process" -"GO:0016072","rRNA metabolic process" -"GO:0061526","acetylcholine secretion" -"GO:1901988","negative regulation of cell cycle phase transition" -"GO:0042685","cardioblast cell fate specification" -"GO:2001168","positive regulation of histone H2B ubiquitination" -"GO:2000767","positive regulation of cytoplasmic translation" -"GO:0035269","protein O-linked mannosylation" -"GO:1903829","positive regulation of cellular protein localization" -"GO:0032844","regulation of homeostatic process" -"GO:0035645","enteric smooth muscle cell differentiation" -"GO:0019496","serine-isocitrate lyase pathway" -"GO:0010190","cytochrome b6f complex assembly" -"GO:0030311","poly-N-acetyllactosamine biosynthetic process" -"GO:0061763","multivesicular body-lysosome fusion" -"GO:0032475","otolith formation" -"GO:0006515","protein quality control for misfolded or incompletely synthesized proteins" -"GO:1904428","negative regulation of tubulin deacetylation" -"GO:1905517","macrophage migration" -"GO:0010603","regulation of cytoplasmic mRNA processing body assembly" -"GO:0061668","mitochondrial ribosome assembly" -"GO:0048544","recognition of pollen" -"GO:0071645","positive regulation of chemokine (C-C motif) ligand 4 production" -"GO:0052362","catabolism by host of symbiont protein" -"GO:0009443","pyridoxal 5'-phosphate salvage" -"GO:0019511","peptidyl-proline hydroxylation" -"GO:0090226","regulation of microtubule nucleation by Ran protein signal transduction" -"GO:2001272","positive regulation of cysteine-type endopeptidase activity involved in execution phase of apoptosis" -"GO:0061036","positive regulation of cartilage development" -"GO:0046005","positive regulation of circadian sleep/wake cycle, REM sleep" -"GO:0002002","regulation of angiotensin levels in blood" -"GO:0060288","formation of a compartment boundary" -"GO:0009890","negative regulation of biosynthetic process" -"GO:0019428","allantoin biosynthetic process" -"GO:0060350","endochondral bone morphogenesis" -"GO:1900452","regulation of long term synaptic depression" -"GO:0018379","cytochrome c-heme linkage via heme-bis-L-cysteine" -"GO:0006231","dTMP biosynthetic process" -"GO:1905216","positive regulation of RNA binding" -"GO:1902731","negative regulation of chondrocyte proliferation" -"GO:0033384","geranyl diphosphate biosynthetic process" -"GO:0048022","negative regulation of melanin biosynthetic process" -"GO:0003264","regulation of cardioblast proliferation" -"GO:0002354","central B cell negative selection" -"GO:0002315","marginal zone B cell differentiation" -"GO:2000061","regulation of ureter smooth muscle cell differentiation" -"GO:1902988","neurofibrillary tangle assembly" -"GO:0098930","axonal transport" -"GO:0045317","equator specification" -"GO:1902840","positive regulation of nuclear migration along microtubule" -"GO:0035520","monoubiquitinated protein deubiquitination" -"GO:0090161","Golgi ribbon formation" -"GO:0038148","chemokine (C-C motif) ligand 2 signaling pathway" -"GO:1903599","positive regulation of autophagy of mitochondrion" -"GO:0032685","negative regulation of granulocyte macrophage colony-stimulating factor production" -"GO:0086050","membrane repolarization during bundle of His cell action potential" -"GO:1905173","eukaryotic translation initiation factor 2B complex assembly" -"GO:1904476","negative regulation of Ras GTPase binding" -"GO:1905859","negative regulation of heparan sulfate proteoglycan binding" -"GO:0046070","dGTP metabolic process" -"GO:0071103","DNA conformation change" -"GO:1990261","pre-mRNA catabolic process" -"GO:0030715","oocyte growth in germarium-derived egg chamber" -"GO:0050902","leukocyte adhesive activation" -"GO:0071108","protein K48-linked deubiquitination" -"GO:1901610","positive regulation of vesicle transport along microtubule" -"GO:0007079","mitotic chromosome movement towards spindle pole" -"GO:1905291","positive regulation of CAMKK-AMPK signaling cascade" -"GO:0009237","siderophore metabolic process" -"GO:0006096","glycolytic process" -"GO:0038118","C-C chemokine receptor CCR7 signaling pathway" -"GO:0061881","positive regulation of anterograde axonal transport of mitochondrion" -"GO:0090656","t-circle formation" -"GO:0035334","Notch receptor processing, ligand-independent" -"GO:0003238","conus arteriosus development" -"GO:0046916","cellular transition metal ion homeostasis" -"GO:0021999","neural plate anterior/posterior regionalization" -"GO:0090107","regulation of high-density lipoprotein particle assembly" -"GO:0035994","response to muscle stretch" -"GO:1901805","beta-glucoside catabolic process" -"GO:0002846","regulation of T cell tolerance induction to tumor cell" -"GO:0044146","negative regulation of growth of symbiont involved in interaction with host" -"GO:0098969","neurotransmitter receptor transport to postsynaptic membrane" -"GO:0033604","negative regulation of catecholamine secretion" -"GO:0034770","histone H4-K20 methylation" -"GO:0018063","cytochrome c-heme linkage" -"GO:2000827","mitochondrial RNA surveillance" -"GO:1904617","negative regulation of actin binding" -"GO:1902969","mitotic DNA replication" -"GO:1900015","regulation of cytokine production involved in inflammatory response" -"GO:0021812","neuronal-glial interaction involved in cerebral cortex radial glia guided migration" -"GO:0010956","negative regulation of calcidiol 1-monooxygenase activity" -"GO:0051202","phytochromobilin metabolic process" -"GO:1900756","protein processing in phagocytic vesicle" -"GO:0120042","negative regulation of macrophage proliferation" -"GO:2000389","regulation of neutrophil extravasation" -"GO:0008617","guanosine metabolic process" -"GO:0045646","regulation of erythrocyte differentiation" -"GO:0010126","mycothiol metabolic process" -"GO:1904777","negative regulation of protein localization to cell cortex" -"GO:0051512","positive regulation of unidimensional cell growth" -"GO:0006221","pyrimidine nucleotide biosynthetic process" -"GO:2001197","basement membrane assembly involved in embryonic body morphogenesis" -"GO:0046122","purine deoxyribonucleoside metabolic process" -"GO:1901286","iron-sulfur-molybdenum cofactor metabolic process" -"GO:0002204","somatic recombination of immunoglobulin genes involved in immune response" -"GO:1903025","regulation of RNA polymerase II regulatory region sequence-specific DNA binding" -"GO:1901357","beta-D-galactofuranose catabolic process" -"GO:0034508","centromere complex assembly" -"GO:0035103","sterol regulatory element binding protein cleavage" -"GO:0072599","establishment of protein localization to endoplasmic reticulum" -"GO:0032742","positive regulation of interleukin-19 production" -"GO:0007288","sperm axoneme assembly" -"GO:0003129","heart induction" -"GO:0070158","mitochondrial seryl-tRNA aminoacylation" -"GO:0007249","I-kappaB kinase/NF-kappaB signaling" -"GO:0043633","polyadenylation-dependent RNA catabolic process" -"GO:2001019","positive regulation of retrograde axon cargo transport" -"GO:1901383","negative regulation of chorionic trophoblast cell proliferation" -"GO:0051638","barbed-end actin filament uncapping" -"GO:2000630","positive regulation of miRNA metabolic process" -"GO:0001783","B cell apoptotic process" -"GO:1902892","positive regulation of root hair elongation" -"GO:0032962","positive regulation of inositol trisphosphate biosynthetic process" -"GO:0040003","chitin-based cuticle development" -"GO:0061621","canonical glycolysis" -"GO:1904925","positive regulation of autophagy of mitochondrion in response to mitochondrial depolarization" -"GO:1904143","positive regulation of carotenoid biosynthetic process" -"GO:0048329","negative regulation of axial mesodermal cell fate specification" -"GO:0035079","polytene chromosome puffing" -"GO:2000691","negative regulation of cardiac muscle cell myoblast differentiation" -"GO:0034661","ncRNA catabolic process" -"GO:0099607","lateral attachment of mitotic spindle microtubules to kinetochore" -"GO:0060895","retinoic acid receptor signaling pathway involved in spinal cord dorsal/ventral patterning" -"GO:0061519","macrophage homeostasis" -"GO:0002510","central B cell tolerance induction" -"GO:0051189","prosthetic group metabolic process" -"GO:0070340","detection of bacterial lipopeptide" -"GO:0000459","exonucleolytic trimming involved in rRNA processing" -"GO:1903259","exon-exon junction complex disassembly" -"GO:0070058","tRNA gene clustering" -"GO:2000494","positive regulation of interleukin-18-mediated signaling pathway" -"GO:0019410","aerobic respiration, using carbon monoxide as electron donor" -"GO:0050919","negative chemotaxis" -"GO:0001301","progressive alteration of chromatin involved in cell aging" -"GO:0045083","negative regulation of interleukin-12 biosynthetic process" -"GO:0090251","protein localization involved in establishment of planar polarity" -"GO:0019471","4-hydroxyproline metabolic process" -"GO:0010260","animal organ senescence" -"GO:1901850","7,8-didemethyl-8-hydroxy-5-deazariboflavin metabolic process" -"GO:0010035","response to inorganic substance" -"GO:0042531","positive regulation of tyrosine phosphorylation of STAT protein" -"GO:0010230","alternative respiration" -"GO:0052704","ergothioneine biosynthesis from histidine via N-alpha,N-alpha,N-alpha-trimethyl-L-histidine" -"GO:0019411","aerobic respiration, using ferrous ions as electron donor" -"GO:1900127","positive regulation of hyaluronan biosynthetic process" -"GO:0043980","histone H2B-K12 acetylation" -"GO:0061740","protein targeting to lysosome involved in chaperone-mediated autophagy" -"GO:0043865","methionine transmembrane transporter activity" -"GO:0071260","cellular response to mechanical stimulus" -"GO:0071290","cellular response to platinum ion" -"GO:0002715","regulation of natural killer cell mediated immunity" -"GO:0000475","maturation of 2S rRNA" -"GO:0030714","anterior/posterior axis specification, follicular epithelium" -"GO:0046322","negative regulation of fatty acid oxidation" -"GO:0090735","DNA repair complex assembly" -"GO:0043101","purine-containing compound salvage" -"GO:0010897","negative regulation of triglyceride catabolic process" -"GO:1903937","response to acrylamide" -"GO:0006732","coenzyme metabolic process" -"GO:0006511","ubiquitin-dependent protein catabolic process" -"GO:0006867","asparagine transport" -"GO:0015980","energy derivation by oxidation of organic compounds" -"GO:0007630","jump response" -"GO:0099088","axonal transport of messenger ribonucleoprotein complex" -"GO:0051039","positive regulation of transcription involved in meiotic cell cycle" -"GO:0045656","negative regulation of monocyte differentiation" -"GO:0060700","regulation of ribonuclease activity" -"GO:0010987","negative regulation of high-density lipoprotein particle clearance" -"GO:0009616","virus induced gene silencing" -"GO:0033308","hydroxyectoine transport" -"GO:1905128","positive regulation of axo-dendritic protein transport" -"GO:0042249","establishment of planar polarity of embryonic epithelium" -"GO:1900224","positive regulation of nodal signaling pathway involved in determination of lateral mesoderm left/right asymmetry" -"GO:0071025","RNA surveillance" -"GO:0048687","positive regulation of sprouting of injured axon" -"GO:0090579","dsDNA loop formation" -"GO:0010744","positive regulation of macrophage derived foam cell differentiation" -"GO:1904824","anaphase-promoting complex assembly" -"GO:0072122","extraglomerular mesangial cell proliferation" -"GO:0043703","photoreceptor cell fate determination" -"GO:0051187","cofactor catabolic process" -"GO:1903472","negative regulation of mitotic actomyosin contractile ring contraction" -"GO:0060322","head development" -"GO:0002302","CD8-positive, alpha-beta T cell differentiation involved in immune response" -"GO:0071316","cellular response to nicotine" -"GO:0061390","positive regulation of direction of cell growth" -"GO:0070488","neutrophil aggregation" -"GO:0000292","RNA fragment catabolic process" -"GO:0035022","positive regulation of Rac protein signal transduction" -"GO:0010452","histone H3-K36 methylation" -"GO:0008614","pyridoxine metabolic process" -"GO:0003323","type B pancreatic cell development" -"GO:0071448","cellular response to alkyl hydroperoxide" -"GO:1903116","positive regulation of actin filament-based movement" -"GO:0051312","chromosome decondensation" -"GO:0042796","snRNA transcription by RNA polymerase III" -"GO:1901091","negative regulation of protein tetramerization" -"GO:1903043","positive regulation of chondrocyte hypertrophy" -"GO:0034390","smooth muscle cell apoptotic process" -"GO:0016100","monoterpenoid catabolic process" -"GO:0043315","positive regulation of neutrophil degranulation" -"GO:0050979","magnetoreception by sensory perception of mechanical stimulus" -"GO:0035886","vascular smooth muscle cell differentiation" -"GO:0097107","postsynaptic density assembly" -"GO:0030963","peptidyl-lysine dihydroxylation to 4,5-dihydroxy-L-lysine" -"GO:1905817","positive regulation of dorsal/ventral axon guidance" -"GO:0097330","response to 5-fluoro-2'-deoxyuridine" -"GO:0035993","deltoid tuberosity development" -"GO:0070133","negative regulation of mitochondrial translational initiation" -"GO:0046680","response to DDT" -"GO:0060255","regulation of macromolecule metabolic process" -"GO:0010651","negative regulation of cell communication by electrical coupling" -"GO:0060578","superior vena cava morphogenesis" -"GO:0010674","negative regulation of transcription from RNA polymerase II promoter involved in meiotic cell cycle" -"GO:0015858","nucleoside transport" -"GO:1900460","negative regulation of invasive growth in response to glucose limitation by negative regulation of transcription from RNA polymerase II promoter" -"GO:0048240","sperm capacitation" -"GO:1901662","quinone catabolic process" -"GO:0061136","regulation of proteasomal protein catabolic process" -"GO:0046280","chalcone catabolic process" -"GO:1901188","negative regulation of ephrin receptor signaling pathway" -"GO:1900814","monodictyphenone catabolic process" -"GO:1902292","cell cycle DNA replication initiation" -"GO:0097366","response to bronchodilator" -"GO:1904689","negative regulation of cytoplasmic translational initiation" -"GO:0010200","response to chitin" -"GO:0051388","positive regulation of neurotrophin TRK receptor signaling pathway" -"GO:0043968","histone H2A acetylation" -"GO:0021848","neuroblast division in subpallium" -"GO:0050841","peptidyl-N6,N6,N6-trimethyl-lysine hydroxylation to peptidyl-N6,N6,N6-trimethyl-5-hydroxy-L-lysine" -"GO:0015917","aminophospholipid transport" -"GO:0036276","response to antidepressant" -"GO:0016557","peroxisome membrane biogenesis" -"GO:0032094","response to food" -"GO:0044209","AMP salvage" -"GO:0008057","eye pigment granule organization" -"GO:0060765","regulation of androgen receptor signaling pathway" -"GO:1904373","response to kainic acid" -"GO:0021849","neuroblast division in subventricular zone" -"GO:0016560","protein import into peroxisome matrix, docking" -"GO:1904792","positive regulation of shelterin complex assembly" -"GO:0045091","regulation of single stranded viral RNA replication via double stranded DNA intermediate" -"GO:0061959","response to (R)-carnitine" -"GO:1901993","regulation of meiotic cell cycle phase transition" -"GO:0035664","TIRAP-dependent toll-like receptor signaling pathway" -"GO:0071872","cellular response to epinephrine stimulus" -"GO:0060577","pulmonary vein morphogenesis" -"GO:0061441","renal artery morphogenesis" -"GO:0046712","GDP catabolic process" -"GO:1900474","negative regulation of mating type switching by negative regulation of transcription from RNA polymerase II promoter" -"GO:1990893","mitotic chromosome centromere condensation" -"GO:0002090","regulation of receptor internalization" -"GO:1900765","emericellin catabolic process" -"GO:0010389","regulation of G2/M transition of mitotic cell cycle" -"GO:0034396","negative regulation of transcription from RNA polymerase II promoter in response to iron" -"GO:0051696","pointed-end actin filament uncapping" -"GO:0050826","response to freezing" -"GO:0140200","adenylate cyclase-activating adrenergic receptor signaling pathway involved in regulation of heart rate" -"GO:1902349","response to chloroquine" -"GO:0007031","peroxisome organization" -"GO:0043651","linoleic acid metabolic process" -"GO:0090216","positive regulation of 1-phosphatidylinositol-4-phosphate 5-kinase activity" -"GO:1901627","negative regulation of postsynaptic membrane organization" -"GO:1901425","response to formic acid" -"GO:0086064","cell communication by electrical coupling involved in cardiac conduction" -"GO:0003253","cardiac neural crest cell migration involved in outflow tract morphogenesis" -"GO:0072219","metanephric cortical collecting duct development" -"GO:0071523","TIR domain-mediated complex assembly" -"GO:0043059","regulation of forward locomotion" -"GO:0097379","dorsal spinal cord interneuron posterior axon guidance" -"GO:1900462","negative regulation of pseudohyphal growth by negative regulation of transcription from RNA polymerase II promoter" -"GO:0044314","protein K27-linked ubiquitination" -"GO:1902130","(+)-lariciresinol metabolic process" -"GO:1902038","positive regulation of hematopoietic stem cell differentiation" -"GO:0048069","eye pigmentation" -"GO:0003091","renal water homeostasis" -"GO:0021763","subthalamic nucleus development" -"GO:0080021","response to benzoic acid" -"GO:0000437","carbon catabolite repression of transcription from RNA polymerase II promoter" -"GO:0046651","lymphocyte proliferation" -"GO:0032343","aldosterone catabolic process" -"GO:0046020","negative regulation of transcription from RNA polymerase II promoter by pheromones" -"GO:1905095","negative regulation of apolipoprotein A-I-mediated signaling pathway" -"GO:0061487","DNA replication initiation from late origin" -"GO:0072347","response to anesthetic" -"GO:0003350","pulmonary myocardium development" -"GO:0070475","rRNA base methylation" -"GO:0043018","negative regulation of lymphotoxin A biosynthetic process" -"GO:0055117","regulation of cardiac muscle contraction" -"GO:0060314","regulation of ryanodine-sensitive calcium-release channel activity" -"GO:0009252","peptidoglycan biosynthetic process" -"GO:1902633","1-phosphatidyl-1D-myo-inositol 4,5-bisphosphate metabolic process" -"GO:1901326","response to tetracycline" -"GO:1901006","ubiquinone-6 biosynthetic process" -"GO:0039613","suppression by virus of host protein phosphorylation" -"GO:1900526","negative regulation of phosphatidylserine biosynthetic process by negative regulation of transcription from RNA polymerase II promoter" -"GO:0014853","regulation of excitatory postsynaptic membrane potential involved in skeletal muscle contraction" -"GO:0015672","monovalent inorganic cation transport" -"GO:0031161","phosphatidylinositol catabolic process" -"GO:1900801","cspyrone B1 catabolic process" -"GO:0075001","adhesion of symbiont infection structure to host" -"GO:0010467","gene expression" -"GO:0035726","common myeloid progenitor cell proliferation" -"GO:0046814","coreceptor-mediated virion attachment to host cell" -"GO:0010351","lithium ion transport" -"GO:0098779","positive regulation of mitophagy in response to mitochondrial depolarization" -"GO:2000027","regulation of organ morphogenesis" -"GO:1903032","negative regulation of microtubule plus-end binding" -"GO:0021540","corpus callosum morphogenesis" -"GO:0042332","gravitaxis" -"GO:0003269","BMP signaling pathway involved in regulation of secondary heart field cardioblast proliferation" -"GO:0097360","chorionic trophoblast cell proliferation" -"GO:0052298","modulation by organism of induced systemic resistance in other organism involved in symbiotic interaction" -"GO:0010135","ureide metabolic process" -"GO:0097241","hematopoietic stem cell migration to bone marrow" -"GO:0045975","positive regulation of translation, ncRNA-mediated" -"GO:0042359","vitamin D metabolic process" -"GO:0036289","peptidyl-serine autophosphorylation" -"GO:0055073","cadmium ion homeostasis" -"GO:0071838","cell proliferation in bone marrow" -"GO:0048227","plasma membrane to endosome transport" -"GO:0010311","lateral root formation" -"GO:1905556","ciliary vesicle assembly" -"GO:0019359","nicotinamide nucleotide biosynthetic process" -"GO:0010734","negative regulation of protein glutathionylation" -"GO:1990044","protein localization to lipid droplet" -"GO:0001945","lymph vessel development" -"GO:0002066","columnar/cuboidal epithelial cell development" -"GO:1901506","regulation of acylglycerol transport" -"GO:0042989","sequestering of actin monomers" -"GO:0042450","arginine biosynthetic process via ornithine" -"GO:0015690","aluminum cation transport" -"GO:1902286","semaphorin-plexin signaling pathway involved in dendrite guidance" -"GO:0018058","N-terminal protein amino acid deamination, from amino carbon" -"GO:0072111","cell proliferation involved in kidney development" -"GO:1900560","austinol biosynthetic process" -"GO:0002466","peripheral tolerance induction to self antigen" -"GO:0000041","transition metal ion transport" -"GO:0014891","striated muscle atrophy" -"GO:0006704","glucocorticoid biosynthetic process" -"GO:0043254","regulation of protein complex assembly" -"GO:0031398","positive regulation of protein ubiquitination" -"GO:1903909","regulation of receptor clustering" -"GO:0043407","negative regulation of MAP kinase activity" -"GO:1900563","dehydroaustinol biosynthetic process" -"GO:1904526","regulation of microtubule binding" -"GO:0021945","positive regulation of cerebellar granule cell migration by calcium" -"GO:0099131","ATP hydrolysis coupled ion transmembrane transport" -"GO:1902612","regulation of anti-Mullerian hormone signaling pathway" -"GO:1901237","tungstate transmembrane transporter activity" -"GO:1902547","regulation of cellular response to vascular endothelial growth factor stimulus" -"GO:0019322","pentose biosynthetic process" -"GO:0048075","positive regulation of eye pigmentation" -"GO:0110012","protein localization to P-body" -"GO:0071918","urea transmembrane transport" -"GO:0000722","telomere maintenance via recombination" -"GO:0032933","SREBP signaling pathway" -"GO:0048823","nucleate erythrocyte development" -"GO:0002363","alpha-beta T cell lineage commitment" -"GO:1903070","negative regulation of ER-associated ubiquitin-dependent protein catabolic process" -"GO:0034184","positive regulation of maintenance of mitotic sister chromatid cohesion" -"GO:1990928","response to amino acid starvation" -"GO:0043309","regulation of eosinophil degranulation" -"GO:1903903","regulation of establishment of T cell polarity" -"GO:0003069","acetylcholine-mediated vasodilation involved in regulation of systemic arterial blood pressure" -"GO:1990168","protein K33-linked deubiquitination" -"GO:0035330","regulation of hippo signaling" -"GO:0061584","hypocretin secretion" -"GO:1990554","mitochondrial 3'-phospho-5'-adenylyl sulfate transmembrane transport" -"GO:0051014","actin filament severing" -"GO:0043473","pigmentation" -"GO:1905097","regulation of guanyl-nucleotide exchange factor activity" -"GO:1900071","regulation of sulfite transport" -"GO:0046318","negative regulation of glucosylceramide biosynthetic process" -"GO:1902803","regulation of synaptic vesicle transport" -"GO:0031104","dendrite regeneration" -"GO:0051443","positive regulation of ubiquitin-protein transferase activity" -"GO:0046390","ribose phosphate biosynthetic process" -"GO:1902461","negative regulation of mesenchymal stem cell proliferation" -"GO:0072655","establishment of protein localization to mitochondrion" -"GO:0031532","actin cytoskeleton reorganization" -"GO:0061544","peptide secretion, neurotransmission" -"GO:0044550","secondary metabolite biosynthetic process" -"GO:0098877","neurotransmitter receptor transport to plasma membrane" -"GO:1905792","positive regulation of mechanosensory behavior" -"GO:0042473","outer ear morphogenesis" -"GO:1900243","negative regulation of synaptic vesicle endocytosis" -"GO:0060874","posterior semicircular canal development" -"GO:0043606","formamide metabolic process" -"GO:0090381","regulation of heart induction" -"GO:0072598","protein localization to chloroplast" -"GO:0072112","glomerular visceral epithelial cell differentiation" -"GO:0006901","vesicle coating" -"GO:0044722","renal phosphate excretion" -"GO:2000268","positive regulation of blood coagulation, intrinsic pathway" -"GO:0042701","progesterone secretion" -"GO:0071494","cellular response to UV-C" -"GO:1905604","negative regulation of maintenance of permeability of blood-brain barrier" -"GO:0006491","N-glycan processing" -"GO:2000209","regulation of anoikis" -"GO:0035998","7,8-dihydroneopterin 3'-triphosphate biosynthetic process" -"GO:1905928","negative regulation of invadopodium disassembly" -"GO:1901591","regulation of double-strand break repair via break-induced replication" -"GO:0002821","positive regulation of adaptive immune response" -"GO:0032226","positive regulation of synaptic transmission, dopaminergic" -"GO:1903976","negative regulation of glial cell migration" -"GO:0045905","positive regulation of translational termination" -"GO:1905712","cellular response to phosphatidylethanolamine" -"GO:0032597","B cell receptor transport into membrane raft" -"GO:0060093","negative regulation of synaptic transmission, glycinergic" -"GO:0070838","divalent metal ion transport" -"GO:1902174","positive regulation of keratinocyte apoptotic process" -"GO:0006593","ornithine catabolic process" -"GO:0072682","eosinophil extravasation" -"GO:1904881","cellular response to hydrogen sulfide" -"GO:0045842","positive regulation of mitotic metaphase/anaphase transition" -"GO:0071801","regulation of podosome assembly" -"GO:0036343","psychomotor behavior" -"GO:2000768","positive regulation of nephron tubule epithelial cell differentiation" -"GO:0042777","plasma membrane ATP synthesis coupled proton transport" -"GO:0090200","positive regulation of release of cytochrome c from mitochondria" -"GO:0060789","hair follicle placode formation" -"GO:0048752","semicircular canal morphogenesis" -"GO:0070246","natural killer cell apoptotic process" -"GO:0061540","octopamine secretion, neurotransmission" -"GO:1900925","positive regulation of glycine import across plasma membrane" -"GO:1903934","positive regulation of DNA primase activity" -"GO:0032600","chemokine receptor transport out of membrane raft" -"GO:2001269","positive regulation of cysteine-type endopeptidase activity involved in apoptotic signaling pathway" -"GO:0110081","negative regulation of placenta blood vessel development" -"GO:0033298","contractile vacuole organization" -"GO:0032990","cell part morphogenesis" -"GO:0097742","de novo centriole assembly" -"GO:1903844","regulation of cellular response to transforming growth factor beta stimulus" -"GO:0046012","positive regulation of oskar mRNA translation" -"GO:0090141","positive regulation of mitochondrial fission" -"GO:1903906","regulation of plasma membrane raft polarization" -"GO:0048387","negative regulation of retinoic acid receptor signaling pathway" -"GO:0060084","synaptic transmission involved in micturition" -"GO:0061301","cerebellum vasculature morphogenesis" -"GO:0042423","catecholamine biosynthetic process" -"GO:0032364","oxygen homeostasis" -"GO:1900407","regulation of cellular response to oxidative stress" -"GO:0021678","third ventricle development" -"GO:2001060","D-glycero-D-manno-heptose 7-phosphate metabolic process" -"GO:0090527","actin filament reorganization" -"GO:0061153","trachea gland development" -"GO:0010561","negative regulation of glycoprotein biosynthetic process" -"GO:0043097","pyrimidine nucleoside salvage" -"GO:0097305","response to alcohol" -"GO:0046092","deoxycytidine metabolic process" -"GO:0001172","transcription, RNA-templated" -"GO:0021808","cytosolic calcium signaling involved in initiation of cell movement in glial-mediated radial cell migration" -"GO:0002229","defense response to oomycetes" -"GO:0052314","phytoalexin metabolic process" -"GO:1902302","regulation of potassium ion export" -"GO:0090335","regulation of brown fat cell differentiation" -"GO:0140039","cell-cell adhesion in response to extracellular stimulus" -"GO:0019693","ribose phosphate metabolic process" -"GO:1902958","positive regulation of mitochondrial electron transport, NADH to ubiquinone" -"GO:1990743","protein sialylation" -"GO:0021845","neurotransmitter-mediated guidance of interneurons involved in substrate-independent cerebral cortex tangential migration" -"GO:0061966","establishment of left/right asymmetry" -"GO:0034356","NAD biosynthesis via nicotinamide riboside salvage pathway" -"GO:0010752","regulation of cGMP-mediated signaling" -"GO:0034152","negative regulation of toll-like receptor 6 signaling pathway" -"GO:0071470","cellular response to osmotic stress" -"GO:1903689","regulation of wound healing, spreading of epidermal cells" -"GO:0038087","VEGF-activated platelet-derived growth factor receptor-alpha signaling pathway" -"GO:0009798","axis specification" -"GO:0046715","active borate transmembrane transporter activity" -"GO:0006690","icosanoid metabolic process" -"GO:0019567","arabinose biosynthetic process" -"GO:1900136","regulation of chemokine activity" -"GO:0006055","CMP-N-acetylneuraminate biosynthetic process" -"GO:0003081","regulation of systemic arterial blood pressure by renin-angiotensin" -"GO:1905416","regulation of amoeboid sperm motility" -"GO:2000134","negative regulation of G1/S transition of mitotic cell cycle" -"GO:0045375","regulation of interleukin-16 biosynthetic process" -"GO:0001932","regulation of protein phosphorylation" -"GO:0097026","dendritic cell dendrite assembly" -"GO:1904427","positive regulation of calcium ion transmembrane transport" -"GO:0006311","meiotic gene conversion" -"GO:1904577","cellular response to tunicamycin" -"GO:0006792","regulation of sulfur utilization" -"GO:1990575","mitochondrial L-ornithine transmembrane transport" -"GO:0044621","modulation of cell migration in other organism" -"GO:0007130","synaptonemal complex assembly" -"GO:1990828","hepatocyte dedifferentiation" -"GO:0021888","hypothalamus gonadotrophin-releasing hormone neuron development" -"GO:0002296","T-helper 1 cell lineage commitment" -"GO:0007218","neuropeptide signaling pathway" -"GO:2000589","regulation of metanephric mesenchymal cell migration" -"GO:0015879","carnitine transport" -"GO:0021779","oligodendrocyte cell fate commitment" -"GO:0002611","negative regulation of plasmacytoid dendritic cell antigen processing and presentation" -"GO:0016226","iron-sulfur cluster assembly" -"GO:1905687","regulation of diacylglycerol kinase activity" -"GO:0000476","maturation of 4.5S rRNA" -"GO:0007355","anterior region determination" -"GO:0071639","positive regulation of monocyte chemotactic protein-1 production" -"GO:0034624","DNA recombinase assembly involved in gene conversion at mating-type locus" -"GO:0030575","nuclear body organization" -"GO:0045072","regulation of interferon-gamma biosynthetic process" -"GO:0001657","ureteric bud development" -"GO:0048695","negative regulation of collateral sprouting of injured axon" -"GO:0006278","RNA-dependent DNA biosynthetic process" -"GO:0002931","response to ischemia" -"GO:0021840","directional guidance of interneurons involved in migration from the subpallium to the cortex" -"GO:0043650","dicarboxylic acid biosynthetic process" -"GO:1904235","regulation of substrate-dependent cell migration, cell attachment to substrate" -"GO:2000471","regulation of hematopoietic stem cell migration" -"GO:0007217","tachykinin receptor signaling pathway" -"GO:0051223","regulation of protein transport" -"GO:0060290","transdifferentiation" -"GO:0060953","cardiac glial cell fate commitment" -"GO:0045862","positive regulation of proteolysis" -"GO:0014722","regulation of skeletal muscle contraction by calcium ion signaling" -"GO:0009438","methylglyoxal metabolic process" -"GO:0007448","anterior/posterior pattern specification, imaginal disc" -"GO:0031118","rRNA pseudouridine synthesis" -"GO:0010759","positive regulation of macrophage chemotaxis" -"GO:0000487","maturation of 5.8S rRNA from tetracistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, 2S rRNA, LSU-rRNA)" -"GO:0007366","periodic partitioning by pair rule gene" -"GO:0043122","regulation of I-kappaB kinase/NF-kappaB signaling" -"GO:0097303","lipoprotein biosynthetic process via N-acyl transfer" -"GO:0001821","histamine secretion" -"GO:0050713","negative regulation of interleukin-1 beta secretion" -"GO:0019507","pyridine metabolic process" -"GO:1904872","regulation of telomerase RNA localization to Cajal body" -"GO:0000967","rRNA 5'-end processing" -"GO:0002934","desmosome organization" -"GO:0061331","epithelial cell proliferation involved in Malpighian tubule morphogenesis" -"GO:0042773","ATP synthesis coupled electron transport" -"GO:0101027","optical nerve axon regeneration" -"GO:0070447","positive regulation of oligodendrocyte progenitor proliferation" -"GO:0031923","pyridoxine transport" -"GO:1900008","negative regulation of extrachromosomal rDNA circle accumulation involved in replicative cell aging" -"GO:0007186","G-protein coupled receptor signaling pathway" -"GO:2001300","lipoxin metabolic process" -"GO:1902265","abscisic acid homeostasis" -"GO:0038107","nodal signaling pathway involved in determination of left/right asymmetry" -"GO:1901745","prephenate(2-) metabolic process" -"GO:1905850","positive regulation of forward locomotion" -"GO:0097103","endothelial stalk cell fate specification" -"GO:0043872","lysine:cadaverine antiporter activity" -"GO:0046697","decidualization" -"GO:0014865","detection of activity" -"GO:1905210","regulation of fibroblast chemotaxis" -"GO:1904338","regulation of dopaminergic neuron differentiation" -"GO:0045959","negative regulation of complement activation, classical pathway" -"GO:0044281","small molecule metabolic process" -"GO:0006820","anion transport" -"GO:1902116","negative regulation of organelle assembly" -"GO:0080190","lateral growth" -"GO:2000975","positive regulation of pro-B cell differentiation" -"GO:1904847","regulation of cell chemotaxis to fibroblast growth factor" -"GO:1904076","regulation of estrogen biosynthetic process" -"GO:0061889","negative regulation of astrocyte activation" -"GO:0046417","chorismate metabolic process" -"GO:0099639","neurotransmitter receptor transport, endosome to plasma membrane" -"GO:0032960","regulation of inositol trisphosphate biosynthetic process" -"GO:0022610","biological adhesion" -"GO:0071066","detection of mechanical stimulus involved in sensory perception of wind" -"GO:0070639","vitamin D2 metabolic process" -"GO:0033023","mast cell homeostasis" -"GO:1903979","negative regulation of microglial cell activation" -"GO:0019427","acetyl-CoA biosynthetic process from acetate" -"GO:0043016","regulation of lymphotoxin A biosynthetic process" -"GO:0010986","positive regulation of lipoprotein particle clearance" -"GO:0045677","negative regulation of R7 cell differentiation" -"GO:0042818","pyridoxamine metabolic process" -"GO:2000673","positive regulation of motor neuron apoptotic process" -"GO:1901623","regulation of lymphocyte chemotaxis" -"GO:0034616","response to laminar fluid shear stress" -"GO:0051453","regulation of intracellular pH" -"GO:0044239","salivary polysaccharide catabolic process" -"GO:0061924","regulation of formation of radial glial scaffolds" -"GO:0060394","negative regulation of pathway-restricted SMAD protein phosphorylation" -"GO:0045354","regulation of interferon-alpha biosynthetic process" -"GO:0110090","positive regulation of hippocampal neuron apoptotic process" -"GO:1904878","negative regulation of calcium ion transmembrane transport via high voltage-gated calcium channel" -"GO:0032111","activation of protein histidine kinase activity" -"GO:0060415","muscle tissue morphogenesis" -"GO:1900003","regulation of serine-type endopeptidase activity" -"GO:0007275","multicellular organism development" -"GO:0045360","regulation of interleukin-1 biosynthetic process" -"GO:0051165","2,5-dihydroxypyridine metabolic process" -"GO:2000233","negative regulation of rRNA processing" -"GO:0007565","female pregnancy" -"GO:0010644","cell communication by electrical coupling" -"GO:0003376","sphingosine-1-phosphate signaling pathway" -"GO:0007270","neuron-neuron synaptic transmission" -"GO:0031120","snRNA pseudouridine synthesis" -"GO:0034373","intermediate-density lipoprotein particle remodeling" -"GO:0060600","dichotomous subdivision of an epithelial terminal unit" -"GO:0042537","benzene-containing compound metabolic process" -"GO:0097746","regulation of blood vessel diameter" -"GO:0007342","fusion of sperm to egg plasma membrane involved in single fertilization" -"GO:0043862","arginine:agmatine antiporter activity" -"GO:0002505","antigen processing and presentation of polysaccharide antigen via MHC class II" -"GO:0045402","regulation of interleukin-4 biosynthetic process" -"GO:0070445","regulation of oligodendrocyte progenitor proliferation" -"GO:0061766","positive regulation of lung blood pressure" -"GO:0044256","protein digestion" -"GO:0007287","Nebenkern assembly" -"GO:0006821","chloride transport" -"GO:0009698","phenylpropanoid metabolic process" -"GO:0060824","retinoic acid receptor signaling pathway involved in neural plate anterior/posterior pattern formation" -"GO:0097601","retina blood vessel maintenance" -"GO:0000466","maturation of 5.8S rRNA from tricistronic rRNA transcript (SSU-rRNA, 5.8S rRNA, LSU-rRNA)" -"GO:0016333","morphogenesis of follicular epithelium" -"GO:1900119","positive regulation of execution phase of apoptosis" -"GO:0097497","blood vessel endothelial cell delamination" -"GO:0090669","telomerase RNA stabilization" -"GO:0045378","regulation of interleukin-17 biosynthetic process" -"GO:0002916","positive regulation of central B cell anergy" -"GO:0010991","negative regulation of SMAD protein complex assembly" -"GO:0048096","chromatin-mediated maintenance of transcription" -"GO:0045393","regulation of interleukin-22 biosynthetic process" -"GO:0007352","zygotic specification of dorsal/ventral axis" -"GO:0019857","5-methylcytosine metabolic process" -"GO:0003020","detection of reduced oxygen by chemoreceptor signaling" -"GO:0031341","regulation of cell killing" -"GO:0019371","cyclooxygenase pathway" -"GO:0044265","cellular macromolecule catabolic process" -"GO:0007305","vitelline membrane formation involved in chorion-containing eggshell formation" -"GO:0009751","response to salicylic acid" -"GO:1905587","positive regulation of outer hair cell apoptotic process" -"GO:0002014","vasoconstriction of artery involved in ischemic response to lowering of systemic arterial blood pressure" -"GO:0032642","regulation of chemokine production" -"GO:0031275","regulation of lateral pseudopodium assembly" -"GO:0001973","adenosine receptor signaling pathway" -"GO:0098725","symmetric cell division" -"GO:0042836","D-glucarate metabolic process" -"GO:0014876","response to injury involved in regulation of muscle adaptation" -"GO:0009313","oligosaccharide catabolic process" -"GO:0003204","cardiac skeleton development" -"GO:1905799","regulation of intraciliary retrograde transport" -"GO:0019380","3-phenylpropionate catabolic process" -"GO:0006497","protein lipidation" -"GO:0018895","dibenzothiophene metabolic process" -"GO:0001994","norepinephrine-epinephrine vasoconstriction involved in regulation of systemic arterial blood pressure" -"GO:1905804","positive regulation of cellular response to manganese ion" -"GO:0070125","mitochondrial translational elongation" -"GO:0070982","L-asparagine metabolic process" -"GO:0032540","positive regulation of host-seeking behavior" -"GO:0030833","regulation of actin filament polymerization" -"GO:1903951","positive regulation of AV node cell action potential" -"GO:0035818","positive regulation of urine volume by pressure natriuresis" -"GO:0022015","radial glial cell division in pallium" -"GO:0009190","cyclic nucleotide biosynthetic process" -"GO:0072072","kidney stroma development" -"GO:0042330","taxis" -"GO:0002858","regulation of natural killer cell mediated cytotoxicity directed against tumor cell target" -"GO:0035551","protein initiator methionine removal involved in protein maturation" -"GO:1903961","positive regulation of anion transmembrane transport" -"GO:1905872","negative regulation of protein localization to cell leading edge" -"GO:0071961","mitotic sister chromatid cohesion, arms" -"GO:0032749","positive regulation of interleukin-25 production" -"GO:0042206","halogenated hydrocarbon catabolic process" -"GO:0007494","midgut development" -"GO:1900258","positive regulation of beta1-adrenergic receptor activity" -"GO:0030815","negative regulation of cAMP metabolic process" -"GO:1901046","positive regulation of oviposition" -"GO:0010704","meiotic DNA double-strand break processing involved in meiotic gene conversion" -"GO:0051122","hepoxilin biosynthetic process" -"GO:1901271","lipooligosaccharide biosynthetic process" -"GO:0009649","entrainment of circadian clock" -"GO:1904451","regulation of potassium:proton exchanging ATPase activity" -"GO:0030417","nicotianamine metabolic process" -"GO:0000449","endonucleolytic cleavage of tricistronic rRNA transcript (SSU-rRNA, LSU-rRNA, 5S)" -"GO:0007193","adenylate cyclase-inhibiting G-protein coupled receptor signaling pathway" -"GO:0060264","regulation of respiratory burst involved in inflammatory response" -"GO:0090510","anticlinal cell division" -"GO:1902697","valine catabolic process to isobutanol" -"GO:0002932","tendon sheath development" -"GO:0000412","histone peptidyl-prolyl isomerization" -"GO:0006665","sphingolipid metabolic process" -"GO:0002936","bradykinin biosynthetic process" -"GO:0060248","detection of cell density by contact stimulus involved in contact inhibition" -"GO:0051491","positive regulation of filopodium assembly" -"GO:0019610","3-hydroxyphenylacetate catabolic process" -"GO:0072285","mesenchymal to epithelial transition involved in metanephric renal vesicle formation" -"GO:0019372","lipoxygenase pathway" -"GO:1900387","negative regulation of cell-cell adhesion by negative regulation of transcription from RNA polymerase II promoter" -"GO:0002006","vasoconstriction by vasopressin involved in systemic arterial blood pressure control" -"GO:0071224","cellular response to peptidoglycan" -"GO:0071258","cellular response to gravity" -"GO:0019529","taurine catabolic process" -"GO:2001207","regulation of transcription elongation from RNA polymerase I promoter" -"GO:0090169","regulation of spindle assembly" -"GO:1903298","negative regulation of hypoxia-induced intrinsic apoptotic signaling pathway" -"GO:0043163","cell envelope organization" -"GO:2000405","negative regulation of T cell migration" -"GO:0018970","toluene metabolic process" -"GO:0070940","dephosphorylation of RNA polymerase II C-terminal domain" -"GO:1902178","fibroblast growth factor receptor apoptotic signaling pathway" -"GO:1902179","verruculogen metabolic process" -"GO:0003398","glial cell differentiation involved in amphid sensory organ development" -"GO:0021869","forebrain ventricular zone progenitor cell division" -"GO:0019501","arsonoacetate catabolic process" -"GO:0031055","chromatin remodeling at centromere" -"GO:0007040","lysosome organization" -"GO:0009111","vitamin catabolic process" -"GO:0044130","negative regulation of growth of symbiont in host" -"GO:0046333","octopamine metabolic process" -"GO:2001266","Roundabout signaling pathway involved in axon guidance" -"GO:0046267","triethanolamine catabolic process" -"GO:0035567","non-canonical Wnt signaling pathway" -"GO:0051252","regulation of RNA metabolic process" -"GO:0010804","negative regulation of tumor necrosis factor-mediated signaling pathway" -"GO:1902380","positive regulation of endoribonuclease activity" -"GO:1990869","cellular response to chemokine" -"GO:0110069","syncytial embryo cellularization" -"GO:0006769","nicotinamide metabolic process" -"GO:0021953","central nervous system neuron differentiation" -"GO:0019256","acrylonitrile catabolic process" -"GO:0046168","glycerol-3-phosphate catabolic process" -"GO:2000483","negative regulation of interleukin-8 secretion" -"GO:0006376","mRNA splice site selection" -"GO:0071329","cellular response to sucrose stimulus" -"GO:0098907","regulation of SA node cell action potential" -"GO:0080140","regulation of jasmonic acid metabolic process" -"GO:0008212","mineralocorticoid metabolic process" -"GO:0031524","menthol metabolic process" -"GO:0007341","penetration of zona pellucida" -"GO:1901596","response to reversine" -"GO:0070126","mitochondrial translational termination" -"GO:0071638","negative regulation of monocyte chemotactic protein-1 production" -"GO:0010667","negative regulation of cardiac muscle cell apoptotic process" -"GO:1902524","positive regulation of protein K48-linked ubiquitination" -"GO:1902545","negative regulation of DNA N-glycosylase activity" -"GO:2000391","positive regulation of neutrophil extravasation" -"GO:0009862","systemic acquired resistance, salicylic acid mediated signaling pathway" -"GO:0090164","asymmetric Golgi ribbon formation" -"GO:0046304","2-nitropropane catabolic process" -"GO:1901560","response to purvalanol A" -"GO:1903904","negative regulation of establishment of T cell polarity" -"GO:0046376","GDP-alpha-D-mannosylchitobiosyldiphosphodolichol metabolic process" -"GO:1903388","regulation of synaptic vesicle uncoating" -"GO:0030214","hyaluronan catabolic process" -"GO:0071237","cellular response to bacteriocin" -"GO:0002323","natural killer cell activation involved in immune response" -"GO:1903139","positive regulation of MAPK cascade involved in cell wall organization or biogenesis" -"GO:2000761","positive regulation of N-terminal peptidyl-lysine acetylation" -"GO:0097050","type B pancreatic cell apoptotic process" -"GO:0010726","positive regulation of hydrogen peroxide metabolic process" -"GO:0022405","hair cycle process" -"GO:1905794","response to puromycin" -"GO:0010839","negative regulation of keratinocyte proliferation" -"GO:0001987","vasoconstriction of artery involved in baroreceptor response to lowering of systemic arterial blood pressure" -"GO:1904971","regulation of viral translation" -"GO:1900865","chloroplast RNA modification" -"GO:0019386","methanogenesis, from carbon dioxide" -"GO:0035390","establishment of chromatin silencing at telomere" -"GO:0030186","melatonin metabolic process" -"GO:0060693","regulation of branching involved in salivary gland morphogenesis" -"GO:1900794","terrequinone A metabolic process" -"GO:1901551","negative regulation of endothelial cell development" -"GO:0033510","luteolin metabolic process" -"GO:0008049","male courtship behavior" -"GO:0070268","cornification" -"GO:1905552","positive regulation of protein localization to endoplasmic reticulum" -"GO:0018979","trichloroethylene metabolic process" -"GO:0060085","smooth muscle relaxation of the bladder outlet" -"GO:0003312","pancreatic PP cell differentiation" -"GO:0046196","4-nitrophenol catabolic process" -"GO:1903370","positive regulation of foraging behavior" -"GO:0006689","ganglioside catabolic process" -"GO:0006653","1,2-diacyl-sn-glycero-3-phosphocholine metabolic process" -"GO:0003267","canonical Wnt signaling pathway involved in positive regulation of secondary heart field cardioblast proliferation" -"GO:0006171","cAMP biosynthetic process" -"GO:0052838","thiazole metabolic process" -"GO:2000036","regulation of stem cell population maintenance" -"GO:1903252","hercynylcysteine sulfoxide metabolic process" -"GO:0048514","blood vessel morphogenesis" -"GO:1901187","regulation of ephrin receptor signaling pathway" -"GO:0045738","negative regulation of DNA repair" -"GO:0019369","arachidonic acid metabolic process" -"GO:0070979","protein K11-linked ubiquitination" -"GO:0031570","DNA integrity checkpoint" -"GO:0035942","dehydroepiandrosterone secretion" -"GO:0019933","cAMP-mediated signaling" -"GO:0071415","cellular response to purine-containing compound" -"GO:0042093","T-helper cell differentiation" -"GO:1900449","regulation of glutamate receptor signaling pathway" -"GO:0051493","regulation of cytoskeleton organization" -"GO:0048860","glioblast division" -"GO:1902615","immune response involved in response to exogenous dsRNA" -"GO:1900425","negative regulation of defense response to bacterium" -"GO:0036023","embryonic skeletal limb joint morphogenesis" -"GO:0090203","transcriptional activation by promoter-terminator looping" -"GO:0032734","positive regulation of interleukin-11 production" -"GO:0045214","sarcomere organization" -"GO:0002103","endonucleolytic cleavage of tetracistronic rRNA transcript (SSU-rRNA, LSU-rRNA, 4.5S-rRNA, 5S-rRNA)" -"GO:0099506","synaptic vesicle transport along actin filament" -"GO:0002205","somatic hypermutation of immunoglobulin genes involved in immune response" -"GO:0007114","cell budding" -"GO:0046440","L-lysine metabolic process" -"GO:2001107","negative regulation of Rho guanyl-nucleotide exchange factor activity" -"GO:0009449","gamma-aminobutyric acid biosynthetic process" -"GO:1902176","negative regulation of oxidative stress-induced intrinsic apoptotic signaling pathway" -"GO:0061871","negative regulation of hepatic stellate cell migration" -"GO:1901483","regulation of transcription factor catabolic process" -"GO:0019506","phenylmercury acetate catabolic process" -"GO:0010659","cardiac muscle cell apoptotic process" -"GO:0048343","paraxial mesodermal cell fate commitment" -"GO:0071863","regulation of cell proliferation in bone marrow" -"GO:0071315","cellular response to morphine" -"GO:1901382","regulation of chorionic trophoblast cell proliferation" -"GO:2001213","negative regulation of vasculogenesis" -"GO:0045669","positive regulation of osteoblast differentiation" -"GO:0043420","anthranilate metabolic process" -"GO:0044852","nonrepetitive DNA condensation" -"GO:0060482","lobar bronchus development" -"GO:2000329","negative regulation of T-helper 17 cell lineage commitment" -"GO:0002038","positive regulation of L-glutamate import across plasma membrane" -"GO:0050802","circadian sleep/wake cycle, sleep" -"GO:0034461","uropod retraction" -"GO:0030004","cellular monovalent inorganic cation homeostasis" -"GO:0007142","male meiosis II" -"GO:1901491","negative regulation of lymphangiogenesis" -"GO:0032278","positive regulation of gonadotropin secretion" -"GO:0060347","heart trabecula formation" -"GO:2001312","lysobisphosphatidic acid biosynthetic process" -"GO:1904992","positive regulation of adenylate cyclase-inhibiting dopamine receptor signaling pathway" -"GO:2000101","regulation of mammary stem cell proliferation" -"GO:0043045","DNA methylation involved in embryo development" -"GO:1901645","regulation of synoviocyte proliferation" -"GO:0007437","adult salivary gland morphogenesis" -"GO:0061358","negative regulation of Wnt protein secretion" -"GO:0035096","larval midgut cell programmed cell death" -"GO:0051391","tRNA acetylation" -"GO:0046459","short-chain fatty acid metabolic process" -"GO:0042631","cellular response to water deprivation" -"GO:0031635","adenylate cyclase-inhibiting opioid receptor signaling pathway" -"GO:1905153","regulation of membrane invagination" -"GO:0060716","labyrinthine layer blood vessel development" -"GO:0035265","organ growth" -"GO:0070676","intralumenal vesicle formation" -"GO:0072504","cellular trivalent inorganic cation homeostasis" -"GO:2000150","regulation of planar cell polarity pathway involved in cardiac muscle tissue morphogenesis" -"GO:0045046","protein import into peroxisome membrane" -"GO:2000334","positive regulation of blood microparticle formation" -"GO:0009913","epidermal cell differentiation" -"GO:1900029","positive regulation of ruffle assembly" -"GO:0032370","positive regulation of lipid transport" -"GO:0035745","T-helper 2 cell cytokine production" -"GO:0007446","imaginal disc growth" -"GO:0009989","cell-matrix recognition" -"GO:0002905","regulation of mature B cell apoptotic process" -"GO:1902887","positive regulation of proteasome-activating ATPase activity" -"GO:1901290","succinyl-CoA biosynthetic process" -"GO:0018985","pronuclear envelope synthesis" -"GO:0043487","regulation of RNA stability" -"GO:1903915","positive regulation of fusion of virus membrane with host plasma membrane" -"GO:0009224","CMP biosynthetic process" -"GO:1904609","cellular response to monosodium L-glutamate" -"GO:0055021","regulation of cardiac muscle tissue growth" -"GO:0061086","negative regulation of histone H3-K27 methylation" -"GO:1905689","positive regulation of diacylglycerol kinase activity" -"GO:0097168","mesenchymal stem cell proliferation" -"GO:0010942","positive regulation of cell death" -"GO:0071361","cellular response to ethanol" -"GO:1902217","erythrocyte apoptotic process" -"GO:0071396","cellular response to lipid" -"GO:1904002","regulation of sebum secreting cell proliferation" -"GO:0032848","negative regulation of cellular pH reduction" -"GO:0042751","estivation" -"GO:0042075","nickel incorporation into nickel-iron-sulfur cluster via pentakis-L-cysteinyl L-histidino nickel tetrairon pentasulfide" -"GO:2000725","regulation of cardiac muscle cell differentiation" -"GO:0043323","positive regulation of natural killer cell degranulation" -"GO:0070159","mitochondrial threonyl-tRNA aminoacylation" -"GO:1905309","positive regulation of cohesin loading" -"GO:0071545","inositol phosphate catabolic process" -"GO:0050832","defense response to fungus" -"GO:1901407","regulation of phosphorylation of RNA polymerase II C-terminal domain" -"GO:0071230","cellular response to amino acid stimulus" -"GO:1903613","regulation of protein tyrosine phosphatase activity" -"GO:0099645","neurotransmitter receptor localization to postsynaptic specialization membrane" -"GO:0061914","negative regulation of growth plate cartilage chondrocyte proliferation" -"GO:0061454","release of sequestered calcium ion into cytosol by Golgi" -"GO:0035362","protein-DNA ISRE complex assembly" -"GO:0071227","cellular response to molecule of oomycetes origin" -"GO:0045780","positive regulation of bone resorption" -"GO:0055064","chloride ion homeostasis" -"GO:0003422","growth plate cartilage morphogenesis" -"GO:0030223","neutrophil differentiation" -"GO:0048497","maintenance of floral organ identity" -"GO:0032409","regulation of transporter activity" -"GO:0021747","cochlear nucleus development" -"GO:1905113","positive regulation of centromere clustering at the mitotic nuclear envelope" -"GO:0038158","granulocyte colony-stimulating factor signaling pathway" -"GO:0000706","meiotic DNA double-strand break processing" -"GO:0014720","tonic skeletal muscle contraction" -"GO:0071898","regulation of estrogen receptor binding" -"GO:1990299","Bub1-Bub3 complex localization to kinetochore" -"GO:1905704","positive regulation of inhibitory synapse assembly" -"GO:0097400","interleukin-17-mediated signaling pathway" -"GO:0032418","lysosome localization" -"GO:0043575","detection of osmotic stimulus" -"GO:1902163","negative regulation of DNA damage response, signal transduction by p53 class mediator resulting in transcription of p21 class mediator" -"GO:0035768","endothelial cell chemotaxis to fibroblast growth factor" -"GO:0034158","toll-like receptor 8 signaling pathway" -"GO:1902614","positive regulation of anti-Mullerian hormone signaling pathway" -"GO:0001845","phagolysosome assembly" -"GO:2000647","negative regulation of stem cell proliferation" -"GO:1901722","regulation of cell proliferation involved in kidney development" -"GO:0014703","oscillatory muscle contraction" -"GO:1902240","positive regulation of intrinsic apoptotic signaling pathway in response to osmotic stress by p53 class mediator" -"GO:0002767","immune response-inhibiting cell surface receptor signaling pathway" -"GO:0071621","granulocyte chemotaxis" -"GO:0048753","pigment granule organization" -"GO:0061179","negative regulation of insulin secretion involved in cellular response to glucose stimulus" -"GO:0010970","transport along microtubule" -"GO:0001842","neural fold formation" -"GO:0010493","Lewis a epitope biosynthetic process" -"GO:1904389","rod bipolar cell differentiation" -"GO:0070673","response to interleukin-18" -"GO:0032736","positive regulation of interleukin-13 production" -"GO:1902017","regulation of cilium assembly" -"GO:0006336","DNA replication-independent nucleosome assembly" -"GO:1901289","succinyl-CoA catabolic process" -"GO:0031915","positive regulation of synaptic plasticity" -"GO:2000221","negative regulation of pseudohyphal growth" -"GO:0051594","detection of glucose" -"GO:0006346","methylation-dependent chromatin silencing" -"GO:1990266","neutrophil migration" -"GO:1904979","negative regulation of endosome organization" -"GO:1990953","intramanchette transport" -"GO:0042665","regulation of ectodermal cell fate specification" -"GO:0070458","cellular detoxification of nitrogen compound" -"GO:0035425","autocrine signaling" -"GO:1902806","regulation of cell cycle G1/S phase transition" -"GO:0007098","centrosome cycle" -"GO:1904901","positive regulation of myosin II filament organization" -"GO:0017145","stem cell division" -"GO:0097230","cell motility in response to potassium ion" -"GO:0052696","flavonoid glucuronidation" -"GO:0032366","intracellular sterol transport" -"GO:0061939","c-di-GMP signaling" -"GO:0046093","deoxycytidine biosynthetic process" -"GO:0010742","macrophage derived foam cell differentiation" -"GO:0003385","cell-cell signaling involved in amphid sensory organ development" -"GO:0070358","actin polymerization-dependent cell motility" -"GO:0090281","negative regulation of calcium ion import" -"GO:1902667","regulation of axon guidance" -"GO:0042463","ocellus photoreceptor cell development" -"GO:1902904","negative regulation of supramolecular fiber organization" -"GO:0020014","schizogony" -"GO:0007495","visceral mesoderm-endoderm interaction involved in midgut development" -"GO:0042593","glucose homeostasis" -"GO:0051614","inhibition of serotonin uptake" -"GO:0045581","negative regulation of T cell differentiation" -"GO:0010481","epidermal cell division" -"GO:0198738","cell-cell signaling by wnt" -"GO:0030920","peptidyl-serine acetylation" -"GO:0010941","regulation of cell death" -"GO:0046373","L-arabinose metabolic process" -"GO:0035623","renal glucose absorption" -"GO:0035542","regulation of SNARE complex assembly" -"GO:0032387","negative regulation of intracellular transport" -"GO:0015718","monocarboxylic acid transport" -"GO:0080155","regulation of double fertilization forming a zygote and endosperm" -"GO:0110094","polyphosphate-mediated signaling" -"GO:1901456","positive regulation of response to toluene" -"GO:0051101","regulation of DNA binding" -"GO:0097722","sperm motility" -"GO:0060260","regulation of transcription initiation from RNA polymerase II promoter" -"GO:0015946","methanol oxidation" -"GO:0060751","branch elongation involved in mammary gland duct branching" -"GO:0015704","cyanate transport" -"GO:0031508","pericentric heterochromatin assembly" -"GO:0090511","periclinal cell division" -"GO:1901646","negative regulation of synoviocyte proliferation" -"GO:1900344","positive regulation of methane biosynthetic process from dimethyl sulfide" -"GO:0021864","radial glial cell division in forebrain" -"GO:0048937","lateral line nerve glial cell development" -"GO:0099536","synaptic signaling" -"GO:0003423","growth plate cartilage chondrocyte division" -"GO:0051348","negative regulation of transferase activity" -"GO:0006616","SRP-dependent cotranslational protein targeting to membrane, translocation" -"GO:0090247","cell motility involved in somitogenic axis elongation" -"GO:0048640","negative regulation of developmental growth" -"GO:0002248","connective tissue replacement involved in inflammatory response wound healing" -"GO:1905531","positive regulation of uracil import across plasma membrane" -"GO:0016477","cell migration" -"GO:1902242","copal-8-ol diphosphate(3-) catabolic process" -"GO:1900126","negative regulation of hyaluronan biosynthetic process" -"GO:0110089","regulation of hippocampal neuron apoptotic process" -"GO:0060804","positive regulation of Wnt signaling pathway by BMP signaling pathway" -"GO:0007284","spermatogonial cell division" -"GO:2000415","positive regulation of fibronectin-dependent thymocyte migration" -"GO:1903408","positive regulation of sodium:potassium-exchanging ATPase activity" -"GO:0002543","activation of blood coagulation via clotting cascade" -"GO:1904116","response to vasopressin" -"GO:0034137","positive regulation of toll-like receptor 2 signaling pathway" -"GO:0045414","regulation of interleukin-8 biosynthetic process" -"GO:1901524","regulation of mitophagy" -"GO:0050923","regulation of negative chemotaxis" -"GO:0001539","cilium or flagellum-dependent cell motility" -"GO:0044053","translocation of peptides or proteins into host cell cytoplasm" -"GO:0015853","adenine transport" -"GO:1904003","negative regulation of sebum secreting cell proliferation" -"GO:0043405","regulation of MAP kinase activity" -"GO:0003365","establishment of cell polarity involved in ameboidal cell migration" -"GO:0050654","chondroitin sulfate proteoglycan metabolic process" -"GO:0097036","regulation of plasma membrane sterol distribution" -"GO:0070684","seminal clot liquefaction" -"GO:0017004","cytochrome complex assembly" -"GO:2000825","positive regulation of androgen receptor activity" -"GO:1902482","regulatory T cell apoptotic process" -"GO:0060900","embryonic camera-type eye formation" -"GO:0033601","positive regulation of mammary gland epithelial cell proliferation" -"GO:0042304","regulation of fatty acid biosynthetic process" -"GO:2000458","regulation of astrocyte chemotaxis" -"GO:0097231","cell motility in response to calcium ion" -"GO:0021980","subpallium cell migration" -"GO:1903376","regulation of oxidative stress-induced neuron intrinsic apoptotic signaling pathway" -"GO:1990867","response to gastrin" -"GO:0032963","collagen metabolic process" -"GO:0043435","response to corticotropin-releasing hormone" -"GO:0009865","pollen tube adhesion" -"GO:0042482","positive regulation of odontogenesis" -"GO:1905693","regulation of phosphatidic acid biosynthetic process" -"GO:0015728","mevalonate transport" -"GO:0070184","mitochondrial tyrosyl-tRNA aminoacylation" -"GO:0048137","spermatocyte division" -"GO:0034767","positive regulation of ion transmembrane transport" -"GO:0006217","deoxycytidine catabolic process" -"GO:0045210","FasL biosynthetic process" -"GO:0060656","regulation of branching involved in mammary cord morphogenesis by fat precursor cell-epithelial cell signaling" -"GO:0072596","establishment of protein localization to chloroplast" -"GO:0008356","asymmetric cell division" -"GO:0051780","behavioral response to nutrient" -"GO:1902304","positive regulation of potassium ion export" -"GO:1990680","response to melanocyte-stimulating hormone" -"GO:0005987","sucrose catabolic process" -"GO:0071337","negative regulation of hair follicle cell proliferation" -"GO:0061116","ductus venosus closure" -"GO:0052697","xenobiotic glucuronidation" -"GO:1905937","negative regulation of germ cell proliferation" -"GO:0021805","cell movement involved in somal translocation" -"GO:0045382","negative regulation of interleukin-18 biosynthetic process" -"GO:0000320","re-entry into mitotic cell cycle" -"GO:0036309","protein localization to M-band" -"GO:1900658","regulation of emericellamide biosynthetic process" -"GO:0050796","regulation of insulin secretion" -"GO:1905907","negative regulation of amyloid fibril formation" -"GO:1900095","regulation of dosage compensation by inactivation of X chromosome" -"GO:0098812","nuclear rRNA polyadenylation involved in polyadenylation-dependent rRNA catabolic process" -"GO:0072043","regulation of pre-tubular aggregate formation by cell-cell signaling" -"GO:1901877","negative regulation of calcium ion binding" -"GO:0010699","cell-cell signaling involved in quorum sensing" -"GO:0043385","mycotoxin metabolic process" -"GO:1904845","cellular response to L-glutamine" -"GO:0000197","activation of MAPKKK activity involved in cell wall organization or biogenesis" -"GO:0097700","vascular endothelial cell response to laminar fluid shear stress" -"GO:0060680","lateral sprouting involved in ureteric bud morphogenesis" -"GO:0044144","modulation of growth of symbiont involved in interaction with host" -"GO:0031065","positive regulation of histone deacetylation" -"GO:0030011","maintenance of cell polarity" -"GO:0098997","fusion of virus membrane with host outer membrane" -"GO:0040016","embryonic cleavage" -"GO:0061909","autophagosome-lysosome fusion" -"GO:0032667","regulation of interleukin-23 production" -"GO:0071975","cell swimming" -"GO:0014859","negative regulation of skeletal muscle cell proliferation" -"GO:1900931","positive regulation of L-tyrosine import across plasma membrane" -"GO:0000167","activation of MAPKKK activity involved in osmosensory signaling pathway" -"GO:0045222","CD4 biosynthetic process" -"GO:0046931","pore complex assembly" -"GO:0140146","calcium ion import into vacuole" -"GO:0036300","B cell receptor internalization" -"GO:1901036","positive regulation of L-glutamine import across plasma membrane" -"GO:1904552","regulation of chemotaxis to arachidonic acid" -"GO:0014872","myoblast division" -"GO:0044079","modulation by symbiont of host neurotransmitter secretion" -"GO:0002256","regulation of kinin cascade" -"GO:0080001","mucilage extrusion from seed coat" -"GO:0035879","plasma membrane lactate transport" -"GO:0021748","dorsal cochlear nucleus development" -"GO:0006113","fermentation" -"GO:1901585","regulation of acid-sensing ion channel activity" -"GO:1904615","cellular response to biphenyl" -"GO:1904923","regulation of autophagy of mitochondrion in response to mitochondrial depolarization" -"GO:0032251","positive regulation of adenosine transport" -"GO:0006948","induction by virus of host cell-cell fusion" -"GO:0042655","activation of JNKKK activity" -"GO:2000632","negative regulation of pre-miRNA processing" -"GO:0097045","phosphatidylserine exposure on blood platelet" -"GO:0007532","regulation of mating-type specific transcription, DNA-templated" -"GO:0060945","cardiac neuron differentiation" -"GO:1905876","positive regulation of postsynaptic density organization" -"GO:1900092","negative regulation of raffinose biosynthetic process" -"GO:2000723","negative regulation of cardiac vascular smooth muscle cell differentiation" -"GO:2000869","positive regulation of estrone secretion" -"GO:2000442","positive regulation of toll-like receptor 15 signaling pathway" -"GO:0019228","neuronal action potential" -"GO:0031107","septin ring disassembly" -"GO:0019553","glutamate catabolic process via L-citramalate" -"GO:0000052","citrulline metabolic process" -"GO:0032958","inositol phosphate biosynthetic process" -"GO:0015607","fatty-acyl-CoA transmembrane transporter activity" -"GO:1990577","C-terminal protein demethylation" -"GO:0019555","glutamate catabolic process to ornithine" -"GO:0036088","D-serine catabolic process" -"GO:0038116","chemokine (C-C motif) ligand 21 signaling pathway" -"GO:0048474","D-methionine transmembrane transporter activity" -"GO:0048789","cytoskeletal matrix organization at active zone" -"GO:0009308","amine metabolic process" -"GO:0021542","dentate gyrus development" -"GO:1904731","positive regulation of intestinal lipid absorption" -"GO:0042274","ribosomal small subunit biogenesis" -"GO:0009964","negative regulation of flavonoid biosynthetic process" -"GO:0075258","negative regulation of teliospore formation" -"GO:0032217","riboflavin transmembrane transporter activity" -"GO:0015721","bile acid and bile salt transport" -"GO:0045967","negative regulation of growth rate" -"GO:0051796","negative regulation of timing of catagen" -"GO:0075077","negative regulation by host of symbiont adenylate cyclase activity" -"GO:0030954","astral microtubule nucleation" -"GO:0046604","positive regulation of mitotic centrosome separation" -"GO:0003139","secondary heart field specification" -"GO:0048699","generation of neurons" -"GO:0090239","regulation of histone H4 acetylation" -"GO:0098958","retrograde axonal transport of mitochondrion" -"GO:0031577","spindle checkpoint" -"GO:2000833","positive regulation of steroid hormone secretion" -"GO:1901731","positive regulation of platelet aggregation" -"GO:0075254","negative regulation of uredospore formation" -"GO:0009624","response to nematode" -"GO:0098761","cellular response to interleukin-7" -"GO:0070178","D-serine metabolic process" -"GO:0110065","regulation of interphase mitotic telomere clustering" -"GO:1902931","negative regulation of alcohol biosynthetic process" -"GO:0019670","anaerobic glutamate catabolic process" -"GO:0061606","N-terminal protein amino acid propionylation" -"GO:0030399","autophagosome membrane disassembly" -"GO:0002235","detection of unfolded protein" -"GO:1902234","positive regulation of positive thymic T cell selection" -"GO:2000467","positive regulation of glycogen (starch) synthase activity" -"GO:0007388","posterior compartment specification" -"GO:1901607","alpha-amino acid biosynthetic process" -"GO:0060583","regulation of actin cortical patch localization" -"GO:0046491","L-methylmalonyl-CoA metabolic process" -"GO:0007374","posterior midgut invagination" -"GO:0001805","positive regulation of type III hypersensitivity" -"GO:0048209","regulation of vesicle targeting, to, from or within Golgi" -"GO:0060572","morphogenesis of an epithelial bud" -"GO:0014813","skeletal muscle satellite cell commitment" -"GO:0006610","ribosomal protein import into nucleus" -"GO:0045638","negative regulation of myeloid cell differentiation" -"GO:0060068","vagina development" -"GO:0038159","C-X-C chemokine receptor CXCR4 signaling pathway" -"GO:0034120","positive regulation of erythrocyte aggregation" -"GO:0071840","cellular component organization or biogenesis" -"GO:0033514","L-lysine catabolic process to acetyl-CoA via L-pipecolate" -"GO:0042904","9-cis-retinoic acid biosynthetic process" -"GO:2000842","positive regulation of dehydroepiandrosterone secretion" -"GO:0000200","inactivation of MAPK activity involved in cell wall organization or biogenesis" -"GO:0032773","positive regulation of monophenol monooxygenase activity" -"GO:0002553","histamine secretion by mast cell" -"GO:0031327","negative regulation of cellular biosynthetic process" -"GO:0009082","branched-chain amino acid biosynthetic process" -"GO:1903592","positive regulation of lysozyme activity" -"GO:0061984","catabolite repression" -"GO:0021505","neural fold folding" -"GO:1900122","positive regulation of receptor binding" -"GO:0033508","glutamate catabolic process to butyrate" -"GO:1904944","positive regulation of cardiac ventricle formation" -"GO:0019547","arginine catabolic process to ornithine" -"GO:0055130","D-alanine catabolic process" -"GO:0046943","carboxylic acid transmembrane transporter activity" -"GO:0060117","auditory receptor cell development" -"GO:0036376","sodium ion export across plasma membrane" -"GO:0010558","negative regulation of macromolecule biosynthetic process" -"GO:2000519","positive regulation of T-helper 1 cell activation" -"GO:1902683","regulation of receptor localization to synapse" -"GO:0007154","cell communication" -"GO:0070988","demethylation" -"GO:1905948","3',5'-cyclic GMP transmembrane-transporting ATPase activity" -"GO:0106020","regulation of vesicle docking" -"GO:1903169","regulation of calcium ion transmembrane transport" -"GO:0035783","CD4-positive, alpha-beta T cell costimulation" -"GO:1900377","negative regulation of secondary metabolite biosynthetic process" -"GO:0048893","afferent axon development in lateral line nerve" -"GO:0050665","hydrogen peroxide biosynthetic process" -"GO:0006446","regulation of translational initiation" -"GO:1905267","endonucleolytic cleavage involved in tRNA processing" -"GO:0038016","insulin receptor internalization" -"GO:1905430","cellular response to glycine" -"GO:0098700","neurotransmitter loading into synaptic vesicle" -"GO:0002933","lipid hydroxylation" -"GO:0044610","FMN transmembrane transporter activity" -"GO:0019086","late viral transcription" -"GO:0018410","C-terminal protein amino acid modification" -"GO:0051013","microtubule severing" -"GO:1901812","beta-carotene biosynthetic process" -"GO:1901282","fructoselysine biosynthetic process" -"GO:0050878","regulation of body fluid levels" -"GO:0032053","ciliary basal body organization" -"GO:0060005","vestibular reflex" -"GO:0035545","determination of left/right asymmetry in nervous system" -"GO:0042425","choline biosynthetic process" -"GO:0055034","Bolwig's organ development" -"GO:0010985","negative regulation of lipoprotein particle clearance" -"GO:0051935","glutamate reuptake" -"GO:0021670","lateral ventricle development" -"GO:0045567","negative regulation of TRAIL receptor 2 biosynthetic process" -"GO:0034173","positive regulation of toll-like receptor 11 signaling pathway" -"GO:0034161","positive regulation of toll-like receptor 8 signaling pathway" -"GO:0061197","fungiform papilla morphogenesis" -"GO:0009635","response to herbicide" -"GO:0019436","sophorosyloxydocosanoate catabolic process" -"GO:0036031","recruitment of mRNA capping enzyme to RNA polymerase II holoenzyme complex" -"GO:0015247","aminophospholipid transmembrane transporter activity" -"GO:0019666","nitrogenous compound fermentation" -"GO:0043697","cell dedifferentiation" -"GO:0051282","regulation of sequestering of calcium ion" -"GO:0032373","positive regulation of sterol transport" -"GO:0071387","cellular response to cortisol stimulus" -"GO:0009812","flavonoid metabolic process" -"GO:2000145","regulation of cell motility" -"GO:2000570","positive regulation of T-helper 2 cell activation" -"NCBIGene:100616481","MIR4423" -"NCBIGene:100847057","MIR5189" -"NCBIGene:693222","MIR637" -"NCBIGene:102464833","MIR6084" -"NCBIGene:100422891","MIR4327" -"NCBIGene:100847093","MIR5589" -"NCBIGene:100500904","MIR3942" -"NCBIGene:406929","MIR138-1" -"NCBIGene:693177","MIR592" -"NCBIGene:100500831","MIR3912" -"NCBIGene:693189","MIR604" -"NCBIGene:100616434","MIR4755" -"NCBIGene:100423008","MIR3118-1" -"NCBIGene:406998","MIR216A" -"NCBIGene:100422854","MIR3187" -"NCBIGene:574501","MIR499A" -"NCBIGene:100616410","MIR4692" -"NCBIGene:100847069","MIR5590" -"NCBIGene:100422832","MIR3191" -"NCBIGene:102465518","MIR6860" -"NCBIGene:100616381","MIR4456" -"NCBIGene:100616277","MIR4522" -"NCBIGene:100302284","MIR1303" -"NCBIGene:100847075","MIR5685" -"NCBIGene:100126348","MIR760" -"NCBIGene:100302170","MIR1206" -"NCBIGene:100302148","MIR1263" -"NCBIGene:100422892","MIR3157" -"NCBIGene:406908","MIR124-2" -"NCBIGene:102465525","MIR6870" -"NCBIGene:100616225","MIR4756" -"NCBIGene:102465857","MIR7976" -"NCBIGene:574513","MIR508" -"NCBIGene:102466911","MIR6785" -"NCBIGene:100616123","MIR4436B1" -"NCBIGene:100616458","MIR5095" -"NCBIGene:102466658","MIR6510" -"NCBIGene:100423016","MIR3159" -"NCBIGene:574498","MIR516A1" -"NCBIGene:100302113","MIR1200" -"NCBIGene:100422846","MIR3164" -"NCBIGene:100616181","MIR4514" -"NCBIGene:100616326","MIR4636" -"NCBIGene:574434","MIR410" -"NCBIGene:100422897","MIR4302" -"NCBIGene:100500878","MIR3679" -"NCBIGene:102466814","MIR7151" -"NCBIGene:100302167","MIR1299" -"NCBIGene:102466225","MIR6077" -"NCBIGene:574452","MIR494" -"NCBIGene:100616233","MIR4459" -"NCBIGene:100847001","MIR5680" -"NCBIGene:406966","MIR191" -"NCBIGene:100500824","MIR3650" -"NCBIGene:100847031","MIR5700" -"NCBIGene:642587","MIR205HG" -"NCBIGene:406959","MIR183" -"NCBIGene:100847071","MIR5684" -"NCBIGene:407020","MIR28" -"NCBIGene:100616170","MIR4739" -"NCBIGene:100302171","MIR1321" -"NCBIGene:442912","MIR367" -"NCBIGene:693213","MIR628" -"NCBIGene:442907","MIR339" -"NCBIGene:100423011","MIR3138" -"NCBIGene:102465253","MIR6507" -"NCBIGene:100616306","MIR378H" -"NCBIGene:102465438","MIR6732" -"NCBIGene:102465429","MIR6511B1" -"NCBIGene:693188","MIR603" -"NCBIGene:100616171","MIR4752" -"NCBIGene:100616288","MIR4665" -"NCBIGene:100422950","MIR3141" -"NCBIGene:574515","MIR510" -"NCBIGene:102466967","MIR6130" -"NCBIGene:100126355","MIR365A" -"NCBIGene:100500840","MIR3656" -"NCBIGene:100302193","MIR1255A" -"NCBIGene:442898","MIR324" -"NCBIGene:664615","MIR376A2" -"NCBIGene:442905","MIR337" -"NCBIGene:102466738","MIR6798" -"NCBIGene:102466737","MIR6793" -"NCBIGene:100313835","MIR1255B2" -"NCBIGene:693163","MIR578" -"NCBIGene:768220","MIR765" -"NCBIGene:100302115","MIR1468" -"NCBIGene:100616126","MIR4686" -"NCBIGene:693137","MIR552" -"NCBIGene:100616204","MIR4729" -"NCBIGene:102465255","MIR6512" -"NCBIGene:100616320","MIR4481" -"NCBIGene:100422979","MIR4324" -"NCBIGene:100616495","MIR2392" -"NCBIGene:100302126","MIR1471" -"NCBIGene:100616441","MIR4474" -"NCBIGene:102465479","MIR6799" -"NCBIGene:406926","MIR135A2" -"NCBIGene:693136","MIR551B" -"NCBIGene:100500819","MIR3609" -"NCBIGene:768218","MIR766" -"NCBIGene:100422918","MIR3167" -"NCBIGene:100616167","MIR4722" -"NCBIGene:100616368","MIR4688" -"NCBIGene:406984","MIR200B" -"NCBIGene:100422940","MIR4305" -"NCBIGene:724031","MIR661" -"NCBIGene:574469","MIR519B" -"NCBIGene:102466742","MIR6818" -"NCBIGene:100616294","MIR4740" -"NCBIGene:100302196","MIR1234" -"NCBIGene:102465254","MIR6509" -"NCBIGene:494325","MIR376A1" -"NCBIGene:693167","MIR582" -"NCBIGene:100422985","MIR1184-2" -"NCBIGene:407019","MIR27B" -"NCBIGene:100302267","MIR2054" -"NCBIGene:100847055","MIR5697" -"NCBIGene:100500873","MIR3934" -"NCBIGene:100423029","MIR3163" -"NCBIGene:494326","MIR377" -"NCBIGene:100422859","MIR3136" -"NCBIGene:100500801","MIR3659" -"NCBIGene:407042","MIR34C" -"NCBIGene:100500832","MIR3658" -"NCBIGene:406989","MIR206" -"NCBIGene:100847059","MIR5094" -"NCBIGene:768222","MIR770" -"NCBIGene:442895","MIR302C" -"NCBIGene:100422988","MIR3156-1" -"NCBIGene:102467004","MIR8053" -"NCBIGene:100616219","MIR4765" -"NCBIGene:100616111","MIR4455" -"NCBIGene:100500812","MIR3677" -"NCBIGene:100847051","MIR5194" -"NCBIGene:100500914","MIR3610" -"NCBIGene:100313886","MIR2116" -"NCBIGene:100422937","MIR4275" -"NCBIGene:406905","MIR1-2" -"NCBIGene:100616459","MIR4745" -"NCBIGene:102466728","MIR6754" -"NCBIGene:100422896","MIR3140" -"NCBIGene:574478","MIR524" -"NCBIGene:100422887","MIR4280" -"NCBIGene:693173","MIR588" -"NCBIGene:100616168","MIR4754" -"NCBIGene:442919","MIR374A" -"NCBIGene:100500889","MIR3657" -"NCBIGene:100500811","MIR3621" -"NCBIGene:574474","MIR518B" -"NCBIGene:102465455","MIR6760" -"NCBIGene:100500833","MIR3653" -"NCBIGene:574441","MIR488" -"NCBIGene:406967","MIR192" -"NCBIGene:406997","MIR215" -"NCBIGene:100616221","MIR4662A" -"NCBIGene:102466722","MIR6730" -"NCBIGene:102466656","MIR6500" -"NCBIGene:100616122","MIR4523" -"NCBIGene:100423015","MIR4289" -"NCBIGene:100847009","MIR1295B" -"NCBIGene:724030","MIR660" -"NCBIGene:100423001","MIR3145" -"NCBIGene:100422932","MIR4328" -"NCBIGene:100302144","MIR1912" -"NCBIGene:100616318","MIR4664" -"NCBIGene:100422962","MIR4281" -"NCBIGene:102464817","MIR5787" -"NCBIGene:100616133","MIR4699" -"NCBIGene:100422929","MIR4261" -"NCBIGene:102465866","MIR8064" -"NCBIGene:693194","MIR609" -"NCBIGene:102466756","MIR6879" -"NCBIGene:100616238","MIR3529" -"NCBIGene:100313777","MIR670" -"NCBIGene:574436","MIR485" -"NCBIGene:100422851","MIR4316" -"NCBIGene:100422980","MIR4323" -"NCBIGene:100847013","MIR5692B" -"NCBIGene:100500915","MIR3915" -"NCBIGene:407049","MIR92A2" -"NCBIGene:768216","MIR454" -"NCBIGene:100847082","MIR5692C1" -"NCBIGene:693133","MIR550A1" -"NCBIGene:406903","MIR10B" -"NCBIGene:407052","MIR95" -"NCBIGene:693185","MIR600" -"NCBIGene:100616343","MIR4677" -"NCBIGene:100616117","MIR4653" -"NCBIGene:102466195","MIR6780A" -"NCBIGene:406882","MIRLET7A2" -"NCBIGene:100422964","MIR3150A" -"NCBIGene:406918","MIR129-2" -"NCBIGene:102465524","MIR6869" -"NCBIGene:100302218","MIR1285-1" -"NCBIGene:442902","MIR330" -"NCBIGene:100313774","MIR302E" -"NCBIGene:406974","MIR197" -"NCBIGene:100847024","MIR5698" -"NCBIGene:693226","MIR641" -"NCBIGene:102465875","MIR8077" -"NCBIGene:100616152","MIR4804" -"NCBIGene:693178","MIR593" -"NCBIGene:100126332","MIR943" -"NCBIGene:494330","MIR381" -"NCBIGene:102465133","MIR6125" -"NCBIGene:100847042","MIR5572" -"NCBIGene:406965","MIR190A" -"NCBIGene:100302150","MIR1296" -"NCBIGene:102465840","MIR7854" -"NCBIGene:100616208","MIR4782" -"NCBIGene:693196","MIR611" -"NCBIGene:100302209","MIR1185-2" -"NCBIGene:693172","MIR587" -"NCBIGene:102465523","MIR6867" -"NCBIGene:100313779","MIR2117" -"NCBIGene:100847004","MIR5188" -"NCBIGene:100302181","MIR1294" -"NCBIGene:100423028","MIR4254" -"NCBIGene:693228","MIR643" -"NCBIGene:102465833","MIR4433B" -"NCBIGene:100616273","MIR451B" -"NCBIGene:100847007","MIR5696" -"NCBIGene:693126","MIR548A2" -"NCBIGene:100302121","MIR1276" -"NCBIGene:574481","MIR521-2" -"NCBIGene:100500804","MIR3654" -"NCBIGene:100616438","MIR4632" -"NCBIGene:407033","MIR30D" -"NCBIGene:406944","MIR153-1" -"NCBIGene:100847053","MIR5702" -"NCBIGene:100500912","MIR3674" -"NCBIGene:100616210","MIR4737" -"NCBIGene:100616254","MIR548AH" -"NCBIGene:102465136","MIR378J" -"NCBIGene:693205","MIR620" -"NCBIGene:100422904","MIR3193" -"NCBIGene:100847016","MIR5695" -"NCBIGene:100302202","MIR1266" -"NCBIGene:102465472","MIR6787" -"NCBIGene:102465482","MIR6804" -"NCBIGene:100126328","MIR940" -"NCBIGene:406980","MIR19B1" -"NCBIGene:100616127","MIR4448" -"NCBIGene:100847050","MIR5191" -"NCBIGene:693147","MIR562" -"NCBIGene:102466982","MIR6729" -"NCBIGene:100616451","MIR4471" -"NCBIGene:100616362","MIR4533" -"NCBIGene:693169","MIR584" -"NCBIGene:100500879","MIR3668" -"NCBIGene:100313781","MIR718" -"NCBIGene:100616260","MIR4663" -"NCBIGene:100422881","MIR3170" -"NCBIGene:100616452","MIR2682" -"NCBIGene:100126321","MIR922" -"NCBIGene:100126336","MIR208B" -"NCBIGene:100500852","MIR3180-4" -"NCBIGene:693168","MIR583" -"NCBIGene:100500821","MIR3910-1" -"NCBIGene:100616375","MIR4438" -"NCBIGene:100422986","MIR3125" -"NCBIGene:100616230","MIR4646" -"NCBIGene:100500900","MIR3691" -"NCBIGene:574505","MIR450A2" -"NCBIGene:100126341","MIR891A" -"NCBIGene:100847087","MIR5192" -"NCBIGene:100423023","MIR3197" -"NCBIGene:100616185","MIR371B" -"NCBIGene:693218","MIR633" -"NCBIGene:102465137","MIR6129" -"NCBIGene:100422861","MIR4306" -"NCBIGene:102465509","MIR6846" -"NCBIGene:494323","MIR361" -"NCBIGene:102466729","MIR6759" -"NCBIGene:100616454","MIR4497" -"NCBIGene:406927","MIR136" -"NCBIGene:100500917","MIR3680-1" -"NCBIGene:100126329","MIR941-1" -"NCBIGene:100616492","MIR378F" -"NCBIGene:100846993","MIR5009" -"NCBIGene:574412","MIR452" -"NCBIGene:693161","MIR576" -"NCBIGene:693190","MIR605" -"NCBIGene:574467","MIR520A" -"NCBIGene:100847010","MIR5581" -"NCBIGene:100422976","MIR4256" -"NCBIGene:102465539","MIR6895" -"NCBIGene:100616141","MIR4428" -"NCBIGene:102465430","MIR6718" -"NCBIGene:102465139","MIR6133" -"NCBIGene:693154","MIR569" -"NCBIGene:574483","MIR517B" -"NCBIGene:693120","MIR33B" -"NCBIGene:100616436","MIR4449" -"NCBIGene:100616315","MIR4781" -"NCBIGene:102465475","MIR6792" -"NCBIGene:100313772","MIR548M" -"NCBIGene:407007","MIR222" -"NCBIGene:406995","MIR181A1" -"NCBIGene:407006","MIR221" -"NCBIGene:100616211","MIR4709" -"NCBIGene:100616266","MIR4733" -"NCBIGene:100847058","MIR5681A" -"NCBIGene:100616172","MIR4719" -"NCBIGene:102466743","MIR6822" -"NCBIGene:100500875","MIR3938" -"NCBIGene:407036","MIR32" -"NCBIGene:102466815","MIR7155" -"NCBIGene:100126320","MIR920" -"NCBIGene:406940","MIR148A" -"NCBIGene:102465528","MIR6877" -"NCBIGene:102466516","MIR6071" -"NCBIGene:100302289","MIR1251" -"NCBIGene:693206","MIR621" -"NCBIGene:100847072","MIR5008" -"NCBIGene:100422882","MIR3120" -"NCBIGene:100302288","MIR548P" -"NCBIGene:100847054","MIR5588" -"NCBIGene:102465441","MIR6737" -"NCBIGene:574470","MIR525" -"NCBIGene:100500803","MIR3919" -"NCBIGene:100500829","MIR3943" -"NCBIGene:100302220","MIR1293" -"NCBIGene:102466203","MIR6874" -"NCBIGene:100847062","MIR5195" -"NCBIGene:100616370","MIR4771-1" -"NCBIGene:100616457","MIR4693" -"NCBIGene:100423026","MIR4299" -"NCBIGene:100422993","MIR3130-1" -"NCBIGene:102465856","MIR7974" -"NCBIGene:406910","MIR125A" -"NCBIGene:102465519","MIR6861" -"NCBIGene:100302163","MIR1278" -"NCBIGene:102466747","MIR6840" -"NCBIGene:406911","MIR125B1" -"NCBIGene:102465491","MIR6819" -"NCBIGene:100500845","MIR642B" -"NCBIGene:574482","MIR520D" -"NCBIGene:100423014","MIR3196" -"NCBIGene:102465497","MIR6828" -"NCBIGene:406972","MIR196A1" -"NCBIGene:102465520","MIR6862-1" -"NCBIGene:100847085","MIR5706" -"NCBIGene:100500841","MIR3678" -"NCBIGene:574495","MIR522" -"NCBIGene:100616299","MIR4450" -"NCBIGene:102465978","MIR6850" -"NCBIGene:100422960","MIR3179-1" -"NCBIGene:619556","MIR455" -"NCBIGene:100616115","MIR4469" -"NCBIGene:100616406","MIR4521" -"NCBIGene:100616121","MIR1268B" -"NCBIGene:102466725","MIR6744" -"NCBIGene:100616177","MIR4419A" -"NCBIGene:406899","MIR106A" -"NCBIGene:102466162","MIR548AZ" -"NCBIGene:100126331","MIR942" -"NCBIGene:100126335","MIR543" -"NCBIGene:406902","MIR10A" -"NCBIGene:406937","MIR145" -"NCBIGene:100422880","MIR3162" -"NCBIGene:100616283","MIR4766" -"NCBIGene:102465469","MIR6782" -"NCBIGene:100500911","MIR3944" -"NCBIGene:100422991","MIR1260B" -"NCBIGene:574473","MIR520B" -"NCBIGene:102466995","MIR7156" -"NCBIGene:100302174","MIR1307" -"NCBIGene:100422927","MIR4291" -"NCBIGene:100616376","MIR4492" -"NCBIGene:100616393","MIR4657" -"NCBIGene:100422953","MIR3165" -"NCBIGene:406950","MIR16-1" -"NCBIGene:100500844","MIR3664" -"NCBIGene:574444","MIR491" -"NCBIGene:100422856","MIR3123" -"NCBIGene:102464836","MIR6088" -"NCBIGene:100187716","MIR1224" -"NCBIGene:100616189","MIR4421" -"NCBIGene:100616470","MIR4488" -"NCBIGene:100616248","MIR4724" -"NCBIGene:102465134","MIR6126" -"NCBIGene:102464827","MIR6074" -"NCBIGene:100846994","MIR3670-2" -"NCBIGene:102465436","MIR6728" -"NCBIGene:100422840","MIR4317" -"NCBIGene:102465514","MIR6854" -"NCBIGene:100616281","MIR4788" -"NCBIGene:102465507","MIR6842" -"NCBIGene:100616142","MIR4458" -"NCBIGene:100616399","MIR4436A" -"NCBIGene:574461","MIR520E" -"NCBIGene:574503","MIR501" -"NCBIGene:100422972","MIR3181" -"NCBIGene:100846996","MIR5007" -"NCBIGene:100302281","MIR1208" -"NCBIGene:407016","MIR26A2" -"NCBIGene:100422849","MIR548T" -"NCBIGene:100846992","MIR548AW" -"NCBIGene:100422867","MIR378C" -"NCBIGene:102465838","MIR7850" -"NCBIGene:102465527","MIR6876" -"NCBIGene:100616280","MIR4503" -"NCBIGene:100422969","MIR2909" -"NCBIGene:100423019","MIR4307" -"NCBIGene:100616338","MIR4794" -"NCBIGene:100302192","MIR548F1" -"NCBIGene:102465535","MIR6888" -"NCBIGene:100302256","MIR1180" -"NCBIGene:406949","MIR15B" -"NCBIGene:100422824","MIR3128" -"NCBIGene:100422944","MIR3186" -"NCBIGene:574456","MIR497" -"NCBIGene:407046","MIR9-1" -"NCBIGene:100616155","MIR4536-1" -"NCBIGene:100302157","MIR1185-1" -"NCBIGene:100616164","MIR4420" -"NCBIGene:102466740","MIR6808" -"NCBIGene:102465944","MIR6072" -"NCBIGene:100616498","MIR378E" -"NCBIGene:100302124","MIR1288" -"NCBIGene:100616191","MIR548AJ1" -"NCBIGene:693138","MIR553" -"NCBIGene:100847048","MIR5690" -"NCBIGene:102466877","MIR8072" -"NCBIGene:100422974","MIR3178" -"NCBIGene:102466193","MIR6757" -"NCBIGene:102465515","MIR6856" -"NCBIGene:100422920","MIR548X" -"NCBIGene:100422848","MIR4283-2" -"NCBIGene:100423038","MIR466" -"NCBIGene:102466986","MIR6866" -"NCBIGene:693183","MIR598" -"NCBIGene:100500825","MIR3660" -"NCBIGene:102466270","MIR6741" -"NCBIGene:100422954","MIR4309" -"NCBIGene:100616364","MIR4785" -"NCBIGene:100616363","MIR4735" -"NCBIGene:574448","MIR202" -"NCBIGene:102465859","MIR7978" -"NCBIGene:574443","MIR490" -"NCBIGene:102465975","MIR6763" -"NCBIGene:102465468","MIR6781" -"NCBIGene:102465451","MIR6753" -"NCBIGene:406969","MIR194-1" -"NCBIGene:693199","MIR614" -"NCBIGene:768219","MIR802" -"NCBIGene:693152","MIR567" -"NCBIGene:102465504","MIR6838" -"NCBIGene:100616175","MIR4633" -"NCBIGene:693156","MIR571" -"NCBIGene:100422909","MIR4295" -"NCBIGene:100847019","MIR5687" -"NCBIGene:102465977","MIR6829" -"NCBIGene:100616139","MIR4741" -"NCBIGene:102465456","MIR6761" -"NCBIGene:102465532","MIR6883" -"NCBIGene:102464826","MIR6073" -"NCBIGene:100302235","MIR1179" -"NCBIGene:100500808","MIR3917" -"NCBIGene:100126318","MIR301B" -"NCBIGene:100616194","MIR4477B" -"NCBIGene:102465512","MIR6851" -"NCBIGene:442914","MIR369" -"NCBIGene:768214","MIR668" -"NCBIGene:102466735","MIR6788" -"NCBIGene:100847025","MIR5583-1" -"NCBIGene:494334","MIR422A" -"NCBIGene:102465669","MIR7113" -"NCBIGene:693162","MIR577" -"NCBIGene:102465447","MIR6747" -"NCBIGene:100616474","MIR4715" -"NCBIGene:100126327","MIR938" -"NCBIGene:574468","MIR526B" -"NCBIGene:100500886","MIR3683" -"NCBIGene:100616394","MIR4444-1" -"NCBIGene:100847077","MIR5688" -"NCBIGene:100422839","MIR3119-1" -"NCBIGene:100500827","MIR3614" -"NCBIGene:100616314","MIR4750" -"NCBIGene:100302286","MIR1267" -"NCBIGene:100616417","MIR4786" -"NCBIGene:100616144","MIR548AN" -"NCBIGene:693200","MIR615" -"NCBIGene:100422996","MIR4262" -"NCBIGene:407015","MIR26A1" -"NCBIGene:100616243","MIR4759" -"NCBIGene:100616257","MIR3975" -"NCBIGene:100616143","MIR4763" -"NCBIGene:100423005","MIR4282" -"NCBIGene:100422843","MIR4293" -"NCBIGene:102466874","MIR8057" -"NCBIGene:100616179","MIR4498" -"NCBIGene:100302114","MIR513C" -"NCBIGene:407048","MIR92A1" -"NCBIGene:100616279","MIR3974" -"NCBIGene:406955","MIR181B1" -"NCBIGene:100302119","MIR1538" -"NCBIGene:574487","MIR518E" -"NCBIGene:494331","MIR382" -"NCBIGene:100422863","MIR4265" -"NCBIGene:406975","MIR198" -"NCBIGene:494336","MIR424" -"NCBIGene:574471","MIR523" -"NCBIGene:574492","MIR517C" -"NCBIGene:100616373","MIR4770" -"NCBIGene:100422889","MIR3194" -"NCBIGene:100302116","MIR1265" -"NCBIGene:102465486","MIR6811" -"NCBIGene:100313778","MIR759" -"NCBIGene:100500872","MIR3911" -"NCBIGene:693121","MIR411" -"NCBIGene:693182","MIR597" -"NCBIGene:100302212","MIR1324" -"NCBIGene:100616193","MIR4453" -"NCBIGene:100616372","MIR4659B" -"NCBIGene:100422879","MIR3124" -"NCBIGene:100616232","MIR4528" -"NCBIGene:693139","MIR554" -"NCBIGene:406920","MIR130B" -"NCBIGene:100423013","MIR4310" -"NCBIGene:100616325","MIR4460" -"NCBIGene:406948","MIR15A" -"NCBIGene:100616353","MIR4532" -"NCBIGene:574496","MIR519A1" -"NCBIGene:100423012","MIR3177" -"NCBIGene:100302237","MIR1281" -"NCBIGene:100847088","MIR5586" -"NCBIGene:100302278","MIR1302-2" -"NCBIGene:574466","MIR519C" -"NCBIGene:100500813","MIR3646" -"NCBIGene:100616448","MIR4792" -"NCBIGene:406917","MIR129-1" -"NCBIGene:102464834","MIR6085" -"NCBIGene:100616149","MIR4512" -"NCBIGene:100500905","MIR3661" -"NCBIGene:100302221","MIR1291" -"NCBIGene:100616307","MIR4757" -"NCBIGene:100616359","MIR4730" -"NCBIGene:407031","MIR30C1" -"NCBIGene:102465691","MIR7154" -"NCBIGene:100616274","MIR4802" -"NCBIGene:102465906","MIR7112" -"NCBIGene:102465140","MIR6134" -"NCBIGene:100616128","MIR4679-1" -"NCBIGene:100302236","MIR1260A" -"NCBIGene:100847076","MIR5580" -"NCBIGene:102465471","MIR6786" -"NCBIGene:100302275","MIR548L" -"NCBIGene:102465692","MIR7157" -"NCBIGene:100302222","MIR1911" -"NCBIGene:100313839","MIR2114" -"NCBIGene:100422934","MIR3143" -"NCBIGene:100847008","MIR4524B" -"NCBIGene:100422915","MIR3065" -"NCBIGene:102465450","MIR6752" -"NCBIGene:102465473","MIR6790" -"NCBIGene:100422981","MIR3173" -"NCBIGene:406941","MIR149" -"NCBIGene:100302183","MIR1825" -"NCBIGene:100847034","MIR5683" -"NCBIGene:100422925","MIR4322" -"NCBIGene:100422956","MIR3180-2" -"NCBIGene:100302280","MIR1237" -"NCBIGene:102466194","MIR6773" -"NCBIGene:100847043","MIR5682" -"NCBIGene:100616148","MIR4760" -"NCBIGene:100302276","MIR1290" -"NCBIGene:693165","MIR580" -"NCBIGene:100422838","MIR3195" -"NCBIGene:100422982","MIR4286" -"NCBIGene:574504","MIR502" -"NCBIGene:102465487","MIR6812" -"NCBIGene:100616134","MIR499B" -"NCBIGene:102465446","MIR6746" -"NCBIGene:100500901","MIR3928" -"NCBIGene:100302153","MIR1298" -"NCBIGene:574514","MIR509-1" -"NCBIGene:407043","MIR7-1" -"NCBIGene:406898","MIR105-2" -"NCBIGene:102466192","MIR6750" -"NCBIGene:102465864","MIR8060" -"NCBIGene:100616220","MIR4736" -"NCBIGene:102466880","MIR8088" -"NCBIGene:100302127","MIR1470" -"NCBIGene:407026","MIR29C" -"NCBIGene:102465880","MIR8086" -"NCBIGene:100616478","MIR4494" -"NCBIGene:100422837","MIR1193" -"NCBIGene:102465879","MIR8085" -"NCBIGene:693210","MIR625" -"NCBIGene:102465461","MIR6770-1" -"NCBIGene:406976","MIR199A1" -"NCBIGene:100616390","MIR4427" -"NCBIGene:102465443","MIR6740" -"NCBIGene:100313806","MIR1255B1" -"NCBIGene:574490","MIR516B1" -"NCBIGene:406983","MIR200A" -"NCBIGene:100313921","MIR548E" -"NCBIGene:100846995","MIR5000" -"NCBIGene:406978","MIR199B" -"NCBIGene:693186","MIR601" -"NCBIGene:693232","MIR647" -"NCBIGene:100302290","MIR1973" -"NCBIGene:406933","MIR141" -"NCBIGene:407021","MIR29A" -"NCBIGene:102465534","MIR6886" -"NCBIGene:406936","MIR144" -"NCBIGene:102466751","MIR6859-1" -"NCBIGene:100313829","MIR548O" -"NCBIGene:100500894","MIR3690" -"NCBIGene:102466873","MIR8052" -"NCBIGene:102465533","MIR6885" -"NCBIGene:407051","MIR9-3" -"NCBIGene:100616183","MIR4513" -"NCBIGene:100847066","MIR5692A1" -"NCBIGene:574410","MIR323B" -"NCBIGene:100500823","MIR3920" -"NCBIGene:102466750","MIR6855" -"NCBIGene:100500903","MIR3913-1" -"NCBIGene:102466854","MIR7705" -"NCBIGene:100616271","MIR4637" -"NCBIGene:100126337","MIR509-3" -"NCBIGene:574485","MIR516B2" -"NCBIGene:724032","MIR662" -"NCBIGene:100616310","MIR4650-1" -"NCBIGene:407041","MIR34B" -"NCBIGene:574499","MIR516A2" -"NCBIGene:693155","MIR570" -"NCBIGene:100847028","MIR5587" -"NCBIGene:100616463","MIR4452" -"NCBIGene:102465832","MIR7843" -"NCBIGene:100422999","MIR4278" -"NCBIGene:100616313","MIR4749" -"NCBIGene:102465508","MIR6843" -"NCBIGene:406925","MIR135A1" -"NCBIGene:100500898","MIR3927" -"NCBIGene:100616295","MIR4764" -"NCBIGene:693151","MIR566" -"NCBIGene:102466720","MIR6720" -"NCBIGene:406881","MIRLET7A1" -"NCBIGene:102465476","MIR6795" -"NCBIGene:100500802","MIR3685" -"NCBIGene:102466250","MIR7973-1" -"NCBIGene:100847000","MIR5579" -"NCBIGene:100422997","MIR4257" -"NCBIGene:442901","MIR328" -"NCBIGene:574038","MIR431" -"NCBIGene:406968","MIR193A" -"NCBIGene:100616324","MIR1245B" -"NCBIGene:406888","MIRLET7F1" -"NCBIGene:100302168","MIR1257" -"NCBIGene:406896","MIR103A2" -"NCBIGene:100616450","MIR548AG1" -"NCBIGene:102466223","MIR7114" -"NCBIGene:100847089","MIR5584" -"NCBIGene:100616420","MIR4744" -"NCBIGene:100847046","MIR5010" -"NCBIGene:100847060","MIR5701-1" -"NCBIGene:100616196","MIR4525" -"NCBIGene:100126325","MIR935" -"NCBIGene:100422910","MIR2861" -"NCBIGene:442920","MIR196B" -"NCBIGene:100313923","MIR449C" -"NCBIGene:574508","MIR505" -"NCBIGene:102466103","MIR6075" -"NCBIGene:100302246","MIR1301" -"NCBIGene:100616471","MIR4798" -"NCBIGene:100616342","MIR4638" -"NCBIGene:100500913","MIR3714" -"NCBIGene:100422866","MIR3115" -"NCBIGene:102465513","MIR6852" -"NCBIGene:100616453","MIR4687" -"NCBIGene:100500807","MIR374C" -"NCBIGene:574509","MIR513A1" -"NCBIGene:100616490","MIR4706" -"NCBIGene:574497","MIR527" -"NCBIGene:100302210","MIR1909" -"NCBIGene:406990","MIR208A" -"NCBIGene:100616120","MIR4695" -"NCBIGene:100302165","MIR1273A" -"NCBIGene:100422826","MIR4274" -"NCBIGene:102466222","MIR7106" -"NCBIGene:102465431","MIR6722" -"NCBIGene:102465521","MIR6864" -"NCBIGene:407014","MIR25" -"NCBIGene:100616156","MIR1273F" -"NCBIGene:406979","MIR19A" -"NCBIGene:100423030","MIR3126" -"NCBIGene:100616125","MIR4731" -"NCBIGene:100616379","MIR4511" -"NCBIGene:100616169","MIR378D2" -"NCBIGene:100847026","MIR5006" -"NCBIGene:102465464","MIR6775" -"NCBIGene:102466104","MIR6090" -"NCBIGene:102465492","MIR6820" -"NCBIGene:574477","MIR518C" -"NCBIGene:100616317","MIR4777" -"NCBIGene:100616429","MIR4672" -"NCBIGene:407024","MIR29B1" -"NCBIGene:100126319","MIR216B" -"NCBIGene:100302211","MIR1203" -"NCBIGene:100500847","MIR3615" -"NCBIGene:102466615","MIR6127" -"NCBIGene:100616327","MIR4484" -"NCBIGene:100616227","MIR4502" -"NCBIGene:406915","MIR128-1" -"NCBIGene:100422858","MIR4285" -"NCBIGene:100616263","MIR4485" -"NCBIGene:102465488","MIR6814" -"NCBIGene:406991","MIR21" -"NCBIGene:100126316","MIR873" -"NCBIGene:100500860","MIR3618" -"NCBIGene:100500882","MIR3667" -"NCBIGene:100616467","MIR4767" -"NCBIGene:407009","MIR224" -"NCBIGene:102466196","MIR6794" -"NCBIGene:574511","MIR506" -"NCBIGene:100313938","MIR548G" -"NCBIGene:406951","MIR16-2" -"NCBIGene:100500871","MIR3622B" -"NCBIGene:100616404","MIR4515" -"NCBIGene:100616240","MIR4496" -"NCBIGene:100302274","MIR1178" -"NCBIGene:100126317","MIR374B" -"NCBIGene:102466724","MIR6739" -"NCBIGene:102465481","MIR6802" -"NCBIGene:574460","MIR498" -"NCBIGene:100126311","MIR147B" -"NCBIGene:100616223","MIR4509-1" -"NCBIGene:100422852","MIR4259" -"NCBIGene:100422965","MIR4263" -"NCBIGene:100302227","MIR1302-1" -"NCBIGene:100616475","MIR548AD" -"NCBIGene:768215","MIR767" -"NCBIGene:102465248","MIR6501" -"NCBIGene:100616369","MIR4713" -"NCBIGene:100422828","MIR4287" -"NCBIGene:100616154","MIR4466" -"NCBIGene:100422947","MIR3122" -"NCBIGene:407053","MIR96" -"NCBIGene:100616140","MIR4506" -"NCBIGene:494333","MIR384" -"NCBIGene:100302149","MIR1249" -"NCBIGene:693233","MIR648" -"NCBIGene:100500834","MIR3924" -"NCBIGene:100500820","MIR3655" -"NCBIGene:100422905","MIR4311" -"NCBIGene:100616130","MIR4526" -"NCBIGene:102465135","MIR6128" -"NCBIGene:102466657","MIR6505" -"NCBIGene:102465835","MIR7845" -"NCBIGene:102465666","MIR7109" -"NCBIGene:406981","MIR19B2" -"NCBIGene:406982","MIR20A" -"NCBIGene:100302140","MIR1302-6" -"NCBIGene:100616293","MIR4510" -"NCBIGene:693192","MIR607" -"NCBIGene:100500883","MIR550B1" -"NCBIGene:554210","MIR429" -"NCBIGene:100616473","MIR4432" -"NCBIGene:100422959","MIR4268" -"NCBIGene:100616330","MIR4491" -"NCBIGene:100302232","MIR1226" -"NCBIGene:100616491","MIR3978" -"NCBIGene:693231","MIR646" -"NCBIGene:102466202","MIR6769B" -"NCBIGene:100500918","MIR3651" -"NCBIGene:442910","MIR345" -"NCBIGene:100616483","MIR4751" -"NCBIGene:102465474","MIR6791" -"NCBIGene:100616195","MIR4718" -"NCBIGene:100302179","MIR1270" -"NCBIGene:406954","MIR181A2" -"NCBIGene:100500897","MIR3617" -"NCBIGene:100423003","MIR3184" -"NCBIGene:100302137","MIR1914" -"NCBIGene:100616371","MIR4746" -"NCBIGene:100302203","MIR1271" -"NCBIGene:100313884","MIR548H4" -"NCBIGene:102466953","MIR6082" -"NCBIGene:100302191","MIR548I4" -"NCBIGene:100847037","MIR5001" -"NCBIGene:102465516","MIR6857" -"NCBIGene:693128","MIR548B" -"NCBIGene:102465490","MIR6816" -"NCBIGene:102465480","MIR6800" -"NCBIGene:100616493","MIR4441" -"NCBIGene:406921","MIR132" -"NCBIGene:102466518","MIR6081" -"NCBIGene:100847002","MIR5011" -"NCBIGene:574480","MIR519D" -"NCBIGene:100422913","MIR320E" -"NCBIGene:693149","MIR564" -"NCBIGene:407050","MIR93" -"NCBIGene:102466268","MIR6511A1" -"NCBIGene:100423035","MIR4313" -"NCBIGene:407032","MIR30C2" -"NCBIGene:100847070","MIR5196" -"NCBIGene:102465530","MIR6881" -"NCBIGene:100616275","MIR4508" -"NCBIGene:100302226","MIR1238" -"NCBIGene:100616431","MIR4431" -"NCBIGene:100616113","MIR4680" -"NCBIGene:100616245","MIR4661" -"NCBIGene:100302134","MIR1289-2" -"NCBIGene:407008","MIR223" -"NCBIGene:100616477","MIR4442" -"NCBIGene:693124","MIR532" -"NCBIGene:442911","MIR346" -"NCBIGene:100126345","MIR889" -"NCBIGene:100847091","MIR5681B" -"NCBIGene:100847018","MIR5585" -"NCBIGene:100847090","MIR5187" -"NCBIGene:407010","MIR23A" -"NCBIGene:100423031","MIR4321" -"NCBIGene:100302208","MIR1253" -"NCBIGene:100423017","MIR3139" -"NCBIGene:102465503","MIR6836" -"NCBIGene:102465252","MIR6506" -"NCBIGene:100616380","MIR4671" -"NCBIGene:102466191","MIR6736" -"NCBIGene:100500885","MIR3925" -"NCBIGene:693224","MIR639" -"NCBIGene:102465802","MIR7704" -"NCBIGene:100500893","MIR3663" -"NCBIGene:574510","MIR513A2" -"NCBIGene:693223","MIR638" -"NCBIGene:100616157","MIR4772" -"NCBIGene:102465499","MIR6831" -"NCBIGene:100616385","MIR4732" -"NCBIGene:100616311","MIR3973" -"NCBIGene:102465478","MIR6797" -"NCBIGene:100313896","MIR320D1" -"NCBIGene:100616132","MIR4728" -"NCBIGene:102466730","MIR6764" -"NCBIGene:100302145","MIR1247" -"NCBIGene:100616449","MIR4725" -"NCBIGene:574462","MIR515-1" -"NCBIGene:407044","MIR7-2" -"NCBIGene:100126303","MIR890" -"NCBIGene:100847086","MIR5699" -"NCBIGene:100422967","MIR3146" -"NCBIGene:100847015","MIR5691" -"NCBIGene:100616153","MIR4726" -"NCBIGene:100313837","MIR762" -"NCBIGene:100302197","MIR1306" -"NCBIGene:100847073","MIR5090" -"NCBIGene:100616486","MIR4698" -"NCBIGene:100302123","MIR1275" -"NCBIGene:406987","MIR204" -"NCBIGene:100422939","MIR3147" -"NCBIGene:102466912","MIR6871" -"NCBIGene:100422908","MIR3129" -"NCBIGene:407013","MIR24-2" -"NCBIGene:100616285","MIR4645" -"NCBIGene:100033819","MIR675" -"NCBIGene:100847012","MIR5004" -"NCBIGene:102466985","MIR6837" -"NCBIGene:100616203","MIR4734" -"NCBIGene:693122","MIR421" -"NCBIGene:102465506","MIR6841" -"NCBIGene:406961","MIR185" -"NCBIGene:100616237","MIR4640" -"NCBIGene:100302175","MIR1207" -"NCBIGene:693234","MIR649" -"NCBIGene:100847065","MIR5591" -"NCBIGene:724026","MIR656" -"NCBIGene:102465876","MIR8079" -"NCBIGene:100302283","MIR1227" -"NCBIGene:102465862","MIR8056" -"NCBIGene:100423025","MIR3198-1" -"NCBIGene:100422983","MIR4314" -"NCBIGene:102465141","MIR6165" -"NCBIGene:100616253","MIR4762" -"NCBIGene:100500810","MIR3620" -"NCBIGene:100500851","MIR3918" -"NCBIGene:100313824","MIR663B" -"NCBIGene:100616256","MIR4721" -"NCBIGene:100500836","MIR3914-1" -"NCBIGene:100616350","MIR4660" -"NCBIGene:407040","MIR34A" -"NCBIGene:100616251","MIR1587" -"NCBIGene:102466734","MIR6783" -"NCBIGene:100302133","MIR1287" -"NCBIGene:102464825","MIR6070" -"NCBIGene:693142","MIR557" -"NCBIGene:100500853","MIR3605" -"NCBIGene:100616262","MIR4701" -"NCBIGene:102465470","MIR6784" -"NCBIGene:100616234","MIR4454" -"NCBIGene:100616207","MIR4439" -"NCBIGene:102465529","MIR6878" -"NCBIGene:100616308","MIR4666A" -"NCBIGene:100616241","MIR4717" -"NCBIGene:100422876","MIR3148" -"NCBIGene:102465501","MIR6834" -"NCBIGene:442906","MIR338" -"NCBIGene:100616297","MIR3977" -"NCBIGene:100422893","MIR3154" -"NCBIGene:100422869","MIR3152" -"NCBIGene:100616336","MIR548AB" -"NCBIGene:406960","MIR184" -"NCBIGene:100616216","MIR4797" -"NCBIGene:100302250","MIR1197" -"NCBIGene:693148","MIR563" -"NCBIGene:100302190","MIR1976" -"NCBIGene:693227","MIR642A" -"NCBIGene:574476","MIR520C" -"NCBIGene:100500861","MIR3665" -"NCBIGene:100616432","MIR4714" -"NCBIGene:102465871","MIR8071-1" -"NCBIGene:100847029","MIR5003" -"NCBIGene:100422966","MIR4277" -"NCBIGene:100422855","MIR4301" -"NCBIGene:574479","MIR517A" -"NCBIGene:693146","MIR561" -"NCBIGene:102465498","MIR6830" -"NCBIGene:407035","MIR31" -"NCBIGene:100616361","MIR4775" -"NCBIGene:100847014","MIR5100" -"NCBIGene:724029","MIR659" -"NCBIGene:100847027","MIR5705" -"NCBIGene:100847021","MIR5002" -"NCBIGene:100616456","MIR4476" -"NCBIGene:102465428","MIR6717" -"NCBIGene:574475","MIR526A1" -"NCBIGene:100616161","MIR4795" -"NCBIGene:100616425","MIR4748" -"NCBIGene:442903","MIR331" -"NCBIGene:100302152","MIR548N" -"NCBIGene:100302242","MIR1236" -"NCBIGene:574433","MIR412" -"NCBIGene:406994","MIR212" -"NCBIGene:102466752","MIR6863" -"NCBIGene:574494","MIR521-1" -"NCBIGene:100616268","MIR4472-1" -"NCBIGene:100422938","MIR3142" -"NCBIGene:100500884","MIR3681" -"NCBIGene:100422821","MIR1273C" -"NCBIGene:100616259","MIR378I" -"GO:1900102","negative regulation of endoplasmic reticulum unfolded protein response" -"GO:0006629","lipid metabolic process" -"GO:1904307","response to desipramine" -"GO:0000767","cell morphogenesis involved in conjugation" -"GO:0035970","peptidyl-threonine dephosphorylation" -"GO:0044782","cilium organization" -"GO:1900473","negative regulation of phosphatidylcholine biosynthetic process by negative regulation of transcription from RNA polymerase II promoter" -"GO:1900811","helvolic acid catabolic process" -"GO:0070257","positive regulation of mucus secretion" -"GO:0060739","mesenchymal-epithelial cell signaling involved in prostate gland development" -"GO:0045667","regulation of osteoblast differentiation" -"GO:1901227","negative regulation of transcription from RNA polymerase II promoter involved in heart development" -"GO:1903811","L-asparagine import across plasma membrane" -"GO:0051548","negative regulation of keratinocyte migration" -"GO:1905834","response to pyrimidine ribonucleotide" -"GO:0034306","regulation of sexual sporulation" -"GO:0016926","protein desumoylation" -"GO:0060127","prolactin secreting cell differentiation" -"GO:0060460","left lung morphogenesis" -"GO:0044700","single organism signaling" -"GO:0071378","cellular response to growth hormone stimulus" -"GO:1904558","response to dextromethorphan" -"GO:0055108","Golgi to transport vesicle transport" -"GO:1904486","response to 17alpha-ethynylestradiol" -"GO:0006168","adenine salvage" -"GO:0072208","metanephric smooth muscle tissue development" -"GO:0036273","response to statin" -"GO:1904512","regulation of initiation of premeiotic DNA replication" -"GO:0032535","regulation of cellular component size" -"GO:1990892","mitotic chromosome arm condensation" -"GO:1905835","cellular response to pyrimidine ribonucleotide" -"GO:0060214","endocardium formation" -"GO:1904583","response to polyamine macromolecule" -"GO:0019669","anaerobic glycine catabolic process" -"GO:1902079","D-valine catabolic process" -"GO:0051713","negative regulation of cytolysis in other organism" -"GO:0060240","negative regulation of signal transduction involved in conjugation with cellular fusion" -"GO:0071158","positive regulation of cell cycle arrest" -"GO:1900607","tensidol B catabolic process" -"GO:1900463","negative regulation of cellular response to alkaline pH by negative regulation of transcription from RNA polymerase II promoter" -"GO:1903342","negative regulation of meiotic DNA double-strand break formation" -"GO:0016060","metarhodopsin inactivation" -"GO:0002902","regulation of B cell apoptotic process" -"GO:0022017","neuroblast division in pallium" -"GO:0072739","response to anisomycin" -"GO:1900477","negative regulation of G1/S transition of mitotic cell cycle by negative regulation of transcription from RNA polymerase II promoter" -"GO:0098724","symmetric stem cell division" -"GO:1903165","response to polycyclic arene" -"GO:1900392","regulation of transport by negative regulation of transcription from RNA polymerase II promoter" -"GO:0021903","rostrocaudal neural tube patterning" -"GO:1900534","palmitic acid catabolic process" -"GO:1902072","negative regulation of hypoxia-inducible factor-1alpha signaling pathway" -"GO:2000808","negative regulation of synaptic vesicle clustering" -"GO:0035952","negative regulation of oligopeptide transport by negative regulation of transcription from RNA polymerase II promoter" -"GO:0061436","establishment of skin barrier" -"GO:0032534","regulation of microvillus assembly" -"GO:0046513","ceramide biosynthetic process" -"GO:1905439","response to chondroitin 6'-sulfate" -"GO:1902696","glycine catabolic process to isobutanol" -"GO:0090071","negative regulation of ribosome biogenesis" -"GO:0009625","response to insect" -"GO:0036277","response to anticonvulsant" -"GO:0090375","negative regulation of transcription from RNA polymerase II promoter in response to iron ion starvation" -"GO:1900604","tensidol A catabolic process" -"GO:0070177","contractile vacuole discharge" -"GO:1901260","peptidyl-lysine hydroxylation involved in bacterial-type EF-P lysine modification" -"GO:1903707","negative regulation of hemopoiesis" -"GO:1901328","response to cytochalasin B" -"GO:0045475","locomotor rhythm" -"GO:1901554","response to paracetamol" -"GO:0042161","lipoprotein oxidation" -"GO:0002867","regulation of B cell deletion" -"GO:0072235","metanephric distal tubule development" -"GO:1902518","response to cyclophosphamide" -"GO:0010688","negative regulation of ribosomal protein gene transcription by RNA polymerase II" -"GO:0071464","cellular response to hydrostatic pressure" -"GO:0010881","regulation of cardiac muscle contraction by regulation of the release of sequestered calcium ion" -"GO:1902385","glycyrrhetinate catabolic process" -"GO:0014051","gamma-aminobutyric acid secretion" -"GO:2000810","regulation of bicellular tight junction assembly" -"GO:0045150","acetoin catabolic process" -"GO:1905381","negative regulation of snRNA transcription by RNA polymerase II" -"Reactome:R-HSA-1912422","Pre-NOTCH Expression and Processing" -"Reactome:R-HSA-5637812","Signaling by EGFRvIII in Cancer" -"Reactome:R-HSA-112409","RAF-independent MAPK1/3 activation" -"Reactome:R-HSA-5652084","Fructose metabolism" -"Reactome:R-HSA-5684264","MAP3K8 (TPL2)-dependent MAPK1/3 activation" -"Reactome:R-HSA-376176","Signaling by ROBO receptors" -"Reactome:R-HSA-2173793","Transcriptional activity of SMAD2/SMAD3:SMAD4 heterotrimer" -"Reactome:R-HSA-5625740","RHO GTPases activate PKNs" -"Reactome:R-HSA-425393","Transport of inorganic cations/anions and amino acids/oligopeptides" -"Reactome:R-HSA-879415","Advanced glycosylation endproduct receptor signaling" -"Reactome:R-HSA-2206296","MPS II - Hunter syndrome" -"Reactome:R-HSA-5619062","Defective SLC1A3 causes episodic ataxia 6 (EA6)" -"Reactome:R-HSA-194315","Signaling by Rho GTPases" -"Reactome:R-HSA-5682113","Defective ABCA1 causes Tangier disease" -"Reactome:R-HSA-8937144","Aryl hydrocarbon receptor signalling" -"Reactome:R-HSA-8934593","Regulation of RUNX1 Expression and Activity" -"Reactome:R-HSA-8951664","Neddylation" -"Reactome:R-HSA-1169408","ISG15 antiviral mechanism" -"Reactome:R-HSA-5683329","Defective ABCD4 causes methylmalonic aciduria and homocystinuria, cblj type (MAHCJ)" -"Reactome:R-HSA-2453864","Retinoid cycle disease events" -"Reactome:R-HSA-8878159","Transcriptional regulation by RUNX3" -"Reactome:R-HSA-2586552","Signaling by Leptin" -"Reactome:R-HSA-5619104","Defective SLC12A1 causes Bartter syndrome 1 (BS1)" -"Reactome:R-HSA-8866654","E3 ubiquitin ligases ubiquitinate target proteins" -"Reactome:R-HSA-446652","Interleukin-1 family signaling" -"Reactome:R-HSA-388841","Costimulation by the CD28 family" -"Reactome:R-HSA-200425","Import of palmitoyl-CoA into the mitochondrial matrix" -"Reactome:R-HSA-3656535","TGFBR1 LBD Mutants in Cancer" -"Reactome:R-HSA-1483206","Glycerophospholipid biosynthesis" -"Reactome:R-HSA-75067","Processing of Capped Intronless Pre-mRNA" -"Reactome:R-HSA-8853659","RET signaling" -"Reactome:R-HSA-392518","Signal amplification" -"Reactome:R-HSA-9033241","Peroxisomal protein import" -"Reactome:R-HSA-5632968","Defective Mismatch Repair Associated With MSH6" -"Reactome:R-HSA-168799","Neurotoxicity of clostridium toxins" -"Reactome:R-HSA-8963676","Intestinal absorption" -"Reactome:R-HSA-5685939","HDR through MMEJ (alt-NHEJ)" -"Reactome:R-HSA-6793080","rRNA modification in the mitochondrion" -"Reactome:R-HSA-381340","Transcriptional regulation of white adipocyte differentiation" -"Reactome:R-HSA-2187338","Visual phototransduction" -"Reactome:R-HSA-5655291","Signaling by FGFR4 in disease" -"Reactome:R-HSA-2161522","Abacavir transport and metabolism" -"Reactome:R-HSA-5632987","Defective Mismatch Repair Associated With PMS2" -"Reactome:R-HSA-8983432","Interleukin-15 signaling" -"Reactome:R-HSA-4793953","Defective B4GALT1 causes B4GALT1-CDG (CDG-2d)" -"Reactome:R-HSA-390918","Peroxisomal lipid metabolism" -"Reactome:R-HSA-448706","Interleukin-1 processing" -"Reactome:R-HSA-982772","Growth hormone receptor signaling" -"Reactome:R-HSA-453279","Mitotic G1-G1/S phases" -"Reactome:R-HSA-163841","Gamma carboxylation, hypusine formation and arylsulfatase activation" -"Reactome:R-HSA-3656244","Defective B4GALT1 causes B4GALT1-CDG (CDG-2d)" -"Reactome:R-HSA-2172127","DAP12 interactions" -"Reactome:R-HSA-199992","trans-Golgi Network Vesicle Budding" -"Reactome:R-HSA-5340573","WNT ligand secretion is abrogated by the PORCN inhibitor LGK974" -"Reactome:R-HSA-2978092","Abnormal conversion of 2-oxoglutarate to 2-hydroxyglutarate" -"Reactome:R-HSA-6791312","TP53 Regulates Transcription of Cell Cycle Genes" -"Reactome:R-HSA-6798695","Neutrophil degranulation" -"Reactome:R-HSA-430116","GP1b-IX-V activation signalling" -"Reactome:R-HSA-6802952","Signaling by BRAF and RAF fusions" -"Reactome:R-HSA-8939902","Regulation of RUNX2 expression and activity" -"Reactome:R-HSA-166166","MyD88-independent TLR4 cascade " -"Reactome:R-HSA-69242","S Phase" -"Reactome:R-HSA-5619052","Defective SLC9A9 causes autism 16 (AUTS16)" -"Reactome:R-HSA-8849175","Threonine catabolism" -"Reactome:R-HSA-5619098","Defective SLC2A2 causes Fanconi-Bickel syndrome (FBS)" -"Reactome:R-HSA-5693567","HDR through Homologous Recombination (HR) or Single Strand Annealing (SSA)" -"Reactome:R-HSA-453276","Regulation of mitotic cell cycle" -"Reactome:R-HSA-73929","Base-Excision Repair, AP Site Formation" -"Reactome:R-HSA-194138","Signaling by VEGF" -"Reactome:R-HSA-5358508","Mismatch Repair" -"Reactome:R-HSA-76005","Response to elevated platelet cytosolic Ca2+" -"Reactome:R-HSA-4551638","SUMOylation of chromatin organization proteins" -"Reactome:R-HSA-5173105","O-linked glycosylation" -"Reactome:R-HSA-140877","Formation of Fibrin Clot (Clotting Cascade)" -"Reactome:R-HSA-909733","Interferon alpha/beta signaling" -"Reactome:R-HSA-1266695","Interleukin-7 signaling" -"Reactome:R-HSA-381038","XBP1(S) activates chaperone genes" -"Reactome:R-HSA-5688426","Deubiquitination" -"Reactome:R-HSA-917729","Endosomal Sorting Complex Required For Transport (ESCRT)" -"Reactome:R-HSA-1799339","SRP-dependent cotranslational protein targeting to membrane" -"Reactome:R-HSA-5660883","Defective SLC7A9 causes cystinuria (CSNU)" -"Reactome:R-HSA-5579014","Defective CYP27B1 causes Rickets vitamin D-dependent 1A (VDDR1A)" -"Reactome:R-HSA-168164","Toll Like Receptor 3 (TLR3) Cascade" -"Reactome:R-HSA-3299685","Detoxification of Reactive Oxygen Species" -"Reactome:R-HSA-5579022","Defective GGT1 causes Glutathionuria (GLUTH)" -"Reactome:R-HSA-2142789","Ubiquinol biosynthesis" -"Reactome:R-HSA-351202","Metabolism of polyamines" -"Reactome:R-HSA-6783589","Interleukin-6 family signaling" -"Reactome:R-HSA-5467340","AXIN missense mutants destabilize the destruction complex" -"Reactome:R-HSA-418594","G alpha (i) signalling events" -"Reactome:R-HSA-5673001","RAF/MAP kinase cascade" -"Reactome:R-HSA-3359473","Defective MMADHC causes methylmalonic aciduria and homocystinuria type cblD" -"Reactome:R-HSA-3359467","Defective MTRR causes methylmalonic aciduria and homocystinuria type cblE" -"Reactome:R-HSA-69239","Synthesis of DNA" -"Reactome:R-HSA-68877","Mitotic Prometaphase" -"Reactome:R-HSA-5579020","Defective SLC35D1 causes Schneckenbecken dysplasia (SCHBCKD)" -"Reactome:R-HSA-4615885","SUMOylation of DNA replication proteins" -"Reactome:R-HSA-1650814","Collagen biosynthesis and modifying enzymes" -"Reactome:R-HSA-6802948","Signaling by high-kinase activity BRAF mutants" -"Reactome:R-HSA-6804760","Regulation of TP53 Activity through Methylation" -"Reactome:R-HSA-5619087","Defective SLC12A3 causes Gitelman syndrome (GS)" -"Reactome:R-HSA-5625970","RHO GTPases activate KTN1" -"Reactome:R-HSA-8957275","Post-translational protein phosphorylation" -"Reactome:R-HSA-1592230","Mitochondrial biogenesis" -"Reactome:R-HSA-1980150","Signaling by NOTCH4" -"Reactome:R-HSA-5579030","Defective CYP19A1 causes Aromatase excess syndrome (AEXS)" -"Reactome:R-HSA-8852135","Protein ubiquitination" -"Reactome:R-HSA-5579009","Defective CYP11B2 causes Corticosterone methyloxidase 1 deficiency (CMO-1 deficiency)" -"Reactome:R-HSA-388396","GPCR downstream signalling" -"Reactome:R-HSA-5619039","Defective SLC12A6 causes agenesis of the corpus callosum, with peripheral neuropathy (ACCPN)" -"Reactome:R-HSA-888590","GABA synthesis, release, reuptake and degradation" -"Reactome:R-HSA-163200","Respiratory electron transport, ATP synthesis by chemiosmotic coupling, and heat production by uncoupling proteins." -"Reactome:R-HSA-2564830","Cytosolic iron-sulfur cluster assembly" -"Reactome:R-HSA-8949215","Mitochondrial calcium ion transport" -"Reactome:R-HSA-6794361","Neurexins and neuroligins" -"Reactome:R-HSA-8979227","Triglyceride metabolism" -"Reactome:R-HSA-5656364","Defective SLC5A1 causes congenital glucose/galactose malabsorption (GGM)" -"Reactome:R-HSA-5619076","Defective SLC17A8 causes autosomal dominant deafness 25 (DFNA25)" -"Reactome:R-HSA-2559585","Oncogene Induced Senescence" -"Reactome:R-HSA-1237044","Erythrocytes take up carbon dioxide and release oxygen" -"Reactome:R-HSA-8853334","Signaling by FGFR3 fusions in cancer" -"Reactome:R-HSA-5339716","Misspliced GSK3beta mutants stabilize beta-catenin" -"Reactome:R-HSA-162587","HIV Life Cycle" -"Reactome:R-HSA-5218859","Regulated Necrosis" -"Reactome:R-HSA-774815","Nucleosome assembly" -"Reactome:R-HSA-5678520","Defective ABCB11 causes progressive familial intrahepatic cholestasis 2 and benign recurrent intrahepatic cholestasis 2" -"Reactome:R-HSA-5682910","LGI-ADAM interactions" -"Reactome:R-HSA-8949664","Processing of SMDT1" -"Reactome:R-HSA-5655302","Signaling by FGFR1 in disease" -"Reactome:R-HSA-2206280","MPS IX - Natowicz syndrome" -"Reactome:R-HSA-975871","MyD88 cascade initiated on plasma membrane" -"Reactome:R-HSA-71336","Pentose phosphate pathway (hexose monophosphate shunt)" -"Reactome:R-HSA-5579006","Defective GSS causes Glutathione synthetase deficiency (GSS deficiency)" -"Reactome:R-HSA-1268020","Mitochondrial protein import" -"Reactome:R-HSA-388844","Receptor-type tyrosine-protein phosphatases" -"Reactome:R-HSA-373752","Netrin-1 signaling" -"Reactome:R-HSA-6785470","tRNA processing in the mitochondrion" -"Reactome:R-HSA-5579024","Defective MAT1A causes Methionine adenosyltransferase deficiency (MATD)" -"Reactome:R-HSA-4719377","Defective DPM2 causes DPM2-CDG (CDG-1u)" -"Reactome:R-HSA-5602415","UNC93B1 deficiency - HSE" -"Reactome:R-HSA-3645790","TGFBR2 Kinase Domain Mutants in Cancer" -"Reactome:R-HSA-5690338","Defective ABCC6 causes pseudoxanthoma elasticum (PXE)" -"Reactome:R-HSA-75892","Platelet Adhesion to exposed collagen" -"Reactome:R-HSA-196757","Metabolism of folate and pterines" -"Reactome:R-HSA-174824","Plasma lipoprotein assembly, remodeling, and clearance" -"Reactome:R-HSA-5619081","Defective SLC6A3 causes Parkinsonism-dystonia infantile (PKDYS)" -"Reactome:R-HSA-6791226","Major pathway of rRNA processing in the nucleolus and cytosol" -"Reactome:R-HSA-75105","Fatty acyl-CoA biosynthesis" -"Reactome:R-HSA-5676934","Protein repair" -"Reactome:R-HSA-5083630","Defective LFNG causes SCDO3" -"Reactome:R-HSA-2028269","Signaling by Hippo" -"Reactome:R-HSA-5250924","B-WICH complex positively regulates rRNA expression" -"Reactome:R-HSA-5609974","Defective PGM1 causes PGM1-CDG (CDG1t)" -"Reactome:R-HSA-5654743","Signaling by FGFR4" -"Reactome:R-HSA-8856828","Clathrin-mediated endocytosis" -"Reactome:R-HSA-212300","PRC2 methylates histones and DNA" -"Reactome:R-HSA-5602636","IKBKB deficiency causes SCID" -"Reactome:R-HSA-3359475","Defective MMAA causes methylmalonic aciduria type cblA" -"Reactome:R-HSA-168928","DDX58/IFIH1-mediated induction of interferon-alpha/beta" -"Reactome:R-HSA-5655799","Defective SLC40A1 causes hemochromatosis 4 (HFE4) (duodenum)" -"Reactome:R-HSA-77289","Mitochondrial Fatty Acid Beta-Oxidation" -"Reactome:R-HSA-3656243","Defective ST3GAL3 causes MCT12 and EIEE15" -"Reactome:R-HSA-73893","DNA Damage Bypass" -"Reactome:R-HSA-6802953","RAS signaling downstream of NF1 loss-of-function variants" -"Reactome:R-HSA-5619094","Variant SLC6A14 may confer susceptibility towards obesity" -"Reactome:R-HSA-1489509","DAG and IP3 signaling" -"Reactome:R-HSA-5334118","DNA methylation" -"Reactome:R-HSA-5619099","Defective AVP causes neurohypophyseal diabetes insipidus (NDI)" -"Reactome:R-HSA-1234174","Regulation of Hypoxia-inducible Factor (HIF) by oxygen" -"Reactome:R-HSA-196071","Metabolism of steroid hormones" -"Reactome:R-HSA-2559582","Senescence-Associated Secretory Phenotype (SASP)" -"Reactome:R-HSA-5579013","Defective CYP7B1 causes Spastic paraplegia 5A, autosomal recessive (SPG5A) and Congenital bile acid synthesis defect 3 (CBAS3)" -"Reactome:R-HSA-2644602","Signaling by NOTCH1 PEST Domain Mutants in Cancer" -"Reactome:R-HSA-3656225","Defective CHST6 causes MCDC1" -"Reactome:R-HSA-389661","Glyoxylate metabolism and glycine degradation" -"Reactome:R-HSA-8876725","Protein methylation" -"Reactome:R-HSA-9006931","Signaling by Nuclear Receptors" -"Reactome:R-HSA-450531","Regulation of mRNA stability by proteins that bind AU-rich elements" -"Reactome:R-HSA-4719360","Defective DPM3 causes DPM3-CDG (CDG-1o)" -"Reactome:R-HSA-5579015","Defective CYP26B1 causes Radiohumeral fusions with other skeletal and craniofacial anomalies (RHFCA)" -"Reactome:R-HSA-5579028","Defective CYP17A1 causes Adrenal hyperplasia 5 (AH5)" -"Reactome:R-HSA-5682294","Defective ABCA12 causes autosomal recessive congenital ichthyosis type 4B" -"Reactome:R-HSA-8953750","Transcriptional Regulation by E2F6" -"Reactome:R-HSA-5657562","Essential fructosuria" -"Reactome:R-HSA-189200","Cellular hexose transport" -"Reactome:R-HSA-2206292","MPS VII - Sly syndrome" -"Reactome:R-HSA-5678771","Defective ABCB4 causes progressive familial intrahepatic cholestasis 3, intrahepatic cholestasis of pregnancy 3 and gallbladder disease 1" -"Reactome:R-HSA-75158","TRAIL signaling" -"Reactome:R-HSA-8853338","Signaling by FGFR3 point mutants in cancer" -"Reactome:R-HSA-6783310","Fanconi Anemia Pathway" -"Reactome:R-HSA-4085001","Sialic acid metabolism" -"Reactome:R-HSA-8950505","Gene and protein expression by JAK-STAT signaling after Interleukin-12 stimulation" -"Reactome:R-HSA-5687583","Defective SLC34A2 causes pulmonary alveolar microlithiasis (PALM)" -"Reactome:R-HSA-8876384","Listeria monocytogenes entry into host cells" -"Reactome:R-HSA-5205647","Mitophagy" -"Reactome:R-HSA-3229133","Glycogen storage disease type Ib (SLC37A4)" -"Reactome:R-HSA-5683177","Defective ABCC8 can cause hypoglycemias and hyperglycemias" -"Reactome:R-HSA-5619045","Defective SLC34A2 causes pulmonary alveolar microlithiasis (PALM)" -"Reactome:R-HSA-5619041","Defective SLC36A2 causes iminoglycinuria (IG) and hyperglycinuria (HG)" -"Reactome:R-HSA-264876","Insulin processing" -"Reactome:R-HSA-75893","TNF signaling" -"Reactome:R-HSA-2404192","Signaling by Type 1 Insulin-like Growth Factor 1 Receptor (IGF1R)" -"Reactome:R-HSA-451927","Interleukin-2 family signaling" -"Reactome:R-HSA-5619070","Defective SLC16A1 causes symptomatic deficiency in lactate transport (SDLT)" -"Reactome:R-HSA-5619109","Defective SLC6A2 causes orthostatic intolerance (OI)" -"Reactome:R-HSA-456926","Thrombin signalling through proteinase activated receptors (PARs)" -"Reactome:R-HSA-112314","Neurotransmitter receptors and postsynaptic signal transmission" -"Reactome:R-HSA-75072","mRNA Editing" -"Reactome:R-HSA-5662853","Essential pentosuria" -"Reactome:R-HSA-5423646","Aflatoxin activation and detoxification" -"Reactome:R-HSA-1483249","Inositol phosphate metabolism" -"Reactome:R-HSA-8864260","Transcriptional regulation by the AP-2 (TFAP2) family of transcription factors" -"Reactome:R-HSA-5619040","Defective SLC34A1 causes hypophosphatemic nephrolithiasis/osteoporosis 1 (NPHLOP1)" -"Reactome:R-HSA-983705","Signaling by the B Cell Receptor (BCR)" -"Reactome:R-HSA-5661231","Metallothioneins bind metals" -"Reactome:R-HSA-1433557","Signaling by SCF-KIT" -"Reactome:R-HSA-4085011","Defective GNE causes sialuria, Nonaka myopathy and inclusion body myopathy 2" -"Reactome:R-HSA-1170546","Prolactin receptor signaling" -"Reactome:R-HSA-5657560","Hereditary fructose intolerance" -"Reactome:R-HSA-8985947","Interleukin-9 signaling" -"Reactome:R-HSA-5358752","T41 mutants of beta-catenin aren't phosphorylated" -"Reactome:R-HSA-163685","Integration of energy metabolism" -"Reactome:R-HSA-927802","Nonsense-Mediated Decay (NMD)" -"Reactome:R-HSA-73933","Resolution of Abasic Sites (AP sites)" -"Reactome:R-HSA-196807","Nicotinate metabolism" -"Reactome:R-HSA-1236394","Signaling by ERBB4" -"Reactome:R-HSA-5674400","Constitutive Signaling by AKT1 E17K in Cancer" -"Reactome:R-HSA-8981607","Intracellular oxygen transport" -"Reactome:R-HSA-3371556","Cellular response to heat stress" -"Reactome:R-HSA-6787450","tRNA modification in the mitochondrion" -"Reactome:R-HSA-5674404","PTEN Loss of Function in Cancer" -"Reactome:R-HSA-6806003","Regulation of TP53 Expression and Degradation" -"Reactome:R-HSA-5619113","Defective SLC3A1 causes cystinuria (CSNU)" -"Reactome:R-HSA-5619088","Defective SLC39A4 causes acrodermatitis enteropathica, zinc-deficiency type (AEZ)" -"Reactome:R-HSA-5578997","Defective AHCY causes Hypermethioninemia with S-adenosylhomocysteine hydrolase deficiency (HMAHCHD)" -"Reactome:R-HSA-8854691","Interleukin-20 family signaling" -"Reactome:R-HSA-1483255","PI Metabolism" -"Reactome:R-HSA-3371599","Defective HLCS causes multiple carboxylase deficiency" -"Reactome:R-HSA-166520","Signalling by NGF" -"Reactome:R-HSA-392517","Rap1 signalling" -"Reactome:R-HSA-109606","Intrinsic Pathway for Apoptosis" -"Reactome:R-HSA-114604","GPVI-mediated activation cascade" -"Reactome:R-HSA-1227986","Signaling by ERBB2" -"Reactome:R-HSA-5660489","MTF1 activates gene expression" -"Reactome:R-HSA-1187000","Fertilization" -"Reactome:R-HSA-8853383","Lysosomal oligosaccharide catabolism" -"Reactome:R-HSA-1630316","Glycosaminoglycan metabolism" -"Reactome:R-HSA-9012852","Signaling by NOTCH3" -"Reactome:R-HSA-5210891","Uptake and function of anthrax toxins" -"Reactome:R-HSA-3304356","SMAD2/3 Phosphorylation Motif Mutants in Cancer" -"Reactome:R-HSA-8949613","Cristae formation" -"Reactome:R-HSA-69304","Regulation of DNA replication" -"Reactome:R-HSA-2454202","Fc epsilon receptor (FCERI) signaling" -"Reactome:R-HSA-373753","Nephrin family interactions" -"Reactome:R-HSA-3560796","Defective PAPSS2 causes SEMD-PA" -"Reactome:R-HSA-5619085","Defective SLC26A3 causes congenital secretory chloride diarrhea 1 (DIAR1)" -"Reactome:R-HSA-3232118","SUMOylation of transcription factors" -"Reactome:R-HSA-112313","Neurotransmitter uptake and metabolism In glial cells" -"Reactome:R-HSA-391160","Signal regulatory protein family interactions" -"Reactome:R-HSA-8876198","RAB GEFs exchange GTP for GDP on RABs" -"Reactome:R-HSA-428359","Insulin-like Growth Factor-2 mRNA Binding Proteins (IGF2BPs/IMPs/VICKZs) bind RNA" -"Reactome:R-HSA-202403","TCR signaling" -"Reactome:R-HSA-2029480","Fcgamma receptor (FCGR) dependent phagocytosis" -"Reactome:R-HSA-75205","Dissolution of Fibrin Clot" -"Reactome:R-HSA-5619111","Defective SLC20A2 causes idiopathic basal ganglia calcification 1 (IBGC1)" -"Reactome:R-HSA-429914","Deadenylation-dependent mRNA decay" -"Reactome:R-HSA-211945","Phase I - Functionalization of compounds" -"Reactome:R-HSA-2990846","SUMOylation" -"Reactome:R-HSA-3858494","Beta-catenin independent WNT signaling" -"Reactome:R-HSA-9018683","Biosynthesis of DPA-derived SPMs" -"Reactome:R-HSA-5678420","Defective ABCC9 causes dilated cardiomyopathy 10, familial atrial fibrillation 12 and hypertrichotic osteochondrodysplasia" -"NCBIGene:100616173","MIR203B" -"NCBIGene:100302188","MIR1243" -"NCBIGene:102465444","MIR6742" -"NCBIGene:102465435","MIR6727" -"NCBIGene:693214","MIR629" -"NCBIGene:574506","MIR503" -"NCBIGene:100302139","MIR1537" -"NCBIGene:574033","MIR18B" -"NCBIGene:102465858","MIR7977" -"NCBIGene:102466984","MIR6801" -"NCBIGene:100302141","MIR1913" -"NCBIGene:100616300","MIR4710" -"NCBIGene:406916","MIR128-2" -"NCBIGene:100500839","MIR3686" -"NCBIGene:100422841","MIR3174" -"NCBIGene:102465463","MIR6772" -"NCBIGene:102466744","MIR6827" -"NCBIGene:100422912","MIR3200" -"NCBIGene:693153","MIR568" -"NCBIGene:574454","MIR496" -"NCBIGene:406901","MIR107" -"NCBIGene:100616145","MIR1273G" -"NCBIGene:100302217","MIR1827" -"NCBIGene:693135","MIR551A" -"NCBIGene:100616482","MIR4685" -"NCBIGene:664616","MIR487B" -"NCBIGene:574450","MIR493" -"NCBIGene:693187","MIR602" -"NCBIGene:100422963","MIR4290" -"NCBIGene:442918","MIR373" -"NCBIGene:100616231","MIR4519" -"NCBIGene:442908","MIR340" -"NCBIGene:100616348","MIR4659A" -"NCBIGene:494328","MIR379" -"NCBIGene:100313830","MIR548H1" -"NCBIGene:100616349","MIR4451" -"NCBIGene:406885","MIRLET7C" -"NCBIGene:100423042","MIR4276" -"NCBIGene:100616174","MIR4643" -"NCBIGene:724028","MIR658" -"NCBIGene:574442","MIR489" -"NCBIGene:574463","MIR519E" -"NCBIGene:442894","MIR302B" -"NCBIGene:100302184","MIR1272" -"NCBIGene:100616480","MIR4479" -"NCBIGene:100423036","MIR2355" -"NCBIGene:406914","MIR127" -"NCBIGene:442891","MIR135B" -"NCBIGene:100847045","MIR548AU" -"NCBIGene:100422975","MIR4252" -"NCBIGene:100126333","MIR708" -"NCBIGene:100302279","MIR1262" -"NCBIGene:100616337","MIR4747" -"NCBIGene:100422978","MIR3185" -"NCBIGene:100126349","MIR921" -"NCBIGene:100422914","MIR4253" -"NCBIGene:100616377","MIR4803" -"NCBIGene:100500880","MIR3662" -"NCBIGene:100616131","MIR3689D1" -"NCBIGene:100500888","MIR3940" -"NCBIGene:100616428","MIR548AM" -"NCBIGene:102465494","MIR6823" -"NCBIGene:574449","MIR492" -"NCBIGene:100302143","MIR1248" -"NCBIGene:693195","MIR610" -"NCBIGene:100423004","MIR4315-1" -"NCBIGene:100616137","MIR4501" -"NCBIGene:407022","MIR296" -"NCBIGene:100847040","MIR5704" -"NCBIGene:406971","MIR195" -"NCBIGene:494332","MIR383" -"NCBIGene:693191","MIR606" -"NCBIGene:100423043","MIR4269" -"NCBIGene:100422868","MIR4270" -"NCBIGene:100313843","MIR711" -"NCBIGene:693130","MIR548D1" -"NCBIGene:100313770","MIR548K" -"NCBIGene:100616188","MIR3972" -"NCBIGene:100302228","MIR1261" -"NCBIGene:100616249","MIR4768" -"NCBIGene:100616469","MIR4429" -"NCBIGene:574457","MIR181D" -"NCBIGene:574516","MIR514A1" -"NCBIGene:406884","MIRLET7B" -"NCBIGene:102465537","MIR6891" -"NCBIGene:100302213","MIR1181" -"NCBIGene:100302261","MIR1910" -"NCBIGene:100616374","MIR4539" -"NCBIGene:100302260","MIR2052" -"NCBIGene:100500849","MIR3916" -"NCBIGene:100616335","MIR219B" -"NCBIGene:693174","MIR589" -"NCBIGene:100847063","MIR548AX" -"NCBIGene:100500891","MIR3935" -"NCBIGene:693220","MIR635" -"NCBIGene:102466271","MIR6893" -"NCBIGene:406947","MIR155" -"NCBIGene:102464829","MIR6078" -"NCBIGene:100302131","MIR302F" -"NCBIGene:100302172","MIR1258" -"NCBIGene:100302258","MIR1469" -"NCBIGene:574517","MIR514A2" -"NCBIGene:100616384","MIR548AC" -"NCBIGene:406922","MIR133A1" -"NCBIGene:100302265","MIR1283-1" -"NCBIGene:693180","MIR595" -"NCBIGene:406993","MIR211" -"NCBIGene:100616292","MIR4690" -"NCBIGene:102466733","MIR6778" -"NCBIGene:100847068","MIR548AO" -"NCBIGene:102464823","MIR6068" -"NCBIGene:100500818","MIR3945" -"NCBIGene:100616430","MIR4644" -"NCBIGene:102465457","MIR6762" -"NCBIGene:100616426","MIR4694" -"NCBIGene:574453","MIR495" -"NCBIGene:100616402","MIR4696" -"NCBIGene:102466732","MIR6774" -"NCBIGene:102465882","MIR8089" -"NCBIGene:100422873","MIR4297" -"NCBIGene:102465453","MIR6756" -"NCBIGene:102465249","MIR6502" -"NCBIGene:102466197","MIR6810" -"NCBIGene:574464","MIR520F" -"NCBIGene:102465538","MIR6892" -"NCBIGene:693215","MIR630" -"NCBIGene:102465536","MIR6890" -"NCBIGene:102466727","MIR6749" -"NCBIGene:406891","MIRLET7I" -"NCBIGene:406893","MIR101-1" -"NCBIGene:100126354","MIR297" -"NCBIGene:442917","MIR372" -"NCBIGene:100500910","MIR3670-1" -"NCBIGene:574458","MIR512-1" -"NCBIGene:693198","MIR613" -"NCBIGene:100616414","MIR4761" -"NCBIGene:100616110","MIR2681" -"NCBIGene:100302255","MIR1323" -"NCBIGene:406890","MIRLET7G" -"NCBIGene:406970","MIR194-2" -"NCBIGene:102466806","MIR7108" -"NCBIGene:100847052","MIR664B" -"NCBIGene:406932","MIR140" -"NCBIGene:102465247","MIR548AY" -"NCBIGene:100616487","MIR4517" -"NCBIGene:693144","MIR559" -"NCBIGene:100616190","MIR548O2" -"NCBIGene:406886","MIRLET7D" -"NCBIGene:100616357","MIR3591" -"NCBIGene:100616439","MIR4658" -"NCBIGene:100616488","MIR548AK" -"NCBIGene:406938","MIR146A" -"NCBIGene:102465505","MIR6839" -"NCBIGene:442897","MIR323A" -"NCBIGene:100500809","MIR23C" -"NCBIGene:100847092","MIR548AS" -"NCBIGene:100313914","MIR548J" -"NCBIGene:102466758","MIR6889" -"NCBIGene:574032","MIR20B" -"NCBIGene:102465485","MIR6809" -"NCBIGene:406934","MIR142" -"NCBIGene:406985","MIR200C" -"NCBIGene:100302135","MIR320C1" -"NCBIGene:100500919","MIR548Y" -"NCBIGene:100126324","MIR934" -"NCBIGene:693158","MIR573" -"NCBIGene:100616356","MIR4774" -"NCBIGene:100126346","MIR190B" -"NCBIGene:100302204","MIR548I1" -"NCBIGene:407037","MIR320A" -"NCBIGene:100847084","MIR548AP" -"NCBIGene:100313887","MIR2277" -"NCBIGene:102465693","MIR7158" -"NCBIGene:100616150","MIR4720" -"NCBIGene:693175","MIR590" -"NCBIGene:574507","MIR504" -"NCBIGene:664614","MIR545" -"NCBIGene:100126314","MIR877" -"NCBIGene:102466199","MIR6825" -"NCBIGene:693171","MIR586" -"NCBIGene:100422883","MIR4325" -"NCBIGene:100616159","MIR4779" -"NCBIGene:102465801","MIR7703" -"NCBIGene:574030","MIR362" -"NCBIGene:100616166","MIR4796" -"NCBIGene:102465976","MIR6807" -"NCBIGene:102466731","MIR6769A" -"NCBIGene:100302118","MIR1286" -"NCBIGene:100422968","MIR4251" -"NCBIGene:100500814","MIR3616" -"NCBIGene:100846998","MIR5689" -"NCBIGene:100616298","MIR4419B" -"NCBIGene:100500864","MIR3929" -"NCBIGene:100847022","MIR5093" -"NCBIGene:100616124","MIR4647" -"NCBIGene:102466749","MIR6849" -"NCBIGene:554212","MIR448" -"NCBIGene:100616229","MIR4473" -"NCBIGene:100500842","MIR3652" -"NCBIGene:102465752","MIR7641-1" -"NCBIGene:102464831","MIR6080" -"NCBIGene:100616212","MIR3689F" -"NCBIGene:574031","MIR363" -"NCBIGene:102465665","MIR7107" -"NCBIGene:100616205","MIR4704" -"NCBIGene:100616351","MIR4670" -"NCBIGene:100313769","MIR320B2" -"NCBIGene:100847049","MIR4999" -"NCBIGene:768212","MIR758" -"NCBIGene:100500866","MIR3941" -"NCBIGene:102465466","MIR6777" -"NCBIGene:100422995","MIR3175" -"NCBIGene:102465841","MIR7855" -"NCBIGene:574472","MIR518F" -"NCBIGene:100616129","MIR4445" -"NCBIGene:100616347","MIR548AI" -"NCBIGene:574489","MIR518D" -"NCBIGene:406906","MIR122" -"NCBIGene:100302182","MIR1279" -"NCBIGene:100302243","MIR1972-1" -"NCBIGene:693225","MIR640" -"NCBIGene:100422895","MIR4294" -"NCBIGene:407039","MIR33A" -"NCBIGene:100302117","MIR320B1" -"NCBIGene:100616187","MIR4783" -"NCBIGene:102465440","MIR6735" -"NCBIGene:100616182","MIR4500" -"NCBIGene:100616319","MIR4493" -"NCBIGene:102464830","MIR6079" -"NCBIGene:100422931","MIR4304" -"NCBIGene:406935","MIR143" -"NCBIGene:100422898","MIR4255" -"NCBIGene:102466739","MIR6803" -"NCBIGene:102465465","MIR6776" -"NCBIGene:100847030","MIR548AT" -"NCBIGene:693160","MIR575" -"NCBIGene:102465874","MIR8075" -"NCBIGene:102466755","MIR6875" -"NCBIGene:100302251","MIR1264" -"NCBIGene:102465251","MIR6504" -"NCBIGene:100302132","MIR1182" -"NCBIGene:494337","MIR425" -"NCBIGene:100616397","MIR4440" -"NCBIGene:100422871","MIR3117" -"NCBIGene:100422827","MIR3160-1" -"NCBIGene:102465442","MIR6738" -"NCBIGene:102466757","MIR6884" -"NCBIGene:100126307","MIR892B" -"NCBIGene:100422853","MIR3182" -"NCBIGene:574451","MIR432" -"NCBIGene:100422984","MIR4308" -"NCBIGene:407045","MIR7-3" -"NCBIGene:100302122","MIR1183" -"NCBIGene:407055","MIR99A" -"NCBIGene:100847023","MIR5091" -"NCBIGene:442892","MIR148B" -"NCBIGene:100616447","MIR4780" -"NCBIGene:442899","MIR325" -"NCBIGene:442896","MIR302D" -"NCBIGene:100302158","MIR1231" -"NCBIGene:574512","MIR507" -"NCBIGene:100616264","MIR4527" -"NCBIGene:100616398","MIR4681" -"NCBIGene:100616328","MIR4424" -"NCBIGene:102466918","MIR8059" -"NCBIGene:100422957","MIR3131" -"NCBIGene:100422847","MIR514B" -"NCBIGene:102465138","MIR6131" -"NCBIGene:100616334","MIR4790" -"NCBIGene:407004","MIR22" -"NCBIGene:100302129","MIR1915" -"NCBIGene:100422973","MIR3169" -"NCBIGene:100422992","MIR3151" -"NCBIGene:100616396","MIR4712" -"NCBIGene:102466746","MIR6780B" -"NCBIGene:100500816","MIR3649" -"NCBIGene:407056","MIR99B" -"NCBIGene:406964","MIR188" -"NCBIGene:100616365","MIR4425" -"NCBIGene:100616460","MIR3689E" -"NCBIGene:407028","MIR302A" -"NCBIGene:693211","MIR626" -"NCBIGene:100422930","MIR4330" -"NCBIGene:100616289","MIR4475" -"NCBIGene:693217","MIR632" -"NCBIGene:102466726","MIR6745" -"NCBIGene:100616389","MIR4463" -"NCBIGene:574435","MIR376B" -"NCBIGene:406923","MIR133A2" -"NCBIGene:102465493","MIR6821" -"NCBIGene:100500867","MIR3684" -"NCBIGene:102465250","MIR6503" -"NCBIGene:100846991","MIR5197" -"NCBIGene:100422903","MIR4288" -"NCBIGene:102466983","MIR6766" -"NCBIGene:442913","MIR376C" -"NCBIGene:102465449","MIR6751" -"NCBIGene:100302214","MIR1277" -"NCBIGene:574488","MIR518A1" -"NCBIGene:100126339","MIR941-2" -"NCBIGene:102465448","MIR6748" -"NCBIGene:102465510","MIR6847" -"NCBIGene:406892","MIR100" -"NCBIGene:100616296","MIR4678" -"NCBIGene:407012","MIR24-1" -"NCBIGene:100616407","MIR4443" -"NCBIGene:100616304","MIR4499" -"NCBIGene:100616226","MIR4468" -"NCBIGene:100500869","MIR3672" -"NCBIGene:100616135","MIR4507" -"NCBIGene:100616345","MIR4426" -"NCBIGene:100500890","MIR3611" -"NCBIGene:100616388","MIR4723" -"NCBIGene:100126351","MIR939" -"NCBIGene:102465459","MIR6767" -"NCBIGene:693123","MIR449B" -"NCBIGene:100616424","MIR4707" -"NCBIGene:693129","MIR548C" -"NCBIGene:100423027","MIR4266" -"NCBIGene:100616360","MIR2467" -"NCBIGene:100616138","MIR4787" -"NCBIGene:102465496","MIR6826" -"NCBIGene:100616282","MIR4738" -"NCBIGene:100616378","MIR4784" -"NCBIGene:102466719","MIR6716" -"NCBIGene:100616209","MIR4461" -"NCBIGene:100126296","MIR298" -"NCBIGene:693202","MIR617" -"NCBIGene:100302125","MIR1289-1" -"NCBIGene:574447","MIR146B" -"NCBIGene:100616392","MIR4773-1" -"NCBIGene:100423020","MIR4258" -"NCBIGene:100423040","MIR3166" -"NCBIGene:100302166","MIR1322" -"NCBIGene:100422875","MIR3192" -"NCBIGene:100313892","MIR761" -"NCBIGene:693159","MIR574" -"NCBIGene:693197","MIR612" -"NCBIGene:100302257","MIR1539" -"NCBIGene:693221","MIR636" -"NCBIGene:100847047","MIR4666B" -"NCBIGene:100500887","MIR676" -"NCBIGene:693219","MIR634" -"NCBIGene:693127","MIR548A3" -"NCBIGene:100616312","MIR4478" -"NCBIGene:693230","MIR645" -"NCBIGene:100616250","MIR3960" -"NCBIGene:100500828","MIR3619" -"NCBIGene:406996","MIR214" -"NCBIGene:100616136","MIR4430" -"NCBIGene:100616489","MIR4417" -"NCBIGene:407018","MIR27A" -"NCBIGene:100616500","MIR4683" -"NCBIGene:100126323","MIR924" -"NCBIGene:724024","MIR654" -"NCBIGene:100126342","MIR892A" -"NCBIGene:102465458","MIR6765" -"NCBIGene:100616261","MIR4504" -"NCBIGene:100126297","MIR300" -"NCBIGene:100616114","MIR4668" -"NCBIGene:406958","MIR182" -"NCBIGene:100616321","MIR378G" -"NCBIGene:102466659","MIR6515" -"NCBIGene:100616214","MIR4667" -"NCBIGene:100616218","MIR3135B" -"NCBIGene:100847078","MIR548AQ" -"NCBIGene:102465257","MIR6514" -"NCBIGene:100126310","MIR876" -"NCBIGene:574408","MIR329-1" -"NCBIGene:100500835","MIR3907" -"NCBIGene:100616405","MIR4518" -"NCBIGene:100616468","MIR4742" -"NCBIGene:100616109","MIR4464" -"NCBIGene:100847079","MIR5193" -"NCBIGene:693141","MIR556" -"NCBIGene:407054","MIR98" -"NCBIGene:100422923","MIR548W" -"NCBIGene:102466081","MIR5739" -"NCBIGene:100302229","MIR1250" -"NCBIGene:100422865","MIR4320" -"NCBIGene:100126302","MIR450B" -"NCBIGene:442909","MIR342" -"NCBIGene:664617","MIR542" -"NCBIGene:100422860","MIR4292" -"NCBIGene:100616158","MIR4505" -"NCBIGene:100126308","MIR541" -"NCBIGene:100616244","MIR3976" -"NCBIGene:100500908","MIR3613" -"NCBIGene:100616276","MIR4538" -"NCBIGene:100302201","MIR1228" -"NCBIGene:102464832","MIR6083" -"NCBIGene:102466519","MIR6086" -"NCBIGene:100422917","MIR4283-1" -"NCBIGene:494335","MIR423" -"NCBIGene:100302259","MIR1202" -"NCBIGene:102466753","MIR6868" -"NCBIGene:406912","MIR125B2" -"NCBIGene:102465502","MIR6835" -"NCBIGene:100616421","MIR4689" -"NCBIGene:100616163","MIR4530" -"NCBIGene:100422951","MIR3144" -"NCBIGene:406900","MIR106B" -"NCBIGene:102465246","MIR6499" -"NCBIGene:100423037","MIR3176" -"NCBIGene:407000","MIR218-1" -"NCBIGene:723778","MIR650" -"NCBIGene:693216","MIR631" -"NCBIGene:100422971","MIR4312" -"NCBIGene:100616484","MIR4470" -"NCBIGene:100188847","MIR1225" -"NCBIGene:100423039","MIR3132" -"NCBIGene:100616301","MIR4674" -"NCBIGene:406963","MIR187" -"NCBIGene:102465803","MIR7706" -"NCBIGene:574455","MIR193B" -"NCBIGene:100616176","MIR4708" -"NCBIGene:693208","MIR623" -"NCBIGene:100616316","MIR4524A" -"NCBIGene:100423021","MIR4298" -"NCBIGene:100616242","MIR4673" -"NCBIGene:100616222","MIR4487" -"NCBIGene:100616494","MIR1269B" -"NCBIGene:100616416","MIR4727" -"NCBIGene:100302254","MIR1282" -"NCBIGene:100616290","MIR4529" -"NCBIGene:100616358","MIR4800" -"NCBIGene:100422921","MIR3149" -"NCBIGene:407011","MIR23B" -"NCBIGene:407027","MIR301A" -"NCBIGene:100616151","MIR4480" -"NCBIGene:102466972","MIR6508" -"NCBIGene:100616147","MIR4769" -"NCBIGene:100616413","MIR4462" -"NCBIGene:100422864","MIR544B" -"NCBIGene:102465462","MIR6771" -"NCBIGene:102466906","MIR6124" -"NCBIGene:100422888","MIR4264" -"NCBIGene:406887","MIRLET7E" -"NCBIGene:100847056","MIR5708" -"NCBIGene:100422850","MIR548V" -"NCBIGene:100422952","MIR4271" -"NCBIGene:442915","MIR370" -"NCBIGene:100302161","MIR1205" -"NCBIGene:102465452","MIR6755" -"NCBIGene:100616386","MIR4654" -"NCBIGene:102465432","MIR6723" -"NCBIGene:100616409","MIR4711" -"NCBIGene:100616146","MIR4534" -"NCBIGene:102466616","MIR6132" -"NCBIGene:102465427","MIR6715B" -"NCBIGene:100500858","MIR3622A" -"NCBIGene:100628560","MIR3155B" -"NCBIGene:693176","MIR591" -"NCBIGene:100126334","MIR885" -"NCBIGene:102466736","MIR6789" -"NCBIGene:102465861","MIR8055" -"NCBIGene:100422989","MIR3155A" -"NCBIGene:102466748","MIR6845" -"NCBIGene:100422857","MIR4318" -"NCBIGene:100313780","MIR2278" -"NCBIGene:100847036","MIR5186" -"NCBIGene:100500817","MIR3612" -"NCBIGene:100422994","MIR4267" -"NCBIGene:100422942","MIR3133" -"NCBIGene:100616112","MIR4793" -"NCBIGene:100422933","MIR378B" -"NCBIGene:100616278","MIR4540" -"NCBIGene:100313840","MIR2115" -"NCBIGene:102465526","MIR6872" -"NCBIGene:100616184","MIR4477A" -"NCBIGene:100616236","MIR4669" -"NCBIGene:102466190","MIR6721" -"NCBIGene:574493","MIR520H" -"NCBIGene:100422990","MIR3134" -"NCBIGene:100616387","MIR3064" -"NCBIGene:100500881","MIR3688-1" -"NCBIGene:406930","MIR138-2" -"NCBIGene:100500857","MIR3939" -"NCBIGene:406889","MIRLET7F2" -"NCBIGene:100313842","MIR2276" -"NCBIGene:100616246","MIR4799" -"NCBIGene:100616252","MIR548AJ2" -"NCBIGene:100302136","MIR1252" -"NCBIGene:100126350","MIR933" -"NCBIGene:102466515","MIR1199" -"NCBIGene:100847081","MIR5703" -"NCBIGene:102466204","MIR6880" -"NCBIGene:100500907","MIR3150B" -"NCBIGene:84981","MIR22HG" -"NCBIGene:100302164","MIR2113" -"NCBIGene:100422941","MIR4272" -"NCBIGene:693125","MIR548A1" -"NCBIGene:406924","MIR134" -"NCBIGene:102465483","MIR6805" -"NCBIGene:100616383","MIR4675" -"NCBIGene:406943","MIR152" -"NCBIGene:100616322","MIR4682" -"NCBIGene:693212","MIR627" -"NCBIGene:102464824","MIR6069" -"NCBIGene:100616354","MIR550A3" -"NCBIGene:100616255","MIR4662B" -"NCBIGene:100423041","MIR4296" -"NCBIGene:574518","MIR514A3" -"NCBIGene:100616284","MIR4489" -"NCBIGene:100616423","MIR4703" -"NCBIGene:574034","MIR433" -"NCBIGene:554214","MIR450A1" -"NCBIGene:768213","MIR671" -"NCBIGene:100616323","MIR4482" -"NCBIGene:100847039","MIR5092" -"NCBIGene:100313841","MIR548Q" -"NCBIGene:102465877","MIR8080" -"NCBIGene:407029","MIR30A" -"NCBIGene:406988","MIR205" -"NCBIGene:100302240","MIR1304" -"NCBIGene:554213","MIR449A" -"NCBIGene:100500856","MIR548Z" -"NCBIGene:100616305","MIR548AE1" -"NCBIGene:100616485","MIR4447" -"NCBIGene:100847035","MIR548AR" -"NCBIGene:100500850","MIR3682" -"NCBIGene:407025","MIR29B2" -"NCBIGene:102465993","MIR7847" -"NCBIGene:100500855","MIR3713" -"NCBIGene:693201","MIR616" -"NCBIGene:100616408","MIR5047" -"NCBIGene:102465690","MIR7153" -"NCBIGene:100422936","MIR3153" -"NCBIGene:100302138","MIR1292" -"NCBIGene:407034","MIR30E" -"NCBIGene:100500899","MIR3692" -"NCBIGene:100302185","MIR1204" -"NCBIGene:100126347","MIR887" -"NCBIGene:102465974","MIR6719" -"NCBIGene:102466741","MIR6813" -"NCBIGene:100500909","MIR3908" -"NCBIGene:102465256","MIR6513" -"NCBIGene:406992","MIR210" -"NCBIGene:100422926","MIR3137" -"NCBIGene:102465467","MIR6779" -"NCBIGene:100616499","MIR4435-1" -"NCBIGene:406952","MIR17" -"NCBIGene:100616258","MIR4516" -"NCBIGene:100616395","MIR4789" -"NCBIGene:100500859","MIR3921" -"NCBIGene:100302155","MIR1256" -"NCBIGene:100616479","MIR4635" -"NCBIGene:693143","MIR558" -"NCBIGene:768217","MIR769" -"NCBIGene:100422884","MIR548U" -"NCBIGene:407023","MIR299" -"NCBIGene:406962","MIR186" -"NCBIGene:102466872","MIR7975" -"NCBIGene:102465484","MIR6806" -"NCBIGene:100500863","MIR548AA1" -"NCBIGene:100616427","MIR5096" -"NCBIGene:100423000","MIR3161" -"NCBIGene:102466247","MIR1273H" -"NCBIGene:406999","MIR217" -"NCBIGene:693157","MIR572" -"NCBIGene:100847080","MIR5190" -"NCBIGene:102466198","MIR6817" -"NCBIGene:102466759","MIR6894" -"NCBIGene:102465454","MIR6758" -"NCBIGene:102465434","MIR6726" -"NCBIGene:102465500","MIR6833" -"NCBIGene:693203","MIR618" -"NCBIGene:100847083","MIR548AV" -"NCBIGene:102465495","MIR6824" -"NCBIGene:442890","MIR133B" -"NCBIGene:102465517","MIR6858" -"NCBIGene:100422842","MIR3074" -"NCBIGene:102464828","MIR6076" -"NCBIGene:100422955","MIR4273" -"NCBIGene:100847044","MIR5087" -"NCBIGene:100500854","MIR3671" -"NCBIGene:102465667","MIR7110" -"NCBIGene:102465878","MIR8082" -"NCBIGene:100126309","MIR875" -"NCBIGene:693166","MIR581" -"NCBIGene:100302112","MIR1284" -"NCBIGene:406942","MIR150" -"NCBIGene:102465689","MIR7152" -"NCBIGene:102466754","MIR6873" -"NCBIGene:102466878","MIR8078" -"NCBIGene:100616464","MIR4778" -"NCBIGene:102466205","MIR6887" -"NCBIGene:406946","MIR154" -"NCBIGene:102465489","MIR6815" -"NCBIGene:442904","MIR335" -"NCBIGene:100616419","MIR4434" -"NCBIGene:100422911","MIR500B" -"NCBIGene:102465872","MIR8073" -"NCBIGene:574484","MIR520G" -"NCBIGene:100616355","MIR4531" -"NCBIGene:100126343","MIR874" -"NCBIGene:100126313","MIR744" -"NCBIGene:100616287","MIR4495" -"NCBIGene:102465688","MIR7150" -"NCBIGene:102466723","MIR6734" -"NCBIGene:100616286","MIR4676" -"NCBIGene:100616224","MIR4753" -"NCBIGene:100847067","MIR5089" -"NCBIGene:100302270","MIR1305" -"NCBIGene:724023","MIR653" -"NCBIGene:406919","MIR130A" -"NCBIGene:100847006","MIR5571" -"NCBIGene:693170","MIR585" -"NCBIGene:619553","MIR484" -"NCBIGene:100500870","MIR3926-1" -"NCBIGene:406973","MIR196A2" -"NCBIGene:693140","MIR555" -"NCBIGene:100422900","MIR3158-1" -"NCBIGene:102465460","MIR6768" -"NCBIGene:100313822","MIR513B" -"NCBIGene:619552","MIR483" -"NCBIGene:102465522","MIR6865" -"NCBIGene:102465863","MIR8058" -"NCBIGene:100422830","MIR3171" -"NCBIGene:406928","MIR137" -"NCBIGene:102465439","MIR6733" -"NCBIGene:100422823","MIR4300" -"NCBIGene:100302225","MIR2053" -"NCBIGene:100422870","MIR3180-1" -"NCBIGene:406897","MIR105-1" -"NCBIGene:100616272","MIR4422" -"NCBIGene:102465836","MIR7846" -"NCBIGene:100302142","MIR1246" -"NCBIGene:100423009","MIR4329" -"NCBIGene:693207","MIR622" -"NCBIGene:724027","MIR657" -"NCBIGene:102466866","MIR7853" -"NCBIGene:407017","MIR26B" -"NCBIGene:100616235","MIR4457" -"NCBIGene:100616186","MIR4490" -"NCBIGene:100422835","MIR3183" -"NCBIGene:100616247","MIR151B" -"NCBIGene:100126326","MIR936" -"NCBIGene:693204","MIR619" -"NCBIGene:102465531","MIR6882" -"NCBIGene:100616352","MIR4642" -"NCBIGene:100616116","MIR4648" -"NCBIGene:406957","MIR181C" -"NCBIGene:100422901","MIR3135A" -"NCBIGene:494329","MIR380" -"NCBIGene:100616160","MIR4655" -"NCBIGene:407001","MIR218-2" -"NCBIGene:100616344","MIR3689D2" -"NCBIGene:100422833","MIR3188" -"NCBIGene:100302156","MIR1229" -"NCBIGene:100616267","MIR4776-1" -"NCBIGene:100302187","MIR1297" -"NCBIGene:102465445","MIR6743" -"NCBIGene:693209","MIR624" -"NCBIGene:100616119","MIR4697" -"NCBIGene:693184","MIR599" -"NCBIGene:100422977","MIR1184-3" -"NCBIGene:100616340","MIR4758" -"NCBIGene:724022","MIR652" -"NCBIGene:406913","MIR126" -"NCBIGene:406931","MIR139" -"NCBIGene:100422862","MIR548S" -"NCBIGene:100616180","MIR4465" -"NCBIGene:102466227","MIR7162" -"NCBIGene:100126340","MIR944" -"NCBIGene:102465695","MIR7160" -"NCBIGene:100422987","MIR3202-1" -"NCBIGene:100126338","MIR937" -"NCBIGene:100422878","MIR3168" -"NCBIGene:100847064","MIR5694" -"NCBIGene:100423034","MIR3199-1" -"NCBIGene:664612","MIR539" -"NCBIGene:102466189","MIR6715A" -"NCBIGene:100500865","MIR3936" -"NCBIGene:100616118","MIR4486" -"NCBIGene:100500906","MIR3689B" -"NCBIGene:100423032","MIR3121" -"NCBIGene:100302224","MIR2110" -"NCBIGene:100616269","MIR4639" -"NCBIGene:102466865","MIR7848" -"NCBIGene:100500826","MIR3909" -"NCBIGene:100616346","MIR4649" -"NCBIGene:102465511","MIR6848" -"NCBIGene:102466721","MIR892C" -"NCBIGene:100616162","MIR4483" -"NCBIGene:100126315","MIR665" -"NCBIGene:102465668","MIR7111" -"NCBIGene:102466879","MIR8083" -"NCBIGene:100422899","MIR3190" -"NCBIGene:100423033","MIR3158-2" -"NCBIGene:100616270","MIR4651" -"NCBIGene:619555","MIR487A" -"NCBIGene:100422948","MIR4284" -"NCBIGene:693193","MIR608" -"NCBIGene:574413","MIR409" -"NCBIGene:100302263","MIR1908" -"NCBIGene:100616435","MIR4801" -"NCBIGene:100616206","MIR4652" -"NCBIGene:100616366","MIR4743" -"NCBIGene:100616367","MIR4467" -"NCBIGene:100847020","MIR5582" -"NCBIGene:100616437","MIR1343" -"NCBIGene:100500846","MIR3689A" -"NCBIGene:100616178","MIR4641" -"NCBIGene:100422945","MIR4326" -"NCBIGene:100616213","MIR4437" -"NCBIGene:100422943","MIR3189" -"NCBIGene:100847032","MIR5707" -"NCBIGene:100616433","MIR4418" -"NCBIGene:100500843","MIR3922" -"NCBIGene:100616333","MIR3689C" -"NCBIGene:100616202","MIR4634" -"NCBIGene:102465477","MIR6796" -"NCBIGene:100422928","MIR3127" -"NCBIGene:100616391","MIR4684" -"NCBIGene:100422902","MIR3116-1" -"NCBIGene:100126304","MIR891B" -"NCBIGene:100616465","MIR4656" -"NCBIGene:100616476","MIR4446" -"NCBIGene:102464835","MIR6087" -"NCBIGene:100616239","MIR4705" -"NCBIGene:407030","MIR30B" -"NCBIGene:100847074","MIR5088" -"NCBIGene:100500876","MIR3675" -"NCBIGene:100313838","MIR764" -"NCBIGene:100616415","MIR4535" -"NCBIGene:102464837","MIR6089" -"NCBIGene:100422874","MIR4279" -"NCBIGene:102467003","MIR7851" -"NCBIGene:100616422","MIR4537" -"NCBIGene:100422894","MIR4260" -"NCBIGene:100847003","MIR5693" -"NCBIGene:406953","MIR18A" -"NCBIGene:693235","MIR92B" -"NCBIGene:494324","MIR375" -"NCBIGene:100422829","MIR4319" -"NCBIGene:100500896","MIR3666" -"NCBIGene:100616215","MIR548AL" -"NCBIGene:100422924","MIR4303" -"NCBIGene:100616332","MIR4716" -"NCBIGene:100616403","MIR4691" -"NCBIGene:406907","MIR124-1" -"NCBIGene:100500822","MIR3937" -"NCBIGene:100422916","MIR3201" -"NCBIGene:100126306","MIR888" -"NCBIGene:442900","MIR326" -"NCBIGene:693181","MIR596" -"NCBIGene:100422970","MIR1273D" -"NCBIGene:100616329","MIR4700" -"NCBIGene:100616291","MIR4791" -"NCBIGene:102466235","MIR7515" -"NCBIGene:100500837","MIR3606" -"NCBIGene:724025","MIR655" -"HP:0010463","Aplasia of the ovary" -"HP:0011060","Dentinogenesis imperfecta limited to primary teeth" -"HP:0011540","Congenitally corrected transposition of the great arteries" -"HP:0010662","Abnormality of the diencephalon" -"HP:0000982","Palmoplantar keratoderma" -"HP:0000434","Nasal mucosa telangiectasia" -"HP:0006485","Agenesis of incisor" -"HP:0007404","Nonepidermolytic palmoplantar keratoderma" -"HP:0100031","Neoplasm of the thyroid gland" -"HP:0012152","Foveoschisis" -"HP:0012742","Thin fingernail" -"HP:0030613","Abnormal foveal morphology on macular OCT" -"HP:0031166","Eyelid myokymia" -"HP:0002361","Psychomotor deterioration" -"HP:0010801","Underdeveloped nasolabial fold" -"HP:0001786","Narrow foot" -"HP:0000478","Abnormality of the eye" -"HP:0000269","Prominent occiput" -"HP:0007435","Diffuse palmoplantar keratoderma" -"HP:0012763","Paroxysmal dyspnea" -"HP:0004283","Narrow palm" -"HP:0008905","Rhizomelia" -"HP:0100024","Conspicuously happy disposition" -"HP:0007293","Anterior sacral meningocele" -"HP:0006477","Abnormality of the alveolar ridges" -"HP:0011225","Epiblepharon" -"HP:0200071","Peripheral vitreoretinal degeneration" -"HP:0005580","Duplication of renal pelvis" -"HP:0003302","Spondylolisthesis" -"HP:0002486","Myotonia" -"HP:0010545","Downbeat nystagmus" -"HP:0006463","Rickets of the lower limbs" -"HP:0001338","Partial agenesis of the corpus callosum" -"HP:0003805","Rimmed vacuoles" -"HP:0009051","Increased muscle glycogen content" -"HP:0001863","Toe clinodactyly" -"HP:0002315","Headache" -"HP:0010521","Gait apraxia" -"HP:0003559","Muscle hyperirritability" -"HP:0012819","Myocarditis" -"HP:0030957","Ventricular septal aneurysm" -"HP:0012040","Corneal stromal edema" -"HP:0030455","Abnormality of pattern visual evoked potentials" -"HP:0008063","Aplasia/Hypoplasia of the lens" -"HP:0002093","Respiratory insufficiency" -"HP:0001891","Iron deficiency anemia" -"HP:0002728","Chronic mucocutaneous candidiasis" -"HP:0031015","Intrahepatic portal vein sclerosis" -"HP:0003376","Steppage gait" -"HP:0031328","Perivascular cardiac fibrosis" -"HP:0100274","Gustatory lacrimation" -"HP:0004878","Intercostal muscle weakness" -"HP:0011444","Decorticate rigidity" -"HP:0009445","Symphalangism of the 3rd finger" -"HP:0001115","Posterior polar cataract" -"HP:0025177","Peribronchovascular interstitial thickening" -"HP:0040141","Tardive dyskinesia" -"HP:0025176","Intralobular interstitial thickening" -"HP:0004461","Congenital earlobe sinuses" -"HP:0100432","Broad distal phalanx of the 4th toe" -"HP:0005474","Decreased calvarial ossification" -"HP:0030992","Abnormal pancreatic duct morphology" -"HP:0012580","Calcium phosphate nephrolithiasis" -"HP:0012459","Hypnic headache" -"HP:0012228","Tension-type headache" -"HP:0004150","Abnormality of the 3rd finger" -"HP:0003730","EMG: myotonic runs" -"HP:0100783","Breast aplasia" -"HP:0011358","Generalized hypopigmentation of hair" -"HP:0100428","Broad proximal phalanx of the 3rd toe" -"HP:0008935","Generalized neonatal hypotonia" -"HP:0004100","Abnormality of the 2nd finger" -"HP:0012318","Occipital neuralgia" -"HP:0012899","Handgrip myotonia" -"HP:0001139","Choroideremia" -"HP:0031784","Abnormal ascending aorta morphology" -"HP:0012904","Cold-sensitive myotonia" -"HP:0008141","Dislocation of toes" -"HP:0410008","Abnormality of the peripheral nervous system" -"HP:0031329","Interstitial cardiac fibrosis" -"HP:0008311","Spinal cord posterior columns myelin loss" -"HP:0100431","Broad distal phalanx of the 3rd toe" -"HP:0010042","Aplasia/Hypoplasia of the 4th metacarpal" -"HP:0100429","Broad proximal phalanx of the 4th toe" -"HP:0010810","Long uvula" -"HP:0006370","Distal ulnar epiphyseal stippling" -"HP:0012199","Cluster headache" -"HP:0004784","Juvenile gastrointestinal polyposis" -"HP:0005524","Macrocytic hemolytic disease" -"HP:0005234","Neonatal intestinal obstruction" -"HP:0003939","Humeroulnar synostosis" -"HP:0030595","Abnormal static automated perimetry test" -"HP:0002335","Agenesis of cerebellar vermis" -"HP:0006771","Duodenal adenocarcinoma" -"HP:0410014","Abnormality of ganglion" -"HP:0003740","Myotonia with warm-up phenomenon" -"HP:0025175","Honeycomb lung" -"HP:0005986","Limitation of neck motion" -"HP:0030663","Optically empty vitreous" -"HP:0012901","Myotonia of the jaw" -"HP:0012639","Abnormality of nervous system morphology" -"HP:0006677","Prolonged QRS complex" -"HP:0030907","Thunderclap headache" -"HP:0003888","Flattened humeral heads" -"HP:0030745","Dilatation of the ductus arteriosus" -"HP:0010635","Partial hyposmia" -"HP:0002195","Dysgenesis of the cerebellar vermis" -"HP:0011809","Paradoxical myotonia" -"HP:0012900","Myotonia of the face" -"HP:0011586","Thoracoabdominal ectopia cordis" -"HP:0100430","Broad proximal phalanx of the 5th toe" -"HP:0007643","Peripheral traction retinal detachment" -"HP:0006482","Abnormality of dental morphology" -"HP:0011266","Microtia, first degree" -"HP:0025178","Subpleural interstitial thickening" -"HP:0000060","Clitoral hypoplasia" -"HP:0008041","Late onset congenital glaucoma" -"HP:0009886","Trichorrhexis nodosa" -"HP:0012700","Abnormal large intestine physiology" -"HP:0011381","Aplasia of the semicircular canal" -"HP:0030786","Photopsia" -"HP:0200083","Severe limb shortening" -"HP:0009654","Osteolytic defect of thumb phalanx" -"HP:0100596","Absent nares" -"HP:0005365","Severe B lymphocytopenia" -"HP:0002118","Abnormality of the cerebral ventricles" -"HP:0005304","Hypoplastic pulmonary veins" -"HP:0010942","Echogenic intracardiac focus" -"HP:0008096","Medially deviated second toe" -"HP:0009719","Hypomelanotic macule" -"HP:0030298","Metaphyseal chondromatosis of humerus" -"HP:0025335","Delayed ability to stand" -"HP:0030290","Unossified sacrum" -"HP:0012821","Unilateral vocal cord paresis" -"HP:0009618","Abnormality of the proximal phalanx of the thumb" -"HP:0001615","Hoarse cry" -"HP:0002996","Limited elbow movement" -"HP:0006282","Generalized hypoplasia of dental enamel" -"HP:0030511","Bradyopsia" -"HP:0009226","Short proximal phalanx of the 5th finger" -"HP:0410068","Increased level of L-glutamic acid in blood" -"HP:0025163","Abnormality of optic chiasm morphology" -"HP:0005856","Ulnar radial head dislocation" -"HP:0002236","Frontal upsweep of hair" -"HP:0100832","Vitreous floaters" -"HP:0012330","Pyelonephritis" -"HP:0009550","Osteolytic defects of the phalanges of the 2nd finger" -"HP:0010064","Symphalangism affecting the phalanges of the hallux" -"HP:0003781","Excessive salivation" -"HP:0003951","Distal humeral metaphyseal irregularity" -"HP:0025072","Prominent U wave" -"HP:0100809","Scalp tenderness" -"HP:0010097","Partial duplication of the distal phalanx of the hallux" -"HP:0009847","Osteolytic defects of the middle phalanges of the hand" -"HP:0030297","Metaphyseal chondromatosis of ulna" -"HP:0000777","Abnormality of the thymus" -"HP:0030294","Metaphyseal chondromatosis of tibia" -"HP:0008464","Absent spinous processes of lower thoracic and lumbar vertebrae" -"HP:0005113","Aortic arch aneurysm" -"HP:0005168","Elevated right atrial pressure" -"HP:0001583","Rotary nystagmus" -"HP:0000848","Increased circulating renin level" -"HP:0005825","Mixed sclerosis of humeral metaphyses" -"HP:0001222","Spatulate thumbs" -"HP:0001868","Autoamputation of foot" -"HP:0004216","Osteolytic defects of the phalanges of the 5th finger" -"HP:0012304","Hypoplastic aortic arch" -"HP:0009903","Conjunctival nodule" -"HP:0031348","Dextrotransposition of the great arteries" -"HP:3000056","Abnormality of artery of lower lip" -"HP:0007109","Periventricular cysts" -"HP:0000244","Brachyturricephaly" -"HP:0025340","Deep episcleral hyperemia" -"HP:0006899","Fusion of the cerebellar hemispheres" -"HP:0040022","Clinodactyly of the 2nd finger" -"HP:0002203","Respiratory paralysis" -"HP:0009597","Short proximal phalanx of the 2nd finger" -"HP:0010755","Asymmetry of the maxilla" -"HP:0005759","Small flat posterior fossa" -"HP:0025085","Bloody diarrhea" -"HP:0000921","Missing ribs" -"HP:0045049","Abnormal DLCO" -"HP:0011514","Abnormality of binocular vision" -"HP:0025170","Neuronal/glioneuronal neoplasm of the central nervous system" -"HP:0100556","Hemiatrophy" -"HP:0003859","Cortical diaphyseal thickening of the upper limbs" -"HP:0025371","Delayed ossification of the sacrum" -"HP:0002786","Tracheobronchomalacia" -"HP:0001361","Nystagmus-induced head nodding" -"HP:0012844","Trichilemmoma" -"HP:0006019","Reduced proximal interphalangeal joint space" -"HP:0030969","Abnormal pulmonary vein physiology" -"HP:0007010","Poor fine motor coordination" -"HP:0005295","Pseudocoarctation of the aorta" -"HP:0009855","Osteolytic defects of the proximal phalanges of the hand" -"HP:0001604","Vocal cord paresis" -"HP:0040277","Neoplasm of the pituitary gland" -"HP:0009443","Osteolytic defects of the phalanges of the 3rd finger" -"HP:0006799","Basal ganglia cysts" -"HP:0012428","Prominent calcaneus" -"HP:0012096","Intracranial epidermoid cyst" -"HP:0025088","Onychomadesis" -"HP:0010544","Vertical nystagmus" -"HP:0030295","Metaphyseal chondromatosis of femur" -"HP:0008055","Aplasia/Hypoplasia affecting the uvea" -"HP:0010880","Increased nuchal translucency" -"HP:0009721","Shagreen patch" -"HP:0031284","Flushing" -"HP:0004887","Respiratory failure requiring assisted ventilation" -"HP:0007874","Almond-shaped palpebral fissure" -"HP:0004195","Osteolytic defects of the phalanges of the 4th finger" -"HP:0007985","Retinal arteriolar occlusion" -"HP:0006459","Dorsal subluxation of ulna" -"HP:0001430","Abnormality of the calf musculature" -"HP:0005070","Proximal radial head dislocation" -"HP:0008750","Laryngeal atresia" -"HP:0006420","Asymmetric radial dysplasia" -"HP:0011414","Hydropic placenta" -"HP:0200003","Splayed epiphyses" -"HP:0000893","Bulging of the costochondral junction" -"HP:0003651","Foam cells" -"HP:0006368","Forearm reduction defects" -"HP:0010052","Abnormality of the proximal phalanx of the hallux" -"HP:0007680","Depigmented fundus" -"HP:0001645","Sudden cardiac death" -"HP:0006565","Increased hepatocellular lipid droplets" -"HP:0000276","Long face" -"HP:0008371","Abnormal metatarsal ossification" -"HP:0012520","Perivascular spaces" -"HP:0001902","Giant platelets" -"HP:0004963","Calcification of the aorta" -"HP:0003209","Decreased pyruvate carboxylase activity" -"HP:0004458","Dilatated internal auditory canal" -"HP:0100557","Hemiatrophy of lower limb" -"HP:0010980","Hyperlipoproteinemia" -"HP:0031573","Tessier number 2 facial cleft" -"HP:0012464","Decreased transferrin saturation" -"HP:0010997","Chromosomal breakage induced by ionizing radiation" -"HP:0003606","Absent urinary urothione" -"HP:0031258","Delirium" -"HP:0002275","Poor motor coordination" -"HP:0004690","Thickened Achilles tendon" -"HP:0000148","Vaginal atresia" -"HP:0003911","Flared humeral metaphysis" -"HP:0030368","Hyperphalangy of the 2nd finger" -"HP:0010672","Abnormality of the third metatarsal bone" -"HP:0030050","Narcolepsy" -"HP:0025012","Status cribrosum" -"HP:0004929","Coronary atherosclerosis" -"HP:0012567","Premature epimetaphyseal fusion in ulna" -"HP:0010867","Dyssynergia" -"HP:0001084","Corneal arcus" -"HP:0009650","Short distal phalanx of the thumb" -"HP:0012005","Deja vu" -"HP:0010639","Elevated alkaline phosphatase of bone origin" -"HP:0002690","Large sella turcica" -"HP:0011923","Decreased activity of mitochondrial complex I" -"HP:0031572","Tessier number 1 facial cleft" -"HP:0004446","Stomatocytosis" -"HP:0012115","Hepatitis" -"HP:0006705","Abnormality of the atrioventricular valves" -"HP:0004368","Increased purine levels" -"HP:0003233","Decreased circulating high-density lipoprotein levels" -"HP:0004921","Abnormality of magnesium homeostasis" -"HP:0010829","Impaired temperature sensation" -"HP:0001892","Abnormal bleeding" -"HP:0012347","Abnormal protein N-linked glycosylation" -"HP:0003215","Dicarboxylic aciduria" -"HP:0006573","Acute hepatic steatosis" -"HP:0012870","Vanishing testis" -"HP:0006146","Broad metacarpal epiphyses" -"HP:0001842","Foot acroosteolysis" -"HP:0011980","Cholesterol gallstones" -"HP:0010241","Short proximal phalanx of finger" -"HP:0002155","Hypertriglyceridemia" -"HP:0030164","Jaw claudication" -"HP:0031169","Postterm pregnancy" -"HP:0007536","Aplasia cutis congenita of midline scalp vertex" -"HP:0004802","Episodic hemolytic anemia" -"HP:0006162","Soft tissue swelling of interphalangeal joints" -"HP:0030995","Peritoneal effusion" -"HP:0002470","Nonprogressive cerebellar ataxia" -"HP:0031585","Tessier number 13 facial cleft" -"HP:0007394","Prominent superficial blood vessels" -"HP:0001075","Atrophic scars" -"HP:0004637","Decreased cervical spine mobility" -"HP:0005989","Redundant neck skin" -"HP:0002131","Episodic ataxia" -"HP:0004763","Paroxysmal supraventricular tachycardia" -"HP:0010796","Brainstem glioma" -"HP:0000503","Tortuosity of conjunctival vessels" -"HP:0007201","Cerebral artery atherosclerosis" -"HP:0012067","Glycopeptiduria" -"HP:0002223","Absent eyebrow" -"HP:0010795","Cerebellar glioma" -"HP:0011276","Vascular skin abnormality" -"HP:0010584","Pseudoepiphyses" -"HP:0000227","Tongue telangiectasia" -"HP:0040096","Neoplasm of the inner ear" -"HP:0010577","Absent epiphyses" -"HP:0006268","Fluctuating splenomegaly" -"HP:0005723","Shoe-shaped sella turcica" -"HP:0008756","Bowing of the vocal cords" -"HP:0012019","Lens luxation" -"HP:0008107","Plantar crease between first and second toes" -"HP:0007466","Midfrontal capillary hemangioma" -"HP:0007589","Aplasia cutis congenita on trunk or limbs" -"HP:0012044","Seesaw nystagmus" -"HP:0100816","Lip hyperpigmentation" -"HP:0011251","Underdeveloped antitragus" -"HP:0003053","Epiphyseal deformities of tubular bones" -"HP:0031244","Swollen lip" -"HP:0031235","Predominantly epidermal neutrophilic infiltrate" -"HP:0006286","Yellow-brown discoloration of the teeth" -"HP:0010162","Absent epiphyses of the toes" -"HP:0012350","Decreased sialylation of N-linked protein glycosylation" -"HP:0007015","Poor gross motor coordination" -"HP:0012460","Dysmorphic inferior cerebellar vermis" -"HP:0011997","Postprandial hyperlactemia" -"HP:0011390","Morphological abnormality of the inner ear" -"HP:0010939","Abnormality of the nasal bone" -"HP:0030219","Semantic dementia" -"HP:0005725","Nonopposable triphalangeal thumb" -"HP:0001592","Selective tooth agenesis" -"HP:0030874","Oxygen desaturation on exertion" -"HP:0030454","Abnormal electrooculogram" -"HP:0007378","Neoplasm of the gastrointestinal tract" -"HP:0005151","Preductal coarctation of the aorta" -"HP:0004990","Epiphyseal streaking" -"HP:0001005","Dermatological manifestations of systemic disorders" -"HP:0031250","Lip fissure" -"HP:0002538","Abnormality of the cerebral cortex" -"HP:0025118","Lip discoloration" -"HP:0011989","Ectopic ossification in ligament tissue" -"HP:0030313","Abnormal periosteum morphology" -"HP:0006927","Unilateral polymicrogyria" -"HP:0010714","2-4 toe syndactyly" -"HP:0011988","Ectopic ossification in tendon tissue" -"HP:0012305","Coarctation of the descending aortic arch" -"HP:0025374","Duplicated odontoid process" -"HP:0001459","1-3 toe syndactyly" -"HP:0000930","Elevated imprint of the transverse sinuses" -"HP:0003837","Soft-tissue ossification around the shoulders" -"HP:0002711","Exaggerated median tongue furrow" -"HP:0004608","Anteriorly placed odontoid process" -"HP:0010655","Epiphyseal stippling" -"HP:0004634","Cuboid-shaped vertebral bodies" -"HP:0001691","Muscular subvalvular aortic stenosis" -"HP:0008401","Onychogryposis of toenails" -"HP:0008661","Urethral stenosis" -"HP:0010588","Premature epimetaphyseal fusion" -"HP:0006189","Prominent interdigital folds" -"HP:0005043","Proximal humeral metaphyseal irregularity" -"HP:0200054","Foot monodactyly" -"HP:0012756","CSF polymorphonuclear pleocytosis" -"HP:0031144","Coarsened hepatic echotexture" -"HP:0005665","Massively thickened long bone cortices" -"HP:0009946","Polydactyly affecting the 2nd finger" -"HP:0031486","Vascular malformation of the lip" -"HP:0011734","Central adrenal insufficiency" -"HP:0030903","Grasp reflex" -"HP:0045043","Decreased serum complement C4a" -"HP:0011587","Abnormal branching pattern of the aortic arch" -"HP:0000080","Abnormality of reproductive system physiology" -"HP:0005174","Membranous subvalvular aortic stenosis" -"HP:0008125","Second metatarsal posteriorly placed" -"HP:0030330","Multinucleated giant chondrocytes in epiphyseal cartilage" -"HP:0000289","Broad philtrum" -"HP:0004591","Disc-like vertebral bodies" -"HP:0011721","Infracardiac total anomalous pulmonary venous connection" -"HP:0003329","Hair shafts flattened at irregular intervals and twisted through 180 degrees about their axes" -"HP:0009630","Broad proximal phalanx of the thumb" -"HP:0025029","Abnormality of enteric neuron morphology" -"HP:0012651","Abasia" -"HP:0004432","Agammaglobulinemia" -"HP:0002949","Fused cervical vertebrae" -"HP:0003149","Hyperuricosuria" -"HP:0004664","Facial midline hemangioma" -"HP:0004453","Overfolding of the superior helices" -"HP:0002972","Reduced delayed hypersensitivity" -"HP:0006433","Dysplastic radii" -"HP:0011406","Infancy onset short-trunk short stature" -"HP:0010067","Aplasia/hypoplasia of the 1st metatarsal" -"HP:0004743","Chronic tubulointerstitial nephritis" -"HP:0011632","Partial right sided absence of pericardium" -"HP:0100378","Absent distal phalanx of the 3rd toe" -"HP:0008718","Unilateral renal dysplasia" -"HP:0003026","Short long bone" -"HP:0012566","Premature epimetaphyseal fusion in radius" -"HP:0012583","Unilateral renal hypoplasia" -"HP:0040115","Abnormality of the Eustachian tube" -"HP:0100351","Contractures of the proximal interphalangeal joint of the 5th toe" -"HP:0030445","Pulmonary carcinoid tumor" -"HP:0040203","Abnormal CSF neopterin level" -"HP:0011471","Gastrostomy tube feeding in infancy" -"HP:0011719","Supracardiac total anomalous pulmonary venous connection" -"HP:0100355","Contractures of the distal interphalangeal joint of the 5th toe" -"HP:0025455","Decreased CSF 5-hydroxyindolacetic acid" -"HP:0000456","Bifid nasal tip" -"HP:0004429","Recurrent viral infections" -"HP:0005208","Secretory diarrhea" -"HP:0100255","Metaphyseal dysplasia" -"HP:0030869","Anorchism" -"HP:0001259","Coma" -"HP:0100379","Aplasia of the distal phalanx of the 4th toe" -"HP:0008969","Leg muscle stiffness" -"HP:0011921","Exudative pleural effusion" -"HP:0005864","Pseudoarthrosis" -"HP:0011720","Cardiac total anomalous pulmonary venous connection" -"HP:0011634","Partial left sided absence of pericardium" -"HP:0002171","Gliosis" -"HP:0100830","Round ear" -"HP:0100242","Sarcoma" -"HP:0100376","Aplasia/hypoplasia of the proximal phalanx of the 4th toe" -"HP:0000537","Epicanthus inversus" -"HP:0009725","Bladder neoplasm" -"HP:0000648","Optic atrophy" -"HP:0100663","Synotia" -"HP:0011316","Left unicoronal synostosis" -"HP:0008857","Neonatal short-trunk short stature" -"HP:0010551","Paraplegia/paraparesis" -"HP:0011950","Bronchiolitis" -"HP:0005901","Chronic recurrent multifocal osteomyelitis" -"HP:0200040","Epidermoid cyst" -"HP:0008929","Asymmetric short stature" -"HP:0008551","Microtia" -"HP:0005547","Myeloproliferative disorder" -"HP:0005687","Deformed humeral heads" -"HP:0030960","Abnormal pupillary morphology" -"HP:0003140","T-wave inversion in the right precordial leads" -"HP:0011155","Focal autonomic seizures with altered responsiveness" -"HP:0011086","Dentinogenesis imperfecta of primary and permanent teeth" -"HP:3000008","Abnormality of mylohyoid muscle" -"HP:0012751","Abnormal basal ganglia MRI signal intensity" -"HP:0005422","Absence of CD8+ T cells" -"HP:0002067","Bradykinesia" -"HP:0007307","Rapid neurologic deterioration" -"HP:0011404","Lethal short-trunk short stature" -"HP:0004485","Cessation of head growth" -"HP:0001840","Metatarsus adductus" -"HP:0040051","Abnormality of upper eyelashes" -"HP:0040292","Left hemiplegia" -"HP:0003698","Difficulty standing" -"HP:0200029","Vasculitis in the skin" -"HP:0011688","Supraventricular tachycardia with an accessory connection mediated pathway" -"HP:0002108","Spontaneous pneumothorax" -"HP:0012002","Experiential auras" -"HP:0001019","Erythroderma" -"HP:0012861","Ovotestis" -"HP:0002273","Tetraparesis" -"HP:0030877","Obstructive deficit on pulmonary function testing" -"HP:0100784","Peripheral arteriovenous fistula" -"HP:0100869","Palmar telangiectasia" -"HP:0011412","Ventouse delivery" -"HP:0006893","Severely dysplastic cerebellum" -"HP:0003251","Male infertility" -"HP:0100297","Increased endomysial connective tissue" -"HP:0003612","Positive ferric chloride test" -"HP:0100500","Fibular deviation of toes" -"HP:0100288","EMG: myokymic discharges" -"HP:0030813","Absent tonsils" -"HP:0001028","Hemangioma" -"HP:0011598","Right aortic arch with retroesophageal left subclavian artery" -"HP:0430006","Ectopic cilia of eyelid" -"HP:0009852","Broad proximal phalanges of the hand" -"HP:0002514","Cerebral calcification" -"HP:0007271","Occipital myelomeningocele" -"HP:0011262","Crimped helix" -"HP:0006650","Thickening of the lateral border of the scapula" -"HP:0100848","Neoplasm of the male external genitalia" -"HP:0010517","Ectopic thymus tissue" -"HP:0000472","Long neck" -"HP:0011387","Enlarged vestibular aqueduct" -"HP:0007733","Laterally curved eyebrow" -"HP:0012419","Hyperoxemia" -"HP:0006460","Increased laxity of ankles" -"HP:0030451","Mesenteric cyst" -"HP:0011230","Laterally extended eyebrow" -"HP:0002951","Partial absence of cerebellar vermis" -"HP:0005072","Hyperextensibility at wrists" -"HP:0010115","Cone-shaped epiphyses of the hallux" -"HP:0001541","Ascites" -"HP:0011710","Bundle branch block" -"HP:0410023","Abnormal distribution of cell junction proteins in buccal mucosal cells" -"HP:0005831","Type B brachydactyly" -"HP:0011473","Villous atrophy" -"HP:0002763","Abnormal cartilage morphology" -"HP:0000321","Square face" -"HP:0009818","Amelia involving the lower limbs" -"HP:0009895","Abnormality of the crus of the helix" -"HP:0000492","Abnormality of the eyelid" -"HP:0200114","Metabolic alkalosis" -"HP:0040270","Decreased glucose tolerance" -"HP:0001360","Holoprosencephaly" -"HP:0410016","Abnormality of cranial ganglion" -"HP:0010292","Absent uvula" -"HP:0030742","Glial remnants posterior to lens" -"HP:0001907","Thromboembolism" -"HP:0410051","Increased level of 3-hydroxy-3-methylglutaric acid in urine" -"HP:0006849","Hypodysplasia of the corpus callosum" -"HP:0006251","Limited wrist extension" -"HP:0009373","Type C brachydactyly" -"HP:0008368","Tarsal synostosis" -"HP:0011995","Atrial septal dilatation" -"HP:0000518","Cataract" -"HP:0100068","Cone-shaped epiphyses of the 4th toe" -"HP:0008523","Posterior helix pit" -"HP:0012505","Enlarged pituitary gland" -"HP:0410015","Abnormality of ganglion of peripheral nervous system" -"HP:0045082","Decreased body mass index" -"HP:0010058","Aplasia/Hypoplasia of the phalanges of the hallux" -"HP:0006118","Shortening of all distal phalanges of the fingers" -"HP:0100581","Dilatation of renal calices" -"HP:0002840","Lymphadenitis" -"HP:0008256","Adrenocortical adenoma" -"HP:0004471","Aplasia cutis congenita over the scalp vertex" -"HP:0025060","Multifocal splenic abscess" -"HP:0005872","Brachytelomesophalangy" -"HP:0000869","Secondary amenorrhea" -"HP:0011141","Age-related cataract" -"HP:0009812","Amelia involving the upper limbs" -"HP:0045025","Narrow palpebral fissure" -"HP:0006684","Ventricular preexcitation with multiple accessory pathways" -"HP:0040071","Abnormal morphology of ulna" -"HP:0011748","Adrenocorticotropic hormone deficiency" -"HP:0004594","Hump-shaped mound of bone in central and posterior portions of vertebral endplate" -"HP:0100762","Hemobilia" -"HP:0030744","Hyaloid vascular remnant and retrolental mass" -"HP:0031387","Increased multinucleated megakaryocyte count" -"HP:0000573","Retinal hemorrhage" -"HP:0030958","Membranous ventricular septal aneurysm" -"HP:0002034","Abnormality of the rectum" -"HP:0003134","Abnormality of peripheral nerve conduction" -"HP:0002226","White eyebrow" -"HP:0001304","Torsion dystonia" -"HP:0011433","High maternal serum chorionic gonadotropin" -"HP:0008014","Central fundal arteriolar microaneurysms" -"HP:0009904","Prominent ear helix" -"HP:0100526","Neoplasm of the lung" -"HP:0100046","Cone-shaped epiphyses of the 2nd toe" -"HP:0040144","L-2-hydroxyglutaric aciduria" -"HP:0006140","Premature fusion of phalangeal epiphyses" -"HP:0003872","Humeral exostoses" -"HP:0010487","Small hypothenar eminence" -"HP:0005944","Bilateral lung agenesis" -"HP:0011051","Agenesis of premolar" -"HP:0010766","Ectopic calcification" -"HP:0031021","Squamous Papilloma" -"HP:0009118","Aplasia/Hypoplasia of the mandible" -"HP:0011228","Horizontal eyebrow" -"HP:0007647","Congenital extraocular muscle anomaly" -"HP:0002908","Conjugated hyperbilirubinemia" -"HP:0000988","Skin rash" -"HP:0100786","Hypersomnia" -"HP:0040233","Factor XIII subunit A deficiency" -"HP:0011912","Abnormality of the glenoid fossa" -"HP:0000967","Petechiae" -"HP:0011229","Broad eyebrow" -"HP:0025430","High-pitched cry" -"HP:0040296","Abnormal location of the eyebrow" -"HP:0012609","Hypomagnesiuria" -"HP:0002349","Focal seizures without impairment of consciousness or awareness" -"HP:0012071","Abnormality of acetylcarnitine metabolism" -"HP:0010886","Osteochondritis Dissecans" -"HP:0004367","Abnormality of glycoprotein metabolism" -"HP:0410030","Cleft lip" -"HP:0003057","Tetraamelia" -"HP:0100770","Hyperperistalsis" -"HP:0005627","Type D brachydactyly" -"HP:0030980","Reduced brain glutamine level by MRS" -"HP:0004523","Long eyebrows" -"HP:0002636","Dilatation of an abdominal artery" -"HP:0031386","Increased micromegakaryocyte count" -"HP:0030212","Collectionism" -"HP:0025458","Decreased CSF albumin" -"HP:0010550","Paraplegia" -"HP:0002322","Resting tremor" -"HP:0040190","White scaling skin" -"HP:0010151","Cone-shaped epiphysis of the 1st metatarsal" -"HP:0010741","Edema of the lower limbs" -"HP:0008391","Dystrophic fingernails" -"HP:0009370","Type A brachydactyly" -"HP:0031689","Megakaryocyte dysplasia" -"HP:0007939","Blue cone monochromacy" -"HP:0009242","Osteolytic defects of the distal phalanx of the 5th finger" -"HP:0025191","Segmental myoclonic seizures" -"HP:0010038","Short 2nd metacarpal" -"HP:0010164","Cone-shaped epiphyses of the toes" -"HP:0030743","Glial remnants anterior to the optic disc" -"HP:0009649","Aplasia of the distal phalanx of the thumb" -"Reactome:R-HSA-157579","Telomere Maintenance" -"Reactome:R-HSA-5603037","IRAK4 deficiency (TLR5)" -"Reactome:R-HSA-5696398","Nucleotide Excision Repair" -"Reactome:R-HSA-6807070","PTEN Regulation" -"Reactome:R-HSA-189445","Metabolism of porphyrins" -"Reactome:R-HSA-1461973","Defensins" -"Reactome:R-HSA-5627083","RHO GTPases regulate CFTR trafficking" -"Reactome:R-HSA-5679096","Defective ABCG5 causes sitosterolemia" -"Reactome:R-HSA-425397","Transport of vitamins, nucleosides, and related molecules" -"Reactome:R-HSA-72086","mRNA Capping" -"Reactome:R-HSA-5083636","Defective GALNT12 causes colorectal cancer 1 (CRCS1)" -"Reactome:R-HSA-170834","Signaling by TGF-beta Receptor Complex" -"Reactome:R-HSA-5619067","Defective SLC1A1 is implicated in schizophrenia 18 (SCZD18) and dicarboxylic aminoaciduria (DCBXA)" -"Reactome:R-HSA-5467333","APC truncation mutants are not K63 polyubiquitinated" -"Reactome:R-HSA-5688399","Defective ABCA3 causes pulmonary surfactant metabolism dysfunction 3 (SMDP3)" -"Reactome:R-HSA-5578996","Defective CYP27A1 causes Cerebrotendinous xanthomatosis (CTX)" -"Reactome:R-HSA-4793950","Defective MAN1B1 causes MRT15" -"Reactome:R-HSA-5609976","Defective GALK1 can cause Galactosemia II (GALCT2)" -"Reactome:R-HSA-373080","Class B/2 (Secretin family receptors)" -"Reactome:R-HSA-379724","tRNA Aminoacylation" -"Reactome:R-HSA-5579027","Defective CYP2R1 causes Rickets vitamin D-dependent 1B (VDDR1B)" -"Reactome:R-HSA-209776","Amine-derived hormones" -"Reactome:R-HSA-3359471","Defective MMAB causes methylmalonic aciduria type cblB" -"Reactome:R-HSA-416476","G alpha (q) signalling events" -"Reactome:R-HSA-5619096","Defective SLC5A5 causes thyroid dyshormonogenesis 1 (TDH1)" -"Reactome:R-HSA-8936459","RUNX1 regulates genes involved in megakaryocyte differentiation and platelet function" -"Reactome:R-HSA-5083628","Defective POMGNT1 causes MDDGA3, MDDGB3 and MDDGC3" -"Reactome:R-HSA-983189","Kinesins" -"Reactome:R-HSA-5358747","S33 mutants of beta-catenin aren't phosphorylated" -"Reactome:R-HSA-5083625","Defective GALNT3 causes familial hyperphosphatemic tumoral calcinosis (HFTC)" -"Reactome:R-HSA-74182","Ketone body metabolism" -"Reactome:R-HSA-196849","Metabolism of water-soluble vitamins and cofactors" -"Reactome:R-HSA-8852405","Signaling by MST1" -"Reactome:R-HSA-5619073","Defective GCK causes maturity-onset diabetes of the young 2 (MODY2)" -"Reactome:R-HSA-6807505","RNA polymerase II transcribes snRNA genes" -"Reactome:R-HSA-2142753","Arachidonic acid metabolism" -"Reactome:R-HSA-2022090","Assembly of collagen fibrils and other multimeric structures" -"Reactome:R-HSA-69620","Cell Cycle Checkpoints" -"Reactome:R-HSA-6809583","Retinoid metabolism disease events" -"Reactome:R-HSA-3899300","SUMOylation of transcription cofactors" -"Reactome:R-HSA-8878171","Transcriptional regulation by RUNX1" -"Reactome:R-HSA-3371497","HSP90 chaperone cycle for steroid hormone receptors (SHR)" -"Reactome:R-HSA-5660862","Defective SLC7A7 causes lysinuric protein intolerance (LPI)" -"Reactome:R-HSA-3656532","TGFBR1 KD Mutants in Cancer" -"Reactome:R-HSA-9018679","Biosynthesis of EPA-derived SPMs" -"Reactome:R-HSA-1368082","RORA activates gene expression" -"Reactome:R-HSA-5619056","Defective HK1 causes hexokinase deficiency (HK deficiency)" -"Reactome:R-HSA-8948216","Collagen chain trimerization" -"Reactome:R-HSA-8982491","Glycogen metabolism" -"Reactome:R-HSA-5336415","Uptake and function of diphtheria toxin" -"Reactome:R-HSA-5083629","Defective POMT2 causes MDDGA2, MDDGB2 and MDDGC2" -"Reactome:R-HSA-6804756","Regulation of TP53 Activity through Phosphorylation" -"Reactome:R-HSA-4755609","Defective DHDDS causes retinitis pigmentosa 59" -"Reactome:R-HSA-5083633","Defective POMT1 causes MDDGA1, MDDGB1 and MDDGC1" -"Reactome:R-HSA-5467345","Deletions in the AXIN genes in hepatocellular carcinoma result in elevated WNT signaling" -"Reactome:R-HSA-3814836","Glycogen storage disease type XV (GYG1)" -"Reactome:R-HSA-5617472","Activation of anterior HOX genes in hindbrain development during early embryogenesis" -"Reactome:R-HSA-212436","Generic Transcription Pathway" -"Reactome:R-HSA-5619035","Defective SLC17A5 causes Salla disease (SD) and ISSD" -"Reactome:R-HSA-391251","Protein folding" -"Reactome:R-HSA-5221030","TET1,2,3 and TDG demethylate DNA" -"Reactome:R-HSA-75896","Plasmalogen biosynthesis" -"Reactome:R-HSA-5579004","Defective CYP26C1 causes Focal facial dermal dysplasia 4 (FFDD4)" -"Reactome:R-HSA-1428517","The citric acid (TCA) cycle and respiratory electron transport" -"Reactome:R-HSA-3108214","SUMOylation of DNA damage response and repair proteins" -"Reactome:R-HSA-3858516","Glycogen storage disease type 0 (liver GYS2)" -"Reactome:R-HSA-975155","MyD88 dependent cascade initiated on endosome" -"Reactome:R-HSA-373755","Semaphorin interactions" -"Reactome:R-HSA-5658471","Defective SLC5A7 causes distal hereditary motor neuronopathy 7A (HMN7A)" -"Reactome:R-HSA-390522","Striated Muscle Contraction" -"Reactome:R-HSA-6796648","TP53 Regulates Transcription of DNA Repair Genes" -"Reactome:R-HSA-5579005","Defective CYP4F22 causes Ichthyosis, congenital, autosomal recessive 5 (ARCI5)" -"Reactome:R-HSA-199977","ER to Golgi Anterograde Transport" -"Reactome:R-HSA-5619101","Variant SLC6A20 contributes towards hyperglycinuria (HG) and iminoglycinuria (IG)" -"Reactome:R-HSA-1368108","BMAL1:CLOCK,NPAS2 activates circadian gene expression" -"Reactome:R-HSA-8866376","Reelin signalling pathway" -"Reactome:R-HSA-5083632","Defective C1GALT1C1 causes Tn polyagglutination syndrome (TNPS)" -"Reactome:R-HSA-1222556","ROS, RNS production in phagocytes" -"Reactome:R-HSA-72203","Processing of Capped Intron-Containing Pre-mRNA" -"Reactome:R-HSA-450294","MAP kinase activation in TLR cascade" -"Reactome:R-HSA-452723","Transcriptional regulation of pluripotent stem cells" -"Reactome:R-HSA-3359462","Defective AMN causes hereditary megaloblastic anemia 1" -"Reactome:R-HSA-6804758","Regulation of TP53 Activity through Acetylation" -"Reactome:R-HSA-5693571","Nonhomologous End-Joining (NHEJ)" -"Reactome:R-HSA-165159","mTOR signalling" -"Reactome:R-HSA-186712","Regulation of beta-cell development" -"Reactome:R-HSA-5619050","Defective SLC4A1 causes hereditary spherocytosis type 4 (HSP4), distal renal tubular acidosis (dRTA) and dRTA with hemolytic anemia (dRTA-HA)" -"Reactome:R-HSA-73857","RNA Polymerase II Transcription" -"Reactome:R-HSA-70614","Amino acid synthesis and interconversion (transamination)" -"Reactome:R-HSA-983169","Class I MHC mediated antigen processing & presentation" -"Reactome:R-HSA-2046104","alpha-linolenic (omega3) and linoleic (omega6) acid metabolism" -"Reactome:R-HSA-5579021","Defective CYP21A2 causes Adrenal hyperplasia 3 (AH3)" -"Reactome:R-HSA-1181150","Signaling by NODAL" -"Reactome:R-HSA-422085","Synthesis, secretion, and deacylation of Ghrelin" -"Reactome:R-HSA-3311021","SMAD4 MH2 Domain Mutants in Cancer" -"Reactome:R-HSA-2559586","DNA Damage/Telomere Stress Induced Senescence" -"Reactome:R-HSA-8878166","Transcriptional regulation by RUNX2" -"Reactome:R-HSA-112308","Presynaptic depolarization and calcium channel opening" -"Reactome:R-HSA-400253","Circadian Clock" -"Reactome:R-HSA-5609978","Defective GALT can cause Galactosemia" -"Reactome:R-HSA-5619095","Defective SLCO2A1 causes primary, autosomal recessive hypertrophic osteoarthropathy 2 (PHOAR2)" -"Reactome:R-HSA-381119","Unfolded Protein Response (UPR)" -"Reactome:R-HSA-5358751","S45 mutants of beta-catenin aren't phosphorylated" -"Reactome:R-HSA-400206","Regulation of lipid metabolism by Peroxisome proliferator-activated receptor alpha (PPARalpha)" -"Reactome:R-HSA-70370","Galactose catabolism" -"Reactome:R-HSA-6802949","Signaling by RAS mutants" -"Reactome:R-HSA-5666185","RHO GTPases Activate Rhotekin and Rhophilins" -"Reactome:R-HSA-445989","TAK1 activates NFkB by phosphorylation and activation of IKKs complex" -"Reactome:R-HSA-5619053","Defective SLC22A5 causes systemic primary carnitine deficiency (CDSP)" -"Reactome:R-HSA-8848584","Wax biosynthesis" -"Reactome:R-HSA-453274","Mitotic G2-G2/M phases" -"Reactome:R-HSA-432030","Transport of glycerol from adipocytes to the liver by Aquaporins" -"Reactome:R-HSA-373760","L1CAM interactions" -"Reactome:R-HSA-5632927","Defective Mismatch Repair Associated With MSH3" -"Reactome:R-HSA-5625900","RHO GTPases activate CIT" -"Reactome:R-HSA-381426","Regulation of Insulin-like Growth Factor (IGF) transport and uptake by Insulin-like Growth Factor Binding Proteins (IGFBPs)" -"Reactome:R-HSA-5659729","Defective SLC6A18 may confer susceptibility to iminoglycinuria and/or hyperglycinuria" -"Reactome:R-HSA-8964572","Lipid particle organization" -"Reactome:R-HSA-8955332","Carboxyterminal post-translational modifications of tubulin" -"Reactome:R-HSA-5619089","Defective SLC6A5 causes hyperekplexia 3 (HKPX3)" -"Reactome:R-HSA-5619058","Defective SLCO1B3 causes hyperbilirubinemia, Rotor type (HBLRR)" -"Reactome:R-HSA-6805567","Keratinization" -"Reactome:R-HSA-73864","RNA Polymerase I Transcription" -"Reactome:R-HSA-5358749","S37 mutants of beta-catenin aren't phosphorylated" -"Reactome:R-HSA-2894858","Signaling by NOTCH1 HD+PEST Domain Mutants in Cancer" -"Reactome:R-HSA-5619036","Defective SLC24A5 causes oculocutaneous albinism 6 (OCA6)" -"Reactome:R-HSA-1980143","Signaling by NOTCH1" -"Reactome:R-HSA-5628897","TP53 Regulates Metabolic Genes" -"Reactome:R-HSA-6782315","tRNA modification in the nucleus and cytosol" -"Reactome:R-HSA-5619063","Defective SLC29A3 causes histiocytosis-lymphadenopathy plus syndrome (HLAS)" -"Reactome:R-HSA-6784531","tRNA processing in the nucleus" -"Reactome:R-HSA-8956321","Nucleotide salvage" -"Reactome:R-HSA-447115","Interleukin-12 family signaling" -"Reactome:R-HSA-5545483","Defective Mismatch Repair Associated With MLH1" -"Reactome:R-HSA-196791","Vitamin D (calciferol) metabolism" -"Reactome:R-HSA-5683678","Defective ABCA3 causes pulmonary surfactant metabolism dysfunction type 3 (SMDP3)" -"Reactome:R-HSA-2408522","Selenoamino acid metabolism" -"Reactome:R-HSA-5626467","RHO GTPases activate IQGAPs" -"Reactome:R-HSA-6811442","Intra-Golgi and retrograde Golgi-to-ER traffic" -"Reactome:R-HSA-1445148","Translocation of GLUT4 to the plasma membrane" -"Reactome:R-HSA-191273","Cholesterol biosynthesis" -"Reactome:R-HSA-2022377","Metabolism of Angiotensinogen to Angiotensins" -"Reactome:R-HSA-6807878","COPI-mediated anterograde transport" -"Reactome:R-HSA-5655332","Signaling by FGFR3 in disease" -"Reactome:R-HSA-5632928","Defective Mismatch Repair Associated With MSH2" -"Reactome:R-HSA-5632684","Hedgehog 'on' state" -"Reactome:R-HSA-381183","ATF6 (ATF6-alpha) activates chaperone genes" -"Reactome:R-HSA-445355","Smooth Muscle Contraction" -"Reactome:R-HSA-8873719","RAB geranylgeranylation" -"Reactome:R-HSA-2206305","MPS IIID - Sanfilippo syndrome D" -"Reactome:R-HSA-168255","Influenza Life Cycle" -"Reactome:R-HSA-168643","Nucleotide-binding domain, leucine rich repeat containing receptor (NLR) signaling pathways" -"Reactome:R-HSA-2219530","Constitutive Signaling by Aberrant PI3K in Cancer" -"Reactome:R-HSA-6804759","Regulation of TP53 Activity through Association with Co-factors" -"Reactome:R-HSA-163125","Post-translational modification: synthesis of GPI-anchored proteins" -"Reactome:R-HSA-5368287","Mitochondrial translation" -"Reactome:R-HSA-8862803","Deregulated CDK5 triggers multiple neurodegenerative pathways in Alzheimer's disease models" -"Reactome:R-HSA-5362517","Signaling by Retinoic Acid" -"Reactome:R-HSA-5579000","Defective CYP1B1 causes Glaucoma" -"Reactome:R-HSA-354192","Integrin alphaIIb beta3 signaling" -"Reactome:R-HSA-499943","Interconversion of nucleotide di- and triphosphates" -"Reactome:R-HSA-1980148","Signaling by NOTCH3" -"Reactome:R-HSA-5693606","DNA Double Strand Break Response" -"Reactome:R-HSA-2555396","Mitotic Metaphase and Anaphase" -"Reactome:R-HSA-167060","NGF processing" -"Reactome:R-HSA-1980145","Signaling by NOTCH2" -"Reactome:R-HSA-194441","Metabolism of non-coding RNA" -"Reactome:R-HSA-5579019","Defective FMO3 causes Trimethylaminuria (TMAU)" -"Reactome:R-HSA-5653890","Lactose synthesis" -"Reactome:R-HSA-525793","Myogenesis" -"Reactome:R-HSA-5683371","Defective ABCB6 causes isolated colobomatous microphthalmia 7 (MCOPCB7)" -"Reactome:R-HSA-202733","Cell surface interactions at the vascular wall" -"Reactome:R-HSA-5619077","Defective SLC24A1 causes congenital stationary night blindness 1D (CSNB1D)" -"Reactome:R-HSA-1614635","Sulfur amino acid metabolism" -"Reactome:R-HSA-5661270","Catabolism of glucuronate to xylulose-5-phosphate" -"Reactome:R-HSA-5339700","TCF7L2 mutants don't bind CTBP" -"Reactome:R-HSA-5579011","Defective CYP2U1 causes Spastic paraplegia 56, autosomal recessive (SPG56)" -"Reactome:R-HSA-1502540","Signaling by Activin" -"Reactome:R-HSA-5658034","HHAT G278V abrogates palmitoylation of Hh-Np" -"Reactome:R-HSA-2206308","MPS IV - Morquio syndrome B" -"Reactome:R-HSA-2426168","Activation of gene expression by SREBF (SREBP)" -"Reactome:R-HSA-5687128","MAPK6/MAPK4 signaling" -"Reactome:R-HSA-201681","TCF dependent signaling in response to WNT" -"Reactome:R-HSA-2559580","Oxidative Stress Induced Senescence" -"Reactome:R-HSA-5579007","Defective ACY1 causes encephalopathy" -"Reactome:R-HSA-5638302","Signaling by Overexpressed Wild-Type EGFR in Cancer" -"Reactome:R-HSA-209952","Peptide hormone biosynthesis" -"Reactome:R-HSA-1834949","Cytosolic sensors of pathogen-associated DNA " -"Reactome:R-HSA-5678895","Defective CFTR causes cystic fibrosis" -"Reactome:R-HSA-4341670","Defective NEU1 causes sialidosis" -"Reactome:R-HSA-2142700","Synthesis of Lipoxins (LX)" -"Reactome:R-HSA-5619110","Defective SLCO1B1 causes hyperbilirubinemia, Rotor type (HBLRR)" -"Reactome:R-HSA-5627117","RHO GTPases Activate ROCKs" -"Reactome:R-HSA-3359469","Defective MTR causes methylmalonic aciduria and homocystinuria type cblG" -"Reactome:R-HSA-1475029","Reversible hydration of carbon dioxide" -"Reactome:R-HSA-2206285","MPS VI - Maroteaux-Lamy syndrome" -"Reactome:R-HSA-162909","Host Interactions of HIV factors" -"Reactome:R-HSA-3359474","Defective MMACHC causes methylmalonic aciduria and homocystinuria type cblC" -"Reactome:R-HSA-418889","Ligand-independent caspase activation via DCC" -"Reactome:R-HSA-1655829","Regulation of cholesterol biosynthesis by SREBP (SREBF)" -"Reactome:R-HSA-5684045","Defective ABCD1 causes adrenoleukodystrophy (ALD)" -"Reactome:R-HSA-432040","Vasopressin regulates renal water homeostasis via Aquaporins" -"Reactome:R-HSA-6803157","Antimicrobial peptides" -"Reactome:R-HSA-6782861","Synthesis of wybutosine at G37 of tRNA(Phe)" -"Reactome:R-HSA-68874","M/G1 Transition" -"Reactome:R-HSA-427413","NoRC negatively regulates rRNA expression" -"Reactome:R-HSA-5223345","Miscellaneous transport and binding events" -"Reactome:R-HSA-397795","G-protein beta:gamma signalling" -"Reactome:R-HSA-3315487","SMAD2/3 MH2 Domain Mutants in Cancer" -"Reactome:R-HSA-380972","Energy dependent regulation of mTOR by LKB1-AMPK" -"Reactome:R-HSA-4839726","Chromatin organization" -"Reactome:R-HSA-202131","Metabolism of nitric oxide" -"Reactome:R-HSA-76009","Platelet Aggregation (Plug Formation)" -"Reactome:R-HSA-1222352","Latent infection of Homo sapiens with Mycobacterium tuberculosis" -"Reactome:R-HSA-427389","ERCC6 (CSB) and EHMT2 (G9a) positively regulate rRNA expression" -"Reactome:R-HSA-5610787","Hedgehog 'off' state" -"Reactome:R-HSA-195253","Degradation of beta-catenin by the destruction complex" -"Reactome:R-HSA-5633008","TP53 Regulates Transcription of Cell Death Genes" -"Reactome:R-HSA-114508","Effects of PIP2 hydrolysis" -"Reactome:R-HSA-166658","Complement cascade" -"Reactome:R-HSA-5358346","Hedgehog ligand biogenesis" -"Reactome:R-HSA-75944","Transcription from mitochondrial promoters" -"Reactome:R-HSA-3560792","Defective SLC26A2 causes chondrodysplasias" -"Reactome:R-HSA-5579012","Defective MAOA causes Brunner syndrome (BRUNS)" -"Reactome:R-HSA-418346","Platelet homeostasis" -"Reactome:R-HSA-5619107","Defective TPR may confer susceptibility towards thyroid papillary carcinoma (TPC)" -"Reactome:R-HSA-5619097","Defective SLC34A3 causes Hereditary hypophosphatemic rickets with hypercalciuria (HHRH)" -"Reactome:R-HSA-2682334","EPH-Ephrin signaling" -"Reactome:R-HSA-416482","G alpha (12/13) signalling events" -"Reactome:R-HSA-2892245","POU5F1 (OCT4), SOX2, NANOG repress genes related to differentiation" -"Reactome:R-HSA-3785653","Myoclonic epilepsy of Lafora" -"Reactome:R-HSA-3878781","Glycogen storage disease type IV (GBE1)" -"Reactome:R-HSA-5658208","Defective SLC5A2 causes renal glucosuria (GLYS1)" -"Reactome:R-HSA-3595172","Defective CHST3 causes SEDCJD" -"Reactome:R-HSA-6791462","TALDO1 deficiency: failed conversion of Fru(6)P, E4P to SH7P, GA3P" -"Reactome:R-HSA-204005","COPII (Coat Protein 2) Mediated Vesicle Transport" -"Reactome:R-HSA-432047","Passive transport by Aquaporins" -"Reactome:R-HSA-8939211","ESR-mediated signaling" -"Reactome:R-HSA-9006115","Signaling by NTRK2 (TRKB)" -"Reactome:R-HSA-166058","MyD88:Mal cascade initiated on plasma membrane" -"Reactome:R-HSA-418597","G alpha (z) signalling events" -"Reactome:R-HSA-2691230","Signaling by NOTCH1 HD Domain Mutants in Cancer" -"Reactome:R-HSA-3359478","Defective MUT causes methylmalonic aciduria mut type" -"Reactome:R-HSA-5357609","Glycogen storage disease type II (GAA)" -"Reactome:R-HSA-71737","Pyrophosphate hydrolysis" -"Reactome:R-HSA-5467348","Truncations of AMER1 destabilize the destruction complex" -"Reactome:R-HSA-5619043","Defective SLC2A1 causes GLUT1 deficiency syndrome 1 (GLUT1DS1)" -"Reactome:R-HSA-5654736","Signaling by FGFR1" -"Reactome:R-HSA-1442490","Collagen degradation" -"Reactome:R-HSA-5663220","RHO GTPases Activate Formins" -"Reactome:R-HSA-418555","G alpha (s) signalling events" -"Reactome:R-HSA-6802955","Paradoxical activation of RAF signaling by kinase inactive BRAF" -"Reactome:R-HSA-6806834","Signaling by MET" -"Reactome:R-HSA-5603041","IRAK4 deficiency (TLR2/4)" -"Reactome:R-HSA-6791055","TALDO1 deficiency: failed conversion of SH7P, GA3P to Fru(6)P, E4P" -"Reactome:R-HSA-5654741","Signaling by FGFR3" -"Reactome:R-HSA-73942","DNA Damage Reversal" -"Reactome:R-HSA-5688031","Defective pro-SFTPB causes pulmonary surfactant metabolism dysfunction 1 (SMDP1) and respiratory distress syndrome (RDS)" -"Reactome:R-HSA-5619054","Defective SLC4A4 causes renal tubular acidosis, proximal, with ocular abnormalities and mental retardation (pRTA-OA)" -"Reactome:R-HSA-1912420","Pre-NOTCH Processing in Golgi" -"Reactome:R-HSA-5339717","Misspliced LRP5 mutants have enhanced beta-catenin-dependent signaling" -"Reactome:R-HSA-3238698","WNT ligand biogenesis and trafficking" -"Reactome:R-HSA-68884","Mitotic Telophase/Cytokinesis" -"Reactome:R-HSA-5619055","Defective SLC24A4 causes hypomineralized amelogenesis imperfecta (AI)" -"Reactome:R-HSA-2132295","MHC class II antigen presentation" -"Reactome:R-HSA-72764","Eukaryotic Translation Termination" -"Reactome:R-HSA-448424","Interleukin-17 signaling" -"Reactome:R-HSA-977347","Serine biosynthesis" -"Reactome:R-HSA-5627123","RHO GTPases activate PAKs" -"Reactome:R-HSA-8935690","Digestion" -"Reactome:R-HSA-1368071","NR1D1 (REV-ERBA) represses gene expression" -"Reactome:R-HSA-8956320","Nucleobase biosynthesis" -"Reactome:R-HSA-70326","Glucose metabolism" -"Reactome:R-HSA-5662702","Melanin biosynthesis" -"Reactome:R-HSA-75157","FasL/ CD95L signaling" -"Reactome:R-HSA-449836","Other interleukin signaling" -"Reactome:R-HSA-111885","Opioid Signalling" -"Reactome:R-HSA-5579010","Defective CYP24A1 causes Hypercalcemia, infantile (HCAI)" -"Reactome:R-HSA-5619066","Defective SLC22A18 causes lung cancer (LNCR) and embryonal rhabdomyosarcoma 1 (RMSE1)" -"Reactome:R-HSA-5578998","Defective OPLAH causes 5-oxoprolinase deficiency (OPLAHD)" -"Reactome:R-HSA-5617833","Cilium Assembly" -"Reactome:R-HSA-72613","Eukaryotic Translation Initiation" -"Reactome:R-HSA-75153","Apoptotic execution phase" -"Reactome:R-HSA-428157","Sphingolipid metabolism" -"Reactome:R-HSA-193704","p75 NTR receptor-mediated signalling" -"Reactome:R-HSA-6790901","rRNA modification in the nucleus and cytosol" -"Reactome:R-HSA-8956319","Nucleobase catabolism" -"Reactome:R-HSA-5579017","Defective CYP11B1 causes Adrenal hyperplasia 4 (AH4)" -"Reactome:R-HSA-5619092","Defective SLC9A6 causes X-linked, syndromic mental retardation,, Christianson type (MRXSCH)" -"Reactome:R-HSA-5687868","Defective SFTPA2 causes idiopathic pulmonary fibrosis (IPF)" -"Reactome:R-HSA-5688849","Defective CSF2RB causes pulmonary surfactant metabolism dysfunction 5 (SMDP5)" -"Reactome:R-HSA-4420332","Defective B3GALT6 causes EDSP2 and SEMDJL1" -"Reactome:R-HSA-5659735","Defective SLC6A19 causes Hartnup disorder (HND)" -"Reactome:R-HSA-5633231","Defective ALG14 causes congenital myasthenic syndrome (ALG14-CMS)" -"Reactome:R-HSA-8849932","Synaptic adhesion-like molecules" -"Reactome:R-HSA-2892247","POU5F1 (OCT4), SOX2, NANOG activate genes related to proliferation" -"Reactome:R-HSA-112310","Neurotransmitter release cycle" -"Reactome:R-HSA-4570464","SUMOylation of RNA binding proteins" -"Reactome:R-HSA-5688890","Defective CSF2RA causes pulmonary surfactant metabolism dysfunction 4 (SMDP4)" -"Reactome:R-HSA-5679090","Defective ABCG8 causes gallbladder disease 4 and sitosterolemia" -"Reactome:R-HSA-375165","NCAM signaling for neurite out-growth" -"Reactome:R-HSA-216083","Integrin cell surface interactions" -"Reactome:R-HSA-5467337","APC truncation mutants have impaired AXIN binding" -"Reactome:R-HSA-983231","Factors involved in megakaryocyte development and platelet production" -"Reactome:R-HSA-112311","Neurotransmitter clearance" -"Reactome:R-HSA-1632852","Macroautophagy" -"Reactome:R-HSA-3560783","Defective B4GALT7 causes EDS, progeroid type" -"Reactome:R-HSA-5602566","TICAM1 deficiency - HSE" -"Reactome:R-HSA-6788656","Histidine, lysine, phenylalanine, tyrosine, proline and tryptophan catabolism" -"Reactome:R-HSA-5668599","RHO GTPases Activate NADPH Oxidases" -"Reactome:R-HSA-975634","Retinoid metabolism and transport" -"Reactome:R-HSA-5579026","Defective CYP11A1 causes Adrenal insufficiency, congenital, with 46,XY sex reversal (AICSR)" -"Reactome:R-HSA-156842","Eukaryotic Translation Elongation" -"Reactome:R-HSA-389542","NADPH regeneration" -"Reactome:R-HSA-168253","Host Interactions with Influenza Factors" -"Reactome:R-HSA-1474244","Extracellular matrix organization" -"Reactome:R-HSA-5609977","Defective GALE can cause Epimerase-deficiency galactosemia (EDG)" -"Reactome:R-HSA-5619108","Defective SLC27A4 causes ichthyosis prematurity syndrome (IPS)" -"Reactome:R-HSA-5083627","Defective LARGE causes MDDGA6 and MDDGB6" -"Reactome:R-HSA-9018677","Biosynthesis of DHA-derived SPMs" -"Reactome:R-HSA-373076","Class A/1 (Rhodopsin-like receptors)" -"Reactome:R-HSA-157858","Gap junction trafficking and regulation" -"Reactome:R-HSA-5602410","TLR3 deficiency - HSE" -"Reactome:R-HSA-5688354","Defective pro-SFTPC causes pulmonary surfactant metabolism dysfunction 2 (SMDP2) and respiratory distress syndrome (RDS)" -"Reactome:R-HSA-400508","Incretin synthesis, secretion, and inactivation" -"Reactome:R-HSA-1247673","Erythrocytes take up oxygen and release carbon dioxide" -"Reactome:R-HSA-168898","Toll-Like Receptors Cascades" -"Reactome:R-HSA-3656237","Defective EXT2 causes exostoses 2" -"Reactome:R-HSA-5578999","Defective GCLC causes Hemolytic anemia due to gamma-glutamylcysteine synthetase deficiency (HAGGSD)" -"Reactome:R-HSA-5602680","MyD88 deficiency (TLR5)" -"Reactome:R-HSA-3656253","Defective EXT1 causes exostoses 1, TRPS2 and CHDS" -"Reactome:R-HSA-5340588","RNF mutants show enhanced WNT signaling and proliferation" -"Reactome:R-HSA-1221632","Meiotic synapsis" -"Reactome:R-HSA-425366","Transport of bile salts and organic acids, metal ions and amine compounds" -"Reactome:R-HSA-156580","Phase II - Conjugation of compounds" -"Reactome:R-HSA-8854214","TBC/RABGAPs" -"Reactome:R-HSA-6806664","Metabolism of vitamin K" -"Reactome:R-HSA-3560801","Defective B3GAT3 causes JDSSDHD" -"Reactome:R-HSA-1474151","Tetrahydrobiopterin (BH4) synthesis, recycling, salvage and regulation" -"Reactome:R-HSA-74158","RNA Polymerase III Transcription" -"Reactome:R-HSA-977225","Amyloid fiber formation" -"Reactome:R-HSA-5668541","TNFR2 non-canonical NF-kB pathway" -"Reactome:R-HSA-5619071","Defective SLC22A12 causes renal hypouricemia 1 (RHUC1)" -"Reactome:R-HSA-500792","GPCR ligand binding" -"Reactome:R-HSA-201451","Signaling by BMP" -"Reactome:R-HSA-198933","Immunoregulatory interactions between a Lymphoid and a non-Lymphoid cell" -"Reactome:R-HSA-3595177","Defective CHSY1 causes TPBS" -"Reactome:R-HSA-2160456","Phenylketonuria" -"Reactome:R-HSA-8942233","Intestinal infectious diseases" -"Reactome:R-HSA-2032785","YAP1- and WWTR1 (TAZ)-stimulated gene expression" -"Reactome:R-HSA-177929","Signaling by EGFR" -"Reactome:R-HSA-186797","Signaling by PDGF" -"Reactome:R-HSA-6785807","Interleukin-4 and 13 signaling" -"Reactome:R-HSA-169911","Regulation of Apoptosis" -"Reactome:R-HSA-5655253","Signaling by FGFR2 in disease" -"Reactome:R-HSA-1592389","Activation of Matrix Metalloproteinases" -"Reactome:R-HSA-3359454","Defective TCN2 causes hereditary megaloblastic anemia" -"Reactome:R-HSA-5083635","Defective B3GALTL causes Peters-plus syndrome (PpS)" -"Reactome:R-HSA-194068","Bile acid and bile salt metabolism" -"Reactome:R-HSA-1474228","Degradation of the extracellular matrix" -"Reactome:R-HSA-8856825","Cargo recognition for clathrin-mediated endocytosis" -"Reactome:R-HSA-3000170","Syndecan interactions" -"Reactome:R-HSA-3828062","Glycogen storage disease type 0 (muscle GYS1)" -"Reactome:R-HSA-6798163","Choline catabolism" -"Reactome:R-HSA-983712","Ion channel transport" -"Reactome:R-HSA-5576891","Cardiac conduction" -"Reactome:R-HSA-4755583","Defective DOLK causes DOLK-CDG (CDG-1m)" -"Reactome:R-HSA-5669034","TNFs bind their physiological receptors" -"Reactome:R-HSA-917937","Iron uptake and transport" -"Reactome:R-HSA-5686938","Regulation of TLR by endogenous ligand" -"Reactome:R-HSA-74752","Signaling by Insulin receptor" -"Reactome:R-HSA-912446","Meiotic recombination" -"Reactome:R-HSA-1566948","Elastic fibre formation" -"Reactome:R-HSA-2173782","Binding and Uptake of Ligands by Scavenger Receptors" -"Reactome:R-HSA-5619060","Defective CP causes aceruloplasminemia (ACERULOP)" -"Reactome:R-HSA-5545619","XAV939 inhibits tankyrase, stabilizing AXIN" -"Reactome:R-HSA-1362409","Mitochondrial iron-sulfur cluster biogenesis" -"Reactome:R-HSA-6802946","Signaling by moderate kinase activity BRAF mutants" -"Reactome:R-HSA-5654738","Signaling by FGFR2" -"Reactome:R-HSA-380994","ATF4 activates genes" -"Reactome:R-HSA-1296071","Potassium Channels" -"Reactome:R-HSA-9027604","Biosynthesis of electrophilic ω-3 PUFA oxo-derivatives" -"Reactome:R-HSA-382556","ABC-family proteins mediated transport" -"Reactome:R-HSA-3359463","Defective CUBN causes hereditary megaloblastic anemia 1" -"Reactome:R-HSA-446728","Cell junction organization" -"Reactome:R-HSA-3359457","Defective GIF causes intrinsic factor deficiency" -"Reactome:R-HSA-140534","Ligand-dependent caspase activation" -"Reactome:R-HSA-420499","Class C/3 (Metabotropic glutamate/pheromone receptors)" -"Reactome:R-HSA-5619049","Defective SLC40A1 causes hemochromatosis 4 (HFE4) (macrophages)" -"Reactome:R-HSA-5579031","Defective ACTH causes Obesity and Pro-opiomelanocortinin deficiency (POMCD)" -"Reactome:R-HSA-427359","SIRT1 negatively regulates rRNA expression" -"Reactome:R-HSA-3359458","Defective LMBRD1 causes methylmalonic aciduria and homocystinuria type cblF" -"Reactome:R-HSA-2660825","Signaling by NOTCH1 t(7;9)(NOTCH1:M1580_K2555) Translocation Mutant" -"Reactome:R-HSA-5602571","TRAF3 deficiency - HSE" -"Reactome:R-HSA-5602498","MyD88 deficiency (TLR2/4)" -"Reactome:R-HSA-3359485","Defective CD320 causes methylmalonic aciduria" -"Reactome:R-HSA-6783783","Interleukin-10 signaling" -"Reactome:R-HSA-8877627","Vitamin E" -"Reactome:R-HSA-112307","Transmission across Electrical Synapses " -"Reactome:R-HSA-4755579","Defective SRD5A3 causes SRD5A3-CDG (CDG-1q) and KHRZ" -"Reactome:R-HSA-1679131","Trafficking and processing of endosomal TLR" -"Reactome:R-HSA-446203","Asparagine N-linked glycosylation" -"Reactome:R-HSA-5625886","Activated PKN1 stimulates transcription of AR (androgen receptor) regulated genes KLK2 and KLK3" -"Reactome:R-HSA-187037","NGF signalling via TRKA from the plasma membrane" -"Reactome:R-HSA-5579002","Defective UGT1A1 causes hyperbilirubinemia" -"Reactome:R-HSA-5659898","Intestinal saccharidase deficiencies" -"Reactome:R-HSA-9033500","TYSND1 cleaves peroxisomal proteins" -"Reactome:R-HSA-5694530","Cargo concentration in the ER" -"Reactome:R-HSA-5619048","Defective SLC11A2 causes hypochromic microcytic anemia, with iron overload 1 (AHMIO1)" -"Reactome:R-HSA-1257604","PIP3 activates AKT signaling" -"Reactome:R-HSA-4717374","Defective DPM1 causes DPM1-CDG (CDG-1e)" -"Reactome:R-HSA-5603027","IKBKG deficiency causes anhidrotic ectodermal dysplasia with immunodeficiency (EDA-ID) (via TLR)" -"Reactome:R-HSA-68875","Mitotic Prophase" -"Reactome:R-HSA-5621481","C-type lectin receptors (CLRs)" -"Reactome:R-HSA-211000","Gene Silencing by RNA" -"Reactome:R-HSA-5362768","Hh mutants that don't undergo autocatalytic processing are degraded by ERAD" -"Reactome:R-HSA-5637815","Signaling by Ligand-Responsive EGFR Variants in Cancer" -"Reactome:R-HSA-8851680","Butyrophilin (BTN) family interactions" -"Reactome:R-HSA-3656234","Defective HEXA causes GM2G1" -"Reactome:R-HSA-881907","Gastrin-CREB signalling pathway via PKC and MAPK" -"Reactome:R-HSA-5603029","IkBA variant leads to EDA-ID" -"Reactome:R-HSA-5683826","Surfactant metabolism" -"Reactome:R-HSA-877300","Interferon gamma signaling" -"Reactome:R-HSA-8877330","RUNX1 and FOXP3 control the development of regulatory T lymphocytes (Tregs)" -"Reactome:R-HSA-3595174","Defective CHST14 causes EDS, musculocontractural type" -"Reactome:R-HSA-3642279","TGFBR2 MSI Frameshift Mutants in Cancer" -"Reactome:R-HSA-512988","Interleukin-3, 5 and GM-CSF signaling" -"Reactome:R-HSA-3656248","Defective HEXB causes GM2G2" -"Reactome:R-HSA-5679001","Defective ABCC2 causes Dubin-Johnson syndrome" -"Reactome:R-HSA-450282","MAPK targets/ Nuclear events mediated by MAP kinases" -"Reactome:R-HSA-5676590","NIK-->noncanonical NF-kB signaling" -"Reactome:R-HSA-70895","Branched-chain amino acid catabolism" -"Reactome:R-HSA-2644605","FBXW7 Mutants and NOTCH1 in Cancer" -"Reactome:R-HSA-8848021","Signaling by PTK6" -"HP:0012543","Hemosiderinuria" -"HP:0010159","Triangular epiphysis of the 1st metatarsal" -"HP:0025058","Hypothalamic atrophy" -"HP:0040267","Distal upper limb muscle hypertrophy" -"HP:0030437","Anal canal neoplasm" -"HP:0009545","Symphalangism of the 2nd finger" -"HP:0006683","Abnormal ventricular filling" -"HP:0004704","Short fifth metatarsal" -"HP:0025071","U wave inversion" -"HP:0003099","Fibular overgrowth" -"HP:0011185","EEG with focal epileptiform discharges" -"HP:0005446","Obtuse angle of mandible" -"HP:0004019","Radial metaphyseal irregularity" -"HP:0031024","Cylindroma" -"HP:0005715","Flattened knee epiphyses" -"HP:3000003","Abnormality of mandibular ramus" -"HP:0010453","Pelvic bone asymmetry" -"HP:0011137","Non-pruritic urticaria" -"HP:0002505","Progressive inability to walk" -"HP:0006585","Congenital pseudoarthrosis of the clavicle" -"HP:0008519","Abnormality of the coccyx" -"HP:0002657","Spondylometaphyseal dysplasia" -"HP:0011242","Underdeveloped stem of antihelix" -"HP:0012512","Diffuse optic disc pallor" -"HP:0003789","Minicore myopathy" -"HP:0007980","Absent retinal pigment epithelium" -"HP:0002376","Developmental regression" -"HP:0008435","Absent in utero ossification of vertebral bodies" -"HP:0003981","Broad radius" -"HP:0010855","EEG with localized low amplitude activity" -"HP:0006808","Cerebral hypomyelination" -"HP:0003657","Granular osmiophilic deposits (GROD) in cells" -"HP:0007086","Social and occupational deterioration" -"HP:0003943","Abnormality of the joint spaces of the elbow" -"HP:0100660","Dyskinesia" -"HP:0007854","Glaucomatous visual field defect" -"HP:0003945","Irregular articular surfaces of the elbow joints" -"HP:0009602","Abnormality of thumb phalanx" -"HP:0005146","Cardiac valve calcification" -"HP:0002317","Unsteady gait" -"HP:0003798","Nemaline bodies" -"HP:0010693","Pulverulent cataract" -"HP:0002529","Neuronal loss in central nervous system" -"HP:0007381","Congenital exfoliative erythroderma" -"HP:0005302","Carotid artery tortuosity" -"HP:0007249","Decreased number of small peripheral myelinated nerve fibers" -"HP:0040276","Adenocarcinoma of the colon" -"HP:0000711","Restlessness" -"HP:0012438","Abnormal gallbladder physiology" -"HP:0008114","Metatarsal diaphyseal endosteal sclerosis" -"HP:0030193","Fatigable weakness of chewing muscles" -"HP:0100141","Ivory epiphysis of the distal phalanx of the 3rd toe" -"HP:0003860","Diaphyseal sclerosis of the upper limbs" -"HP:0001923","Reticulocytosis" -"HP:0003411","Proximal femoral metaphyseal irregularity" -"HP:0011937","Hypoplastic fifth toenail" -"HP:0009892","Anotia" -"HP:0008362","Aplasia/Hypoplasia of the hallux" -"HP:0010643","Midnasal atresia" -"HP:0010078","Bullet-shaped distal phalanx of the hallux" -"HP:0430016","Abnormality of tensor veli palatini muscle" -"HP:0003006","Neuroblastoma" -"HP:0008593","Prominent antitragus" -"HP:0001927","Acanthocytosis" -"HP:0002062","Morphological abnormality of the pyramidal tract" -"HP:0100163","Ivory epiphysis of the proximal phalanx of the 3rd toe" -"HP:0003949","Abnormality of the elbow metaphyses" -"HP:0011241","Serpiginous stem of antihelix" -"HP:0012796","Increased cup-to-disc ratio" -"HP:0006999","Basal ganglia gliosis" -"HP:0002487","Hyperkinesis" -"HP:0011173","Hypokinetic seizures" -"HP:0010305","Absence of the sacrum" -"HP:0200050","Bracket metacarpal epiphyses" -"HP:0003463","Increased extraneuronal autofluorescent lipopigment" -"HP:0011588","Cervical aortic arch" -"HP:0001266","Choreoathetosis" -"HP:0006599","Medial widening of clavicles" -"HP:0010534","Transient global amnesia" -"HP:0001268","Mental deterioration" -"HP:0002283","Global brain atrophy" -"HP:0030607","Reduced OCT-measured macular thickness" -"HP:0006913","Frontal cortical atrophy" -"HP:0005165","Shortened PR interval" -"HP:0002677","Small foramen magnum" -"HP:0005264","Abnormality of the gallbladder" -"HP:0003713","Muscle fiber necrosis" -"HP:0030269","Increased serum insulin-like growth factor 1" -"HP:0003946","Abnormality of the epiphyses of the elbow" -"HP:0030806","Fast-growing nails" -"HP:0002350","Cerebellar cyst" -"HP:0001783","Broad metatarsal" -"HP:0010195","Broad middle phalanges of the toes" -"HP:0012882","Hyperplastic labia majora" -"HP:0009623","Proximal placement of thumb" -"HP:0006571","Reduced number of intrahepatic bile ducts" -"HP:0100781","Abnormality of the sacroiliac joint" -"HP:0012252","Abnormal respiratory system morphology" -"HP:0006265","Aplasia/Hypoplasia of fingers" -"HP:3000024","Abnormal facial artery morphology" -"HP:0002330","Paroxysmal drowsiness" -"HP:0000262","Turricephaly" -"HP:0025386","Bitemporal hollowing" -"HP:0007721","Saccular conjunctival dilatations" -"HP:0008683","Enlarged labia minora" -"HP:0010021","Ivory epiphysis of the 1st metacarpal" -"HP:0011743","Adrenal gland agenesis" -"HP:0011070","Abnormality of molar morphology" -"HP:0011741","Secondary hyperaldosteronism" -"HP:0010743","Short metatarsal" -"HP:0003656","Decreased beta-glucocerebrosidase protein and activity" -"HP:0030434","Pilomatrixoma" -"HP:0031157","Carotid cavernous fistula" -"HP:0011662","Tricuspid atresia" -"HP:0100318","Lafora bodies" -"HP:0011524","Iris melanoma" -"HP:0009352","Ivory epiphysis of the proximal phalanx of the 3rd finger" -"HP:0030886","Abnormal lymphocyte apoptosis" -"HP:0006415","Cortically dense long tubular bones" -"HP:0002612","Congenital hepatic fibrosis" -"HP:0009104","Aplasia/Hypoplasia of the pubic bone" -"HP:0040047","Abnormality of the right hemidiaphragm" -"HP:0001302","Pachygyria" -"HP:0031051","Tarsal sclerosis" -"HP:0100268","Upper lip pit" -"HP:0100672","Vaginal hernia" -"HP:0011933","Elongated superior cerebellar peduncle" -"HP:0001412","Enteroviral hepatitis" -"HP:0031123","Recurrent gastroenteritis" -"HP:0005853","Congenital foot contraction deformities" -"HP:0100559","Lower limb asymmetry" -"HP:0011079","Impacted tooth" -"HP:0006293","Agenesis of maxillary central incisor" -"HP:0007461","Hemangiomatosis" -"HP:0005746","Osteosclerosis of the base of the skull" -"HP:0007330","Frontal encephalocele" -"HP:0003226","Rectilinear intracellular accumulation of autofluorescent lipopigment storage material" -"HP:0006400","Absent knee epiphyses" -"HP:0011486","Abnormality of corneal thickness" -"HP:0005938","Abnormal respiratory motile cilium morphology" -"HP:0030991","Sclerosing cholangitis" -"HP:0003491","Elevated urine pyrophosphate" -"HP:0100554","Hemihypertrophy of upper limb" -"HP:3000074","Abnormal lingual artery morphology" -"HP:0004490","Calvarial hyperostosis" -"HP:0009681","Ivory epiphysis of the distal phalanx of the thumb" -"HP:0045001","Abnormal ossification of the trapezium" -"HP:0005206","Pancreatic pseudocyst" -"HP:0010454","Acetabular spurs" -"HP:3000041","Abnormality of external carotid artery" -"HP:0100924","Sclerosis of toe phalanx" -"HP:0200143","Megaloblastic erythroid hyperplasia" -"HP:0031350","Cardiac sarcoma" -"HP:0005060","Limited elbow flexion/extension" -"HP:0003380","Decreased number of peripheral myelinated nerve fibers" -"HP:0009246","Aplasia of the distal phalanx of the 5th finger" -"HP:0001287","Meningitis" -"HP:0011816","Parietal encephalocele" -"HP:0007383","Congenital localized absence of skin" -"HP:0000346","Whistling appearance" -"HP:0031356","Terminal insomnia" -"HP:0007476","Anhidrotic ectodermal dysplasia" -"HP:0003985","Exostoses of the ulna" -"HP:0001312","Giant somatosensory evoked potentials" -"HP:0005129","Congenital hypertrophy of left ventricle" -"HP:0012478","Temporomandibular joint ankylosis" -"HP:0004423","Cranium bifidum occultum" -"HP:0003015","Flared metaphysis" -"HP:0007115","Orbital encephalocele" -"HP:0030588","Abnormal visual field test" -"HP:0009738","Abnormality of the antihelix" -"HP:0030032","Partial absence of foot" -"HP:0000496","Abnormality of eye movement" -"HP:0000128","Renal potassium wasting" -"HP:0001551","Abnormality of the umbilicus" -"HP:0010111","Short phalanx of hallux" -"HP:0025460","High myoinositol in brain by MRS" -"HP:0008089","Abnormality of the fifth metatarsal bone" -"HP:0002511","Alzheimer disease" -"HP:0009906","Aplasia/Hypoplasia of the earlobes" -"HP:0001310","Dysmetria" -"HP:0007123","Subcortical dementia" -"HP:0010663","Abnormality of thalamus morphology" -"HP:0005540","Red blood cell keratocytosis" -"HP:0002292","Frontal balding" -"HP:0012052","Low serum calcitriol" -"HP:0002167","Neurological speech impairment" -"HP:0005906","Delayed pneumatization of the mastoid process" -"HP:0006507","Aplasia/hypoplasia of the humerus" -"HP:0001347","Hyperreflexia" -"HP:0500021","Reduced brain gamma-aminobutyric acid level by MRS" -"HP:0009929","Abnormality of the columella" -"HP:0004562","Beaking of vertebral bodies T12-L3" -"HP:0030076","Lobular carcinoma in situ" -"HP:0007269","Spinal muscular atrophy" -"HP:0009011","Hypoplasia of serratus anterior muscle" -"HP:0030765","Sleep terror" -"HP:0005689","Dermatoglyphic ridges abnormal" -"HP:0007256","Abnormal pyramidal signs" -"HP:0007488","Diffuse skin atrophy" -"HP:0000751","Personality changes" -"HP:0008422","Vertebral wedging" -"HP:0002071","Abnormality of extrapyramidal motor function" -"HP:0012333","Abnormal sudomotor regulation" -"HP:0006762","Renal pelvic carcinoma" -"HP:0001473","Metatarsal osteolysis" -"HP:0012633","Asymmetry of intraocular pressure" -"HP:0006937","Impaired distal tactile sensation" -"HP:0012397","Aortic atherosclerosis" -"HP:0009846","Curved middle phalanges of the hand" -"HP:0007048","Large basal ganglia" -"HP:0001027","Soft, doughy skin" -"HP:0004717","Axial malrotation of the kidney" -"HP:0100960","Asymmetric ventricles" -"HP:0004607","Anterior beaking of lower thoracic vertebrae" -"HP:0003532","Ornithinuria" -"HP:0030054","Perifollicular fibrosis" -"HP:0025045","Abnormal brain lactate level by MRS" -"HP:0005625","Osteoporosis of vertebrae" -"HP:0006579","Prolonged neonatal jaundice" -"HP:0003869","Humeral cortical thinning" -"HP:0030058","Sickled erythrocytes" -"HP:0430000","Abnormality of the frontal bone" -"HP:0003854","Sclerosis of metaphyses of the upper limbs" -"HP:0007885","Slowed horizontal saccades" -"HP:0005478","Prominent frontal sinuses" -"HP:0008988","Pelvic girdle muscle atrophy" -"HP:0040160","Generalized osteoporosis" -"HP:0012334","Extrahepatic cholestasis" -"HP:0005170","Complete heart block with broad QRS complexes" -"HP:0010553","Oculogyric crisis" -"HP:0007597","Congenital palmoplantar keratodermia" -"HP:0011193","EEG with focal spikes" -"HP:0010001","Complete duplication of the distal phalanges of the hand" -"HP:0004060","Trident hand" -"HP:0001013","Eruptive xanthomas" -"HP:0012423","Colonic inertia" -"HP:0012715","Profound hearing impairment" -"HP:0200133","Lumbosacral meningocele" -"HP:0012021","Persistent patent ductus venosus" -"HP:0100264","Proximal symphalangism" -"HP:0004911","Episodic metabolic acidosis" -"HP:0011081","Incisor macrodontia" -"HP:0009194","Small epiphyses of the metacarpals" -"HP:0010708","1-5 finger syndactyly" -"HP:0030125","Sacralization of the fifth lumbar vertebra" -"HP:0030736","Sacrococcygeal teratoma" -"HP:0008726","Hypoplasia of the vagina" -"HP:0006077","Absent proximal finger flexion creases" -"HP:0010532","Paroxysmal vertigo" -"HP:0030040","Fused lumbar vertebrae" -"HP:0010790","Hyoplasia of the Leydig cells" -"HP:0007350","Hyperreflexia in upper limbs" -"HP:0031227","Nasopharyngeal teratoma" -"HP:0005143","Anomalous origin of right pulmonary artery from ascending aorta" -"HP:0020038","Vertebrobasilar dolichoectasia" -"HP:0031467","Negative affectivity" -"HP:0012539","Non-Hodgkin lymphoma" -"HP:0011930","Hyperextensible skin of chest" -"HP:0045080","Decreased number of CD3+ T cells" -"HP:0010236","Small epiphyses of the phalanges of the hand" -"HP:0031315","External carotid artery calcification" -"HP:0030755","Craniofacial teratoma" -"HP:0012815","Hypoplastic female external genitalia" -"HP:0008236","Isosexual precocious puberty" -"HP:0007280","Acute infantile spinal muscular atrophy" -"HP:0025121","Simple partial occipital seizures" -"HP:0011040","Abnormality of the intrahepatic bile duct" -"HP:0007054","Hyperreflexia proximally" -"HP:0011093","Molarization of premolar" -"HP:0100240","Synostosis of joints" -"HP:0031094","Abnormal breast physiology" -"HP:0030039","Fused thoracic vertebrae" -"HP:0008363","Aplasia/Hypoplasia of the tarsal bones" -"HP:0002853","Increased proportion of HLA DR+ and CD57+ T cells" -"HP:0012226","Ovarian teratoma" -"HP:0410055","Decreased level of erythritol in urine" -"HP:0003900","Small humeral epiphyses" -"HP:0001501","6 metacarpals" -"HP:0012403","Decreased urine alpha-ketoglutarate concentration" -"HP:0004010","Small radial epiphyses" -"HP:0000050","Hypoplastic male external genitalia" -"HP:0030767","Epignathus" -"HP:0045038","Gastric lymphoma" -"HP:0025453","Delayed adrenarche" -"HP:0030741","Mediastinal teratoma" -"HP:0000415","Abnormality of the choanae" -"HP:0004321","Bladder fistula" -"HP:0006931","Lipoma of corpus callosum" -"HP:0025576","Abnormal inferior vena cava morphology" -"HP:0003502","Mild short stature" -"HP:0007833","Anterior chamber synechiae" -"HP:0005638","Decreased anterioposterior diameter of lumbar vertebral bodies" -"HP:0003185","Short sacroiliac notch" -"HP:0002085","Occipital encephalocele" -"HP:0030311","Lower extremity joint dislocation" -"HP:0008069","Neoplasm of the skin" -"HP:0004971","Pulmonary artery hypoplasia" -"HP:0009723","Abnormality of the subungual region" -"HP:0030254","Nail bed hemorrhage" -"HP:0003023","Bowing of limbs due to multiple fractures" -"HP:0030805","Absent lunula" -"HP:0100245","Desmoid tumors" -"HP:0030817","Beaked nails" -"HP:0007065","Disorganization of the anterior cerebellar vermis" -"HP:0012710","Ingrown nail" -"HP:0025435","Increased lactate dehydrogenase activity" -"HP:0003070","Elbow ankylosis" -"HP:0030808","Ragged cuticle" -"HP:0006623","Costochondral joint sclerosis" -"HP:0005010","Osteomyelitis leading to amputation due to slow healing fractures" -"HP:0007565","Multiple cafe-au-lait spots" -"HP:0002661","Painless fractures due to injury" -"HP:0100276","Skin pit" -"HP:0012662","Parietal hypometabolism in FDG PET" -"HP:0002647","Aortic dissection" -"HP:3000062","Abnormality of internal carotid artery" -"HP:0100012","Neoplasm of the eye" -"HP:0012218","Alveolar soft part sarcoma" -"HP:0004955","Generalized arterial tortuosity" -"HP:0002979","Bowing of the legs" -"HP:0003177","Squared iliac bones" -"HP:0030935","Abnormality of intestinal smooth muscle morphology" -"HP:0007370","Aplasia/Hypoplasia of the corpus callosum" -"HP:0000647","Sclerocornea" -"HP:0001920","Renal artery stenosis" -"HP:0012805","Iris transillumination defect" -"HP:0030815","Lipoma of the tongue" -"HP:0010837","Decreased serum ceruloplasmin" -"HP:0004408","Abnormality of the sense of smell" -"HP:0100529","Abnormality of phosphate homeostasis" -"HP:0030360","Large cell lung carcinoma" -"HP:0012075","Personality disorder" -"HP:0011365","Patchy hypopigmentation of hair" -"HP:0012659","Prefrontal hypometabolism in FDG PET" -"HP:0100857","Flat sella turcica" -"HP:0006431","Proximal femoral metaphyseal abnormality" -"HP:0000664","Synophrys" -"HP:0012041","Decreased fertility in males" -"HP:0008653","Crescentic glomerulonephritis" -"HP:0000497","Globe retraction and deviation on abduction" -"HP:0011918","Clinodactyly of the 4th toe" -"HP:0004540","Congenital, generalized hypertrichosis" -"HP:0001326","EEG with irregular generalized spike and wave complexes" -"HP:0040332","Multifocal hypointensity of cerebral white matter on MRI" -"HP:0011852","Chylopericardium" -"HP:0001074","Atypical nevi in non-sun exposed areas" -"HP:0008372","Abnormality of vitamin A metabolism" -"HP:0030078","Lung adenocarcinoma" -"HP:0012661","Hypothalamic hypometabolism in FDG PET" -"HP:0007277","Paucity of anterior horn motor neurons" -"HP:0200147","Neuronal loss in basal ganglia" -"HP:0000288","Abnormality of the philtrum" -"HP:0002927","Histidinuria" -"HP:0003321","Biconcave flattened vertebrae" -"HP:0030126","Abnormality of the endometrium" -"HP:0004357","Abnormality of leucine metabolism" -"HP:0000519","Congenital cataract" -"HP:0011397","Abnormality of the dorsal column of the spinal cord" -"HP:0001841","Preaxial foot polydactyly" -"HP:0045034","Elevated urinary aminoisobutyric acid" -"HP:0002048","Renal cortical atrophy" -"HP:0002087","Abnormality of the upper respiratory tract" -"HP:0002909","Generalized aminoaciduria" -"HP:0008087","Nonossified fifth metatarsal" -"HP:0007989","Intraretinal exudate" -"HP:0100734","Abnormality of vertebral epiphysis morphology" -"HP:0030127","Endometriosis" -"HP:0003137","Prolinuria" -"HP:0003166","Increased urinary taurine" -"HP:0010493","Long metacarpals" -"HP:0005463","Elongated sella turcica" -"HP:0007902","Vitreous hemorrhage" -"HP:0004565","Severe platyspondyly" -"HP:0000178","Abnormality of lower lip" -"HP:0006213","Thin proximal phalanges with broad epiphyses of the hand" -"HP:0005121","Posterior scalloping of vertebral bodies" -"HP:0000852","Pseudohypoparathyroidism" -"HP:0025376","Hyperglutaminuria" -"HP:0011784","Thyrotoxicosis with diffuse goiter" -"HP:0200068","Nonprogressive visual loss" -"HP:0007747","Monocular horizontal nystagmus" -"HP:0011804","Abnormality of muscle physiology" -"HP:0025134","Increased serum estradiol" -"HP:0001132","Lens subluxation" -"HP:0004558","Cervical platyspondyly" -"HP:0025387","Pill-rolling tremor" -"HP:0010109","Short hallux" -"HP:0005787","Lumbar platyspondyly" -"HP:0009752","Cleft in skull base" -"HP:0003246","Prominent scrotal raphe" -"HP:0012697","Small basal ganglia" -"HP:0030602","Abnormal fundus autofluorescence imaging" -"HP:0005752","Flattened moderately deformed vertebrae" -"HP:0003168","Dibasicaminoaciduria" -"HP:0011702","Abnormal electrophysiology of sinoatrial node origin" -"HP:0008052","Retinal fold" -"HP:0003986","Exostoses of the radius" -"HP:0007937","Reticular pigmentary degeneration" -"HP:0012731","Ectopic anterior pituitary gland" -"HP:0005035","Shortening of all phalanges of the toes" -"HP:0030490","Exudative vitreoretinopathy" -"HP:0006169","Decreased mobility 3rd-5th fingers" -"HP:0007602","Complex palmar dermatoglyphic pattern" -"HP:0200085","Limb tremor" -"HP:0011922","Abnormal activity of mitochondrial respiratory chain" -"HP:0009897","Horizontal crus of helix" -"HP:0003167","Carnosinuria" -"HP:0006504","Anomaly of the limb diaphyses" -"HP:0003879","Humeral pseudarthrosis" -"HP:0003163","Elevated urinary delta-aminolevulinic acid" -"HP:0011006","Abnormality of the musculature of the neck" -"HP:0025358","Uveal ectropion" -"HP:0007057","Poor hand-eye coordination" -"HP:0031005","Hyperalgesia" -"HP:0025328","Antepartum hemorrhage" -"HP:0007984","Electronegative electroretinogram" -"HP:0003108","Hyperglycinuria" -"HP:0011917","Short 5th toe" -"HP:0003093","Limited hip extension" -"HP:0003535","3-Methylglutaconic aciduria" -"HP:0005303","Aortic arch calcification" -"HP:0008418","Squared-off platyspondyly" -"HP:0003153","Cystathioninuria" -"HP:0001097","Keratoconjunctivitis sicca" -"HP:0025333","Cortical thinning of foot bones" -"HP:0011966","Elevated plasma citrulline" -"HP:0003268","Argininuria" -"HP:0008205","Insulin-dependent but ketosis-resistant diabetes" -"HP:0009930","Asymmetry of the nares" -"HP:0008439","Lumbar hemivertebrae" -"HP:0007797","Retinal vascular malformation" -"HP:0007646","Absent lower eyelashes" -"HP:0002901","Hypocalcemia" -"HP:0008037","Absent anterior eye chamber" -"HP:0009633","Osteolytic defect of the proximal phalanx of the thumb" -"HP:0003260","Hydroxyprolinemia" -"HP:0005472","Orbital craniosynostosis" -"HP:0001953","Diabetic ketoacidosis" -"HP:0012172","Stereotypical body rocking" -"HP:0009285","Curved phalanges of the 4th finger" -"HP:0006929","Hypoglycemic encephalopathy" -"HP:0010704","1-2 finger syndactyly" -"HP:0002070","Limb ataxia" -"HP:0012556","Hyperbetaalaninemia" -"HP:0001233","2-3 finger syndactyly" -"HP:0004923","Hyperphenylalaninemia" -"HP:0005829","Maldevelopment of radioulnar joint" -"HP:0001987","Hyperammonemia" -"HP:0012880","Abnormality of the labia minora" -"HP:0012636","Retinal vein occlusion" -"HP:0002154","Hyperglycinemia" -"HP:0005248","Intrahepatic biliary atresia" -"HP:0010641","Abnormality of the midnasal cavity" -"HP:0006834","Developmental stagnation at onset of seizures" -"HP:0030691","Divergence nystagmus" -"HP:0010621","Cutaneous syndactyly of toes" -"HP:0002161","Hyperlysinemia" -"HP:0008430","Anterior beaking of lumbar vertebrae" -"HP:0007641","Dyschromatopsia" -"HP:0025311","Anterior chamber cyst" -"HP:0008798","Widened sacrosciatic notch" -"HP:0009101","Submucous cleft lip" -"HP:0003334","Elevated circulating catecholamine level" -"HP:0030636","Occult macular dystrophy" -"HP:0030318","Angular cheilitis" -"HP:0007815","Abnormal distribution of retinal arterioles and venules" -"HP:0007765","Deep anterior chamber" -"HP:0010459","True hermaphroditism" -"HP:0003235","Hypermethioninemia" -"HP:0003159","Hyperoxaluria" -"HP:0003354","Hyperthreoninemia" -"HP:0004384","Type I truncus arteriosus" -"HP:0012630","Abnormality of the trabecular meshwork" -"HP:0006976","Necrotizing encephalopathy" -"HP:0011609","Type III truncus arteriosus" -"HP:0008358","Hyperprolinemia" -"HP:0010492","Osseous finger syndactyly" -"HP:0031482","Abnormal regional left ventricular contraction" -"HP:0001563","Fetal polyuria" -"HP:0011788","Increased serum free triiodothyronine" -"HP:0100651","Type I diabetes mellitus" -"HP:0025495","Hypoplastic aorta" -"HP:0006886","Impaired distal vibration sensation" -"HP:0100894","Broad xiphoid process" -"HP:0006725","Pancreatic adenocarcinoma" -"HP:0007986","Increased retinal vascularity" -"HP:0011485","Corneolenticular adhesion" -"HP:0005253","Increased anterioposterior diameter of thorax" -"HP:0008344","Elevated plasma branched chain amino acids" -"HP:0005236","Chronic calcifying pancreatitis" -"HP:0011324","Multiple suture craniosynostosis" -"HP:0009280","Short 4th finger" -"HP:0003352","Endopolyploidy on chromosome studies of bone marrow" -"HP:0006879","Pontocerebellar atrophy" -"HP:0030433","Osteoid osteoma" -"HP:0002160","Hyperhomocystinemia" -"HP:0003072","Hypercalcemia" -"HP:0011340","Incomplete cleft of the upper lip" -"HP:0031349","Levotransposition of the great arteries" -"HP:0008001","Foveal hyperpigmentation" -"HP:0003231","Hypertyrosinemia" -"HP:0010705","4-5 finger syndactyly" -"HP:0010831","Impaired proprioception" -"HP:0005978","Type II diabetes mellitus" -"HP:0010896","Hypersarcosinemia" -"HP:0000660","Lipemia retinalis" -"HP:0004630","Anterior beaking of thoracic vertebrae" -"HP:0006097","3-4 finger syndactyly" -"HP:0006555","Diffuse hepatic steatosis" -"HP:0010906","Hyperhistidinemia" -"HP:0006568","Increased hepatic glycogen content" -"HP:0030129","Impaired ristocetin cofactor assay activity" -"HP:0006655","Rib segmentation abnormalities" -"HP:0011447","Hyposegmentation of neutrophil nuclei" -"HP:0003764","Nevus" -"HP:0031299","Elevated left atrial pressure" -"HP:0002439","Frontolimbic dementia" -"HP:0002497","Spastic ataxia" -"HP:0005772","Aplasia/Hypoplasia of the tibia" -"HP:0030779","Ethmocephaly" -"HP:0006607","Precocious costochondral ossification" -"HP:0012611","Increased urinary urate" -"HP:0003431","Decreased motor nerve conduction velocity" -"HP:0012822","Bilateral vocal cord paresis" -"HP:0001667","Right ventricular hypertrophy" -"HP:0012196","Cheyne-Stokes respiration" -"HP:0007732","Lacrimal gland hypoplasia" -"HP:0030207","Paradoxical respiration" -"HP:0007873","Abnormally prominent line of Schwalbe" -"HP:0005549","Congenital neutropenia" -"HP:0003332","Absent primary metaphyseal spongiosa" -"HP:0001177","Preaxial hand polydactyly" -"HP:0025149","Atrophic muscularis propria" -"HP:0011179","Beta-EEG" -"HP:0000437","Depressed nasal tip" -"HP:0008537","Cleft at the superior portion of the pinna" -"HP:0008250","Infantile hypercalcemia" -"HP:0100836","Malignant neoplasm of the central nervous system" -"HP:0000402","Stenosis of the external auditory canal" -"HP:0011781","Thyroid C cell hyperplasia" -"HP:0004397","Ectopic anus" -"HP:0030260","Microphallus" -"HP:0025196","Increased total iron binding capacity" -"HP:0001772","Talipes equinovalgus" -"HP:0011088","Dens in dente" -"HP:0040274","Adenocarcinoma of the small intestine" -"HP:0000436","Abnormality of the nasal tip" -"HP:0030252","Absence of mature B cells" -"HP:0002548","Parkinsonism with favorable response to dopaminergic medication" -"HP:0030192","Fatigable weakness of bulbar muscles" -"HP:0011024","Abnormality of the gastrointestinal tract" -"HP:0030196","Fatigable weakness of respiratory muscles" -"HP:0003554","Type 2 muscle fiber atrophy" -"HP:0005819","Short middle phalanx of finger" -"HP:0030027","Abnormality of the nasal cartilage" -"HP:0010868","Ocular dyssynergia" -"HP:0010690","Mirror image hand polydactyly" -"HP:0031369","Colon perforation" -"HP:0008659","Multiple small medullary renal cysts" -"HP:0003330","Abnormal bone structure" -"HP:0007990","Hypoplastic iris stroma" -"HP:0004886","Congenital laryngeal stridor" -"HP:0000429","Abnormality of the nasal alae" -"HP:0004529","Atrophic, patchy alopecia" -"HP:0010826","Abnormality of the twelfth cranial nerve" -"HP:0001785","Ankle swelling" -"HP:0011372","Aplasia of the inner ear" -"HP:0040186","Maculopapular exanthema" -"HP:0011119","Abnormality of the nasal dorsum" -"HP:0002860","Squamous cell carcinoma" -"HP:0012551","Absent neutrophil specific granules" -"HP:0001682","Subvalvular aortic stenosis" -"HP:0030612","Abnormal retinal morphology on macular OCT" -"HP:0002416","Subependymal cysts" -"HP:0030791","Abnormal jaw morphology" -"HP:0008200","Primary hyperparathyroidism" -"HP:0009209","Ivory epiphysis of the middle phalanx of the 5th finger" -"HP:0011986","Ectopic ossification" -"HP:0011408","Moderate intrauterine growth retardation" -"HP:0010457","Widening of the sacrosciatic notch" -"HP:0008181","Abetalipoproteinemia" -"HP:0002894","Neoplasm of the pancreas" -"HP:0040142","5-oxoprolinase deficiency" -"HP:0011530","Retinal hole" -"HP:0010802","Perioral hyperpigmentation" -"HP:0004780","Elbow hypertrichosis" -"HP:0011963","Pretesticular azoospermia" -"HP:0030747","Preterm intraventricular hemorrhage" -"HP:0012103","Abnormality of the mitochondrion" -"HP:0100548","Exstrophy" -"HP:0100027","Recurrent pancreatitis" -"HP:0008794","Dysplastic iliac wings" -"HP:0002321","Vertigo" -"HP:0007933","Broad lateral eyebrow" -"HP:0003741","Congenital muscular dystrophy" -"HP:0007663","Reduced visual acuity" -"HP:0006887","Intellectual disability, progressive" -"HP:0012422","Villous hypertrophy of choroid plexus" -"HP:0000639","Nystagmus" -"HP:0006694","Early progressive calcific cardiac valvular disease" -"HP:0100661","Trigeminal neuralgia" -"HP:0000306","Abnormality of the chin" -"HP:0010828","Hemifacial spasm" -"HP:0012290","Mouth neoplasm" -"HP:0040056","Absent upper eyelashes" -"HP:0030977","Increased factor VIII activity" -"HP:0410012","Abnormality of the mouth floor" -"HP:0010821","Gelastic seizures" -"HP:0006112","Expanded phalanges with widened medullary cavities" -"HP:0045045","Elevated plasma acylcarnitine levels" -"HP:0025309","Abnormal pupil shape" -"HP:0031570","Tessier number 0 facial cleft" -"HP:0008460","Hypoplastic spinal processes" -"HP:0004554","Generalized hypertrichosis" -"HP:0009170","Osteolytic defects of the middle phalanx of the 5th finger" -"HP:0012841","Retinal vascular tortuosity" -"HP:0003391","Gowers sign" -"HP:0001609","Hoarse voice" -"HP:0011337","Abnormality of mouth size" -"HP:0006336","Short dental roots" -"HP:0012202","Increased serum bile acid concentration" -"HP:0002539","Cortical dysplasia" -"HP:0002737","Thick skull base" -"HP:0000360","Tinnitus" -"HP:0010780","Hyperacusis" -"HP:0006026","Rounded epiphyses" -"HP:0025034","Abnormal morphology of erythroid progenitor cell" -"HP:0031587","Tessier number 30 facial cleft" -"HP:0009071","Inflammatory myopathy" -"HP:0008670","Partial vaginal septum" -"HP:0008475","Hypoplastic sacral vertebrae" -"HP:0030532","Visual acuity test abnormality" -"HP:0004789","Lactose intolerance" -"HP:0001605","Vocal cord paralysis" -"HP:0001271","Polyneuropathy" -"HP:0008189","Insulin insensitivity" -"HP:0012221","Pretibial blistering" -"HP:0010220","Abnormality of the epiphysis of the 2nd metacarpal" -"HP:0100748","Muscular edema" -"HP:0008702","Absent internal genitalia" -"HP:0045009","Abnormal morphology of the radius" -"HP:0004535","Anterior cervical hypertrichosis" -"HP:0006785","Limb-girdle muscular dystrophy" -"HP:0200101","Decreased/absent ankle reflexes" -"HP:0005090","Lateral femoral bowing" -"HP:0011913","Lumbar hypertrichosis" -"HP:0006114","Multiple palmar creases" -"HP:0004821","Hypersegmentation of neutrophil nuclei" -"HP:0012574","Mesangial hypercellularity" -"HP:0010726","Prominent corneal nerve fibers" -"HP:0009439","Short middle phalanx of the 3rd finger" -"HP:0009907","Attached earlobe" -"HP:0011338","Abnormality of mouth shape" -"HP:0000533","Chorioretinal atrophy" -"HP:0025397","Mosaic attenuation pattern on pulmonary HRCT" -"HP:0012486","Myelitis" -"HP:0040083","Toe walking" -"HP:0011914","Thoracic hypertrichosis" -"HP:0011253","Type I cryptotia" -"HP:3000054","Abnormality of inferior alveolar artery" -"HP:0100643","Abnormality of nail color" -"HP:0001291","Abnormality of the cranial nerves" -"HP:0002752","Sparse bone trabeculae" -"HP:0100595","Camptocormia" -"HP:3000011","Abnormality of palatoglossus muscle" -"HP:0004881","Episodic hypoventilation" -"HP:0012472","Eclabion" -"HP:0006696","Polymorphic and polytopic ventricular extrasystoles" -"HP:0200153","Agenesis of lateral incisor" -"HP:0040149","Woolly scalp hair" -"HP:0007859","Congenital horizontal nystagmus" -"HP:0009138","Synostosis involving bones of the lower limbs" -"HP:0012086","Abnormal urinary color" -"HP:0003779","Antegonial notching of mandible" -"HP:0010628","Facial palsy" -"HP:0011028","Abnormality of blood circulation" -"HP:0100305","Ring fibers" -"HP:0003038","Fibular hypoplasia" -"HP:0003839","Abnormality of upper limb epiphysis morphology" -"HP:0100875","Hemimacroglossia" -"HP:0006938","Impaired vibration sensation at ankles" -"HP:0003551","Difficulty climbing stairs" -"HP:0008952","Shoulder muscle hypoplasia" -"HP:0007905","Abnormal iris vasculature" -"HP:0010249","Enlarged epiphyses of the distal phalanges of the hand" -"HP:0040213","Hypopnea" -"HP:3000040","Abnormality of ethmoid sinus" -"HP:0005562","Multiple renal cysts" -"HP:0100531","Wind-swept deformity of the knees" -"HP:0007894","Hypopigmentation of the fundus" -"HP:0002156","Homocystinuria" -"HP:0009515","Cone-shaped epiphysis of the middle phalanx of the 2nd finger" -"HP:0007525","Yellow subcutaneous tissue covered by thin, scaly skin" -"HP:0010166","Fragmentation of the epiphyses of the toes" -"HP:0009487","Ulnar deviation of the hand" -"HP:0010540","Advanced pneumatization of cranial sinuses" -"HP:0025389","Pulmonary interstitial high-resolution computed tomography abnormality" -"HP:0007096","Hypoplasia of the optic tract" -"HP:0009102","Anterior open-bite malocclusion" -"HP:0011330","Metopic synostosis" -"HP:0030230","Central core regions in muscle fibers" -"HP:0009303","Osteolytic defects of the distal phalanx of the 4th finger" -"HP:0012470","Setting-sun eye phenomenon" -"HP:0001680","Coarctation of aorta" -"HP:0002687","Abnormality of frontal sinus" -"HP:0007588","Reticular hyperpigmentation" -"HP:0030452","Chylolymphatic mesenteric cyst" -"HP:0003323","Progressive muscle weakness" -"HP:0001734","Annular pancreas" -"HP:0430022","Abnormality of the sphenoid sinus" -"HP:0030508","Retinal cavernous hemangioma" -"HP:0100822","Rectocele" -"HP:0002047","Malignant hyperthermia" -"HP:0000378","Cupped ear" -"HP:0031405","Poroma" -"HP:0006143","Abnormal finger flexion creases" -"HP:0030818","Central nail canal" -"HP:0003116","Abnormal echocardiogram" -"HP:0005415","Decreased number of CD8+ T cells" -"HP:0007770","Hypoplasia of the retina" -"HP:0012905","Euryblepharon" -"HP:0008507","Static ophthalmoparesis" -"HP:0031273","Shock" -"HP:0006957","Loss of ability to walk" -"HP:0012078","Motor conduction block" -"HP:0008606","Supraauricular pit" -"HP:0030769","Exencephaly" -"HP:0002850","IgM deficiency" -"HP:0025107","Cutis marmorata telangiectatica congenita" -"HP:0007011","Fourth cranial nerve palsy" -"HP:0200017","Cerebral white matter agenesis" -"HP:0031503","Night gasping" -"HP:0430023","Abnormality of the maxillary sinus" -"HP:0002333","Motor deterioration" -"HP:0030163","Abnormal vascular physiology" -"HP:0003287","Abnormality of mitochondrial metabolism" -"HP:0005048","Synostosis of carpal bones" -"HP:0001969","Tubulointerstitial abnormality" -"HP:0011778","Thyroid atypical adenoma" -"HP:0002038","Protein avoidance" -"HP:0025019","Arterial rupture" -"HP:0009225","Aplasia of the proximal phalanx of the 5th finger" -"HP:0030146","Abnormal liver parenchyma morphology" -"HP:0005603","Numerous congenital melanocytic nevi" -"HP:0012246","Oculomotor nerve palsy" -"HP:0002299","Brittle hair" -"HP:0002747","Respiratory insufficiency due to muscle weakness" -"HP:0001142","Lenticonus" -"HP:0025443","Abnormal cardiac atrial physiology" -"HP:0006897","Cranial nerve VI palsy" -"HP:0003310","Abnormality of the odontoid process" -"HP:0011909","Flattened metacarpal heads" -"HP:0030956","Abnormality of cardiovascular system electrophysiology" -"HP:3000039","Abnormality of dorsal nasal artery" -"HP:0030049","Brain abscess" -"HP:0010602","Type 2 muscle fiber predominance" -"HP:0012034","Liposarcoma" -"HP:0030177","Abnormality of peripheral nervous system electrophysiology" -"HP:0001384","Abnormality of the hip joint" -"HP:0031325","Myocardial granulomatous infiltrates" -"HP:0030436","Fibrofolliculoma" -"HP:0031351","Calcified amorphous tumor of the heart" -"HP:0031322","Myocardial lymphocytic infiltration" -"HP:0010622","Neoplasm of the skeletal system" -"HP:0002246","Abnormality of the duodenum" -"HP:0031525","Keratoacanthoma" -"HP:0009917","Persistent pupillary membrane" -"HP:0031535","Increased theta frequency activity in EEG" -"HP:0031549","Lymphocytoma cutis" -"HP:0006389","Limited knee flexion" -"HP:0025432","Acanthoma" -"HP:0010843","EEG with focal slow activity" -"HP:0008783","Wide proximal femoral metaphysis" -"HP:0031518","Absent posterior alpha rhythm" -"HP:0012197","Insulinoma" -"HP:0031330","Perivascular myocardial immune cell infiltration" -"HP:0008162","Asymptomatic hyperammonemia" -"HP:0010044","Short 4th metacarpal" -"HP:0012301","Type II transferrin isoform profile" -"HP:0007437","Multiple cutaneous leiomyomas" -"HP:0003902","Epiphyseal stippling of the humerus" -"HP:0012149","Bilineage myelodysplasia" -"HP:0031018","Eccrine syringofibroadenoma" -"HP:0003984","Posteriorly dislocated ulna" -"HP:0000263","Oxycephaly" -"HP:0012366","Basilar invagination" -"HP:0100023","Recurrent hand flapping" -"HP:0005259","Abnormal facility in opposing the shoulders" -"HP:0012105","Occipital cortical atrophy" -"HP:0030428","Cutaneous myxoma" -"HP:0006749","Malignant gastrointestinal tract tumors" -"HP:0006769","Myxoid subcutaneous tumors" -"HP:0031564","Bronchial isomerism" -"HP:0011478","True anophthalmia" -"HP:0430021","Abnormal common carotid artery morphology" -"HP:0007620","Cutaneous leiomyoma" -"HP:0030794","Abnormal C-peptide level" -"HP:3000065","Abnormal lacrimal artery morphology" -"HP:0031491","Continuous spike and waves during slow sleep" -"HP:0012740","Papilloma" -"HP:0011212","EEG with photoparoxysmal response grade II" -"HP:0002730","Chronic noninfectious lymphadenopathy" -"HP:0008237","Hypothalamic hypothyroidism" -"HP:0006619","Anterior rib punctate calcifications" -"HP:0002875","Exertional dyspnea" -"HP:0007866","Retinal infarction" -"HP:0031420","Small yellow foveal lesion with surrounding grey zone" -"HP:0007922","Hypermyelinated retinal nerve fibers" -"HP:0001489","Posterior vitreous detachment" -"HP:0003904","Wide epiphyses of the upper limbs" -"HP:0031528","Subretinal deposits" -"HP:0100768","Choriocarcinoma" -"HP:0025537","Plantar edema" -"HP:0006983","Slowly progressive spastic quadriparesis" -"HP:0009835","Aplasia/Hypoplasia of the distal phalanges of the hand" -"HP:0012528","Abnormal number of alpha granules" -"HP:0031527","Intraretinal fluid" -"HP:0007585","Skin fragility with non-scarring blistering" -"HP:0006134","Enlarged metacarpal epiphyses" -"HP:0007858","Chorioretinal lacunae" -"HP:0012691","Focal T2 hypointense thalamic lesion" -"HP:0012795","Abnormality of the optic disc" -"HP:0010548","Percussion myotonia" -"HP:0001327","Photomyoclonic seizures" -"HP:0003481","Segmental peripheral demyelination/remyelination" -"HP:0040235","Leukocyte inclusion bodies" -"HP:0006386","Hypoplastic distal radial epiphyses" -"HP:0012549","Conjunctival lipoma" -"HP:0005707","Bilateral triphalangeal thumbs" -"HP:0006438","Enlargement of the distal femoral epiphysis" -"HP:0012903","Myotonia of the upper limb" -"HP:0025482","Positive perchlorate discharge test" -"HP:0006149","Increased laxity of fingers" -"HP:0005866","Opposable triphalangeal thumb" -"HP:0012902","Myotonia of the lower limb" -"HP:0009703","Synostosis involving the 1st metacarpal" -"HP:0100336","Bilateral cleft lip" -"HP:0002634","Arteriosclerosis" -"HP:0012204","Recurrent vulvovaginal candidiasis" -"HP:0030502","Retinoschisis" -"HP:0012527","Abnormal alpha granule content" -"HP:0006232","Expanded metacarpals with widened medullary cavities" -"HP:0006773","Cutaneous angiolipomas" -"HP:0100337","Bilateral cleft palate" -"HP:0009640","Synostosis of the proximal phalanx of the thumb with the 1st metatcarpal" -"HP:0012777","Retinal neoplasm" -"HP:0100546","Carotid artery stenosis" -"HP:0011170","Myoclonic atonic seizures" -"HP:0006383","Progressive bowing of long bones" -"HP:0010950","Abnormality of the fourth ventricle" -"HP:0100251","Lipomas of the central neryous system" -"HP:0030666","Retinal neovascularization" -"HP:0010070","Curved 1st metatarsal" -"HP:0030206","EMG: incremental response of compound muscle action potential to repetitive nerve stimulation" -"HP:0012638","Abnormality of nervous system physiology" -"HP:0031158","Widened atrophic scar" -"HP:0007811","Horizontal pendular nystagmus" -"HP:0025314","Choroidal nevus" -"HP:0007107","Segmental peripheral demyelination" -"HP:0010874","Tendon xanthomatosis" -"HP:0003898","Large humeral epiphyses" -"HP:0003077","Hyperlipidemia" -"HP:0012426","Optic disc drusen" -"HP:0009705","Synostosis involving the 2nd metacarpal" -"HP:0100642","Neoplasm of the adrenal medulla" -"HP:0007661","Abnormality of chorioretinal pigmentation" -"HP:0030148","Heart murmur" -"HP:0006473","Anterior bowing of long bones" -"HP:0002631","Dilatation of ascending aorta" -"HP:0031363","Palpable purpura" -"HP:0004970","Ascending aortic dilation" -"HP:0006387","Wide distal femoral metaphysis" -"HP:0010165","Enlarged epiphyses of the toes" -"HP:0100657","Thoracoabdominal eventration" -"HP:0025129","Abnormal small intestinal mucosa morphology" -"HP:0100514","Abnormality of vitamin E metabolism" -"HP:0030611","Retinal pigment epithelial loss on macular OCT" -"HP:0007731","Chorioretinal dysplasia" -"HP:0001699","Sudden death" -"HP:3000005","Abnormality of masseter muscle" -"HP:0040024","Clinodactyly of the 3rd finger" -"HP:0030882","Coronary artery aneurysm" -"HP:0031631","Subpleural honeycombing" -"HP:0100659","Abnormality of the cerebral vasculature" -"HP:0200065","Chorioretinal degeneration" -"HP:0030952","Birdshot choroidal lesions" -"HP:0012730","Aglossia" -"HP:0005890","Hyperostosis cranialis interna" -"HP:0031365","Macular purpura" -"HP:0031040","Late spermatogenesis maturation arrest" -"HP:0008240","Secondary growth hormone deficiency" -"HP:0025148","Dark choroid" -"HP:0040084","Abnormal circulating renin" -"HP:0002616","Aortic root dilatation" -"HP:0005067","Proximal fibular overgrowth" -"HP:0012358","Abnormal protein O-linked glycosylation" -"HP:0000972","Palmoplantar hyperkeratosis" -"HP:0007516","Redundant skin on fingers" -"HP:0007376","Abnormality of the choroid plexus" -"HP:0011981","Pigment gallstones" -"HP:0031531","Sub-RPE deposits" -"HP:0003013","Bulging epiphyses" -"HP:0031508","Abnormal thyroid hormone level" -"HP:0500046","Seborrhoeic blepharitis" -"HP:0030979","Dilatation of large choroidal vessels" -"HP:0008315","Decreased plasma free carnitine" -"HP:0011752","Neoplasm of the posterior pituitary" -"HP:0004416","Precocious atherosclerosis" -"HP:0030497","Macular cotton wool spots" -"HP:0010176","Curved toe phalanx" -"HP:0009442","Curved phalanges of the 3rd finger" -"HP:0010271","Enlarged epiphyses of the proximal phalanges of the hand" -"HP:0001114","Xanthelasma" -"HP:0007573","Late onset atopic dermatitis" -"HP:0025353","Anti-multiple nuclear dots antibody positivity" -"HP:0003913","Humeral metaphyseal irregularity" -"HP:0004354","Abnormality of carboxylic acid metabolism" -"HP:0031586","Tessier number 14 facial cleft" -"HP:0012537","Food intolerance" -"HP:0003897","Irregular ossification of the humeral epiphyses" -"HP:0031575","Tessier number 3 facial cleft" -"HP:0011782","Thyroid crisis" -"HP:0012535","Abnormal synaptic transmission" -"HP:0005739","Posterior subluxation of radial head" -"HP:0003570","Molybdenum cofactor deficiency" -"HP:0025021","Abnormal erythrocyte sedimentation rate" -"HP:0008723","Gonadal dysgenesis with female appearance, male" -"HP:0004364","Abnormality of nitrogen compound homeostasis" -"HP:0011017","Abnormality of cell physiology" -"HP:0012749","Focal T2 hypointense brainstem lesion" -"HP:0040127","Abnormal sweat homeostasis" -"HP:0025052","Abnormal brain N-acetyl aspartate level by MRS" -"HP:0004360","Abnormality of acid-base homeostasis" -"HP:0031577","Tessier number 5 facial cleft" -"HP:0011317","Right unicoronal synostosis" -"HP:0012337","Abnormal homeostasis" -"HP:0003403","EMG: decremental response of compound muscle action potential to repetitive nerve stimulation" -"HP:0003343","Glutathione synthetase deficiency" -"HP:0011812","Agraphesthesia" -"HP:0009699","Osteolytic defects of the hand bones" -"HP:0100252","Diaphyseal dysplasia" -"HP:0025079","Pancreatic abscess" -"HP:0001218","Autoamputation" -"HP:0012466","Chronic respiratory acidosis" -"HP:0031582","Tessier number 10 facial cleft" -"HP:0004358","Abnormality of superoxide metabolism" -"HP:0008297","Transient hyperphenylalaninemia" -"HP:0006397","Lateral displacement of patellae" -"HP:0003533","Delayed oxidation of acetaldehyde" -"HP:0011786","Thyrotoxicosis with toxic single thyroid nodule" -"HP:0040329","Multifocal hyperintensity of cerebral white matter on MRI" -"HP:0008835","Multicentric femoral head ossification" -"HP:0007812","Herpetiform corneal ulceration" -"HP:0002700","Large foramen magnum" -"HP:0009060","Scapular muscle atrophy" -"HP:0030994","Pancreas divisum" -"HP:0009843","Aplasia/Hypoplasia of the middle phalanges of the hand" -"HP:0031581","Tessier number 9 facial cleft" -"HP:0011783","Thyrotoxicosis from ectopic thyroid tissue" -"HP:0031414","High serum calcifediol" -"HP:0040010","Small posterior fossa" -"HP:0031454","Apocrine hidrocystoma" -"HP:0011785","Thyrotoxicosis with toxic multinodular goitre" -"HP:0006572","Subacute progressive viral hepatitis" -"HP:0008823","Hypoplastic inferior pubic rami" -"HP:0010275","Pseudoepiphyses of the proximal phalanges of the hand" -"HP:0031048","Light-chain paraproteinemia" -"HP:0000239","Large fontanelles" -"HP:0002814","Abnormality of the lower limb" -"HP:0007295","Chaotic rapid conjugate ocular movements" -"HP:0008348","Immunoglobulin IgG2 deficiency" -"HP:0031593","Abnormal PR interval" -"HP:0000145","Transverse vaginal septum" -"HP:0005832","Dysharmonic delayed bone age" -"HP:0030533","Abnormal unaided visual acuity test" -"HP:0008108","Advanced tarsal ossification" -"HP:0002100","Recurrent aspiration pneumonia" -"HP:0010719","Abnormality of hair texture" -"HP:0009312","Osteolytic defects of the proximal phalanx of the 4th finger" -"HP:0030884","Gastrojejunal tube feeding in infancy" -"HP:0003258","Glyoxalase deficiency" -"HP:0002345","Action tremor" -"HP:0010171","Epiphyseal stippling of toe phalanges" -"HP:0012032","Lipoma" -"HP:0002017","Nausea and vomiting" -"HP:0001928","Abnormality of coagulation" -"HP:0011395","Aplasia/Hypoplasia of the cochlea" -"HP:0025116","Fetal distress" -"HP:0002693","Abnormality of the skull base" -"HP:0002451","Limb dystonia" -"HP:0009778","Short thumb" -"HP:0011123","Inflammatory abnormality of the skin" -"HP:0003199","Decreased muscle mass" -"HP:0001483","Eye poking" -"HP:0010727","Spontaneous rupture of the globe" -"HP:0001270","Motor delay" -"HP:0005588","Patchy palmoplantar keratoderma" -"HP:0011113","Abnormality of cytokine secretion" -"HP:0002655","Spondyloepiphyseal dysplasia" -"HP:0010876","Abnormality of circulating protein level" -"HP:0000997","Axillary freckling" -"HP:0002524","Cataplexy" -"HP:0009797","Cholesteatoma" -"HP:0002362","Shuffling gait" -"HP:0040219","Absent natural killer cells" -"HP:0001538","Protuberant abdomen" -"HP:0011869","Abnormal platelet function" -"HP:0003139","Panhypogammaglobulinemia" -"HP:0012168","Head-banging" -"HP:0006756","Diffuse leiomyomatosis" -"HP:0012407","Scissor gait" -"HP:0003513","Reduced ratio of renal calcium clearance to creatinine clearance" -"HP:0003785","Decreased CSF homovanillic acid" -"HP:0030052","Inguinal freckling" -"HP:0100718","Uterine rupture" -"HP:0001911","Abnormality of granulocytes" -"HP:0006016","Delayed phalangeal epiphyseal ossification" -"HP:0011470","Nasogastric tube feeding in infancy" -"HP:0100513","Vitamin E deficiency" -"HP:0030051","Tip-toe gait" -"HP:0011533","Snowflake vitreoretinal degeneration" -"HP:0003541","Urinary glycosaminoglycan excretion" -"HP:0007104","Prolonged somatosensory evoked potentials" -"HP:0100950","Decreased activity of 3-hydroxyacyl-CoA dehydrogenase" -"HP:0010372","Broad phalanges of the 4th toe" -"HP:0200097","Oral mucosal blisters" -"HP:0010486","Abnormality of the hypothenar eminence" -"HP:0005267","Premature delivery because of cervical insufficiency or membrane fragility" -"HP:0002220","Melanin pigment aggregation in hair shafts" -"HP:0011616","Pulmonary situs inversus" -"HP:0030353","Decreased serum insulin-like growth factor 1" -"HP:0100071","Irregular epiphyses of the 4th toe" -"HP:0012153","Hypotriglyceridemia" -"HP:0011846","Osteoblastoma" -"HP:0000884","Prominent sternum" -"HP:0001712","Left ventricular hypertrophy" -"HP:0010360","Broad phalanges of the 3rd toe" -"HP:0000384","Preauricular skin tag" -"HP:0005340","Spastic/hyperactive bladder" -"HP:0009747","Lumbosacral hirsutism" -"HP:0025010","Foveal atrophy" -"HP:0000147","Polycystic ovaries" -"HP:0040314","Blind vagina" -"HP:0012251","ST segment elevation" -"HP:0005112","Dilatation of the abdominal aorta" -"HP:0011954","Nodular regenerative hyperplasia of liver" -"HP:0007002","Motor axonal neuropathy" -"HP:0004959","Dilatation of the descending thoracic aorta" -"HP:0100060","Irregular epiphyses of the 3rd toe" -"HP:0011620","Abnormality of abdominal situs" -"HP:0025425","Laryngospasm" -"HP:0001771","Achilles tendon contracture" -"HP:0005979","Metabolic ketoacidosis" -"HP:0100082","Irregular epiphyses of the 5th toe" -"HP:0007159","Fluctuations in consciousness" -"HP:0012526","Absence of alpha granules" -"HP:0006522","Repeated pneumothoraces" -"HP:0000287","Increased facial adipose tissue" -"HP:0010384","Broad phalanges of the 5th toe" -"HP:0001751","Vestibular dysfunction" -"HP:0000951","Abnormality of the skin" -"HP:0011840","Abnormality of T cell physiology" -"HP:0005314","Anomalous branches of internal carotid artery" -"HP:0012393","Allergy" -"HP:0030506","Yellow/white lesions of the retina" -"HP:0025044","Lung abscess" -"HP:0100049","Irregular epiphyses of the 2nd toe" -"HP:0009186","Contracture of the metacarpophalangeal joint of the 5th finger" -"HP:0009495","Pseudoepiphyses of the 2nd finger" -"HP:0008687","Hypoplasia of the prostate" -"HP:0003247","Overgrowth of external genitalia" -"HP:0000068","Urethral atresia" -"HP:0002079","Hypoplasia of the corpus callosum" -"HP:0007238","Nonarteriosclerotic cerebral calcification" -"HP:0003565","Elevated erythrocyte sedimentation rate" -"HP:0008705","Ureteral triplication" -"HP:0006638","Midclavicular aplasia" -"HP:0009924","Aplasia/Hypoplasia involving the nose" -"HP:0000377","Abnormality of the pinna" -"HP:0005212","Anal mucosal leukoplakia" -"HP:0000987","Atypical scarring of skin" -"HP:0010157","Small epiphysis of the 1st metatarsal" -"HP:0008643","Nephroblastomatosis" -"HP:0003162","Fasting hypoglycemia" -"HP:0100849","Neoplasm of the scrotum" -"HP:0004817","Drug-sensitive hemolytic anemia" -"HP:0012277","Hypoglycinemia" -"HP:0003808","Abnormal muscle tone" -"HP:0001120","Abnormality of corneal size" -"HP:0004331","Decreased skull ossification" -"HP:0008583","Underfolded superior helices" -"HP:0003416","Spinal canal stenosis" -"HP:0025470","Telogen effluvium" -"HP:0003079","Defective DNA repair after ultraviolet radiation damage" -"HP:0000009","Functional abnormality of the bladder" -"HP:0030894","Insufficient response to short acting pulmonary vasodilator" -"HP:0001052","Nevus flammeus" -"HP:0008494","Inferior lens subluxation" -"HP:0004856","Normochromic microcytic anemia" -"HP:0006136","Bilateral postaxial polydactyly" -"HP:0010028","Bullet-shaped 1st metacarpal" -"HP:0002557","Hypoplastic nipples" -"HP:0012286","Abnormal hypothalamus morphology" -"HP:0006984","Distal sensory loss of all modalities" -"HP:0004863","Compensated hemolytic anemia" -"HP:0100620","Germinoma" -"HP:0004844","Coombs-positive hemolytic anemia" -"HP:0007915","Polymorphous posterior corneal dystrophy" -"HP:0012431","Episodic fatigue" -"HP:0007911","Congenital bilateral ptosis" -"HP:0012680","Abnormality of the pineal gland" -"HP:0010858","EEG with hyperventilation-induced epileptiform discharges" -"HP:0005535","Exercise-induced hemolysis" -"HP:0008000","Decreased corneal reflex" -"HP:0005731","Cortical irregularity" -"HP:0004814","Fava bean-induced hemolytic anemia" -"HP:0009880","Broad distal phalanges of all fingers" -"HP:0008028","Cystoid macular degeneration" -"HP:0000049","Shawl scrotum" -"HP:0011492","Abnormality of corneal stroma" -"HP:0011379","Dilated vestibule of the inner ear" -"HP:0003387","Decreased number of large peripheral myelinated nerve fibers" -"HP:0100005","Testicular mesothelioma" -"HP:0012843","Hair follicle neoplasm" -"HP:0025319","Rubeosis iridis" -"HP:0025390","Reticular pattern on pulmonary HRCT" -"HP:0001762","Talipes equinovarus" -"HP:0009834","Abnormality of the proximal phalanges of the hand" -"HP:0007932","Bilateral congenital mydriasis" -"HP:0001930","Nonspherocytic hemolytic anemia" -"HP:0100639","Erectile abnormalities" -"HP:0009609","Duplication of the 1st metacarpal" -"HP:0006737","Extraadrenal pheochromocytoma" -"HP:0031484","Cold-induced hemolysis" -"HP:0011120","Concave nasal ridge" -"HP:0005511","Heinz body anemia" -"HP:0002000","Short columella" -"HP:0005525","Spontaneous hemolytic crises" -"HP:0000149","Ovarian gonadoblastoma" -"HP:0030983","Ovarian thecoma" -"HP:0001438","Abnormality of abdomen morphology" -"HP:0025469","Anagen effluvium" -"HP:0100259","Postaxial polydactyly" -"HP:0005494","Premature posterior fontanelle closure" -"HP:0025348","Abnormality of the corneal limbus" -"HP:0011617","Pulmonary situs ambiguus" -"HP:0002212","Curly hair" -"HP:0011509","Macular hyperpigmentation" -"HP:0003459","Polyclonal elevation of IgM" -"HP:0500011","Moon facies" -"HP:0040184","Oral bleeding" -"HP:0004362","Abnormality of enteric ganglion morphology" -"HP:0006774","Ovarian papillary adenocarcinoma" -"HP:0008269","Increased red cell hemolysis by shear stress" -"HP:0011495","Abnormality of corneal epithelium" -"HP:0001195","Single umbilical artery" -"HP:0001140","Epibulbar dermoid" -"HP:0100517","Neoplasm of the urethra" -"HP:0003184","Decreased hip abduction" -"HP:0007705","Corneal degeneration" -"HP:0004298","Abnormality of the abdominal wall" -"HP:0006714","Aplasia/Hypoplasia of the sternum" -"HP:0009180","Ulnar deviation of the 5th finger" -"HP:0030431","Osteochondroma" -"HP:0002230","Generalized hirsutism" -"HP:0009429","Aplasia of the distal phalanx of the 3rd finger" -"HP:0007755","Juvenile epithelial corneal dystrophy" -"HP:0030809","Abnormal tongue morphology" -"HP:0100840","Aplasia/Hypoplasia of the eyebrow" -"HP:0002227","White eyelashes" -"HP:0006407","Irregular distal femoral epiphysis" -"HP:0009844","Broad middle phalanx of finger" -"HP:0500008","Cornea verticillata" -"HP:0009928","Thick nasal alae" -"HP:0008812","Flattened femoral head" -"HP:0012811","Wide nasal ridge" -"HP:0000540","Hypermetropia" -"HP:0030149","Cardiogenic shock" -"HP:0011699","Atrial reentry tachycardia" -"HP:0030293","Fibular metaphyseal irregularity" -"HP:0005442","Widely patent coronal suture" -"HP:0002744","Bilateral cleft lip and palate" -"HP:0100691","Abnormality of the curvature of the cornea" -"HP:0004493","Craniofacial hyperostosis" -"HP:0011481","Abnormality of the lacrimal duct" -"HP:0030012","Abnormal female reproductive system physiology" -"HP:0000260","Wide anterior fontanel" -"HP:0007628","Mandibular condyle hypoplasia" -"HP:0002678","Skull asymmetry" -"HP:0008459","Cervical vertebral agenesis" -"HP:0002041","Intractable diarrhea" -"HP:0004288","Pseudoepiphyses of hand bones" -"HP:0010086","Broad proximal phalanx of the hallux" -"HP:0040177","Abnormal level of platelet-activating factor" -"HP:0008573","Low-frequency sensorineural hearing impairment" -"HP:0007260","Type II lissencephaly" -"HP:0005684","Distal arthrogryposis" -"HP:0008936","Muscular hypotonia of the trunk" -"HP:0410056","Decreased level of erythritol in CSF" -"HP:0025094","Disciform macular scar" -"HP:0100588","Paraphimosis" -"HP:0005001","Recurrent patellar dislocation" -"HP:0009438","Absent middle phalanx of 3rd finger" -"HP:0005037","Proximal radio-ulnar synostosis" -"HP:0012370","Prominence of the zygomatic bone" -"HP:0008005","Congenital corneal dystrophy" -"HP:0008945","Loss of ability to walk in early childhood" -"HP:0200154","Agenesis of mandibular lateral incisor" -"HP:0007379","Neoplasm of the genitourinary tract" -"HP:0011257","Serpiginous crus of helix" -"HP:0001500","Broad finger" -"HP:0005026","Mesomelic/rhizomelic limb shortening" -"HP:0009951","Partial duplication of the distal phalanx of the 2nd finger" -"HP:0007702","Pigmentary retinal deposits" -"HP:0040275","Adenocarcinoma of the large intestine" -"HP:0100821","Urethrocele" -"HP:0040004","Abnormality of corneal shape" -"HP:0007385","Aplasia cutis congenita of scalp" -"HP:0002738","Hypoplastic frontal sinuses" -"HP:0025417","Patulous urethra" -"HP:0000224","Decreased taste sensation" -"HP:0008517","Aplasia/Hypoplasia of the sacrum" -"HP:0012276","Digital flexor tenosynovitis" -"HP:0008048","Abnormality of the line of Schwalbe" -"HP:0003111","Abnormality of ion homeostasis" -"HP:0005456","Absent ethmoidal sinuses" -"HP:0100896","Rectal polyposis" -"HP:0002789","Tachypnea" -"HP:0006566","Neonatal cholestatic liver disease" -"HP:0005923","Abnormalities of the metaphyses of the hand" -"HP:0011796","Perilobar nephroblastomatosis" -"HP:0005229","Jejunoileal ulceration" -"HP:0005894","Double first metacarpals" -"HP:0008054","Abnormality of the vasculature of the conjunctiva" -"HP:0006135","Decreased finger mobility" -"HP:0011847","Giant cell tumor of bone" -"HP:0000292","Loss of facial adipose tissue" -"HP:0003647","Electron transfer flavoprotein-ubiquinone oxidoreductase defect" -"HP:0011982","Black pigment gallstones" -"HP:0008187","Absence of secondary sex characteristics" -"HP:0005764","Polyarticular arthritis" -"HP:0025367","Trichoepithelioma" -"HP:0012267","Absent respiratory ciliary axoneme radial spokes" -"HP:0030405","Pancreatic endocrine tumor" -"HP:0005045","Diaphyseal cortical sclerosis" -"HP:0002553","Highly arched eyebrow" -"HP:0011453","Abnormality of the incus" -"HP:0001674","Complete atrioventricular canal defect" -"HP:0008113","Multiple plantar creases" -"HP:0000728","Impaired ability to form peer relationships" -"HP:0001063","Acrocyanosis" -"HP:0010660","Abnormal hand bone ossification" -"HP:0012273","Increased carotid artery intimal medial thickness" -"HP:0006480","Premature loss of teeth" -"HP:0025337","Red eye" -"HP:0003043","Abnormality of the shoulder" -"HP:0031095","Abnormal humerus morphology" -"HP:0009276","Contracture of the proximal interphalangeal joint of the 4th finger" -"HP:0007457","Prominent veins on trunk" -"HP:0000914","Shield chest" -"HP:0005733","Spinal stenosis with reduced interpedicular distance" -"HP:0007232","Spinocerebellar tract disease in lower limbs" -"HP:0000666","Horizontal nystagmus" -"HP:0011175","Versive seizures" -"HP:0001197","Abnormality of prenatal development or birth" -"HP:0007420","Spontaneous hematomas" -"HP:0000655","Vitreoretinal degeneration" -"HP:0030349","Decreased circulating androgen level" -"HP:0009568","Aplasia/Hypoplasia of the middle phalanx of the 2nd finger" -"HP:0001421","Abnormality of the musculature of the hand" -"HP:0006256","Abnormality of hand joint mobility" -"HP:0007777","Chorioretinal scar" -"HP:0006889","Intellectual disability, borderline" -"HP:0012471","Thick vermilion border" -"HP:0004222","Cone-shaped epiphysis of the distal phalanx of the 5th finger" -"HP:0011807","Type 1 muscle fiber atrophy" -"HP:0025492","Microcoria" -"HP:0009626","Contractures of the interphalangeal joint of the thumb" -"HP:0011431","Fetal fifth finger clinodactyly" -"HP:0030251","Absence of memory B cells" -"HP:0011363","Abnormality of hair growth rate" -"HP:0031402","Reduced antigen-specific T cell proliferation" -"HP:0006434","Hypoplasia of proximal radius" -"HP:0012736","Profound global developmental delay" -"HP:0005922","Abnormal hand morphology" -"HP:0011315","Unicoronal synostosis" -"HP:0008730","Female external genitalia in individual with 46,XY karyotype" -"HP:0001248","Short tubular bones of the hand" -"HP:0007185","Loss of consciousness" -"HP:0009697","Contracture of the distal interphalangeal joint of the fingers" -"HP:0100871","Abnormality of the palm" -"HP:0010432","Absent distal phalanx of the 2nd toe" -"HP:0030062","Craniopharyngioma" -"HP:0003203","Negative nitroblue tetrazolium reduction test" -"HP:0007078","Decreased amplitude of sensory action potentials" -"HP:0005925","Abnormalities of the diaphyses of the hand" -"HP:0011749","Adrenocorticotropic hormone excess" -"HP:0005182","Bicuspid pulmonary valve" -"HP:0100681","Esophageal duplication" -"HP:0006490","Abnormality of lower-limb metaphyses" -"HP:0003254","Abnormality of DNA repair" -"HP:0009491","Enlarged epiphyses of the 2nd finger" -"HP:0000032","Abnormality of male external genitalia" -"HP:0012451","Acute constipation" -"HP:0008445","Cervical spinal canal stenosis" -"HP:0100000","Early onset of sexual maturation" -"HP:0030304","Abnormal number of vertebrae" -"HP:0012346","Abnormal protein glycosylation" -"HP:0011297","Abnormality of digit" -"HP:0001018","Abnormal palmar dermatoglyphics" -"HP:0031291","Ichthyosis follicularis" -"HP:0008948","Proximal upper limb amyotrophy" -"HP:0025103","Umbilicated nodule" -"HP:0030909","Anti-liver cytosolic antigen type 1 antibody positivity" -"HP:0008420","Punctate vertebral calcifications" -"HP:0008453","Congenital kyphoscoliosis" -"HP:0030147","Truncal titubation" -"HP:0030003","Paralytic lagophthalmos" -"HP:0010160","Abnormality of the epiphyses of the toes" -"HP:0040066","Abnormal morphology of bones of the lower limbs" -"HP:0025457","Decreased CSF total protein" -"HP:0007791","Patchy atrophy of the retinal pigment epithelium" -"HP:0012572","Ureter duplex" -"HP:0030775","Modic type vertebral endplate changes" -"HP:0200016","Acrokeratosis" -"HP:0004303","Abnormality of muscle fibers" -"HP:0012876","Premature ejaculation" -"HP:0007455","Adermatoglyphia" -"HP:0006944","Abolished vibration sense" -"HP:0040310","Sterile arthritis" -"HP:0030037","Bifid ureter" -"HP:0007469","Palmoplantar cutis gyrata" -"HP:0001641","Abnormal pulmonary valve morphology" -"HP:0100861","Vertebral body sclerosis" -"HP:0010732","Nodular changes affecting the eyelids" -"HP:0004976","Knee dislocation" -"HP:0006505","Abnormality of limb epiphysis morphology" -"HP:0007988","Macular hypopigmentation" -"HP:0003106","Subperiosteal bone resorption" -"HP:0005155","Ventricular escape rhythm" -"HP:0000017","Nocturia" -"HP:0100262","Synostosis involving digits" -"HP:0009768","Broad phalanges of the hand" -"HP:0007033","Cerebellar dysplasia" -"HP:0002818","Abnormality of the radius" -"HP:0011158","Auditory auras" -"HP:0004000","Cone-shaped distal radial epiphysis" -"HP:0030030","Absent ray" -"HP:0007503","Generalized ichthyosis" -"HP:0012571","Ureter fissus" -"HP:0003796","Irregular iliac crest" -"HP:0007807","Optic nerve compression" -"HP:0002509","Limb hypertonia" -"HP:0004237","Large carpal bones" -"HP:0001983","Reduced lymphocyte surface expression of CD43" -"HP:0040065","Abnormal morphology of bones of the upper limbs" -"HP:0025554","Yellow nodule" -"HP:0009077","Weakness of long finger extensor muscles" -"HP:0025106","Nevus roseus" -"HP:0008057","Aplasia/Hypoplasia affecting the fundus" -"HP:0025529","Hyperpigmented nodule" -"HP:0003610","Fibroblast metachromasia" -"HP:0012454","Unilateral wrist flexion contracture" -"HP:0009815","Aplasia/hypoplasia of the extremities" -"HP:0011169","Generalized clonic seizures" -"HP:0008102","Expanded metatarsals with widened medullary cavities" -"HP:0000878","11 pairs of ribs" -"HP:0010462","Aplasia/Hypoplasia of the ovary" -"HP:0010506","Abnormal plantar dermatoglyphics" -"HP:0008062","Aplasia/Hypoplasia affecting the anterior segment of the eye" -"HP:0012192","Cutaneous T-cell lymphoma" -"HP:0000866","Euthyroid multinodular goiter" -"HP:0005462","Calcification of falx cerebri" -"HP:0030210","Muscle specific kinase antibody positivity" -"HP:0007867","Restrictive partial external ophthalmoplegia" -"HP:0003164","Hypothalamic gonadotropin-releasing hormone deficiency" -"HP:0004768","Sparse anterior scalp hair" -"HP:0030041","Schmorl's node" -"HP:0100524","Limb duplication" -"HP:0010999","Aplasia of the optic tract" -"HP:0005250","High intestinal obstruction" -"HP:0410049","Abnormality of radial ray" -"HP:0000594","Shallow anterior chamber" -"HP:0005914","Aplasia/Hypoplasia involving the metacarpal bones" -"HP:0031181","Necrolytic migratory erythema" -"HP:0009744","Abnormality of the spinal dura mater" -"HP:0025535","Shawl sign" -"HP:0031574","Orbital cleft" -"HP:0000918","Scapular exostoses" -"HP:0004754","Permanent atrial fibrillation" -"HP:0005152","Histiocytoid cardiomyopathy" -"HP:0005323","Hemifacial hypertrophy" -"HP:0031319","Cardiomyocyte hypertrophy" -"HP:0002834","Flared femoral metaphysis" -"HP:0011332","Hemifacial hypoplasia" -"HP:0007200","Episodic hypersomnia" -"HP:0007083","Hyperactive patellar reflex" -"HP:0025536","V-sign" -"HP:0001757","High-frequency sensorineural hearing impairment" -"HP:0031335","Abnormal cardiomyocyte mitochondrial morphology" -"HP:0008504","Moderate sensorineural hearing impairment" -"HP:0011474","Childhood onset sensorineural hearing impairment" -"HP:0010497","Sirenomelia" -"HP:0008309","Medium chain dicarboxylic aciduria" -"HP:0006576","Hepatic vascular malformations" -"HP:0030296","Metaphyseal chondromatosis of radius" -"HP:0005147","Bidirectional ventricular ectopy" -"HP:0004309","Ventricular preexcitation" -"HP:0025493","Palmoplantar erythema" -"HP:0031333","Myocardial sarcomeric disarray" -"HP:0030250","Pulmonary granulomatosis" -"HP:0031338","Abnormal cardiomyocyte plakoglobin staining" -"HP:0006558","Decreased mitochondrial complex III activity in liver tissue" -"HP:0100030","Accessory ectopic thyroid tissue" -"HP:0031358","Vegetative state" -"HP:0031320","Cardiomyocyte mitochondrial proliferation" -"HP:0040113","Old-aged sensorineural hearing impairment" -"HP:0005338","Sparse lateral eyebrow" -"HP:0030529","Ring scotoma" -"HP:0007722","Retinal pigment epithelial atrophy" -"HP:0011544","L-looping of the right ventricle" -"HP:0009767","Aplasia/Hypoplasia of the phalanges of the hand" -"HP:0008625","Severe sensorineural hearing impairment" -"HP:0002002","Deep philtrum" -"HP:0004214","Curved phalanges of the 5th finger" -"HP:0012536","Maternal anticardiolipin antibody positive" -"HP:0011535","Abnormal atrial arrangement" -"HP:0030609","Photoreceptor layer loss on macular OCT" -"HP:0007187","Focal lissencephaly" -"HP:0011302","Long palm" -"HP:0004592","Thoracic platyspondyly" -"HP:0100629","Midline facial cleft" -"HP:0025066","Decreased mean corpuscular volume" -"HP:0011507","Macular flecks" -"HP:0007494","Discrete 2 to 5-mm hyper- and hypopigmented macules" -"HP:0010326","Deviation of the 2nd toe" -"HP:0005274","Prominent nasal tip" -"HP:0011613","Interrupted aortic arch type B" -"HP:0006670","Impaired myocardial contractility" -"HP:0008587","Mild neurosensory hearing impairment" -"HP:0003186","Inverted nipples" -"HP:0031332","Cardiomyocyte degeneration" -"HP:0031334","Cardiomyocyte inclusion bodies" -"HP:0031088","Vaginal dryness" -"HP:0031339","Abnormal cadiomyocyte dystrophin staining" -"HP:0011853","Serous pericardial effusion" -"HP:0025419","Pulmonary pneumatocele" -"HP:0007737","Bone spicule pigmentation of the retina" -"HP:0000694","Shell teeth" -"HP:0031571","Paramedian facial cleft" -"HP:0010173","Aplasia/Hypoplasia of the phalanges of the toes" -"HP:0011333","Asymmetric crying face" -"HP:0008615","Adult onset sensorineural hearing impairment" -"HP:0040323","Erythema of the eyelids" -"HP:0001964","Aplasia/Hypoplasia of metatarsal bones" -"HP:0011505","Cystoid macular edema" -"HP:0100015","Stahl ear" -"HP:0001967","Diffuse mesangial sclerosis" -"HP:0031275","Distributive shock" -"HP:0006521","Pulmonary lymphangiectasia" -"HP:0003867","Humeral cortical irregularity" -"HP:0008030","Retinal arteritis" -"HP:0003841","Fragmented epiphyses of the upper limbs" -"HP:0010767","Sacrococcygeal pilonidal abnormality" -"HP:0008046","Abnormality of the retinal vasculature" -"HP:0025491","Venous stenosis" -"HP:0002876","Episodic tachypnea" -"HP:0005852","Limited elbow extension and supination" -"HP:0010773","Partial anomalous pulmonary venous return" -"HP:0009204","Bracket epiphysis of the middle phalanx of the 5th finger" -"HP:0002256","Small bowel diverticula" -"HP:0011874","Heparin-induced thrombocytopenia" -"HP:0012709","Abnormal brain choline/creatine ratio by MRS" -"HP:0012721","Venous malformation" -"HP:0031302","Lower extremity peripheral arterial calcification" -"HP:0400000","Tall chin" -"HP:0030071","Medulloepithelioma" -"HP:0012039","Descemet Membrane Folds" -"HP:0025049","Abnormal brain creatine level by MRS" -"HP:0001076","Glabellar hemangioma" -"HP:0031274","Hypovolemic shock" -"HP:0003852","Normal density transverse bands in metaphyses of the upper limbs" -"HP:0007734","Enlarged lacrimal glands" -"HP:0005688","Dysplastic distal thumb phalanges with a central hole" -"HP:0007146","Bilateral basal ganglia lesions" -"HP:0011174","Hyperkinetic seizures" -"HP:0030393","Endolymphatic sac tumor" -"HP:0011019","Abnormality of chromosome condensation" -"HP:0100083","Ivory epiphyses of the 5th toe" -"HP:0009050","Quadriceps muscle atrophy" -"HP:0007250","Recurrent external ophthalmoplegia" -"HP:0009988","Duplication of the distal phalanx of the 5th finger" -"HP:0009535","Aplasia of the 2nd finger" -"HP:0200063","Colorectal polyposis" -"HP:0002991","Abnormality of fibula morphology" -"HP:0001300","Parkinsonism" -"HP:0030266","Abnormality of the sacroiliac notch" -"HP:0006366","Adductor longus contractures" -"HP:0100022","Abnormality of movement" -"HP:0031353","Otitis media with effusion" -"HP:0007179","Absent smooth pursuit" -"HP:0000835","Adrenal hypoplasia" -"HP:0000020","Urinary incontinence" -"HP:0001608","Abnormality of the voice" -"HP:0011837","Partial IgA deficiency" -"HP:0003560","Muscular dystrophy" -"HP:0009381","Short finger" -"HP:0030638","Congenital stationary night blindness with normal fundus" -"HP:0100050","Ivory epiphyses of the 2nd toe" -"HP:0009019","Progressive loss of facial adipose tissue" -"HP:0004376","Neuroblastic tumors" -"HP:0006267","Large placenta" -"HP:0001336","Myoclonus" -"HP:0008826","Dislocation of the femoral head" -"HP:0012379","Abnormal enzyme/coenzyme activity" -"HP:0012396","Biliary dyskinesia" -"HP:0006830","Severe neonatal hypotonia in males" -"HP:0012696","Abnormal thalamic MRI signal intensity" -"HP:0008784","Wide capital femoral epiphyses" -"HP:0011497","Iris neovascularization" -"HP:0012213","Decreased glomerular filtration rate" -"HP:3000059","Abnormal inferior thyroid vein morphology" -"HP:0031161","Reduced brain glutamate level by MRS" -"HP:0100348","Contracture of the proximal interphalangeal joint of the 2nd toe" -"HP:0007112","Temporal cortical atrophy" -"HP:0031276","Obstructive shock" -"HP:0001272","Cerebellar atrophy" -"HP:0003894","Delayed humeral epiphyseal ossification" -"HP:0002642","Arteriovenous fistulas of celiac and mesenteric vessels" -"HP:0001789","Hydrops fetalis" -"HP:0025047","Abnormal brain choline level by MRS" -"HP:0006326","Buried teeth encased in mucopolysaccharide" -"HP:0012104","Parietal cortical atrophy" -"HP:0011518","Dichromacy" -"HP:0004052","Delayed ossification of the hand bones" -"HP:0011265","Cleft earlobe" -"HP:0011078","Abnormality of canine" -"HP:0040228","Decreased level of plasminogen" -"HP:0003113","Hypochloremia" -"HP:0003068","Madelung-like forearm deformities" -"HP:0012185","Constrictive median neuropathy" -"HP:0005767","1-2 toe complete cutaneous syndactyly" -"HP:0010508","Metatarsus valgus" -"HP:0002340","Caudate atrophy" -"HP:0005607","Abnormality of the tracheobronchial system" -"HP:0030679","Ash-leaf spot" -"HP:0009591","Abnormality of the vestibulocochlear nerve" -"HP:0030825","Absent foveal reflex" -"HP:0004695","Calcaneal epiphyseal stippling" -"HP:0011396","Abnormality of the cochlear nerve" -"HP:0031108","Triceps weakness" -"HP:0006207","Partial fusion of carpals" -"HP:0040313","Oligoarthritis" -"HP:0011476","Profound sensorineural hearing impairment" -"HP:0010827","Abnormality of the seventh cranial nerve" -"HP:3000047","Abnormality of glossopharyngeal nerve" -"HP:0030075","Ductal carcinoma in situ" -"HP:0030735","Ureterovesical junction obstruction" -"HP:0011443","Abnormality of coordination" -"HP:0009103","Aplasia/Hypoplasia involving the pelvis" -"HP:0001293","Cranial nerve compression" -"HP:0031117","Purely bicuspid aortic valve" -"HP:0040311","Symetrical distal arthritis" -"HP:0005694","Partial fusion of proximal row of carpal bones" -"HP:0007097","Cranial nerve motor loss" -"HP:0007007","Cavitation of the basal ganglia" -"HP:0006926","Metachromatic leukodystrophy variant" -"HP:0012099","Abnormality of circulating catecholamine level" -"HP:3000055","Abnormality of inferior alveolar nerve" -"HP:0011348","Abnormality of the sixth cranial nerve" -"HP:0011392","Abnormality of the vestibular nerve" -"HP:0012488","Intraventricular arachnoid cyst" -"HP:0010824","Abnormality of the fifth cranial nerve" -"HP:0003278","Square pelvis bone" -"HP:0012489","Suprasellar arachnoid cyst" -"HP:0012871","Varicocele" -"HP:0010809","Broad uvula" -"HP:0003277","Constricted iliac wings" -"HP:0030218","Punding" -"HP:0002561","Absent nipple" -"HP:0031601","P pulmonale" -"HP:0012487","Cerebellopontine angle arachnoid cyst" -"HP:0001062","Atypical nevus" -"HP:3000075","Abnormality of lingual nerve" -"HP:0009279","Radial deviation of the 4th finger" -"HP:0003848","Cupped metaphyses of the upper limbs" -"HP:0031118","Single raphe bicuspid aortic valve" -"HP:0031598","Notched P wave" -"HP:3000048","Abnormality of great auricular nerve" -"HP:0011059","Localized periodontitis" -"HP:0006237","Prominent interphalangeal joints" -"HP:0008153","Periodic hypokalemic paresis" -"HP:0008073","Low maternal serum estriol" -"HP:0009798","Euthyroid goiter" -"HP:0040232","Delayed onset bleeding" -"HP:0011973","Paroxysmal lethargy" -"HP:0012726","Episodic hypokalemia" -"HP:0008762","Repetitive compulsive behavior" -"HP:0012518","Abnormal circle of Willis morphology" -"HP:0008655","Aplasia/Hypoplasia of the fallopian tube" -"HP:0008251","Congenital goiter" -"HP:0011833","Overhanging nasal tip" -"HP:0005769","Fifth finger distal phalanx clinodactyly" -"HP:0031600","P wave inversion" -"HP:0008249","Thyroid hyperplasia" -"HP:0007668","Impaired pursuit initiation and maintenance" -"HP:0100352","Contracture of the distal interphalangeal joint of the 2nd toe" -"HP:0000586","Shallow orbits" -"HP:0002478","Progressive spastic quadriplegia" -"HP:0010825","Abnormality of the eleventh cranial nerve" -"HP:0000091","Abnormality of the renal tubule" -"HP:0031145","Starry sky appearance on hepatic sonography" -"HP:0100709","Reduction of oligodendroglia" -"HP:0000502","Abnormality of the conjunctiva" -"HP:0004846","Prolonged bleeding after surgery" -"HP:0010100","Complete duplication of hallux phalanx" -"HP:0003217","Hyperglutaminemia" -"HP:0007560","Unusual dermatoglyphics" -"HP:0004037","Abnormality of the ulnar epiphyses" -"HP:0012145","Abnormality of multiple cell lineages in the bone marrow" -"HP:0002707","Palate telangiectasia" -"HP:0012109","Angle closure glaucoma" -"HP:0031324","Myocardial multinucleated giant cells" -"HP:0030665","Rubral tremor" -"HP:0000525","Abnormality of the iris" -"HP:0008226","Androgen insufficiency" -"HP:0012026","Hyperornithinemia" -"HP:0012143","Abnormality of cells of the megakaryocyte lineage" -"HP:0031190","Superficial dermal perivascular inflammatory infiltrate" -"HP:0007727","Opacification of the corneal epithelium" -"HP:0005359","Aplasia of the thymus" -"HP:0009849","Symphalangism of middle phalanx of finger" -"HP:0040020","Radial deviation of the 5th finger" -"HP:0031089","Palatal edema" -"HP:0011488","Abnormality of corneal endothelium" -"HP:0100040","Broad 2nd toe" -"HP:0001802","Absent toenail" -"HP:0012130","Abnormality of cells of the erythroid lineage" -"HP:0003086","Acromesomelia" -"HP:0010839","Increased urinary copper concentration" -"HP:0030448","Soft tissue sarcoma" -"HP:0012135","Abnormality of cells of the granulocytic lineage" -"HP:0005297","Premature occlusive vascular stenosis" -"HP:0011418","Abnormal insertion of umbilical cord" -"HP:0007473","Crusting erythematous dermatitis" -"HP:0031292","Cutaneous abscess" -"HP:0008080","Hallux varus" -"HP:0007035","Anterior encephalocele" -"HP:0007872","Choroidal hemangioma" -"HP:0012394","Iodine contrast allergy" -"HP:0005011","Mesomelic arm shortening" -"HP:0012364","Decreased urinary potassium" -"HP:0011887","Choroid hemorrhage" -"HP:0001088","Brushfield spots" -"HP:0005867","Fused fourth and fifth metacarpals" -"HP:0008198","Congenital hypoparathyroidism" -"HP:0012148","Multiple lineage myelodysplasia" -"HP:0009536","Short 2nd finger" -"HP:0003083","Dislocated radial head" -"HP:0002545","Patchy demyelination of subcortical white matter" -"HP:0012629","Phacodonesis" -"HP:0007030","Nonprogressive encephalopathy" -"HP:0007504","Diffuse slow skin atrophy" -"HP:0011775","Thyroid macrofollicular adenoma" -"HP:0012195","Irregular respiration" -"HP:0031017","Swiss cheese atrial septal defect" -"HP:0031648","Penetrating aortic ulcer" -"HP:0012254","Ewing's sarcoma" -"HP:0012150","Single lineage myelodysplasia" -"HP:0009462","Radial deviation of the 3rd finger" -"HP:0012140","Abnormality of cells of the lymphoid lineage" -"HP:0011121","Abnormality of skin morphology" -"HP:0003348","Hyperalaninemia" -"HP:0000996","Facial capillary hemangioma" -"HP:0031649","Aortic rupture" -"HP:0011567","Sinus venosus atrial septal defect" -"HP:0006462","Generalized bone demineralization" -"HP:0005021","Bilateral elbow dislocations" -"HP:0012395","Seasonal allergy" -"HP:0002708","Prominent median palatal raphe" -"HP:0007774","Hypoplasia of the ciliary body" -"HP:0010291","Prominent palatine ridges" -"HP:0011036","Abnormality of renal excretion" -"HP:0001912","Abnormality of basophils" -"HP:0100789","Torus palatinus" -"HP:0030018","Decreased female libido" -"HP:0008808","High iliac wings" -"HP:0040021","Radial deviation of the thumb" -"HP:0100577","Urinary bladder inflammation" -"HP:0003204","Intracellular accumulation of autofluorescent lipopigment storage material" -"HP:0001234","Hitchhiker thumb" -"HP:0012577","Thin glomerular basement membrane" -"HP:0009237","Short 5th finger" -"HP:0030332","obsolete Abnormal T cell morphology" -"HP:0025084","Folliculitis" -"HP:0005756","Neonatal epiphyseal stippling" -"HP:0030083","Salt craving" -"HP:0012129","Abnormality of bone marrow stromal cells" -"HP:0011357","Abnormality of hair density" -"HP:0012326","Abnormal celiac artery morphology" -"HP:0008720","Primary testicular failure" -"HP:0031526","Subretinal fluid" -"HP:0000133","Gonadal dysgenesis" -"HP:0006850","Hypoplasia of the ventral pons" -"HP:0007262","Symmetric peripheral demyelination" -"HP:0000896","Rib exostoses" -"HP:0001090","Large eyes" -"HP:0000887","Cupped ribs" -"HP:0008003","Jerky ocular pursuit movements" -"HP:0006894","Hypoplastic olfactory lobes" -"HP:0003375","Narrow greater sacrosciatic notches" -"HP:0005215","Frequent Giardia lamblia infestation" -"HP:0007369","Atrophy/Degeneration affecting the cerebrum" -"HP:0009113","Diaphragmatic weakness" -"HP:0010054","Abnormality of the first metatarsal bone" -"HP:0010290","Short hard palate" -"HP:0011701","Multifocal atrial tachycardia" -"HP:0006817","Aplasia/Hypoplasia of the cerebellar vermis" -"HP:0007728","Congenital miosis" -"HP:0005506","Chronic myelogenous leukemia" -"HP:0005891","Progressive forearm bowing" -"HP:0030079","Cervix cancer" -"HP:0011910","Shortening of all phalanges of fingers" -"HP:0008271","Abnormal cartilage collagen" -"HP:0002891","Uterine leiomyosarcoma" -"HP:0008058","Aplasia/Hypoplasia of the optic nerve" -"HP:0025108","Angioma serpentinum" -"HP:0012687","Agenesis of pineal gland" -"HP:0012477","Vocal tremor" -"HP:0009932","Single naris" -"HP:0004524","Temporal hypotrichosis" -"HP:0012513","Upper limb pain" -"HP:0000300","Oval face" -"HP:0008843","Hip osteoarthritis" -"HP:0031296","Atrial septal hypertrophy" -"HP:0006881","Diffuse peripheral demyelination" -"HP:0001702","Abnormality of the tricuspid valve" -"HP:0004276","Exostoses of hand bones" -"HP:0030031","Small toe" -"HP:0010891","Morbus Scheuermann" -"HP:0002392","EEG with polyspike wave complexes" -"HP:0004742","Abnormality of the renal collecting system" -"HP:0012110","Hypoplasia of the pons" -"HP:0008776","Abnormal renal artery morphology" -"HP:0007364","Aplasia/Hypoplasia of the cerebrum" -"HP:0100778","Cryoglobulinemia" -"HP:0010654","Aplasia of the falx cerebri" -"HP:0025105","Nevus anemicus" -"HP:0003960","Exostoses of the forearm bones" -"HP:0006292","Abnormality of dental eruption" -"HP:0011339","Abnormality of upper lip vermillion" -"HP:0011640","Single coronary artery origin" -"HP:0004220","Short middle phalanx of the 5th finger" -"HP:0012429","Aplasia/Hypoplasia of the cerebral white matter" -"HP:0012287","Hypothalamic luteinizing hormone-releasing hormone deficiency" -"HP:0005084","Anterior radial head dislocation" -"HP:0100745","Abnormality of the humeroulnar joint" -"HP:0030176","Asymmetric peripheral demyelination" -"HP:0011962","Obstructive azoospermia" -"HP:0011571","Parachute mitral valve" -"HP:0011000","Aplasia/Hypoplasia of the optic tract" -"HP:0031226","Perinephric fluid collection" -"HP:0012813","Unilateral breast hypoplasia" -"HP:0012575","Abnormality of the nephron" -"HP:0004945","Extracranial internal carotid artery dissection" -"HP:0000158","Macroglossia" -"HP:0000943","Dysostosis multiplex" -"HP:0000816","Abnormality of Krebs cycle metabolism" -"HP:0030499","Macular drusen" -"HP:0009748","Large earlobe" -"HP:0100538","Abnormality of the supraorbital ridges" -"HP:0011035","Abnormality of renal cortex morphology" -"HP:0004746","Glomerular subendothelial electron-dense deposits" -"HP:0009660","Short phalanx of the thumb" -"HP:0006915","Inability to walk by childhood/adolescence" -"HP:0010489","Absent palmar crease" -"HP:0003276","Pelvic bone exostoses" -"HP:0012401","Abnormal urine alpha-ketoglutarate concentration" -"HP:0025541","Decreased activity of complement receptor" -"HP:0002217","Slow-growing hair" -"HP:0003426","First dorsal interossei muscle atrophy" -"HP:0009162","Absent middle phalanx of 5th finger" -"HP:0030195","Fatigable weakness of swallowing muscles" -"HP:0031378","Abnormal lymphocyte proliferation" -"HP:0006709","Aplasia/Hypoplasia of the nipples" -"HP:0006045","Short pointed phalanges" -"HP:0007363","Aplasia/Hypoplasia of the pyramidal tract" -"HP:0012087","Abnormal mitochondrial shape" -"HP:0008828","Delayed proximal femoral epiphyseal ossification" -"HP:0004557","Anterior vertebral fusion" -"HP:0002869","Flared iliac wings" -"HP:0002084","Encephalocele" -"HP:0002762","Multiple exostoses" -"HP:0031025","Gastric leiomyosarcoma" -"HP:0011757","Posterior pituitary hypoplasia" -"HP:0004459","Exostosis of the external auditory canal" -"HP:0006934","Congenital nystagmus" -"HP:0012784","Perinephritis" -"HP:0007362","Aplasia/Hypoplasia of the brainstem" -"HP:0012864","Abnormal sperm morphology" -"HP:0005066","Cone-shaped epiphyses fused within their metaphyses" -"HP:0001136","Retinal arteriolar tortuosity" -"HP:0007946","Unilateral narrow palpebral fissure" -"HP:0025063","Scaphoid abdomen" -"HP:0005335","Sleepy facial expression" -"HP:0030717","Meconium peritonitis" -"HP:0007608","Abnormal palmar dermal ridges" -"HP:0003462","Elevated 8-dehydrocholesterol" -"HP:0008339","Diaminoaciduria" -"HP:0200006","Slanting of the palpebral fissure" -"HP:0007710","Peripheral vitreous opacities" -"HP:0025114","Hypergranulosis" -"HP:0006859","Posterior leukoencephalopathy" -"HP:0010569","Elevated 7-dehydrocholesterol" -"HP:0009909","Uplifted earlobe" -"HP:0008273","Transient aminoaciduria" -"HP:0030009","Cervical insufficiency" -"HP:0012068","Aspartylglucosaminuria" -"HP:0011532","Subretinal exudate" -"HP:0040242","Muscle haemorrhage" -"HP:0011308","Slender toe" -"HP:0003296","Hyperthreoninuria" -"HP:0001069","Episodic hyperhidrosis" -"HP:0012175","Resistance to activated protein C" -"HP:0010995","Abnormality of dicarboxylic acid metabolism" -"HP:0011322","Right unilambdoid synostosis" -"HP:0003978","Fractured radius" -"HP:0007537","Severe photosensitivity" -"HP:0012530","Abnormal number of dense granules" -"HP:0011355","Localized skin lesion" -"HP:0003687","Centrally nucleated skeletal muscle fibers" -"HP:0006313","Widely spaced primary teeth" -"HP:0011389","Functional abnormality of the inner ear" -"HP:0010689","Mirror image polydactyly" -"HP:0006994","Diffuse leukoencephalopathy" -"HP:0010334","Polydactyly affecting the 3rd toe" -"HP:0003361","Tryptophanuria" -"HP:0009458","Aplasia of the proximal phalanx of the 3rd finger" -"HP:0040073","Abnormal morphology of forearm bone" -"HP:0007971","Lamellar cataract" -"HP:0030513","Difficulty adjusting from light to dark" -"HP:0010979","Abnormality of the level of lipoprotein cholesterol" -"HP:0030781","Increased circulating free fatty acid level" -"HP:0011925","Decreased activity of mitochondrial ATP synthase complex" -"HP:0009134","Osteolysis involving bones of the feet" -"HP:0008336","Complex organic aciduria" -"HP:0500010","Increased cholesterol esters" -"HP:0007616","Nevus flammeus nuchae" -"HP:0008335","Renal aminoaciduria" -"HP:0025583","Tapetal-like fundal reflex" -"HP:0005623","Absent ossification of calvaria" -"HP:0040211","Abnormality of the skin of the palm" -"HP:0012806","Proboscis" -"HP:0008353","Neutral hyperaminoaciduria" -"HP:0010998","Increased susceptibility to spontaneous sister chromatid exchange" -"HP:0006384","Club-shaped distal femur" -"HP:0100795","Abnormally straight spine" -"HP:0025011","Pyriform aperture stenosis" -"HP:0003465","Elevated 8(9)-cholestenol" -"HP:0011237","Broad inferior crus of antihelix" -"HP:0200007","Abnormal size of the palpebral fissures" -"HP:0005292","Intimal thickening in the coronary arteries" -"HP:0000661","Palpebral fissure narrowing on adduction" -"HP:0011321","Left unilambdoid synostosis" -"HP:0004394","Multiple gastric polyps" -"HP:0011958","Retinal perforation" -"HP:0000574","Thick eyebrow" -"HP:0007992","Lattice retinal degeneration" -"HP:0040091","Asymmetry of the size of ears" -"HP:0030777","Modic type II vertebral endplate changes" -"HP:0200134","Epileptic encephalopathy" -"HP:0007829","Diffuse retinal cone degeneration" -"HP:0010820","Dacrystic seizures" -"HP:0010570","Low maternal serum alpha-fetoprotein" -"HP:0006381","Rudimentary fibula" -"HP:0004755","Supraventricular tachycardia" -"HP:0011435","Low maternal serum PAPP-A" -"HP:0004478","Ethmoidal encephalocele" -"HP:0002188","Delayed CNS myelination" -"HP:0006147","Progressive fusion 2nd-5th pip joints" -"HP:0012205","Globozoospermia" -"HP:0011557","Double inlet to single ventricle of indeterminate morphology" -"HP:0001738","Exocrine pancreatic insufficiency" -"HP:0008163","Decreased circulating cortisol level" -"HP:0100732","Pancreatic fibrosis" -"HP:0007436","Hair-nail ectodermal dysplasia" -"HP:0031355","Maintenance insomnia" -"HP:0007529","Hidrotic ectodermal dysplasia" -"HP:0008462","Cervical instability" -"HP:0007769","Peripheral retinal degeneration" -"HP:0006692","Short chordae tendineae of the tricuspid valve" -"HP:0010484","Hypertrophy of the upper limb" -"HP:0410006","Abnormality of ophthalmic artery" -"HP:0011555","Double inlet left ventricle" -"HP:0100025","Overfriendliness" -"HP:0003982","Aplasia of the ulna" -"HP:0003397","Generalized hypotonia due to defect at the neuromuscular junction" -"HP:0006280","Chronic pancreatitis" -"HP:0007239","Congenital encephalopathy" -"HP:0001992","Organic aciduria" -"HP:0003224","Increased cellular sensitivity to UV light" -"HP:0008020","Progressive cone degeneration" -"HP:0000992","Cutaneous photosensitivity" -"HP:0011432","High maternal serum alpha-fetoprotein" -"HP:0010018","Enlarged epiphysis of the 1st metacarpal" -"HP:0007814","Retinal pigment epithelial mottling" -"HP:0001943","Hypoglycemia" -"HP:0009887","Abnormality of hair pigmentation" -"HP:0009485","Radial deviation of the hand or of fingers of the hand" -"HP:0003359","Decreased urinary sulfate" -"HP:0011556","Double inlet right ventricle" -"HP:0002149","Hyperuricemia" -"HP:0011434","Low maternal serum chorionic gonadotropin" -"HP:0012167","Hair-pulling" -"HP:0200094","Frontal open bite" -"HP:0009878","Cerebellar ataxia associated with quadrupedal gait" -"HP:0011924","Decreased activity of mitochondrial complex III" -"HP:0100547","Abnormality of forebrain morphology" -"HP:0030978","Decreased CSF/serum albumin ratio" -"HP:0031354","Sleep onset Insomnia" -"HP:0006006","Hypotrophy of the small hand muscles" -"HP:0031006","Acroparesthesia" -"HP:0010949","Abnormality of umbilical vein blood flow" -"HP:0031154","Beaded vitreous appearance" -"HP:0002919","Ketonuria" -"HP:0010696","Polar cataract" -"HP:0011908","Unilateral radial aplasia" -"HP:0002046","Heat intolerance" -"HP:0004018","Flared radial metaphysis" -"HP:0009600","Flexion contracture of thumb" -"HP:0008278","Cerebellar cortical atrophy" -"HP:0008318","Elevated leukocyte alkaline phosphatase" -"HP:0000817","Poor eye contact" -"HP:0005213","Pancreatic calcification" -"HP:0006446","Dysplastic patella" -"HP:0031530","Multifocal subretinal deposits" -"HP:0010947","Abnormality of ductus venosus blood flow" -"HP:0007667","Cystic retinal degeneration" -"HP:0010968","Abnormality of liposaccharide metabolism" -"HP:0001817","Absent fingernail" -"HP:0011680","Single ventricle of indeterminate morphology" -"HP:0001977","Abnormal thrombosis" -"HP:0012035","Steatocystoma multiplex" -"HP:0030247","Splanchnic vein thrombosis" -"HP:0004977","Bilateral radial aplasia" -"HP:0030785","Mediastinal cystic lymphangioma" -"HP:0200020","Corneal erosion" -"HP:0031529","Focal subretinal deposits" -"HP:0004930","Abnormality of the pulmonary vasculature" -"HP:0100700","Abnormality of the arachnoid mater" -"HP:0006358","Shovel-shaped maxillary central incisors" -"HP:0000180","Lobulated tongue" -"HP:0000185","Cleft soft palate" -"HP:0008223","Compensated hypothyroidism" -"HP:0001965","Abnormality of the scalp" -"HP:0002629","Gastrointestinal arteriovenous malformation" -"HP:0000765","Abnormality of the thorax" -"HP:0011828","Midline sinus of philtrum" -"HP:0003762","Uterus didelphys" -"HP:0011827","Malaligned philtral ridges" -"HP:0500012","Abnormality of gonadotropin-releasing hormone level" -"HP:0031803","Fundus hemorrhage" -"HP:0010479","Patent urachus" -"HP:0410059","Increased level of D-threitol in urine" -"HP:0008301","Dermatan sulfate excretion in urine" -"HP:0005542","Prolonged whole-blood clotting time" -"HP:0008423","Spinal dysplasia" -"HP:0011820","Membranous choanal atresia" -"HP:0031046","Absent soft palate" -"HP:0030418","Vulvar melanoma" -"HP:0001848","Calcaneovalgus deformity" -"HP:0010749","Blepharochalasis" -"HP:0025198","Inflammatory cap polyp" -"HP:0012081","Enlarged cerebellum" -"HP:0025385","Diet-resistant subcutaneous adipose tissue below waist" -"HP:0011926","Proximal placement of hallux" -"HP:0100746","Macrodactyly of finger" -"HP:0000172","Abnormality of the uvula" -"HP:0006711","Aplasia/Hypoplasia involving bones of the thorax" -"HP:0011181","Low voltage EEG" -"HP:0002494","Abnormal rapid eye movement sleep" -"HP:0012094","Abnormal pancreas size" -"HP:0006965","Acute necrotizing encephalopathy" -"HP:0000528","Anophthalmia" -"HP:0007265","Absent mesencephalon" -"HP:0001128","Trichiasis" -"HP:0100335","Non-midline cleft lip" -"HP:0009121","Abnormal axial skeleton morphology" -"HP:0030531","Altitudinal visual field defect" -"HP:0100765","Abnormality of the tonsils" -"HP:0007549","Desquamation of skin soon after birth" -"HP:0001048","Cavernous hemangioma" -"HP:0030986","Biliary epithelial hyperplasia" -"HP:0001646","Abnormality of the aortic valve" -"HP:0008753","Aplasia of the epiglottis" -"HP:0030870","Abnormality of spinal facet joint" -"HP:0008186","Adrenocortical cytomegaly" -"HP:0011983","Brown pigment gallstones" -"HP:0007036","Hypoplasia of olfactory tract" -"HP:0011826","Philtrum with midline raphe" -"HP:0010987","Abnormality of cellular immune system" -"HP:0002723","Absence of bactericidal oxidative 'respiratory burst' in phagocytes" -"HP:0031603","Impaired nasal mucociliary clearance" -"HP:0100707","Abnormality of the astrocytes" -"HP:0005425","Recurrent sinopulmonary infections" -"HP:0430014","Abnormality of musculature of soft palate" -"HP:0031245","Productive cough" -"HP:0011579","Unbalanced atrioventricular canal defect" -"HP:0012568","Lower eyelid edema" -"HP:0007935","Juvenile posterior subcapsular lenticular opacities" -"HP:0030883","Femoroacetabular Impingement" -"HP:0001540","Diastasis recti" -"HP:0011268","Absent tragus" -"HP:0001196","Short umbilical cord" -"HP:0000356","Abnormality of the outer ear" -"HP:0011829","Narrow philtrum" -"HP:0001829","Foot polydactyly" -"HP:0012538","Gluten intolerance" -"HP:0100711","Abnormality of the thoracic spine" -"HP:0004941","Extrahepatic portal hypertension" -"HP:0007730","Iris hypopigmentation" -"HP:0004437","Cranial hyperostosis" -"HP:0030326","Abnormal macrophage count" -"HP:0008442","Vertebral hyperostosis" -"HP:0010779","Large pelvis bone" -"HP:0030731","Carcinoma" -"HP:0040224","Abnormality of fibrinolysis" -"HP:0008338","Partial functional complement factor D deficiency" -"HP:0030501","Macular crystals" -"HP:0012801","Narrow jaw" -"HP:0025007","Ectopic fovea" -"HP:0025407","Rectourethral fistula" -"HP:0000804","Xanthine nephrolithiasis" -"HP:0010105","Short first metatarsal" -"HP:0006803","Vivid hallucinations" -"HP:3000078","Abnormality of mandible coronoid process" -"HP:0012802","Broad jaw" -"HP:0010872","T-wave inversion" -"HP:0009940","Asymmetry of the mandible" -"HP:0010753","Midline defect of mandible" -"HP:3000077","Abnormality of mandible condylar process" -"HP:0012191","B-cell lymphoma" -"HP:0012156","Hemophagocytosis" -"HP:0040263","Jaw ankylosis" -"HP:0009100","Thick anterior alveolar ridges" -"HP:0030325","Cervicomedullary schisis" -"HP:0010996","Abnormality of monocarboxylic acid metabolism" -"HP:0011360","Acquired abnormal hair pattern" -"HP:0030914","Abnormal peristalsis" -"HP:0030948","Elevated gamma-glutamyltransferase activity" -"HP:0100579","Mucosal telangiectasiae" -"HP:0000558","Rieger anomaly" -"HP:0004388","Microcolon" -"HP:0002006","Facial cleft" -"HP:0001133","Constriction of peripheral visual field" -"HP:0004401","Meconium ileus" -"HP:0012664","Reduced ejection fraction" -"HP:0000407","Sensorineural hearing impairment" -"HP:0007875","Congenital blindness" -"HP:0002193","Pseudobulbar behavioral symptoms" -"HP:0002058","Myopathic facies" -"HP:0012809","Narrow nasal base" -"HP:0100543","Cognitive impairment" -"HP:0001684","Secundum atrial septal defect" -"HP:0005232","Pancreatic dysplasia" -"HP:0010917","Abnormality of tyrosine metabolism" -"HP:0002835","Aspiration" -"HP:0000926","Platyspondyly" -"HP:0011331","Hemifacial atrophy" -"HP:0001339","Lissencephaly" -"HP:0012554","Absent thumbnail" -"HP:0001284","Areflexia" -"HP:0004188","Abnormality of the 4th finger" -"HP:0000772","Abnormality of the ribs" -"HP:0002574","Episodic abdominal pain" -"HP:0005180","Tricuspid regurgitation" -"HP:0025160","Abnormal temper tantrums" -"HP:0004439","Craniofacial dysostosis" -"HP:0000485","Megalocornea" -"HP:0005918","Abnormality of phalanx of finger" -"HP:0001006","Hypotrichosis" -"HP:0012747","Abnormal brainstem MRI signal intensity" -"HP:0000706","Unerupted tooth" -"HP:0030892","Deep cerebral white matter hyperdensities" -"HP:0200039","Pustule" -"HP:0005280","Depressed nasal bridge" -"HP:0006353","Hypoplasia of the tooth germ" -"HP:0000311","Round face" -"HP:0003468","Abnormal vertebral morphology" -"HP:0009467","Radial deviation of the 2nd finger" -"HP:0004434","C8 deficiency" -"HP:0005203","Spontaneous esophageal perforation" -"HP:0012043","Pendular nystagmus" -"HP:0001263","Global developmental delay" -"HP:0030057","Autoimmune antibody positivity" -"HP:0012648","Decreased inflammatory response" -"HP:0002323","Anencephaly" -"HP:0003527","Hyperprostaglandinuria" -"HP:0008347","Decreased activity of mitochondrial complex IV" -"HP:0010849","EEG with spike-wave complexes (>3.5 Hz)" -"HP:0011146","Dialeptic seizures" -"HP:0002578","Gastroparesis" -"HP:0007633","Bilateral microphthalmos" -"HP:0006535","Recurrent intrapulmonary hemorrhage" -"HP:0100257","Ectrodactyly" -"HP:0045006","Aplasia of lymphatic vessels" -"HP:0006963","0" -"HP:0009045","Exercise-induced rhabdomyolysis" -"HP:0008499","High-grade hypermetropia" -"HP:3000007","Abnormality of mentalis muscle" -"HP:0000509","Conjunctivitis" -"HP:0001885","Short 2nd toe" -"HP:0011684","Non-restrictive ventricular septal defect" -"HP:0004969","Peripheral pulmonary artery stenosis" -"HP:0031003","Polyneuritis" -"HP:0030515","Moderate visual impairment" -"HP:0100576","Amaurosis fugax" -"HP:0002056","Abnormality of the glabella" -"HP:0030016","Dyspareunia" -"HP:0030199","Fatigable weakness of neck muscles" -"HP:0009720","Adenoma sebaceum" -"HP:0004370","Abnormality of temperature regulation" -"HP:0007607","Hypohidrotic ectodermal dysplasia" -"HP:0003856","Upper limb metaphyseal widening" -"HP:0005322","Prominent nasal septum" -"HP:0012817","Noncompaction cardiomyopathy" -"HP:0001107","Ocular albinism" -"HP:0011681","Subarterial ventricular septal defect" -"HP:0005988","Congenital muscular torticollis" -"HP:0009549","Curved phalanges of the 2nd finger" -"HP:0001010","Hypopigmentation of the skin" -"HP:0010721","Abnormal hair whorl" -"HP:0012499","Descending aortic dissection" -"HP:0030283","Partial absence of the septum pellucidum" -"HP:0004850","Recurrent deep vein thrombosis" -"HP:0012369","Abnormality of malar bones" -"HP:0007758","Congenital visual impairment" -"HP:0002724","Recurrent Aspergillus infections" -"HP:0031732","Increased basal tear production" -"HP:0006417","Broad femoral metaphyses" -"HP:0000466","Limited neck range of motion" -"HP:0100572","Fibrous cardiac diverticulum" -"HP:0030450","Neuroplasm of the autonomic nervous system" -"HP:0001810","Dystrophic toenail" -"HP:0010752","Cleft mandible" -"HP:0550003","Proximal scleroderma" -"HP:0006644","Thoracic dysplasia" -"HP:0006688","Paroxysmal tachycardia" -"HP:0005243","Partial abdominal muscle agenesis" -"HP:0008229","Thyroid lymphangiectasia" -"HP:0004409","Hyposmia" -"HP:0006687","Aortic tortuosity" -"HP:0010962","Extralobar sequestration" -"HP:0012479","Temporomandibular joint crepitus" -"HP:0002414","Spina bifida" -"HP:0002644","Abnormality of pelvic girdle bone morphology" -"HP:0010975","Abnormality of B cell number" -"HP:0011824","Chin with H-shaped crease" -"HP:0011665","Takotsubo cardiomyopathy" -"HP:0006187","Fusion of midphalangeal joints" -"HP:0000716","Depressivity" -"HP:0025233","Sleep paralysis" -"HP:0011255","Absent crus of helix" -"HP:0100959","Dense metaphyseal bands" -"HP:0000833","Glucose intolerance" -"HP:0003309","Ovoid thoracolumbar vertebrae" -"HP:0011399","Tibialis atrophy" -"HP:0000134","Female hypogonadism" -"HP:0010316","Ebstein's anomaly of the tricuspid valve" -"HP:0002990","Fibular aplasia" -"HP:0001946","Ketosis" -"HP:0011714","Libman-Sacks lesions" -"HP:0003542","Increased serum pyruvate" -"HP:0001161","Hand polydactyly" -"HP:0430007","Symblepharon" -"HP:0011742","Ectopic adrenal gland" -"HP:0011832","Narrow nasal tip" -"HP:0001315","Reduced tendon reflexes" -"HP:0011747","Abnormality of the anterior pituitary" -"HP:0005311","Agenesis of pulmonary vessels" -"HP:0006921","Axial muscle stiffness" -"HP:0001709","Third degree atrioventricular block" -"HP:0004779","Brittle scalp hair" -"HP:0000104","Renal agenesis" -"HP:0007676","Hypoplasia of the iris" -"HP:0000690","Agenesis of maxillary lateral incisor" -"HP:0000391","Thickened helices" -"HP:0002766","Relatively short spine" -"HP:0008554","Cochlear malformation" -"HP:0001899","Increased hematocrit" -"HP:0011645","Dilatation of the sinus of Valsalva" -"HP:0005416","Decreased serum complement factor B" -"HP:0001332","Dystonia" -"HP:0007289","Limb fasciculations" -"HP:0001042","High axial triradius" -"HP:0100269","Paramedian lip pit" -"HP:0010311","Aplasia/Hypoplasia of the breasts" -"HP:0001695","Cardiac arrest" -"HP:0010833","Spontaneous pain sensation" -"HP:0007446","Palmoplantar blistering" -"HP:0030810","Abnormal tongue physiology" -"HP:0001061","Acne" -"HP:0003810","Late-onset distal muscle weakness" -"HP:0011106","Hypovolemia" -"HP:0003109","Hyperphosphaturia" -"HP:0200059","Metastatic angiosarcoma" -"HP:0000237","Small anterior fontanelle" -"HP:0006160","Irregular metacarpals" -"HP:0030151","Cholangitis" -"HP:0000859","Hyperaldosteronism" -"HP:0010471","Oligosacchariduria" -"HP:0004112","Midline nasal groove" -"HP:0001547","Abnormality of the rib cage" -"HP:0008639","Gonadal hypoplasia" -"HP:0007880","Marginal corneal dystrophy" -"HP:0001238","Slender finger" -"HP:0040266","Proximal upper limb muscle hypertrophy" -"HP:0001941","Acidosis" -"HP:0025500","Class II obesity" -"HP:0002300","Mutism" -"HP:0008483","Cervical vertebral bodies with decreased anteroposterior diameter" -"HP:0012405","Hypocitraturia" -"HP:0002140","Ischemic stroke" -"HP:0012092","Abnormality of exocrine pancreas physiology" -"HP:0009832","Abnormality of the distal phalanx of finger" -"HP:0410073","Increased level of ribose in CSF" -"HP:0004934","Vascular calcification" -"HP:0012752","Focal T2 hypointense basal ganglia lesion" -"HP:0007649","Congenital hypertrophy of retinal pigment epithelium" -"HP:0008265","Mitochondrial lysine transport defect" -"HP:0003110","Abnormality of urine homeostasis" -"HP:0004306","Abnormality of the endocardium" -"HP:0031388","Megakaryocyte nucleus hyperlobulation" -"HP:0011713","Left bundle branch block" -"HP:0010158","Stippling of the epiphysis of the 1st metatarsal" -"HP:0040194","Increased head circumference" -"HP:0003457","EMG abnormality" -"HP:0002652","Skeletal dysplasia" -"HP:0006682","Ventricular extrasystoles" -"HP:0010284","Intra-oral hyperpigmentation" -"HP:0031731","Increased tear production" -"HP:0000752","Hyperactivity" -"HP:0009319","Joint contracture of the 3rd finger" -"HP:0009356","Triangular epiphysis of the proximal phalanx of the 3rd finger" -"HP:0001799","Short nail" -"HP:0011581","Double outlet left ventricle" -"HP:0001951","Episodic ammonia intoxication" -"HP:0000727","Frontal lobe dementia" -"HP:0002648","Abnormality of calvarial morphology" -"HP:0002847","Impaired memory B-cell generation" -"HP:0005537","Decreased mean platelet volume" -"HP:0007156","Asymmetric limb muscle stiffness" -"HP:0005107","Abnormality of the sacrum" -"HP:0010585","Small epiphyses" -"HP:0011522","Protanopia" -"HP:0011650","Bilateral ductus arteriosus" -"HP:0000564","Lacrimal duct atresia" -"HP:0000218","High palate" -"HP:0000358","Posteriorly rotated ears" -"HP:0003312","Abnormal form of the vertebral bodies" -"HP:0001663","Ventricular fibrillation" -"HP:0002150","Hypercalciuria" -"HP:0005486","Small fontanelle" -"HP:0000468","Increased adipose tissue around the neck" -"HP:0005397","Exaggerated cellular immune processes" -"HP:0007029","Cerebral berry aneurysm" -"HP:0008817","Aplastic pubic bones" -"HP:0011168","Eyelid myoclonias" -"HP:0002848","Specific anti-polysaccharide antibody deficiency" -"HP:0004756","Ventricular tachycardia" -"HP:0000891","Cervical ribs" -"HP:0010509","Aplasia of the tarsal bones" -"HP:0000882","Hypoplastic scapulae" -"HP:0001727","Thromboembolic stroke" -"HP:3000021","Abnormality of buccal fat pad" -"HP:0002654","Multiple epiphyseal dysplasia" -"HP:0001873","Thrombocytopenia" -"HP:0009838","Curved distal phalanges of the hand" -"HP:0004872","Incisional hernia" -"HP:0007818","Central heterochromia" -"HP:0012650","Perisylvian polymicrogyria" -"HP:0100806","Sepsis" -"HP:0002740","Recurrent E. coli infections" -"HP:0000447","Pear-shaped nose" -"HP:0100568","Neoplasm of the endocrine system" -"HP:0001733","Pancreatitis" -"HP:0008944","Distal lower limb amyotrophy" -"HP:0007886","Absent extraocular muscles" -"HP:0001119","Keratoglobus" -"HP:0001561","Polyhydramnios" -"HP:0005617","Bilateral camptodactyly" -"HP:0002842","Recurrent Burkholderia cepacia infections" -"HP:0002742","Recurrent Klebsiella infections" -"HP:0000028","Cryptorchidism" -"HP:0009471","Contracture of the proximal interphalangeal joint of the 3rd finger" -"HP:0005225","Intestinal edema" -"HP:0000021","Megacystis" -"HP:0002491","Spasticity of facial muscles" -"HP:0025235","Non-rapid eye movement parasomnia" -"HP:0004053","Dysharmonic maturation of the hand bones" -"HP:0000114","Proximal tubulopathy" -"HP:0012521","Optic nerve aplasia" -"HP:0008955","Progressive distal muscular atrophy" -"HP:0005879","Congenital finger flexion contractures" -"HP:0002254","Intermittent diarrhea" -"HP:0007149","Distal upper limb amyotrophy" -"HP:0006961","Jerky head movements" -"HP:0002695","Symmetrical, oval parietal bone defects" -"HP:0002580","Volvulus" -"HP:0012232","Shortened QT interval" -"HP:0005376","Recurrent Haemophilus influenzae infections" -"HP:0100518","Dysuria" -"HP:0000460","Narrow nose" -"HP:0008438","Vertebral arch anomaly" -"HP:0010318","Aplasia/Hypoplasia of the abdominal wall musculature" -"HP:0008967","Exercise-induced muscle stiffness" -"HP:0002454","Eye of the tiger anomaly of globus pallidus" -"HP:0010287","Abnormality of the submandibular glands" -"HP:0002037","Inflammation of the large intestine" -"HP:0009688","Cone-shaped epiphysis of the thumb" -"HP:0009185","Contracture of the proximal interphalangeal joint of the 5th finger" -"HP:0030897","Decreased intestinal transit time" -"HP:0001216","Delayed ossification of carpal bones" -"HP:0025201","Abnormal apolipoprotein level" -"HP:0000319","Smooth philtrum" -"HP:0009469","Contracture of the distal interphalangeal joint of the 3rd finger" -"HP:0031522","Cervical clear cell adenocarcinoma" -"HP:0001215","Camptodactyly of 2nd-5th fingers" -"HP:0011194","EEG with series of focal spikes" -"HP:0009538","Contracture of the distal interphalangeal joint of the 2nd finger" -"HP:0009216","Cone-shaped epiphysis of the middle phalanx of the 4th finger" -"HP:0004861","Refractory macrocytic anemia" -"HP:0001642","Pulmonic stenosis" -"HP:0040330","Confluent hyperintensity of cerebral white matter on MRI" -"HP:0006441","Lateral humeral condyle aplasia" -"HP:0012343","Decreased serum ferritin" -"HP:0100790","Hernia" -"HP:0025126","Oral hairy leukoplakia" -"HP:0025017","Capillary fragility" -"HP:0000197","Abnormality of parotid gland" -"HP:0005430","Recurrent Neisserial infections" -"HP:0010748","Ectopic lacrimal punctum" -"HP:0010500","Hyperextensibility of the knee" -"HP:0001999","Abnormal facial shape" -"HP:0009275","Contracture of the distal interphalangeal joint of the 4th finger" -"HP:0009278","Ulnar deviation of the 4th finger" -"HP:0000417","Slender nose" -"HP:0002633","Vasculitis" -"HP:0012147","Reduced quantity of Von Willebrand factor" -"HP:0004962","Thoracic aorta calcification" -"HP:0002018","Nausea" -"HP:0012812","Fullness of paranasal tissue" -"HP:0000337","Broad forehead" -"HP:0002741","Recurrent Serratia marcescens infections" -"HP:0008959","Distal upper limb muscle weakness" -"HP:0002191","Progressive spasticity" -"HP:0007779","Anterior segment of eye aplasia" -"HP:0002028","Chronic diarrhea" -"HP:0010288","Abnormality of the sublingual glands" -"HP:0002401","Stroke-like episode" -"HP:0031281","Sialadenitis" -"HP:0009540","Contracture of the proximal interphalangeal joint of the 2nd finger" -"HP:0012590","Abnormal urine output" -"HP:0012250","ST segment depression" -"HP:0025027","Osteoma cutis" -"HP:0002733","Abnormality of the lymph nodes" -"HP:0100328","Carpometacarpal synostosis" -"HP:0001894","Thrombocytosis" -"HP:0000966","Hypohidrosis" -"HP:0030469","Abnormal dark-adapted electroretinogram" -"HP:0005345","Abnormal vena cava morphology" -"HP:0100285","EMG: impaired neuromuscular transmission" -"HP:0002232","Patchy alopecia" -"HP:0005775","Multiple skeletal anomalies" -"HP:0012483","Abnormal alpha granules" -"HP:0100284","EMG: myotonic discharges" -"HP:0011423","Hyperchloremia" -"HP:0011675","Arrhythmia" -"HP:0030828","Wheezing" -"HP:0006109","Absent phalangeal crease" -"HP:0001700","Myocardial necrosis" -"HP:0100287","EMG: slow motor conduction" -"HP:0012738","Agenesis of canine" -"HP:0001976","Reduced antithrombin III activity" -"HP:0007958","Optic atrophy from cranial nerve compression" -"HP:0003336","Abnormal enchondral ossification" -"HP:0100258","Preaxial polydactyly" -"HP:0007677","Vitelliform-like macular lesions" -"HP:0030006","Single fiber EMG abnormality" -"HP:0100656","Thoracoabdominal wall defect" -"HP:0012885","Fallopian tube duplication" -"HP:0011892","Vitamin K deficiency" -"HP:0010296","Ankyloglossia" -"HP:0011480","Unilateral microphthalmos" -"HP:0002884","Hepatoblastoma" -"HP:0031733","Reflex tearing" -"HP:0012883","Fallopian tube cyst" -"HP:0030710","Lipomeningocele" -"HP:0011590","Double aortic arch" -"HP:0012884","Fallopian tube torsion" -"HP:0030730","Parietal meningocele" -"HP:0002970","Genu varum" -"HP:0010890","Morbus Osgood-Schlatter" -"HP:0011425","Fetal ultrasound soft marker" -"HP:0000662","Nyctalopia" -"HP:0100552","Neoplasm of the tracheobronchial system" -"HP:0007590","Aplasia cutis congenita over posterior parietal area" -"HP:0006379","Proximal tibial hypoplasia" -"HP:0009775","Amniotic constriction ring" -"HP:0030000","EMG: repetitive nerve stimulation abnormality" -"HP:0003528","Elevated calcitonin" -"HP:0003694","Late-onset proximal muscle weakness" -"HP:0011596","Left aortic arch with right descending aorta and right ductus arteriosus" -"HP:0000200","Short lingual frenulum" -"HP:0100035","Phonic tics" -"HP:0100962","Shyness" -"HP:0003090","Hypoplasia of the capital femoral epiphysis" -"HP:0008656","Incomplete male pseudohermaphroditism" -"HP:0009072","Decreased Achilles reflex" -"HP:0011979","Elevated urinary dopamine" -"HP:0011810","Impaired two-point discrimination" -"HP:0011516","Achromatopsia" -"HP:0012480","Abnormality of cerebral veins" -"HP:0002318","Cervical myelopathy" -"HP:0040312","Temporomandibular arthritis" -"HP:0030871","Facet joint arthrosis" -"HP:0006335","Persistence of primary teeth" -"HP:0000307","Pointed chin" -"HP:0006990","Myelin-dependent gliosis" -"HP:0002436","Occipital meningocele" -"HP:0010030","Osteolytic defects of the 1st metacarpal" -"HP:0007596","Painful subcutaneous lipomas" -"HP:0011267","Microtia, third degree" -"HP:0025179","Ground-glass opacification on pulmonary HRCT" -"HP:0009736","Tibial pseudoarthrosis" -"HP:0025004","Hallux rigidus" -"HP:0001770","Toe syndactyly" -"HP:0030729","Frontoethmoidal meningocele" -"HP:0011738","Corticotropin-releasing hormone receptor defect" -"HP:0100283","EMG: continuous motor unit activity at rest" -"HP:0011978","Elevated urinary vanillylmandelic acid" -"HP:0025037","Hypothalamic gliosis" -"HP:0003688","Cytochrome C oxidase-negative muscle fibers" -"HP:0012418","Hypoxemia" -"HP:0008407","Hyperconvex thumb nails" -"HP:0009277","Contracture of the metacarpophalangeal joint of the 4th finger" -"HP:0012417","Hypocapnia" -"HP:0030683","Vaginitis" -"HP:0011329","Abnormality of cranial sutures" -"HP:0000821","Hypothyroidism" -"HP:0000110","Renal dysplasia" -"HP:0002703","Abnormality of skull ossification" -"HP:0025436","Elevated serum 11-deoxycortisol" -"HP:0008953","Pectoralis major hypoplasia" -"HP:0031671","Typical atrial flutter" -"HP:0000252","Microcephaly" -"HP:0009772","Patchy sclerosis of finger phalanx" -"HP:0011171","Simple febrile seizures" -"HP:0200141","Small, conical teeth" -"HP:0003003","Colon cancer" -"HP:0100878","Enlarged uterus" -"HP:0001513","Obesity" -"HP:0000061","Ambiguous genitalia, female" -"HP:0100544","Neoplasm of the heart" -"HP:0001520","Large for gestational age" -"HP:0011638","Anomalous origin of left coronary artery from the pulmonary artery" -"HP:0002311","Incoordination" -"HP:0025502","Overweight" -"HP:0002086","Abnormality of the respiratory system" -"HP:0002190","Choroid plexus cyst" -"HP:0200109","Absent/shortened outer dynein arms" -"HP:0000089","Renal hypoplasia" -"HP:0010098","Complete duplication of the 1st metatarsal" -"HP:0100280","Crohn's disease" -"HP:0000205","Pursed lips" -"HP:0007039","Symmetric lesions of the basal ganglia" -"HP:0000597","Ophthalmoparesis" -"HP:0030241","Hypoplasia of deltoid muscle" -"HP:0012097","Intracranial dermoid cyst" -"HP:0002717","Adrenal overactivity" -"HP:0030680","Abnormality of cardiovascular system morphology" -"HP:0002251","Aganglionic megacolon" -"HP:0011014","Abnormal glucose homeostasis" -"HP:0100855","Triceps hypoplasia" -"HP:0011238","Prominent inferior crus of antihelix" -"HP:0004575","Fusion of midcervical facet joints" -"HP:0000414","Bulbous nose" -"HP:0001257","Spasticity" -"HP:0011326","Anterior plagiocephaly" -"HP:0011580","Short chordae tendineae of the mitral valve" -"HP:0004688","Irregular tarsal bones" -"HP:0000316","Hypertelorism" -"HP:0001790","Nonimmune hydrops fetalis" -"HP:0009830","Peripheral neuropathy" -"HP:0000048","Bifid scrotum" -"HP:0011686","Abnormal coronary artery course" -"HP:0006500","Abnormality of lower limb epiphysis morphology" -"HP:0002459","Dysautonomia" -"HP:0010133","Ivory epiphysis of the proximal phalanx of the hallux" -"HP:0003198","Myopathy" -"HP:0030309","Flared distal fibular metaphysis" -"HP:0004273","Cupped metaphyses of hand bones" -"HP:0004466","Prolonged brainstem auditory evoked potentials" -"HP:0010953","Noncommunicating hydrocephalus" -"HP:0003768","Periodic paralysis" -"HP:0100307","Cerebellar hemisphere hypoplasia" -"HP:0009193","Pseudoepiphyses of the metacarpals" -"HP:0010971","Absence of Lutheran antigen on erythrocytes" -"HP:0000368","Low-set, posteriorly rotated ears" -"HP:0100504","Vitamin B2 deficiency" -"HP:0010347","Aplasia/Hypoplasia of the phalanges of the 2nd toe" -"HP:0010396","Broad proximal phalanx of the 2nd toe" -"HP:0003378","Axonal degeneration/regeneration" -"HP:0003248","Gonadal tissue inappropriate for external genitalia or chromosomal sex" -"HP:0030138","Excessive bleeding from superficial cuts" -"HP:0011246","Underdeveloped superior crus of antihelix" -"HP:0005602","Progressive vitiligo" -"HP:0004785","Malrotation of colon" -"HP:0001460","Aplasia/Hypoplasia involving the skeletal musculature" -"HP:0400002","Extra concha fold" -"HP:0002003","Large forehead" -"HP:0005191","Congenital knee dislocation" -"HP:0009026","Hypoplasia of latissimus dorsi muscle" -"HP:0005134","Absence of the pulmonary valve" -"HP:0030642","Fundus albipunctatus" -"HP:0030975","Pontine tegmental cap" -"HP:0008230","Decreased testosterone in males" -"HP:0100899","Sclerosis of finger phalanx" -"HP:0010049","Short metacarpal" -"HP:0005621","Trapezoidal shaped vertebral bodies" -"HP:0010155","Ivory epiphysis of the 1st metatarsal" -"HP:0100553","Hemihypertrophy of lower limb" -"HP:0100621","Dysgerminoma" -"HP:0006347","Microdontia of primary teeth" -"HP:0011573","Hypoplastic tricuspid valve" -"HP:0000340","Sloping forehead" -"HP:0009635","Synostosis of thumb phalanx" -"HP:0007542","Absent pigmentation of the ventral chest" -"HP:0031071","Abnormal endocrine morphology" -"HP:0002334","Abnormality of the cerebellar vermis" -"HP:0000824","Growth hormone deficiency" -"HP:0003566","Increased serum prostaglandin E2" -"HP:0012562","Premature epimetaphyseal fusion in hand" -"HP:0012667","Regional left ventricular wall motion abnormality" -"HP:0025038","Intratesticular abscess" -"HP:0001805","Thick nail" -"HP:0012029","Abnormality of urine hormone level" -"HP:0006226","Osteoarthritis of the first carpometacarpal joint" -"HP:0002036","Hiatus hernia" -"HP:0001149","Lattice corneal dystrophy" -"HP:0000842","Hyperinsulinemia" -"HP:0001640","Cardiomegaly" -"HP:0006233","Osteoarthritis of the distal interphalangeal joint" -"HP:0005198","Stiff interphalangeal joints" -"HP:0009059","Congenital generalized lipodystrophy" -"HP:0000847","Abnormality of renin-angiotensin system" -"HP:0100800","Aplasia/Hypoplasia of the pancreas" -"HP:0008373","Puberty and gonadal disorders" -"HP:0007697","Hypoplasia of the lower eyelids" -"HP:0012207","Reduced sperm motility" -"HP:0004378","Abnormality of the anus" -"HP:0031072","Abnormal endocrine physiology" -"HP:0040171","Decreased serum testosterone level" -"HP:0000160","Narrow mouth" -"HP:0001763","Pes planus" -"HP:0005135","Abnormal T-wave" -"HP:0012605","Hypernatriuria" -"HP:0002757","Recurrent fractures" -"HP:0002198","Dilated fourth ventricle" -"HP:0005487","Prominent metopic ridge" -"HP:0007006","Dorsal column degeneration" -"HP:0008050","Abnormality of the palpebral fissures" -"HP:0002751","Kyphoscoliosis" -"HP:0007962","Speckled corneal dystrophy" -"HP:0003189","Long nose" -"HP:0012188","Hyperemesis gravidarum" -"HP:0008272","Renal tubular lysine transport defect" -"HP:0012546","Skewed maternal X inactivation" -"HP:0008072","Maternal virilization in pregnancy" -"HP:0008225","Thyroid follicular hyperplasia" -"HP:0005273","Absent nasal septal cartilage" -"HP:0100622","Maternal seizures" -"HP:0004275","Duplication of hand bones" -"HP:0010073","Synostosis involving the 1st metatarsal" -"HP:0030244","Maternal fever in pregnancy" -"HP:0003725","Firm muscles" -"HP:0007016","Corticospinal tract hypoplasia" -"HP:0008354","Factor X activation deficiency" -"HP:0100888","Interdigital loops" -"HP:0011984","Atretic gallbladder" -"HP:0031437","Pregnancy exposure" -"HP:0012434","Delayed social development" -"HP:0009484","Deviation of the hand or of fingers of the hand" -"HP:0003393","Thenar muscle atrophy" -"HP:0011502","Posterior lenticonus" -"HP:0004610","Lumbar spinal canal stenosis" -"HP:0009800","Maternal diabetes" -"HP:0100033","Tics" -"HP:0006390","Anterior tibial bowing" -"HP:0010239","Aplasia of the middle phalanx of the hand" -"HP:0003232","Mitochondrial malic enzyme reduced" -"HP:0006978","Dysmyelinating leukodystrophy" -"HP:0007098","Paroxysmal choreoathetosis" -"HP:0100743","Neoplasm of the rectum" -"HP:0031456","Ectopic pregnancy" -"HP:0030912","Duplicated clitoris" -"HP:0002068","Neuromuscular dysphagia" -"HP:0030522","Peripheral visual field constriction with >50 degrees central field preserved" -"HP:0008695","Transient nephrotic syndrome" -"HP:0005453","Absent/hypoplastic paranasal sinuses" -"HP:0011437","Maternal autoimmune disease" -"HP:0011901","Dysfibrinogenemia" -"HP:0000206","Glossitis" -"HP:0012619","Multiple bladder diverticula" -"HP:0010281","Cleft lower lip" -"HP:0011400","Abnormal CNS myelination" -"HP:0009901","Crumpled ear" -"HP:0006958","Abnormal auditory evoked potentials" -"HP:0011436","Abnormal maternal serum screening" -"HP:0011512","Hyperpigmentation of the fundus" -"HP:0100610","Maternal hyperphenylalaninemia" -"HP:0006470","Thin long bone diaphyses" -"HP:0100603","Toxemia of pregnancy" -"HP:0005773","Short forearm" -"HP:0008290","Partial complement factor H deficiency" -"HP:0100248","Hemiballismus" -"HP:0030322","Vertebral artery hypoplasia" -"HP:0012225","Oligodontia of primary teeth" -"HP:0100833","Neoplasm of the small intestine" -"HP:0031162","Impaired oropharyngeal swallow response" -"HP:0100486","Symphalangism of the proximal phalanx of the 5th toe with the 5th metatarsal" -"HP:0200151","Cutaneous mastocytosis" -"HP:0010698","Nuclear pulverulent cataract" -"HP:0012764","Orthopnea" -"HP:0040222","Maternal thrombophilia" -"HP:0008489","Spondylolisthesis at L5-S1" -"HP:0200105","Absent fifth toenail" -"HP:0008749","Laryngeal hypoplasia" -"HP:0011677","Tetralogy of Fallot with atrioventricular canal defect" -"HP:0003738","Exercise-induced myalgia" -"HP:0100889","Abnormality of the ductus choledochus" -"HP:0005357","Defective B cell differentiation" -"HP:0008134","Irregular tarsal ossification" -"HP:0011049","Agenesis of primary maxillary lateral incisor" -"HP:0003025","Metaphyseal irregularity" -"HP:0001343","Kernicterus" -"HP:0001822","Hallux valgus" -"HP:0001320","Cerebellar vermis hypoplasia" -"HP:0002162","Low posterior hairline" -"HP:0001008","Accumulation of melanosomes in melanocytes" -"HP:0001631","Atrial septal defect" -"HP:0031596","Abnormal PR segment" -"HP:0003172","Abnormality of the pubic bone" -"HP:0008428","Vertebral clefting" -"HP:0025074","Abnormal QRS complex" -"HP:0100009","Intracranial meningioma" -"HP:0002075","Dysdiadochokinesis" -"HP:0100427","Broad middle phalanx of the 5th toe" -"HP:0001704","Tricuspid valve prolapse" -"HP:0011599","Mesocardia" -"HP:0005692","Joint hyperflexibility" -"HP:0001199","Triphalangeal thumb" -"HP:0001273","Abnormality of the corpus callosum" -"HP:0005025","Hypoplastic distal humeri" -"HP:0000479","Abnormal retinal morphology" -"HP:0100426","Broad middle phalanx of the 4th toe" -"HP:0031595","Abnormal P wave" -"HP:0011947","Respiratory tract infection" -"HP:0012739","Agenesis of the small intestine" -"HP:0000214","Lip telangiectasia" -"HP:0004894","Laryngotracheal stenosis" -"HP:0000527","Long eyelashes" -"HP:0007410","Palmoplantar hyperhidrosis" -"HP:0001950","Respiratory alkalosis" -"HP:0012057","Superficial spreading melanoma" -"HP:0008789","Cone-shaped capital femoral epiphysis" -"HP:0008697","Hypoplasia of the fallopian tube" -"HP:0011848","Abdominal colic" -"HP:0006454","Delayed patellar ossification" -"HP:0009937","Facial hirsutism" -"HP:0100425","Broad middle phalanx of the 3rd toe" -"HP:0010456","Abnormality of the greater sacrosciatic notch" -"HP:0003383","Onion bulb formation" -"HP:0000034","Hydrocele testis" -"HP:0200104","Absent fifth fingernail" -"HP:0004375","Neoplasm of the nervous system" -"HP:0002208","Coarse hair" -"HP:0007325","Generalized dystonia" -"HP:0031294","Hypoplastic right atrium" -"HP:0000490","Deeply set eye" -"HP:0008501","Median cleft lip and palate" -"HP:0002841","Recurrent fungal infections" -"HP:0002089","Pulmonary hypoplasia" -"HP:0012265","Ciliary dyskinesia" -"HP:0010306","Short thorax" -"HP:0006538","Recurrent bronchopulmonary infections" -"HP:0030256","Small intestinal polyposis" -"HP:0011537","Left atrial isomerism" -"HP:0002822","Hyperplasia of the femoral trochanters" -"HP:0011046","Agenesis of primary maxillary central incisor" -"HP:0005210","Hypoplastic colon" -"HP:0012872","Abnormal vas deferens morphology" -"HP:0002803","Congenital contracture" -"HP:0000523","Subcapsular cataract" -"HP:0011891","Post-partum hemorrhage" -"HP:0010630","Abnormality of metatarsal epiphysis" -"HP:0006731","Follicular thyroid carcinoma" -"HP:0010582","Irregular epiphyses" -"HP:0003771","Pulp stones" -"HP:0031547","Abnormal QT interval" -"HP:0001544","Prominent umbilicus" -"HP:0010818","Generalized tonic seizures" -"HP:0010405","Broad middle phalanx of the 2nd toe" -"HP:0005343","Hypoplasia of the bladder" -"HP:0003182","Shallow acetabular fossae" -"HP:0001552","Barrel-shaped chest" -"HP:0003145","Decreased adenosylcobalamin" -"HP:0100002","Pleural mesothelioma" -"HP:0010774","Cor triatriatum" -"HP:0001057","Aplasia cutis congenita" -"HP:0001714","Ventricular hypertrophy" -"HP:0002946","Supernumerary vertebrae" -"HP:0003930","Lytic defects of humeral diaphysis" -"HP:0006744","Adrenocortical carcinoma" -"HP:0025370","Abnormal ossification of the sacrum" -"HP:0006349","Agenesis of permanent teeth" -"HP:0005247","Hypoplasia of the abdominal wall musculature" -"HP:0012531","Pain" -"HP:0040196","Mild microcephaly" -"HP:0004334","Dermal atrophy" -"HP:0006059","Cone-shaped metacarpal epiphyses" -"HP:0012025","Abnormality of ornithine metabolism" -"HP:0008279","Transient hyperlipidemia" -"HP:0000144","Decreased fertility" -"HP:0001355","Megalencephaly" -"HP:0002132","Porencephalic cyst" -"HP:0012224","Circulating immune complexes" -"HP:0012563","Premature epimetaphyseal fusion in foot" -"HP:0000740","Episodic paroxysmal anxiety" -"HP:0012658","Abnormal brain FDG positron emission tomography" -"HP:0003835","Shoulder subluxation" -"HP:0003891","Abnormality of the humeral epiphysis" -"HP:0005709","2-3 toe cutaneous syndactyly" -"HP:0012850","Small intestinal dysmotility" -"HP:0100716","Self-injurious behavior" -"HP:0006190","Radially deviated wrists" -"HP:0003878","Periosteal new bone of humerus" -"HP:0100739","Bulimia" -"HP:0002039","Anorexia" -"HP:0003907","Abnormality of the humeral metaphyses" -"HP:0000837","Increased circulating gonadotropin level" -"HP:0004835","Microspherocytosis" -"HP:0010455","Steep acetabular roof" -"HP:0002681","Deformed sella turcica" -"HP:0006008","Unilateral brachydactyly" -"HP:0025342","Central retinal artery occlusion" -"HP:0007599","Generalized reticulate brown pigmentation" -"HP:0006009","Broad phalanx" -"HP:0002442","Dyscalculia" -"HP:0002159","Heparan sulfate excretion in urine" -"HP:0100753","Schizophrenia" -"HP:0025368","Abnormality of growth plate morphology" -"HP:0009716","Subependymal nodules" -"HP:0007574","Generalized bronze hyperpigmentation" -"HP:0004325","Decreased body weight" -"HP:0008472","Prominent protruding coccyx" -"HP:0012791","Abnormal humeral ossification" -"HP:0012069","Keratan sulfate excretion in urine" -"HP:0006742","Congenital neuroblastoma" -"HP:0004590","Hypoplastic sacrum" -"HP:0025349","Limbal edema" -"HP:0000722","Obsessive-compulsive behavior" -"HP:0500044","Upper eyelid retraction" -"HP:0009920","Nevus of Ota" -"HP:0002981","Abnormality of the calf" -"HP:0000723","Restrictive behavior" -"HP:0006782","Malignant eosinophil proliferation" -"HP:0000734","Disinhibition" -"HP:0002572","Episodic vomiting" -"HP:0006825","Pallor of dorsal columns of the spinal cord" -"HP:0012437","Abnormal gallbladder morphology" -"HP:0031033","Impaired urinary acidification" -"HP:0003160","Abnormal isoelectric focusing of serum transferrin" -"HP:0100710","Impulsivity" -"HP:0003980","Pseudarthrosis of the radius" -"HP:0030514","Difficulty adjusting from dark to light" -"HP:0012070","Chondroitin sulfate excretion in urine" -"HP:0010101","Partial duplication of the phalanges of the hallux" -"HP:0030198","Fatigable weakness of distal limb muscles" -"HP:0012349","Abnormal sialylation of N-linked protein glycosylation" -"HP:0000141","Amenorrhea" -"HP:0031139","Frog-leg posture" -"HP:0002827","Hip dislocation" -"HP:0001560","Abnormality of the amniotic fluid" -"HP:0003126","Low-molecular-weight proteinuria" -"HP:0030391","Spoken Word Recognition Deficit" -"HP:0008433","Reversed usual vertebral column curves" -"HP:0000768","Pectus carinatum" -"HP:0025471","Congenital panfollicular nevus" -"HP:0001440","Metatarsal synostosis" -"HP:0100731","Transverse facial cleft" -"HP:0001934","Persistent bleeding after trauma" -"HP:0025518","Visual gaze preference" -"HP:0003241","External genital hypoplasia" -"HP:0030524","Peripheral visual field constriction with 30-40 degrees central field preserved" -"HP:0025404","Abnormal visual fixation" -"HP:0001660","Truncus arteriosus" -"HP:0006767","Pituitary prolactin cell adenoma" -"HP:0002637","Cerebral ischemia" -"HP:0000121","Nephrocalcinosis" -"HP:0001637","Abnormal myocardium morphology" -"HP:0100814","Blue nevus" -"HP:0100272","Branchial sinus" -"HP:0004467","Preauricular pit" -"HP:0011233","Antihelical shelf" -"HP:0030394","Fallopian tube carcinoma" -"HP:0007517","Palmoplantar cutis laxa" -"HP:0011235","Additional crus of antihelix" -"HP:0004845","Acute monocytic leukemia" -"HP:0006266","Small placenta" -"HP:0010816","Epidermal nevus" -"HP:0004609","Patchy distortion of vertebrae" -"HP:0002871","Central apnea" -"HP:0001151","Impaired horizontal smooth pursuit" -"HP:0100797","Toenail dysplasia" -"HP:0000242","Parietal bossing" -"HP:0030525","Peripheral visual field constriction with 20-30 degrees central field preserved" -"HP:0010684","Low alkaline phosphatase of bone origin" -"HP:0100625","Enlarged thorax" -"HP:0030523","Peripheral visual field constriction with 40-50 degrees central field preserved" -"HP:0009942","Duplication of thumb phalanx" -"HP:0002032","Esophageal atresia" -"HP:0001694","Right-to-left shunt" -"HP:0000027","Azoospermia" -"HP:0003049","Ulnar deviation of the wrist" -"HP:0000309","Abnormality of the midface" -"HP:0011949","Acute infectious pneumonia" -"HP:0000137","Abnormality of the ovary" -"HP:0005386","Recurrent protozoan infections" -"HP:0006095","Wide tufts of distal phalanges" -"HP:0011759","Pituitary gonadotropic cell adenoma" -"HP:0007941","Limited extraocular movements" -"HP:0011342","Mild global developmental delay" -"HP:0006539","Bronchial cartilage hypoplasia" -"HP:0100757","Pancreatoblastoma" -"HP:0005257","Thoracic hypoplasia" -"HP:0011987","Ectopic ossification in muscle tissue" -"HP:0000708","Behavioral abnormality" -"HP:0003458","EMG: myopathic abnormalities" -"HP:0030527","Peripheral visual field constriction with <10 degrees central field preserved" -"HP:0009739","Hypoplasia of the antihelix" -"HP:0001600","Abnormality of the larynx" -"HP:0025511","Nevus sebaceus" -"HP:0005563","Decreased numbers of nephrons" -"HP:0000524","Conjunctival telangiectasia" -"HP:0006747","Ganglioneuroblastoma" -"HP:0000549","Abnormal conjugate eye movement" -"HP:0011762","Pituitary thyrotropic cell adenoma" -"HP:0011761","Pituitary null cell adenoma" -"HP:0011236","Angulated antihelix" -"HP:0002865","Medullary thyroid carcinoma" -"HP:0009177","Proximal/middle symphalangism of 5th finger" -"HP:0002281","Gray matter heterotopias" -"HP:0011674","Cardiac teratoma" -"HP:0100590","Rectal fistula" -"HP:0001761","Pes cavus" -"HP:0001804","Hypoplastic fingernail" -"HP:0011758","Pituitary acidophilic stem cell adenoma" -"HP:0000225","Gingival bleeding" -"HP:0008665","Clitoral hypertrophy" -"HP:0000142","Abnormality of the vagina" -"HP:0012547","Abnormal involuntary eye movements" -"HP:0008770","Obsessive-compulsive trait" -"HP:0008666","Impaired histidine renal tubular absorption" -"HP:0011347","Abnormality of ocular abduction" -"HP:0006829","Severe muscular hypotonia" -"HP:0007748","Irido-fundal coloboma" -"HP:0030682","Left ventricular noncompaction" -"HP:0000421","Epistaxis" -"HP:0011353","Arterial intimal fibrosis" -"HP:0001321","Cerebellar hypoplasia" -"HP:0100898","Connective tissue nevi" -"HP:0000395","Prominent antihelix" -"HP:0005156","Hypoplastic left atrium" -"HP:0009473","Joint contracture of the hand" -"HP:0012258","Abnormal axonemal organization of respiratory motile cilia" -"HP:0007302","Bipolar affective disorder" -"HP:0025186","Marcus Gunn jaw winking synkinesis" -"HP:0002406","Limb dysmetria" -"HP:0004048","Narrow joint spaces of wrist" -"HP:0000845","Growth hormone excess" -"HP:0012309","Cutaneous amyloidosis" -"HP:0002604","Gastrointestinal telangiectasia" -"HP:0005449","Bridged sella turcica" -"HP:0005977","Hypochloremic metabolic alkalosis" -"HP:0010047","Short 5th metacarpal" -"HP:0031180","Erythema migrans" -"HP:0000387","Absent earlobe" -"HP:0008866","Failure to thrive secondary to recurrent infections" -"HP:0006723","Intestinal carcinoid" -"HP:0000542","Impaired ocular adduction" -"HP:0007489","Diffuse telangiectasia" -"HP:0030183","Impaired visually enhanced vestibulo-ocular reflex" -"HP:0410018","Recurrent ear infections" -"HP:0000593","Abnormality of the anterior chamber" -"HP:0003216","Generalized amyloid deposition" -"HP:0002139","Arrhinencephaly" -"HP:0009701","Metacarpal synostosis" -"HP:0001239","Wrist flexion contracture" -"HP:0006780","Parathyroid carcinoma" -"HP:0003799","Marked delay in bone age" -"HP:0008742","Prominent prostate median bar" -"HP:0000526","Aniridia" -"HP:0011003","Severe Myopia" -"HP:0011367","Yellow nails" -"HP:0100787","Prostate neoplasm" -"HP:0030756","Erythrodontia" -"HP:0410000","Abnormality of vomer" -"HP:0005308","Pulmonary artery vasoconstriction" -"HP:0000235","Abnormality of the fontanelles or cranial sutures" -"HP:0030526","Peripheral visual field constriction with 10-20 degrees central field preserved" -"HP:0005437","Recurrent infections in infancy and early childhood" -"HP:0004599","Absent or minimally ossified vertebral bodies" -"HP:0008711","Benign prostatic hyperplasia" -"HP:0009921","Duane anomaly" -"HP:0400001","Chin with vertical crease" -"HP:0031688","Erythroid dysplasia" -"HP:3000029","Abnormality of depressor labii inferioris" -"HP:0000719","Inappropriate behavior" -"HP:0031578","Tessier number 6 facial cleft" -"HP:0030793","Jaw swelling" -"HP:0006988","Alobar holoprosencephaly" -"HP:0003927","Cortical irregularity of humeral diaphysis" -"HP:0008684","Aplasia/hypoplasia of the uterus" -"HP:0010649","Flat nasal alae" -"HP:0006315","Single median maxillary incisor" -"HP:0008767","Self-mutilation of tongue and lips due to involuntary movements" -"HP:0000111","Renal juxtaglomerular cell hypertrophy/hyperplasia" -"HP:0007820","Atretic lacrimal punctum" -"HP:0009596","Aplasia of the proximal phalanx of the 2nd finger" -"HP:0100728","Germ cell neoplasia" -"HP:0031193","Abnormal morphology of right ventricular trabeculae" -"HP:0200123","Chronic hepatitis" -"HP:0010530","Palatal myoclonus" -"HP:0002380","Fasciculations" -"HP:0002507","Semilobar holoprosencephaly" -"HP:0004122","Midline defect of the nose" -"HP:0012082","Cerebellar Purkinje layer atrophy" -"HP:0005207","Gastric hypertrophy" -"HP:0007166","Paroxysmal dyskinesia" -"HP:0003269","Sudanophilic leukodystrophy" -"HP:0040185","Macrothrombocytopenia" -"HP:0008034","Abnormal iris pigmentation" -"HP:0200084","Giant cell hepatitis" -"HP:0000733","Stereotypy" -"HP:0012869","Acephalic spermatozoa" -"HP:0010664","Fusion of the left and right thalami" -"HP:0012323","Sleep myoclonus" -"HP:0025420","Diffuse alveolar hemorrhage" -"HP:0010648","Dermal translucency" -"HP:0006499","Abnormality of femoral epiphysis" -"HP:0025357","Erratic myoclonus" -"HP:0045084","Limb myoclonus" -"HP:0100266","Synostosis of carpals/tarsals" -"HP:0005329","Fixed facial expression" -"HP:0200119","Acute hepatitis" -"HP:0025097","Eyelid myoclonus" -"HP:0002465","Poor speech" -"HP:0010531","Spinal myoclonus" -"HP:0012165","Oligodactyly" -"HP:0031172","Sectoral retinitis pigmentosa" -"HP:0012125","Prostate cancer" -"HP:0030706","Ranula" -"HP:0002305","Athetosis" -"HP:0002457","Abnormal head movements" -"HP:0002169","Clonus" -"HP:0001337","Tremor" -"HP:0031421","Small superior frontal cortex" -"HP:0008167","Very long chain fatty acid accumulation" -"HP:0004474","Persistent open anterior fontanelle" -"HP:0008509","Aged leonine appearance" -"HP:0100265","Synostosis of metacarpals/metatarsals" -"HP:0003492","High urinary gonadotropin level" -"HP:0008035","Retinitis pigmentosa inversa" -"HP:0011964","Intermittent painful muscle spasms" -"HP:0011479","Abnormal lacrimal punctum morphology" -"HP:0006625","Multifocal breast carcinoma" -"HP:0040148","Cortical myoclonus" -"HP:0002072","Chorea" -"HP:0001579","Primary hypercorticolism" -"HP:0005389","Depletion of components of the alternative complement pathway" -"HP:0010722","Asymmetry of the ears" -"HP:0009896","Abnormality of the antitragus" -"HP:0007047","Atrophy of the dentate nucleus" -"HP:0025531","Harlequin phenomenon" -"HP:0030215","Inappropriate crying" -"HP:0005583","Tubular basement membrane disintegration" -"HP:0030023","Quelprud Nodule" -"HP:0009295","Short middle phalanx of the 4th finger" -"HP:0200047","Chondritis of pinna" -"HP:0030022","Question mark ear" -"HP:0004240","Sclerotic foci within carpal bones" -"HP:0011569","Cleft anterior mitral valve leaflet" -"HP:0002050","Macroorchidism, postpubertal" -"HP:0030967","Abnormal pulmonary artery physiology" -"HP:0011129","Bilateral fetal pyelectasis" -"HP:0100837","Atrophodermia vermiculata" -"HP:0011660","Anomalous origin of one pulmonary artery from ascending aorta" -"HP:0008660","Renotubular dysgenesis" -"HP:0100338","Non-midline cleft palate" -"HP:0030677","Mozart ear" -"HP:0011323","Cleft of chin" -"HP:0010712","1-4 toe syndactyly" -"HP:0012372","Abnormal eye morphology" -"HP:0031119","Bicuspid aortic valve with right-left cusp fusion" -"HP:0007987","Progressive visual field defects" -"HP:0000363","Abnormality of earlobe" -"HP:0007802","Granular corneal dystrophy" -"HP:0031121","Bicuspid aortic valve with left-noncoronary cusp fusion" -"HP:0031120","Bicuspid aortic valve with right-noncoronary cusp fusion" -"HP:0040112","Abnormal number of tubercles" -"HP:0001491","Congenital fibrosis of extraocular muscles" -"HP:0010723","Cystic lesions of the pinnae" -"HP:0001986","Hypertonic dehydration" -"HP:0011641","Coronary artery fistula" -"HP:0410031","Submucous cleft of soft and hard palate" -"HP:0030025","Auricular pit" -"HP:0005848","Bifid thumb distal phalanx" -"HP:0031272","Pulmonary arterial atherosclerosis" -"HP:0030021","Auricular tag" -"HP:0011198","EEG with generalized epileptiform discharges" -"HP:0000642","Red-green dyschromatopsia" -"HP:0100891","Bifid xiphoid process" -"HP:0000394","Lop ear" -"HP:0003337","Reduced prothrombin consumption" -"HP:0011252","Cryptotia" -"HP:0002846","Abnormality of B cells" -"HP:0030043","Hip subluxation" -"HP:0008956","Proximal lower limb amyotrophy" -"HP:0005291","Inflammatory arteriopathy" -"HP:0008239","Adrenal medullary hypoplasia" -"HP:0010596","Abnormality of the proximal radial epiphysis" -"HP:0025289","Cervical lymphadenopathy" -"HP:0012300","Ureteral agenesis" -"HP:0000947","Dumbbell-shaped long bone" -"HP:0000501","Glaucoma" -"HP:0008873","Disproportionate short-limb short stature" -"HP:0000484","Hyperopic astigmatism" -"HP:0003281","Increased serum ferritin" -"HP:0031546","Cardiac conduction abnormality" -"HP:0010348","Broad phalanges of the 2nd toe" -"HP:0100380","Aplasia of the distal phalanx of the 5th toe" -"HP:0000815","Hypergonadotropic hypogonadism" -"HP:0003634","Amyoplasia" -"HP:0007432","Intermittent generalized erythematous papular rash" -"HP:0008330","Reduced von Willebrand factor activity" -"HP:0007451","Ipsilateral lack of facial sweating" -"HP:0010186","Broad distal phalanx of the toes" -"HP:0000998","Hypertrichosis" -"HP:0011195","EEG with focal sharp slow waves" -"HP:0011999","Paranoia" -"HP:0009539","Contracture of the metacarpophalangeal joint of the 2nd finger" -"HP:0100801","Pancreatic aplasia" -"HP:0030160","Cervicitis" -"HP:0012312","Monocytopenia" -"HP:0010204","Broad proximal phalanx of toe" -"HP:0003292","Decreased serum leptin" -"HP:0009606","Complete duplication of distal phalanx of the thumb" -"HP:0011723","Congenital malformation of the right heart" -"HP:0003498","Disproportionate short stature" -"HP:0002269","Abnormality of neuronal migration" -"HP:0000204","Cleft upper lip" -"HP:0002937","Hemivertebrae" -"HP:0030860","Abnormal CSF amyloid level" -"HP:0012865","Sperm head anomaly" -"HP:0012873","Absent vas deferens" -"HP:0009005","Weakness of the intrinsic hand muscles" -"HP:0002510","Spastic tetraplegia" -"HP:0010039","Aplasia/Hypoplasia of the 3rd metacarpal" -"HP:0025259","Stiff elbow" -"HP:0002381","Aphasia" -"HP:0005214","Intestinal obstruction" -"HP:0000707","Abnormality of the nervous system" -"HP:0003993","Broad ulna" -"HP:0025260","Stiff wrist" -"HP:0550004","Verruca plana" -"HP:0003279","Coxa magna" -"HP:0002049","Proximal renal tubular acidosis" -"HP:0030728","Meromelia" -"HP:0100503","Vitamin B1 deficiency" -"HP:0040119","Unilateral conductive hearing impairment" -"HP:0031488","Arteriovenous malformation of the lip" -"HP:0100819","Intestinal fistula" -"HP:0030635","Retinal dystrophy with early macular involvement" -"HP:0010167","Irregular epiphyses of the toes" -"HP:0003363","Abdominal situs inversus" -"HP:0012233","Intramuscular hematoma" -"HP:0011877","Increased mean platelet volume" -"HP:0012314","Bouchard's node" -"HP:0025273","Achilles tendonitis" -"HP:0100613","Death in early adulthood" -"HP:0100825","Cheilitis" -"HP:0009301","Short proximal phalanx of the 4th finger" -"HP:0003489","Acute episodes of neuropathic symptoms" -"HP:0001633","Abnormality of the mitral valve" -"HP:0010516","Thymus hyperplasia" -"HP:0031056","Fusiform cerebral aneurysm" -"HP:0031548","Follicular infundibulum tumor" -"HP:0000718","Aggressive behavior" -"HP:0011527","Lentiglobus" -"HP:0001973","Autoimmune thrombocytopenia" -"HP:0011935","Decreased urinary urate" -"HP:0100578","Lipoatrophy" -"HP:0008282","Unconjugated hyperbilirubinemia" -"HP:0000713","Agitation" -"HP:0004910","Bicarbonate-wasting renal tubular acidosis" -"HP:0003881","Humeral sclerosis" -"HP:0012772","Abnormal upper to lower segment ratio" -"HP:0004246","Delayed ossification of the scaphoid" -"HP:0005790","Short mandibular condyles" -"HP:0031738","Mechanical entropion" -"HP:0002923","Rheumatoid factor positive" -"HP:0030216","Inertia" -"HP:0002019","Constipation" -"HP:0011098","Speech apraxia" -"HP:0009785","Triceps aplasia" -"HP:0006903","Congenital peripheral neuropathy" -"HP:0012755","Enlarged brainstem" -"HP:0002463","Language impairment" -"HP:0001493","Falciform retinal fold" -"HP:0002960","Autoimmunity" -"HP:0007642","Congenital stationary night blindness" -"HP:0031286","Perifollicular erythema" -"HP:0012501","Abnormality of the brainstem white matter" -"HP:0001220","Interphalangeal joint contracture of finger" -"HP:0002166","Impaired vibration sensation in the lower limbs" -"HP:0006456","Irregular proximal tibial epiphyses" -"HP:0008607","Progressive conductive hearing impairment" -"HP:0030662","Vitreous inflammatory cells" -"HP:0006165","Proportionate shortening of all digits" -"HP:0025263","Stiff knee" -"HP:0004857","Hyperchromic macrocytic anemia" -"HP:0011946","Bronchiolitis obliterans" -"HP:0030217","Limb apraxia" -"HP:0002021","Pyloric stenosis" -"HP:0001580","Pigmented micronodular adrenocortical disease" -"HP:0002448","Progressive encephalopathy" -"HP:0001446","Abnormality of the musculature of the upper limbs" -"HP:0012716","Moderate conductive hearing impairment" -"HP:0001662","Bradycardia" -"HP:0002630","Fat malabsorption" -"HP:0011900","Hypofibrinogenemia" -"HP:0005661","Salmonella osteomyelitis" -"HP:0030535","Abnormal pinhole visual acuity test" -"HP:0025261","Stiff finger" -"HP:0040111","Bilateral external ear deformity" -"HP:0006846","Acute encephalopathy" -"HP:0009115","Aplasia/hypoplasia involving the skeleton" -"HP:0009413","Enlarged epiphyses of the 3rd finger" -"HP:0100168","Fragmented epiphyses" -"HP:0009742","Stiff shoulders" -"HP:0008242","Pseudohypoaldosteronism" -"HP:0003434","Sensory ataxic neuropathy" -"HP:0000410","Mixed hearing impairment" -"HP:0012181","Entrapment neuropathy" -"HP:0007963","Pattern dystrophy of the retina" -"HP:0003473","Fatigable weakness" -"HP:0003470","Paralysis" -"HP:0008598","Mild conductive hearing impairment" -"HP:0006216","Single interphalangeal crease of fifth finger" -"HP:0007685","Peripheral retinal avascularization" -"HP:0007961","Rarefaction of retinal pigmentation" -"HP:0025265","Stiff toe" -"HP:0010447","Anal fistula" -"HP:0025264","Stiff ankle" -"HP:0001251","Ataxia" -"HP:0005579","Impaired reabsorption of chloride" -"HP:0040055","Short lower eyelashes" -"HP:0040075","Hypopituitarism" -"HP:0025336","Delayed ability to sit" -"HP:0001301","Chronic sensorineural polyneuropathy" -"HP:0005197","Generalized morning stiffness" -"HP:0002027","Abdominal pain" -"HP:0000135","Hypogonadism" -"HP:0006949","Episodic peripheral neuropathy" -"HP:0006865","Sensorimotor polyneuropathy affecting arms more than legs" -"HP:0045039","Osteolysis involving bones of the upper limbs" -"HP:0005895","Radial deviation of thumb terminal phalanx" -"HP:0002378","Hand tremor" -"HP:0100324","Scleroderma" -"HP:0031489","Venous malformation of the lip" -"HP:0010541","Cutis gyrata of scalp" -"HP:0003689","Multiple mitochondrial DNA deletions" -"HP:0025262","Stiff hip" -"HP:0011885","Hemorrhage of the eye" -"HP:0030339","Decreased circulating gonadotropin level" -"HP:0008591","Congenital conductive hearing impairment" -"HP:0006361","Irregular femoral epiphysis" -"HP:0025248","Eruptive vellus hair cyst" -"HP:0010298","Smooth tongue" -"HP:0031605","Abnormality of fundus pigmentation" -"HP:0010873","Cervical spinal cord atrophy" -"HP:0012504","Abnormal size of pituitary gland" -"HP:0001597","Abnormality of the nail" -"HP:0031516","Oocyte arrest at metaphase I" -"HP:0008094","Widely spaced toes" -"HP:0200146","Cystic medial necrosis of the aorta" -"HP:0000350","Small forehead" -"HP:0009754","Fibrous syngnathia" -"HP:0008039","Subepithelial corneal opacities" -"HP:0001717","Coronary artery calcification" -"HP:0003887","Abnormality of the humeral heads" -"HP:0011312","Fused nails" -"HP:0001373","Joint dislocation" -"HP:0007505","Progressive hyperpigmentation" -"HP:0006495","Aplasia/Hypoplasia of the ulna" -"HP:0010322","Abnormality of the 5th toe" -"HP:0030010","Hydrometrocolpos" -"HP:0010965","Abnormality of phytanic acid metabolism" -"HP:0005183","Pericardial lymphangiectasia" -"HP:0007832","Pigmentation of the sclera" -"HP:0009883","Duplication of the distal phalanx of hand" -"HP:0002044","Zollinger-Ellison syndrome" -"HP:0008275","Abnormal light-adapted electroretinogram" -"HP:0007499","Recurrent staphylococcal infections" -"HP:0009128","Aplasia/Hypoplasia involving the musculature of the extremities" -"HP:0005586","Hyperpigmentation in sun-exposed areas" -"HP:0025546","Abnormal mean corpuscular hemoglobin" -"HP:0030976","Abnormal factor VIII activity" -"HP:0001966","Mesangial abnormality" -"HP:0005173","Calcific aortic valve stenosis" -"HP:0007947","Pericentral retinitis pigmentosa" -"HP:0008760","Violent behavior" -"HP:0000364","Hearing abnormality" -"HP:0011724","Uhl's anomaly" -"HP:0004272","Cortical thinning of hand bones" -"HP:0031594","PR segment depression" -"HP:0025272","Melasma" -"HP:0011126","Nephroptosis" -"HP:0008541","Superiorly displaced ears" -"HP:0011905","Reduced hemoglobin A" -"HP:0010289","Cleft of alveolar ridge of maxilla" -"HP:0002332","Lack of peer relationships" -"HP:0001549","Abnormality of the ileum" -"HP:0000860","Parathyroid hypoplasia" -"HP:0011858","Reduced factor IX activity" -"HP:0030419","Bartholin gland carcinoma" -"HP:0010989","Abnormality of the intrinsic pathway" -"HP:0001809","Split nail" -"HP:0005645","Intervertebral disk calcification" -"HP:0005527","Reduced kininogen activity" -"HP:0002831","Long coccyx" -"HP:0006042","Y-shaped metacarpals" -"HP:0031002","Neuritis" -"HP:0005332","Recurrent mandibular subluxations" -"HP:0025250","Closed comedo" -"HP:0100850","Neoplasm of the penis" -"HP:0100593","Calcification of cartilage" -"HP:0005507","Hemoglobin Barts" -"HP:0001014","Angiokeratoma" -"HP:0000372","Abnormality of the auditory canal" -"HP:0031544","Elevated propionylcarnitine level" -"HP:0045047","HbS hemoglobin" -"HP:0002031","Abnormality of esophagus morphology" -"HP:0001131","Corneal dystrophy" -"HP:0025018","Abnormal capillary physiology" -"HP:0011574","Imperforate atrioventricular valve" -"HP:0001724","Aortic dilatation" -"HP:0000725","Psychotic episodes" -"HP:0011501","Anterior lenticonus" -"HP:0011361","Congenital abnormal hair pattern" -"HP:0001575","Mood changes" -"HP:0011052","Agenesis of maxillary premolar" -"HP:0030420","Vulvar adenocarcinoma" -"HP:0008785","Delayed ossification of pubic rami" -"HP:0045075","Sparse eyebrow" -"HP:0002060","Abnormality of the cerebrum" -"HP:0001622","Premature birth" -"HP:0002758","Osteoarthritis" -"HP:0003536","Decreased fumarate hydratase activity" -"HP:0003146","Hypocholesterolemia" -"HP:0040218","Reduced natural killer cell number" -"HP:0009508","Ivory epiphysis of the distal phalanx of the 2nd finger" -"HP:0200122","Atypical or prolonged hepatitis" -"HP:0010345","Flexion contracture of the 5th toe" -"HP:0003739","Myoclonic spasms" -"HP:0007403","Hypertrophy of skin of soles" -"HP:0005982","Reduced phenylalanine hydroxylase activity" -"HP:0000012","Urinary urgency" -"HP:0200072","Episodic quadriplegia" -"HP:0000787","Nephrolithiasis" -"HP:0009327","Ivory epiphysis of the middle phalanx of the 3rd finger" -"HP:0011127","Perioral eczema" -"HP:3000027","Abnormality of buccinator muscle" -"HP:0031038","Spermatogenesis maturation arrest" -"HP:0010212","Flexion contracture of the hallux" -"HP:0000529","Progressive visual loss" -"HP:0100645","Cystocele" -"HP:0010333","Flexion contracture of 3rd toe" -"HP:0002111","Restrictive deficit on pulmonary function testing" -"HP:0003834","Shoulder dislocation" -"HP:0000277","Abnormality of the mandible" -"HP:0000831","Insulin-resistant diabetes mellitus" -"HP:0011258","Tragal bridge of crus of helix" -"HP:0012391","Hyporeflexia of upper limbs" -"HP:0011221","Vertical forehead creases" -"HP:0004431","Complement deficiency" -"HP:0004762","Hypoplasia of right ventricle" -"HP:0012400","Abnormal aldolase level" -"HP:0000738","Hallucinations" -"HP:0008012","Congenital myopia" -"HP:0100058","Enlarged epiphyses of the 3rd toe" -"HP:0031209","Decreased lipoprotein lipase activity" -"HP:0025242","Dot-and-blot retinal hemorrhage" -"HP:0000559","Corneal scarring" -"HP:0009802","Aplasia of the phalanges of the hand" -"HP:0000308","Microretrognathia" -"HP:0004353","Abnormality of pyrimidine metabolism" -"HP:0031221","Abnormal radioactive iodine uptake test result" -"HP:0009734","Optic glioma" -"HP:0003210","Decreased methylmalonyl-CoA mutase activity" -"HP:0004236","Irregular carpal bones" -"HP:0007402","Areas of hypopigmentation and hyperpigmentation that do not follow Blaschko lines" -"HP:0025244","Subretinal pigment epithelium hemorrhage" -"HP:0012360","Decreased fucosylation of O-linked protein glycosylation" -"HP:0010475","Cloacal exstrophy" -"HP:0025433","Decreased lecithin cholesterol acyl transferase activity" -"HP:0000470","Short neck" -"HP:0005900","Fifth metacarpal with ulnar notch" -"HP:0004891","Recurrent infections due to aspiration" -"HP:0200148","Abnormal liver function tests during pregnancy" -"HP:0009670","Ivory epiphysis of the proximal phalanx of the thumb" -"HP:0010543","Opsoclonus" -"HP:0010327","Flexion contracture of the 2nd toe" -"HP:0100856","Poorly ossified vertebrae" -"HP:0001876","Pancytopenia" -"HP:0003836","Stippled calcification of the shoulder" -"HP:0000157","Abnormality of the tongue" -"HP:0009519","Ivory epiphysis of the middle phalanx of the 2nd finger" -"HP:0003240","Increased phosphoribosylpyrophosphate synthetase" -"HP:0000580","Pigmentary retinopathy" -"HP:0005218","Anoperineal fistula" -"HP:0001836","Camptodactyly of toe" -"HP:0009831","Mononeuropathy" -"HP:0008194","Multiple pancreatic beta-cell adenomas" -"HP:0010339","Flexion contracture of the 4th toe" -"HP:0025240","Preretinal hemorrhage" -"HP:0007392","Excessive wrinkled skin" -"HP:0001776","Bilateral talipes equinovarus" -"HP:0040070","Abnormality of upper limb bone" -"HP:0002540","Inability to walk" -"HP:0009530","Ivory epiphysis of the proximal phalanx of the 2nd finger" -"HP:0011072","Rootless teeth" -"HP:0003637","Reduced 4-Hydroxyphenylpyruvate dioxygenase activity" -"HP:0001305","Dandy-Walker malformation" -"HP:0008400","Onycholysis of distal fingernails" -"HP:0001956","Truncal obesity" -"HP:0007708","Absent inner eyelashes" -"HP:0000092","Tubular atrophy" -"HP:0001859","Distal foot symphalangism" -"HP:0000488","Retinopathy" -"HP:0100047","Enlarged epiphyses of the 2nd toe" -"HP:0005910","Rhomboid or triangular shaped 5th finger middle phalanx" -"HP:0007471","Axillary and groin hyperpigmentation and hypopigmentation" -"HP:0100069","Enlarged epiphyses of the 4th toe" -"HP:0025239","Subhyaloid hemorrhage" -"HP:0012792","Absent ossification of thoracic vertebral bodies" -"HP:0008675","Enlarged polycystic ovaries" -"HP:0100551","Neoplasm of the trachea" -"HP:0002904","Hyperbilirubinemia" -"HP:0011611","Interrupted aortic arch" -"HP:0410003","Cleft primary palate" -"HP:0100080","Enlarged epiphyses of the 5th toe" -"HP:0006716","Hereditary nonpolyposis colorectal carcinoma" -"HP:0001193","Ulnar deviation of the hand or of fingers of the hand" -"HP:0040069","Abnormality of lower limb bone" -"HP:0008124","Talipes calcaneovarus" -"HP:0007485","Absence of subcutaneous fat" -"HP:0008392","Subungual hyperkeratosis" -"HP:0004792","Rectoperineal fistula" -"HP:0001627","Abnormal heart morphology" -"HP:0007438","Mottled pigmentation of the trunk and proximal extremities" -"HP:0008166","Decreased beta-galactosidase activity" -"HP:0011998","Postprandial hyperglycemia" -"HP:0004800","Duodenal diverticula" -"HP:0100635","Carotid paraganglioma" -"HP:0000389","Chronic otitis media" -"HP:0000748","Inappropriate laughter" -"HP:0008542","Low-frequency hearing loss" -"HP:0004605","Absent vertebral body mineralization" -"HP:0012361","Increased fucosylation of O-linked protein glycosylation" -"HP:0008678","Renal hypoplasia/aplasia" -"HP:0001882","Leukopenia" -"HP:0002600","Hyporeflexia of lower limbs" -"HP:0025441","Achilles tendon calcification" -"HP:0031473","Hostility" -"HP:0005092","Streaky metaphyseal sclerosis" -"HP:0008740","Longitudinal vaginal septum" -"HP:0000322","Short philtrum" -"HP:0000418","Narrow nasal ridge" -"HP:0010116","Enlarged epiphyses of the hallux" -"HP:0012392","Jaw hyporeflexia" -"HP:0030417","Squamous cell carcinoma of the vulva" -"HP:0011795","Intralobar nephroblastomatosis" -"HP:0030778","Modic type III vertebral endplate changes" -"HP:0030494","Macular microaneurysm/hemorrhage" -"HP:0003249","Genital ulcers" -"HP:0005019","Diaphyseal thickening" -"HP:0008144","Flattening of the talar dome" -"HP:0007495","Prematurely aged appearance" -"HP:0030551","Visual acuity light perception with projection" -"HP:0030881","Shoulder impingement" -"HP:0200058","Angiosarcoma" -"HP:0010514","Hyperpituitarism" -"HP:0025230","Tendonitis" -"HP:0003453","Antineutrophil antibody positivity" -"HP:0031474","Pulmonary chondroma" -"HP:0003076","Glycosuria" -"HP:0004964","Pulmonary arterial medial hypertrophy" -"HP:0030220","Socially inappropriate behavior" -"HP:0025241","Flame-shaped retinal hemorrhage" -"HP:0003707","Calf muscle pseudohypertrophy" -"HP:0007335","Recurrent encephalopathy" -"HP:0002943","Thoracic scoliosis" -"HP:0008768","Inappropriate sexual behavior" -"HP:0003202","Skeletal muscle atrophy" -"HP:0410026","Abnormality of the periodontium" -"HP:0006702","Coronary artery dissection" -"HP:0040309","Increased size of the mandible" -"HP:0000808","Penoscrotal hypospadias" -"HP:0001978","Extramedullary hematopoiesis" -"HP:0002270","Abnormality of the autonomic nervous system" -"HP:0006481","Abnormality of primary teeth" -"HP:0000807","Glandular hypospadias" -"HP:0031492","Epithelial neoplasm" -"HP:0031389","Abnormal MHC II surface expression" -"HP:0009819","Lower limb phocomelia" -"HP:0000347","Micrognathia" -"HP:0000051","Perineal hypospadias" -"HP:0004818","Paroxysmal nocturnal hemoglobinuria" -"HP:0000508","Ptosis" -"HP:0011751","Abnormality of the posterior pituitary" -"HP:0008743","Coronal hypospadias" -"HP:0012352","Abnormal fucosylation of protein N-linked glycosylation" -"HP:0002608","Celiac disease" -"HP:0011076","Abnormality of premolar" -"HP:0012714","Severe hearing impairment" -"HP:0009813","Upper limb phocomelia" -"HP:0000175","Cleft palate" -"HP:0040079","Irregular dentition" -"HP:0000126","Hydronephrosis" -"HP:0009447","Aplasia/Hypoplasia of the phalanges of the 3rd finger" -"HP:0002576","Intussusception" -"HP:0031035","Chronic infection" -"HP:0000602","Ophthalmoplegia" -"HP:0005396","Susceptibility to coronavirus 229e" -"HP:0012170","Nail-biting" -"HP:0000369","Low-set ears" -"HP:0005482","Abnormality of the alternative complement pathway" -"HP:0025124","Fragile teeth" -"HP:0012647","Abnormal inflammatory response" -"HP:0012853","Scrotal hypospadias" -"HP:0000365","Hearing impairment" -"HP:0012718","Morphological abnormality of the gastrointestinal tract" -"HP:0008830","Hypoplastic pubic rami" -"HP:0009900","Unilateral deafness" -"HP:0025231","Abnormality of synovial bursa morphology" -"HP:0009658","Aplasia/Hypoplasia of the phalanges of the thumb" -"HP:0002460","Distal muscle weakness" -"HP:0031487","Capillary malformation of the lip" -"HP:0012712","Mild hearing impairment" -"HP:0011903","Hemoglobin H" -"HP:0012382","Left-to-right shunt" -"HP:0003737","Mitochondrial myopathy" -"HP:0011760","Pituitary growth hormone cell adenoma" -"HP:0000010","Recurrent urinary tract infections" -"HP:0008053","Aplasia/Hypoplasia of the iris" -"HP:0009851","Aplasia/Hypoplasia of the proximal phalanges of the hand" -"HP:0012854","Midshaft hypospadias" -"HP:0011676","Tetralogy of Fallot with absent subarterial conus" -"HP:0012024","Hypergalactosemia" -"HP:0000426","Prominent nasal bridge" -"HP:0004919","Galactose intolerance" -"HP:0006184","Decreased palmar creases" -"HP:0011064","Abnormal number of incisors" -"HP:0000011","Neurogenic bladder" -"HP:0006483","Abnormal number of teeth" -"HP:0004727","Impaired renal concentrating ability" -"HP:0007272","Progressive psychomotor deterioration" -"HP:0200116","Distal ileal atresia" -"HP:0000737","Irritability" -"HP:0031372","Cold paresis" -"HP:0011047","Agenesis of primary mandibular central incisor" -"HP:0006673","Reduced systolic function" -"HP:0005255","Absence of pectoralis minor muscle" -"HP:0031409","Abnormal lymphocyte physiology" -"HP:0100256","Senile plaques" -"HP:0005368","Abnormality of humoral immunity" -"HP:0011968","Feeding difficulties" -"HP:0012713","Moderate hearing impairment" -"HP:0010033","Triangular shaped 1st metacarpal" -"HP:0003200","Ragged-red muscle fibers" -"HP:0011904","Persistence of hemoglobin F" -"HP:0009290","Short distal phalanx of the 4th finger" -"HP:0031385","Megakaryocyte nucleus hypolobulation" -"HP:0003244","Penile hypospadias" -"HP:0001537","Umbilical hernia" -"HP:0012355","Abnormal mannosylation of N-linked protein glycosylation" -"HP:0000676","Abnormality of the incisor" -"HP:0006748","Adrenal pheochromocytoma" -"HP:0004395","Malnutrition" -"HP:0031383","Abnormal lymphocyte surface marker expression" -"HP:0012781","Mid-frequency hearing loss" -"HP:0001939","Abnormality of metabolism/homeostasis" -"HP:0004839","Pyropoikilocytosis" -"HP:0001649","Tachycardia" -"HP:0005102","Cochlear degeneration" -"HP:0002986","Radial bowing" -"HP:0009934","Supernumerary naris" -"HP:0000592","Blue sclerae" -"HP:0011405","Childhood onset short-limb short stature" -"HP:0008516","Abnormality of the vertebral spinous processes" -"HP:0003131","Cystinuria" -"HP:0100858","Dilatation of celiac artery" -"HP:0000055","Abnormality of female external genitalia" -"HP:0001593","Maxillary lateral incisor microdontia" -"HP:0007117","Corticospinal tract atrophy" -"HP:0003417","Coronal cleft vertebrae" -"HP:0031278","Abnormal thoracic duct morphology" -"HP:0003318","Cervical spine hypermobility" -"HP:0005957","Breathing dysregulation" -"HP:0030421","Epididymal neoplasm" -"HP:0007720","Flat cornea" -"HP:0000044","Hypogonadotrophic hypogonadism" -"HP:0030891","Periventricular white matter hyperdensities" -"HP:0000504","Abnormality of vision" -"HP:0006402","Distal shortening of limbs" -"HP:0003022","Hypoplasia of the ulna" -"HP:0001256","Intellectual disability, mild" -"HP:0001241","Capitate-hamate fusion" -"HP:0001386","Joint swelling" -"HP:0012001","EEG with generalized polyspikes" -"HP:0100589","Urogenital fistula" -"HP:0002810","Dumbbell-shaped metaphyses" -"HP:0010948","Abnormality of the fetal cardiovascular system" -"HP:0000096","Glomerulosclerosis" -"HP:0031480","Abnormal mitral valve leaflet morphology" -"HP:0001904","Autoimmune neutropenia" -"HP:0008288","Nonketotic hyperglycinemia" -"HP:0004382","Mitral valve calcification" -"HP:0007459","Generalized anhidrosis" -"HP:0002641","Peripheral thrombosis" -"HP:0040046","Abnormality of the left hemidiaphragm" -"HP:0004981","Prominent styloid process of ulna" -"HP:0005793","Shortening of all distal phalanges of the toes" -"HP:0011568","Double orifice mitral valve" -"HP:0003521","Disproportionate short-trunk short stature" -"HP:0200043","Verrucae" -"HP:0004444","Spherocytosis" -"HP:0003345","Elevated urinary norepinephrine" -"HP:0000127","Renal salt wasting" -"HP:0008419","Intervertebral disc degeneration" -"HP:0005484","Postnatal microcephaly" -"HP:0000750","Delayed speech and language development" -"HP:0006394","Limited pronation/supination of forearm" -"HP:0007384","Aberrant melanosome maturation" -"HP:0001833","Long foot" -"HP:0003614","Trimethylaminuria" -"HP:0010653","Abnormality of the falx cerebri" -"HP:0000698","Conical tooth" -"HP:0008417","Vertebral hypoplasia" -"HP:0005991","Limited neck flexion" -"HP:0003040","Arthropathy" -"HP:0008064","Ichthyosis" -"HP:0004039","Abnormality of ulnar metaphysis" -"HP:0002209","Sparse scalp hair" -"HP:0001654","Abnormality of the heart valves" -"HP:0000341","Narrow forehead" -"HP:0008629","Pulsatile tinnitus" -"HP:0011819","Submucous cleft soft palate" -"HP:0008386","Aplasia/Hypoplasia of the nails" -"HP:0001507","Growth abnormality" -"HP:0000745","Diminished motivation" -"HP:0002355","Difficulty walking" -"HP:0004532","Sacral hypertrichosis" -"HP:0008751","Laryngeal cleft" -"HP:0000366","Abnormality of the nose" -"HP:0000033","Ambiguous genitalia, male" -"HP:0030442","Anal margin squamous cell carcinoma" -"HP:0001924","Sideroblastic anemia" -"HP:0001739","Abnormality of the nasopharynx" -"HP:0025326","Retinal arterial occlusion" -"HP:0000403","Recurrent otitis media" -"HP:0002144","Tethered cord" -"HP:0004380","Aortic valve calcification" -"HP:0002861","Melanoma" -"HP:0006758","Malignant genitourinary tract tumor" -"HP:0005817","Postaxial polysyndactyly of foot" -"HP:0000534","Abnormality of the eyebrow" -"HP:0010638","Elevated alkaline phosphatase of hepatic origin" -"HP:0030197","Fatigable weakness of skeletal muscles" -"HP:0030077","Bronchial neoplasm" -"HP:0009718","Subependymal giant-cell astrocytoma" -"HP:0000616","Miosis" -"HP:0010502","Fibular bowing" -"HP:0010579","Cone-shaped epiphysis" -"HP:0100550","Tendon rupture" -"HP:0030605","Abnormal indocyanine green angiography" -"HP:0011850","Parotitis" -"HP:0025523","Abnormal morphology of the chordae tendinae of the mitral valve" -"HP:0000625","Cleft eyelid" -"HP:0005671","Bilateral intracranial calcifications" -"HP:0005815","Supernumerary ribs" -"HP:0009879","Cortical gyral simplification" -"HP:0012465","Elevated hepatic iron concentration" -"HP:0003191","Cleft ala nasi" -"HP:0200138","Bilateral choanal atresia/stenosis" -"HP:0011107","Recurrent aphthous stomatitis" -"HP:0200037","Skin vesicle" -"HP:0003918","Sclerotic humeral metaphysis" -"HP:0011150","Myoclonic absences" -"HP:0031478","Abnormal mitral valve annulus morphology" -"HP:0006872","Cerebral hypoplasia" -"HP:0004860","Thiamine-responsive megaloblastic anemia" -"HP:0100775","Dural ectasia" -"HP:0002729","Follicular hyperplasia" -"HP:0100261","Abnormal tendon morphology" -"HP:0003388","Easy fatigability" -"HP:0010882","Pulmonary valve atresia" -"HP:0003658","Hypomethioninemia" -"HP:0011232","Infra-orbital fold" -"HP:0011271","Prominent tragus" -"HP:0003117","Abnormality of circulating hormone level" -"HP:0008845","Mesomelic short stature" -"HP:0000548","Cone/cone-rod dystrophy" -"HP:0031479","Dilatation of the mitral annulus" -"HP:0007400","Irregular hyperpigmentation" -"HP:0000773","Short ribs" -"HP:0000064","Hypoplastic labia minora" -"HP:0005466","Hypoplasia of the frontal bone" -"HP:0004315","IgG deficiency" -"HP:0011270","Duplicated tragus" -"HP:0006703","Aplasia/Hypoplasia of the lungs" -"HP:0000150","Gonadoblastoma" -"HP:0100522","Thymoma" -"HP:0030059","Mitochondrial depletion" -"HP:0001328","Specific learning disability" -"HP:0025146","Foveal degeneration" -"HP:0200012","Short corpus callosum" -"HP:0003207","Arterial calcification" -"HP:0007000","Morning myoclonic jerks" -"HP:0012424","Chorioretinitis" -"HP:0008511","Central posterior corneal opacity" -"HP:0001533","Slender build" -"HP:0012198","Juvenile colonic polyposis" -"HP:0007440","Generalized hyperpigmentation" -"HP:0030443","Anal margin basal cell carcinoma" -"HP:0006278","Ectopic pancreatic tissue" -"HP:0012797","Lymphatic vessel neoplasm" -"HP:0009913","Aplasia/Hypoplasia of the tragus" -"HP:0000455","Broad nasal tip" -"HP:0011737","Corticotropin-releasing hormone deficient adrenal insufficiency" -"HP:0100703","Tongue thrusting" -"HP:0200149","CSF lymphocytic pleiocytosis" -"HP:0012098","Edema of the dorsum of feet" -"HP:0006515","Interstitial pneumonitis" -"HP:0000579","Nasolacrimal duct obstruction" -"HP:0004796","Gastrointestinal obstruction" -"HP:0002682","Broad skull" -"HP:0011554","Double inlet atrioventricular connection" -"HP:0000445","Wide nose" -"HP:0011564","Mitral valve arcade" -"HP:0003355","Aminoaciduria" -"HP:0004729","Acute tubulointerstitial nephritis" -"HP:0008872","Feeding difficulties in infancy" -"HP:0002815","Abnormality of the knee" -"HP:0006362","Varus deformity of humeral neck" -"HP:0100370","Aplasia/Hypoplasia of the distal phalanx of the 4th toe" -"HP:0009599","Abnormality of thumb epiphysis" -"HP:0011811","Impaired touch localization" -"HP:0030996","Megaduodenum" -"HP:0001399","Hepatic failure" -"HP:0000250","Dense calvaria" -"HP:0007103","Hypointensity of cerebral white matter on MRI" -"HP:0007428","Telangiectasia of the oral mucosa" -"HP:0031191","Deep dermal perivascular inflammatory infiltrate" -"HP:0008150","Elevated serum transaminases during infections" -"HP:0031179","Nuchal rigidity" -"HP:0009341","Ivory epiphysis of the distal phalanx of the 3rd finger" -"HP:0002090","Pneumonia" -"HP:0005041","Irregular capital femoral epiphysis" -"HP:0030308","Flared distal tibial metaphysis" -"HP:0000695","Natal tooth" -"HP:0100580","Barrett esophagus" -"HP:0030981","Abnormal CSF/serum albumin ratio" -"HP:0003324","Generalized muscle weakness" -"HP:0010413","Aplasia/Hypoplasia of the distal phalanx of the 2nd toe" -"HP:0008997","Proximal muscle weakness in upper limbs" -"HP:0100369","Aplasia/Hypoplasia of the distal phalanx of the 3rd toe" -"HP:0010932","Abnormality of nucleobase metabolism" -"HP:0001387","Joint stiffness" -"HP:0025454","Abnormal CSF metabolite level" -"HP:0005190","Proximal finger joint hyperextensibility" -"HP:0011104","Abnormality of blood volume homeostasis" -"HP:0011034","Amyloidosis" -"HP:0007740","Long eyelashes in irregular rows" -"HP:0006398","Flat distal femoral epiphysis" -"HP:0001082","Cholecystitis" -"HP:0005556","Abnormality of the metopic suture" -"HP:0045007","Abnormality of the substantia nigra" -"HP:0012319","Absent pigmentation of the abdomen" -"HP:0001548","Overgrowth" -"HP:0012321","D-2-hydroxyglutaric aciduria" -"HP:0012444","Brain atrophy" -"HP:0004737","Global glomerulosclerosis" -"HP:0000016","Urinary retention" -"HP:0002566","Intestinal malrotation" -"HP:0200018","Protanomaly" -"HP:0002914","Hyperchloriduria" -"HP:0002625","Deep venous thrombosis" -"HP:0030328","Decreased osteoclast count" -"HP:0031463","Esophageal squamous papilloma" -"HP:0001980","Megaloblastic bone marrow" -"HP:0012283","Small distal femoral epiphysis" -"HP:0025416","Vaginal stricture" -"HP:0011682","Perimembranous ventricular septal defect" -"HP:0005541","Congenital agranulocytosis" -"HP:0002024","Malabsorption" -"HP:0010645","Aplasia of the distal phalanges of the toes" -"HP:0004322","Short stature" -"HP:0100842","Septo-optic dysplasia" -"HP:0001643","Patent ductus arteriosus" -"HP:0007068","Inferior vermis hypoplasia" -"HP:0007964","Degenerative vitreoretinopathy" -"HP:0002731","Decreased lymphocyte apoptosis" -"HP:0100371","Aplasia/Hypoplasia of the distal phalanx of the 5th toe" -"HP:0001081","Cholelithiasis" -"HP:0030998","Cerebrospinal fluid rhinorrhoea" -"HP:0003066","Limited knee extension" -"HP:0001857","Short distal phalanx of toe" -"HP:0001290","Generalized hypotonia" -"HP:0012229","CSF pleocytosis" -"HP:0030171","Perirenal hematoma" -"HP:0025456","Abnormal CSF protein level" -"HP:0003128","Lactic acidosis" -"HP:0010657","Patchy reduction of bone mineral density" -"HP:0009470","Contracture of the metacarpophalangeal joint of the 3rd finger" -"HP:0010076","Aplasia/Hypoplasia of the distal phalanx of the hallux" -"HP:0000599","Abnormality of the frontal hairline" -"HP:0005245","Intestinal hypoplasia" -"HP:0002882","Sudden episodic apnea" -"HP:0004468","Anomalous tracheal cartilage" -"HP:0005792","Short humerus" -"HP:0004313","Decreased antibody level in blood" -"HP:0000692","Misalignment of teeth" -"HP:0010046","Aplasia of the 5th metacarpal" -"HP:0031047","Paraproteinemia" -"HP:0001223","Pointed proximal second through fifth metacarpals" -"HP:0001435","Abnormality of the shoulder girdle musculature" -"HP:0012178","Reduced natural killer cell activity" -"HP:0000776","Congenital diaphragmatic hernia" -"HP:0000826","Precocious puberty" -"HP:0007514","Edema of the dorsum of hands" -"HP:0010040","Aplasia of the 3rd metacarpal" -"HP:0040156","Elevated urinary carboxylic acid" -"HP:0010282","Thin lower lip vermilion" -"HP:0005716","Lethal skeletal dysplasia" -"HP:0002500","Abnormality of the cerebral white matter" -"HP:0012610","Abnormality of urinary uric acid concentration" -"HP:0010528","Prosopagnosia" -"HP:0010179","Symphalangism affecting the phalanges of the toes" -"HP:0040315","Tongue edema" -"HP:0011608","Type II truncus arteriosus" -"HP:0008968","Muscle hypertrophy of the lower extremities" -"HP:0002245","Meckel diverticulum" -"HP:0005106","Abnormality of the vertebral endplates" -"HP:0005565","Reduced renal corticomedullary differentiation" -"HP:0005328","Progeroid facial appearance" -"HP:0002623","Overriding aorta" -"HP:0002570","Steatorrhea" -"HP:0006308","Atrophy of alveolar ridges" -"HP:0012049","Laryngeal dystonia" -"HP:0010527","Astereognosia" -"HP:0040049","Macular edema" -"HP:0200159","Agenesis of primary mandibular lateral incisor" -"HP:0030739","Altman type III sacrococcygeal teratoma" -"HP:0006789","Mitochondrial encephalopathy" -"HP:0000274","Small face" -"HP:0006608","Midclavicular hypoplasia" -"HP:0003394","Muscle cramps" -"HP:0002982","Tibial bowing" -"HP:0000506","Telecanthus" -"HP:0100633","Esophagitis" -"HP:0007105","Infantile encephalopathy" -"HP:0001155","Abnormality of the hand" -"HP:0025081","Darier's sign" -"HP:0000843","Hyperparathyroidism" -"HP:0010035","Aplasia of the 1st metacarpal" -"HP:0011466","Aplasia/Hypoplasia of the gallbladder" -"HP:0011695","Cerebellar hemorrhage" -"HP:0012398","Peripheral edema" -"HP:0001798","Anonychia" -"HP:0007462","Bitot spots of the conjunctiva" -"HP:0008437","Bifid thoracic vertebrae" -"HP:0000944","Abnormality of the metaphysis" -"HP:0002828","Multiple joint contractures" -"HP:0001249","Intellectual disability" -"HP:0000179","Thick lower lip vermilion" -"HP:0002506","Diffuse cerebral atrophy" -"HP:0000076","Vesicoureteral reflux" -"HP:0004968","Recurrent cerebral hemorrhage" -"HP:0005652","Cortical sclerosis" -"HP:0006892","Frontotemporal cerebral atrophy" -"HP:0000601","Hypotelorism" -"HP:0100277","Periauricular skin pits" -"HP:0030485","Abnormal amplitude of pattern electroretinogram" -"HP:0012889","Cervical endometriosis" -"HP:0006329","Alveolar process hypoplasia" -"HP:0007285","Facial palsy secondary to cranial hyperostosis" -"HP:0000463","Anteverted nares" -"HP:0000685","Hypoplasia of teeth" -"HP:0007058","Generalized cerebral atrophy/hypoplasia" -"HP:0030997","Atretic vas deferens" -"HP:0010742","Edema of the upper limbs" -"HP:0009085","Alveolar ridge overgrowth" -"HP:0100598","Pulmonary edema" -"HP:0025040","Thalamic edema" -"HP:0030738","Altman type II sacrococcygeal teratoma" -"HP:0004611","Anterior concavity of thoracic vertebrae" -"HP:0001671","Abnormality of the cardiac septa" -"HP:0010866","Abdominal wall defect" -"HP:0007552","Abnormal subcutaneous fat tissue distribution" -"HP:0002063","Rigidity" -"HP:0000343","Long philtrum" -"HP:0001385","Hip dysplasia" -"HP:0000187","Broad alveolar ridges" -"HP:0002571","Achalasia" -"HP:0030844","Undetectable pattern electroretinogram" -"HP:0010442","Polydactyly" -"HP:0003563","Decreased circulating low-density lipoprotein levels" -"HP:0000687","Widely spaced teeth" -"HP:0030158","Cervical ectropion" -"HP:0000003","Multicystic kidney dysplasia" -"HP:0100519","Anuria" -"HP:0010525","Finger agnosia" -"HP:0001919","Acute kidney injury" -"HP:0009058","Increased muscle lipid content" -"HP:0010533","Spasmus nutans" -"HP:0002595","Ileus" -"HP:0000448","Prominent nose" -"HP:0011177","EEG with 4-5/second background activity" -"HP:0005640","Abnormal vertebral segmentation and fusion" -"HP:0000975","Hyperhidrosis" -"HP:0030222","Visual agnosia" -"HP:0000072","Hydroureter" -"HP:0000689","Dental malocclusion" -"HP:0007924","Slow decrease in visual acuity" -"HP:0100654","Retrobulbar optic neuritis" -"HP:0009092","Progressive alveolar ridge hypertropy" -"HP:0005285","Absent nasal bridge" -"HP:0012606","Renal sodium wasting" -"HP:0002239","Gastrointestinal hemorrhage" -"HP:0002688","Absent frontal sinuses" -"HP:0008773","Aplasia/Hypoplasia of the middle ear" -"HP:0030008","Cervical agenesis" -"HP:0000855","Insulin resistance" -"HP:0001324","Muscle weakness" -"HP:0001942","Metabolic acidosis" -"HP:0010610","Palmar pits" -"HP:0001708","Right ventricular failure" -"HP:0002756","Pathologic fracture" -"HP:0025270","Abnormality of esophagus physiology" -"HP:0008083","2nd-5th toe middle phalangeal hypoplasia" -"HP:0030487","Abnormal P50/N95 ratio of pattern electroretinogram" -"HP:0007609","Hypoproteinemic edema" -"HP:0002936","Distal sensory impairment" -"HP:0100267","Lip pit" -"HP:0004916","Generalized distal tubular acidosis" -"HP:0009084","Midline notch of upper alveolar ridge" -"HP:0031188","Genital edema" -"HP:0004566","Pear-shaped vertebrae" -"HP:0009611","Bifid distal phalanx of the thumb" -"HP:0000430","Underdeveloped nasal alae" -"HP:0100560","Upper limb asymmetry" -"HP:0002586","Peritonitis" -"HP:0001607","Subglottic stenosis" -"HP:0030284","Triangular tongue" -"HP:0011884","Abnormal umbilical stump bleeding" -"HP:0025039","Basal ganglia edema" -"HP:0012724","Upper eyelid edema" -"HP:0004295","Abnormality of the gastric mucosa" -"HP:0011818","Nasofrontal encephalocele" -"HP:0031298","Coronary sinus enlargement" -"HP:0001070","Mottled pigmentation" -"HP:0009791","Bifid sacrum" -"HP:0025147","Beaten bronze macular sheen" -"HP:0004308","Ventricular arrhythmia" -"HP:0001106","Periorbital hyperpigmentation" -"HP:0100724","Hypercoagulability" -"HP:0004341","Abnormality of vitamin B12 metabolism" -"HP:0001638","Cardiomyopathy" -"HP:0005278","Hypoplastic nasal tip" -"HP:0040092","Asymmetry of the shape of the ears" -"HP:0008180","Mildly elevated creatine phosphokinase" -"HP:0003874","Humerus varus" -"HP:0005543","Reduced protein C activity" -"HP:0010499","Patellar subluxation" -"HP:0012142","Pancreatic squamous cell carcinoma" -"HP:0011248","Everted antitragus" -"HP:0012211","Abnormal renal physiology" -"HP:0008496","Multiple rows of eyelashes" -"HP:0040093","Asymmetry of the position of the ears" -"HP:0100676","Vaginal lymphocele" -"HP:0004936","Venous thrombosis" -"HP:0001997","Gout" -"HP:0009717","Cortical tubers" -"HP:0009935","Aplasia/Hypoplasia of the nasal septum" -"HP:0200015","Symmetric great toe depigmentation" -"HP:3000046","Abnormality of geniohyoid muscle" -"HP:0030631","Hyperautofluorescent macular lesion" -"HP:0030530","Arcuate scotoma" -"HP:0012234","Agranulocytosis" -"HP:0009589","Bilateral vestibular Schwannoma" -"HP:0007715","Weak extraocular muscles" -"HP:0008208","Parathyroid hyperplasia" -"HP:0003150","Glutaric aciduria" -"HP:0011263","Forward facing earlobe" -"HP:0100641","Neoplasm of the adrenal cortex" -"HP:0001629","Ventricular septal defect" -"HP:0002235","Pili canaliculi" -"HP:0010593","Abnormality of fibular epiphyses" -"HP:0009056","Loss of subcutaneous adipose tissue from upper limbs" -"HP:0100586","Aseptic leukocyturia" -"HP:0004327","Abnormal vitreous humor morphology" -"HP:0006918","Diffuse cerebral sclerosis" -"HP:0012810","Wide nasal base" -"HP:0011033","Impairment of fructose metabolism" -"HP:0007610","Blotching pigmentation of the skin" -"HP:0000045","Abnormality of the scrotum" -"HP:0001659","Aortic regurgitation" -"HP:0030329","Retinal thinning" -"HP:0002326","Transient ischemic attack" -"HP:0007063","Aplasia of the inferior half of the cerebellar vermis" -"HP:0012132","Erythroid hyperplasia" -"HP:0010815","Nevus sebaceous" -"HP:0011125","Abnormality of dermal melanosomes" -"HP:0011745","Non-secretory adrenocortical adenoma" -"HP:0002837","Recurrent bronchitis" -"HP:0007623","Pigmentation anomalies of sun-exposed skin" -"HP:0001881","Abnormality of leukocytes" -"HP:0007427","Reticulated skin pigmentation" -"HP:0002615","Hypotension" -"HP:0011250","Bifid antitragus" -"HP:0009107","Abnormal ossification involving the femoral head and neck" -"HP:0006589","Flaring of lower rib cage" -"HP:0005587","Profuse pigmented skin lesions" -"HP:0040034","Abnormality of the second metatarsal bone" -"HP:0002170","Intracranial hemorrhage" -"HP:0002045","Hypothermia" -"HP:0012410","Pure red cell aplasia" -"HP:0001644","Dilated cardiomyopathy" -"HP:0007841","Amyloid deposition in the vitreous humor" -"HP:0010940","Aplasia/Hypoplasia of the nasal bone" -"HP:0011780","Thyroid hemiagenesis" -"HP:0000036","Abnormality of the penis" -"HP:0100536","Abnormality of the fascia" -"HP:0045044","Decreased serum complement C4b" -"HP:0030483","Reduced amplitude of dark-adapted bright flash electroretinogram a-wave" -"HP:0007483","Depigmentation/hyperpigmentation of skin" -"HP:0004783","Duodenal polyposis" -"HP:0011934","Dilatation of mesenteric artery" -"HP:0011249","Absent antitragus" -"HP:0005110","Atrial fibrillation" -"HP:0006524","Tracheobronchial leiomyomatosis" -"HP:0005768","2-4 toe cutaneous syndactyly" -"HP:0430017","Abnormality of uvular muscle" -"HP:0007800","Increased axial globe length" -"HP:0100584","Endocarditis" -"HP:0006413","Broad tibial metaphyses" -"HP:0030305","Decreased number of vertebrae" -"HP:0005268","Spontaneous abortion" -"HP:0040227","Decreased level of histidine-rich glycoprotein" -"HP:0012121","Panuveitis" -"HP:0010554","Cutaneous finger syndactyly" -"HP:0010805","Upturned corners of mouth" -"HP:0001401","Intrahepatic biliary dysgenesis" -"HP:0005256","Unilateral absence of pectoralis major muscle" -"HP:0011593","Left aortic arch with retroesophageal diverticulum of Kommerell" -"HP:0004900","Severe lactic acidosis" -"HP:0011523","Iris cyst" -"HP:0040012","Chromosome breakage" -"HP:0011301","Absent foot" -"HP:0011304","Broad thumb" -"HP:0002653","Bone pain" -"HP:0012282","Morbilliform rash" -"HP:0008049","Abnormality of the extraocular muscles" -"HP:0011993","Impaired neutrophil bactericidal activity" -"HP:0030188","Tremor by anatomical site" -"HP:0005275","Cartilaginous ossification of nose" -"HP:0007813","Nongranulomatous uveitis" -"HP:0031483","Reduced contraction of the left ventricular apex" -"HP:0031643","Fusiform ascending tubular aorta aneurysm" -"HP:3000012","Abnormality of palatopharyngeus muscle" -"HP:0005878","Enlarged sagittal diameter of the cervical canal" -"HP:0008736","Hypoplasia of penis" -"HP:0009825","Aplasia involving bones of the extremities" -"HP:0040143","Dystopic os odontoideum" -"HP:0004440","Coronal craniosynostosis" -"HP:0040011","Flat posterior fossa" -"HP:0040173","Abnormality of the tongue muscle" -"HP:0000683","Grayish enamel" -"HP:0005028","Widened proximal tibial metaphyses" -"HP:0009722","Dental enamel pits" -"HP:0012124","Intermediate uveitis" -"HP:0001647","Bicuspid aortic valve" -"HP:0000565","Esotropia" -"HP:0012425","Stercoral ulcer" -"HP:0005897","Severe generalized osteoporosis" -"HP:0000744","Low frustration tolerance" -"HP:0002180","Neurodegeneration" -"HP:0030668","Periorbital dermoid cyst" -"HP:0030270","Elevated red cell adenosine deaminase activity" -"HP:0200049","Upper limb hypertonia" -"HP:0012386","Absent hallux" -"HP:0012003","Affective auras" -"HP:0006035","Cone-shaped epiphyses of phalanges 2 to 5" -"HP:0040325","Bull's eye rash" -"HP:0009615","Complete duplication of the first metacarpal" -"HP:0031532","Focal sub-RPE deposits" -"HP:0011012","Abnormality of polysaccharide metabolism" -"HP:0040324","Heliotrope rash" -"HP:0008605","Unilateral external ear deformity" -"HP:0001933","Subcutaneous hemorrhage" -"HP:0005947","Decreased sensitivity to hypoxemia" -"HP:0025520","Calcinosis cutis" -"HP:0004407","Bony paranasal bossing" -"HP:0006285","Hypomineralization of enamel" -"HP:0009918","Ectopia pupillae" -"HP:0031307","Internal carotid artery calcification" -"HP:0000739","Anxiety" -"HP:0005451","Decreased cranial base ossification" -"HP:0012643","Foveal hypopigmentation" -"HP:0007401","Macular atrophy" -"HP:0100677","Vulval varicose vein" -"HP:0025300","Malar rash" -"HP:0012281","Chylous ascites" -"HP:0011520","Deuteranomaly" -"HP:0000420","Short nasal septum" -"HP:0010564","Bifid epiglottis" -"HP:0008786","Iliac crest serration" -"HP:0100484","Symphalangism of the proximal phalanx of the 3rd toe with the 3rd metatarsal" -"HP:0040030","Chorioretinal hypopigmentation" -"HP:0002792","Reduced vital capacity" -"HP:0008440","C1-C2 vertebral abnormality" -"HP:0100485","Symphalangism of the proximal phalanx of the 4th toe with the 4th metatarsal" -"HP:0011622","Inlet ventricular septal defect" -"HP:0006541","Chronic obstructive airway disease from birth" -"HP:0001586","Vesicovaginal fistula" -"HP:0001498","Carpal bone hypoplasia" -"HP:0002015","Dysphagia" -"HP:0010495","Amniotic constriction rings of legs" -"HP:0002475","Myelomeningocele" -"HP:0011585","Thoracic ectopia cordis" -"HP:0010676","Mechanical ileus" -"HP:0030333","Abnormal alpha-beta T cell morphology" -"HP:0100626","Chronic hepatic failure" -"HP:0011362","Abnormal hair quantity" -"HP:0012316","Fibrous tissue neoplasm" -"HP:0002666","Pheochromocytoma" -"HP:0009323","Cone-shaped epiphysis of the middle phalanx of the 3rd finger" -"HP:0100615","Ovarian neoplasm" -"HP:0008986","Agenesis of the diaphragm" -"HP:0002344","Progressive neurologic deterioration" -"HP:0004389","Intestinal pseudo-obstruction" -"HP:0040303","Decreased serum iron" -"HP:0004904","Maturity-onset diabetes of the young" -"HP:0002109","Abnormality of the bronchi" -"HP:0001488","Bilateral ptosis" -"HP:0002877","Nocturnal hypoventilation" -"HP:0004606","Unossified vertebral bodies" -"HP:0005249","Functional intestinal obstruction" -"HP:0000877","Insulin-resistant diabetes mellitus at puberty" -"HP:0001252","Muscular hypotonia" -"HP:0012050","Anasarca" -"HP:0001264","Spastic diplegia" -"HP:0030060","Nervous tissue neoplasm" -"HP:0012409","Cortical nephrocalcinosis" -"HP:0002231","Sparse body hair" -"HP:0002719","Recurrent infections" -"HP:0006634","Osteosclerosis of ribs" -"HP:0030253","Defective T cell proliferation" -"HP:0003537","Hypouricemia" -"HP:0009732","Plexiform neurofibroma" -"HP:0003305","Block vertebrae" -"HP:0003870","Crumpled humerus" -"HP:0030289","Flattened femoral epiphysis" -"HP:0009468","Deviation of the 2nd finger" -"HP:0005384","Defective B cell activation" -"HP:0010478","Abnormality of the urachus" -"HP:0005476","Widely patent sagittal suture" -"HP:0005613","Aplasia/hypoplasia of the femur" -"HP:0007414","Neonatal wrinkled skin of hands and feet" -"HP:0003250","Aplasia of the vagina" -"HP:0011772","Abnormality of thyroid morphology" -"HP:0006392","Increased density of long bones" -"HP:0040086","Abnormal prolactin level" -"HP:0009537","Flexion contracture of the 2nd finger" -"HP:0000198","Absence of Stensen duct" -"HP:0007627","Mandibular condyle aplasia" -"HP:0009463","Ulnar deviation of the 3rd finger" -"HP:0008112","Plantar flexion contractures" -"HP:0012666","Severely reduced ejection fraction" -"HP:0009637","Absent proximal phalanx of thumb" -"HP:0030246","Maternal first trimester fever" -"HP:0025025","Rectovestibular fistula" -"HP:0012227","Urethral stricture" -"HP:0003205","Curvilinear intracellular accumulation of autofluorescent lipopigment storage material" -"HP:0005254","Unilateral chest hypoplasia" -"HP:0011356","Regional abnormality of skin" -"HP:0000339","Pugilistic facies" -"HP:0000030","Testicular gonadoblastoma" -"HP:0005916","Abnormal metacarpal morphology" -"HP:0009408","Aplasia/Hypoplasia of the phalanges of the 4th finger" -"HP:0008264","Neutrophil inclusion bodies" -"HP:0031433","Alexithymia" -"HP:0009788","Quadriceps aplasia" -"HP:0040272","Hyperintensity of MRI T2 signal of the spinal cord" -"HP:0100619","Sertoli cell neoplasm" -"HP:0009922","Vascular remnant arising from the disc" -"HP:0031007","Orofacial action-specific dystonia induced by speech" -"HP:0005871","Metaphyseal chondrodysplasia" -"HP:0001492","Axenfeld anomaly" -"HP:0001474","Sclerotic scapulae" -"HP:0010724","Advanced pneumatization of the mastoid process" -"HP:0200022","Choroid plexus papilloma" -"HP:0004484","Craniofacial asymmetry" -"HP:0006646","Costal cartilage calcification" -"HP:0045057","Decreased levels of alpha-fetoprotein" -"HP:0100923","Clavicular sclerosis" -"HP:0007889","Iridescent posterior subcapsular cataract" -"HP:0002764","Stippled chondral calcification" -"HP:0002932","Aldehyde oxidase deficiency" -"HP:0003208","Fingerprint intracellular accumulation of autofluorescent lipopigment storage material" -"HP:0011256","Crus of helix connected to antihelix" -"HP:0003452","Increased serum iron" -"HP:0012106","Rhizomelic leg shortening" -"HP:0010739","Osteopoikilosis" -"HP:0007453","Flexural lichenification" -"HP:0012767","Abnormal placental size" -"HP:0005877","Multiple small vertebral fractures" -"HP:0006450","Multicentric ossification of proximal femoral epiphyses" -"HP:0005973","Fructose intolerance" -"HP:0010539","Thin calvarium" -"HP:0030002","Nocturnal lagophthalmos" -"HP:0010937","Abnormality of the nasal skeleton" -"HP:0012669","Carotid sinus syncope" -"HP:0010888","Morbus Koehler" -"HP:0004852","Reduced leukocyte alkaline phosphatase" -"HP:0000047","Hypospadias" -"HP:0002550","Absent facial hair" -"HP:0031599","P mitrale" -"HP:0002219","Facial hypertrichosis" -"HP:0100483","Symphalangism of the proximal phalanx of the 2nd toe with the 2nd metatarsal" -"HP:0000677","Oligodontia" -"HP:0005346","Abnormal facial expression" -"HP:0011799","Abnormality of facial soft tissue" -"HP:0007695","Abnormal pupillary light reflex" -"HP:0001056","Milia" -"HP:0010688","Low placental alkaline phosphatase" -"HP:0002679","Abnormality of the sella turcica" -"HP:0007020","Progressive spastic paraplegia" -"HP:0007975","Hypometric horizontal saccades" -"HP:0000606","Abnormality of the periorbital region" -"HP:0003756","Skeletal myopathy" -"HP:0010956","Fetal megacystis" -"HP:0011380","Morphological abnormality of the semicircular canal" -"HP:0003635","Loss of subcutaneous adipose tissue in limbs" -"HP:3000043","Abnormal facial vein morphology" -"HP:0011842","Abnormality of skeletal morphology" -"HP:0008763","No social interaction" -"HP:0040166","Abnormality of the periosteum" -"HP:0010751","Dimple chin" -"HP:3000032","Abnormality of central retinal artery" -"HP:0011153","Focal motor seizures" -"HP:0004660","Hypoplasia of facial musculature" -"HP:0009126","Increased adipose tissue" -"HP:0011077","Abnormality of molar" -"HP:3000025","Abnormality of ciliary ganglion" -"HP:0009374","Broad phalanges of the 5th finger" -"HP:0031318","Myofiber disarray" -"HP:0003720","Generalized muscle hypertrophy" -"HP:0004491","Large posterior fontanelle" -"HP:0011821","Abnormality of facial skeleton" -"HP:0030629","Perifoveal ring of hyperautofluorescence" -"HP:0010683","Low tissue non-specific alkaline phosphatase" -"HP:0410013","Abnormality of the submandibular region" -"HP:0005390","Recurrent opportunistic infections" -"HP:0003552","Muscle stiffness" -"HP:0001696","Situs inversus totalis" -"HP:0005513","Increased megakaryocyte count" -"HP:0100230","Ivory epiphysis of the proximal phalanx of the 5th toe" -"HP:0012289","Facial neoplasm" -"HP:0004332","Abnormality of lymphocytes" -"HP:0005150","Abnormal atrioventricular conduction" -"HP:0040068","Abnormality of limb bone" -"HP:0000290","Abnormality of the forehead" -"HP:0011707","Mobitz I atrioventricular block" -"HP:0003546","Exercise intolerance" -"HP:3000050","Abnormality of odontoid tissue" -"HP:0005387","Combined immunodeficiency" -"HP:0003020","Enlargement of the wrists" -"HP:0030823","Scleral thickening" -"HP:0003414","Atlantoaxial dislocation" -"HP:0011157","Auras" -"HP:0002211","White forelock" -"HP:0000938","Osteopenia" -"HP:0100647","Graves disease" -"HP:0012503","Abnormality of the pituitary gland" -"HP:0025062","Geophagia" -"HP:0004791","Esophageal ulceration" -"HP:0004452","Abnormality of the middle ear ossicles" -"HP:0002013","Vomiting" -"HP:0030351","Urticarial plaque" -"HP:0011843","Abnormality of skeletal physiology" -"HP:0012735","Cough" -"HP:0005400","Reduction of neutrophil motility" -"HP:0025131","Finger swelling" -"HP:0010687","Low intestinal alkaline phosphatase" -"HP:0002748","Rickets" -"HP:0001945","Fever" -"HP:0031093","Abnormal breast morphology" -"HP:0030737","Altman type I sacrococcygeal teratoma" -"HP:0010625","Anterior pituitary dysgenesis" -"HP:0008669","Abnormal spermatogenesis" -"HP:0012074","Tonic pupil" -"HP:0007343","Abnormal morphology of the limbic system" -"HP:0012670","Orthostatic syncope" -"HP:0000629","Periorbital fullness" -"HP:0008771","Aplasia/Hypoplasia of the ear" -"HP:0011636","Abnormal origin of the coronary arteries" -"HP:0001137","Alternating esotropia" -"HP:0040168","Focal seizures, afebril" -"HP:0025061","Unifocal splenic abscess" -"HP:0002308","Arnold-Chiari malformation" -"HP:0100767","Abnormality of the placenta" -"HP:0010468","Aplasia/Hypoplasia of the testes" -"HP:0003896","Irregular humeral epiphyses" -"HP:0001022","Albinism" -"HP:0011328","Abnormality of fontanelles" -"HP:0002745","Oral leukoplakia" -"HP:0005950","Laryngeal web" -"HP:0006679","Granulomatous coronary arteritis" -"HP:0004492","Widely patent fontanelles and sutures" -"HP:0031390","Reduced MHC II surface expression" -"HP:0008839","Hypoplastic pelvis" -"HP:0002778","Abnormality of the trachea" -"HP:0005942","Desquamative interstitial pneumonitis" -"HP:0006564","Fluctuating hepatomegaly" -"HP:0011484","Posterior synechiae of the anterior chamber" -"HP:0004004","Irregular radial epiphyses" -"HP:0010675","Abnormal foot bone ossification" -"HP:0040189","Scaling skin" -"HP:0100534","Episcleritis" -"HP:0010233","Irregular epiphyses of the phalanges of the hand" -"HP:0010976","B lymphocytopenia" -"HP:0100358","Contracture of the metatarsophalangeal joint of the 4th toe" -"HP:0010604","Cyst of the eyelid" -"HP:0005656","Positional foot deformity" -"HP:0012359","Abnormal fucosylation of O-linked protein glycosylation" -"HP:0100532","Scleritis" -"HP:0005160","Total anomalous pulmonary venous return" -"HP:0007497","Focal friction-related palmoplantar hyperkeratosis" -"HP:0008090","Ankylosis of feet small joints" -"HP:0007506","Congenital absence of skin of limbs" -"HP:0003221","Chromosomal breakage induced by crosslinking agents" -"HP:0008110","Equinovarus deformity" -"HP:0006461","Proximal femoral epiphysiolysis" -"HP:0005349","Hypoplasia of the epiglottis" -"HP:0040176","Abnormal level of phospholipids" -"HP:0007141","Sensorimotor neuropathy" -"HP:0001051","Seborrheic dermatitis" -"HP:0100026","Arteriovenous malformation" -"HP:0009140","Synostosis involving bones of the feet" -"HP:0011726","Persistent fetal circulation" -"HP:0010785","Gonadal neoplasm" -"HP:0100273","Neoplasm of the colon" -"HP:0005745","Congenital foot contractures" -"HP:0011948","Acute respiratory tract infection" -"HP:0012484","Abnormal dense granules" -"HP:0001217","Clubbing" -"HP:0000643","Blepharospasm" -"HP:0012356","Decreased mannosylation of N-linked protein glycosylation" -"HP:0009882","Short distal phalanx of finger" -"HP:0006520","Progressive pulmonary function impairment" -"HP:0003482","EMG: axonal abnormality" -"HP:0008482","Asymmetry of spinal facet joints" -"HP:0000451","Triangular nasal tip" -"HP:0009884","Tapered distal phalanges of finger" -"HP:0011411","Forceps delivery" -"HP:0003564","Folate-dependent fragile site at Xq28" -"HP:0011074","Localized hypoplasia of dental enamel" -"HP:0007515","Hypoplastic pilosebaceous units" -"HP:0025558","Lamellar cataract with riders" -"HP:0007548","Palmoplantar keratosis with erythema and scale" -"HP:0011991","Abnormal neutrophil count" -"HP:0030255","Large intestinal polyposis" -"HP:0025522","Elongated chordae tendinae of the mitral valve" -"HP:0004223","Ivory epiphysis of the distal phalanx of the 5th finger" -"HP:0004426","Abnormality of the cheek" -"HP:0001915","Aplastic anemia" -"HP:0000465","Webbed neck" -"HP:0025485","Vaginal adenosis" -"HP:0004419","Recurrent thrombophlebitis" -"HP:0100721","Mediastinal lymphadenopathy" -"HP:0009025","Increased connective tissue" -"HP:0004808","Acute myeloid leukemia" -"HP:0007613","Spinous keratoses of palms and soles" -"HP:0007930","Prominent epicanthal folds" -"HP:0100958","Narrow foramen obturatorium" -"HP:0003272","Abnormality of the hip bone" -"HP:0003948","Irregular epiphyses of the elbow" -"HP:0008664","Urethral sphincter sclerosis" -"HP:0003095","Septic arthritis" -"HP:0100270","Abnormality of dorsoventral patterning of the limbs" -"HP:0100321","Abnormality of the dentate nucleus" -"HP:0002959","Impaired Ig class switch recombination" -"HP:0005312","Pulmonary aterial intimal fibrosis" -"HP:0011976","Elevated urinary catecholamines" -"HP:0007703","Abnormality of retinal pigmentation" -"HP:0007553","Congenital symmetrical palmoplantar keratosis" -"HP:0009916","Anisocoria" -"HP:0003402","Decreased miniature endplate potentials" -"HP:0005439","Maxillozygomatic hypoplasia" -"HP:0004470","Atretic occipital cephalocele" -"HP:0100872","Abnormality of the plantar skin of foot" -"HP:0030911","Bifid clitoris" -"HP:0004311","Abnormality of macrophages" -"HP:0009190","Irregular epiphyses of the metacarpals" -"HP:0000759","Abnormal peripheral nervous system morphology" -"HP:0010512","Adrenal calcification" -"HP:0003028","Abnormality of the ankles" -"HP:0002504","Calcification of the small brain vessels" -"HP:0001886","Foot osteomyelitis" -"HP:0011944","Small vessel vasculitis" -"HP:0012378","Fatigue" -"HP:0007351","Upper limb postural tremor" -"HP:0030711","Hydrocolpos" -"HP:0045014","Hypolipidemia" -"HP:0005441","Sclerotic cranial sutures" -"HP:0002253","Colonic diverticula" -"HP:0100299","Muscle fiber inclusion bodies" -"HP:0100769","Synovitis" -"HP:0001780","Abnormality of toe" -"HP:0010507","Foot asymmetry" -"HP:0031371","Rectal perforation" -"HP:0002363","Abnormality of brainstem morphology" -"HP:0012060","Acral lentiginous melanoma" -"HP:0004586","Biconcave vertebral bodies" -"HP:0007545","Congenital palmoplantar keratosis" -"HP:0004601","Spina bifida occulta at L5" -"HP:0009743","Distichiasis" -"HP:0012768","Neonatal asphyxia" -"HP:0008796","Externally rotated hips" -"HP:0012119","Methemoglobinemia" -"HP:0007530","Punctate palmoplantar hyperkeratosis" -"HP:0001830","Postaxial foot polydactyly" -"HP:0011552","Ambiguous atrioventricular connection" -"HP:0008757","Unilateral vocal cord paralysis" -"HP:0030005","Capillary leak" -"HP:0009136","Duplication involving bones of the feet" -"HP:0007447","Diffuse palmoplantar hyperkeratosis" -"HP:0004927","Pulmonary artery dilatation" -"HP:0001854","Podagra" -"HP:0006719","Benign gastrointestinal tract tumors" -"HP:0007066","Proximal limb muscle stiffness" -"HP:0002825","Caudal appendage" -"HP:0001539","Omphalocele" -"HP:0000712","Emotional lability" -"HP:0002134","Abnormality of the basal ganglia" -"HP:0100627","Displacement of the external urethral meatus" -"HP:0025489","Bladder duplication" -"HP:0008788","Delayed pubic bone ossification" -"HP:0004828","Refractory anemia with ringed sideroblasts" -"HP:0002579","Gastrointestinal dysmotility" -"HP:0009184","Contracture of the distal interphalangeal joint of the 5th finger" -"HP:0007227","Macrogyria" -"HP:0003693","Distal amyotrophy" -"HP:0012023","Galactosuria" -"HP:0001972","Macrocytic anemia" -"HP:0030261","Absent penis" -"HP:0100678","Premature skin wrinkling" -"HP:0008588","Slit-like opening of the exterior auditory meatus" -"HP:0000774","Narrow chest" -"HP:0004960","Absent pulmonary artery" -"HP:0003112","Abnormality of serum amino acid levels" -"HP:0000590","Progressive external ophthalmoplegia" -"HP:0008232","Elevated circulating follicle stimulating hormone level" -"HP:0011089","Double tooth" -"HP:0011990","Abnormality of neutrophil physiology" -"HP:0008115","Clinodactyly of the 3rd toe" -"HP:0004043","Lytic defects of ulnar metaphysis" -"HP:0000040","Long penis" -"HP:0010695","Sutural cataract" -"HP:0003091","Trophic limb changes" -"HP:0005791","Cortical thickening of long bone diaphyses" -"HP:0100530","Abnormality of calcium-phosphate metabolism" -"HP:0100631","Neoplasm of the adrenal gland" -"HP:0011867","Abnormality of the wing of the ilium" -"HP:0002590","Paralytic ileus" -"HP:0004405","Prominent nipples" -"HP:0003548","Subsarcolemmal accumulations of abnormally shaped mitochondria" -"HP:0030672","Asteroid hyalosis" -"HP:0002066","Gait ataxia" -"HP:0010935","Abnormality of the upper urinary tract" -"HP:0006202","Osteolysis of scaphoids" -"HP:0100693","Iridodonesis" -"HP:0100771","Hypoperistalsis" -"HP:0002720","IgA deficiency" -"HP:0012341","Microprolactinoma" -"HP:0004953","Dilatation of abdominal aorta" -"HP:0002014","Diarrhea" -"HP:0006378","Osteolysis of patellae" -"HP:0008421","Tall lumbar vertebral bodies" -"HP:0012581","Solitary renal cyst" -"HP:0000953","Hyperpigmentation of the skin" -"HP:0000216","Broad secondary alveolar ridge" -"HP:0001230","Broad metacarpals" -"HP:0031417","Rhinorrhea" -"HP:0000510","Rod-cone dystrophy" -"HP:0008490","Sacral segmentation defect" -"HP:0000494","Downslanted palpebral fissures" -"HP:0008079","Absent fifth metatarsal" -"HP:0031042","Strawberry tongue" -"HP:0000544","External ophthalmoplegia" -"HP:0004528","Generalized hypotrichosis" -"HP:0007713","Juvenile zonular cataracts" -"HP:0000911","Flat glenoid fossa" -"HP:0003016","Metaphyseal widening" -"HP:0002725","Systemic lupus erythematosus" -"HP:0012509","Reduced thyroxin-binding globulin" -"HP:0005194","Flattened metatarsal heads" -"HP:0025383","Dorsocervical fat pad" -"HP:0012453","Bilateral wrist flexion contracture" -"HP:0000042","Absent external genitalia" -"HP:0100877","Renal diverticulum" -"HP:0004752","Congenital atrioventricular dissociation" -"HP:0002582","Chronic atrophic gastritis" -"HP:0008838","Stippled calcification proximal humeral epiphyses" -"HP:0003270","Abdominal distention" -"HP:0001007","Hirsutism" -"HP:0008026","Horizontal opticokinetic nystagmus" -"HP:0001250","Seizures" -"HP:0004646","Hypoplasia of the nasal bone" -"HP:0550005","Bilateral basilar pulmonary fibrosis" -"HP:0010293","Aplasia/Hypoplasia of the uvula" -"HP:0005063","Fragmented, irregular epiphyses" -"HP:0012084","Abnormality of skeletal muscle fiber size" -"HP:0011647","Postductal coarctation of the aorta" -"HP:0001508","Failure to thrive" -"HP:0001166","Arachnodactyly" -"HP:0011800","Midface retrusion" -"HP:0003842","Irregular epiphyses of the upper limbs" -"HP:0005863","Type E brachydactyly" -"HP:0001522","Death in infancy" -"HP:0030889","Congenital shortened small intestine" -"HP:0000108","Renal corticomedullary cysts" -"HP:0006086","Thin metacarpal cortices" -"HP:0009592","Astrocytoma" -"HP:0006367","Crumpled long bones" -"HP:0002352","Leukoencephalopathy" -"HP:0011992","Abnormality of neutrophil morphology" -"HP:0003493","Antinuclear antibody positivity" -"HP:0002194","Delayed gross motor development" -"HP:0002797","Osteolysis" -"HP:0000957","Cafe-au-lait spot" -"HP:0009125","Lipodystrophy" -"HP:0010730","Double eyebrow" -"HP:0010699","Triangular nuclear cataract" -"HP:0008476","Irregular sclerotic endplates" -"HP:0030606","Abnormal OCT-measured macular thickness" -"HP:0100847","Palmoplantar pustulosis" -"HP:0025394","Cystic pattern on pulmonary HRCT" -"HP:0010259","Cone-shaped epiphyses of the middle phalanges of the hand" -"HP:0007968","Remnants of the hyaloid vascular system" -"HP:0009453","Osteolytic defects of the proximal phalanx of the 3rd finger" -"HP:0003370","Flat capital femoral epiphysis" -"HP:0011893","Abnormal leukocyte count" -"HP:0025243","Subretinal hemorrhage" -"HP:0009424","Osteolytic defects of the distal phalanx of the 3rd finger" -"HP:0000704","Periodontitis" -"HP:0011656","Double outlet right ventricle with subaortic ventricular septal defect without pulmonary stenosis" -"HP:0000649","Abnormality of visual evoked potentials" -"HP:0000846","Adrenal insufficiency" -"HP:0009727","Achromatic retinal patches" -"HP:0000763","Sensory neuropathy" -"HP:0040016","Prominent coccyx" -"HP:0008946","Pelvic girdle amyotrophy" -"HP:0009737","Lisch nodules" -"HP:0040294","Duplicated tongue" -"HP:0030145","Lack of bowel sounds" -"HP:0010300","Abnormally low-pitched voice" -"HP:0025251","Open comedo" -"HP:0002863","Myelodysplasia" -"HP:0030620","Inner retinal layer loss on macular OCT" -"HP:0012190","T-cell lymphoma" -"HP:0001598","Concave nail" -"HP:0007776","Sparse lower eyelashes" -"HP:0010477","Aplasia of the bladder" -"HP:0010252","Ivory epiphyses of the distal phalanges of the hand" -"HP:0007375","Abnormality of the septum pellucidum" -"HP:0012671","Abulia" -"HP:0030466","Abnormal full-field electroretinogram" -"HP:0000999","Pyoderma" -"HP:0011124","Abnormality of epidermal morphology" -"HP:0100295","Muscle fiber atrophy" -"HP:0002965","Cutaneous anergy" -"HP:0000155","Oral ulcer" -"HP:0025517","Hypoplastic hippocampus" -"HP:0030144","Hypoactive bowel sounds" -"HP:0012545","Reduced aldolase level" -"HP:0030046","Hypoglycosylation of alpha-dystroglycan" -"HP:0100726","Kaposi's sarcoma" -"HP:0025514","Morning glory anomaly" -"HP:0011823","Chin with horizontal crease" -"HP:0010515","Aplasia/Hypoplasia of the thymus" -"HP:0006727","T-cell acute lymphoblastic leukemias" -"HP:0030591","Abnormal kinetic perimetry test" -"HP:0030029","Splayed fingers" -"HP:0000613","Photophobia" -"HP:0040050","Sparse upper eyelashes" -"HP:0100670","Rough bone trabeculation" -"HP:0005526","Lymphoid leukemia" -"HP:0006253","Swelling of proximal interphalangeal joints" -"HP:0004848","Ph-positive acute lymphoblastic leukemia" -"HP:0025143","Chills" -"HP:0410010","Abnormality of somatic nerve plexus" -"HP:0000058","Abnormality of the labia" -"HP:0011413","Shoulder dystocia" -"HP:0011243","Abnormality of inferior crus of antihelix" -"HP:0011105","Hypervolemia" -"HP:0000293","Full cheeks" -"HP:0031459","Soft tissue neoplasm" -"HP:0040098","Basalioma of the outer ear" -"HP:0002104","Apnea" -"HP:0006028","Metaphyseal cupping of metacarpals" -"HP:0010650","Hypoplasia of the premaxilla" -"HP:0005281","Hypoplastic nasal bridge" -"HP:0005013","Dysplastic distal radial epiphyses" -"HP:0008209","Premature ovarian insufficiency" -"HP:0030644","Blind-spot enlargment" -"HP:0011039","Abnormality of the helix" -"HP:0002367","Visual hallucinations" -"HP:0003444","EMG: chronic denervation signs" -"HP:0100016","Abnormality of mesentery morphology" -"HP:0012634","Iris pigment dispersion" -"HP:0006563","Malformation of the hepatic ductal plate" -"HP:0005421","Decreased serum complement C3" -"HP:0006611","Decreased number of sternal ossification centers" -"HP:0040081","Abnormal levels of creatine kinase in blood" -"HP:0006234","Osteolysis involving tarsal bones" -"HP:0006167","Prominent proximal interphalangeal joints" -"HP:0000419","Abnormality of the nasal septum" -"HP:0011254","Type II cryptotia" -"HP:0003002","Breast carcinoma" -"HP:0008095","Osteolysis of talus" -"HP:0005917","Supernumerary metacarpal bones" -"HP:0005750","Contractures of the joints of the lower limbs" -"HP:0040223","Pulmonary hemorrhage" -"HP:0007475","Congenital bullous ichthyosiform erythroderma" -"HP:0010009","Abnormality of the 1st metacarpal" -"HP:0000717","Autism" -"HP:0006051","Metacarpal periosteal thickening" -"HP:0010010","Abnormality of the 2nd metacarpal" -"HP:0003529","Parathormone-independent increased renal tubular calcium reabsorption" -"HP:0010012","Abnormality of the 4th metacarpal" -"HP:0010451","Aplasia/Hypoplasia of the spleen" -"HP:0007772","Impaired smooth pursuit" -"HP:0006449","Distal radial epiphyseal osteolysis" -"HP:0010458","Female pseudohermaphroditism" -"HP:0000551","Abnormality of color vision" -"HP:0030652","Vitreous haze" -"HP:0030211","Slow pupillary light response" -"HP:0010559","Vertical clivus" -"HP:0007603","Freckles in sun-exposed areas" -"HP:0011943","Increased urinary thiosulfate" -"HP:0012064","Unicameral bone cyst" -"HP:0031313","Abdominal aortic calcification" -"HP:0030307","Flared lower limb metaphysis" -"HP:0001595","Abnormality of the hair" -"HP:0001872","Abnormality of thrombocytes" -"HP:0000286","Epicanthus" -"HP:0005498","Midline skin dimples over anterior/posterior fontanelles" -"HP:0011234","Absent antihelix" -"HP:0011911","Abnormality of metacarpophalangeal joint" -"HP:0045042","Decreased serum complement C4" -"HP:0008414","Lumbar kyphosis in infancy" -"HP:0004889","Intermittent episodes of respiratory insufficiency due to muscle weakness" -"HP:0004712","Renal malrotation" -"HP:0025110","Placoid macular lesion" -"HP:0011244","Abnormality of stem of antihelix" -"HP:0005353","Susceptibility to herpesvirus" -"HP:0000396","Overfolded helix" -"HP:0012894","Paraspinal muscle hypertrophy" -"HP:0010011","Abnormality of the 3rd metacarpal" -"HP:0011960","Substantia nigra gliosis" -"HP:0011521","Deuteranopia" -"HP:0008182","Adrenocortical hypoplasia" -"HP:0012123","Posterior uveitis" -"HP:0025515","Delayed thelarche" -"HP:0001634","Mitral valve prolapse" -"HP:0011245","Abnormality of superior crus of antihelix" -"HP:0000568","Microphthalmia" -"HP:0003170","Abnormality of the acetabulum" -"HP:0030361","Abnormality of eicosanoid metabolism" -"HP:0030661","Vitreous snowballs" -"HP:0001504","Metacarpal osteolysis" -"HP:0000978","Bruising susceptibility" -"HP:0040128","Abnormal sweat electrolytes" -"HP:0003574","Positive regitine blocking test" -"HP:0012215","Testicular microlithiasis" -"HP:0001325","Hypoglycemic coma" -"HP:0001317","Abnormality of the cerebellum" -"HP:0000453","Choanal atresia" -"HP:0006896","Hypnopompic hallucinations" -"HP:0031359","Cutaneous sclerotic plaque" -"HP:0012249","Abnormal ST segment" -"HP:0030857","Eye movement-induced pain" -"HP:0007782","Peripheral retinal cone degeneration" -"HP:0100829","Galactorrhea" -"HP:0009182","Triangular shaped middle phalanx of the 5th finger" -"HP:0002601","Paresis of extensor muscles of the big toe" -"HP:0030173","Peripheral hypermyelination" -"HP:0040322","Purple urine" -"HP:0009053","Distal lower limb muscle weakness" -"HP:0100362","Aplasia of the phalanges of the 3rd toe" -"HP:0002528","Granulovacuolar degeneration" -"HP:0009587","Triangular shaped proximal phalanx of the 2nd finger" -"HP:0002314","Degeneration of the lateral corticospinal tracts" -"HP:0012272","J wave" -"HP:0031360","Yellow skin plaque" -"HP:0025267","Snoring" -"HP:0025474","Erythematous plaque" -"HP:0009523","Triangular epiphysis of the middle phalanx of the 2nd finger" -"HP:0012895","Scapular muscle hypertrophy" -"HP:0005606","Hyperpigmented nevi and streak" -"HP:0008314","Decreased activity of mitochondrial complex II" -"HP:0025550","Elevated circulating ribitol concentration" -"HP:0040318","Red urine" -"HP:0004488","Macrocephaly at birth" -"HP:0100296","Perifascicular muscle fiber atrophy" -"HP:0012436","Nonocclusive coronary artery disease" -"HP:0012055","Ciliary body melanoma" -"HP:0031012","Thin-cap fibroatheroma" -"HP:0040319","Dark urine" -"HP:0006837","Congenital Horner syndrome" -"HP:0005490","Postnatal macrocephaly" -"HP:0000359","Abnormality of the inner ear" -"HP:0040278","Prolactinoma" -"HP:0004293","Synostosis of second metacarpal-trapezoid" -"HP:0025070","Abnormal U wave" -"HP:0004661","Frontalis muscle weakness" -"HP:0000547","Tapetoretinal degeneration" -"HP:0009527","Enlarged epiphysis of the proximal phalanx of the 2nd finger" -"HP:0030004","Cicatricial lagophthalmos" -"HP:0007111","Chronic hepatic encephalopathy" -"HP:0040320","Red-brown urine" -"HP:0009693","Pseudoepiphysis of the thumb" -"HP:3000018","Abnormality of zygomaticus major muscle" -"HP:0005008","Large joint dislocations" -"HP:0000971","Abnormality of the sweat gland" -"HP:0040317","Blue urine" -"HP:0410072","Increased level of ribose in urine" -"HP:3000020","Abnormality of zygomaticus minor muscle" -"HP:0040151","Epiblepharon of lower lid" -"HP:0010055","Broad hallux" -"HP:0009898","Underdeveloped crus of the helix" -"HP:0007943","Congenital stapes ankylosis" -"HP:0012799","Unilateral facial palsy" -"HP:0007670","Abnormal vestibulo-ocular reflex" -"HP:0011959","Unilateral hypoplasia of pectoralis major muscle" -"HP:0012114","Endometrial carcinoma" -"HP:0008151","Prolonged prothrombin time" -"HP:0031011","Fatty streak" -"HP:0002635","Atheromatosis" -"HP:0030310","Upper extremity joint dislocation" -"HP:0009534","Triangular epiphysis of the proximal phalanx of the 2nd finger" -"HP:0012868","Sperm tail anomaly" -"HP:0004602","Cervical C2/C3 vertebral fusion" -"HP:0008488","Anterior rounding of vertebral bodies" -"HP:0012452","Restless legs" -"HP:0006406","Club-shaped proximal femur" -"HP:0012342","Macroprolactinoma" -"HP:0003731","Quadriceps muscle weakness" -"HP:0025234","Parasomnia" -"HP:0030172","Peripheral amyelination" -"HP:0001349","Facial diplegia" -"HP:0012462","Chin myoclonus" -"HP:0008303","Olivary degeneration" -"HP:0012095","Multiple joint dislocation" -"HP:0430005","Abnormality of ethmoid bone" -"HP:0005495","Metopic suture patent to nasal root" -"HP:0004371","Abnormality of glycosaminoglycan metabolism" -"HP:0011122","Abnormality of skin physiology" -"HP:0025325","Sparse medial eyebrow" -"HP:0012047","Hemeralopia" -"HP:0005576","Tubulointerstitial fibrosis" -"HP:0025318","Ovarian carcinoma" -"HP:0008261","Pancreatic islet cell adenoma" -"HP:0003173","Hypoplastic pubic bone" -"HP:0009745","Spinalarachnoid cyst" -"HP:0031207","Hepatic hemangioma" -"HP:0012384","Rhinitis" -"HP:0008178","Abnormal cartilage matrix" -"HP:0008188","Thyroid dysgenesis" -"HP:0009759","Neck pterygia" -"HP:0012510","Extra-axial cerebrospinal fluid accumulation" -"HP:0010301","Spinal dysraphism" -"HP:0100128","Ivory epiphysis of the proximal phalanx of the 2nd toe" -"HP:0030584","Color vision test abnormality" -"HP:0000217","Xerostomia" -"HP:0001871","Abnormality of blood and blood-forming tissues" -"HP:0009757","Intercrural pterygium" -"HP:0001262","Excessive daytime somnolence" -"HP:0010832","Abnormality of pain sensation" -"HP:0000895","Lateral clavicle hook" -"HP:0012432","Chronic fatigue" -"HP:0010830","Impaired tactile sensation" -"HP:0030773","Internuclear ophthalmoplegia" -"HP:0410067","Increased level of L-fucose in urine" -"HP:0031469","Low self esteem" -"HP:0030264","Webbed penis" -"HP:0003238","Hyperpepsinogenemia I" -"HP:0100776","Recurrent pharyngitis" -"HP:0004614","Spina bifida occulta at S1" -"HP:0012016","EEG with occipital focal spikes" -"HP:0005423","Dysfunctional alternative complement pathway" -"HP:0010094","Complete duplication of the proximal phalanx of the hallux" -"HP:0007843","Attenuation of retinal blood vessels" -"HP:0012297","Slender proximal phalanx of finger" -"HP:0011572","Supramitral ring" -"HP:0002575","Tracheoesophageal fistula" -"HP:0030262","Narrow penis" -"HP:0012288","Neoplasm of head and neck" -"HP:0030213","Emotional blunting" -"HP:0007688","Undetectable light- and dark-adapted electroretinogram" -"HP:0100106","Ivory epiphysis of the distal phalanx of the 2nd toe" -"HP:0100512","Vitamin D deficiency" -"HP:0100802","Malposition of the stomach" -"HP:0011623","Muscular ventricular septal defect" -"HP:0008802","Hypoplasia of the femoral head" -"HP:0011974","Myelofibrosis" -"HP:0001147","Retinal exudate" -"HP:0005223","Duplicated colon" -"HP:0007803","Monochromacy" -"HP:0012182","Oropharyngeal squamous cell carcinoma" -"HP:0012122","Anterior uveitis" -"HP:0009105","Abnormal ossification of the pubic bone" -"HP:0025197","Inclusion body fibromatosis" -"HP:0006980","Progressive leukoencephalopathy" -"HP:0009299","Aplasia/Hypoplasia of the middle phalanx of the 4th finger" -"HP:0012411","Premature pubarche" -"HP:0002651","Spondyloepimetaphyseal dysplasia" -"HP:0003422","Vertebral segmentation defect" -"HP:0012789","Hypoplasia of the calcaneus" -"HP:0001468","Aplasia/Hypoplasia involving the musculature of the upper arm" -"HP:0003882","Slender humerus" -"HP:0030323","Unilateral vertebral artery hypoplasia" -"HP:0006527","Lymphoid interstitial pneumonia" -"HP:0025459","Increased CSF/serum albumin ratio" -"HP:0005522","Pyridoxine-responsive sideroblastic anemia" -"HP:0012028","Hepatocellular adenoma" -"HP:0031092","Spindle-shaped finger" -"HP:0000512","Abnormal electroretinogram" -"HP:0008940","Generalized lymphadenopathy" -"HP:0012388","Acute bronchitis" -"HP:0025547","Decreased mean corpuscular hemoglobin" -"HP:0012295","Slender middle phalanx of finger" -"HP:0010835","Dissociated sensory loss" -"HP:0003752","Episodic flaccid weakness" -"HP:0000464","Abnormality of the neck" -"HP:0000230","Gingivitis" -"HP:0006514","Intraalveolar nodular calcifications" -"HP:0012015","EEG with frontal focal spikes" -"HP:0000543","Optic disc pallor" -"HP:0011802","Hamartoma of tongue" -"HP:0008998","Pectoralis hypoplasia" -"HP:0009756","Popliteal pterygium" -"HP:0001528","Hemihypertrophy" -"HP:0031406","Abnormal cytokine signaling" -"HP:0005240","Esophageal obstruction" -"HP:0012296","Slender distal phalanx of finger" -"HP:0002438","Cerebellar malformation" -"HP:0001060","Axillary pterygia" -"HP:0011621","Gerbode ventricular septal defect" -"HP:0005108","Abnormality of the intervertebral disk" -"HP:0005788","Abnormal cervical myelogram" -"HP:0008801","Hypoplasia of the lesser trochanter" -"HP:0011142","Age-related nuclear cataract" -"HP:0002495","Impaired vibratory sensation" -"HP:0030263","Torsion of the penis" -"HP:0001955","Unexplained fevers" -"HP:0200056","Macular scar" -"HP:0005317","Increased pulmonary vascular resistance" -"HP:0003223","Decreased methylcobalamin" -"HP:0040062","Slender radius" -"HP:0003274","Hypoplastic acetabulae" -"HP:0001040","Multiple pterygia" -"HP:0002354","Memory impairment" -"HP:0011143","Age-related cortical cataract" -"HP:0011269","Bifid tragus" -"HP:0025082","Abnormal cutaneous elastic fiber morphology" -"HP:0100689","Decreased corneal thickness" -"HP:0410075","Increased level of xylitol in CSF" -"HP:0030936","Abnormal layering of muscularis propria" -"HP:0010926","Aculeiform cataract" -"HP:0031306","Intracranial arterial calcification" -"HP:0003952","Sclerotic foci of metaphyses of the elbow" -"HP:0011793","Neoplasm by anatomical site" -"HP:0004940","Generalized arterial calcification" -"HP:0008568","Vestibular areflexia" -"HP:0007024","Pseudobulbar paralysis" -"HP:0025083","Elevated dermal desmosine content" -"HP:0011346","Mild expressive language delay" -"HP:0031512","Abnormal cutaneous collagen fibril morphology" -"HP:0430002","Abnormality of the lacrimal bone" -"HP:0030937","Fibrotic muscularis propria" -"HP:0001931","Hypochromic anemia" -"HP:0011928","Short proximal phalanx of toe" -"HP:0030764","Ochronosis" -"HP:0031314","Carotid artery calcification" -"HP:0004369","Decreased purine levels" -"HP:0004820","Acute myelomonocytic leukemia" -"HP:0008648","Anteriorly displaced urethral meatus" -"HP:0031301","Peripheral arterial calcification" -"HP:0010383","Aplasia/Hypoplasia of the phalanges of the 5th toe" -"HP:0430004","Frontomalar faciosynostosis" -"HP:0031538","Abnormal dermoepidermal junction morphology" -"HP:0004589","Dysplasia of second lumbar vertebra" -"HP:0007314","White matter neuronal heterotopia" -"HP:0010214","Contracture of the interphalangeal joint of the hallux" -"HP:0010668","Abnormality of the zygomatic bone" -"HP:0100354","Contracture of the distal interphalangeal joint of the 4th toe" -"HP:0000933","Posterior fossa cyst at the fourth ventricle" -"HP:0006863","Severe expressive language delay" -"HP:0007481","Hyperpigmented nevi" -"HP:0003409","Distal sensory impairment of all modalities" -"HP:0011345","Moderate expressive language delay" -"HP:0012127","Uraciluria" -"HP:0005429","Recurrent systemic pyogenic infections" -"HP:0009971","Polydactyly affecting the 4th finger" -"HP:0002141","Gait imbalance" -"HP:0005403","Decrease in T cell count" -"HP:0011118","Abnormality of tumor necrosis factor secretion" -"HP:0011144","Age-related posterior subcapsular cataract" -"HP:0011274","Recurrent mycobacterial infections" -"HP:0004836","Acute promyelocytic leukemia" -"HP:0005419","Decreased T cell activation" -"HP:0000823","Delayed puberty" -"HP:0006302","Dagger-shaped pulp calcifications" -"HP:0012544","Elevated aldolase level" -"HP:0004499","Chronic rhinitis due to narrow nasal airway" -"HP:0012741","Unilateral cryptorchidism" -"HP:0002164","Nail dysplasia" -"HP:0011545","Abnormal connection of the cardiac segments" -"HP:0011902","Abnormal hemoglobin" -"HP:0003616","Premature separation of centromeric heterochromatin" -"HP:0000291","Abnormality of facial adipose tissue" -"HP:0010013","Abnormality of the 5th metacarpal" -"HP:0002533","Abnormal posturing" -"HP:0009098","Chronic oral candidiasis" -"HP:0004359","Abnormality of fatty-acid metabolism" -"HP:0008346","Increased red cell sickling tendency" -"HP:0030355","Abnormal serum interferon-gamma level" -"HP:0012399","Pressure ulcer" -"HP:0012183","Hyperplastic colonic polyposis" -"HP:0012108","Open angle glaucoma" -"HP:0011801","Enlargement of parotid gland" -"HP:0007709","Band-shaped corneal dystrophy" -"HP:0004257","Delayed ossification of the trapezoid bone" -"HP:0200030","Punctate vasculitis skin lesions" -"HP:0100498","Deviation of toes" -"HP:0200021","Down-sloping shoulders" -"HP:0003158","Hyposthenuria" -"HP:0001226","Acral ulceration and osteomyelitis leading to autoamputation of digits" -"HP:0001896","Reticulocytopenia" -"HP:0011115","Abnormality of chemokine secretion" -"HP:0011628","Congenital defect of the pericardium" -"HP:0004991","Rhizomelic arm shortening" -"HP:0012702","Tenesmus" -"HP:0000802","Impotence" -"HP:0031451","Lower extremity subcutanous fat hypertrophy" -"HP:0001511","Intrauterine growth retardation" -"HP:0011834","Moyamoya phenomenon" -"HP:0009064","Generalized lipodystrophy" -"HP:0007893","Progressive retinal degeneration" -"HP:0100327","Cow milk allergy" -"HP:0011534","Abnormal spatial orientation of the cardiac segments" -"HP:0003413","Atlantoaxial abnormality" -"HP:0031331","Abnormal cardiomyocyte morphology" -"HP:0006121","Acral ulceration leading to autoamputation of digits" -"HP:0003717","Minimal subcutaneous fat" -"HP:0001374","Congenital hip dislocation" -"HP:0005009","Dumbbell-shaped humerus" -"HP:0001913","Granulocytopenia" -"HP:0002365","Hypoplasia of the brainstem" -"HP:0008922","Childhood-onset short-trunk short stature" -"HP:0009417","Pseudoepiphyses of the 3rd finger" -"HP:0001036","Parakeratosis" -"HP:0012351","Increased sialylation of N-linked protein glycosylation" -"HP:0005913","Abnormality of metacarpal epiphyses" -"HP:0040138","Mucinous histiocytosis" -"HP:0010161","Abnormality of the phalanges of the toes" -"HP:0011817","Basal encephalocele" -"HP:0003477","Peripheral axonal neuropathy" -"HP:0100243","Leiomyosarcoma" -"HP:0006252","Interphalangeal joint erosions" -"HP:0001862","Acral ulceration and osteomyelitis leading to autoamputation of the digits (feet)" -"HP:0004307","Abnormal anatomic location of the heart" -"HP:0010448","Colonic atresia" -"HP:0002754","Osteomyelitis" -"HP:0003729","Enteroviral dermatomyositis syndrome" -"HP:0011239","Underdeveloped inferior crus of antihelix" -"HP:0012637","Renal calcium wasting" -"HP:0001026","Penetrating foot ulcers" -"HP:0045040","Abnormal lactate dehydrogenase activity" -"HP:0000431","Wide nasal bridge" -"HP:0031164","Growth arrest lines" -"HP:0004254","Delayed ossification of the trapezium" -"HP:0010319","Abnormality of the 2nd toe" -"HP:0010885","Aseptic necrosis" -"HP:0000317","Facial myokymia" -"HP:0011114","Defective production of NFKB1-dependent cytokines" -"HP:0006779","Alveolar rhabdomyosarcoma" -"HP:0009625","Contractures of the metacarpophalangeal joint of the thumb" -"HP:0005531","Biphenotypic acute leukaemia" -"HP:0001741","Phimosis" -"HP:0007233","Clusters of axonal regeneration" -"HP:0001975","Decreased platelet glycoprotein IIb-IIIa" -"HP:0040063","Decreased adipose tissue" -"HP:0005560","Imbalanced hemoglobin synthesis" -"HP:0011787","Central hypothyroidism" -"HP:0011498","Partial aniridia" -"HP:0005406","Recurrent bacterial skin infections" -"HP:0012322","Perifolliculitis" -"HP:0007380","Facial telangiectasia" -"HP:0200023","Priapism" -"HP:0011504","Bull's eye maculopathy" -"HP:0011102","Ileal atresia" -"HP:0002476","Primitive reflex" -"HP:0200013","Neoplasm of fatty tissue" -"HP:0004527","Large clumps of pigment irregularly distributed along hair shaft" -"HP:0011116","Abnormality of interferon secretion" -"HP:0008689","Bilateral cryptorchidism" -"HP:0012701","Bowel urgency" -"HP:0005120","Abnormality of cardiac atrium" -"HP:0004797","Multiple small bowel atresias" -"HP:0002833","Cystic angiomatosis of bone" -"HP:0011703","Sinus tachycardia" -"HP:0007906","Increased intraocular pressure" -"HP:0001102","Angioid streaks of the retina" -"HP:0008103","Delayed tarsal ossification" -"HP:0001713","Abnormal cardiac ventricle morphology" -"HP:0012608","Hypermagnesiuria" -"HP:0025452","Pyoderma gangrenosum" -"HP:0001908","Hypoplastic anemia" -"HP:0005374","Cellular immunodeficiency" -"HP:0045017","Congenital malformation of the left heart" -"HP:0008734","Decreased testicular size" -"HP:0011117","Abnormality of interleukin secretion" -"HP:0005316","Peripheral pulmonary vessel aplasia" -"HP:0008833","Irregular acetabular roof" -"HP:0002234","Early balding" -"HP:0010026","Aplasia/Hypoplasia of the 1st metacarpal" -"HP:0002689","Absent paranasal sinuses" -"HP:0040249","Reduced plasminogen activator inhibitor 1 antigen" -"HP:0004673","Decreased facial expression" -"HP:0040247","Reduced euglobulin clot lysis time" -"HP:0005956","Anteroposteriorly shortened larynx" -"HP:0100773","Cartilage destruction" -"HP:0011864","Elevated plasma pyrophosphate" -"HP:0025341","Corneal keratic precipitates" -"HP:0010740","Osteopathia striata" -"HP:0004049","Decreased carpal angles of wrist" -"HP:0030139","Excessive bleeding after a venipuncture" -"HP:0040243","Prolonged euglobulin clot lysis time" -"HP:0012699","Anomaly of lower limb diaphyses" -"HP:0007900","Hypoplastic lacrimal duct" -"HP:0011513","Retinal cavernous angioma" -"HP:0004931","Arteriosclerosis of small cerebral arteries" -"HP:0009808","Anomaly of the upper limb diaphyses" -"HP:0002948","Vertebral fusion" -"HP:0010068","Broad first metatarsal" -"HP:0040301","Increased urinary glycerol" -"HP:0012430","Cerebral white matter hypoplasia" -"HP:0007344","Atrophy/Degeneration involving the spinal cord" -"HP:0031019","Pyknotic bone marrow neutrophils" -"HP:0010472","Abnormality of the heme biosynthetic pathway" -"HP:0011204","EEG with continuous slow activity" -"HP:0100072","Ivory epiphyses of the 4th toe" -"HP:0009456","Triangular shaped proximal phalanx of the 3rd finger" -"HP:0004337","Abnormality of amino acid metabolism" -"HP:0003466","Paradoxical increased cortisol secretion on dexamethasone suppression test" -"HP:0025193","Posterolateral diaphragmatic hernia" -"HP:0010104","Absent first metatarsal" -"HP:0010119","Ivory epiphyses of the hallux" -"HP:0010494","Acromelia of the lower limbs" -"HP:0008447","Hypoplastic coccygeal vertebrae" -"HP:0200150","Increased serum bile acid concentration during pregnancy" -"HP:0009943","Complete duplication of thumb phalanx" -"HP:0010845","EEG with generalized slow activity" -"HP:0002808","Kyphosis" -"HP:0012374","Abnormal globe morphology" -"HP:0011164","Vegetative auras" -"HP:0011491","Reduced number of corneal endothelial cells" -"HP:0004280","Irregular ossification of hand bones" -"HP:0003648","Lacticaciduria" -"HP:0009108","Aplasia/Hypoplasia involving the femoral head and neck" -"HP:0004764","Myxomatous mitral valve degeneration" -"HP:0000598","Abnormality of the ear" -"HP:0004349","Reduced bone mineral density" -"HP:0007270","Atypical absence seizures" -"HP:0008133","Distal tapering of metatarsals" -"HP:0011026","Aplasia/Hypoplasia of the vagina" -"HP:0040031","Chorioretinal hyperpigmentation" -"HP:0012641","Decreased intracranial pressure" -"HP:0030752","Dacryocystocele" -"HP:0009890","High anterior hairline" -"HP:0040248","Reduced plasminogen activator inhibitor 1 activity" -"HP:0100852","Abnormal fear/anxiety-related behavior" -"HP:0031510","Linear earlobe crease" -"HP:0030214","Hypersexuality" -"HP:0003783","Externally rotated/abducted legs" -"HP:0012635","Iris hypoperfusion" -"HP:0005824","Clinodactyly of the 2nd toe" -"HP:0031206","Striatal T2 hyperintensity" -"HP:0012719","Functional abnormality of the gastrointestinal tract" -"HP:0011468","Facial tics" -"HP:0010473","Porphyrinuria" -"HP:0031511","Diagonal earlobe crease" -"HP:0011489","Abnormal migration of corneal endothelium" -"HP:0030753","Intrauterine fetal demise of one twin after midgestation" -"HP:0004226","Curved distal phalanx of the 5th finger" -"HP:0003436","Prolonged miniature endplate currents" -"HP:0012201","Reduced prothrombin activity" -"HP:0003067","Madelung deformity" -"HP:0030320","Increased intervertebral space" -"HP:0100494","Abnormal mast cell morphology" -"HP:0010313","Breast hypertrophy" -"HP:0030282","Posterior rib gap" -"HP:0006813","Hemiclonic seizures" -"HP:0001562","Oligohydramnios" -"HP:0009161","Aplasia/Hypoplasia of the middle phalanx of the 5th finger" -"HP:0025473","Hyperpigmented papule" -"HP:0007648","Punctate cataract" -"HP:0005572","Decreased renal tubular phosphate excretion" -"HP:0004632","Cervical segmentation defect" -"HP:0012045","Retinal flecks" -"HP:0005987","Multinodular goiter" -"HP:0012093","Abnormality of endocrine pancreas physiology" -"HP:0002622","Dissecting aortic dilatation" -"HP:0000212","Gingival overgrowth" -"HP:0100003","Peritoneal mesothelioma" -"HP:0012448","Delayed myelination" -"HP:0010778","Tracheomegaly" -"HP:0007326","Progressive choreoathetosis" -"HP:0031289","White papule" -"HP:0009894","Thickened ears" -"HP:0025508","Gottron's papules" -"HP:0011303","Convex contour of sole" -"HP:0004812","Pre-B-cell acute lymphoblastic leukemia" -"HP:0009803","Short phalanx of finger" -"HP:0040025","Clinodactyly of the 4th finger" -"HP:0002879","Anisospondyly" -"HP:0040140","Degeneration of the striatum" -"HP:0031239","Extrafoveal choroidal neovascularization" -"HP:0002267","Exaggerated startle response" -"HP:0030552","Visual acuity light perception without projection" -"HP:0001182","Tapered finger" -"HP:0030350","Erythematous papule" -"HP:0004582","Irregularity of vertebral bodies" -"HP:0009267","Ivory epiphysis of the proximal phalanx of the 4th finger" -"HP:0030130","Impaired von Willibrand factor collagen binding activity" -"HP:0006101","Finger syndactyly" -"HP:0005157","Concentric hypertrophic cardiomyopathy" -"HP:0008193","Primary gonadal insufficiency" -"HP:0006989","Dysplastic corpus callosum" -"HP:0031004","Hemiareflexia" -"HP:0025509","Piezogenic pedal papules" -"HP:0001670","Asymmetric septal hypertrophy" -"HP:0100607","Dysmenorrhea" -"HP:0030799","Scaphocephaly" -"HP:0010694","Lamellar pulverulent cataract" -"HP:0100246","Osteoma" -"HP:0012621","Persistent cloaca" -"HP:0003510","Severe short stature" -"HP:0012642","Cerebellar agenesis" -"HP:0002297","Red hair" -"HP:0001363","Craniosynostosis" -"HP:0002225","Sparse pubic hair" -"HP:0010921","Coralliform cataract" -"HP:0002007","Frontal bossing" -"HP:0031436","Increased pitch variability of speech" -"HP:0003880","Sclerotic foci of the humerus" -"HP:0005321","Mandibulofacial dysostosis" -"HP:0000454","Flared nostrils" -"HP:0002522","Areflexia of lower limbs" -"HP:0011220","Prominent forehead" -"HP:0002589","Gastrointestinal atresia" -"HP:0025512","Skin-colored papule" -"HP:0000154","Wide mouth" -"HP:0000062","Ambiguous genitalia" -"HP:0009256","Ivory epiphysis of the distal phalanx of the 4th finger" -"HP:0005892","Proximal tibial and fibular fusion" -"HP:0003996","Flattened radial head" -"HP:0040217","Elevated hemoglobin A1c" -"HP:0008715","Testicular dysgenesis" -"HP:0004618","Sandwich appearance of vertebral bodies" -"HP:0006533","Bronchodysplasia" -"HP:0030637","Cone dysfunction syndrome" -"HP:0000894","Short clavicles" -"HP:0007452","Midface capillary hemangioma" -"HP:0004476","Aplasia cutis congenita over parietal area" -"HP:0004348","Abnormality of bone mineral density" -"HP:0010856","EEG with periodic complexes" -"HP:0009422","Broad distal phalanx of the 3rd finger" -"HP:0006582","Reye syndrome-like episodes" -"HP:0000041","Chordee" -"HP:0430025","Bilateral facial palsy" -"HP:0002732","Lymph node hypoplasia" -"HP:0009292","Broad distal phalanx of the 4th finger" -"HP:0006230","Unilateral oligodactyly" -"HP:0009460","Aplasia of the 3rd finger" -"HP:0009558","Broad distal phalanx of the 2nd finger" -"HP:0000078","Abnormality of the genital system" -"HP:0010764","Short eyelashes" -"HP:0001788","Premature rupture of membranes" -"HP:0031053","Coarctation in the transverse aortic arch" -"HP:0011384","Abnormality of the internal auditory canal" -"HP:0004443","Lambdoidal craniosynostosis" -"HP:0100955","Giant cell granuloma of mandible" -"HP:0010112","Mesoaxial foot polydactyly" -"HP:0002555","Absent pubic hair" -"HP:0001782","Bulbous tips of toes" -"HP:0009123","Mixed hypo- and hyperpigmentation of the skin" -"HP:0011735","Adrenocorticotropin deficient adrenal insufficiency" -"HP:0100291","Abnormality of central somatosensory evoked potentials" -"HP:0007009","Central nervous system degeneration" -"HP:0010877","Unilateral strabismus" -"HP:0009238","Aplasia of the 5th finger" -"HP:0006424","Elongated radius" -"HP:0100566","Amyelia" -"HP:0004749","Atrial flutter" -"HP:0010822","Scintillating scotoma" -"HP:0007479","Congenital nonbullous ichthyosiform erythroderma" -"HP:0030440","Anal margin neoplasm" -"HP:0100692","Increased corneal curvature" -"HP:0011275","Recurrent mycobacterium avium complex infections" -"HP:0011664","Left ventricular noncompaction cardiomyopathy" -"HP:0011643","Coronary sinus atrial septal defect" -"HP:0011138","Abnormality of skin adnexa morphology" -"HP:0100509","Abnormality of vitamin C metabolism" -"HP:0009244","Distal/middle symphalangism of 5th finger" -"HP:0100563","Diastomatomyelia" -"HP:0030281","Cervical C3/C4 vertebral fusion" -"HP:0011351","Moderate receptive language delay" -"HP:3000013","Abnormality of platysma" -"HP:0010188","Curved distal toe phalanx" -"HP:0007286","Horizontal jerk nystagmus" -"HP:0010197","Curved middle toe phalanx" -"HP:0009761","Anterior clefting of vertebral bodies" -"HP:0006262","Aplasia/Hypoplasia of the 5th finger" -"HP:0011896","Subconjunctival hemorrhage" -"HP:0025276","Abnormality of skin adnexa physiology" -"HP:0011371","Recurrent viral skin infections" -"HP:0002174","Postural tremor" -"HP:0003041","Humeroradial synostosis" -"HP:0008432","Anterior wedging of L1" -"HP:0008822","Hypoplastic ischiopubic rami" -"HP:0030187","Titubation" -"HP:3000004","Abnormality of frontalis muscle belly" -"HP:0010061","Curved hallux phalanx" -"HP:0100564","Triplomyelia" -"HP:0009700","Finger symphalangism" -"HP:0100333","Unilateral cleft lip" -"HP:0010362","Curved 3rd toe phalanx" -"HP:0031584","Tessier number 12 facial cleft" -"HP:0025604","Orbital schwannoma" -"HP:0040018","Clinodactyly of hallux" -"HP:0010538","Small sella turcica" -"HP:0100565","Hydromyelia" -"HP:0031604","Agenesis of the carotid canal" -"HP:0006209","Partial-complete absence of 5th phalanges" -"HP:0006069","Severe carpal ossification delay" -"HP:0009684","Stippling of the epiphysis of the distal phalanx of the thumb" -"HP:0011712","Right bundle branch block" -"HP:0005679","Dupuytren contracture" -"HP:0009728","Neoplasm of striated muscle" -"HP:0011132","Chronic furunculosis" -"HP:0003800","Muscle abnormality related to mitochondrial dysfunction" -"HP:0007605","Excessive wrinkling of palmar skin" -"HP:0011565","Common atrium" -"HP:0010617","Cardiac fibroma" -"HP:0000585","Band keratopathy" -"HP:0009465","Ulnar deviation of finger" -"HP:0003445","EMG: neuropathic changes" -"HP:0010991","Abnormality of the abdominal musculature" -"HP:0011531","Vitritis" -"HP:0005885","Absent ossification of cervical vertebral bodies" -"HP:0025014","Subcutaneous spheroids" -"HP:0000889","Abnormality of the clavicle" -"HP:0040146","D-2-hydroxyglutaric acidemia" -"HP:0002558","Supernumerary nipple" -"HP:0030426","Ossifying fibroma" -"HP:0006970","Periventricular leukomalacia" -"HP:0000612","Iris coloboma" -"HP:0003655","Reduced activity of N-acetylglucosaminyltransferase II" -"HP:0012727","Dilatation of the thoracic aorta" -"HP:0011805","Abnormality of muscle morphology" -"HP:0006721","Acute lymphoblastic leukemia" -"HP:0009603","Deviation of the thumb" -"HP:0012243","Abnormal reproductive system morphology" -"HP:0004954","Dilatation of the descending aortic" -"HP:0040212","Risus sardonicus" -"HP:0031026","Snail-like ilia" -"HP:0001710","Conotruncal defect" -"HP:0100309","Subdural hemorrhage" -"HP:0010618","Ovarian fibroma" -"HP:0006768","Localized neuroblastoma" -"HP:0009127","Abnormality of the musculature of the limbs" -"HP:0009595","Occasional neurofibromas" -"HP:0011240","Prominent stem of antihelix" -"HP:0007687","Unilateral ptosis" -"HP:0031293","Digital pitting scar" -"HP:0010071","Osteolytic defects of the 1st metatarsal" -"HP:0007817","Horizontal supranuclear gaze palsy" -"HP:0009724","Subungual fibromas" -"HP:0009317","Deviation of the 3rd finger" -"HP:0009179","Deviation of the 5th finger" -"HP:0006108","Tapered metacarpals" -"HP:0100569","Abnormal vertebral ossification" -"HP:0100039","Thickened cortex of bones" -"HP:0001350","Slurred speech" -"HP:0100698","Subcutaneous neurofibromas" -"HP:0008708","Partial development of the penile shaft" -"HP:0010037","Aplasia of the 2nd metacarpal" -"HP:0031097","Abnormal thyroid-stimulating hormone level" -"HP:0010659","Patchy variation in bone mineral density" -"HP:0007576","Palmar neurofibromas" -"HP:0006751","Paraspinal neurofibromas" -"HP:0000473","Torticollis" -"HP:0003778","Short mandibular rami" -"HP:0009273","Deviation of the 4th finger" -"HP:0000742","Self-mutilation" -"HP:0012118","Laryngeal carcinoma" -"HP:0010043","Aplasia of the 4th metacarpal" -"HP:0008316","Abnormal mitochondria in muscle tissue" -"HP:0005068","Absent styloid process of ulna" -"HP:0003811","Neonatal death" -"HP:0001697","Abnormal pericardium morphology" -"HP:0004961","Pulmonary artery sling" -"HP:0040155","Elevated urinary 3-hydroxybutyric acid" -"HP:0000832","Primary hypothyroidism" -"HP:0010203","Aplasia/hypoplasia of proximal toe phalanx" -"HP:0010172","Triangular epiphyses of the toes" -"HP:0009131","Abnormality of the musculature of the thorax" -"HP:0006827","Atrophy of the spinal cord" -"HP:0005364","Severe viral infections" -"HP:0000191","Accessory oral frenulum" -"HP:0100723","Gastrointestinal stroma tumor" -"HP:0007407","Excessive skin wrinkling on dorsum of hands and fingers" -"HP:0004831","Recurrent thromboembolism" -"HP:0008985","Increased intramuscular fat" -"HP:0040326","Hypoplasia of the olfactory bulb" -"HP:0012846","Multiple trichilemmomata" -"HP:0040019","Finger clinodactyly" -"HP:0100574","Biliary tract neoplasm" -"HP:0025113","Misophonia" -"HP:0012788","Reticulate pigmentation of oral mucosa" -"HP:0011058","Generalized periodontitis" -"HP:0031176","Absent thoracic vertebra" -"HP:0005327","Loss of facial expression" -"HP:0007766","Optic disc hypoplasia" -"HP:0012177","Abnormal natural killer cell physiology" -"HP:0000623","Supranuclear ophthalmoplegia" -"HP:0004571","Widening of cervical spinal canal" -"HP:0004320","Vaginal fistula" -"HP:0003089","Hamstring contractures" -"HP:0040172","Abnormality of occipitofrontalis muscle" -"HP:0040290","Abnormality of skeletal muscles" -"HP:0007976","Cerulean cataract" -"HP:0010619","Fibroadenoma of the breast" -"HP:0007431","Congenital ichthyosiform erythroderma" -"HP:0010920","Zonular cataract" -"HP:0006350","Obliteration of the pulp chamber" -"HP:0100017","Capsular cataract" -"HP:0011773","Uninodular goiter" -"HP:0030498","Macular thickening" -"HP:0031672","Reverse typical atrial flutter" -"HP:0100587","Abnormality of the preputium" -"HP:0010651","Abnormality of the meninges" -"HP:0030404","Glucagonoma" -"HP:0030495","Abnormality of macular vasculature" -"HP:0012059","Lentigo maligna melanoma" -"HP:0100571","Cardiac diverticulum" -"HP:0005324","Disturbance of facial expression" -"HP:0009588","Vestibular Schwannoma" -"HP:0010700","Total cataract" -"HP:0040197","Encephalomalacia" -"HP:0006598","Irregular ossification at anterior rib ends" -"HP:0011506","Choroidal neovascularization" -"HP:0004445","Elliptocytosis" -"HP:0011075","Green teeth" -"HP:0007305","CNS demyelination" -"HP:0010892","Abnormality of branched chain family amino acid metabolism" -"HP:0002403","Positive Romberg sign" -"HP:0009593","Peripheral Schwannoma" -"HP:0010922","Membranous cataract" -"HP:0030011","Imperforate hymen" -"HP:0003524","Decreased methionine synthase activity" -"HP:0010972","Anemia of inadequate production" -"HP:0011553","Discordant atrioventricular connection" -"HP:0030895","Abnormal gastrointestinal motility" -"HP:0004329","Abnormality of the posterior segment of the globe" -"HP:0025252","Geographic tongue" -"HP:0030917","Low APGAR score" -"HP:0011325","Pansynostosis" -"HP:0031105","Abnormal uterus morphology" -"HP:0003358","Elevated intracellular cystine" -"HP:0030601","Abnormal posterior segment imaging" -"HP:0001118","Juvenile cataract" -"HP:0007658","Large hyperpigmented retinal spots" -"HP:0200000","Dysharmonic bone age" -"HP:0100011","Scleral schwannoma" -"HP:0031151","Vitreomacular traction" -"HP:0006818","Type I lissencephaly" -"HP:0000493","Abnormality of the fovea" -"HP:0009349","Enlarged epiphysis of the proximal phalanx of the 3rd finger" -"HP:0004355","Abnormality of proteoglycan metabolism" -"HP:0000608","Macular degeneration" -"HP:0100316","Hirano bodies" -"HP:0009141","Depletion of mitochondrial DNA in muscle tissue" -"HP:0030056","Uncombable hair" -"HP:0100835","Benign neoplasm of the central nervous system" -"HP:0011508","Macular hole" -"HP:0031044","Type A5 brachydactyly" -"HP:0009790","Hemisacrum" -"HP:0031150","Vitreomacular adhesion" -"HP:0009773","Symphalangism affecting the phalanges of the hand" -"HP:0008002","Abnormality of macular pigmentation" -"HP:0007377","Abnormality of somatosensory evoked potentials" -"HP:0010558","Abnormality of the clivus" -"HP:0007408","Tegumentary leishmaniasis susceptibility" -"HP:0007892","Hypoplasia of the lacrimal puncta" -"HP:0000635","Blue irides" -"HP:0008119","Deformed tarsal bones" -"HP:0001864","Clinodactyly of the 5th toe" -"HP:0002286","Fair hair" -"HP:0100738","Abnormal eating behavior" -"HP:0007023","Antenatal intracerebral hemorrhage" -"HP:0008247","Euthyroid hyperthyroxinemia" -"HP:0008097","Partial fusion of tarsals" -"HP:0007819","Presenile cataracts" -"HP:0012313","Heberden's node" -"HP:0003456","Low urinary cyclic AMP response to PTH administration" -"HP:0100961","Enlarged hippocampus" -"HP:0009331","Triangular epiphysis of the middle phalanx of the 3rd finger" -"HP:0001092","Absent lacrimal punctum" -"HP:0007581","Mediosternal, longitudinal streak of hypopigmentation" -"HP:0006882","Severe hydrocephalus" -"HP:0100175","Ivory epiphysis of the distal phalanx of the 4th toe" -"HP:0030746","Intraventricular hemorrhage" -"HP:0007188","Congenital facial diplegia" -"HP:0011309","Tapered toe" -"HP:0100197","Ivory epiphysis of the proximal phalanx of the 4th toe" -"HP:0003080","Hydroxyprolinuria" -"HP:0010591","Abnormality of the proximal tibial epiphysis" -"HP:0007178","Motor polyneuropathy" -"HP:0002145","Frontotemporal dementia" -"HP:0012793","Kinked brainstem" -"HP:0000223","Abnormality of taste sensation" -"HP:0005510","Transient erythroblastopenia" -"HP:0011642","Abnormal coronary sinus morphology" -"HP:0002643","Neonatal respiratory distress" -"HP:0008047","Abnormality of the vasculature of the eye" -"HP:0030414","Verrucous cell carcinoma of the tongue" -"HP:0001017","Anemic pallor" -"HP:0004296","Abnormality of gastrointestinal vasculature" -"HP:0010681","Elevated intestinal alkaline phosphatase" -"HP:0009004","Hypoplasia of the musculature" -"HP:0004361","Abnormality of circulating leptin level" -"HP:0011448","Ankle clonus" -"HP:0003460","Total immunoglobulin A deficiency" -"HP:0006790","Cerebral cortex with spongiform changes" -"HP:3000036","Abnormality of head blood vessel" -"HP:0001803","Nail pits" -"HP:0000873","Diabetes insipidus" -"HP:0010665","Bilateral coxa valga" -"HP:0002549","Deficit in phonologic short-term memory" -"HP:0030831","Rhonchi" -"HP:0005650","Cutaneous syndactyly between fingers 2 and 5" -"HP:0002832","Calcific stippling" -"HP:0003449","Cold-induced muscle cramps" -"HP:0003613","Antiphospholipid antibody positivity" -"HP:0011830","Abnormality of oral mucosa" -"HP:0008754","Laryngeal calcification" -"HP:0000935","Thickened cortex of long bones" -"HP:0025016","Abnormal capillary morphology" -"HP:0002656","Epiphyseal dysplasia" -"HP:0009164","Abnormal calcification of the carpal bones" -"HP:0011496","Corneal neovascularization" -"HP:0030667","Peripheral retinal neovascularization" -"HP:0003710","Exercise-induced muscle cramps" -"HP:0031465","Abnormal vasa vasorum morphology" -"HP:0002187","Intellectual disability, profound" -"HP:0006488","Bowing of the arm" -"HP:0031323","Myocardial eosinophilic infiltration" -"HP:0040288","Nasogastric tube feeding" -"HP:0006414","Distal tibial bowing" -"HP:0000885","Broad ribs" -"HP:0000086","Ectopic kidney" -"HP:0030468","Abnormal multifocal electroretinogram" -"HP:0030962","Abnormal morphology of the great vessels" -"HP:0003447","Axonal loss" -"HP:0003514","Deficiency or absence of cytochrome b(-245)" -"HP:0004948","Vascular tortuosity" -"HP:0000795","Abnormality of the urethra" -"HP:0002508","Brainstem dysplasia" -"HP:0010934","Xanthinuria" -"HP:0010682","Elevated placental alkaline phosphatase" -"HP:0002512","Brain stem compression" -"HP:0002189","Excessive daytime sleepiness" -"HP:0005567","Renal magnesium wasting" -"HP:0030467","Abnormal pattern electroretinogram" -"HP:0000023","Inguinal hernia" -"HP:0007396","Early cutaneous photosensitivity" -"HP:0011939","3-4 finger cutaneous syndactyly" -"HP:0004403","Proximal esophageal atresia" -"HP:0011441","Abnormality of the medulla oblongata" -"HP:0002921","Abnormality of the cerebrospinal fluid" -"HP:0012340","Decreased resting energy expenditure" -"HP:0001331","Absent septum pellucidum" -"HP:0002446","Astrocytosis" -"HP:0002179","Opisthotonus" -"HP:0011624","Apical muscular ventricular septal defect" -"HP:0000103","Polyuria" -"HP:0006144","Shortening of all proximal phalanges of the fingers" -"HP:0010297","Bifid tongue" -"HP:3000060","Abnormality of infraorbital artery" -"HP:0007361","Abnormality of the pons" -"HP:0030245","Intrapartum fever" -"HP:0008890","Severe short-limb dwarfism" -"HP:0002667","Nephroblastoma" -"HP:0002213","Fine hair" -"HP:0002418","Abnormality of midbrain morphology" -"HP:0011403","Abnormal umbilical cord blood vessels" -"HP:0002780","Bronchomalacia" -"HP:0011861","Bilateral trilobed lungs" -"HP:0001636","Tetralogy of Fallot" -"HP:0010978","Abnormality of immune system physiology" -"HP:0011600","Abnormal direction of ventricular apex" -"HP:0010788","Testicular neoplasm" -"HP:0030186","Kinetic tremor" -"HP:0100695","Lipedema" -"HP:0030061","Neuroectodermal neoplasm" -"HP:0009109","Denervation of the diaphragm" -"HP:0011895","Anemia due to reduced life span of red cells" -"HP:0006088","1-5 finger complete cutaneous syndactyly" -"HP:0009459","Short proximal phalanx of the 3rd finger" -"HP:0001015","Prominent superficial veins" -"HP:3000037","Abnormality of neck blood vessel" -"HP:0004415","Pulmonary artery stenosis" -"HP:0012750","T2 hypointense brainstem" -"HP:0000029","Testicular atrophy" -"HP:0031321","Myocardial immune cell infiltration" -"HP:0000487","Congenital strabismus" -"HP:0012578","Membranous nephropathy" -"HP:0002997","Abnormality of the ulna" -"HP:0007717","Chronic irritative conjunctivitis" -"HP:0010168","Ivory epiphyses of the toes" -"HP:0012847","Epilepsia partialis continua" -"HP:0004924","Abnormal oral glucose tolerance" -"HP:0004026","Broad radial metaphysis" -"HP:0000444","Convex nasal ridge" -"HP:0001125","Transient unilateral blurring of vision" -"HP:0006176","Two carpal ossification centers present at birth" -"HP:0012668","Vasovagal syncope" -"HP:0025410","Splenogonadal fusion" -"HP:0000767","Pectus excavatum" -"HP:0031091","Toe dactylitis" -"HP:0006323","Premature loss of primary teeth" -"HP:0000458","Anosmia" -"HP:0007042","Focal white matter lesions" -"HP:0008327","Microscopic nephrocalcinosis" -"HP:0005939","Multiple bilateral pneumothoraces" -"HP:0006596","Restricted chest movement" -"HP:0001844","Abnormality of the hallux" -"HP:0012762","Cerebral white matter atrophy" -"HP:0000924","Abnormality of the skeletal system" -"HP:0031013","Ankylosis" -"HP:0030301","Abnormality of the anterior commissure" -"HP:0010547","Muscle flaccidity" -"HP:0030084","Clinodactyly" -"HP:0006248","Limited wrist movement" -"HP:0008596","Postlingual sensorineural hearing impairment" -"HP:0010501","Limitation of knee mobility" -"HP:0006274","Reduced pancreatic beta cells" -"HP:0025059","Splenic abscess" -"HP:0012362","Abnormal sialylation of O-linked protein glycosylation" -"HP:0031317","Fatty replacement of ventricular myocardial tissue" -"HP:0010878","Fetal cystic hygroma" -"HP:0200041","Skin erosion" -"HP:0004050","Absent hand" -"HP:0030415","Sarcomatoid carcinoma of the tongue" -"HP:0010230","Cone-shaped epiphyses of the phalanges of the hand" -"HP:0003654","Reduced dihydropyrimidine dehydrogenase activity" -"HP:0010811","Narrow uvula" -"HP:0031475","Nonconvulsive status epilepticus" -"HP:0012056","Cutaneous melanoma" -"HP:0005352","Severe T-cell immunodeficiency" -"HP:0003758","Reduced subcutaneous adipose tissue" -"HP:0000700","Periapical bone loss" -"HP:0011352","Severe receptive language delay" -"HP:0008078","Thin metatarsal cortices" -"HP:0002673","Coxa valga" -"HP:0012723","Sinoatrial block" -"HP:0010321","Abnormality of the 4th toe" -"HP:0010666","Hypoplasia of the anterior nasal spine" -"HP:0011305","Partial absence of toe" -"HP:0010237","Epiphyseal stippling of finger phalanges" -"HP:0006812","White mater abnormalities in the posterior periventricular region" -"HP:0003950","Flared elbow metaphyses" -"HP:0011771","Autoimmune hypoparathyroidism" -"HP:0000932","Abnormality of the posterior cranial fossa" -"HP:0006203","Decreased movement range in interphalangeal joints" -"HP:0009710","Chilblain lesions" -"HP:0000327","Hypoplasia of the maxilla" -"HP:0006291","Marked delay in eruption of permanent teeth" -"HP:0005193","Restricted large joint movement" -"HP:0007346","Subcortical white matter calcifications" -"HP:0012557","EEG with centrotemporal focal spike waves" -"HP:0006476","Abnormality of the pancreatic islet cells" -"HP:0012223","Splenic rupture" -"HP:0010505","Limitation of movement at ankles" -"HP:0002266","Focal clonic seizures" -"HP:0001571","Multiple impacted teeth" -"HP:0006659","Internally rotated shoulders" -"HP:0002215","Sparse axillary hair" -"HP:0045004","Abnormal ossification of the trapezoid bone" -"HP:0007502","Follicular hyperkeratosis" -"HP:0007754","Macular dystrophy" -"HP:0003472","Hypocalcemic tetany" -"HP:0009751","Aplasia of the pectoralis major muscle" -"HP:0030890","Hyperintensity of cerebral white matter on MRI" -"HP:0008887","Adipose tissue loss" -"HP:0030276","Small scrotum" -"HP:0012073","Abnormal urinary acylglycine profile" -"HP:0025409","Abnormal spleen physiology" -"HP:0010452","Ectopia of the spleen" -"HP:0010320","Abnormality of the 3rd toe" -"HP:0004442","Sagittal craniosynostosis" -"HP:0003214","Prolonged G2 phase of cell cycle" -"HP:0003044","Shoulder flexion contracture" -"HP:0003338","Focal necrosis of right ventricular muscle cells" -"HP:0010879","Postnatal cystic hygroma" -"HP:0025167","Fragmented elastic fibers in the dermis" -"HP:0031014","Arteria lusoria" -"HP:0025152","Poor visual behavior for age" -"HP:0030824","Mizuo phenomenon" -"HP:0009046","Difficulty running" -"HP:0001471","Aplasia/Hypoplasia of the musculature of the pelvis" -"HP:0031252","Dilated left subclavian artery" -"HP:0010404","Aplasia/Hypoplasia of the middle phalanx of the 2nd toe" -"HP:0000188","Short upper lip" -"HP:0010027","Broad 1st metacarpal" -"HP:0007398","Asymmetric, linear skin defects" -"HP:0012492","Cerebral artery stenosis" -"HP:0011069","Increased number of teeth" -"HP:0006170","Chess-pawn distal phalanges" -"HP:0005104","Hypoplastic nasal septum" -"HP:0006494","Aplasia/Hypoplasia involving bones of the feet" -"HP:0001718","Mitral stenosis" -"HP:0030604","Abnormal fundus fluorescein angiography" -"HP:0002307","Drooling" -"HP:0040210","Abnormal level of biopterin" -"HP:0006467","Limited shoulder movement" -"HP:0007799","Conjunctival whitish salt-like deposits" -"HP:0011727","Peroneal muscle weakness" -"HP:0005360","Susceptibility to chickenpox" -"HP:0005211","Midgut malrotation" -"HP:0004392","Prune belly" -"HP:0011494","Generalized opacification of the cornea" -"HP:0006943","Diffuse spongiform leukoencephalopathy" -"HP:0100292","Amyloidosis of peripheral nerves" -"HP:0011915","Cardiovascular calcification" -"HP:0100028","Ectopic thyroid" -"HP:0002464","Spastic dysarthria" -"HP:0010961","Intralobar sequestration" -"HP:0009783","Biceps aplasia" -"HP:0012022","Congenital portosystemic venous shunt" -"HP:0000531","Corneal crystals" -"HP:0003974","Absent radius" -"HP:0010772","Anomalous pulmonary venous return" -"HP:0008082","Medial deviation of the foot" -"HP:0004496","Posterior choanal atresia" -"HP:0011708","Mobitz II atrioventricular block" -"HP:0100780","Conjunctival hamartoma" -"HP:0007522","Increased number of skin folds" -"HP:0030528","Paracentral scotoma" -"HP:0030430","Neuroma" -"HP:0010631","Abnormality of the epiphyses of the feet" -"HP:0100628","Esophageal diverticulum" -"HP:0005144","Left ventricular septal hypertrophy" -"HP:0100662","Chondritis" -"HP:0007656","Lacrimal gland aplasia" -"HP:0004414","Abnormality of the pulmonary artery" -"HP:0005109","Abnormality of the Achilles tendon" -"HP:0005667","Os odontoideum" -"HP:0007076","Extrapyramidal muscular rigidity" -"HP:0001626","Abnormality of the cardiovascular system" -"HP:0012672","Akinetic mutism" -"HP:0100374","Aplasia/Hypoplasia of the middle phalanx of the 5th toe" -"HP:0000294","Low anterior hairline" -"HP:0010977","Abnormality of phagocytes" -"HP:0031253","Anomalous origin of left subclavian artery" -"HP:0025354","Abnormal cellular phenotype" -"HP:0011538","Atrial situs inversus" -"HP:0011382","Hypoplasia of the semicircular canal" -"HP:0011541","Criss-cross atrioventricular valves" -"HP:0008425","Cuboid-shaped thoracolumbar vertebral bodies" -"HP:0008132","Medial rotation of the medial malleolus" -"HP:0011219","Short face" -"HP:0000736","Short attention span" -"HP:0007508","Punctate palmar hyperkeratosis" -"HP:0100644","Melanonychia" -"HP:0012416","Hypercapnia" -"HP:0010846","EEG with persistent abnormal rhythmic activity" -"HP:0001832","Abnormality of the metatarsal bones" -"HP:0012748","Focal T2 hyperintense brainstem lesion" -"HP:0031633","Isolation of the left subclavian artery" -"HP:0010754","Abnormality of the temporomandibular joint" -"HP:0008011","Peripheral opacification of the cornea" -"HP:0009016","Upper limb muscle hypoplasia" -"HP:0011543","Superior-inferior ventricles without criss-cross atrioventricular valves" -"HP:0001436","Abnormality of the foot musculature" -"HP:0031189","Wrist drop" -"HP:0012219","Erythema nodosum" -"HP:0040044","Hypoplasia of the diaphragm" -"HP:0008357","Reduced factor XIII activity" -"HP:0031632","Anomalous origin of the right subclavian artery from the descending aorta" -"HP:0008424","Hypoplastic 5th lumbar vertebrae" -"HP:0025476","Testicular lipomatosis" -"HP:0001839","Split foot" -"HP:0010794","Impaired visuospatial constructive cognition" -"HP:0010854","EEG with generalized low amplitude activity" -"HP:0001685","Myocardial fibrosis" -"HP:0008233","Decreased circulating progesterone" -"HP:0011031","Abnormality of iron homeostasis" -"HP:0012849","Small intestinal bleeding" -"HP:0001134","Anterior polar cataract" -"HP:0025513","Scleral rupture" -"HP:0008962","Calf muscle hypoplasia" -"HP:0100372","Aplasia/Hypoplasia of the middle phalanx of the 3rd toe" -"HP:0000202","Oral cleft" -"HP:0010483","Amniotic constriction rings of arms" -"HP:0010414","Broad distal phalanx of the 2nd toe" -"HP:0006070","Metacarpophalangeal joint contracture" -"HP:0011493","Central opacification of the cornea" -"HP:0025384","Diet-resistant subcutaneous adipose tissue" -"HP:0006352","Failure of eruption of permanent teeth" -"HP:0002074","Increased neuronal autofluorescent lipopigment" -"HP:0003406","Peripheral nerve compression" -"HP:0030854","Scleral staphyloma" -"HP:0002691","Platybasia" -"HP:0012798","Pulmonary lymphangiomyomatosis" -"HP:0002287","Progressive alopecia" -"HP:0001308","Tongue fasciculations" -"HP:0025434","Reduced hemolytic complement activity" -"HP:0008677","Congenital nephrotic syndrome" -"HP:0002692","Hypoplastic facial bones" -"HP:0010215","Contractures of the metatarsophalangeal joint of the hallux" -"HP:0430028","Hyperplasia of the maxilla" -"HP:0012018","EEG with temporal focal spikes" -"HP:0010485","Hyperextensibility at elbow" -"HP:0010883","Aortic valve atresia" -"HP:0012046","Areflexia of upper limbs" -"HP:0030185","Isometric tremor" -"HP:0005873","Polysyndactyly of hallux" -"HP:0012420","Meconium stained amniotic fluid" -"HP:0002761","Generalized joint laxity" -"HP:0030236","Abnormality of muscle size" -"HP:0030898","Pruritis on abdomen" -"HP:0001719","Double outlet right ventricle" -"HP:0008909","Lethal short-limbed short stature" -"HP:0031229","Increased incisura length" -"HP:0030724","Central nervous system cyst" -"HP:0008277","Abnormality of zinc homeostasis" -"HP:0030242","Portal vein thrombosis" -"HP:0006426","Rudimentary to absent tibiae" -"HP:0006932","Transient psychotic episodes" -"HP:0012217","Increased urinary porphobilinogen" -"HP:0010045","Aplasia/Hypoplasia of the 5th metacarpal" -"HP:0012443","Abnormality of brain morphology" -"HP:0010496","Hypertrophy of the lower limb" -"HP:0005639","Hyperextensible hand joints" -"HP:0030899","Pruritis on hand" -"HP:0001821","Broad nail" -"HP:0045087","Hip joint hypermobility" -"HP:0030901","Pruritis on breast" -"HP:0031610","Recurrent should dislocation" -"HP:0010510","Hypermobility of toe joints" -"HP:0005508","Monoclonal immunoglobulin M proteinemia" -"HP:0030885","Recurrent parasitic infections" -"HP:0100353","Contracture of the distal interphalangeal joint of the 3rd toe" -"HP:0031455","Presacral ganglioneuroma" -"HP:0000571","Hypometric saccades" -"HP:0025203","Caput medusae" -"HP:0012746","Thin toenail" -"HP:0006717","Peripheral neuroepithelioma" -"HP:0025402","Square-wave jerks" -"HP:0011445","Athetoid cerebral palsy" -"HP:0100006","Neoplasm of the central nervous system" -"HP:0010717","Osseous syndactyly of toes" -"HP:0000653","Sparse eyelashes" -"HP:0002928","Decreased activity of the pyruvate dehydrogenase complex" -"HP:0030142","Abnormal bowel sounds" -"HP:0002143","Abnormality of the spinal cord" -"HP:0030900","Pruritus on foot" -"HP:0410043","Abnormal neural tube morphology" -"HP:0012588","Steroid-resistant nephrotic syndrome" -"HP:0000917","Superior pectus carinatum" -"HP:0012260","Abnormal central microtubular pair morphology of respiratory motile cilia" -"HP:0010624","Aplastic/hypoplastic toenail" -"HP:0012089","Arteritis" -"HP:0030161","Vaginal pruritus" -"HP:0031282","Malalignment of the great toenail" -"HP:0007183","Focal T2 hyperintense basal ganglia lesion" -"HP:0012511","Temporal optic disc pallor" -"HP:0100349","Contracture of the proximal interphalangeal joint of the 3rd toe" -"HP:0100357","Contracture of the metatarsophalangeal joint of the 3rd toe" -"HP:0025180","Centrilobular ground-glass opacification on pulmonary HRCT" -"HP:0012456","Medial arterial calcification" -"HP:0007311","Short stepped shuffling gait" -"HP:0007017","Progressive forgetfulness" -"HP:0001345","Psychotic mentation" -"HP:0031122","Two-raphe bicuspid aortic valve" -"HP:0003011","Abnormality of the musculature" -"HP:0007158","Progressive extrapyramidal muscular rigidity" -"HP:0007338","Hypermetric saccades" -"HP:0006094","Finger joint hypermobility" -"HP:0000381","Stapes ankylosis" -"HP:0008455","Dysplastic sacrum" -"HP:0002793","Abnormal pattern of respiration" -"HP:0005620","Hypermobility of interphalangeal joints" -"HP:0008393","Congenital curved nail of fourth toe" -"HP:0000679","Taurodontia" -"HP:0004250","Proximally placed lunate" -"HP:0007973","Retinal dysplasia" -"HP:0007367","Atrophy/Degeneration affecting the central nervous system" -"HP:0010542","Vestibular nystagmus" -"HP:0045086","Knee joint hypermobility" -"HP:0012589","Multidrug-resistant nephrotic syndrome" -"HP:0000641","Dysmetric saccades" -"HP:0002153","Hyperkalemia" -"HP:0200034","Papule" -"HP:0004438","Hyperostosis frontalis interna" -"HP:0000131","Uterine leiomyoma" -"HP:0011736","Primary hyperaldosteronism" -"HP:0002521","Hypsarrhythmia" -"HP:0004732","Impaired renal uric acid clearance" -"HP:0011344","Severe global developmental delay" -"HP:0012031","Lipomatous tumor" -"HP:0000609","Optic nerve hypoplasia" -"HP:0009958","Polydactyly affecting the 3rd finger" -"HP:0005111","Dilatation of the ascending aorta" -"HP:0001518","Small for gestational age" -"HP:0001274","Agenesis of corpus callosum" -"HP:0005855","Multiple prenatal fractures" -"HP:0007626","Mandibular osteomyelitis" -"HP:0100864","Short femoral neck" -"HP:0001555","Asymmetry of the thorax" -"HP:0012033","Sacral lipoma" -"HP:0100444","Curved middle phalanx of the 4th toe" -"HP:0009575","Triangular shaped middle phalanx of the 2nd finger" -"HP:0001792","Small nail" -"HP:0002135","Basal ganglia calcification" -"HP:0000709","Psychosis" -"HP:0003265","Neonatal hyperbilirubinemia" -"HP:0010691","Mirror image foot polydactyly" -"HP:0007650","Progressive ophthalmoplegia" -"HP:0005404","Increase in B cell number" -"HP:0000582","Upslanted palpebral fissure" -"HP:0009659","Partial absence of thumb" -"HP:0007334","Generalized tonic-clonic seizures with focal onset" -"HP:0100611","Multiple glomerular cysts" -"HP:0002983","Micromelia" -"HP:0100761","Visceral angiomatosis" -"HP:0030814","Orange discoloured tonsils" -"HP:0000886","Deformed rib cage" -"HP:0001171","Split hand" -"HP:0010626","Anterior pituitary agenesis" -"HP:0100805","Precocious menopause" -"HP:0007477","Abnormal dermatoglyphics" -"HP:0005548","Megakaryocytopenia" -"HP:0000073","Ureteral duplication" -"HP:0001820","Leukonychia" -"HP:0100592","Peritoneal abscess" -"HP:0008255","Transient neonatal diabetes mellitus" -"HP:0100583","Corneal perforation" -"HP:0007131","Acute demyelinating polyneuropathy" -"HP:0000632","Lacrimation abnormality" -"HP:0200120","Chronic active hepatitis" -"HP:0003300","Ovoid vertebral bodies" -"HP:0009017","Loss of gluteal subcutaneous adipose tissue" -"HP:0002360","Sleep disturbance" -"HP:0004871","Perineal fistula" -"HP:0000545","Myopia" -"HP:0010634","Total hyposmia" -"HP:0003384","Peripheral axonal atrophy" -"HP:0010511","Long toe" -"HP:0000182","Movement abnormality of the tongue" -"HP:0030369","Induced vaginal delivery" -"HP:0009938","Sunken cheeks" -"HP:0009324","Enlarged epiphysis of the middle phalanx of the 3rd finger" -"HP:0000786","Primary amenorrhea" -"HP:0002247","Duodenal atresia" -"HP:0001901","Polycythemia" -"HP:0007556","Plantar hyperkeratosis" -"HP:0009704","Chronic CSF lymphocytosis" -"HP:0100387","Aplasia of the middle phalanges of the toes" -"HP:0011897","Neutrophilia" -"HP:0012660","Thalamic hypometabolism in FDG PET" -"HP:0000046","Scrotal hypoplasia" -"HP:0011154","Focal autonomic seizures" -"HP:0030449","Therapeutic abortion" -"HP:0007486","Cavernous hemangioma of the face" -"HP:0045054","Brachial plexus neuropathy" -"HP:0007464","Sparse facial hair" -"HP:0005574","Non-acidotic proximal tubulopathy" -"HP:0012101","Decreased serum creatinine" -"HP:0008993","Increased intraabdominal fat" -"HP:0410074","Increased level of xylitol in urine" -"HP:0010834","Trophic changes related to pain" -"HP:0100785","Insomnia" -"HP:0012552","Increased neutrophil nuclear projections" -"HP:0006740","Transitional cell carcinoma of the bladder" -"HP:3000033","Abnormality of nasopharyngeal adenoids" -"HP:0012072","aciduria" -"HP:0009777","Absent thumb" -"HP:0002077","Migraine with aura" -"HP:0025521","Increased body fat percentage" -"HP:0009968","Partial duplication of the distal phalanx of the 3rd finger" -"HP:0100312","Cerebral germinoma" -"HP:0004724","Calcium nephrolithiasis" -"HP:0025607","Upper eyelid entropion" -"HP:0011161","Olfactory auras" -"HP:0011961","Non-obstructive azoospermia" -"HP:0002503","Spinocerebellar tract degeneration" -"HP:0025429","Abnormal cry" -"HP:0008991","Exercise-induced leg cramps" -"HP:0031736","Involutional entropion" -"HP:0030723","Congenital megalourethra" -"HP:0100271","Hyponasal speech" -"HP:0031737","Cicatricial entropion" -"HP:0030503","Macular telangiectasia" -"HP:0006321","Multiple non-erupting secondary teeth" -"HP:0005238","Discrete intestinal polyps" -"HP:0005369","Decreased serum complement factor H" -"HP:0011563","Abnormal ventriculo-arterial connection" -"HP:0410005","Cleft hard palate" -"HP:0003795","Short middle phalanx of toe" -"HP:0500006","Urethritis" -"HP:0010863","Receptive language delay" -"HP:0010242","Aplasia of the proximal phalanges of the hand" -"HP:0007970","Congenital ptosis" -"HP:0010733","Naevus flammeus of the eyelid" -"HP:0001123","Visual field defect" -"HP:0008722","Urethral diverticulum" -"HP:0006064","Limited interphalangeal movement" -"HP:0012371","Hyperplasia of midface" -"HP:0030291","Lower-limb metaphyseal irregularity" -"HP:0001476","Delayed closure of the anterior fontanelle" -"HP:0009769","Bullet-shaped phalanges of the hand" -"HP:0009088","Speech articulation difficulties" -"HP:0040167","Facial papilloma" -"HP:0005356","Decreased serum complement factor I" -"HP:0004404","Abnormal nipple morphology" -"HP:0031009","Ainhum" -"HP:0009371","Type A1 brachydactyly" -"HP:0006575","Intrahepatic cholestasis with episodic jaundice" -"HP:0011162","Psychic auras" -"HP:0011259","Expanded terminal portion of crus of helix" -"HP:0008706","Distal urethral duplication" -"HP:0000587","Abnormality of the optic nerve" -"HP:0007230","Decreased distal sensory nerve action potential" -"HP:0001033","Facial flushing after alcohol intake" -"HP:0006681","Absent atrioventricular node" -"HP:0009899","Prominent crus of helix" -"HP:0011335","Frontal hirsutism" -"HP:0011160","Gustatory auras" -"HP:0012163","Carotid artery dilatation" -"HP:0006955","Olivopontocerebellar hypoplasia" -"HP:0100779","Urogenital sinus anomaly" -"HP:0000119","Abnormality of the genitourinary system" -"HP:0012760","Impaired social reciprocity" -"HP:0011223","Metopic depression" -"HP:0010480","Urethral fistula" -"HP:0010314","Premature thelarche" -"HP:0006873","Symmetrical progressive peripheral demyelination" -"HP:0100186","Ivory epiphysis of the middle phalanx of the 4th toe" -"HP:0100601","Eclampsia" -"HP:0007220","Demyelinating motor neuropathy" -"HP:0001998","Neonatal hypoglycemia" -"HP:0030879","Interlobular septal thickening on pulmonary HRCT" -"HP:0025130","Decreased small intestinal mucosa lactase activity" -"HP:0100727","Histiocytosis" -"HP:0005339","Abnormality of complement system" -"HP:0012548","Fatty replacement of skeletal muscle" -"HP:0410009","Abnormality of the somatic nervous system" -"HP:0040321","Dark yellow urine" -"HP:0000026","Male hypogonadism" -"HP:0005857","Cervical spina bifida" -"HP:0100061","Ivory epiphyses of the 3rd toe" -"HP:0030685","Decreased adiponectin level" -"HP:0003267","Reduced orotidine 5-prime phosphate decarboxylase activity" -"HP:0003130","Abnormal peripheral myelination" -"HP:0430003","Abnormality of the palatine bone" -"HP:0031001","Minifascicle formation" -"HP:0008850","Severe postnatal growth retardation" -"HP:0012408","Medullary nephrocalcinosis" -"HP:0000963","Thin skin" -"HP:0012331","Abnormal autonomic nervous system morphology" -"HP:0012598","Abnormal urine potassium concentration" -"HP:0002342","Intellectual disability, moderate" -"HP:0006802","Abnormal anterior horn cell morphology" -"HP:0000124","Renal tubular dysfunction" -"HP:0003382","Hypertrophic nerve changes" -"HP:0100275","Diffuse cerebellar atrophy" -"HP:0030643","Vitelliform-like retinal lesions" -"HP:0100323","Juvenile aseptic necrosis" -"HP:0002804","Arthrogryposis multiplex congenita" -"HP:0011813","Increased cerebral lipofuscin" -"HP:0000820","Abnormality of the thyroid gland" -"HP:0025393","Reticulonodular pattern on pulmonary HRCT" -"HP:0030973","Postexertional malaise" -"HP:0100007","Neoplasm of the peripheral nervous system" -"HP:0002136","Broad-based gait" -"HP:0012268","Myxoid liposarcoma" -"HP:0025396","Decreased attenuation pattern on pulmonary HRCT" -"HP:0010864","Intellectual disability, severe" -"HP:0025392","Nodular pattern on pulmonary HRCT" -"HP:0012780","Neoplasm of the ear" -"HP:0000272","Malar flattening" -"HP:0030507","Retinal crystals" -"HP:0007263","Spinocerebellar atrophy" -"HP:0025277","Gustatory sweating" -"HP:0012080","Cerebellar granular layer atrophy" -"HP:0031205","Reduced lysosomal acid lipase activity" -"HP:0003405","Diffuse axonal swelling" -"HP:0010686","Low alkaline phosphatase of hepatic origin" -"HP:0009771","Osteolytic defects of the phalanges of the hand" -"HP:0007948","Dense posterior cortical cataract" -"HP:0012553","Hypoplastic thumbnail" -"HP:0004326","Cachexia" -"HP:0003643","Sulfite oxidase deficiency" -"HP:0000857","Neonatal insulin-dependent diabetes mellitus" -"HP:0031562","Balanced double aortic arch" -"HP:0011644","Coronary sinus diverticulum" -"HP:0100817","Renovascular hypertension" -"HP:0025395","Combined cystic and ground-glass pattern on pulmonary HRCT" -"HP:0007592","Aplasia/Hypoplastia of the eccrine sweat glands" -"HP:0000233","Thin vermilion border" -"HP:0003443","Decreased size of nerve terminals" -"HP:0004379","Abnormality of alkaline phosphatase activity" -"HP:0045010","Abnormality of peripheral nerves" -"HP:0008619","Bilateral sensorineural hearing impairment" -"HP:0009891","Underdeveloped supraorbital ridges" -"HP:0003009","Enhanced neurotoxicity of vincristine" -"HP:0031373","Stiff tongue" -"HP:0011147","Typical absence seizures" -"HP:0000164","Abnormality of the dentition" -"HP:0012320","Absent pigmentation of the limbs" -"HP:0040291","Skeletal muscle steatosis" -"HP:0001765","Hammertoe" -"HP:0011278","Intrapulmonary sequestration" -"HP:0003991","Osteosclerosis of the ulna" -"HP:0005841","Calcific stippling of infantile cartilaginous skeleton" -"HP:0002980","Femoral bowing" -"HP:0002627","Right aortic arch with mirror image branching" -"HP:0010791","Hyperplasia of the Leydig cells" -"HP:0012582","Bilateral renal dysplasia" -"HP:0001167","Abnormality of finger" -"HP:0004795","Hamartomatous stomach polyps" -"HP:0030321","Abnormal vertebral artery morphology" -"HP:0001469","Abnormality of the musculature of the pelvis" -"HP:0005116","Arterial tortuosity" -"HP:0011626","Scimitar anomaly" -"HP:3000073","Abnormality of levator veli palatini muscle" -"HP:0000931","Thinning and bulging of the posterior fossa bones" -"HP:0007634","Nonarteritic anterior ischemic optic neuropathy" -"HP:0001041","Facial erythema" -"HP:0410027","Alveolar bone loss around teeth" -"HP:0003956","Bowed forearm bones" -"HP:0004761","Post-angioplasty coronary artery restenosis" -"HP:0001281","Tetany" -"HP:0010720","Abnormal hair pattern" -"HP:0100322","Aplasia of the pyramidal tract" -"HP:0004258","Small trapezoid bone" -"HP:0008733","Dysplastic testes" -"HP:0031251","Abnormal subclavian artery morphology" -"HP:0011519","Anomalous trichromacy" -"HP:0010881","Abnormality of the umbilical cord" -"HP:0000782","Abnormality of the scapula" -"HP:0010170","Small epiphyses of the toes" -"HP:0012020","Right aortic arch" -"HP:0010924","Posterior cortical cataract" -"HP:0001311","Abnormal nervous system electrophysiology" -"HP:0004247","Small scaphoid" -"HP:0008138","Equinus calcaneus" -"HP:0009689","Enlarged thumb epiphysis" -"HP:0100616","Testicular teratoma" -"HP:0002836","Bladder exstrophy" -"HP:0011446","Abnormality of higher mental function" -"HP:0010178","Patchy sclerosis of toe phalanx" -"HP:0001679","Abnormal aortic morphology" -"HP:0030708","Myeloschisis" -"HP:0012180","Cystic medial necrosis" -"HP:0011536","Right atrial isomerism" -"HP:0009770","Curved phalanges of the hand" -"HP:0010710","3-5 finger syndactyly" -"HP:0000075","Renal duplication" -"HP:0040234","Factor XIII subunit B deficiency" -"HP:0002200","Pseudobulbar signs" -"HP:0011883","Abnormal platelet granules" -"HP:0003844","Small epiphyses of the upper limbs" -"HP:0009514","Bracket epiphysis of the middle phalanx of the 2nd finger" -"HP:0012759","Neurodevelopmental abnormality" -"HP:3000049","Abnormal greater palatine artery morphology" -"HP:0006704","Abnormal coronary artery morphology" -"HP:0000190","Abnormality of oral frenula" -"HP:0012640","Abnormality of intracranial pressure" -"HP:0025388","Thyroid nodule" -"HP:0040286","Abnormality of axial muscles" -"HP:0005294","Arterial dissection" -"HP:0002435","Meningocele" -"HP:0012733","Macule" -"HP:0010386","Curved 5th toe phalanx" -"HP:3000067","Abnormal lateral cricoarytenoid muscle morphology" -"HP:0006442","Hypoplasia of proximal fibula" -"HP:0002888","Ependymoma" -"HP:0011310","Bridged palmar crease" -"HP:0005736","Short tibia" -"HP:0031310","Basilar artery calcification" -"HP:0030438","Anal canal squamous cell carcinoma" -"HP:0100774","Hyperostosis" -"HP:0000600","Abnormality of the pharynx" -"HP:0009112","Absent left hemidiaphragm" -"HP:0011750","Neoplasm of the anterior pituitary" -"HP:0012375","Chemosis" -"HP:0003865","Bowed humerus" -"HP:0005743","Avascular necrosis of the capital femoral epiphysis" -"HP:0004799","Jejunoileal diverticula" -"HP:0030344","Decreased circulating luteinizing hormone level" -"HP:0004622","Progressive intervertebral space narrowing" -"HP:0001996","Chronic metabolic acidosis" -"HP:0200032","Kayser-Fleischer ring" -"HP:0010603","Odontogenic keratocysts of the jaw" -"HP:0012657","Abnormal brain positron emission tomography" -"HP:0010374","Curved 4th toe phalanx" -"HP:0004736","Crossed fused renal ectopia" -"HP:0012208","Nonmotile sperm" -"HP:0010029","Curved 1st metacarpal" -"HP:0002091","Restrictive ventilatory defect" -"HP:0009145","Abnormal cerebral artery morphology" -"HP:0000375","Abnormal cochlea morphology" -"HP:0006517","Alveolar proteinosis" -"HP:0010769","Pilonidal sinus" -"HP:0040045","Abnormality of the hemidiaphragms" -"HP:0000268","Dolichocephaly" -"HP:0045018","Partial duplication of eyebrows" -"HP:0000630","Abnormal retinal artery morphology" -"HP:0000298","Mask-like facies" -"HP:0012344","Morphea" -"HP:0030055","Hyperconvex toenail" -"HP:0011442","Abnormality of central motor function" -"HP:0100541","Femoral hernia" -"HP:0009062","Infantile axial hypotonia" -"HP:0003440","Horizontal sacrum" -"HP:0010350","Curved 2nd toe phalanx" -"HP:0012284","Small proximal tibial epiphyses" -"HP:0000301","Abnormality of facial musculature" -"HP:0012447","Abnormal myelination" -"HP:0100555","Asymmetric growth" -"HP:0005344","Abnormal carotid artery morphology" -"HP:0011388","Enlarged cochlear aqueduct" -"HP:0007716","Intraocular melanoma" -"HP:0006554","Acute hepatic failure" -"HP:0005765","Sacral meningocele" -"HP:0040007","Absent pigmentation of chest" -"HP:0025498","Aceruloplasminemia" -"HP:0011730","Abnormality of central sensory function" -"HP:0010206","Curved proximal toe phalanx" -"HP:0000349","Widow's peak" -"HP:0007108","Demyelinating peripheral neuropathy" -"HP:0011350","Mild receptive language delay" -"HP:0003161","4-Hydroxyphenylpyruvic aciduria" -"HP:0005347","Cartilaginous trachea" -"HP:0005003","Aplasia/Hypoplasia of the capital femoral epiphysis" -"HP:0001723","Restrictive cardiomyopathy" -"HP:0430009","Hypoplasia of eyelid" -"HP:0004002","Flattened radial epiphyses" -"HP:0011844","Abnormal appendicular skeleton morphology" -"HP:0004330","Increased skull ossification" -"HP:0031160","Myelokathexis" -"HP:0007763","Retinal telangiectasia" -"HP:0003895","Flattened humeral epiphyses" -"HP:0100618","Leydig cell neoplasia" -"HP:0002817","Abnormality of the upper limb" -"HP:0007876","Juvenile cortical cataract" -"HP:0005758","Basilar impression" -"HP:0000905","Progressive clavicular acroosteolysis" -"HP:0000916","Broad clavicles" -"HP:0006600","Progressive calcification of costochondral cartilage" -"HP:0011942","Increased urinary sulfite" -"HP:0000841","Hyperactive renin-angiotensin system" -"HP:0004234","Bone-in-a-bone appearance of carpal bones" -"HP:0005069","Rhizo-meso-acromelic limb shortening" -"HP:0003777","Pili torti" -"HP:0009794","Branchial anomaly" -"HP:0011614","Interrupted aortic arch type C" -"HP:0025162","Severe temper tantrums" -"HP:0012711","Delayed ossification of vertebral epiphysis" -"HP:0001232","Nail bed telangiectasia" -"HP:0012054","Choroidal melanoma" -"HP:0000234","Abnormality of the head" -"HP:0000607","Periorbital wrinkles" -"HP:0004771","Premature graying of body hair" -"HP:0005700","Increased bone density with cystic changes" -"HP:0003219","Ethylmalonic aciduria" -"HP:0011612","Interrupted aortic arch type A" -"HP:0005103","Calcification of the auricular cartilage" -"HP:0008127","Bipartite calcaneus" -"HP:0002289","Alopecia universalis" -"HP:0007583","Telangiectasia macularis eruptiva perstans" -"HP:0001869","Deep plantar creases" -"HP:0030178","Abnormality of central nervous system electrophysiology" -"HP:0010444","Pulmonary insufficiency" -"HP:0025008","Tracheal tug on inspiration" -"HP:0012573","Global proximal tubulopathy" -"HP:0010560","Undulate clavicles" -"HP:0011539","Atrial situs ambiguous" -"HP:0002925","Increased thyroid-stimulating hormone level" -"HP:0012285","Abnormal hypothalamus physiology" -"HP:0012449","Sacroiliac joint synovitis" -"HP:0001611","Nasal speech" -"HP:0002353","EEG abnormality" -"HP:0007756","Slitlike anterior chamber angles in children" -"HP:0006089","Palmar hyperhidrosis" -"HP:0008451","Posterior vertebral hypoplasia" -"HP:0009110","Diaphragmatic eventration" -"HP:0008463","Central vertebral hypoplasia" -"HP:0001322","Brain very small" -"HP:0011375","Cochlear aplasia" -"HP:0012745","Short palpebral fissure" -"HP:0001806","Onycholysis" -"HP:0006645","Thin clavicles" -"HP:0000220","Velopharyngeal insufficiency" -"HP:0000652","Lower eyelid coloboma" -"HP:0030137","Prolonged bleeding following circumcision" -"HP:0011419","Placental abruption" -"HP:0004291","Stippled calcification of hand bones" -"HP:0005967","Mixed respiratory and metabolic acidosis" -"HP:0007204","Diffuse white matter abnormalities" -"HP:0025154","Portosystemic collateral veins" -"HP:0031602","Abnormal mucociliary clearance" -"HP:0000253","Progressive microcephaly" -"HP:0008465","Absent vertebra" -"HP:0002296","Progressive hypotrichosis" -"HP:0011718","Abnormality of the pulmonary veins" -"HP:0007110","Central hypoventilation" -"HP:0008075","Progressive pes cavus" -"HP:0011577","Partial atrioventricular canal defect" -"HP:0006591","Absent glenoid fossa" -"HP:0012303","Abnormal aortic arch morphology" -"HP:0003175","Hypoplastic ischia" -"HP:0007164","Slowed slurred speech" -"HP:0005413","Increased alpha-globulin" -"HP:0100350","Contracture of the proximal interphalangeal joint of the 4th toe" -"HP:0003435","Cold-induced hand cramps" -"HP:0004880","Respiratory infections in early life" -"HP:0030878","Abnormality on pulmonary function testing" -"HP:0012245","Sex reversal" -"HP:0030893","Abnormal response to short acting pulmonary vasodilator" -"HP:0100545","Arterial stenosis" -"HP:0011671","Interrupted inferior vena cava with azygous continuation" -"HP:0040304","Duplication of the sella turcica" -"HP:0031231","Narrow incisura width" -"HP:0012242","Superior rectus atrophy" -"HP:0000922","Posterior rib cupping" -"HP:0012256","Absent outer dynein arms" -"HP:0006453","Lateral displacement of the femoral head" -"HP:0010967","Abnormality of carnitine metabolism" -"HP:0005622","Broad long bones" -"HP:0009653","Curved thumb phalanx" -"HP:0008777","Abnormality of the vocal cords" -"HP:0031458","Adenoiditis" -"HP:0000221","Furrowed tongue" -"HP:0005195","Polyarticular arthropathy" -"HP:0004691","2-3 toe syndactyly" -"HP:0008984","Neck muscle hypoplasia" -"HP:0004629","Small cervical vertebral bodies" -"HP:0002461","Dense calcifications in the cerebellar dentate nucleus" -"HP:0006471","Fixed elbow flexion" -"HP:0000678","Dental crowding" -"HP:0000890","Long clavicles" -"HP:0002918","Hypermagnesemia" -"HP:0031165","Multifocal seizures" -"HP:0100653","Optic neuritis" -"HP:0008444","Posterior wedging of vertebral bodies" -"HP:0010470","Supernumerary testes" -"HP:0008434","Hypoplastic cervical vertebrae" -"HP:0004794","Malrotation of small bowel" -"HP:0004890","Elevated pulmonary artery pressure" -"HP:0007559","Localized epidermolytic hyperkeratosis" -"HP:0200117","Recurrent upper and lower respiratory tract infections" -"HP:0011354","Generalized abnormality of skin" -"HP:0003550","Predominantly lower limb lymphedema" -"HP:0008473","Narrow anterio-posterior vertebral body diameter" -"HP:0001065","Striae distensae" -"HP:0012236","Elevated sweat chloride" -"HP:0031309","Cerebral artery calcification" -"HP:0009927","Aplasia of the nose" -"HP:0007936","Restrictive external ophthalmoplegia" -"HP:0012259","Absent inner and outer dynein arms" -"HP:0030707","Unilateral lung agenesis" -"HP:0006283","Multiple unerupted teeth" -"HP:0008449","Progressive cervical vertebral spine fusion" -"HP:0000927","Abnormality of skeletal maturation" -"HP:0001477","Compensatory chin elevation" -"HP:0100528","Pleuropulmonary blastoma" -"HP:0009804","Reduced number of teeth" -"HP:0030953","Conjunctival hyperemia" -"HP:0006099","Metacarpophalangeal joint hyperextensibility" -"HP:0004619","Lumbar kyphoscoliosis" -"HP:0005534","Transient myeloproliferative syndrome" -"HP:0002398","Degeneration of anterior horn cells" -"HP:0001159","Syndactyly" -"HP:0002199","Hypocalcemic seizures" -"HP:0007395","Postnatal-onset ichthyosiform erythroderma" -"HP:0001162","Postaxial hand polydactyly" -"HP:0001437","Abnormality of the musculature of the lower limbs" -"HP:0012241","Levator palpebrae superioris atrophy" -"HP:0025161","Frequent temper tantrums" -"HP:0001655","Patent foramen ovale" -"HP:0011629","Total absence of the pericardium" -"HP:0008981","Calf muscle hypertrophy" -"HP:0012441","Sphincter of Oddi dyskinesia" -"HP:0011630","Complete diaphragmatic absence of pericardium" -"HP:0009124","Abnormality of adipose tissue" -"HP:0002501","Spasticity of pharyngeal muscles" -"HP:0100492","Joint contractures involving the joints of the feet" -"HP:0005105","Abnormal nasal morphology" -"HP:0012354","Increased fucosylation of N-linked protein glycosylation" -"HP:0010213","Contracture of the tarsometatarsal joint of the hallux" -"HP:0011929","Hypersegmentation of proximal phalanx of third finger" -"HP:0006153","Disharmonious carpal bone" -"HP:0008122","Calcaneonavicular fusion" -"HP:0005941","Intermittent hyperpnea at rest" -"HP:0030692","Brain neoplasm" -"HP:0004197","Symphalangism of the 4th finger" -"HP:0009827","Amelia" -"HP:0000674","Anodontia" -"HP:0005450","Calvarial osteosclerosis" -"HP:0005876","Progressive flexion contractures" -"HP:0011631","Complete right sided absence of pericardium" -"HP:0000065","Labial hypertrophy" -"HP:0008765","Auditory hallucinations" -"HP:0009504","Cone-shaped epiphysis of the distal phalanx of the 2nd finger" -"HP:0031404","Impaired antigen-specific response" -"HP:0005997","Restricted neck movement due to contractures" -"HP:0001847","Long hallux" -"HP:0003719","Muscle mounding" -"HP:0100329","Tarsometatarsal synostosis" -"HP:0010224","Abnormality of the epiphysis of the 4th metacarpal" -"HP:0011635","Partial diaphragmatic absence of pericardium" -"HP:0011090","Fused teeth" -"HP:0006346","Screwdriver-shaped incisors" -"HP:0002597","Abnormality of the vasculature" -"HP:0001049","Absent dorsal skin creases over affected joints" -"HP:0011032","Abnormality of fluid regulation" -"HP:0005974","Episodic ketoacidosis" -"HP:0025013","Decerebrate rigidity" -"HP:0000849","Adrenocortical abnormality" -"HP:0011706","Second degree atrioventricular block" -"HP:0005505","Refractory anemia" -"HP:0006110","Shortening of all middle phalanges of the fingers" -"HP:0011156","Focal autonomic seizures without altered responsiveness" -"HP:0012517","Reduced catalase activity" -"HP:0005363","Humoral immunodeficiency" -"HP:0100859","Dilatation of superior mesenteric artery" -"HP:0000085","Horseshoe kidney" -"HP:0011705","First degree atrioventricular block" -"HP:0004255","Small trapezium" -"HP:0030166","Night sweats" -"HP:0001959","Polydipsia" -"HP:0005802","Coalescence of tarsal bones" -"HP:0003855","Spurred metaphyses of the upper limbs" -"HP:0002396","Cogwheel rigidity" -"HP:0001319","Neonatal hypotonia" -"HP:0011633","Complete left sided absence of pericardium" -"HP:0000668","Hypodontia" -"HP:0011044","Abnormal number of permanent teeth" -"HP:0000331","Short chin" -"HP:0008281","Acute hyperammonemia" -"HP:0000798","Oligospermia" -"HP:0005682","Talocalcaneal synostosis" -"HP:0000556","Retinal dystrophy" -"HP:0000633","Decreased lacrimation" -"HP:0002753","Thin bony cortex" -"HP:0001545","Anteriorly placed anus" -"HP:0001258","Spastic paraplegia" -"HP:0010804","Tented upper lip vermilion" -"HP:0012248","Prolonged PR interval" -"HP:0009941","Asymmetry of the mouth" -"HP:0008820","Absent ossification of capital femoral epiphysis" -"HP:0007822","Central retinal exudate" -"HP:0009526","Cone-shaped epiphysis of the proximal phalanx of the 2nd finger" -"HP:0009003","Increased subcutaneous truncal adipose tissue" -"HP:0006559","Hepatic calcification" -"HP:0002613","Biliary cirrhosis" -"HP:0004463","Absent brainstem auditory responses" -"HP:0009845","Bullet-shaped middle phalanges of the hand" -"HP:0009711","Retinal capillary hemangioma" -"HP:0100250","Meningeal calcification" -"HP:0004926","Orthostatic hypotension due to autonomic dysfunction" -"HP:0008633","Absent gonadal tissue" -"HP:0000105","Enlarged kidney" -"HP:0012757","Abnormal neuron morphology" -"HP:0031232","Increased incisura width" -"HP:0004573","Anterior wedging of T11" -"HP:0006844","Absent patellar reflexes" -"HP:0003797","Limb-girdle muscle atrophy" -"HP:0000746","Delusions" -"HP:0200057","Marcus Gunn pupil" -"HP:0100020","Posterior capsular cataract" -"HP:0040251","Hand dimples" -"HP:0031230","Decreased incisura length" -"HP:0009464","Ulnar deviation of the 2nd finger" -"HP:0004430","Severe combined immunodeficiency" -"HP:0008202","Prolactin deficiency" -"HP:0012778","Retinal astrocytic hamartoma" -"HP:0008213","Gonadotropin deficiency" -"HP:0010359","Aplasia/Hypoplasia of the phalanges of the 3rd toe" -"HP:0002715","Abnormality of the immune system" -"HP:0003736","Autophagic vacuoles" -"HP:0010652","Abnormality of the dura mater" -"HP:0012848","Small intestinal stenosis" -"HP:0030509","Retinal racemose hemangioma" -"HP:0012036","Sternocleidomastoid amyotrophy" -"HP:0010102","Aplasia of the distal phalanx of the hallux" -"HP:0001395","Hepatic fibrosis" -"HP:0002493","Upper motor neuron dysfunction" -"HP:0010303","Abnormality of the spinal meninges" -"HP:0007082","Dilated third ventricle" -"HP:0006391","Overtubulated long bones" -"HP:0011368","Epidermal thickening" -"HP:0030081","Punctate periventricular T2 hyperintense foci" -"HP:0009049","Peroneal muscle atrophy" -"HP:0008915","Childhood-onset truncal obesity" -"HP:0009372","Type A2 brachydactyly" -"HP:0003957","Cortical thickening of the forearm bones" -"HP:0040033","Aplasia/Hypoplasia of the fifth metatarsal bone" -"HP:0100263","Distal symphalangism" -"HP:0009552","Aplasia/Hypoplasia of the phalanges of the 2nd finger" -"HP:0003357","Thymic hormone decreased" -"HP:0004809","Neonatal alloimmune thrombocytopenia" -"HP:0009376","Aplasia/Hypoplasia of the phalanges of the 5th finger" -"HP:0011094","Overbite" -"HP:0006175","Proximal phalangeal periosteal thickening" -"HP:0008529","Absence of acoustic reflex" -"HP:0012216","Entrapment neuropathy of suprascapular nerve" -"HP:0000132","Menorrhagia" -"HP:0011111","Abnormality of immune serum protein physiology" -"HP:0003665","Amyotrophy of the musculature of the pelvis" -"HP:0100433","Broad distal phalanx of the 5th toe" -"HP:0005990","Thyroid hypoplasia" -"HP:0040103","Cutaneous stenosis of the external auditory canal" -"HP:0005272","Prominent nasolabial fold" -"HP:0007221","Progressive truncal ataxia" -"HP:0005164","Dysplastic pulmonary valve" -"HP:0003697","Scapuloperoneal amyotrophy" -"HP:0000584","Punctate corneal epithelial erosions" -"HP:0100701","Abnormality of the pia mater" -"HP:0012858","Decreased scrotal rugation" -"HP:0400007","Polymenorrhea" -"HP:0006193","Thimble-shaped middle phalanges of hand" -"HP:0100705","Abnormality of the glial cells" -"HP:0010627","Anterior pituitary hypoplasia" -"HP:0031055","Abnormal branching pattern of left aortic arch" -"HP:0005655","Multiple digital exostoses" -"HP:0000376","Incomplete partition of the cochlea type II" -"HP:0030510","Combined hamartoma of the retinal pigment epithelium and retina" -"HP:0010601","Abnormality of the proximal ulnar epiphysis" -"HP:0012037","Pectoralis amyotrophy" -"HP:0001059","Pterygium" -"HP:0025157","Increased urinary sedoheptulose" -"HP:0009816","Lower limb undergrowth" -"HP:0007808","Bilateral retinal coloboma" -"HP:0030200","Fatiguable weakness of proximal limb muscles" -"HP:0410066","Increased level of hippuric acid in urine" -"HP:0001984","Intolerance to protein" -"HP:0012184","Increased circulating high-density lipoprotein levels" -"HP:0002787","Tracheal calcification" -"HP:0025112","Sound sensitivity" -"HP:3000034","Abnormality of cartilage of nasal septum" -"HP:0030843","Cardiac amyloidosis" -"HP:0000912","Sprengel anomaly" -"HP:0012550","Colonic varices" -"HP:0025533","Peau d'orange" -"HP:0001963","Abnormal speech discrimination" -"HP:0010185","Aplasia/Hypoplasia of the distal phalanges of the toes" -"HP:0025472","Recurrent plantar mycosis" -"HP:0006729","Retroperitoneal chemodectomas" -"HP:0002864","Paraganglioma of head and neck" -"HP:0000757","Lack of insight" -"HP:0030190","Oral motor hypotonia" -"HP:0005042","Irregular, rachitic-like metaphyses" -"HP:0000696","Delayed eruption of permanent teeth" -"HP:0004411","Deviated nasal septum" -"HP:0006781","Hurthle cell thyroid adenoma" -"HP:0011985","Acholic stools" -"HP:0012389","Appendicular hypotonia" -"HP:0006552","Fibrocystic lung disease" -"HP:0000162","Glossoptosis" -"HP:0100879","Enlarged ovaries" -"HP:0011334","Facial shape deformation" -"HP:0012377","Hemianopia" -"HP:0001812","Hyperconvex fingernails" -"HP:0011087","Talon cusp" -"HP:0045055","Tiger tail banding" -"HP:0003875","Humeral lytic defects" -"HP:0008470","Lower thoracic interpediculate narrowness" -"HP:0001046","Intermittent jaundice" -"HP:0010304","Spinal meningeal diverticulum" -"HP:0031403","Impaired pathogen-specific CD8 cytoxicity" -"HP:0000433","Abnormality of the nasal mucosa" -"HP:0005407","Decreased number of CD4+ T cells" -"HP:0025507","Yellow papule" -"HP:0000732","Inflexible adherence to routines or rituals" -"HP:0012440","Abnormal biliary tract morphology" -"HP:0009713","Spinal hemangioblastoma" -"HP:0009027","Foot dorsiflexor weakness" -"HP:0006489","Abnormality of the femoral metaphysis" -"HP:0100501","Recurrent bronchiolitis" -"HP:0003944","Narrow joint spaces of the elbow" -"HP:0100636","Pulmonary paraglioma" -"HP:0012262","Abnormal ciliary motility" -"HP:0011880","Acute disseminated intravascular coagulation" -"HP:0004399","Congenital pyloric atresia" -"HP:0100010","Spinal meningioma" -"HP:0008800","Limited hip movement" -"HP:0006055","Ulnar deviated club hands" -"HP:0001141","Severe visual impairment" -"HP:0010637","Conjunctival amyloidosis" -"HP:0100851","Abnormal emotion/affect behavior" -"HP:0012888","Abnormality of the uterine cervix" -"HP:0001283","Bulbar palsy" -"HP:0007750","Hypoplasia of the fovea" -"HP:0011148","Absence seizures with special features" -"HP:0025356","Pschomotor retardation" -"HP:0012579","Minimal change glomerulonephritis" -"HP:0008744","Abnormality of the aryepiglottic fold" -"HP:0006595","Scapulohumeral synostosis" -"HP:0008390","Recurrent loss of toenails and fingernails" -"HP:0003027","Mesomelia" -"HP:0000295","Doll-like facies" -"HP:0011777","Thyroid papillary adenoma" -"HP:0003103","Abnormal cortical bone morphology" -"HP:0011774","Thyroid follicular adenoma" -"HP:0009023","Abdominal wall muscle weakness" -"HP:0200067","Recurrent spontaneous abortion" -"HP:0100558","Hemiatrophy of upper limb" -"HP:0000680","Delayed eruption of primary teeth" -"HP:0001341","Olfactory lobe agenesis" -"HP:0025479","Self-neglect" -"HP:0001816","Thin nail" -"HP:0000721","Lack of spontaneous play" -"HP:0012214","Increased glomerular filtration rate" -"HP:0006640","Multiple rib fractures" -"HP:0100880","Nephrogenic rest" -"HP:0011440","Alcohol-induced rhabdomyolysis" -"HP:0012120","Methylmalonic aciduria" -"HP:0007417","Discoid lupus rash" -"HP:0040202","Abnormal consumption behavior" -"HP:0002453","Abnormality of the globus pallidus" -"HP:0000976","Eczematoid dermatitis" -"HP:0012457","Medial calcification of medium-sized arteries" -"HP:0001053","Hypopigmented skin patches" -"HP:0030858","Addictive behavior" -"HP:0001878","Hemolytic anemia" -"HP:0001227","Abnormality of the thenar eminence" -"HP:0011091","Gemination" -"HP:0410033","Unilateral alveolar cleft of maxilla" -"HP:0000193","Bifid uvula" -"HP:0002421","Poor head control" -"HP:0003646","Bicarbonaturia" -"HP:0000297","Facial hypotonia" -"HP:0001808","Fragile nails" -"HP:0010770","Pilonidal fistula" -"HP:0031466","Impairment in personality functioning" -"HP:0005520","Chronic disseminated intravascular coagulation" -"HP:0004713","Reversible renal failure" -"HP:0001030","Fragile skin" -"HP:0004966","Medial calcification of large arteries" -"HP:0000619","Impaired convergence" -"HP:0000171","Microglossia" -"HP:0000941","Short diaphyses" -"HP:0008454","Lumbar kyphosis" -"HP:0000320","Bird-like facies" -"HP:0007074","Thick corpus callosum" -"HP:0003701","Proximal muscle weakness" -"HP:0011359","Dry hair" -"HP:0004617","Butterfly vertebral arch" -"HP:0005598","Facial telangiectasia in butterfly midface distribution" -"HP:0007957","Corneal opacity" -"HP:0031370","Small intestinal perforation" -"HP:0100839","Hepatic agenesis" -"HP:0002859","Rhabdomyosarcoma" -"HP:0005100","Premature birth following premature rupture of fetal membranes" -"HP:0006763","Anal canal squamous carcinoma" -"HP:0012058","Nodular melanoma" -"HP:0003307","Hyperlordosis" -"HP:0000265","Mastoiditis" -"HP:0031140","Abnormal liver sonography" -"HP:0003144","Increased serum serotonin" -"HP:0001692","Primary atrial arrhythmia" -"HP:0100634","Neuroendocrine neoplasm" -"HP:0030053","Stiff skin" -"HP:0010761","Broad columella" -"HP:0025249","Comedo" -"HP:0006707","Abnormality of the hepatic vasculature" -"HP:3000061","Abnormality of infra-orbital nerve" -"HP:0001716","Wolff-Parkinson-White syndrome" -"HP:0009765","Low hanging columella" -"HP:0100594","Esophageal web" -"HP:0000968","Ectodermal dysplasia" -"HP:0002851","Elevated proportion of CD4-negative, CD8-negative, alpha-beta regulatory T cells" -"HP:0000446","Narrow nasal bridge" -"HP:0030853","Heterotaxy" -"HP:0031137","Storage in hepatocytes" -"HP:0005115","Supraventricular arrhythmia" -"HP:0030722","Ectopic liver" -"HP:0030411","Jejunal adenocarcinoma" -"HP:0100752","Abnormal liver lobulation" -"HP:0008074","Metatarsal periosteal thickening" -"HP:0100648","Neoplasm of the tongue" -"HP:0009714","Abnormality of the epididymis" -"HP:0011690","Permanent junctional reciprocating tachycardia" -"HP:0045061","Decreased carnitine level in liver" -"HP:0001278","Orthostatic hypotension" -"HP:0003328","Abnormal hair laboratory examination" -"HP:0005261","Joint hemorrhage" -"HP:0100841","Microgastria" -"HP:0010615","Angiofibromas" -"HP:0410060","Decreased level of D-mannose in urine" -"HP:0031326","Monoclonal light chain cardiac amyloidosis" -"HP:0003645","Prolonged partial thromboplastin time" -"HP:0003469","Peripheral dysmyelination" -"HP:0007778","Posterior retinal neovascularization" -"HP:0025510","Nevus spillus" -"HP:0030821","Hooded lower eyelid" -"HP:0007470","Periarticular subcutaneous nodules" -"HP:0007881","Central corneal dystrophy" -"HP:0005217","Duplication of internal organs" -"HP:0025245","Cutaneous cyst" -"HP:0006106","Absent trapezoid bone" -"HP:0040134","Abnormal hepatic iron concentration" -"HP:0008065","Aplasia/Hypoplasia of the skin" -"HP:0006437","Disproportionate prominence of the femoral medial condyle" -"HP:0031501","Pelvic mass" -"HP:0009730","Rhabdomyoma" -"HP:0031146","Impaired oral bolus formation" -"HP:0010715","2-5 toe syndactyly" -"HP:0008972","Decreased activity of mitochondrial respiratory chain" -"HP:0003306","Spinal rigidity" -"HP:0031285","Abnormal perifollicular morphology" -"HP:0011054","Agenesis of molar" -"HP:0030300","10 pairs of ribs" -"HP:0008323","Abnormal light- and dark-adapted electroretinogram" -"HP:0012280","Hepatic amyloidosis" -"HP:0005584","Renal cell carcinoma" -"HP:0040100","Abnormality of the vestibular window" -"HP:0011769","Ectopic parathyroid" -"HP:0000615","Abnormality of the pupil" -"HP:0004510","Pancreatic islet-cell hyperplasia" -"HP:0006298","Prolonged bleeding after dental extraction" -"HP:0007266","Cerebral dysmyelination" -"HP:0012415","Abnormal blood gas level" -"HP:0005305","Cerebral venous thrombosis" -"HP:0000452","Choanal stenosis" -"HP:0030424","Epididymal cyst" -"HP:0007510","Focal dermal aplasia/hypoplasia" -"HP:0012541","Cephalohematoma" -"HP:0045074","Thin eyebrow" -"HP:0000818","Abnormality of the endocrine system" -"HP:0100493","Hypoammonemia" -"HP:0002671","Basal cell carcinoma" -"HP:0002705","High, narrow palate" -"HP:0001531","Failure to thrive in infancy" -"HP:0003461","Increased urinary O-linked sialopeptides" -"HP:0030625","Hyporeflective spaces on macular OCT" -"HP:0005680","Tongue-like lumbar vertebral deformities" -"HP:0001884","Talipes calcaneovalgus" -"HP:0000813","Bicornuate uterus" -"HP:0012166","Skin-picking" -"HP:0100649","Neoplasm of the oral cavity" -"HP:0000471","Gastrointestinal angiodysplasia" -"HP:0004472","Mandibular hyperostosis" -"HP:0005184","Prolonged QTc interval" -"HP:0003115","Abnormal EKG" -"HP:0001058","Poor wound healing" -"HP:0025181","Abdominal aseptic abscess" -"HP:0025022","Decreased erythrocyte sedimentation rate" -"HP:0031020","Bone marrow hypercellularity" -"HP:0006581","Depletion of mitochondrial DNA in liver" -"HP:0003715","Myofibrillar myopathy" -"HP:0006217","Limited mobility of proximal interphalangeal joint" -"HP:0025527","Serpiginous cutaneous lesion" -"HP:0031607","Pelvic organ prolapse" -"HP:0031057","Skin fissure" -"HP:0040165","Periostitis" -"HP:0007229","Intracerebral periventricular calcifications" -"HP:0012857","Increased scrotal rugation" -"HP:0010307","Stridor" -"HP:0006498","Aplasia/Hypoplasia of the patella" -"HP:0000627","Posterior embryotoxon" -"HP:0002009","Potter facies" -"HP:0030610","Photoreceptor outer segment loss on macular OCT" -"HP:0002216","Premature graying of hair" -"HP:0025528","Annular cutaneous lesion" -"HP:0000995","Melanocytic nevus" -"HP:0200044","Porokeratosis" -"HP:0002304","Akinesia" -"HP:0009353","Pseudoepiphysis of the proximal phalanx of the 3rd finger" -"HP:0010022","Pseudoepiphysis of the 1st metacarpal" -"HP:0006698","Dilatation of the ventricular cavity" -"HP:0000775","Abnormality of the diaphragm" -"HP:0007450","Increased groin pigmentation with raindrop depigmentation" -"HP:0008668","Gonadal dysgenesis, male" -"HP:0001117","Sudden loss of visual acuity" -"HP:0001181","Adducted thumb" -"HP:0100310","Epidural hemorrhage" -"HP:0008093","Short 4th toe" -"HP:0006610","Wide intermamillary distance" -"HP:0011789","Thyroid-stimulating hormone receptor defect" -"HP:0006668","Twelfth rib hypoplasia" -"HP:0009671","Pseudoepiphysis of the proximal phalanx of the thumb" -"HP:0007760","Crystalline corneal dystrophy" -"HP:0002313","Spastic paraparesis" -"HP:0000467","Neck muscle weakness" -"HP:0005336","Forehead hyperpigmentation" -"HP:0004340","Abnormality of vitamin B metabolism" -"HP:0003759","Hypoplasia of lymphatic vessels" -"HP:0001874","Abnormality of neutrophils" -"HP:0005643","Short 3rd toe" -"HP:0001837","Broad toe" -"HP:0000888","Horizontal ribs" -"HP:0100823","Genital hernia" -"HP:0006801","Hyperactive deep tendon reflexes" -"HP:0000176","Submucous cleft hard palate" -"HP:0004826","Folate-unresponsive megaloblastic anemia" -"HP:0007831","Nonprogressive restrictive external ophthalmoplegia" -"HP:0000576","Centrocecal scotoma" -"HP:0001073","Cigarette-paper scars" -"HP:0011661","Anomalous origin of left pulmonary artery from ascending aorta" -"HP:0004855","Reduced protein S activity" -"HP:0000008","Abnormality of female internal genitalia" -"HP:0000993","Molluscoid pseudotumors" -"HP:0009200","Pseudoepiphysis of the proximal phalanx of the 5th finger" -"HP:0100612","Odontogenic neoplasm" -"HP:0003074","Hyperglycemia" -"HP:0011971","Dermatographic urticaria" -"HP:0005242","Extrahepatic biliary duct atresia" -"HP:0010583","Ivory epiphyses" -"HP:0002173","Hypoglycemic seizures" -"HP:0000646","Amblyopia" -"HP:0003298","Spina bifida occulta" -"HP:0007572","Hyperpigmented streaks" -"HP:0012851","Colonic stenosis" -"HP:0008263","Thyroid defect in oxidation and organification of iodide" -"HP:0011166","Focal myoclonic seizures" -"HP:0009069","Lethal infantile mitochondrial myopathy" -"HP:0100686","Enthesitis" -"HP:0009268","Pseudoepiphysis of the proximal phalanx of the 4th finger" -"HP:0000800","Cystic renal dysplasia" -"HP:0030239","Hypoplasia of the upper arm musculature" -"HP:0012852","Hepatic bridging fibrosis" -"HP:0001187","Hyperextensibility of the finger joints" -"HP:0011977","Elevated urinary homovanillic acid" -"HP:0030955","Alcoholism" -"HP:0012506","Small pituitary gland" -"HP:0000483","Astigmatism" -"HP:0012189","Hodgkin lymphoma" -"HP:0007199","Progressive spastic paraparesis" -"HP:0006992","Anterior basal encephalocele" -"HP:0009294","Absent middle phalanx of 4th finger" -"HP:0040035","Abnormality of the fourth metatarsal bone" -"HP:0003320","C1-C2 subluxation" -"HP:0009412","Cone-shaped epiphyses of the 3rd finger" -"HP:0009811","Abnormality of the elbow" -"HP:0002650","Scoliosis" -"HP:0010567","Y-shaped metatarsals" -"HP:0011349","Abducens palsy" -"HP:0009291","Aplasia of the distal phalanx of the 4th finger" -"HP:0031448","Herpetiform vesicles" -"HP:0011376","Morphological abnormality of the vestibule of the inner ear" -"HP:0000408","Progressive sensorineural hearing impairment" -"HP:0100630","Neoplasia of the nasopharynx" -"HP:0045026","Abnormality of the mediastinum" -"HP:0010085","Aplasia/Hypoplasia of the proximal phalanx of the hallux" -"HP:0008963","Tibialis muscle weakness" -"HP:0006511","Laryngeal stridor" -"HP:0005445","Widened posterior fossa" -"HP:0010913","Hyperisoleucinemia" -"HP:0040009","Hyperparakeratosis" -"HP:0003005","Ganglioneuroma" -"HP:0011272","Underdeveloped tragus" -"HP:0000348","High forehead" -"HP:0004383","Hypoplastic left heart" -"HP:0011336","Bitemporal forceps marks" -"HP:0007942","Internal ophthalmoplegia" -"HP:0000405","Conductive hearing impairment" -"HP:0031435","Monotonic speech" -"HP:0025023","Rectal atresia" -"HP:0410070","Increased level of ribitol in urine" -"HP:0002186","Apraxia" -"HP:0000907","Anterior rib cupping" -"HP:0001031","Subcutaneous lipoma" -"HP:0009997","Duplication of phalanx of hand" -"HP:0012293","Abnormal genital pigmentation" -"HP:0010706","1-3 finger syndactyly" -"HP:0011037","Decreased urine output" -"HP:0002823","Abnormality of femur morphology" -"HP:0011459","Esophageal carcinoma" -"HP:0010957","Congenital posterior urethral valve" -"HP:0005101","High-frequency hearing impairment" -"HP:0002271","Autonomic dysregulation" -"HP:0003890","Prominent deltoid tuberosities" -"HP:0002722","Recurrent abscess formation" -"HP:0001009","Telangiectasia" -"HP:0000868","Decreased fertility in females" -"HP:0005951","Progressive inspiratory stridor" -"HP:0100650","Vaginal neoplasm" -"HP:0006172","Flattened, squared-off epiphyses of tubular bones" -"HP:0011201","EEG with changes in voltage" -"HP:0000729","Autistic behavior" -"HP:0008436","Absent/hypoplastic coccyx" -"HP:0000264","Abnormality of the mastoid" -"HP:0000255","Acute sinusitis" -"HP:0003700","Generalized amyotrophy" -"HP:0011709","Atrioventricular dissociation" -"HP:0007132","Pallidal degeneration" -"HP:0006156","Ulnar deviation of thumb" -"HP:0008071","Maternal hypertension" -"HP:0005539","T-cell chronic lymphocytic lymphoma/leukemia" -"HP:0009298","Aplasia of the proximal phalanx of the 4th finger" -"HP:0025246","Trichilemmal cyst" -"HP:0011511","Macular schisis" -"HP:0100013","Neoplasm of the breast" -"HP:0000977","Soft skin" -"HP:0001601","Laryngomalacia" -"HP:0000667","Phthisis bulbi" -"HP:0001620","High pitched voice" -"HP:0012158","Carotid artery dissection" -"HP:0100029","Lingual thyroid" -"HP:0003722","Neck flexor weakness" -"HP:0100818","Long thorax" -"HP:0031008","Lingual dystonia" -"HP:0008043","Retinal arteriolar constriction" -"HP:0008031","Posterior Y-sutural cataract" -"HP:0005659","Thoracic kyphoscoliosis" -"HP:0100792","Acantholysis" -"HP:0009183","Joint contracture of the 5th finger" -"HP:0001750","Single ventricle" -"HP:0009395","Cone-shaped epiphyses of the 4th finger" -"HP:0009796","Branchial cyst" -"HP:0031468","Separation insecurity" -"HP:0010941","Aplasia of the nasal bone" -"HP:0003119","Abnormality of lipid metabolism" -"HP:0011202","EEG with diffuse acceleration" -"HP:0006297","Hypoplasia of dental enamel" -"HP:0004997","Multicentric ossification of proximal humeral epiphyses" -"HP:0001845","Overlapping toe" -"HP:0012737","Small intestinal polyp" -"HP:0009741","Nephrosclerosis" -"HP:0010294","Palate fistula" -"HP:0007126","Proximal amyotrophy" -"HP:0011176","EEG with constitutional variants" -"HP:0410057","Increased level of D-threitol in plasma" -"HP:0012048","Oromandibular dystonia" -"HP:0000879","Short sternum" -"HP:0000934","Chondrocalcinosis" -"HP:0004576","Sclerotic vertebral endplates" -"HP:0002664","Neoplasm" -"HP:0012490","Panniculitis" -"HP:0000769","Abnormality of the breast" -"HP:0009106","Abnormal pelvis bone ossification" -"HP:0100865","Broad ischia" -"HP:0010620","Malar prominence" -"HP:0002614","Hepatic periportal necrosis" -"HP:0012387","Bronchitis" -"HP:0001651","Dextrocardia" -"HP:0000829","Hypoparathyroidism" -"HP:0025355","Retinal arterial macroaneurysms" -"HP:0002999","Patellar dislocation" -"HP:0009466","Radial deviation of finger" -"HP:0000961","Cyanosis" -"HP:0011182","Epileptiform EEG discharges" -"HP:0040147","L-2-hydroxyglutaric acidemia" -"HP:0000019","Urinary hesitancy" -"HP:0001348","Brisk reflexes" -"HP:0100684","Salivary gland neoplasm" -"HP:0030796","Increased C-peptide level" -"HP:0002984","Hypoplasia of the radius" -"HP:0007360","Aplasia/Hypoplasia of the cerebellum" -"HP:0012534","Dysesthesia" -"HP:0100679","Lack of skin elasticity" -"HP:0008185","Precocious puberty in males" -"HP:0030721","Tetraphocomelia" -"HP:0025401","Staring gaze" -"HP:0008855","Moderate postnatal growth retardation" -"HP:0001153","Septate vagina" -"HP:0025195","Central diaphragmatic hernia" -"HP:0000498","Blepharitis" -"HP:0400004","Long ear" -"HP:0004433","Secretory IgA deficiency" -"HP:0002265","Large fleshy ears" -"HP:0001212","Prominent fingertip pads" -"HP:0002826","Halberd-shaped pelvis" -"HP:0030453","Abnormal visual electrophysiology" -"HP:0025194","Morgagni diaphragmatic hernia" -"HP:0000658","Eyelid apraxia" -"HP:0009926","Increased lacrimation" -"HP:0000940","Abnormal diaphysis morphology" -"HP:0010260","Enlarged epiphyses of the middle phalanges of the hand" -"HP:0002663","Delayed epiphyseal ossification" -"HP:0100808","Gastric diverticulum" -"HP:0009396","Enlarged epiphyses of the 4th finger" -"HP:0010465","Precocious puberty in females" -"HP:0100963","Hyperesthesia" -"HP:0030800","Abnormal visual accommodation" -"HP:0007418","Alopecia totalis" -"HP:0007052","Multifocal cerebral white matter abnormalities" -"HP:0012592","Albuminuria" -"HP:0010807","Open bite" -"HP:0030156","Bence Jones Proteinuria" -"HP:0005216","Chewing difficulties" -"HP:0031391","Elevated MHC II surface expression" -"HP:0006375","Dumbbell-shaped femur" -"HP:0100719","Lens coloboma" -"HP:0200113","Aphalangy of hands and feet" -"HP:0100736","Abnormality of the soft palate" -"HP:0031225","Intrapulmonary shunt" -"HP:0010808","Protruding tongue" -"HP:0025466","Beta 2-microglobulinuria" -"HP:0002805","Accelerated bone age after puberty" -"HP:0006429","Broad femoral neck" -"HP:0002726","Recurrent Staphylococcus aureus infections" -"HP:0012450","Chronic constipation" -"HP:0012593","Nephrotic range proteinuria" -"HP:0006501","Aplasia/Hypoplasia of the radius" -"HP:0012502","Abnormality of the internal capsule" -"HP:0030410","Sebaceous gland carcinoma" -"HP:0030848","Elevated jugular venous pressure" -"HP:0030068","Olfactory esthesioneuroblastoma" -"HP:0031415","High serum calcitriol" -"HP:3000042","Abnormal jugular vein morphology" -"HP:0005701","Multiple enchondromatosis" -"HP:0000539","Abnormality of refraction" -"HP:0025247","Dermoid cyst" -"HP:0011700","Automatic atrial tachycardia" -"HP:0003127","Hypocalciuria" -"HP:0200001","Dysharmonic accelerated bone age" -"HP:0001464","Aplasia/Hypoplasia involving the shoulder musculature" -"HP:0008628","Abnormality of the stapes" -"HP:0001558","Decreased fetal movement" -"HP:0012595","Mild proteinuria" -"HP:0030798","Abnormality of the bed nucleus of stria terminalis" -"HP:0000657","Oculomotor apraxia" -"HP:0000015","Bladder diverticulum" -"HP:0004425","Flat forehead" -"HP:0025431","Staccato cry" -"HP:0006311","Generalized microdontia" -"HP:0012632","Abnormal intraocular pressure" -"HP:0012597","Heavy proteinuria" -"HP:0006290","Discolored lateral incisors" -"HP:0030801","Reduced visual accommodation" -"HP:0010981","Hypolipoproteinemia" -"HP:0002126","Polymicrogyria" -"HP:0012596","Moderate proteinuria" -"HP:0000636","Upper eyelid coloboma" -"HP:0007587","Numerous pigmented freckles" -"HP:0009380","Aplasia of the fingers" -"HP:0012570","Synovial sarcoma" -"HP:0007617","Fine, reticulate skin pigmentation" -"HP:0011972","Hypoglycorrhachia" -"HP:0005054","Metaphyseal spurs" -"HP:0040289","Cyclic neutropenia" -"HP:0002229","Alopecia areata" -"HP:0006174","Metacarpal diaphyseal endosteal sclerosis" -"HP:0004406","Spontaneous, recurrent epistaxis" -"HP:0009388","Ivory epiphyses of the 5th finger" -"HP:0002895","Papillary thyroid carcinoma" -"HP:0011525","Iris nevus" -"HP:0009494","Ivory epiphyses of the 2nd finger" -"HP:0010263","Ivory epiphyses of the middle phalanges of the hand" -"HP:0040054","Short upper eyelashes" -"HP:0006765","Chondrosarcoma" -"HP:0030363","Primary Caesarian section" -"HP:0003288","Mitochondrial propionyl-CoA carboxylase defect" -"HP:0010994","Abnormality of the striatum" -"HP:0002165","Pterygium of nails" -"HP:0001929","Reduced factor XI activity" -"HP:0009805","Low-output congestive heart failure" -"HP:0030811","Tongue pain" -"HP:0005227","Adenomatous colonic polyposis" -"HP:0012559","Increased T3/T4 ratio" -"HP:0100008","Schwannoma" -"HP:0009399","Ivory epiphyses of the 4th finger" -"HP:0025553","Periorbital ecchymosis with tarsal plate sparing" -"HP:0005619","Thoracolumbar kyphosis" -"HP:0031153","Membranous vitreous appearance" -"HP:0011080","Abnormality of premolar morphology" -"HP:0011469","Nasal regurgitation" -"HP:0012239","Atransferrinemia" -"HP:0100803","Abnormality of the periungual region" -"HP:0200102","Sparse or absent eyelashes" -"HP:0011673","Cardiac hemangioma" -"HP:0100697","Neurofibrosarcoma" -"HP:0006040","Long second metacarpal" -"HP:0100826","Neoplasm of the nail" -"HP:0004057","Mitten deformity" -"HP:0003903","Broad humeral epiphyses" -"HP:0007374","Atrophy/Degeneration involving the caudate nucleus" -"HP:0100751","Esophageal neoplasm" -"HP:0003909","Cortical subperiosteal resorption of humeral metaphyses" -"HP:0100755","Abnormality of salivation" -"HP:0002821","Neuropathic arthropathy" -"HP:0009416","Ivory epiphyses of the 3rd finger" -"HP:0100606","Neoplasm of the respiratory system" -"HP:0010274","Ivory epiphyses of the proximal phalanges of the hand" -"HP:0008033","Congenital exotropia" -"HP:0002930","Thyroid hormone receptor defect" -"HP:0009205","Cone-shaped epiphysis of the middle phalanx of the 5th finger" -"HP:0003367","Abnormality of the femoral neck" -"HP:0025552","Periorbital purpura" -"HP:0007704","Paroxysmal involuntary eye movements" -"HP:0030299","Distal femoral metaphyseal abnormality" -"HP:0009692","Ivory epiphysis of the thumb" -"HP:0011704","Sick sinus syndrome" -"HP:0030771","Mallet finger" -"HP:0030807","Abnormal nail growth" -"HP:0040159","Abnormal spaced incisors" -"HP:0004633","Lower thoracic kyphosis" -"HP:0009191","Ivory epiphyses of the metacarpals" -"HP:0002872","Apneic episodes precipitated by illness, fatigue, stress" -"HP:0000215","Thick upper lip vermilion" -"HP:0001377","Limited elbow extension" -"HP:0045079","Distal femoral metaphyseal irregularity" -"HP:0007840","Long upper eyelashes" -"HP:0030819","Ski jump nail" -"HP:0005464","Craniofacial osteosclerosis" -"HP:0100925","Sclerosis of foot bone" -"HP:0009758","Pyramidal skinfold extending from the base to the top of the nails" -"HP:0004841","Reduced factor XII activity" -"HP:0004042","Ulnar metaphyseal irregularity" -"HP:0007458","Focal hyperextensible skin" -"HP:0500009","Dysplastic gangliocytoma of the cerebellum" -"HP:0008131","Tarsal stippling" -"HP:0025330","Downgaze palsy" -"HP:0025009","Forward slanting upper incisors" -"HP:0011672","Cardiac myxoma" -"HP:0011282","Abnormality of hindbrain morphology" -"HP:0007236","Recurrent subcortical infarcts" -"HP:0005686","Patchy osteosclerosis" -"HP:0002542","Olivopontocerebellar atrophy" -"HP:0005366","Recurrent streptococcus pneumoniae infections" -"HP:0002694","Sclerosis of skull base" -"HP:0000207","Triangular mouth" -"HP:0011002","Osteopetrosis" -"HP:0008396","Chronic monilial nail infection" -"HP:0004054","Sclerosis of hand bone" -"HP:0002898","Embryonal neoplasm" -"HP:0004635","Cervical C5/C6 vertebrae fusion" -"HP:0025323","Abnormal arterial physiology" -"HP:0004284","Notched hand bones" -"HP:0012761","Absent mastoid" -"HP:0030846","Abnormality of venous physiology" -"HP:0100533","Inflammatory abnormality of the eye" -"HP:0012754","CNS hypermyelination" -"HP:0001116","Macular coloboma" -"HP:0000620","Dacryocystitis" -"HP:0006228","Valgus hand deformity" -"HP:0006339","Conical mandibular incisor" -"HP:0011940","Anterior wedging of T12" -"HP:0002779","Tracheomalacia" -"HP:0004277","Fractured hand bones" -"HP:0031614","Inferior retinal coloboma" -"HP:0030358","Non-small cell lung carcinoma" -"HP:0004287","Pointed hand bones" -"HP:0007041","Chronic lymphocytic meningitis" -"HP:0040187","Neonatal sepsis" -"HP:0006191","Deep palmar crease" -"HP:0008478","Scheuermann-like vertebral changes" -"HP:0001705","Right ventricular outlet obstruction" -"HP:0004482","Relative macrocephaly" -"HP:0010536","Central sleep apnea" -"HP:0012473","Tongue atrophy" -"HP:0011038","Abnormality of renal resorption" -"HP:0007332","Hemifacial seizures" -"HP:0000762","Decreased nerve conduction velocity" -"HP:0012866","Sperm neck anomaly" -"HP:0011084","Hypocalcification of dental enamel" -"HP:0011083","Conical maxillary incisor" -"HP:0004292","Undermodelled hand bones" -"HP:0012665","Moderately reduced ejection fraction" -"HP:0011065","Conical incisor" -"HP:0006342","Peg-shaped maxillary lateral incisors" -"HP:0030500","Yellow/white lesions of the macula" -"HP:0012893","Neck muscle hypertrophy" -"HP:0000965","Cutis marmorata" -"HP:0010636","Schizencephaly" -"HP:0002813","Abnormality of limb bone morphology" -"HP:0030850","Abnormal pulse pressure" -"HP:0040265","Upper limb muscle hypertrophy" -"HP:0012113","Abnormality of creatine metabolism" -"HP:0007773","Vitreoretinopathy" -"HP:0011679","Tetralogy of Fallot with pulmonary stenosis" -"HP:0031364","Ecchymosis" -"HP:0011082","Conical primary incisor" -"HP:0000278","Retrognathia" -"HP:0000650","Abnormal amplitude of pattern reversal visual evoked potentials" -"HP:0011364","White hair" -"HP:0005927","Aplasia/hypoplasia involving bones of the hand" -"HP:0010174","Broad phalanx of the toes" -"HP:0012867","Sperm mid-piece anomaly" -"HP:0010488","Aplasia/Hypoplasia of the palmar creases" -"HP:0006509","Diverticulosis of trachea" -"HP:0004285","Overmodelled hand bones" -"HP:0009042","Marked muscular hypertrophy" -"HP:0100720","Hypoplasia of the ear cartilage" -"HP:0010844","EEG with multifocal slow activity" -"HP:0012892","Facial muscle hypertrophy" -"HP:0010776","Tracheobronchmegaly" -"HP:0009020","Exercise-induced muscle fatigue" -"HP:0031597","PR segment elevation" -"HP:0000077","Abnormality of the kidney" -"HP:0011172","Complex febrile seizures" -"HP:0012325","Chronic myelomonocytic leukemia" -"HP:0012771","Increased arm span" -"HP:0100884","Compensatory scoliosis" -"HP:0000870","Prolactin excess" -"HP:0004278","Synostosis involving bones of the hand" -"HP:0001989","Fetal akinesia sequence" -"HP:0005224","Rectal abscess" -"HP:0005424","Absent specific antibody response" -"HP:0005608","Bilobate gallbladder" -"HP:0025068","Incomitant strabismus" -"HP:0002218","Silver-gray hair" -"HP:0011247","Prominent superior crus of antihelix" -"HP:0030408","Pineoblastoma" -"HP:0003791","Deposits immunoreactive to beta-amyloid protein" -"HP:0100834","Neoplasm of the large intestine" -"HP:0010537","Wide cranial sutures" -"HP:0031261","Bladder polyp" -"HP:0003048","Radial head subluxation" -"HP:0000920","Enlargement of the costochondral junction" -"HP:0040250","Reduced prothrombin antigen" -"HP:0100682","Tracheal atresia" -"HP:0200064","Asymmetry of iris pigmentation" -"HP:0000577","Exotropia" -"HP:0006163","Enlarged metacarpophalangeal joints" -"HP:0009281","Aplasia of the 4th finger" -"HP:0003344","3-Methylglutaric aciduria" -"HP:0200028","Pretibial myxedema" -"HP:0005244","Gastrointestinal infarctions" -"HP:0012463","Elevated transferrin saturation" -"HP:0006129","Drumstick terminal phalanges" -"HP:0006247","Enlarged interphalangeal joints" -"HP:0004944","Dilatation of the cerebral artery" -"HP:0003183","Wide pubic symphysis" -"HP:0025313","Exophoria" -"HP:0010219","Structural foot deformity" -"HP:0001204","Distal symphalangism of hands" -"HP:0000183","Difficulty in tongue movements" -"HP:0011560","Mitral atresia" -"HP:0003988","Long ulna" -"HP:0200124","Chronic hepatitis due to cryptospridium infection" -"HP:0005354","Absent cellular immunity" -"HP:0025266","Cervical osteoarthritis" -"HP:0010331","Aplasia/Hypoplasia of the 3rd toe" -"HP:0001831","Short toe" -"HP:0031054","Long segment coarctation of the aorta" -"HP:0001098","Abnormal fundus morphology" -"HP:0009240","Broad distal phalanx of the 5th finger" -"HP:0005930","Abnormality of epiphysis morphology" -"HP:0003549","Abnormality of connective tissue" -"HP:0040273","Adenocarcinoma of the intestines" -"HP:0012469","Infantile spasms" -"HP:0006210","Postaxial oligodactyly" -"HP:0009642","Broad distal phalanx of the thumb" -"HP:0010746","Hypoplasia of the phalanges of the toes" -"HP:0003973","Wide radioulnar joints" -"HP:0003154","Increased circulating ACTH level" -"HP:0003148","Elevated serum acid phosphatase" -"HP:0004180","Short distal phalanx of the 3rd finger" -"HP:0030624","Subretinal hyporeflective spaces on macular OCT" -"HP:0004974","Coarctation of abdominal aorta" -"HP:0100604","Neoplasm of the lip" -"HP:0000081","Duplicated collecting system" -"HP:0030035","Struvite nephrolithiasis" -"HP:0008635","Hypertrophy of the urinary bladder" -"HP:0000567","Chorioretinal coloboma" -"HP:0100453","Osteolytic defects of the middle phalanx of the 4th toe" -"HP:0002151","Increased serum lactate" -"HP:0010077","Broad distal phalanx of the hallux" -"HP:0025069","Comitant strabismus" -"HP:0010476","Aplasia/Hypoplasia of the bladder" -"HP:0011849","Abnormal bone ossification" -"HP:0031734","Lacrimal pump failure" -"HP:0010440","Ectopic accesory toe-like appendage" -"HP:0006916","Intraaxonal accumulation of curvilinear autofluorescent lipopigment storage material" -"HP:0012263","Immotile cilia" -"HP:0007856","Punctate opacification of the cornea" -"HP:0005086","Knee osteoarthritis" -"HP:0007181","Interosseus muscle atrophy" -"HP:0025043","Enlarged mesenteric lymph node" -"HP:0008724","Hypoplasia of the ovary" -"HP:0003353","Propionyl-CoA carboxylase deficiency" -"HP:0002010","Narrow maxilla" -"HP:0001083","Ectopia lentis" -"HP:0410071","Increased level of ribitol in CSF" -"HP:0006858","Impaired distal proprioception" -"HP:0003088","Premature osteoarthritis" -"HP:0030623","Intraretinal hyporeflective spaces on macular OCT" -"HP:0000140","Abnormality of the menstrual cycle" -"HP:0009565","Aplasia of the distal phalanx of the 2nd finger" -"HP:0004268","Osteoarthritis of the small joints of the hand" -"HP:0002929","Leydig cell insensitivity to gonadotropin" -"HP:0030951","Skeletal muscle fibrosis" -"HP:0007678","Lacrimal duct stenosis" -"HP:0001824","Weight loss" -"HP:0009795","Branchial fistula" -"HP:0030725","Neurenteric cyst" -"HP:0004374","Hemiplegia/hemiparesis" -"HP:0000383","Abnormality of periauricular region" -"HP:0200046","Cat cry" -"HP:0025312","Esophoria" -"HP:0000159","Abnormality of the lip" -"HP:0006587","Straight clavicles" -"HP:0004058","Hand monodactyly" -"HP:0003065","Patellar hypoplasia" -"HP:0100491","Abnormality of lower limb joint" -"HP:0004639","Elevated amniotic fluid alpha-fetoprotein" -"HP:0000929","Abnormality of the skull" -"HP:0008846","Severe intrauterine growth retardation" -"HP:0040164","Lipomas of upper eyelids" -"HP:0000796","Urethral obstruction" -"HP:0030766","Ear pain" -"HP:0012079","Abnormality of central motor conduction" -"HP:0008780","Congenital bilateral hip dislocation" -"HP:0012522","Spider hemangioma" -"HP:0500005","Anal pain" -"HP:0100874","Thick hair" -"HP:0007768","Central retinal vessel vascular tortuosity" -"HP:0030181","Gordon reflex" -"HP:0031249","Parageusia" -"HP:0004876","Spontaneous neonatal pneumothorax" -"HP:0000169","Gingival fibromatosis" -"HP:0040017","Protruding coccyx" -"HP:0000535","Sparse and thin eyebrow" -"HP:0200025","Mandibular pain" -"HP:0100870","Plantar telangiectasia" -"HP:0025481","Cervical hemivertebrae" -"HP:0008404","Nail dystrophy" -"HP:0030833","Neck pain" -"HP:0008467","Thoracic hemivertebrae" -"HP:0009893","Telangiectasia of the ear" -"HP:0002483","Bulbar signs" -"HP:0002680","J-shaped sella turcica" -"HP:0030157","Flank pain" -"HP:0006649","Costochondral pain" -"HP:0030816","Gingival recession" -"HP:0005288","Abnormality of the nares" -"HP:0007208","Irregular myelin loops" -"HP:0009129","Upper limb amyotrophy" -"HP:0011952","Acute aspiration pneumonia" -"HP:0030019","Increased female libido" -"HP:0030080","Burkitt lymphoma" -"HP:0006870","Lobar holoprosencephaly" -"HP:0025555","Periungual teleangiectasia" -"HP:0012329","Tufted angioma" -"HP:0010943","Echogenic fetal bowel" -"HP:0002599","Head titubation" -"HP:0007621","Telangiectasia of extensor surfaces" -"HP:0003607","4-Hydroxyphenylacetic aciduria" -"HP:0002101","Abnormal lung lobation" -"HP:0012679","Widened interpedicular distance" -"HP:0006743","Embryonal rhabdomyosarcoma" -"HP:0030834","Shoulder pain" -"HP:3000014","Abnormality of procerus muscle" -"HP:0009094","Cleft lower alveolar ridge" -"HP:0030836","Wrist pain" -"HP:0500027","Aplastic colon" -"HP:0006888","Meningoencephalocele" -"HP:0003239","Phosphoethanolaminuria" -"HP:0009461","Short 3rd finger" -"HP:0005899","Metaphyseal dysostosis" -"HP:0030838","Hip pain" -"HP:0002552","Trichodysplasia" -"HP:0030835","Elbow pain" -"HP:0200026","Ocular pain" -"HP:0003683","Large beaked nose" -"HP:0030839","Knee pain" -"HP:0410034","Bilateral alveolar cleft of maxilla" -"HP:0000588","Optic nerve coloboma" -"HP:0005089","Abnormal metaphyseal trabeculation" -"HP:0030155","Scrotal pain" -"HP:0006901","Impaired thermal sensitivity" -"HP:0004051","Advanced ossification of the hand bones" -"HP:0030841","Toe pain" -"HP:0100037","Abnormality of the scalp hair" -"HP:0003118","Increased circulating cortisol level" -"HP:0000910","Wide-cupped costochondral junctions" -"HP:0002427","Motor aphasia" -"HP:0012786","Recurrent cystitis" -"HP:0009809","Abnormality of upper limb metaphysis" -"HP:0010736","Monostotic fibrous dysplasia" -"HP:0011648","Patent ductus arteriosus after birth at term" -"HP:0030837","Finger pain" -"HP:0001688","Sinus bradycardia" -"HP:0008652","Autonomic erectile dysfunction" -"HP:0040264","Jaw pain" -"HP:0011717","AV nodal reentry tachycardia" -"HP:0007429","Few cafe-au-lait spots" -"HP:0011649","Patent ductus arteriosus after premature birth" -"HP:0004980","Metaphyseal rarefaction" -"HP:0010735","Polyostotic fibrous dysplasia" -"HP:0000575","Scotoma" -"HP:0006376","Limited elbow flexion" -"HP:0031096","Delayed vertebral ossification" -"HP:0000499","Abnormality of the eyelashes" -"HP:0011725","Chaotic multifocal atrial tachycardia" -"HP:0011053","Agenesis of mandibular premolar" -"HP:0007738","Uncontrolled eye movements" -"HP:0012446","Low CSF 5-methyltetrahydrofolate" -"HP:0010562","Keloids" -"HP:0040207","Abnormal CSF biopterin level" -"HP:0003304","Spondylolysis" -"HP:0000634","Impaired ocular abduction" -"HP:0005233","Hypoplasia of the gallbladder" -"HP:0100515","Pollakisuria" -"HP:0030015","Female anorgasmia" -"HP:0000232","Everted lower lip vermilion" -"HP:0003653","Cellular metachromasia" -"HP:0004297","Abnormality of the biliary system" -"HP:0025534","Ocular melanocytosis" -"HP:0003400","Basal lamina 'onion bulb' formation" -"HP:0025487","Abnormality of bladder morphology" -"HP:0010285","Oral synechia" -"HP:0005325","Extension of hair growth on temples to lateral eyebrow" -"HP:0011515","Abnormal stereopsis" -"HP:0000764","Peripheral axonal degeneration" -"HP:0007526","Hypopigmented skin patches on arms" -"HP:0004851","Folate-responsive megaloblastic anemia" -"HP:0002659","Increased susceptibility to fractures" -"HP:0040239","Increased plasma vitamin K epoxide after vitamin K supplementation" -"HP:0007267","Chronic axonal neuropathy" -"HP:0006642","Large sternal ossification centers" -"HP:0011483","Anterior synechiae of the anterior chamber" -"HP:0006201","Hypermobility of distal interphalangeal joints" -"HP:0025339","Superficial episcleral hyperemia" -"HP:0000591","Abnormality of the sclera" -"HP:0001072","Thickened skin" -"HP:0030406","Primary peritoneal carcinoma" -"HP:0011899","Hyperfibrinogenemia" -"HP:0030534","Abnormal best corrected visual acuity test" -"HP:0005595","Generalized hyperkeratosis" -"HP:0005469","Flat occiput" -"HP:0009576","Absent middle phalanx of 2nd finger" -"HP:0012317","Sacroiliac arthritis" -"HP:0009577","Short middle phalanx of the 2nd finger" -"HP:0008716","Urethrovaginal fistula" -"HP:0020006","Ciliary body coloboma" -"HP:0005265","Abnormality of the jejunum" -"HP:0100735","Hypertensive crisis" -"HP:0005593","Macular hypopigmented whorls, streaks, and patches" -"HP:0030085","Abnormal CSF lactate level" -"HP:0030017","Vaginismus" -"HP:0010771","Pilonidal abscess" -"HP:0002408","Cerebral arteriovenous malformation" -"HP:0000275","Narrow face" -"HP:0006755","Cutaneous leiomyosarcoma" -"HP:0001211","Abnormality of the fingertips" -"HP:0008176","Neonatal unconjugated hyperbilirubinemia" -"HP:0007411","Hypoplastic-absent sebaceous glands" -"HP:0008964","Nonprogressive muscular atrophy" -"HP:0025575","Abnormal superior vena cava morphology" -"HP:0008921","Neonatal short-limb short stature" -"HP:0005237","Degenerative liver disease" -"HP:0500030","Abnormal hepatic glycogen storage" -"HP:0006519","Alveolar cell carcinoma" -"HP:0030042","Incomplete ossification of pubis" -"HP:0007899","Retinal nonattachment" -"HP:0012014","EEG with central focal spikes" -"HP:0003716","Generalized muscular appearance from birth" -"HP:0008717","Unilateral renal atrophy" -"HP:0009002","Loss of truncal subcutaneous adipose tissue" -"HP:0000326","Abnormality of the maxilla" -"HP:0007903","Paravenous chorioretinal atrophy" -"HP:0006060","Tombstone-shaped proximal phalanges" -"HP:0002684","Thickened calvaria" -"HP:0025380","Increased serum androstenedione" -"HP:0002078","Truncal ataxia" -"HP:0008774","Aplasia/Hypoplasia of the inner ear" -"HP:0012367","Extra fontanelles" -"HP:0000074","Ureteropelvic junction obstruction" -"HP:0002518","Abnormality of the periventricular white matter" -"HP:0008729","Absence of labia majora" -"HP:0005085","Limited knee flexion/extension" -"HP:0011500","Polycoria" -"HP:0006432","Trapezoidal distal femoral condyles" -"HP:0010149","Absent epiphysis of the 1st metatarsal" -"HP:0000654","Decreased light- and dark-adapted electroretinogram amplitude" -"HP:0001335","Bimanual synkinesia" -"HP:0009073","Progressive proximal muscle weakness" -"HP:0012230","Rhegmatogenous retinal detachment" -"HP:0004918","Hyperchloremic metabolic acidosis" -"HP:0011377","Aplasia of the vestibule" -"HP:0012542","Onychauxis" -"HP:0002011","Morphological abnormality of the central nervous system" -"HP:0005461","Craniofacial disproportion" -"HP:0012507","Weakness of orbicularis oculi muscle" -"HP:0002356","Writer's cramp" -"HP:0011452","Functional abnormality of the middle ear" -"HP:0012000","EEG with generalized spikes" -"HP:0030423","Splenic cyst" -"HP:0040040","Onycholysis of toenails" -"HP:0003763","Bruxism" -"HP:0003749","Pelvic girdle muscle weakness" -"HP:0010464","Streak ovary" -"HP:0040023","Clinodactyly of the thumb" -"HP:0002839","Urinary bladder sphincter dysfunction" -"HP:0001993","Ketoacidosis" -"HP:0006690","Myocardial calcification" -"HP:0040221","Hypoplasia of the dental root" -"HP:0010910","Hypervalinemia" -"HP:0100799","Neoplasm of the middle ear" -"HP:0001388","Joint laxity" -"HP:0010789","Abnormality of the Leydig cells" -"HP:0040268","Recurrent infections of the middle ear" -"HP:0012231","Exudative retinal detachment" -"HP:0004336","Myelin outfoldings" -"HP:0012540","Axillary epidermoid cyst" -"HP:0040090","Abnormality of the tympanic membrane" -"HP:0005571","Increased renal tubular phosphate reabsorption" -"HP:0009715","Papillary cystadenoma of the epididymis" -"HP:0004281","Irregular sclerosis of hand bones" -"HP:0000411","Protruding ear" -"HP:0009590","Unilateral vestibular Schwannoma" -"HP:0007950","Peripapillary chorioretinal atrophy" -"HP:0012017","EEG with parietal focal spikes" -"HP:0040262","Glue ear" -"HP:0012663","Mildly reduced ejection fraction" -"HP:0005458","Premature closure of fontanelles" -"HP:0011140","Gastrointestinal duplication" -"HP:0012179","Craniofacial dystonia" -"HP:0001156","Brachydactyly" -"HP:0010859","Frank breech presentation" -"HP:0002594","Pancreatic hypoplasia" -"HP:0006330","Rotated maxillary central incisors" -"HP:0009220","Ivory epiphysis of the middle phalanx of the 4th finger" -"HP:0001034","Hypermelanotic macule" -"HP:0040099","Abnormality of the round window" -"HP:0025128","Reduced intraabdominal adipose tissue" -"HP:0000219","Thin upper lip vermilion" -"HP:0025519","Multiple biliary hamartomas" -"HP:0000280","Coarse facial features" -"HP:0012787","Recurrent pyelonephritis" -"HP:0010841","Multifocal epileptiform discharges" -"HP:0006157","Prominent palmar flexion creases" -"HP:0008457","Caudal interpedicular narrowing" -"HP:0004840","Hypochromic microcytic anemia" -"HP:0001392","Abnormality of the liver" -"HP:0007215","Periodic hyperkalemic paralysis" -"HP:0011716","Junctional ectopic tachycardia" -"HP:0004734","Renal cortical microcysts" -"HP:0004879","Intermittent hyperventilation" -"HP:0001482","Subcutaneous nodule" -"HP:0025141","Gingival calcification" -"HP:0100853","Hypoplastic areola" -"HP:0005798","Posterior radial head dislocation" -"HP:0100687","Polyotia" -"HP:0000100","Nephrotic syndrome" -"HP:0007341","Diffuse swelling of cerebral white matter" -"HP:0010549","Weakness due to upper motor neuron dysfunction" -"HP:0031523","Salivary gland oncocytoma" -"HP:0002961","Dysgammaglobulinemia" -"HP:0008608","Hypertrophic auricular cartilage" -"HP:0012062","Bone cyst" -"HP:0040331","Focal hypointensity of cerebral white matter on MRI" -"HP:0008326","Vitamin B6 deficiency" -"HP:0001096","Keratoconjunctivitis" -"HP:0040183","Encopresis" -"HP:0040333","Confluent hypointensity of cerebral white matter on MRI" -"HP:0006549","Unilateral primary pulmonary dysgenesis" -"HP:0003438","Absent Achilles reflex" -"HP:0000282","Facial edema" -"HP:0010745","Aplasia of the phalanges of the toes" -"HP:0007321","Deep white matter hypodensities" -"HP:0011284","Short-segment aganglionic megacolon" -"HP:0005326","Hypoplastic philtrum" -"HP:0001880","Eosinophilia" -"HP:0012038","Corneal guttata" -"HP:0007327","Mixed demyelinating and axonal polyneuropathy" -"HP:0040095","Neoplasm of the outer ear" -"HP:0011005","Mixed cirrhosis" -"HP:0012794","Periventricular white matter hypodensities" -"HP:0100730","Bronchogenic cyst" -"HP:0003045","Abnormality of the patella" -"HP:0002110","Bronchiectasis" -"HP:0030603","Abnormal optical coherence tomography" -"HP:0000651","Diplopia" -"HP:0010817","Linear nevus sebaceous" -"HP:0002372","Normal interictal EEG" -"HP:0005984","Elevated maternal serum alpha-fetoprotein" -"HP:0005050","Anterolateral radial head dislocation" -"HP:0001371","Flexion contracture" -"HP:0007534","Congenital posterior occipital alopecia" -"HP:0100763","Abnormality of the lymphatic system" -"HP:0002249","Melena" -"HP:0006185","Enlarged proximal interphalangeal joints" -"HP:0100881","Congenital mesoblastic nephroma" -"HP:0006529","Abnormal pulmonary lymphatics" -"HP:0002040","Esophageal varix" -"HP:0010299","Abnormality of dentin" -"HP:0011085","Hypomature dental enamel" -"HP:0003760","Percussion-induced rapid rolling muscle contractions" -"HP:0100658","Cellulitis" -"HP:0003286","Cystathioninemia" -"HP:0005850","Congenital talipes calcaneovalgus" -"HP:0000246","Sinusitis" -"HP:0012412","Premature adrenarche" -"HP:0000621","Entropion" -"HP:0010574","Abnormality of the epiphysis of the femoral head" -"HP:0000222","Gingival hyperkeratosis" -"HP:0007340","Lower limb muscle weakness" -"HP:0012090","Abnormality of pancreas morphology" -"HP:0100152","Ivory epiphysis of the middle phalanx of the 3rd toe" -"HP:0009939","Mandibular aplasia" -"HP:0001510","Growth delay" -"HP:0003765","Psoriasiform dermatitis" -"HP:0030792","Jaw neoplasm" -"HP:0004420","Arterial thrombosis" -"HP:0003561","Birth length less than 3rd percentile" -"HP:0100359","Contracture of the metatarsophalangeal joint of the 5th toe" -"HP:0008388","Abnormal toenail morphology" -"HP:0030249","Enanthema" -"HP:0004005","Large radial epiphyses" -"HP:0000325","Triangular face" -"HP:0012174","Glioblastoma multiforme" -"HP:0010616","Lung fibroma" -"HP:0010546","Muscle fibrillation" -"HP:0011313","Narrow nail" -"HP:0010312","Asymmetry of the breasts" -"HP:0030688","Increased glucagon level" -"HP:0100747","Macrodactyly of toe" -"HP:0007598","Bilateral single transverse palmar creases" -"HP:0003942","Synovial chondromatosis of the elbow" -"HP:0031445","Oral mucosa nodule" -"HP:0008214","Decreased serum estradiol" -"HP:0010578","Bracket epiphyses" -"HP:0001664","Torsade de pointes" -"HP:0012385","Camptodactyly" -"HP:0031248","Palmar pruritus" -"HP:0007089","Facial-lingual fasciculations" -"HP:0002324","Hydranencephaly" -"HP:0100812","Halitosis" -"HP:0001087","Congenital glaucoma" -"HP:0031446","Erosion of oral mucosa" -"HP:0011273","Anisocytosis" -"HP:0100673","Vaginal hydrocele" -"HP:0006279","Beta-cell dysfunction" -"HP:0003941","Stippled calcification of the elbow" -"HP:0001180","Hand oligodactyly" -"HP:0000474","Thickened nuchal skin fold" -"HP:0006851","Symmetric spinal nerve root neurofibromas" -"HP:0009708","Synostosis involving the 5th metacarpal" -"HP:0025317","Cubitus varus" -"HP:0004952","Pulmonary arteriovenous fistulas" -"HP:0030804","Trachyonychia" -"HP:0006577","Macronodular cirrhosis" -"HP:0030865","Large elbow" -"HP:3000019","Abnormality of buccal mucosa" -"HP:0001480","Freckling" -"HP:0025125","White lesion of the oral mucosa" -"HP:0002750","Delayed skeletal maturation" -"HP:0003165","Elevated circulating parathyroid hormone level" -"HP:0008070","Sparse hair" -"HP:0001129","Large central visual field defect" -"HP:0001591","Bell-shaped thorax" -"HP:0000315","Abnormality of the orbital region" -"HP:0001639","Hypertrophic cardiomyopathy" -"HP:0004935","Pulmonary artery atresia" -"HP:0001669","Transposition of the great arteries" -"HP:0000766","Abnormality of the sternum" -"HP:0000163","Abnormality of the oral cavity" -"HP:0009706","Synostosis involving the 3rd metacarpal" -"HP:0009707","Synostosis involving the 4th metacarpal" -"HP:0002967","Cubitus valgus" -"HP:0011410","Caesarian section" -"HP:0012720","Neoplasm of the nose" -"HP:0009553","Abnormality of the hairline" -"HP:0009157","Ivory epiphysis of the proximal phalanx of the 5th finger" -"HP:0006855","Cerebellar vermis atrophy" -"HP:0003179","Protrusio acetabuli" -"HP:0008283","Fasting hyperinsulinemia" -"HP:0030072","Paranasal sinus neoplasm" -"HP:0003371","Enlargement of the proximal femoral epiphysis" -"HP:0011740","Glucocortocoid-insensitive primary hyperaldosteronism" -"HP:0004417","Intermittent claudication" -"HP:0002777","Tracheal stenosis" -"HP:0008191","Thyroid agenesis" -"HP:0010793","Bifid nail" -"HP:0003995","Abnormality of the radial head" -"HP:0005341","Autonomic bladder dysfunction" -"HP:0000248","Brachycephaly" -"HP:0001787","Abnormal delivery" -"HP:0009555","Hypoplasia of the pharynx" -"HP:0100744","Abnormality of the humeroradial joint" -"HP:0001814","Deep-set nails" -"HP:0001095","Hypertensive retinopathy" -"HP:0100525","Urachus fistula" -"HP:0008394","Congenital onychodystrophy" -"HP:0001566","Widely-spaced maxillary central incisors" -"HP:0010231","Enlarged epiphyses of the phalanges of the hand" -"HP:0006254","Elevated alpha-fetoprotein" -"HP:0012622","Chronic kidney disease" -"HP:0001937","Microangiopathic hemolytic anemia" -"HP:0001080","Biliary tract abnormality" -"HP:0000883","Thin ribs" -"HP:0031453","Oral lichenoid lesion" -"HP:0030803","Platonychia" -"HP:0010783","Erythema" -"HP:0011327","Posterior plagiocephaly" -"HP:0001701","Pericarditis" -"HP:0002992","Abnormality of tibia morphology" -"HP:0005004","Flattened proximal radial epiphyses" -"HP:0002204","Pulmonary embolism" -"HP:0100254","Stenosis of the medullary cavity of the long bones" -"HP:0008631","Ureteral dysgenesis" -"HP:0000659","Peters anomaly" -"HP:0003256","Abnormality of the coagulation cascade" -"HP:0008636","Lobular glomerulopathy" -"HP:0100539","Periorbital edema" -"HP:0003051","Enlarged metaphyses" -"HP:0011458","Abdominal symptom" -"HP:0040237","Impaired binding of factor VIII to VWF" -"HP:0002829","Arthralgia" -"HP:0011646","Juxtaductal coarctation of the aorta" -"HP:0031316","Abnormal ventricular myocardium morphology" -"HP:0002197","Generalized seizures" -"HP:0031155","Increased Arden ratio of electrooculogram" -"HP:0025488","Detrusor sphincter dyssynergia" -"HP:0004786","Jejunal diverticula" -"HP:0001961","Hypoplastic heart" -"HP:0012820","Bilateral vocal cord paralysis" -"HP:0001849","Foot oligodactyly" -"HP:0009908","Anterior creases of earlobe" -"HP:0000741","Apathy" -"HP:0002605","Hepatic necrosis" -"HP:0004684","Talipes valgus" -"HP:0011416","Placental infarction" -"HP:0002384","Focal seizures with impairment of consciousness or awareness" -"HP:0011159","Epigastric auras" -"HP:0006685","Endocardial fibrosis" -"HP:0030868","Monorchism" -"HP:0005592","Giant melanosomes in melanocytes" -"HP:0004059","Radial club hand" -"HP:0009857","Symphalangism affecting the proximal phalanges of the hand" -"HP:0001289","Confusion" -"HP:0100516","Neoplasm of the ureter" -"HP:0008227","Pituitary resistance to thyroid hormone" -"HP:0008179","Decreased Arden ratio of electrooculogram" -"HP:0004692","4-5 toe syndactyly" -"HP:0002127","Abnormal upper motor neuron morphology" -"HP:0006385","Short lower limbs" -"HP:0004987","Mesomelic leg shortening" -"HP:0002955","Granulomatosis" -"HP:0002293","Alopecia of scalp" -"HP:0001405","Periportal fibrosis" -"HP:0008676","Congenital megaureter" -"HP:0000070","Ureterocele" -"HP:0003496","Increased IgM level" -"HP:0006155","Long phalanx of finger" -"HP:0009196","Absent metacarpal epiphyses" -"HP:0010944","Abnormality of the renal pelvis" -"HP:0008059","Aplasia/Hypoplasia of the macula" -"HP:0000491","Keratitis" -"HP:0002390","Spinal arteriovenous malformation" -"HP:0012515","Hip flexor weakness" -"HP:0100279","Ulcerative colitis" -"HP:0005521","Disseminated intravascular coagulation" -"HP:0010599","Abnormality of the distal humeral epiphysis" -"HP:0002083","Migraine without aura" -"HP:0010936","Abnormality of the lower urinary tract" -"HP:0006273","Pancreatic lymphangiectasis" -"HP:0011776","Thyroid microfollicular adenoma" -"HP:0006205","Irregular phalanges" -"HP:0000952","Jaundice" -"HP:0000039","Epispadias" -"HP:0003641","Hemoglobinuria" -"HP:0030140","Oral cavity bleeding" -"HP:0025494","Coated aorta" -"HP:0031308","Vertebral artery calcification" -"HP:0011391","Morphological abnormality of the nerves of the inner ear" -"HP:0003940","Osteoarthritis of the elbow" -"HP:0010988","Abnormality of the extrinsic pathway" -"HP:0002912","Methylmalonic acidemia" -"HP:0031579","Tessier number 7 facial cleft" -"HP:0045037","Abnormality of jaw muscles" -"HP:0012235","Drug-induced agranulocytosis" -"HP:0006783","Posterior pharyngeal cleft" -"HP:0025439","Pharyngitis" -"HP:0008747","Cartilaginous ossification of larynx" -"HP:0007809","Punctate corneal dystrophy" -"HP:0000720","Mood swings" -"HP:0004421","Elevated systolic blood pressure" -"HP:3000063","Abnormality of internal jugular vein" -"HP:0012468","Chronic acidosis" -"HP:0012775","Stellate iris" -"HP:0000875","Episodic hypertension" -"HP:0100320","Rosenthal fibres" -"HP:0004047","Wide ulnar metaphysis" -"HP:0000605","Supranuclear gaze palsy" -"HP:0003994","Dislocated wrist" -"HP:0045048","Increased HbA2 hemoglobin" -"HP:0003575","Increased intracellular sodium" -"HP:0005605","Large cafe-au-lait macules with irregular margins" -"HP:0012814","Bilateral breast hypoplasia" -"HP:0011873","Abnormal platelet count" -"HP:0012133","Erythroid hypoplasia" -"HP:0006715","Glomus tympanicum paraganglioma" -"HP:0000025","Functional abnormality of male internal genitalia" -"HP:0012200","Abnormality of prothrombin" -"HP:0003530","Glutaric acidemia" -"HP:0008829","Delayed femoral head ossification" -"HP:0009781","Lester's sign" -"HP:3000053","Abnormality of hypopharynx" -"HP:0003534","Reduced xanthine dehydrogenase activity" -"HP:0005600","Congenital giant melanocytic nevus" -"HP:0010228","Absent epiphyses of the phalanges of the hand" -"HP:0012146","Abnormality of von Willebrand factor" -"HP:0003001","Glomus jugular tumor" -"HP:0004920","Phenylpyruvic acidemia" -"HP:0008060","Aplasia/Hypoplasia of the fovea" -"HP:0100057","Cone-shaped epiphyses of the 3rd toe" -"HP:0007274","Recurrent bacterial meningitis" -"HP:0011286","Total colonic aganglionosis" -"HP:0008942","Acute rhabdomyolysis" -"HP:0010568","Hamartoma of the eye" -"HP:0005428","Severe recurrent varicella" -"HP:0430024","Abnormality of external jugular vein" -"HP:0007928","Abnormal flash visual evoked potentials" -"HP:0200070","Peripheral retinal atrophy" -"HP:0040236","Hyperfibrinolysis" -"HP:0100079","Cone-shaped epiphyses of the 5th toe" -"HP:0025477","Periarticular calcification" -"HP:0001995","Hyperchloremic acidosis" -"HP:0002640","Hypertension associated with pheochromocytoma" -"HP:0010904","Abnormality of histidine metabolism" -"HP:0011369","Mongolian blue spot" -"HP:0010765","Palmar hyperkeratosis" -"HP:0012645","Enlarged peripheral nerve" -"HP:0006691","Pulmonic valve myxoma" -"HP:0001706","Endocardial fibroelastosis" -"HP:0011307","Splayed toes" -"HP:0200106","Absent/shortened dynein arms" -"HP:0004972","Elevated mean arterial pressure" -"HP:0011021","Abnormality of circulating enzyme level" -"HP:0006794","Loss of ability to walk in first decade" -"HP:0040145","Dicarboxylic acidemia" -"HP:0025035","Abnormal proerythroblast morphology" -"HP:0001003","Multiple lentigines" -"HP:0005059","Arthralgia/arthritis" -"HP:0012654","Abnormal CSF dopamine level" -"HP:0004570","Increased vertebral height" -"HP:0002023","Anal atresia" -"HP:0100235","Synostosis involving bones of the toes" -"HP:0011886","Hyphema" -"HP:0000071","Ureteral stenosis" -"HP:0000825","Hyperinsulinemic hypoglycemia" -"HP:0001085","Papilledema" -"HP:0005766","Disproportionate shortening of the tibia" -"HP:0002411","Myokymia" -"HP:0002094","Dyspnea" -"HP:0001988","Recurrent hypoglycemia" -"HP:0011604","Aortopulmonary window" -"HP:0002099","Asthma" -"HP:0004279","Short palm" -"HP:0000059","Hypoplastic labia majora" -"HP:0001744","Splenomegaly" -"HP:0010609","Skin tags" -"HP:0025351","Recurrent interdigital mycosis" -"HP:0030327","Abnormal osteoclast count" -"HP:0001408","Bile duct proliferation" -"HP:0005959","Impaired gluconeogenesis" -"HP:0010150","Bracket epiphysis of the 1st metatarsal" -"HP:0006270","Hypoplastic spleen" -"HP:0025424","Abnormal larynx physiology" -"HP:0002987","Elbow flexion contracture" -"HP:0200127","Atrial cardiomyopathy" -"HP:0002113","Pulmonary infiltrates" -"HP:0005099","Severe hydrops fetalis" -"HP:0001769","Broad foot" -"HP:0002069","Generalized tonic-clonic seizures" -"HP:0000303","Mandibular prognathia" -"HP:0040052","Abnormality of lower eyelashes" -"HP:0025090","Abnormal large intestinal mucosa morphology" -"HP:0011683","Restrictive ventricular septal defect" -"HP:0000505","Visual impairment" -"HP:0011594","Right aortic arch with retroesophageal diverticulum of Kommerell" -"HP:0008320","Impaired collagen-induced platelet aggregation" -"HP:0006606","Irregular chondrocostal junctions" -"HP:0002057","Prominent glabella" -"HP:0006706","Cystic liver disease" -"HP:0000691","Microdontia" -"HP:0005886","Aphalangy of the hands" -"HP:0004825","Increased hemoglobin oxygen affinity" -"HP:0003840","Delayed upper limb epiphyseal ossification" -"HP:0006304","Widely-spaced incisors" -"HP:0000778","Hypoplasia of the thymus" -"HP:0002665","Lymphoma" -"HP:0010180","Triangular shaped phalanges of the toes" -"HP:0009531","Pseudoepiphysis of the proximal phalanx of the 2nd finger" -"HP:0002958","Immune dysregulation" -"HP:0100704","Cortical visual impairment" -"HP:0001146","Pigmentary retinal degeneration" -"HP:0012717","Severe conductive hearing impairment" -"HP:0000682","Abnormality of dental enamel" -"HP:0000554","Uveitis" -"HP:0003368","Abnormality of the femoral head" -"HP:0003273","Hip contracture" -"HP:0100281","Chronic colitis" -"HP:0002591","Polyphagia" -"HP:0009348","Cone-shaped epiphysis of the proximal phalanx of the 3rd finger" -"HP:0005401","Recurrent candida infections" -"HP:0001870","Acroosteolysis of distal phalanges (feet)" -"HP:0001971","Hypersplenism" -"HP:0100617","Testicular seminoma" -"HP:0009702","Carpal synostosis" -"HP:0010925","Nuclear punctate cataract" -"HP:0000520","Proptosis" -"HP:0006548","Pulmonary arteriovenous malformation" -"HP:0002900","Hypokalemia" -"HP:0007618","Subcutaneous calcification" -"HP:0004209","Clinodactyly of the 5th finger" -"HP:0010163","Bracket epiphyses of the toes" -"HP:0001730","Progressive hearing impairment" -"HP:0001334","Communicating hydrocephalus" -"HP:0006487","Bowing of the long bones" -"HP:0001877","Abnormality of erythrocytes" -"HP:0009740","Aplasia of the parotid gland" -"HP:0011597","Right aortic arch with left descending aorta and left ductus arteriosus" -"HP:0000107","Renal cyst" -"HP:0006770","Clear cell renal cell carcinoma" -"HP:0000858","Menstrual irregularities" -"HP:0006775","Multiple myeloma" -"HP:0000758","Impaired use of nonverbal behaviors" -"HP:0001038","Warfarin-induced skin necrosis" -"HP:0000400","Macrotia" -"HP:0001413","Micronodular cirrhosis" -"HP:0004418","Thrombophlebitis" -"HP:0005597","Congenital alopecia totalis" -"HP:0040104","Osseous stenosis of the external auditory canal" -"HP:0006443","Patellar aplasia" -"HP:0003301","Irregular vertebral endplates" -"HP:0001382","Joint hypermobility" -"HP:0010175","Bullet-shaped toe phalanx" -"HP:0006560","Biliary hyperplasia" -"HP:0012164","Asterixis" -"HP:0003264","Deficiency of N-acetylglucosamine-1-phosphotransferase" -"HP:0001612","Weak cry" -"HP:0012565","Premature epimetaphyseal fusion in fibula" -"HP:0002172","Postural instability" -"HP:0008244","Congenital adrenal hypoplasia" -"HP:0007541","Frontal cutaneous lipoma" -"HP:0000338","Hypomimic face" -"HP:0011835","Absent scaphoid" -"HP:0004448","Fulminant hepatic failure" -"HP:0005033","Distal ulnar hypoplasia" -"HP:0030045","Serpentine fibula" -"HP:0040161","Localized osteoporosis" -"HP:0011464","Aganglionosis of the small intestine" -"HP:0031240","Juxtafoveal choroidal neovascularization" -"HP:0012623","Stage 1 chronic kidney disease" -"HP:0031434","Abnormal speech prosody" -"HP:0008821","Hypoplastic inferior ilia" -"HP:0001898","Increased red blood cell mass" -"HP:0000201","Pierre-Robin sequence" -"HP:0005648","Bilateral ulnar hypoplasia" -"HP:0004699","Osteoporotic metatarsal" -"HP:0003085","Long fibula" -"HP:0002374","Diminished movement" -"HP:0001414","Microvesicular hepatic steatosis" -"HP:0005307","Postural hypotension with compensatory tachycardia" -"HP:0025403","Stooped posture" -"HP:0011651","Double outlet right ventricle with doubly committed ventricular septal defect and pulmonary stenosis" -"HP:0100798","Fingernail dysplasia" -"HP:0025151","Ganglioneuromatosis" -"HP:0200129","Calcific mitral stenosis" -"HP:0003964","Osteoporotic forearm bones" -"HP:0000743","Frontal release signs" -"HP:0012625","Stage 3 chronic kidney disease" -"HP:0012307","Spatulate ribs" -"HP:0030676","Satyr ear" -"HP:0031241","Subfoveal choroidal neovascularization" -"HP:0030512","Difficulty adjusting to changes in luminance" -"HP:0006492","Aplasia/Hypoplasia of the fibula" -"HP:0002389","Cavum septum pellucidum" -"HP:0012525","Abnormal alpha granule distribution" -"HP:0012626","Stage 4 chronic kidney disease" -"HP:0003084","Fractures of the long bones" -"HP:0031297","Unroofed coronary sinus" -"HP:0011655","Double outlet right ventricle with subaortic ventricular septal defect and pulmonary stenosis" -"HP:0008076","Osteoporotic tarsals" -"HP:0011112","Abnormality of serum cytokine level" -"HP:0010503","Fibular duplication" -"HP:0012508","Metamorphopsia" -"HP:0011652","Double outlet right ventricle with doubly committed ventricular septal defect without pulmonary stenosis" -"HP:0031327","Transthyretin cardiac amyloidosis" -"HP:0025373","Interictal EEG abnormality" -"HP:0025391","Crazy paving pattern on pulmonary HRCT" -"HP:0010954","Hypoplastic right heart" -"HP:0005300","Nodular inflammatory vasculitis" -"HP:0010871","Sensory ataxia" -"HP:0000399","Prelingual sensorineural hearing impairment" -"HP:0008824","Hypoplastic iliac body" -"HP:0025150","Hypoganglionosis" -"HP:0006615","Absent in utero rib ossification" -"HP:0100535","Tibiofibular diastasis" -"HP:0031107","Decreased fibular diameter" -"HP:0011203","EEG with abnormally slow frequencies" -"HP:0100373","Aplasia/Hypoplasia of the middle phalanx of the 4th toe" -"HP:0006753","Neoplasm of the stomach" -"HP:0031444","Dilatation of the tricuspid annulus" -"HP:0004323","Abnormality of body weight" -"HP:0031152","Full-thickness macular hole" -"HP:0010852","EEG with photoparoxysmal response" -"HP:0005036","Unilateral ulnar hypoplasia" -"HP:0005928","Synostosis involving the fibula" -"HP:0003876","Osteoporotic humerus" -"HP:0011438","Maternal teratogenic exposure" -"HP:0031106","T-shaped uterus" -"HP:0012624","Stage 2 chronic kidney disease" -"HP:0002944","Thoracolumbar scoliosis" -"HP:0012461","Bacteriuria" -"HP:0003275","Narrow pelvis bone" -"HP:0012085","Pyuria" -"HP:0002183","Phonophobia" -"HP:0003234","Decreased plasma carnitine" -"HP:0009139","Osteolysis involving bones of the lower limbs" -"HP:0002938","Lumbar hyperlordosis" -"HP:0025168","Left ventricular diastolic dysfunction" -"HP:0000371","Acute otitis media" -"HP:0006866","Midline central nervous system lipomas" -"HP:0003311","Hypoplasia of the odontoid process" -"HP:0006127","Long proximal phalanx of finger" -"HP:0002341","Cervical cord compression" -"HP:0000002","Abnormality of body height" -"HP:0000749","Paroxysmal bursts of laughter" -"HP:0003121","Limb joint contracture" -"HP:0030034","Diffuse glomerular basement membrane lamellation" -"HP:0005187","Progressive joint destruction" -"HP:0002699","Abnormality of the foramen magnum" -"HP:0003455","Elevated long chain fatty acids" -"HP:0008527","Congenital sensorineural hearing impairment" -"HP:0000794","IgA deposition in the glomerulus" -"HP:0001994","Renal Fanconi syndrome" -"HP:0011558","Double inlet to single ventricle with common atrioventricular orifice" -"HP:0001231","Abnormality of the fingernails" -"HP:0006288","Advanced eruption of teeth" -"HP:0009729","Cardiac rhabdomyoma" -"HP:0005411","Chronic intestinal candidiasis" -"HP:0010557","Overlapping fingers" -"HP:0000791","Uric acid nephrolithiasis" -"HP:0009063","Progressive distal muscle weakness" -"HP:0003733","Thigh hypertrophy" -"HP:0007850","Retinal vascular proliferation" -"HP:0004260","Large hamate bone" -"HP:0001852","Sandal gap" -"HP:0000098","Tall stature" -"HP:0006067","Multiple carpal ossification centers" -"HP:0000336","Prominent supraorbital ridges" -"HP:0010387","Osteolytic defects of the phalanges of the 5th toe" -"HP:0011562","Straddling atrioventricular valve" -"HP:0011625","Multiple muscular ventricular septal defects" -"HP:0030639","Congenital stationary night blindness with abnormal fundus" -"HP:0005875","Increased dermatoglyphic whorls" -"HP:0002103","Abnormality of the pleura" -"HP:0001525","Severe failure to thrive" -"HP:0004238","Lytic defects of carpal bones" -"HP:0003196","Short nose" -"HP:0006852","Episodic generalized hypotonia" -"HP:0012220","Non-caseating epithelioid cell granulomatosis" -"HP:0012237","Urocanic aciduria" -"HP:0002885","Medulloblastoma" -"HP:0006048","Distal widening of metacarpals" -"HP:0012299","Long distal phalanx of finger" -"HP:0011570","Congenital mitral stenosis" -"HP:0011025","Abnormality of cardiovascular system physiology" -"HP:0011467","Absent gallbladder" -"HP:0000675","Macrodontia of permanent maxillary central incisor" -"HP:0004428","Elfin facies" -"HP:0031246","Nonproductive cough" -"HP:0025089","Feculent vomiting" -"HP:0010992","Stress urinary incontinence" -"HP:0002857","Genu valgum" -"HP:0000245","Abnormality of the paranasal sinuses" -"HP:0045003","Abnormal ossification of the scaphoid" -"HP:0030159","Cervical polyp" -"HP:0100502","Vitamin B12 deficiency" -"HP:0025188","Retinal vasculitis" -"HP:0012803","Anisometropia" -"HP:0003826","Stillbirth" -"HP:0011744","Secondary hypercorticolism" -"HP:0000956","Acanthosis nigricans" -"HP:0004235","Comma-shaped carpal bones" -"HP:0031247","Whooping cough" -"HP:0002781","Upper airway obstruction" -"HP:0006603","Flared, irregular rib ends" -"HP:0012779","Transient hearing impairment" -"HP:0000557","Buphthalmos" -"HP:0006824","Cranial nerve paralysis" -"HP:0005313","Arterial fibromuscular dysplasia" -"HP:0040169","Loose anagen hair" -"HP:0002668","Paraganglioma" -"HP:0012324","Myeloid leukemia" -"HP:0007390","Hyperkeratosis with erythema" -"HP:0004302","Functional motor problems" -"HP:0006628","Absent sternal ossification" -"HP:0000684","Delayed eruption of teeth" -"HP:0012332","Abnormal autonomic nervous system physiology" -"HP:0000211","Trismus" -"HP:0025169","Left ventricular systolic dysfunction" -"HP:0011043","Abnormality of circulating adrenocorticotropin level" -"HP:0011178","Alpha-EEG" -"HP:0000166","Severe periodontitis" -"HP:0012564","Premature epimetaphyseal fusion in tibia" -"HP:0000854","Thyroid adenoma" -"HP:0002714","Downturned corners of mouth" -"HP:0045041","Reduced lactate dehydrogenase B level" -"HP:0004819","Normocytic hypoplastic anemia" -"HP:0100882","Fibrous hamartoma" -"HP:0001376","Limitation of joint mobility" -"HP:0012485","Abnormal surface-connected open canalicular system" -"HP:0001178","Ulnar claw" -"HP:0007830","Adult-onset night blindness" -"HP:0000099","Glomerulonephritis" -"HP:0012308","Decreased serum complement C9" -"HP:0007780","Cortical pulverulent cataract" -"HP:0002107","Pneumothorax" -"HP:0012491","Abnormal dense tubular system" -"HP:0001279","Syncope" -"HP:0002893","Pituitary adenoma" -"HP:0011110","Tonsillitis" -"HP:0005200","Retroperitoneal fibrosis" -"HP:0002697","Parietal foramina" -"HP:0040039","Onycholysis of fingernails" -"HP:0002357","Dysphasia" -"HP:0005932","Abnormal renal corticomedullary differentiation" -"HP:0002480","Hepatic encephalopathy" -"HP:0012151","Hemothorax" -"HP:0004095","Curved fingers" -"HP:0000199","Tongue nodules" -"HP:0000256","Macrocephaly" -"HP:0010518","Thyroglossal cyst" -"HP:0003220","Abnormality of chromosome stability" -"HP:0011029","Internal hemorrhage" -"HP:0000572","Visual loss" -"HP:0004626","Lumbar scoliosis" -"HP:0011851","Hemopericardium" -"HP:0000670","Carious teeth" -"HP:0040137","Comedonal acne" -"HP:0030044","Flexion contracture of digit" -"HP:0002138","Subarachnoid hemorrhage" -"HP:0003423","Thoracolumbar kyphoscoliosis" -"HP:0009919","Retinoblastoma" -"HP:0000822","Hypertension" -"HP:0010762","Chordoma" -"HP:0008361","Corticospinal tract pallor" -"HP:0005943","Respiratory arrest" -"HP:0003019","Abnormality of the wrist" -"HP:0007299","Dysfunction of lateral corticospinal tracts" -"HP:0000236","Abnormality of the anterior fontanelle" -"HP:0010747","Medial flaring of the eyebrow" -"HP:0100360","Contractures of the joints of the upper limbs" -"HP:0001897","Normocytic anemia" -"HP:0200008","Intestinal polyposis" -"HP:0007372","Atrophy/Degeneration involving the corticospinal tracts" -"HP:0005945","Laryngeal obstruction" -"HP:0009824","Upper limb undergrowth" -"HP:0002890","Thyroid carcinoma" -"HP:0002527","Falls" -"HP:0000194","Open mouth" -"HP:0040036","Onychogryposis of fingernail" -"HP:0010614","Fibroma" -"HP:0008559","Hypoplastic superior helix" -"HP:0002073","Progressive cerebellar ataxia" -"HP:0007333","Hypoplasia of the frontal lobes" -"HP:0004097","Deviation of finger" -"HP:0011876","Abnormal platelet volume" -"HP:0001067","Neurofibromas" -"HP:0100742","Vascular neoplasm" -"HP:0012524","Abnormal platelet shape" -"HP:0100725","Lichenification" -"HP:0004271","Cortical thickening of hand bones" -"HP:0100249","Calcification of muscles" -"HP:0007824","Total ophthalmoplegia" -"HP:0030866","Large knee" -"HP:0010474","Bladder stones" -"HP:0040229","Decreased level of thrombomodulin" -"HP:0008513","Bilateral conductive hearing impairment" -"HP:0006316","Irregularly spaced teeth" -"HP:0040226","Decreased level of heparin co-factor II" -"HP:0007397","Axillary apocrine gland hypoplasia" -"HP:0006344","Abnormality of primary molar morphology" -"HP:0040053","Long lower eyelashes" -"HP:0031431","Persistent repetition of words" -"HP:0008691","Solitary bladder diverticulum" -"HP:0030712","Uterine synechiae" -"HP:0040230","Decreased level of tissue plasminogen activator" -"HP:0007692","Nonnuclear polymorphic congenital cataract" -"HP:0040244","Prolonged Russell's viper venom time" -"HP:0011095","Overjet" -"HP:0005432","Transient hypogammaglobulinemia of infancy" -"HP:0011825","Tented philtrum" -"HP:0009889","Localized hirsutism" -"HP:0100238","Synostosis involving bones of the upper limbs" -"HP:0010607","Hordeolum externum" -"HP:0030427","Ossifying fibroma of the jaw" -"HP:0008484","Thoracolumbar interpediculate narrowness" -"HP:0100019","Cortical cataract" -"HP:0008204","Precocious puberty with Sertoli cell tumor" -"HP:0007965","Undetectable visual evoked potentials" -"HP:0000699","Diastema" -"HP:0007925","Lacrimal duct aplasia" -"HP:0040101","Cutaneous atresia of the external auditory canal" -"HP:0011898","Abnormality of circulating fibrinogen" -"HP:0003390","Sensory axonal neuropathy" -"HP:0011996","Elevated factor V activity" -"HP:0040245","Reduced alpha-2-antiplasmin activity" -"HP:0025331","Upgaze palsy" -"HP:0040246","Reduced antithrombin antigen" -"HP:0011062","Misalignment of incisors" -"HP:0500031","Sclerosis of the carpal bones" -"HP:0000243","Trigonocephaly" -"HP:0003555","Muscle fiber splitting" -"HP:0007210","Lower limb amyotrophy" -"HP:0011300","Broad fingertip" -"HP:0003259","Elevated serum creatinine" -"HP:0006671","Paroxysmal atrial tachycardia" -"HP:0011610","Type IV truncus arteriosus" -"HP:0011763","Pituitary carcinoma" -"HP:0005172","Left posterior fascicular block" -"HP:0009875","Triangular shaped distal phalanges of the hand" -"HP:0008755","Laryngotracheomalacia" -"HP:0012212","Abnormal glomerular filtration rate" -"HP:0009933","Narrow naris" -"HP:0005301","Persistent left superior vena cava" -"HP:0045016","Elevated serum long-chain fatty acids" -"HP:0001581","Recurrent skin infections" -"HP:0000618","Blindness" -"HP:0008480","Cervical spondylosis" -"HP:0200066","Ribbonlike corneal degeneration" -"HP:0007240","Progressive gait ataxia" -"HP:0006562","Viral hepatitis" -"HP:0025427","Abnormal bronchus physiology" -"HP:0006597","Diaphragmatic paralysis" -"HP:0003071","Flattened epiphysis" -"HP:0011951","Aspiration pneumonia" -"HP:0004347","Weakness of muscles of respiration" -"HP:0007793","Granular macular appearance" -"HP:0002573","Hematochezia" -"HP:0010644","Midnasal stenosis" -"HP:0000069","Abnormality of the ureter" -"HP:0000079","Abnormality of the urinary system" -"HP:0003308","Cervical subluxation" -"HP:0005564","Absence of renal corticomedullary differentiation" -"HP:0003100","Slender long bone" -"HP:0030829","Abnormal breath sound" -"HP:0011857","Plasmacytoma" -"HP:0011841","Ventricular flutter" -"HP:0007994","Peripheral visual field loss" -"HP:0025115","Civatte bodies" -"HP:0012027","Laryngeal edema" -"HP:0003474","Sensory impairment" -"HP:0002282","Heterotopia" -"HP:0005585","Spotty hyperpigmentation" -"HP:0003809","Reduced intrathoracic adipose tissue" -"HP:0031087","Absent pubertal growth spurt" -"HP:0030875","Abnormality of pulmonary circulation" -"HP:0010612","Plantar pits" -"HP:0007001","Loss of Purkinje cells in the cerebellar vermis" -"HP:0008572","External ear malformation" -"HP:0001449","Duplication of metatarsal bones" -"HP:0007456","Progressive reticulate hyperpigmentation" -"HP:0008066","Abnormal blistering of the skin" -"HP:0008703","Gonadal calcification" -"HP:0004396","Poor appetite" -"HP:0004933","Ascending aortic dissection" -"HP:0008169","Reduced factor VII activity" -"HP:0000790","Hematuria" -"HP:0100562","Diplomyelia" -"HP:0009912","Abnormality of the tragus" -"HP:0011814","Increased urinary hypoxanthine" -"HP:0025095","Sneeze" -"HP:0005479","IgE deficiency" -"HP:0000013","Hypoplasia of the uterus" -"HP:0006518","Pulmonary venous occlusion" -"HP:0009792","Teratoma" -"HP:0007546","Linear hyperpigmentation" -"HP:0030088","Increased serum testosterone level" -"HP:0002043","Esophageal stricture" -"HP:0031416","Abnormal nasal mucus secretion" -"HP:0009814","Upper limb peromelia" -"HP:0009733","Glioma" -"HP:0007406","Hyperpigmentation of eyelids" -"HP:0003987","Fractured ulna" -"HP:0010580","Enlarged epiphyses" -"HP:0001367","Abnormal joint morphology" -"HP:0000958","Dry skin" -"HP:0030719","Unguarded tricuspid valve" -"HP:0004563","Increased spinal bone density" -"HP:0002123","Generalized myoclonic seizures" -"HP:0100247","Recurrent singultus" -"HP:0003787","Type 1 and type 2 muscle fiber minicore regions" -"HP:0006532","Recurrent pneumonia" -"HP:0030359","Squamous cell lung carcinoma" -"HP:0030357","Small cell lung carcinoma" -"HP:0002868","Narrow iliac wings" -"HP:3000031","Abnormality of anterior ethmoidal artery" -"HP:0001621","Weak voice" -"HP:0003401","Paresthesia" -"HP:0001032","Absent distal interphalangeal creases" -"HP:0006239","Shortening of all middle phalanges of the toes" -"HP:0100764","Lymphangioma" -"HP:0000546","Retinal degeneration" -"HP:0031432","Persistent repetition of actions" -"HP:0006277","Pancreatic hyperplasia" -"HP:0003155","Elevated alkaline phosphatase" -"HP:0010234","Ivory epiphyses of the phalanges of the hand" -"HP:0011868","Sciatica" -"HP:0011733","Abnormality of adrenal physiology" -"HP:0010286","Abnormal salivary gland morphology" -"HP:0002858","Meningioma" -"HP:0008321","Reduced factor X activity" -"HP:0007439","Generalized keratosis follicularis" -"HP:0006479","Abnormality of the dental pulp" -"HP:0000969","Edema" -"HP:0011477","Upbeat nystagmus" -"HP:0010680","Elevated alkaline phosphatase of renal origin" -"HP:0004906","Hypernatremic dehydration" -"HP:0100640","Laryngeal cyst" -"HP:0008216","Adrenal gland dysgenesis" -"HP:0002059","Cerebral atrophy" -"HP:0006119","Proximal tapering of metacarpals" -"HP:0003365","Arthralgia of the hip" -"HP:0045058","Abnormality of the testis size" -"HP:0000851","Congenital hypothyroidism" -"HP:0012584","Bilateral renal hypoplasia" -"HP:0005828","Transient pulmonary infiltrates" -"HP:0010685","Low alkaline phosphatase of renal origin" -"HP:0001602","Laryngeal stenosis" -"HP:0001045","Vitiligo" -"HP:0002816","Genu recurvatum" -"HP:0006657","Hypoplasia of first ribs" -"HP:0005632","Absent forearm" -"HP:0003690","Limb muscle weakness" -"HP:0005912","Biliary atresia" -"HP:0011916","Toe extensor amyotrophy" -"HP:0030036","Isothenuria" -"HP:0008197","Absence of pubertal development" -"HP:0000238","Hydrocephalus" -"HP:0008682","Acute tubular necrosis" -"HP:0005141","Episodes of ventricular tachycardia" -"HP:0030303","Hypoplastic anterior commissure" -"HP:0002790","Neonatal breathing dysregulation" -"HP:0004905","Vitamin A deficiency" -"HP:0001678","Atrioventricular block" -"HP:0031493","Glandular cell neoplasm" -"HP:0008640","Congenital macroorchidism" -"HP:0025475","Erythematous macule" -"HP:0002721","Immunodeficiency" -"HP:0004231","Carpal bone aplasia" -"HP:0012860","Testicular fibrosis" -"HP:0005880","Metacarpophalangeal synostosis" -"HP:0002922","Increased CSF protein" -"HP:0007665","Curly eyelashes" -"HP:0006919","Abnormal aggressive, impulsive or violent behavior" -"HP:0030302","Agenesis of the anterior commissure" -"HP:0002544","Retrocollis" -"HP:0100788","Fused lips" -"HP:0100614","Myositis" -"HP:0004854","Intermittent thrombocytopenia" -"HP:0001025","Urticaria" -"HP:0001658","Myocardial infarction" -"HP:0004568","Beaking of vertebral bodies" -"HP:0011020","Abnormality of mucopolysaccharide metabolism" -"HP:0006979","Sleep-wake cycle disturbance" -"HP:0000283","Broad face" -"HP:0007281","Developmental stagnation" -"HP:0007021","Pain insensitivity" -"HP:0009436","Triangular shaped middle phalanx of the 3rd finger" -"HP:0001344","Absent speech" -"HP:0005293","Venous insufficiency" -"HP:0002035","Rectal prolapse" -"HP:0002926","Abnormality of thyroid physiology" -"HP:0030286","Atrophic superior cerebellar peduncle" -"HP:0010595","Abnormality of the distal fibular epiphysis" -"HP:0002588","Duodenal ulcer" -"HP:0011970","Cerebral amyloid angiopathy" -"HP:0010594","Abnormality of the proximal fibular epiphysis" -"HP:0005290","Internal carotid artery hypoplasia" -"HP:0009784","Aplasia/Hypoplasia of the triceps" -"HP:0100749","Chest pain" -"HP:0010317","Scapular aplasia" -"HP:0007561","Telangiectases in sun-exposed and nonexposed skin" -"HP:0005005","Femoral bowing present at birth, straightening with time" -"HP:0003228","Hypernatremia" -"HP:0008207","Primary adrenal insufficiency" -"HP:0005231","Chronic gastritis" -"HP:0005726","Thumbs hypoplastic with bulbous tips" -"HP:0000771","Gynecomastia" -"HP:0025327","Decreased renal parenchymal thickness" -"HP:0002268","Paroxysmal dystonia" -"HP:0002423","Long-tract signs" -"HP:0004345","Abnormality of ganglioside metabolism" -"HP:0100510","Vitamin C deficiency" -"HP:0000097","Focal segmental glomerulosclerosis" -"HP:0003538","Increased serum iduronate sulfatase activity" -"HP:0006784","Paranasal sinus hypoplasia" -"HP:0006631","Hypoplastic distal segments of scapulae" -"HP:0011439","Anesthetic-induced rhabdomylosis" -"HP:0002240","Hepatomegaly" -"HP:0001404","Hepatocellular necrosis" -"HP:0002619","Varicose veins" -"HP:0004758","Effort-induced polymorphic ventricular tachycardias" -"HP:0000139","Uterine prolapse" -"HP:0003450","Axonal regeneration" -"HP:0009516","Enlarged epiphysis of the middle phalanx of the 2nd finger" -"HP:0031159","Thinning of Descemet membrane" -"HP:0010048","Aplasia of metacarpal bones" -"HP:0010524","Agnosia" -"HP:0007944","Intermittent microsaccadic pursuits" -"HP:0000083","Renal insufficiency" -"HP:0011490","Abnormality of Descemet's membrane" -"HP:0003755","Type 1 fibers relatively smaller than type 2 fibers" -"HP:0007792","Microsaccadic pursuit" -"HP:0005964","Intermittent hypothermia" -"HP:0007521","Irregular hyperpigmentation of back" -"HP:0003261","Increased IgA level" -"HP:0005096","Distal femoral bowing" -"HP:0005246","Giant hypertrophic gastritis" -"HP:0004937","Pulmonary artery aneurysm" -"HP:0100540","Palpebral edema" -"HP:0008978","Necrotizing myopathy" -"HP:0012186","Entrapment neuropathy of the ulnar nerve at elbow" -"HP:0025480","Lipomyelomeningocele" -"HP:0005133","Right ventricular dilatation" -"HP:0003464","Abnormal cholesterol homeostasis" -"HP:0100034","Motor tics" -"HP:0004913","Intermittent lactic acidemia" -"HP:0003107","Abnormality of cholesterol metabolism" -"HP:0005781","Contractures of the large joints" -"HP:0100671","Abnormal trabecular bone morphology" -"HP:0002207","Diffuse reticular or finely nodular infiltrations" -"HP:0000962","Hyperkeratosis" -"HP:0100018","Nuclear cataract" -"HP:0001732","Abnormality of the pancreas" -"HP:0045081","Abnormality of body mass index" -"HP:0005220","Multiple intestinal neurofibromatosis" -"HP:0006891","Thick cerebral cortex" -"HP:0009911","Abnormality of the temporal bone" -"HP:0001126","Cryptophthalmos" -"HP:0010862","Delayed fine motor development" -"HP:0002185","Neurofibrillary tangles" -"HP:0031086","Ectopic ovary" -"HP:0030341","Decreased circulating follicle stimulating hormone level" -"HP:0002791","Hypoventilation" -"HP:0025258","Stiff neck" -"HP:0006357","Premature loss of permanent teeth" -"HP:0031368","Intestinal perforation" -"HP:0009055","Generalized limb muscle atrophy" -"HP:0002530","Axial dystonia" -"HP:0011487","Increased corneal thickness" -"HP:0009836","Broad distal phalanx of finger" -"HP:0030439","Anal canal adenocarcinoma" -"HP:0008803","Narrow sacroiliac notch" -"HP:0002250","Abnormality of the large intestine" -"HP:0011109","Chronic sinusitis" -"HP:0010729","Cherry red spot of the macula" -"HP:0001760","Abnormality of the foot" -"HP:0007979","Gaze-evoked horizontal nystagmus" -"HP:0005222","Bowel diverticulosis" -"HP:0003931","Periosteal new bone of humeral diaphysis" -"HP:0004469","Chronic bronchitis" -"HP:0001618","Dysphonia" -"HP:0002419","Molar tooth sign on MRI" -"HP:0007879","Allergic conjunctivitis" -"HP:0005626","Posterior fusion of lumbosacral vertebrae" -"HP:0002474","Expressive language delay" -"HP:0100668","Intestinal duplication" -"HP:0040082","Happy demeanor" -"HP:0005830","Flexion contracture of toe" -"HP:0002205","Recurrent respiratory infections" -"HP:0030950","Pulmonary venous hypertension" -"HP:0002244","Abnormality of the small intestine" -"HP:0000189","Narrow palate" -"HP:0100754","Mania" -"HP:0002312","Clumsiness" -"HP:0031366","Palate neoplasm" -"HP:0030143","Hyperactive bowel sounds" -"HP:0011139","Gastric duplication" -"HP:0008291","Pituitary corticotropic cell adenoma" -"HP:0025028","Abnormality of enteric nervous system morphology" -"HP:0004790","Hypoplasia of the small intestine" -"HP:0007371","Corpus callosum atrophy" -"HP:0031211","Elevated cholesterol ester level" -"HP:0001888","Lymphopenia" -"HP:0011755","Ectopic posterior pituitary" -"HP:0001265","Hyporeflexia" -"HP:0005266","Intestinal polyp" -"HP:0000143","Rectovaginal fistula" -"HP:0002593","Intestinal lymphangiectasia" -"HP:0002359","Frequent falls" -"HP:0100951","Enlarged fossa interpeduncularis" -"HP:0003201","Rhabdomyolysis" -"HP:0012363","Decreased sialylation of O-linked protein glycosylation" -"HP:0002290","Poliosis" -"HP:0002812","Coxa vara" -"HP:0004901","Exercise-induced lactic acidemia" -"HP:0001152","Saccadic smooth pursuit" -"HP:0200035","Skin plaque" -"HP:0010903","Abnormality of glutamine metabolism" -"HP:0011956","Intestinal lymphoid nodular hyperplasia" -"HP:0007460","Autoamputation of digits" -"HP:0031259","Oophoritis" -"HP:0002870","Obstructive sleep apnea" -"HP:0004625","Biconvex vertebral bodies" -"HP:0000834","Abnormality of the adrenal glands" -"HP:0011451","Congenital microcephaly" -"HP:0004898","Persistent lactic acidosis" -"HP:0004333","Bone-marrow foam cells" -"HP:0006689","Bacterial endocarditis" -"HP:0002843","Abnormal T cell morphology" -"HP:0001791","Fetal ascites" -"HP:0004343","Abnormality of glycosphingolipid metabolism" -"HP:0007468","Perifollicular hyperkeratosis" -"HP:0003609","Foam cells with lamellar inclusion bodies" -"HP:0004897","Stress/infection-induced lactic acidosis" -"HP:0040178","Increased level of platelet-activating factor" -"HP:0007412","Macular hyperpigmented dermopathy" -"HP:0000329","Facial hemangioma" -"HP:0006583","Fatal liver failure in infancy" -"HP:0031288","Cobblestone-like hyperkeratosis" -"HP:0007100","Progressive ventriculomegaly" -"HP:0006766","Papillary renal cell carcinoma" -"HP:0005348","Inspiratory stridor" -"HP:0004925","Chronic lactic acidosis" -"HP:0030832","Vitreous strands" -"HP:0031039","Early spermatogenesis maturation arrest" -"HP:0031583","Tessier number 11 facial cleft" -"HP:0000561","Absent eyelashes" -"HP:0004915","Impairment of galactose metabolism" -"HP:0030505","Nummular pigmentation of the retina" -"HP:0030348","Increased circulating androgen level" -"HP:0011135","Aplasia/Hypoplasia of the sweat glands" -"HP:0003102","Increased carrying angle" -"HP:0004581","Increased anterior vertebral height" -"HP:0040097","Neoplasm of the ceruminal gland" -"HP:0000035","Abnormality of the testis" -"HP:0005130","Restrictive heart failure" -"HP:0001949","Hypokalemic alkalosis" -"HP:0011454","Abnormality of the malleus" -"HP:0008486","Lumbar interpedicular narrowing" -"HP:0200024","Premature chromatid separation" -"HP:0008211","Parathyroid agenesis" -"HP:0000631","Retinal arterial tortuosity" -"HP:0030918","Low 1-minute APGAR score" -"HP:0030331","Impaired stimulus-induced skin wrinkling" -"HP:0003938","Synostosis involving the elbow" -"HP:0007500","Decreased number of sweat glands" -"HP:0030014","Female sexual dysfunction" -"HP:0010990","Abnormality of the common coagulation pathway" -"HP:0011728","Elbow clonus" -"HP:0007675","Progressive night blindness" -"HP:0001722","High-output congestive heart failure" -"HP:0006486","Abnormality of the dental root" -"HP:0030273","Reduced red cell adenosine deaminase activity" -"HP:0007413","Nevus flammeus of the forehead" -"HP:0012173","Orthostatic tachycardia" -"HP:0000228","Oral cavity telangiectasia" -"HP:0025532","Positive pathergy test" -"HP:0009013","Congenital absence of gluteal muscles" -"HP:0002743","Recurrent enteroviral infections" -"HP:0031423","Small cerebellar cortex" -"HP:0012555","Absent nail of hallux" -"HP:0008458","Progressive congenital scoliosis" -"HP:0002924","obsolete Decreased circulating aldosterone level" -"HP:0004099","Macrodactyly" -"HP:0006289","Agenesis of central incisor" -"HP:0008714","Ureterovesical stenosis" -"HP:0004015","Abnormality of radial metaphyses" -"HP:0002450","Abnormal motor neuron morphology" -"HP:0010363","Osteolytic defects of the phalanges of the 3rd toe" -"HP:0006530","Interstitial pulmonary abnormality" -"HP:0002905","Hyperphosphatemia" -"HP:0007917","Tractional retinal detachment" -"HP:0031223","Focal pancreatic islet hyperplasia" -"HP:0001795","Hyperconvex nail" -"HP:0003851","Lytic defects in metaphyses of the upper limbs" -"HP:0006536","Obstructive lung disease" -"HP:0007482","Generalized papillary lesions" -"HP:0010803","Everted upper lip vermilion" -"HP:0001737","Pancreatic cysts" -"HP:0030136","Enhanced ristocetin cofactor assay activity" -"HP:0009584","Osteolytic defects of the proximal phalanx of the 2nd finger" -"HP:0030235","Extremely elevated creatine phosphokinase" -"HP:0010062","Osteolytic defects of the phalanges of the hallux" -"HP:0007018","Attention deficit hyperactivity disorder" -"HP:0100750","Atelectasis" -"HP:0031028","Lactescent serum" -"HP:0010198","Osteolytic defects of the middle phalanges of the toes" -"HP:0008331","Elevated creatine kinase after exercise" -"HP:0001089","Iris atrophy" -"HP:0009763","Limb pain" -"HP:0002913","Myoglobinuria" -"HP:0031447","Penile freckling" -"HP:0000809","Urinary tract atresia" -"HP:0012458","Medial calcification of small arteries" -"HP:0001055","Erysipelas" -"HP:0001001","Abnormality of subcutaneous fat tissue" -"HP:0005972","Respiratory acidosis" -"HP:0010351","Osteolytic defects of the phalanges of the 2nd toe" -"HP:0100623","Abnormality of corpus cavernosum" -"HP:0002639","Budd-Chiari syndrome" -"HP:0010865","Oppositional defiant disorder" -"HP:0003451","Increased rate of premature chromosome condensation" -"HP:0001047","Atopic dermatitis" -"HP:0003992","Slender ulna" -"HP:0012804","Corneal ulceration" -"HP:0012253","Abnormal respiratory epithelium morphology" -"HP:0002020","Gastroesophageal reflux" -"HP:0006236","Slender metacarpals" -"HP:0100599","Bifid penis" -"HP:0005676","Rudimentary postaxial polydactyly of hands" -"HP:0003212","Increased IgE level" -"HP:0003750","Increased muscle fatiguability" -"HP:0008569","Microtia, second degree" -"HP:0012255","Dynein arm defect of respiratory motile cilia" -"HP:0010806","U-Shaped upper lip vermilion" -"HP:0400003","Focal absence of the external ear" -"HP:0002373","Febrile seizures" -"HP:0009561","Osteolytic defects of the distal phalanx of the 2nd finger" -"HP:0005696","Postaxial polydactyly type A" -"HP:0002516","Increased intracranial pressure" -"HP:0030364","Secondary Caesarian section" -"HP:0040241","Increased RIPA" -"HP:0001773","Short foot" -"HP:0012279","Hyposerinemia" -"HP:0001954","Episodic fever" -"HP:0001686","Loss of voice" -"HP:0010375","Osteolytic defects of the phalanges of the 4th toe" -"HP:0005263","Gastritis" -"HP:0011739","Dexamethasone-suppresible primary hyperaldosteronism" -"HP:0010633","Partial anosmia" -"HP:0000897","Rachitic rosary" -"HP:0000522","Alacrima" -"HP:0400005","Short ear" -"HP:0001974","Leukocytosis" -"HP:0031224","Diffuse pancreatic islet hyperplasia" -"HP:0003448","Decreased sensory nerve conduction velocity" -"HP:0031128","Impaired collagen-related peptide-induced platelet aggregation" -"HP:0008954","Intrinsic hand muscle atrophy" -"HP:0005952","Decreased pulmonary function" -"HP:0009490","Cone-shaped epiphyses of the 2nd finger" -"HP:0002607","Bowel incontinence" -"HP:0012725","Cutaneous syndactyly" -"HP:0006423","Peg-like central prominence of distal tibial metaphyses" -"HP:0040240","Increased ratio of VWF propeptide to VWF antigen" -"HP:0000756","Agoraphobia" -"HP:0010207","Osteolytic defect of the proximal toe phalanx" -"HP:0003031","Ulnar bowing" -"HP:0003326","Myalgia" -"HP:0000710","Hyperorality" -"HP:0011863","Abnormal sternal ossification" -"HP:0410028","Oral herpes" -"HP:0009384","Cone-shaped epiphyses of the 5th finger" -"HP:0001370","Rheumatoid arthritis" -"HP:0007301","Oromotor apraxia" -"HP:0010248","Cone-shaped epiphyses of the distal phalanges of the hand" -"HP:0100760","Clubbing of toes" -"HP:0002953","Vertebral compression fractures" -"HP:0005976","Hyperkalemic metabolic acidosis" -"HP:0007133","Progressive peripheral neuropathy" -"HP:0009572","Osteolytic defects of the middle phalanx of the 2nd finger" -"HP:0000867","Secondary hyperparathyroidism" -"HP:0011277","Abnormality of the urinary system physiology" -"HP:0000803","Renal cortical cysts" -"HP:0010632","Total anosmia" -"HP:0011919","Pleural empyema" -"HP:0012620","Cloacal abnormality" -"HP:0002783","Recurrent lower respiratory tract infections" -"HP:0010786","Urinary tract neoplasm" -"HP:0006647","Congenital microthorax" -"HP:0006637","Sternal punctate calcifications" -"HP:0006956","Dilation of lateral ventricles" -"HP:0006145","Central Y-shaped metacarpal" -"HP:0005609","Gallbladder dysfunction" -"HP:0002883","Hyperventilation" -"HP:0010189","Osteolytic defects of the distal phalanges of the toes" -"HP:0009437","Aplasia/Hypoplasia of the middle phalanx of the 3rd finger" -"HP:3000022","Abnormality of cartilage of external ear" -"HP:0007761","Pericentral scotoma" -"HP:0030234","Highly elevated creatine phosphokinase" -"HP:0000024","Prostatitis" -"HP:0001163","Abnormality of the metacarpal bones" -"HP:0100892","Abnormality of the xiphoid process" -"HP:0100953","Enlarged interhemispheric fissure" -"HP:0040057","Abnormality of nasal hair" -"HP:0011670","Left superior vena cava draining to coronary sinus" -"HP:0030413","Squamous cell carcinoma of the tongue" -"HP:0000919","Abnormality of the costochondral junction" -"HP:0012390","Anal fissure" -"HP:0012107","Increased fibular diameter" -"HP:0000904","Flaring of rib cage" -"HP:0008589","Hypoplastic helices" -"HP:0011151","Obtundation status" -"HP:0010938","Abnormality of the external nose" -"HP:0006561","Lipid accumulation in hepatocytes" -"HP:0008116","Flexion limitation of toes" -"HP:0005289","Abnormality of the nasolabial region" -"HP:0011449","Knee clonus" -"HP:0004864","Refractory sideroblastic anemia" -"HP:0010561","Undulate ribs" -"HP:0005949","Apneic episodes in infancy" -"HP:0000422","Abnormality of the nasal bridge" -"HP:0001340","Enhancement of the C-reflex" -"HP:0003961","Fractured forearm bones" -"HP:0004132","Dimple on nasal tip" -"HP:0006593","Anomalous rib insertion to vertebrae" -"HP:0030822","Hooded upper eyelid" -"HP:0006665","Coat hanger sign of ribs" -"HP:0030280","Rib gap" -"HP:0011398","Central hypotonia" -"HP:0006641","Prominent floating ribs" -"HP:0040059","Calcification of ribs" -"HP:0012474","Carotid artery occlusion" -"HP:0100952","Enlarged sylvian cistern" -"HP:0001853","Bifid distal phalanx of toe" -"HP:0011224","Ablepharon" -"HP:0025451","Testicular adrenal rest tumor" -"HP:0011167","Focal tonic seizures" -"HP:0012808","Abnormal nasal base" -"HP:0001039","Atheroeruptive xanthoma" -"HP:0001707","Abnormality of the right ventricle" -"HP:0000923","Beaded ribs" -"HP:0012705","Abnormal metabolic brain imaging by MRS" -"HP:0008577","Underfolded helix" -"HP:0012294","Abnormality of the occipital bone" -"HP:0410054","Decreased level of GABA in serum" -"HP:0000892","Bifid ribs" -"HP:0007182","Peripheral hypomyelination" -"HP:0006224","Tapering pointed ends of distal finger phalanges" -"HP:0200128","Biventricular hypertrophy" -"HP:0100860","Dilatation of Inferior mesenteric artery" -"HP:0008416","Six lumbar vertebrae" -"HP:0006699","Premature atrial contractions" -"HP:0012306","Abnormal rib ossification" -"HP:0006584","Small abnormally formed scapulae" -"HP:0005477","Progressive sclerosis of skull base" -"HP:0003803","Type 1 muscle fiber predominance" -"HP:0008369","Abnormal tarsal ossification" -"HP:0002280","Enlarged cisterna magna" -"HP:0005820","Superior rib anomalies" -"HP:0008775","Abnormality of the prostate" -"HP:0030007","EMG: positive sharp waves" -"HP:0006712","Aplasia/Hypoplasia of the ribs" -"HP:0430018","Abnormality of nasal musculature" -"HP:0004253","Absent trapezium" -"HP:0025530","Xanthomas of the palmar creases" -"HP:0007449","Confetti-like hypopigmented macules" -"HP:0030496","Macular exudation" -"HP:0010952","Mild fetal ventriculomegaly" -"HP:0031517","Verruciform xanthoma" -"HP:0008544","Abnormally folded helix" -"HP:0009888","Abnormality of secondary sexual hair" -"HP:3000009","Abnormality of nasalis muscle" -"HP:0010571","Elevated levels of phytanic acid" -"HP:0031290","Tuberous xanthoma" -"HP:0008807","Acetabular dysplasia" -"HP:0009608","Complete duplication of proximal phalanx of the thumb" -"HP:0002410","Aqueductal stenosis" -"HP:0005162","Left ventricular failure" -"HP:0031464","Genital blistering" -"HP:0001909","Leukemia" -"HP:0000589","Coloboma" -"HP:0031045","Acral blistering" -"HP:0010194","Aplasia/Hypoplasia of the middle phalanges of the toes" -"HP:0009087","Posteriorly placed tongue" -"HP:0100608","Metrorrhagia" -"HP:0011475","Persistent stapedial artery" -"HP:0012373","Abnormal eye physiology" -"HP:0000799","Renal steatosis" -"HP:0010093","Duplication of the proximal phalanx of the hallux" -"HP:0025321","Copper accumulation in liver" -"HP:0002277","Horner syndrome" -"HP:0002621","Atherosclerosis" -"HP:0010959","Congenital cystic adenomatoid malformation of the lung" -"HP:0010513","Pituitary calcification" -"HP:0006906","Congenital intracerebral calcification" -"HP:0001735","Acute pancreatitis" -"HP:0100813","Testicular torsion" -"HP:0003639","Elevated urinary epinephrine" -"HP:0000022","Abnormality of male internal genitalia" -"HP:0001653","Mitral regurgitation" -"HP:0002910","Elevated hepatic transaminases" -"HP:0031442","Abnormal tricuspid chordae tendinae morphology" -"HP:0006710","Aplasia/Hypoplasia of the clavicles" -"HP:0002445","Tetraplegia" -"HP:0005550","Chronic lymphatic leukemia" -"HP:0004943","Accelerated atherosclerosis" -"HP:0008222","Female infertility" -"HP:0005994","Nodular goiter" -"HP:0008707","Absent scrotum" -"HP:0045051","Decreased DLCO" -"HP:0012345","Abnormal glycosylation" -"HP:0010640","Abnormality of the nasal cavity" -"HP:0008293","Long-chain dicarboxylic aciduria" -"HP:0003642","Type I transferrin isoform profile" -"HP:0001650","Aortic valve stenosis" -"HP:0001298","Encephalopathy" -"HP:0009762","Facial wrinkling" -"HP:0001397","Hepatic steatosis" -"HP:0009915","Corneal asymmetry" -"HP:0008081","Pes valgus" -"HP:0002526","Deficit in nonword repetition" -"HP:0006951","Retrocerebellar cyst" -"HP:0000979","Purpura" -"HP:0002696","Abnormality of the parietal bone" -"HP:0025268","Stuttering" -"HP:0008383","Slow-growing nails" -"HP:0001012","Multiple lipomas" -"HP:0000925","Abnormality of the vertebral column" -"HP:0003362","Increased circulating very-low-density lipoprotein levels" -"HP:0008477","Poorly ossified cervical vertebrae" -"HP:0030205","Increased jitter at single fibre EMG" -"HP:0030776","Modic type I vertebral endplate changes" -"HP:0031566","Abnormal pulmonary valve cusp morphology" -"HP:0000486","Strabismus" -"HP:0010701","Abnormal immunoglobulin level" -"HP:0100796","Orchitis" -"HP:0031041","Obstruction of the superior vena cava" -"HP:0008672","Calcium oxalate nephrolithiasis" -"HP:0009239","Aplasia/Hypoplasia of the distal phalanx of the 5th finger" -"HP:0002248","Hematemesis" -"HP:0007045","Midline brain calcifications" -"HP:0004598","Supernumerary vertebral ossification centers" -"HP:0003540","Impaired platelet aggregation" -"HP:0005678","Anterior atlanto-occipital dislocation" -"HP:0030784","Anomia" -"HP:0001194","Abnormalities of placenta or umbilical cord" -"HP:0000495","Recurrent corneal erosions" -"HP:0005181","Premature coronary artery disease" -"HP:0040085","Abnormal circulating aldosterone" -"HP:0000705","Amelogenesis imperfecta" -"HP:0011575","Imperforate tricuspid valve" -"HP:0010309","Bifid sternum" -"HP:0002098","Respiratory distress" -"HP:0000130","Abnormality of the uterus" -"HP:0002168","Scanning speech" -"HP:0003124","Hypercholesterolemia" -"HP:0002472","Small cerebral cortex" -"HP:0100845","Anaphylactic shock" -"HP:0006693","Myocardial steatosis" -"HP:0009031","Amyotrophy of ankle musculature" -"HP:0001342","Cerebral hemorrhage" -"HP:0010875","Chaddock reflex" -"HP:0100866","Short iliac bones" -"HP:0001093","Optic nerve dysplasia" -"HP:0005177","Premature arteriosclerosis" -"HP:0006528","Chronic lung disease" -"HP:0006960","Choroid plexus calcification" -"HP:0007700","Anterior segment dysgenesis" -"HP:0011004","Abnormal systemic arterial morphology" -"HP:0001138","Optic neuropathy" -"HP:0001144","Orbital cyst" -"HP:0012703","Abnormality of the subarachnoid space" -"HP:0100052","Small epiphyses of the 2nd toe" -"HP:0000552","Tritanomaly" -"HP:0003141","Increased circulating low-density lipoprotein levels" -"HP:0002425","Anarthria" -"HP:0011099","Spastic hemiparesis" -"HP:0000014","Abnormality of the bladder" -"HP:0003333","Increased serum beta-hexosaminidase" -"HP:0003351","Decreased circulating renin level" -"HP:0030802","Lower eyelid retraction" -"HP:0004381","Supravalvular aortic stenosis" -"HP:0001889","Megaloblastic anemia" -"HP:0000840","Adrenogenital syndrome" -"HP:0003341","Junctional split" -"HP:0001879","Abnormality of eosinophils" -"HP:0008739","Labial pseudohypertrophy" -"HP:0012652","Exercise-induced asthma" -"HP:0010605","Chalazion" -"HP:0004822","Atypical elliptocytosis" -"HP:0001958","Nonketotic hypoglycemia" -"HP:0030153","Cholangiocarcinoma" -"HP:0008161","Absent leukocyte alkaline phosphatase" -"HP:0002061","Lower limb spasticity" -"HP:0002076","Migraine" -"HP:0002404","Thickened superior cerebellar peduncle" -"HP:0100582","Nasal polyposis" -"HP:0500023","Shoulder muscle aplasia" -"HP:0002097","Emphysema" -"HP:0012734","Ketotic hypoglycemia" -"HP:0008452","Wafer-thin platyspondyly" -"HP:0007206","Hemimegalencephaly" -"HP:0025109","Reduced red cell pyruvate kinase activity" -"HP:0004885","Episodic respiratory distress" -"HP:0003218","Oroticaciduria" -"HP:0009806","Nephrogenic diabetes insipidus" -"HP:0001991","Aplasia/Hypoplasia of toe" -"HP:0030863","Nasal flaring" -"HP:0012311","Monocytosis" -"HP:0007081","Late-onset muscular dystrophy" -"HP:0030864","Intercostal retractions" -"HP:0008491","Premature anterior fontanel closure" -"HP:0008738","Partially duplicated kidney" -"HP:0002064","Spastic gait" -"HP:0009028","Generalized weakness of limb muscles" -"HP:0012315","Histiocytoma" -"HP:0030675","Contracture of proximal interphalangeal joints of 2nd-5th fingers" -"HP:0011711","Left anterior fascicular block" -"HP:0001985","Hypoketotic hypoglycemia" -"HP:0012030","Increased urinary cortisol level" -"HP:0004385","Protracted diarrhea" -"HP:0000828","Abnormality of the parathyroid gland" -"HP:0003105","Protuberances at ends of long bones" -"HP:0008994","Proximal muscle weakness in lower limbs" -"HP:0002055","Curved linear dimple below the lower lip" -"HP:0003392","First dorsal interossei muscle weakness" -"HP:0040299","Decreased circulating free fatty acid level" -"HP:0100293","Muscle fiber hypertrophy" -"HP:0006964","Cerebral cortical neurodegeneration" -"HP:0011314","Abnormality of long bone morphology" -"HP:0012155","Decreased corneal sensation" -"HP:0003484","Upper limb muscle weakness" -"HP:0005722","Hyperextensible thumb" -"HP:0011343","Moderate global developmental delay" -"HP:0012053","Low serum calcifediol" -"HP:0009054","Scapuloperoneal myopathy" -"HP:0002577","Abnormality of the stomach" -"HP:0025096","Paroxysmal sneezing" -"HP:0000864","Abnormality of the hypothalamus-pituitary axis" -"HP:0011722","Mixed total anomalous pulmonary venous connection" -"HP:0030873","Anticentromere antibody positivity" -"HP:0007686","Abnormal pupillary function" -"HP:0006733","Acute megakaryocytic leukemia" -"HP:0045028","Type III lissencephaly" -"HP:0010923","Anterior subcapsular cataract" -"HP:0007570","Hyperkeratosis lenticularis perstans" -"HP:0025610","Posterior blepharitis" -"HP:0025440","Warm reactive autoantibody positivity" -"HP:0100308","Cerebral cortical hemiatrophy" -"HP:0025080","Orthokeratotic hyperkeratosis" -"HP:0008245","Pituitary hypothyroidism" -"HP:0031016","Alternating radiolucent and radiodense metaphyseal lines" -"HP:0025375","Orthotopic os odontoideum" -"HP:0011845","Short second metatarsal" -"HP:0012257","Absent inner dynein arms" -"HP:0009171","Triangular epiphyses of the metacarpals" -"HP:0008586","Hypoplasia of the cochlea" -"HP:0003152","Increased serum 1,25-dihydroxyvitamin D3" -"HP:0008399","Circumungual hyperkeratosis" -"HP:0025329","Anti-glutamic acid decarboxylase antibody positivity" -"HP:0003180","Flat acetabular roof" -"HP:0009189","Fragmentation of the metacarpal epiphyses" -"HP:0000267","Cranial asymmetry" -"HP:0008410","Subungual hyperkeratotic fragments" -"HP:0000457","Depressed nasal ridge" -"HP:0003454","Platelet antibody positive" -"HP:0010526","Dysgraphia" -"HP:0007443","Partial albinism" -"HP:0040180","Hyperkeratosis pilaris" -"HP:0005235","Jejunal atresia" -"HP:0010713","1-5 toe syndactyly" -"HP:0008117","Shortening of the talar neck" -"HP:0011889","Bleeding with minor or no trauma" -"HP:0008498","No permanent dentition" -"HP:0004003","Medially flattened radial epiphyses" -"HP:0012210","Abnormal renal morphology" -"HP:0012157","Subcortical cerebral atrophy" -"HP:0009944","Partial duplication of thumb phalanx" -"HP:0007744","Iridoretinal coloboma" -"HP:0007448","Hyperkeratosis over edematous areas" -"HP:0007827","Nodular corneal dystrophy" -"HP:0011890","Prolonged bleeding following procedure" -"HP:0007193","Generalized tonic-clonic seizures on awakening" -"HP:0001748","Polysplenia" -"HP:0011907","Reduced alpha/beta synthesis ratio" -"HP:0011341","Long upper lip" -"HP:0011906","Reduced beta/alpha synthesis ratio" -"HP:0012402","Increased urine alpha-ketoglutarate concentration" -"HP:0006695","Atrioventricular canal defect" -"HP:0011510","Drusen" -"HP:0025428","Bronchospasm" -"HP:0004686","Short third metatarsal" -"HP:0006012","Widened metacarpal shaft" -"HP:0030908","Liver kidney microsome type 1 antibody positivity" -"HP:0005612","Arthrogryposis-like hand anomaly" -"HP:0012203","Onychomycosis" -"HP:0003562","Abnormal metaphyseal vascular invasion" -"HP:0040231","Abnormal onset of bleeding" -"HP:0011018","Abnormality of the cell cycle" -"HP:0009839","Osteolytic defects of the distal phalanges of the hand" -"HP:0005575","Hemolytic-uremic syndrome" -"HP:0100260","Mesoaxial polydactyly" -"HP:0045059","Hyperkeratotic papule" -"HP:0025499","Class I obesity" -"HP:0001169","Broad palm" -"HP:0011131","Perianal rash" -"HP:0007535","Hypopigmented streaks" -"HP:0003021","Metaphyseal cupping" -"HP:0010016","Bracket epiphysis of the 1st metacarpal" -"HP:0025381","Anti-pituitary antibody positivity" -"HP:0025324","Arterial occlusion" -"HP:0004757","Paroxysmal atrial fibrillation" -"HP:0003398","Abnormal synaptic transmission at the neuromuscular junction" -"HP:0012743","Abdominal obesity" -"HP:0010522","Dyslexia" -"HP:0012066","Increased urinary disaccharide excretion" -"HP:0004689","Short fourth metatarsal" -"HP:0005599","Hypopigmentation of hair" -"HP:0001543","Gastroschisis" -"HP:0200098","Absent skin pigmentation" -"HP:0004552","Scarring alopecia of scalp" -"HP:0003526","Orotic acid crystalluria" -"HP:0030208","Acetylcholine receptor antibody positivity" -"HP:0009793","Presacral teratoma" -"HP:0007421","Telangiectases of the cheeks" -"HP:0001530","Mild postnatal growth retardation" -"HP:0007554","Confetti hypopigmentation pattern of lower leg skin" -"HP:0012270","Decreased muscle glycogen content" -"HP:0007993","Malformed lacrimal ducts" -"HP:0003977","Deformed radius" -"HP:0002263","Exaggerated cupid's bow" -"HP:0031104","Insulin receptor antibody positivity" -"HP:0040162","Orthokeratosis" -"HP:0030880","Raynaud phenomenon" -"HP:0025379","Anti-thyroid peroxidase antibody positivity" -"HP:0030876","Increased pulmonary capillary wedge pressure" -"HP:0030167","Antimitochondrial antibody positivity" -"HP:0007838","Progressive ptosis" -"HP:0030859","Topoisomerase I antibody positivity" -"HP:0012348","Decreased galactosylation of N-linked protein glycosylation" -"HP:0100804","Ungual fibroma" -"HP:0002546","Incomprehensible speech" -"HP:0003133","Abnormality of the spinocerebellar tracts" -"HP:0030888","C3 nephritic factor positivity" -"HP:0007501","Streaks of hyperkeratosis along each finger onto the palm" -"HP:0006150","Swan neck-like deformities of the fingers" -"HP:0007207","Photosensitive tonic-clonic seizures" -"HP:0030209","Calcium channel antibody positivity" -"HP:0003908","Corner fracture of metaphysis" -"HP:0011936","Decreased plasma total carnitine" -"HP:0001112","Leber optic atrophy" -"HP:0006962","Gait instability, worse in the dark" -"HP:0008468","Abnormal sacral segmentation" -"HP:0025190","Generalized tonic-clonic seizures without focal onset" -"HP:0010851","EEG with burst suppression" -"HP:0003905","Abnormality of the humeral epiphyseal plate" -"HP:0025343","Lupus anticoagulant" -"HP:0030047","Abnormality of lateral ventricle" -"HP:0007490","Linear arrays of macular hyperkeratoses in flexural areas" -"HP:0011888","Bleeding requiring red cell transfusion" -"HP:0025501","Class III obesity" -"HP:0002242","Abnormality of the intestine" -"HP:0004312","Abnormality of reticulocytes" -"HP:0003193","Allergic rhinitis" -"HP:0004447","Poikilocytosis" -"HP:0004294","Subluxation of metacarpal phalangeal joints" -"HP:0002181","Cerebral edema" -"HP:0010490","Abnormality of the palmar creases" -"HP:0003339","Pyrimidine-responsive megaloblastic anemia" -"HP:0012134","Dysplastic erythropoesis" -"HP:0011754","Pituicytoma" -"HP:0010970","Blood group antigen abnormality" -"HP:0007359","Focal seizures" -"HP:0000974","Hyperextensible skin" -"HP:0031533","Multifocal sub-RPE deposits" -"HP:0003487","Babinski sign" -"HP:0006409","Progressive leg bowing" -"HP:0008285","Transient hypophosphatemia" -"HP:0025332","Abnormality of foot cortical bone" -"HP:0010629","Abnormal morphology of the cortex of the humerus" -"HP:0000789","Infertility" -"HP:0001394","Cirrhosis" -"HP:0005546","Increased red cell osmotic resistance" -"HP:0011838","Sclerodactyly" -"HP:0100326","Immunologic hypersensitivity" -"HP:0030271","Reduced erythrocyte 2,3-diphosphoglycerate concentration" -"HP:0010608","Hordeolum internum" -"HP:0002088","Abnormality of lung morphology" -"HP:0005502","Increased red cell osmotic fragility" -"HP:0003901","Stippled calcification of the humeral epiphyses" -"HP:0004372","Reduced consciousness/confusion" -"HP:0011578","Transitional atrioventricular canal defect" -"HP:0002105","Hemoptysis" -"HP:0005882","Dermatoglyphic variants" -"HP:0040328","Focal hyperintensity of cerebral white matter on MRI" -"HP:0001260","Dysarthria" -"HP:0010229","Bracket epiphyses of the phalanges of the hand" -"HP:0005926","Abnormality of hand cortical bone" -"HP:0005132","Pericardial constriction" -"HP:0008306","Abnormal iron deposition in mitochondria" -"HP:0007868","Age-related macular degeneration" -"HP:0000964","Eczema" -"HP:0100570","Carcinoid tumor" -"HP:0000902","Rib fusion" -"HP:0001895","Normochromic anemia" -"HP:0100844","Pancreatic fistula" -"HP:0100600","Penoscrotal transposition" -"HP:0003923","Square humeral metaphysis" -"HP:0002033","Poor suck" -"HP:0001948","Alkalosis" -"HP:0012187","Increased erythrocyte protoporphyrin concentration" -"HP:0012131","Abnormal number of erythroid precursors" -"HP:0030272","Abnormal erythrocyte enzyme activity" -"HP:0001572","Macrodontia" -"HP:0025372","Loud snoring" -"HP:0000052","Urethral atresia, male" -"HP:0002196","Myelopathy" -"HP:0000872","Hashimoto thyroiditis" -"HP:0001024","Skin dimple over apex of long bone angulation" -"HP:0030757","Tooth abscess" -"HP:0000031","Epididymitis" -"HP:0010310","Chylothorax" -"HP:0009774","Triangular shaped phalanges of the hand" -"HP:0004621","Enlarged vertebral pedicles" -"HP:0001905","Congenital thrombocytopenia" -"HP:0003573","Increased total bilirubin" -"HP:0010445","Primum atrial septal defect" -"HP:0000830","Anterior hypopituitarism" -"HP:0000090","Nephronophthisis" -"HP:0010576","Intracranial cystic lesion" -"HP:0003917","Pointed humeral metaphysis" -"HP:0100253","Abnormality of the medullary cavity of the long bones" -"HP:0006496","Aplasia/hypoplasia involving bones of the upper limbs" -"HP:0005202","Helicobacter pylori infection" -"HP:0010884","Acromelia" -"HP:0025065","Abnormal erythrocyte volume" -"HP:0100827","Lymphocytosis" -"HP:0003910","Enlarged humeral metaphyses" -"HP:0003138","Increased blood urea nitrogen" -"HP:0004813","Post-transfusion thrombocytopenia" -"HP:0012785","Flexion contracture of finger" -"HP:0025119","Violet lip discoloration" -"HP:0100542","Abnormal localization of kidney" -"HP:0012176","Abnormal natural killer morphology" -"HP:0003347","Impaired lymphocyte transformation with phytohemagglutinin" -"HP:0011001","Increased bone mineral density" -"HP:0006408","Distal tapering femur" -"HP:0100885","Lateral venous anomaly" -"HP:0007862","Retinal calcification" -"HP:0001981","Schistocytosis" -"HP:0008441","Herniation of intervertebral nuclei" -"HP:0008461","Cervical vertebral facet hypoplasia" -"HP:0010744","Absent metatarsal bone" -"HP:0012890","Posteriorly placed anus" -"HP:0006643","Fused sternal ossification centers" -"HP:0004450","Preauricular skin furrow" -"HP:0001043","Prominent scalp veins" -"HP:0011746","Secretory adrenocortical adenoma" -"HP:0002346","Head tremor" -"HP:0001756","Vestibular hypofunction" -"HP:0002920","Decreased circulating ACTH level" -"HP:0010861","Incomplete breech presentation" -"HP:0001922","Vacuolated lymphocytes" -"HP:0004580","Anterior scalloping of vertebral bodies" -"HP:0030168","Dilated superficial abdominal veins" -"HP:0031580","Tessier number 8 facial cleft" -"HP:0002224","Woolly hair" -"HP:0003761","Calcinosis" -"HP:0002971","Absent microvilli on the surface of peripheral blood lymphocytes" -"HP:0004356","Abnormality of lysosomal metabolism" -"HP:0002749","Osteomalacia" -"HP:0010646","Cervical spine instability" -"HP:0003097","Short femur" -"HP:0000117","Renal phosphate wasting" -"HP:0012516","Tetralogy of Fallot with pulmonary atresia" -"HP:0030488","Abnormal central response of multifocal electroretinogram" -"HP:0005849","Diffuse cerebral calcification" -"HP:0004912","Hypophosphatemic rickets" -"HP:0011659","Tetralogy of Fallot with absent pulmonary valve" -"HP:0100036","Pseudo-fractures" -"HP:0005518","Increased mean corpuscular volume" -"HP:0004603","Hyperconvex vertebral body endplates" -"HP:0011603","Congenital malformation of the great arteries" -"HP:0002897","Parathyroid adenoma" -"HP:0006208","Metaphyseal cupping of proximal phalanges" -"HP:0010095","Partial duplication of the proximal phalanx of the hallux" -"HP:0005201","Anomalous splenoportal venous system" -"HP:0005117","Elevated diastolic blood pressure" -"HP:0002645","Wormian bones" -"HP:0008732","Renal hypophosphatemia" -"HP:0010656","Abnormal epiphyseal ossification" -"HP:0010860","Complete breech presentation" -"HP:0005199","Aplasia of the abdominal wall musculature" -"HP:0009252","Cone-shaped epiphysis of the distal phalanx of the 4th finger" -"HP:0009820","Lower limb peromelia" -"HP:0100669","Abnormal pigmentation of the oral mucosa" -"HP:0003568","Decreased glucosephosphate isomerase activity" -"HP:0007067","Distal peripheral sensory neuropathy" -"HP:0030934","Oral erythroplakia" -"HP:0040306","Decreased male libido" -"HP:0008497","Congenital craniofacial dysostosis" -"HP:0031090","Finger dactylitis" -"HP:0000550","Undetectable electroretinogram" -"HP:0030939","Palpebral thickening" -"HP:0001947","Renal tubular acidosis" -"HP:0008555","Absent vestibular function" -"HP:0004909","Hypokalemic hypochloremic metabolic alkalosis" -"HP:0006491","Abnormality of the tibial metaphysis" -"HP:0100890","Cyst of the ductus choledochus" -"HP:0040300","Abnormal circulating free fatty acid level" -"HP:0010702","Increased antibody level in blood" -"HP:0008341","Distal renal tubular acidosis" -"HP:0004788","Intestinal lymphedema" -"HP:0012126","Stomach cancer" -"HP:0002562","Low-set nipples" -"HP:0001105","Retinal atrophy" -"HP:0003886","Wide humerus" -"HP:0011967","Hypocupremia" -"HP:0008364","Abnormality of the calcaneus" -"HP:0005948","Cystic lung disease" -"HP:0001099","Fundus atrophy" -"HP:0010734","Fibrous dysplasia of the bones" -"HP:0012497","Reduced maximal expiratory pressure" -"HP:0005230","Biliary tract obstruction" -"HP:0010328","Polydactyly affecting the 2nd toe" -"HP:0009829","Phocomelia" -"HP:0000819","Diabetes mellitus" -"HP:0005616","Accelerated skeletal maturation" -"HP:0005093","Absent proximal radial epiphyses" -"HP:0010889","Morbus Kienboeck" -"HP:0003691","Scapular winging" -"HP:0040080","Anteverted ears" -"HP:0001875","Neutropenia" -"HP:0011969","Elevated circulating luteinizing hormone level" -"HP:0005789","Generalized osteosclerosis" -"HP:0001657","Prolonged QT interval" -"HP:0003282","Low alkaline phosphatase" -"HP:0010575","Dysplasia of the femoral head" -"HP:0100300","Desmin bodies" -"HP:0100511","Abnormality of vitamin D metabolism" -"HP:0005523","Lymphoproliferative disorder" -"HP:0030608","Increased OCT-measured macular thickness" -"HP:0010118","Irregular epiphyses of the hallux" -"HP:0011945","Bronchiolitis obliterans organizing pneumonia" -"HP:0011128","Acute esophageal necrosis" -"HP:0002515","Waddling gait" -"HP:0008970","Scapulohumeral muscular dystrophy" -"HP:0005219","Absence of intrinsic factor" -"HP:0006152","Proximal symphalangism of hands" -"HP:0001176","Large hands" -"HP:0000863","Central diabetes insipidus" -"HP:0030432","Chondroblastoma" -"HP:0011770","Tertiary hyperparathyroidism" -"HP:0011027","Abnormality of the fallopian tube" -"HP:0000726","Dementia" -"HP:0008818","Large iliac wings" -"HP:0009337","Cone-shaped epiphysis of the distal phalanx of the 3rd finger" -"HP:0040154","Acne inversa" -"HP:0009789","Perianal abscess" -"HP:0009566","Short distal phalanx of the 2nd finger" -"HP:0000122","Unilateral renal agenesis" -"HP:0004377","Hematological neoplasm" -"HP:0010036","Aplasia/Hypoplasia of the 2nd metacarpal" -"HP:0040188","Osteochondrosis" -"HP:0001970","Tubulointerstitial nephritis" -"HP:0012496","Reduced maximal inspiratory pressure" -"HP:0004938","Tortuous cerebral arteries" -"HP:0000989","Pruritus" -"HP:0030961","Microspherophakia" -"HP:0011546","Abnormal atrioventricular connection" -"HP:0010606","Hordeolum" -"HP:0100838","Recurrent cutaneous abscess formation" -"HP:0030664","Beevor's sign" -"HP:0012137","Abnormal number of granulocyte precursors" -"HP:0002331","Recurrent paroxysmal headache" -"HP:0002343","Normal pressure hydrocephalus" -"HP:0001635","Congestive heart failure" -"HP:0004993","Slender long bones with narrow diaphyses" -"HP:0012818","Biventricular noncompaction cardiomyopathy" -"HP:0100954","Open operculum" -"HP:0012816","Right ventricular noncompaction cardiomyopathy" -"HP:0012594","Microalbuminuria" -"HP:0007153","Progressive extrapyramidal movement disorder" -"HP:0009385","Enlarged epiphyses of the 5th finger" -"HP:0030493","Abnormality of foveal pigmentation" -"HP:0007366","Atrophy/Degeneration affecting the brainstem" -"HP:0000805","Enuresis" -"HP:3000076","Abnormality of lingual tonsil" -"HP:0000603","Central scotoma" -"HP:0001402","Hepatocellular carcinoma" -"HP:0009645","Osteolytic defect of the distal phalanx of the thumb" -"HP:0008609","Morphological abnormality of the middle ear" -"HP:0011165","Visual auras" -"HP:0002148","Hypophosphatemia" -"HP:0010709","2-4 finger syndactyly" -"HP:0011457","Loss of eyelashes" -"HP:0010782","Shoulder dimples" -"HP:0030447","Merkel cell skin cancer" -"HP:0006276","Hyperechogenic pancreas" -"HP:0100717","Abnormality of the cementum" -"HP:0010084","Duplication of the distal phalanx of the hallux" -"HP:0012842","Skin appendage neoplasm" -"HP:0000385","Small earlobe" -"HP:0000614","Abnormality of the nasolacrimal system" -"HP:0003063","Abnormality of the humerus" -"HP:0025127","Actinic keratosis" -"HP:0100694","Tibial torsion" -"HP:0006179","Pseudoepiphyses of second metacarpal" -"HP:0000617","Abnormality of ocular smooth pursuit" -"HP:0007606","Multiple cutaneous malignancies" -"HP:0010711","1-2 toe syndactyly" -"HP:0002974","Radioulnar synostosis" -"HP:0010838","High nonceruloplasmin-bound serum copper" -"HP:0011163","Somatosensory auras" -"HP:0009931","Enlarged naris" -"HP:0010270","Cone-shaped epiphyses of the proximal phalanges of the hand" -"HP:0008848","Moderately short stature" -"HP:0031287","Seborrheic keratosis" -"HP:0008259","Adrenocorticotropin receptor defect" -"HP:0009274","Joint contracture of the 4th finger" -"HP:0006986","Upper limb spasticity" -"HP:0010799","Pinealoma" -"HP:0009554","Projection of scalp hair onto lateral cheek" -"HP:0010731","Extension of eyebrows towards upper eyelid" -"HP:0006904","Late-onset spinocerebellar degeneration" -"HP:0031801","Vocal cord dysfunction" -"HP:0100521","Neoplasm of the thymus" -"HP:0009677","Cone-shaped epiphysis of the distal phalanx of the thumb" -"HP:0007787","Posterior subcapsular cataract" -"HP:0006778","Benign genitourinary tract neoplasm" -"HP:0003429","CNS hypomyelination" -"HP:0030812","Enlarged tonsils" -"HP:0005532","Macrocytic dyserythropoietic anemia" -"HP:0008142","Delayed calcaneal ossification" -"HP:0005946","Ventilator dependence with inability to wean" -"HP:0012532","Chronic pain" -"HP:0009067","Progressive spinal muscular atrophy" -"HP:0012704","Widened subarachnoid space" -"HP:0006440","Increased density of long bone diaphyses" -"HP:0008402","Ridged fingernail" -"HP:0006821","Polymicrogyria, anterior to posterior gradient" -"HP:0001800","Hypoplastic toenails" -"HP:0001071","Angiokeratoma corporis diffusum" -"HP:0200125","Mitochondrial respiratory chain defects" -"HP:0030690","Gingival cleft" -"HP:0012091","Abnormality of pancreas physiology" -"HP:0031234","Neutrophilic infiltration of the skin" -"HP:0012368","Flat face" -"HP:0012144","Abnormality of cells of the monocyte/macrophage lineage" -"HP:0003557","Increased variability in muscle fiber diameter" -"HP:0010469","Absent testis" -"HP:0100712","Abnormality of the lumbar spine" -"HP:0007095","Frontoparietal polymicrogyria" -"HP:0011133","Increased sensitivity to ionizing radiation" -"HP:0008366","Contractures involving the joints of the feet" -"HP:0011566","Cor triatriatum dexter" -"HP:0410019","Epigastric pain" -"HP:0006107","Fingerpad telangiectases" -"HP:0011589","Common origin of the right brachiocephalic artery and left common carotid artery" -"HP:0010491","Digital constriction ring" -"HP:0030840","Ankle pain" -"HP:0000581","Blepharophimosis" -"HP:0031520","Groin pain" -"HP:0025238","Foot pain" -"HP:0002963","Abnormal delayed hypersensitivity skin test" -"HP:0007586","Telangiectases producing 'marbled' skin" -"HP:0000836","Hyperthyroidism" -"HP:0030943","Vulvodynia" -"HP:0012533","Allodynia" -"HP:0002866","Hypoplastic iliac wing" -"HP:0030069","Primary central nervous system lymphoma" -"HP:0009230","Osteolytic defects of the proximal phalanx of the 5th finger" -"HP:0001188","Hand clenching" -"HP:0030180","Oppenheim reflex" -"HP:0003010","Prolonged bleeding time" -"HP:0008398","Hypoplastic fifth fingernail" -"HP:0031472","Risk taking" -"HP:0001838","Rocker bottom foot" -"HP:0008352","Impaired platelet adhesion" -"ChEMBL:20883","tegafur" -"ChEMBL:128988","frentizole" -"ChEMBL:684","diethylcarbamazine" -"ChEMBL:1697840","iodothiouracil" -"ChEMBL:113","caffeine" -"ChEMBL:13291","fludiazepam" -"ChEMBL:1455","altretamine" -"ChEMBL:1201464","choriogonadotropin alfa" -"ChEMBL:1096885","valrubicin" -"ChEMBL:1027","tiagabine" -"ChEMBL:1162144","pyruvic acid" -"ChEMBL:64","isoniazid" -"ChEMBL:1201362","clobetasol" -"ChEMBL:477772","pazopanib" -"ChEMBL:2146126","lithium" -"ChEMBL:70566","eptazocine" -"ChEMBL:583042","vx-11e" -"ChEMBL:1198","pramoxine" -"ChEMBL:2104232","fenprostalene" -"ChEMBL:1626223","pyrantel" -"ChEMBL:517","disopyramide" -"ChEMBL:4","ofloxacin" -"ChEMBL:1201748","cabazitaxel" -"ChEMBL:1109","sulfaphenazole" -"ChEMBL:119","trimetrexate" -"ChEMBL:1730601","gimeracil" -"ChEMBL:866","mycophenolic acid" -"ChEMBL:1094636","niraparib" -"ChEMBL:499808","caspofungin" -"ChEMBL:649","nadolol" -"ChEMBL:116","amprenavir" -"ChEMBL:1535","hydroxychloroquine" -"ChEMBL:2105041","dimoxyline" -"ChEMBL:370143","paromomycin" -"ChEMBL:46102","roxatidine" -"ChEMBL:2103837","tafamidis" -"ChEMBL:1201621","somatropin" -"ChEMBL:1201387","trandolaprilat" -"ChEMBL:1228","oxyphenbutazone anhydrous" -"ChEMBL:1201406","ethynodiol" -"ChEMBL:568","oxazepam" -"ChEMBL:1201237","levobunolol" -"ChEMBL:1059","pregabalin" -"ChEMBL:1639","aliskiren" -"ChEMBL:1005","remifentanil" -"ChEMBL:980","guaifenesin" -"ChEMBL:3039525","golvatinib" -"ChEMBL:238804","selexipag" -"ChEMBL:95","tacrine" -"ChEMBL:2219536","mipomersen" -"ChEMBL:2105581","veralipride" -"ChEMBL:2110922","amezinium" -"ChEMBL:291962","leucine" -"ChEMBL:1620144","pyricarbate" -"ChEMBL:2059073","sulisobenzone" -"ChEMBL:951","iophendylate" -"ChEMBL:489326","cabozantinib" -"ChEMBL:625","thiabendazole" -"ChEMBL:240163","pazufloxacin" -"ChEMBL:965","carbamoylcholine" -"ChEMBL:3353410","osimertinib" -"ChEMBL:652","flecainide" -"ChEMBL:2110646","flutropium" -"ChEMBL:127643","dimethisoquin" -"ChEMBL:704","mesalamine" -"ChEMBL:3039537","sebelipase alfa" -"ChEMBL:680","cefaclor anhydrous" -"ChEMBL:1200969","dutasteride" -"ChEMBL:1201595","laronidase" -"ChEMBL:163672","chromonar" -"ChEMBL:1508","escitalopram" -"ChEMBL:30008","flunarizine" -"ChEMBL:81697","ethyl biscoumacetate" -"ChEMBL:2111003","peplomycin" -"ChEMBL:1201688","fomivirsen" -"ChEMBL:1088","mesoridazine" -"ChEMBL:2403108","ceritinib" -"ChEMBL:1037","guanadrel" -"ChEMBL:1175","duloxetine" -"ChEMBL:1186579","methylnaltrexone" -"ChEMBL:2108278","eteplirsen" -"ChEMBL:1200633","ivermectin" -"ChEMBL:1200851","methylhomatropine" -"ChEMBL:551466","aclidinium" -"ChEMBL:83","tamoxifen" -"ChEMBL:1676","fluticasone furoate" -"ChEMBL:108","carbamazepine" -"ChEMBL:6966","verapamil" -"ChEMBL:363295","terodiline" -"ChEMBL:596","fentanyl" -"ChEMBL:1201752","ixabepilone" -"ChEMBL:1200555","iotrolan" -"ChEMBL:1201620","somatrem" -"ChEMBL:1663","perflutren" -"ChEMBL:1201407","unoprostone" -"ChEMBL:1648","isradipine" -"ChEMBL:1454","levamisole" -"ChEMBL:2103822","tasimelteon" -"ChEMBL:1201168","isocarboxazid" -"ChEMBL:1201182","temsirolimus" -"ChEMBL:226345","adenine" -"ChEMBL:1398654","chlorisondamine" -"ChEMBL:505","chlorpheniramine" -"ChEMBL:2104208","emylcamate" -"ChEMBL:1213353","prifinium" -"ChEMBL:314854","fingolimod" -"ChEMBL:1201779","benzylpenicilloyl polylysine" -"ChEMBL:1206690","parecoxib" -"ChEMBL:1736","metrizoic acid" -"ChEMBL:2104860","mepitiostane" -"ChEMBL:1272","repaglinide" -"ChEMBL:1201262","dipivefrin" -"ChEMBL:479","thioridazine" -"ChEMBL:1095097","eplerenone" -"ChEMBL:152","cidofovir anhydrous" -"ChEMBL:1201208","phenmetrazine" -"ChEMBL:264241","anidulafungin" -"HP:0002221","Absent axillary hair" -"HP:0001225","Wrist swelling" -"HP:0008158","Hyperapobetalipoproteinemia" -"HP:0001677","Coronary artery disease" -"HP:0031337","Abnormal cardiomyocyte connexin43 staining" -"HP:0006735","Renal cortical adenoma" -"HP:0010955","Dilatation of the bladder" -"HP:0006333","Crowded maxillary incisors" -"HP:0001681","Angina pectoris" -"HP:0006371","Broad long bone diaphyses" -"HP:0045029","Eosinophilic fasciitis" -"HP:0100665","Angioedema" -"HP:0011424","Increased serum zinc" -"HP:0005558","Chronic leukemia" -"HP:0009854","Curved proximal phalanges of the hand" -"HP:0004950","Peripheral arterial stenosis" -"HP:0008360","Neonatal hypoproteinemia" -"HP:0001297","Stroke" -"HP:0100133","Abnormality of the pubic hair" -"HP:0012732","Anorectal anomaly" -"HP:0001403","Macrovesicular hepatic steatosis" -"HP:0000125","Pelvic kidney" -"HP:0001683","Ectopia cordis" -"HP:0030409","Renal transitional cell carcinoma" -"HP:0002119","Ventriculomegaly" -"HP:0000991","Xanthomatosis" -"HP:0004352","Abnormality of purine metabolism" -"HP:0001574","Abnormality of the integument" -"HP:0003081","Increased urinary potassium" -"HP:0011860","Metaphyseal dappling" -"HP:0002638","Superficial thrombophlebitis" -"HP:0011798","Renal oncocytoma" -"HP:0005145","Coronary artery stenosis" -"HP:0100507","Folate deficiency" -"HP:0031049","Heavy-chain paraproteinemia" -"HP:0002611","Cholestatic liver disease" -"HP:0001944","Dehydration" -"HP:0010716","3-5 toe syndactyly" -"HP:0007511","Mottled pigmentation of photoexposed areas" -"HP:0007929","Peripheral retinal detachment" -"HP:0400008","Menometrorrhagia" -"HP:0004798","Recurrent infection of the gastrointestinal tract" -"HP:0000555","Leukocoria" -"HP:0002617","Dilatation" -"HP:0008663","Renal sarcoma" -"HP:0200011","Abnormal length of corpus callosum" -"HP:0002584","Intestinal bleeding" -"HP:0012171","Stereotypical hand wringing" -"HP:0007651","Ectropion of lower eyelids" -"HP:0011794","Embryonal renal neoplasm" -"HP:0008443","Spinal deformities" -"HP:0012051","Reactive hypoglycemia" -"HP:0025123","White streaks/specks on enamel." -"HP:0001917","Renal amyloidosis" -"HP:0004227","Short distal phalanx of the 5th finger" -"HP:0003906","Broad humeral epiphyseal plate" -"HP:0000136","Bifid uterus" -"HP:0001807","Ridged nail" -"HP:0000876","Oligomenorrhea" -"HP:0100495","Mastocytosis" -"HP:0007480","Decreased sweating due to autonomic dysfunction" -"HP:0100777","Exostoses" -"HP:0004230","Subluxation of the proximal interphalangeal joint of the little finger" -"HP:0011932","Abnormality of the superior cerebellar peduncle" -"HP:0004249","Accessory lunate" -"HP:0100356","Contracture of the metatarsophalangeal joint of the 2nd toe" -"HP:0011815","Cephalocele" -"HP:0012569","Delayed menarche" -"HP:0005681","Juvenile rheumatoid arthritis" -"HP:0012194","Episodic hemiplegia" -"HP:0012136","Dysplastic granulopoesis" -"HP:0040293","Right hemiplegia" -"HP:0010819","Atonic seizures" -"HP:0005720","Shortening of all metacarpals" -"HP:0100758","Gangrene" -"HP:0005881","Spinal instability" -"HP:0006161","Short metacarpals with rounded proximal ends" -"HP:0031630","Abnormal subpleural morphology" -"HP:0008696","Renal hamartoma" -"HP:0007759","Opacification of the corneal stroma" -"HP:0004464","Postauricular pit" -"HP:0007595","Redundant skin in infancy" -"HP:0001557","Prenatal movement abnormality" -"HP:0010034","Short 1st metacarpal" -"HP:0011859","Punctate keratitis" -"HP:0003073","Hypoalbuminemia" -"HP:0012169","Self-biting" -"HP:0007707","Congenital primary aphakia" -"HP:0031283","Tufted hairs" -"HP:0011875","Abnormal platelet morphology" -"HP:0030237","Hand muscle weakness" -"HP:0100001","Malignant mesothelioma" -"HP:0010226","Abnormality of the epiphysis of the 5th metacarpal" -"HP:0002716","Lymphadenopathy" -"HP:0012238","Increased circulating chylomicron levels" -"HP:0011994","Abnormality of the atrial septum" -"HP:0007425","Hyperextensible skin of face" -"HP:0010460","Abnormality of the female genitalia" -"HP:0025042","Abnormality of mesenteric lymph nodes" -"HP:0006334","Hypoplasia of the primary teeth" -"HP:0003782","Eunuchoid habitus" -"HP:0002867","Abnormality of the ilium" -"HP:0011213","EEG with photoparoxysmal response grade III" -"HP:0003174","Abnormality of the ischium" -"HP:0010340","Polydactyly affecting the 4th toe" -"HP:0004495","Thin anteverted nares" -"HP:0031515","Abnormal meiosis" -"HP:0008111","Broad distal hallux" -"HP:0001827","Genital tract atresia" -"HP:0030191","Abnormal peripheral nervous system synaptic transmission" -"HP:0010438","Abnormal ventricular septum morphology" -"HP:0031347","Uterine arteriovenous malformation" -"HP:0011214","EEG with photoparoxysmal response grade IV" -"HP:0011576","Intermediate atrioventricular canal defect" -"HP:0011211","EEG with photoparoxysmal response grade I" -"HP:0008165","Reduced circulating T-helper cells" -"HP:0006977","Grammar-specific speech disorder" -"HP:0030797","Reduced volume of central subdivision of bed nucleus of stria terminalis" -"HP:0011402","Demyelinating sensory neuropathy" -"HP:0012244","Abnormal sex determination" -"HP:0003640","Foam cells in visceral organs and CNS" -"HP:0003252","Anteriorly displaced genitalia" -"HP:0000811","Abnormal external genitalia" -"HP:0010958","Bilateral renal agenesis" -"HP:0005590","Spotty hypopigmentation" -"HP:0001407","Hepatic cysts" -"HP:0000151","Aplasia of the uterus" -"HP:0030491","Choriocapillaris atrophy" -"HP:0001029","Poikiloderma" -"HP:0010529","Echolalia" -"HP:0010280","Stomatitis" -"HP:0004975","Erlenmeyer flask deformity of the femurs" -"HP:0010678","Enuresis diurna" -"HP:0000541","Retinal detachment" -"HP:0030268","Hyperplastic callus formation" -"HP:0000174","Abnormality of the palate" -"HP:0012381","Delayed self-feeding during toddler years" -"HP:0100523","Liver abscess" -"HP:0006493","Aplasia/hypoplasia involving bones of the lower limbs" -"HP:0007524","Atypical neurofibromatosis" -"HP:0005148","Pulmonary valve defects" -"HP:0007434","Plaque-like facial hemangioma" -"HP:0002092","Pulmonary arterial hypertension" -"HP:0012722","Heart block" -"HP:0011067","Mesiodens" -"HP:0000476","Cystic hygroma" -"HP:0012063","Aneurysmal bone cyst" -"HP:0010017","Cone-shaped epiphysis of the 1st metacarpal" -"HP:0001362","Calvarial skull defect" -"HP:0000054","Micropenis" -"HP:0003495","GM2-ganglioside accumulation" -"HP:0012065","Multiple bony cystic lesions" -"HP:0000622","Blurred vision" -"HP:0100303","Muscle fiber cytoplasmatic inclusion bodies" -"HP:0001743","Abnormality of the spleen" -"HP:0001100","Heterochromia iridis" -"HP:0000067","Urethral atresia, female" -"HP:0008345","Hypoplasia of the iris dilator muscle" -"HP:0002121","Absence seizures" -"HP:0011073","Abnormality of dental color" -"HP:0006510","Chronic obstructive pulmonary disease" -"HP:0004914","Recurrent infantile hypoglycemia" -"HP:0000271","Abnormality of the face" -"HP:0002133","Status epilepticus" -"HP:0009594","Retinal hamartoma" -"HP:0025423","Abnormal larynx morphology" -"HP:0011953","Pulmonary lymphoma" -"HP:0011100","Intestinal atresia" -"HP:0006439","Radioulnar dislocation" -"HP:0200042","Skin ulcer" -"HP:0011097","Epileptic spasms" -"HP:0009263","Cone-shaped epiphysis of the proximal phalanx of the 4th finger" -"HP:0000481","Abnormality of the cornea" -"HP:0003774","Stage 5 chronic kidney disease" -"HP:0005653","Moderate generalized osteoporosis" -"HP:0010222","Abnormality of the epiphysis of the 3rd metacarpal" -"HP:0005318","Cerebral vasculitis" -"HP:0100041","Broad 3rd toe" -"HP:0004451","Postauricular skin tag" -"HP:0000123","Nephritis" -"HP:0011285","Long-segment aganglionic megacolon" -"HP:0030082","Abnormal drinking behavior" -"HP:0007328","Impaired pain sensation" -"HP:0006380","Knee flexion contracture" -"HP:0002370","Poor coordination" -"HP:0100605","Neoplasm of the larynx" -"HP:0000960","Sacral dimple" -"HP:0500028","Cotton wool plaques" -"HP:0001409","Portal hypertension" -"HP:0011517","Cone monochromacy" -"HP:0200048","Cyanotic episode" -"HP:0004787","Fulminant hepatitis" -"HP:0000482","Microcornea" -"HP:0100042","Broad 4th toe" -"HP:0004386","Gastrointestinal inflammation" -"HP:0410032","Cleft of uvula" -"HP:0011797","Papillary renal cell carcinoma type 1" -"HP:0007308","Extrapyramidal dyskinesia" -"HP:0007291","Posterior fossa cyst" -"HP:0003959","Deformed forearm bones" -"HP:0009828","Peromelia" -"HP:0011856","Pica" -"HP:0011103","Abnormality of the left ventricular outflow tract" -"HP:0012264","Absent central microtubular pair morphology of respiratory motile cilia" -"HP:0005306","Capillary hemangiomas" -"HP:0006732","Papillary renal cell carcinoma type 2" -"HP:0010677","Enuresis nocturna" -"HP:0009155","Cone-shaped epiphysis of the proximal phalanx of the 5th finger" -"HP:0004875","Neonatal inspiratory stridor" -"HP:0007354","Amyotrophic lateral sclerosis" -"HP:0003042","Elbow dislocation" -"HP:0000093","Proteinuria" -"HP:0031050","Whole-immunoglobulin paraproteinemia" -"HP:0009666","Cone-shaped epiphysis of the proximal phalanx of the thumb" -"HP:0002585","Abnormality of the peritoneum" -"HP:0100043","Broad 5th toe" -"HP:0012271","Episodic upper airway obstruction" -"HP:0001582","Redundant skin" -"HP:0010647","Abnormal elasticity of skin" -"HP:0002054","Heavy supraorbital ridges" -"HP:0009726","Renal neoplasm" -"HP:0001818","Paronychia" -"HP:0006192","Tapered phalanx of finger" -"HP:0009914","Cyclopia" -"HP:0011715","Trifascicular block" -"HP:0010901","Abnormality of methionine metabolism" -"HP:0004859","Amegakaryocytic thrombocytopenia" -"HP:0001746","Asplenia" -"HP:0000656","Ectropion" -"HP:0010566","Hamartoma" -"HP:0031344","Pelvic arteriovenous malformation" -"HP:0025274","Ovarian dermoid cyst" -"HP:0008450","Narrow vertebral interpedicular distance" -"HP:0010238","Triangular epiphyses of the phalanges of the hand" -"HP:0010371","Aplasia/Hypoplasia of the phalanges of the 4th toe" -"HP:0040126","Abnormal vitamin B12 level" -"HP:0030720","Subchorionic septal cyst" -"HP:0010441","Ectopic accessory finger-like appendage" -"HP:0005186","Synovial hypertrophy" -"HP:0005999","Ureteral atresia" -"HP:0001519","Disproportionate tall stature" -"HP:0005776","Carpal bone malsegmentation" -"HP:0030401","Abnormal platelet dense granule ATP/ADP ratio" -"HP:0002942","Thoracic kyphosis" -"HP:0006159","Mesoaxial hand polydactyly" -"HP:0006355","Agenesis of mandibular central incisor" -"HP:0003325","Limb-girdle muscle weakness" -"HP:0010232","Fragmentation of the epiphyses of the phalanges of the hand" -"HP:0031374","Ankle weakness" -"HP:0008019","Superior lens subluxation" -"HP:0025024","Megarectum" -"HP:0012529","Abnormal dense granule content" -"HP:0006531","Pleural lymphangiectasia" -"HP:0002795","Functional respiratory abnormality" -"HP:0003704","Scapuloperoneal weakness" -"HP:0003029","Enlargement of the ankles" -"HP:0000362","Otosclerosis" -"HP:0030066","Ependymoblastoma" -"HP:0031430","Oligoclonal T cell expansion" -"HP:0006337","Premature eruption of permanent teeth" -"HP:0031576","Tessier number 4 facial cleft" -"HP:0000871","Panhypopituitarism" -"HP:0000413","Atresia of the external auditory canal" -"HP:0003517","Birth length greater than 97th percentile" -"HP:0010679","Elevated tissue non-specific alkaline phosphatase" -"HP:0010031","Patchy sclerosis of the 1st metacarpal" -"HP:0006332","Supernumerary maxillary incisor" -"HP:0004239","Proximally placed carpal bones" -"HP:0003327","Axial muscle weakness" -"HP:0007129","Cerebellar medulloblastoma" -"HP:0011931","Abnormality of the cerebellar peduncle" -"HP:0030150","Plasmacytosis" -"HP:0002025","Anal stenosis" -"HP:0011499","Mydriasis" -"HP:0430026","Abnormality of the shape of the midface" -"HP:0011920","Transudative pleural effusion" -"HP:0031110","Twin-to-twin transfusion" -"HP:0100527","Neoplasia of the pleura" -"HP:0001191","Abnormality of the carpal bones" -"HP:0011407","Proportionate tall stature" -"HP:0012439","Abnormal biliary tract physiology" -"HP:0003899","Round humeral epiphyses" -"HP:0010302","Spinal cord tumor" -"HP:0010014","Abnormality of the epiphysis of the 1st metacarpal" -"HP:0100508","Abnormality of vitamin metabolism" -"HP:0003920","Sloping humeral metaphysis" -"HP:0100575","Neoplasm of the gallbladder" -"HP:0012117","Hyperalbuminemia" -"HP:0004676","Prominent supraorbital arches in adult" -"HP:0009601","Aplasia/Hypoplasia of the thumb" -"HP:3000015","Abnormality of risorius muscle" -"HP:0012758","Neurodevelopmental delay" -"HP:0025422","Pleural cyst" -"HP:0012475","Specific antibody deficiency" -"HP:0010759","Prominence of the premaxilla" -"HP:0004751","Paroxysmal ventricular tachycardia" -"HP:0004398","Peptic ulcer" -"HP:0011386","Narrow internal auditory canal" -"HP:0100074","Small epiphyses of the 4th toe" -"HP:0010446","Tricuspid stenosis" -"HP:0031452","Lichenoid skin lesion" -"HP:0010911","Hyperleucinemia" -"HP:0004241","Stippled calcification in carpal bones" -"HP:0006895","Lower limb hypertonia" -"HP:0030248","Mesenteric venous thrombosis" -"HP:0031170","Female fetal virilization" -"HP:0005176","Dysplastic aortic valve" -"HP:0100729","Large face" -"HP:0100876","Infra-orbital crease" -"HP:0002973","Abnormality of the forearm" -"HP:0100585","Telangiectasia of the skin" -"HP:0008469","Cervical vertebral dysplasia" -"HP:0002626","Venous varicosities of celiac and mesenteric vessels" -"HP:0200096","Triangular-shaped open mouth" -"HP:0009821","Forearm undergrowth" -"HP:0002519","Hypnagogic hallucinations" -"HP:0000480","Retinal coloboma" -"HP:0011378","Hypoplasia of the vestibule of the inner ear" -"HP:0009735","Spinal neurofibromas" -"HP:0031521","Vaginal clear cell adenocarcinoma" -"HP:0000161","Median cleft lip" -"HP:0010121","Small epiphyses of the hallux" -"HP:0045005","Neural tube defect" -"HP:0000637","Long palpebral fissure" -"HP:0006633","Glenoid fossa hypoplasia" -"HP:0004631","Decreased cervical spine flexion due to contractures of posterior cervical muscles" -"HP:0100085","Small epiphyses of the 5th toe" -"HP:0003947","Delayed elbow epiphyseal ossification" -"HP:0012877","Retrograde ejaculation" -"HP:0012881","Abnormality of the labia majora" -"HP:0010784","Uterine neoplasm" -"HP:0040198","Non-medullary thyroid carcinoma" -"HP:0030243","Hepatic vein thrombosis" -"HP:0002672","Gastrointestinal carcinoma" -"HP:0011779","Anaplastic thyroid carcinoma" -"HP:0002624","Abnormal venous morphology" -"HP:0003427","Thenar muscle weakness" -"HP:0000153","Abnormality of the mouth" -"HP:0025086","Bloody mucoid diarrhea" -"HP:0025104","Capillary malformation" -"HP:0040295","Duplication of the upper lip" -"HP:0002916","Abnormality of chromosome segregation" -"HP:0006465","Periosteal thickening of long tubular bones" -"HP:0009099","Median cleft palate" -"HP:0100004","Pericardial mesothelioma" -"HP:0009780","Iliac horns" -"HP:0100063","Small epiphyses of the 3rd toe" -"HP:0006369","Irregular patellae" -"HP:0009760","Antecubital pterygium" -"HP:0011068","Odontoma" -"HP:0004502","Bilateral choanal atresia" -"HP:0000812","Abnormal internal genitalia" -"HP:0000946","Hypoplastic ilia" -"HP:0000939","Osteoporosis" -"HP:0030999","Abnormal vestibular saccule morphology" -"HP:0100893","Prominent xiphoid process" -"HP:0002339","Abnormality of the caudate nucleus" -"HP:0009638","Short proximal phalanx of thumb" -"HP:0012240","Increased intramyocellular lipid droplets" -"HP:0030223","Perseveration" -"HP:0006772","Renal angiomyolipoma" -"HP:0011871","Impaired ristocetin-induced platelet aggregation" -"HP:0008819","Narrow femoral neck" -"HP:0001101","Iritis" -"HP:0000511","Vertical supranuclear gaze palsy" -"HP:0003997","Hypoplastic radial head" -"HP:0030974","Cryptozoospermia" -"HP:0012587","Macroscopic hematuria" -"HP:0010041","Short 3rd metacarpal" -"HP:0000514","Slow saccadic eye movements" -"HP:0004722","Thickening of the glomerular basement membrane" -"HP:0031142","Abnormal hepatic echogenicity" -"HP:0003213","Deficient excision of UV-induced pyrimidine dimers in DNA" -"HP:0002202","Pleural effusion" -"HP:0004696","Talipes cavus equinovarus" -"HP:0006206","Hypersegmentation of proximal phalanx of second finger" -"HP:0500069","Paralytic ectropion" -"HP:0002366","Abnormal lower motor neuron morphology" -"HP:0011559","Double inlet to single ventricle with two atrioventricular valves" -"HP:0005968","Temperature instability" -"HP:0005528","Bone marrow hypocellularity" -"HP:0030780","Abnormality of the protein C anticoagulant pathway" -"HP:0011965","Abnormality of citrulline metabolism" -"HP:0003508","Proportionate short stature" -"HP:0004942","Aortic aneurysm" -"HP:0000839","Pituitary dwarfism" -"HP:0002718","Recurrent bacterial infections" -"HP:0100244","Fibrosarcoma" -"HP:0010915","Abnormality of pyruvate family amino acid metabolism" -"HP:0025608","Cicatricial ectropion" -"HP:0010066","Duplication of phalanx of hallux" -"HP:0007165","Periventricular gray matter heterotopia" -"HP:0100867","Duodenal stenosis" -"HP:0006466","Ankle contracture" -"HP:0003418","Back pain" -"HP:0030048","Colpocephaly" -"HP:0003849","Flared upper limb metaphysis" -"HP:0007655","Eversion of lateral third of lower eyelids" -"HP:0005780","Absent fourth finger distal interphalangeal crease" -"HP:0003187","Breast hypoplasia" -"HP:0011450","CNS infection" -"HP:0005420","Recurrent gram-negative bacterial infections" -"HP:0011654","Double outlet right ventricle with non-committed ventricular septal defect without pulmonary stenosis" -"HP:0005435","Impaired T cell function" -"HP:0011657","Double outlet right ventricle with subpulmonary ventricular septal defect and pulmonary stenosis" -"HP:0005241","Total intestinal aganglionosis" -"HP:0001903","Anemia" -"HP:0004324","Increased body weight" -"HP:0004339","Abnormality of sulfur amino acid metabolism" -"HP:0007430","Generalized edema" -"HP:0004274","Deficient ossification of hand bones" -"HP:0003712","Skeletal muscle hypertrophy" -"HP:0031384","Reduced T cell CD40 expression" -"HP:0004902","Congenital lactic acidosis" -"HP:0003419","Low back pain" -"HP:0007064","Progressive language deterioration" -"HP:0010894","Abnormality of serine family amino acid metabolism" -"HP:0031524","Ampulla of Vater carcinoma" -"HP:0002862","Bladder carcinoma" -"HP:0011653","Double outlet right ventricle with non-committed ventricular septal defect and pulmonary stenosis" -"HP:0010902","Abnormality of glutamine family amino acid metabolism" -"HP:0010144","Ivory epiphysis of the distal phalanx of the hallux" -"HP:0001900","Increased hemoglobin" -"HP:0002632","Low-to-normal blood pressure" -"HP:0001410","Decreased liver function" -"HP:0002329","Drowsiness" -"HP:0002686","Prenatal maternal abnormality" -"HP:0430015","Abnormality of musculature of pharynx" -"HP:0001850","Abnormality of the tarsal bones" -"HP:0010899","Abnormality of aspartate family amino acid metabolism" -"HP:0003262","Smooth muscle antibody positivity" -"HP:0005954","Pulmonary capillary hemangiomatosis" -"HP:0003297","Hyperlysinuria" -"HP:0011318","Bicoronal synostosis" -"HP:0004305","Involuntary movements" -"HP:0001269","Hemiparesis" -"HP:0100883","Chorangioma" -"HP:0009195","Epiphyseal stippling of the metacarpals" -"HP:0004207","Abnormality of the 5th finger" -"HP:0001054","Numerous nevi" -"HP:0003075","Hypoproteinemia" -"HP:0011658","Double outlet right ventricle with subpulmonary ventricular septal defect without pulmonary stenosis" -"HP:0100820","Glomerulopathy" -"HP:0005844","Rounded middle phalanx of finger" -"HP:0007569","Generalized seborrheic dermatitis" -"HP:0001962","Palpitations" -"HP:0004390","Hamartomatous polyposis" -"HP:0004338","Abnormality of aromatic amino acid family metabolism" -"HP:0006502","Aplasia/Hypoplasia involving the carpal bones" -"HP:0008456","C2-C3 subluxation" -"HP:0003225","Reduced factor V activity" -"HP:0002587","Projectile vomiting" -"HP:0008007","Primary congenital glaucoma" -"HP:0100038","Slow-growing scalp hair" -"HP:0011955","Hepatic granulomatosis" -"HP:0009746","Thick nasal septum" -"HP:0004262","Abnormality of the capitate bone" -"HP:0003125","Reduced factor VIII activity" -"HP:0012247","Specific anosmia" -"HP:0000915","Pectus excavatum of inferior sternum" -"HP:0005017","Polyarticular chondrocalcinosis" -"HP:0012209","Juvenile myelomonocytic leukemia" -"HP:0004252","Abnormality of the trapezium" -"HP:0004947","Arteriovenous fistula" -"HP:0006014","Abnormally shaped carpal bones" -"HP:0009779","3-4 toe syndactyly" -"HP:0031175","Absent cervical vertebra" -"HP:0040089","Abnormality of natural killer cell number" -"HP:0006257","Abnormality of carpal bone ossification" -"HP:0006180","Crowded carpal bones" -"HP:0002710","Commissural lip pit" -"HP:0000853","Goiter" -"HP:0011472","Abnormality of small intestinal villus morphology" -"HP:0001495","Carpal osteolysis" -"HP:0030131","Abnormal von Willebrand factor multimer distribution" -"HP:0010869","Asynergia" -"HP:0011822","Broad chin" -"HP:0003784","Type 1 collagen overmodification" -"HP:0030985","Decreased serum bile concentration" -"HP:0010059","Broad hallux phalanx" -"HP:0006092","Malaligned carpal bone" -"HP:0004256","Abnormality of the trapezoid bone" -"HP:0006739","Squamous cell carcinoma of the skin" -"HP:0004243","Abnormality of the scaphoid" -"HP:0012649","Increased inflammatory response" -"HP:0002563","Constrictive pericarditis" -"HP:0004248","Abnormality of the lunate bone" -"HP:0010775","Vascular ring" -"HP:0012327","Celiac artery compression" -"HP:0005465","Facial hyperostosis" -"HP:0011678","Tetralogy of Fallot with pulmonary atresia and major aortopulmonary collateral arteries" -"HP:0000900","Thickened ribs" -"HP:0011370","Recurrent cutaneous fungal infections" -"HP:0011839","Abnormality of T cell count" -"HP:0100537","Fasciitis" -"HP:0004259","Abnormality of the hamate bone" -"HP:0004264","Narrow carpal joint spaces" -"HP:0011941","Anterior wedging of L2" -"HP:0004232","Accessory carpal bones" -"HP:0011975","Aminoglycoside-induced hearing loss" -"HP:0005961","Hypoargininemia" -"HP:0011482","Abnormal lacrimal gland morphology" -"HP:0012154","Anhedonia" -"HP:0009433","Osteolytic defects of the middle phalanx of the 3rd finger" -"HP:0011264","Discontinuous ascending root of helix" -"HP:0002592","Gastric ulcer" -"HP:0002102","Pleuritis" -"HP:0000053","Macroorchidism" -"HP:0011261","Darwin tubercle of helix" -"HP:0011790","Activating thyroid-stimulating hormone receptor defect" -"HP:0030074","Chemodectoma" -"HP:0002383","Encephalitis" -"HP:0000357","Abnormal location of ears" -"HP:0008024","Congenital nuclear cataract" -"HP:0030486","Abnormal timing of pattern electroretinogram" -"HP:0030258","Hyperpigmented genitalia" -"HP:0009169","Broad middle phalanx of the 5th finger" -"HP:0010523","Alexia" -"HP:0012856","Abnormal scrotal rugation" -"HP:0031228","Abnormal incisura morphology" -"HP:0005136","Mitral annular calcification" -"HP:0007657","Diffuse nuclear cataract" -"HP:0030392","Choroid plexus carcinoma" -"HP:0100561","Spinal cord lesion" -"HP:0003892","Absent humeral epiphyseal ossification" -"HP:0003571","Propionicacidemia" -"HP:0031233","Horizontal inferior border of scapula" -"HP:0040150","Epiblepharon of upper lid" -"HP:0100313","Cerebral granulomatosis" -"HP:0008528","Long hairs growing from helix of pinna" -"HP:0002243","Protein-losing enteropathy" -"HP:0001396","Cholestasis" -"HP:0012646","Retractile testis" -"HP:0002444","Hypothalamic hamartoma" -"HP:0009297","Osteolytic defects of the middle phalanx of the 4th finger" -"HP:3000072","Abnormality of levator palpebrae superioris" -"HP:0006544","Extrapulmonary sequestrum" -"HP:0200053","Hemihypotrophy of lower limb" -"HP:0003236","Elevated serum creatine phosphokinase" -"HP:0007352","Cerebellar calcifications" -"HP:0007069","Profound static encephalopathy" -"HP:0001094","Iridocyclitis" -"HP:0006574","Hepatic arteriovenous malformation" -"HP:0030845","Heliotrope rash of eyelid" -"HP:0007898","Exudative retinopathy" -"HP:0200036","Skin nodule" -"HP:0030732","Dysplastic tricuspid valve" -"HP:0004681","Deep longitudinal plantar crease" -"HP:0001433","Hepatosplenomegaly" -"HP:0004481","Progressive macrocephaly" -"HP:0031441","Abnormal tricuspid valve annulus morphology" -"HP:0004218","Symphalangism of the 5th finger" -"HP:0003893","Advanced ossification of the humeral epiphysis" -"HP:0002120","Cerebral cortical atrophy" -"HP:0005868","Metaphyseal enchondromatosis" -"HP:0030820","Hooded eyelid" -"HP:0007162","Diffuse demyelination of the cerebral white matter" -"HP:0008045","Enlarged flash visual evoked potentials" -"HP:0010750","Dermatochalasis" -"HP:0001648","Cor pulmonale" -"HP:0025478","Atrial standstill" -"HP:0200118","Malabsorption of Vitamin B12" -"HP:0004979","Metaphyseal sclerosis" -"HP:0000270","Delayed cranial suture closure" -"HP:0012673","Aplasia of the upper vagina" -"HP:0030001","Lagopthalmos" -"HP:0000063","Fused labia minora" -"HP:0002886","Vagal paraganglioma" -"HP:0001406","Intrahepatic cholestasis" -"HP:0007258","Severe demyelination of the white matter" -"HP:0012887","Ovarian serous cystadenoma" -"HP:0000273","Facial grimacing" -"HP:0004804","Congenital hemolytic anemia" -"HP:0008883","Mild intrauterine growth retardation" -"HP:0100602","Preeclampsia" -"HP:0430008","Accessory eyelid" -"HP:0030489","Abnormal paracentral response of multifocal electroretinogram" -"HP:0001357","Plagiocephaly" -"HP:0030425","Calcified ovarian cyst" -"HP:0500043","Eyelid retraction" -"HP:0031367","Metaphyseal striations" -"HP:0011134","Low-grade fever" -"HP:0007268","Aprosencephaly" -"HP:0005807","Absent distal phalanges" -"HP:0005185","Global systolic dysfunction" -"HP:0009227","Broad proximal phalanx of the 5th finger" -"HP:0430010","Microblepharia" -"HP:0012886","Hemorrhagic ovarian cyst" -"HP:0006557","Polycystic liver disease" -"HP:0025093","Peripapillary exudate" -"HP:0031443","Abnormal tricuspid valve leaflet morphology" -"HP:0007509","Patchy hypo- and hyperpigmentation" -"HP:0030026","Squared superior portion of helix" -"HP:0100810","Pointed helix" -"HP:0000793","Membranoproliferative glomerulonephritis" -"HP:0001369","Arthritis" -"HP:0001711","Abnormal morphology of the left ventricle" -"HP:0012631","Pigment deposition in the trabecular meshwork" -"HP:0009755","Ankyloblepharon" -"HP:0002385","Paraparesis" -"HP:0011226","Aplasia/Hypoplasia of the eyelid" -"HP:0040139","Lipogranulomatosis" -"HP:0005517","T-cell lymphoma/leukemia" -"HP:0005258","Pectoral muscle hypoplasia/aplasia" -"HP:0003034","Diaphyseal sclerosis" -"HP:0031357","Glomeruloid hemangioma" -"HP:0025549","Eccentric visual fixation" -"HP:0030553","Visual acuity no light perception" -"HP:0030366","Delivery by Odon device" -"HP:0030915","Cerebellar edema" -"HP:0031422","Abnormal morphology of the cerebellar cortex" -"HP:0006722","Small intestine carcinoid" -"HP:0012498","Nuchal cord" -"HP:0030365","Vaginal birth after Caesarian" -"HP:0031066","Abnormal ovarian physiology" -"HP:0003819","Death in childhood" -"HP:0025405","Visual fixation instability" -"HP:0011401","Delayed peripheral myelination" -"HP:0031449","Perineal hemangioma" -"HP:0040259","Aplastic nasopharyngeal adenoids" -"HP:0012514","Lower limb pain" -"HP:0031490","Hemangioma of the lip" -"HP:0008305","Exercise-induced myoglobinuria" -"HP:0006880","Cerebellar hemangioblastoma" -"HP:0010797","Hemangioblastoma" -"HP:0030362","Reduced muscle carnitine level" -"HP:0007209","Facial paralysis" -"HP:0007834","Progressive cataract" -"HP:0000056","Abnormality of the clitoris" -"HP:0025609","Anterior blepharitis" -"HP:0012467","Acute respiratory acidosis" -"HP:0004263","Large capitate bone" -"HP:0008610","Infantile sensorineural hearing impairment" -"HP:0012266","T-wave alternans" -"HP:0012698","Cerebellar gliosis" -"HP:0011063","Abnormality of incisor morphology" -"HP:0012222","Arachnoid hemangiomatosis" -"HP:0000640","Gaze-evoked nystagmus" -"HP:0004487","Acrobrachycephaly" -"HP:0000753","Autism with high cognitive abilities" -"HP:0031043","Type A4 brachydactyly" -"HP:0000563","Keratoconus" -"HP:0012675","Iron accumulation in brain" -"HP:0000735","Impaired social interactions" -"HP:0003652","Recurrent myoglobinuria" -"HP:0030446","Atypical pulmonary carcinoid tumor" -"HP:0030314","Periostosis" -"HP:0000324","Facial asymmetry" -"HP:0001104","Macular hypoplasia" -"HP:0011022","Abnormality of unsaturated fatty acid metabolism" -"HP:0001935","Microcytic anemia" -"HP:0009622","Distally placed thumb" -"HP:0012845","Single trichilemmoma" -"HP:0003271","Visceromegaly" -"HP:0100219","Ivory epiphysis of the middle phalanx of the 5th toe" -"HP:0100759","Clubbing of fingers" -"HP:0005561","Abnormality of bone marrow cell morphology" -"HP:0100208","Ivory epiphysis of the distal phalanx of the 5th toe" -"HP:0002947","Cervical kyphosis" -"HP:0010535","Sleep apnea" -"HP:0001288","Gait disturbance" -"HP:0007190","Neuronal loss in the cerebral cortex" -"HP:0006660","Aplastic clavicles" -"HP:0008322","Abnormal mitochondrial morphology" -"HP:0004922","Atypical hyperphenylalaninemia" -"HP:0003037","Enlarged joints" -"HP:0001103","Abnormal macular morphology" -"HP:0100021","Cerebral palsy" -"HP:0100134","Abnormality of the axillary hair" -"HP:0000570","Abnormality of saccadic eye movements" -"HP:0002371","Loss of speech" -"HP:0030233","Bethlem sign" -"HP:0004245","Comma-shaped scaphoid" -"HP:0030521","Bitemporal hemianopia" -"HP:0040102","Osseous atresia of the external auditory canal" -"HP:0004679","Large tarsal bones" -"HP:0030902","Palmomental reflex" -"HP:0002301","Hemiplegia" -"HP:0040175","Platelet-activating factor acetylhydrolase deficiency" -"HP:0007465","Honeycomb palmoplantar keratoderma" -"HP:0012874","Abnormal male reproductive system physiology" -"HP:0000913","Posterior rib fusion" -"HP:0012042","Aspirin-induced asthma" -"HP:0000538","Pseudopapilledema" -"HP:0010964","Abnormality of long-chain fatty-acid metabolism" -"HP:0030904","Glabellar reflex" -"HP:0006543","Cardiorespiratory arrest" -"HP:0010798","Lip freckle" -"HP:0200005","Abnormal shape of the palpebral fissure" -"HP:0002788","Recurrent upper respiratory tract infections" -"HP:0000475","Broad neck" -"HP:0007027","Poorly formed metencephalon" -"HP:0001982","Sea-blue histiocytosis" -"HP:0006946","Recurrent meningitis" -"HP:0000973","Cutis laxa" -"HP:0002945","Intervertebral space narrowing" -"HP:0030906","Suck reflex" -"HP:0008947","Infantile muscular hypotonia" -"HP:0012653","Status asthmaticus" -"HP:0002298","Absent hair" -"HP:0004251","Lunate-triquetral fusion" -"HP:0004719","Hyperechogenic kidneys" -"HP:0002490","Increased CSF lactate" -"HP:0004823","Anisopoikilocytosis" -"HP:0003724","Shoulder girdle muscle atrophy" -"HP:0000168","Abnormality of the gingiva" -"HP:0001742","Nasal obstruction" -"HP:0005039","Multiple long-bone exostoses" -"HP:0003349","Low cholesterol esterification rates" -"HP:0003868","Humeral cortical thickening" -"HP:0010787","Genital neoplasm" -"HP:0001747","Accessory spleen" -"HP:0004454","Abnormal middle ear reflexes" -"HP:0002902","Hyponatremia" -"HP:0010966","Abnormality of fatty-acid anion metabolism" -"HP:0100117","Ivory epiphysis of the middle phalanx of the 2nd toe" -"HP:0006200","Widened distal phalanges" -"HP:0005905","Abnormal cervical curvature" -"HP:0002977","Aplasia/Hypoplasia involving the central nervous system" -"HP:0008797","Early ossification of capital femoral epiphyses" -"HP:0011096","Peripheral demyelination" -"HP:0011319","Bilambdoid synostosis" -"HP:0006516","Hypersensitivity pneumonitis" -"HP:0010481","Urethral valve" -"HP:0002849","Absence of lymph node germinal center" -"HP:0001890","Autoimmune hemolytic anemia" -"HP:0000388","Otitis media" -"HP:0002157","Azotemia" -"HP:0200095","Anterior open bite" -"HP:0001465","Amyotrophy involving the shoulder musculature" -"HP:0011957","Abnormality of the pectoral muscle" -"HP:0002488","Acute leukemia" -"HP:0040181","Chapped lip" -"HP:0009130","Hand muscle atrophy" -"HP:0012302","Herpes simplex encephalitis" -"HP:0002080","Intention tremor" -"HP:0003490","Defective dehydrogenation of isovaleryl CoA and butyryl CoA" -"HP:0002257","Chronic rhinitis" -"HP:0002415","Leukodystrophy" -"HP:0006000","Ureteral obstruction" -"HP:0011320","Unilambdoid synostosis" -"HP:0003955","Bone-in-a-bone appearance of forearm" -"HP:0005178","Complete heart block with narrow QRS complexes" -"HP:0030292","Tibial metaphyseal irregularity" -"HP:0004244","Accessory scaphoid" -"HP:0012357","Increased mannosylation of N-linked protein glycosylation" -"HP:0005310","Large vessel vasculitis" -"HP:0031500","Abdominal mass" -"HP:0000177","Abnormality of upper lip" -"HP:0005473","Fusion of middle ear ossicles" -"HP:0030905","Snout reflex" -"HP:0003467","Atlantoaxial instability" -"HP:0010850","EEG with spike-wave complexes" -"HP:0008221","Adrenal hyperplasia" -"HP:0003547","Shoulder girdle muscle weakness" -"HP:0100843","Glioblastoma" -"HP:0011870","Impaired arachidonic acid-induced platelet aggregation" -"HP:0010169","Pseudoepiphyses of the toes" -"HP:0008651","Uric acid urolithiasis independent of gout" -"HP:0004870","Chronic hemolytic anemia" -"HP:0009486","Radial deviation of the hand" -"HP:0001050","Plethora" -"HP:0031129","Impaired phorbol myristate acetate-induced platelet aggregation" -"HP:0011145","Symptomatic seizures" -"HP:0100334","Unilateral cleft palate" -"HP:0002907","Microscopic hematuria" -"HP:0030165","Temporal artery tortuosity" -"HP:0010781","Skin dimples" -"HP:0007835","S-shaped palpebral fissures" -"HP:0004046","Spurred ulnar metaphysis" -"HP:0011854","Hemoperitoneum" -"HP:0006243","Phalangeal dislocation" -"HP:0003850","Upper-limb metaphyseal irregularity" -"HP:0002206","Pulmonary fibrosis" -"HP:0003319","Abnormality of the cervical spine" -"HP:0002896","Neoplasm of the liver" -"HP:0012077","Histrionic personality disorder" -"HP:0011687","AV nodal tachycardia" -"HP:0001254","Lethargy" -"HP:0012859","Esophageal leukoplakia" -"HP:0012328","Cementoma" -"HP:0100702","Arachnoid cyst" -"HP:0011764","Pituitary spindle cell oncocytoma" -"HP:0004866","Impaired ADP-induced platelet aggregation" -"HP:0008231","Macronodular adrenal hyperplasia" -"HP:0031127","Impaired convulxin-induced platelet aggregation" -"HP:0100699","Scarring" -"HP:0003572","Low plasma citrulline" -"HP:0004422","Biparietal narrowing" -"HP:0001172","Abnormality of the thumb" -"HP:0010960","Bronchopulmonary sequestration" -"HP:0100014","Epiretinal membrane" -"HP:0001351","Jerk-locked premyoclonus spikes" -"HP:0008148","Impaired epinephrine-induced platelet aggregation" -"HP:0008376","Nasal, dysarthic speech" -"HP:0001000","Abnormality of skin pigmentation" -"HP:0007601","Midline facial capillary hemangioma" -"HP:0002176","Spinal cord compression" -"HP:0011729","Abnormality of joint mobility" -"HP:0012076","Borderline personality disorder" -"HP:0011227","Elevated C-reactive protein level" -"HP:0025278","Cold-induced sweating" -"HP:0000196","Lower lip pit" -"HP:0004233","Advanced ossification of carpal bones" -"HP:0007099","Arnold-Chiari type I malformation" -"HP:0002669","Osteosarcoma" -"HP:0011872","Impaired thrombin-induced platelet aggregation" -"HP:0003194","Short nasal bridge" -"HP:0000112","Nephropathy" -"HP:0025548","Increased mean corpuscular hemoglobin" -"HP:0030403","Spontaneous platelet aggregation" -"HP:0001698","Pericardial effusion" -"HP:0002395","Lower limb hyperreflexia" -"HP:0000703","Dentinogenesis imperfecta" -"HP:0000970","Anhidrosis" -"HP:0002676","Cloverleaf skull" -"HP:0002152","Hyperproteinemia" -"HP:0005381","Recurrent meningococcal disease" -"HP:0007034","Generalized hyperreflexia" -"HP:0012500","Verrucous papule" -"HP:0030319","Weakness of facial musculature" -"HP:0000138","Ovarian cyst" -"HP:0011231","Prominent eyelashes" -"HP:0003237","Increased IgG level" -"HP:0001285","Spastic tetraparesis" -"HP:0200136","Oral-pharyngeal dysphagia" -"HP:0011894","Impaired thromboxane A2 agonist-induced platelet aggregation" -"HP:0100632","Pulmonary sequestration" -"HP:0008258","Congenital adrenal hyperplasia" -"HP:0031130","Impaired calcium ionophore-induced platelet aggregation" -"HP:0012353","Decreased fucosylation of N-linked protein glycosylation" -"HP:0100315","Lewy bodies" -"HP:0031457","Pulmonary opacity" -"HP:0012774","Increased upper to lower segment ratio" -"HP:0006011","Cuboidal metacarpal" -"HP:0009709","Increased CSF interferon alpha" -"HP:0005483","Abnormal epiglottis morphology" -"HP:0001623","Breech presentation" -"HP:0011627","Aorto-ventricular tunnel" -"HP:0012061","Urinary excretion of sialylated oligosaccharides" -"HP:0005320","Lack of facial subcutaneous fat" -"HP:0003206","Decreased activity of NADPH oxidase" -"HP:0100828","Increase in T cell count" -"HP:0009037","Segmental spinal muscular atrophy" -"HP:0031379","Abnormal T cell proliferation" -"HP:0001693","Cardiac shunt" -"HP:0010969","Abnormality of glycolipid metabolism" -"HP:0011855","Pharyngeal edema" -"HP:0030194","Fatigable weakness of speech muscles" -"HP:0010443","Bifid femur" -"HP:0000037","Male pseudohermaphroditism" -"HP:0030416","Vulvar neoplasm" -"HP:0011615","Abnormality of pulmonary situs" -"HP:0011136","Aplasia of the sweat glands" -"HP:0025076","Abnormal QRS voltage" -"HP:0002917","Hypomagnesemia" -"HP:0030265","Wide penis" -"HP:0030830","Rales" -"HP:0003316","Butterfly vertebrae" -"HP:0000066","Labial hypoplasia" -"HP:0004810","Congenital hypoplastic anemia" -"HP:0011808","Decreased patellar reflex" -"HP:0007836","Mosaic corneal dystrophy" -"HP:0009731","Cerebral hamartomata" -"HP:0011108","Recurrent sinusitis" -"HP:0003142","Excessive purine production" -"HP:0007690","Map-dot-fingerprint corneal dystrophy" -"HP:0007550","Hypohidrosis or hyperhidrosis" -"HP:0030872","Abnormal cardiac ventricular function" -"HP:0030709","Myelocystocele" -"HP:0008061","Aplasia/Hypoplasia of the retina" -"HP:0001245","Small thenar eminence" -"HP:0030670","Hamartoma of the orbital region" -"HP:0007387","Hypoplastic sweat glands" -"HP:0011803","Bifid nose" -"HP:0025092","Epidermal acanthosis" -"HP:0007795","Anterior cortical cataract" -"HP:0002310","Orofacial dyskinesia" -"HP:0031236","Predominantly dermal neutrophilic infiltrate" -"HP:0002933","Ventral hernia" -"HP:0007913","Reticular retinal dystrophy" -"HP:0005512","Impaired neutrophil killing of staphylococci" -"HP:0005995","Decreased adipose tissue around neck" -"HP:0031111","Cutaneous hamartoma" -"HP:0011792","Neoplasm by histology" -"HP:0004365","Abnormality of tryptophan metabolism" -"HP:0006959","Proximal spinal muscular atrophy" -"HP:0200073","Respiratory insufficiency due to defective ciliary clearance" -"HP:0007313","Cerebral degeneration" -"HP:0000370","Abnormality of the middle ear" -"HP:0040088","Abnormal lymphocyte count" -"HP:0410058","Increased level of D-threitol in CSF" -"HP:0000517","Abnormality of the lens" -"HP:0001960","Hypokalemic metabolic alkalosis" -"HP:0011663","Right ventricular cardiomyopathy" -"HP:0007544","Piebaldism" -"HP:0001004","Lymphedema" -"HP:0003396","Syringomyelia" -"HP:0004616","Cleft vertebral arch" -"HP:0000954","Single transverse palmar crease" -"HP:0003558","Viral infection-induced rhabdomyolysis" -"HP:0002536","Abnormal cortical gyration" -"HP:0000980","Pallor" -"HP:0004373","Focal dystonia" -"HP:0200055","Small hand" -"HP:0006580","Portal fibrosis" -"HP:0007441","Hyperpigmented/hypopigmented macules" -"ChEMBL:75753","xamoterol" -"ChEMBL:506","primaquine" -"ChEMBL:408","troglitazone" -"ChEMBL:1200600","fluorometholone" -"ChEMBL:3527065","amino acids" -"ChEMBL:470670","levomenthol" -"ChEMBL:491571","doripenem" -"ChEMBL:1200547","magnesium chloride" -"ChEMBL:1547","thiamine ion" -"ChEMBL:19299","loxoprofen" -"ChEMBL:79","lidocaine" -"ChEMBL:22498","pheniprazine" -"ChEMBL:1201353","dexchlorpheniramine" -"ChEMBL:1252","abarelix" -"ChEMBL:413","sirolimus" -"ChEMBL:1657","tazarotene" -"ChEMBL:464","etretinate" -"ChEMBL:1201360","halobetasol" -"ChEMBL:2111112","vernakalant" -"ChEMBL:2218896","nabilone" -"ChEMBL:1201","thiothixene" -"ChEMBL:644","trimipramine" -"ChEMBL:712","anisindione" -"ChEMBL:3707307","fabomotizole" -"ChEMBL:1230914","air" -"ChEMBL:726","fluphenazine" -"ChEMBL:813","eprosartan" -"ChEMBL:1556","inosine" -"ChEMBL:750","zonisamide" -"ChEMBL:1395","methyltestosterone" -"ChEMBL:178","daunorubicin" -"ChEMBL:1140","niacinamide" -"ChEMBL:765","guanethidine" -"ChEMBL:1266","tetrahydrozoline" -"ChEMBL:991","stavudine" -"ChEMBL:686","mefenamic acid" -"ChEMBL:1201287","dexbrompheniramine" -"ChEMBL:1589","acetohexamide" -"ChEMBL:628","pentoxifylline" -"ChEMBL:1908370","finafloxacin" -"ChEMBL:1753","clindamycin" -"ChEMBL:2104790","mephenoxalone" -"ChEMBL:927","cefdinir" -"ChEMBL:822","terbinafine" -"ChEMBL:1220","tinidazole" -"ChEMBL:259209","milnacipran" -"ChEMBL:180022","neratinib" -"ChEMBL:144673","hexetidine" -"ChEMBL:1631107","cefquinome" -"ChEMBL:1269025","edoxaban" -"ChEMBL:497613","fludeoxyglucose f-18" -"ChEMBL:553","erlotinib" -"ChEMBL:1180725","propantheline" -"ChEMBL:1201832","romiplostim" -"ChEMBL:89598","vigabatrin" -"ChEMBL:224325","chlorquinaldol" -"ChEMBL:660","amantadine" -"ChEMBL:864","carbinoxamine" -"ChEMBL:1200647","candicidin" -"ChEMBL:1029","miglustat" -"ChEMBL:117287","prucalopride" -"ChEMBL:36506","novobiocin" -"ChEMBL:422330","lumefantrine" -"ChEMBL:486208","borneol" -"ChEMBL:449","butabarbital" -"ChEMBL:1594","pantothenic acid" -"ChEMBL:1087630","oxibendazole" -"ChEMBL:2110802","benzpyrinium" -"ChEMBL:2109047","interferon alfa-n3" -"ChEMBL:2095222","ocriplasmin" -"ChEMBL:222559","tipranavir" -"ChEMBL:9","norfloxacin" -"ChEMBL:658","sufentanil" -"ChEMBL:353972","atipamezole" -"ChEMBL:1201487","sacrosidase" -"ChEMBL:1173655","afatinib" -"ChEMBL:1234886","oxygen" -"ChEMBL:1908391","masitinib" -"ChEMBL:1200709","crotamiton" -"ChEMBL:282724","sitaxentan" -"ChEMBL:557555","ciprofibrate" -"ChEMBL:2106871","glaucarubin" -"ChEMBL:1013","loracarbef" -"ChEMBL:467","hydroxyurea" -"ChEMBL:2108638","raxibacumab" -"ChEMBL:615","penicillin v" -"ChEMBL:2105711","tofogliflozin" -"ChEMBL:1201566","darbepoetin alfa" -"ChEMBL:501122","ceftaroline fosamil" -"ChEMBL:1235508","1,2-dimyristoyl-sn-glycero-3-phosphocholine" -"ChEMBL:2042122","flutemetamol f-18" -"ChEMBL:1436","cefuroxime" -"ChEMBL:1743007","daratumumab" -"ChEMBL:742","ketamine" -"ChEMBL:19490","zomepirac" -"ChEMBL:3544996","idarucizumab" -"ChEMBL:1278","naratriptan" -"ChEMBL:428880","cromolyn" -"ChEMBL:1200807","norelgestromin" -"ChEMBL:1184360","diamthazole" -"ChEMBL:132767","trapidil" -"ChEMBL:1615777","iobenguane i-123" -"ChEMBL:1316","carprofen" -"ChEMBL:1159717","tulobuterol" -"ChEMBL:1739","metocurine" -"ChEMBL:1341","methoxyflurane" -"ChEMBL:1182247","didecyldimonium" -"ChEMBL:1589793","brilliant green cation" -"ChEMBL:546","oxprenolol" -"ChEMBL:1619758","etryptamine" -"ChEMBL:398707","hydromorphone" -"ChEMBL:457547","micafungin" -"ChEMBL:1363","formoterol" -"ChEMBL:308954","etravirine" -"ChEMBL:406","indapamide" -"ChEMBL:325109","clebopride" -"ChEMBL:1765291","zaltoprofen" -"ChEMBL:1162","norethindrone" -"ChEMBL:2105487","sulfur" -"ChEMBL:626","naftifine" -"ChEMBL:1201798","sevelamer" -"ChEMBL:305660","ebastine" -"ChEMBL:1697833","clortermine" -"ChEMBL:1020","tolmetin" -"ChEMBL:2097081","nitroprusside" -"ChEMBL:710","finasteride" -"ChEMBL:1200680","selenium sulfide" -"ChEMBL:826","enoxacin" -"ChEMBL:894","bupropion" -"ChEMBL:1568","fludarabine" -"ChEMBL:700","sulfapyridine" -"ChEMBL:1165268","iodipamide" -"ChEMBL:1121","sincalide" -"ChEMBL:334491","budipine" -"ChEMBL:1237068","lactulose" -"ChEMBL:434394","nebivolol" -"ChEMBL:1201054","selenomethionine se-75" -"ChEMBL:576127","fenspiride" -"ChEMBL:788","idoxuridine" -"ChEMBL:127865","piperocaine" -"ChEMBL:1201075","ioxilan" -"ChEMBL:1200694","sevoflurane" -"ChEMBL:27193","dilevalol" -"ChEMBL:3137312","dasabuvir" -"ChEMBL:1090","vidarabine anhydrous" -"ChEMBL:2106830","piroheptine" -"ChEMBL:431770","istradefylline" -"ChEMBL:1233584","isoleucine" -"ChEMBL:856","primidone" -"ChEMBL:558913","psi-7411" -"ChEMBL:1201232","isopropamide" -"ChEMBL:2108710","rimabotulinumtoxinb" -"ChEMBL:1729","cisapride" -"ChEMBL:411","diethylstilbestrol" -"ChEMBL:1504","triamcinolone acetonide" -"ChEMBL:295698","ketoconazole" -"ChEMBL:1571","testolactone" -"ChEMBL:1289926","axitinib" -"ChEMBL:2108676","elosulfase alfa" -"ChEMBL:1437","norepinephrine" -"ChEMBL:175247","orlistat" -"ChEMBL:1200649","quinupristin" -"ChEMBL:1201746","pralatrexate" -"ChEMBL:107","colchicine" -"ChEMBL:997","ibandronic acid" -"ChEMBL:1201341","echothiophate" -"ChEMBL:953","entacapone" -"ChEMBL:1584","piperacetazine" -"ChEMBL:1240977","oxantel" -"ChEMBL:1206","profenamine" -"ChEMBL:723","carvedilol" -"ChEMBL:520400","bamipine" -"ChEMBL:1200374","exemestane" -"ChEMBL:1201794","flavin mononucleotide" -"ChEMBL:1733","quinaprilat" -"ChEMBL:278398","phenindamine" -"ChEMBL:1551","ursodiol" -"ChEMBL:1201361","alclometasone" -"ChEMBL:895","nalbuphine" -"ChEMBL:1429","desmopressin" -"ChEMBL:2147777","teneligliptin" -"ChEMBL:167731","pixantrone" -"ChEMBL:697","methsuximide" -"ChEMBL:1672","cefpodoxime" -"ChEMBL:612","dextroamphetamine" -"ChEMBL:1200471","pyrithione zinc" -"ChEMBL:2104627","nifurpirinol" -"ChEMBL:27","propranolol" -"ChEMBL:406117","gusperimus" -"ChEMBL:387326","quinine" -"ChEMBL:1902981","eperisone" -"ChEMBL:1077896","ropivacaine" -"ChEMBL:858","edetic acid" -"ChEMBL:674","oseltamivir acid" -"ChEMBL:141446","fluroxene" -"ChEMBL:3426621","ripasudil" -"ChEMBL:135400","zopiclone" -"ChEMBL:502384","triethylenemelamine" -"ChEMBL:1129","trifluridine" -"ChEMBL:5","nalidixic acid" -"ChEMBL:706","cetyl alcohol" -"ChEMBL:2107884","reslizumab" -"ChEMBL:2107830","empagliflozin" -"ChEMBL:512351","betrixaban" -"ChEMBL:2108214","agalsidase alfa" -"ChEMBL:857","biotin" -"ChEMBL:1342","4-hydroxybutanoic acid" -"ChEMBL:1964120","taliglucerase alfa" -"ChEMBL:1255800","fidaxomicin" -"ChEMBL:807","memantine" -"ChEMBL:235668","tipiracil" -"ChEMBL:1292","clofazimine" -"ChEMBL:1697830","chlormadinone" -"ChEMBL:1251","ganirelix" -"ChEMBL:3707331","rolapitant" -"ChEMBL:1200907","trilostane" -"ChEMBL:515","chlorambucil" -"ChEMBL:1201515","pegvisomant" -"ChEMBL:1201354","tridihexethyl" -"ChEMBL:1229908","ethamivan" -"ChEMBL:1201610","corticotropin" -"ChEMBL:1201284","cinacalcet" -"ChEMBL:3275188","lauryldimethyl-3,4-dichlorobenzylammonium" -"ChEMBL:521","ibuprofen" -"ChEMBL:1505","almotriptan" -"ChEMBL:2104994","indisetron" -"ChEMBL:526","propofol" -"ChEMBL:420","guanabenz" -"ChEMBL:1743048","obinutuzumab" -"ChEMBL:1897362","haloxon" -"ChEMBL:2107831","lusutrombopag" -"ChEMBL:923","risedronic acid" -"ChEMBL:1201548","tyloxapol" -"ChEMBL:1255","formaldehyde" -"ChEMBL:1201212","midodrine" -"ChEMBL:1496","rosuvastatin" -"ChEMBL:485696","sulfisomidine" -"ChEMBL:1201821","palifermin" -"ChEMBL:1087","mepivacaine" -"ChEMBL:253592","camylofin" -"ChEMBL:2107869","insulin degludec" -"ChEMBL:1089","phenelzine" -"ChEMBL:1201087","cabergoline" -"ChEMBL:1149","levocarnitine" -"ChEMBL:566315","obeticholic acid" -"ChEMBL:802","minoxidil" -"ChEMBL:768","esmolol" -"ChEMBL:2105128","flumethiazide" -"ChEMBL:780","pentetic acid" -"ChEMBL:3391662","paritaprevir" -"ChEMBL:1743049","olaratumab" -"ChEMBL:55","pentamidine" -"ChEMBL:139","diclofenac" -"ChEMBL:1107","halofantrine" -"ChEMBL:1908331","romurtide" -"ChEMBL:363449","nadifloxacin" -"ChEMBL:1025","isoflurophate" -"ChEMBL:1201554","antithrombin alfa" -"ChEMBL:917","floxuridine" -"ChEMBL:681","etomidate" -"ChEMBL:373081","micronomicin" -"ChEMBL:514446","dehydrocholic acid" -"ChEMBL:443","sulfamethoxazole" -"ChEMBL:591","ethchlorvynol" -"ChEMBL:1201439","basiliximab" -"ChEMBL:1201749","difluprednate" -"ChEMBL:2110746","dibutoline" -"ChEMBL:1073","glipizide" -"ChEMBL:2146883","cobimetinib" -"ChEMBL:495","alprostadil" -"ChEMBL:1358","fulvestrant" -"ChEMBL:2105275","propylhexedrine" -"ChEMBL:1200829","gluconolactone" -"ChEMBL:1108","droperidol" -"ChEMBL:92","docetaxel anhydrous" -"ChEMBL:1201325","hexocyclium" -"ChEMBL:499","timolol anhydrous" -"ChEMBL:525610","teriparatide" -"ChEMBL:530","amdinocillin" -"ChEMBL:1201524","technetium tc-99m apcitide" -"ChEMBL:734","acetohydroxamic acid" -"ChEMBL:99946","levomilnacipran" -"ChEMBL:2040682","ciclesonide" -"ChEMBL:1201558","interferon alfa-2b" -"ChEMBL:2104391","insulin detemir" -"ChEMBL:1350","tiludronic acid" -"ChEMBL:609","trientine" -"ChEMBL:153479","ambroxol" -"ChEMBL:564085","troleandomycin" -"ChEMBL:1201309","nafarelin" -"ChEMBL:1863514","asparaginase erwinia chrysanthemi" -"ChEMBL:1200802","talbutal" -"ChEMBL:1214124","perampanel" -"ChEMBL:2074922","efonidipine" -"ChEMBL:1615775","oxidronic acid" -"ChEMBL:2103873","macitentan" -"ChEMBL:2095212","mirabegron" -"ChEMBL:1422","sitagliptin" -"ChEMBL:589","ropinirole" -"ChEMBL:1200668","calcium chloride" -"ChEMBL:836","tamsulosin" -"ChEMBL:284348","dalfampridine" -"ChEMBL:1908355","tenidap" -"ChEMBL:361812","ramatroban" -"ChEMBL:549","citalopram" -"ChEMBL:2105755","naldemedine" -"ChEMBL:43064","cinnarizine" -"ChEMBL:421","sulfasalazine" -"ChEMBL:58323","lacosamide" -"ChEMBL:1213252","clorazepic acid" -"ChEMBL:720","benzyl alcohol" -"ChEMBL:1480987","cyclandelate" -"ChEMBL:3707314","methoxy polyethylene glycol-epoetin beta" -"ChEMBL:340978","benoxaprofen ammonium" -"ChEMBL:460026","icosapent" -"ChEMBL:959","rimantadine" -"ChEMBL:53463","doxorubicin" -"ChEMBL:821","guanidine" -"ChEMBL:839","carteolol" -"ChEMBL:588","fenoldopam" -"ChEMBL:1201291","ioxaglic acid" -"ChEMBL:524","methoxamine" -"ChEMBL:1501","fluocinonide" -"ChEMBL:2110739","furtrethonium" -"ChEMBL:3621988","chidamide" -"ChEMBL:222645","flucloxacillin" -"ChEMBL:240597","chenodiol" -"ChEMBL:1767408","diquafosol" -"ChEMBL:1908360","everolimus" -"ChEMBL:124211","butethamine" -"ChEMBL:2095207","choline c-11" -"ChEMBL:534","ketotifen" -"ChEMBL:592943","tinoridine" -"ChEMBL:1102","glutethimide" -"ChEMBL:1201594","rasburicase" -"ChEMBL:1697842","methallenestril" -"ChEMBL:223228","efavirenz" -"ChEMBL:461529","oxytetracycline anhydrous" -"ChEMBL:1902627","clorprenaline" -"ChEMBL:577","enalaprilat anhydrous" -"ChEMBL:1187846","scopolamine" -"ChEMBL:969","prazepam" -"ChEMBL:2104036","aminometradine" -"ChEMBL:1576","ethinamate" -"ChEMBL:1688852","valnemulin" -"ChEMBL:2362906","isobornyl thiocyanoacetate" -"ChEMBL:1909303","colestipol" -"ChEMBL:1201342","methixene" -"ChEMBL:1191","sulfamethizole" -"ChEMBL:1201866","liraglutide" -"ChEMBL:2103870","lumacaftor" -"ChEMBL:1018","dienestrol" -"ChEMBL:1522","eszopiclone" -"ChEMBL:1200617","rimexolone" -"ChEMBL:1113","amoxapine" -"ChEMBL:1065","methysergide" -"ChEMBL:562","griseofulvin" -"ChEMBL:501849","simeprevir" -"ChEMBL:3301581","abaloparatide" -"ChEMBL:669","cyclobenzaprine" -"ChEMBL:23","diltiazem" -"ChEMBL:1734","solifenacin" -"ChEMBL:1623","meclizine" -"ChEMBL:1201192","armodafinil" -"ChEMBL:415284","nalorphine" -"ChEMBL:448","pentobarbital" -"ChEMBL:229128","mephenesin" -"ChEMBL:13280","flunitrazepam" -"ChEMBL:1498","desoxycortone" -"ChEMBL:653","nizatidine" -"ChEMBL:52939","sarpogrelate" -"ChEMBL:2111125","phenactropinium" -"ChEMBL:576","succinic acid" -"ChEMBL:623","nefazodone" -"ChEMBL:1009","levodopa" -"ChEMBL:1372341","pirenoxine" -"ChEMBL:1177","pemoline" -"ChEMBL:1591","demeclocycline" -"ChEMBL:442","ergotamine" -"ChEMBL:415","clomipramine" -"ChEMBL:2007641","pertuzumab" -"ChEMBL:1201322","thonzonium" -"ChEMBL:376488","bedaquiline" -"ChEMBL:3545184","etelcalcetide" -"ChEMBL:1536","ergocalciferol" -"ChEMBL:871","etidronic acid" -"ChEMBL:1624","levothyroxine" -"ChEMBL:601719","crizotinib" -"ChEMBL:1201338","cyclopentolate" -"ChEMBL:340801","perlapine" -"ChEMBL:458875","clevudine" -"ChEMBL:1614637","pheneticillin" -"ChEMBL:2028850","icatibant" -"ChEMBL:1396","varenicline" -"ChEMBL:2104294","dimorpholamine" -"ChEMBL:2096623","ioflupane i-123" -"ChEMBL:2105760","brexpiprazole" -"ChEMBL:1201234","mephentermine" -"ChEMBL:2108701","hydroxyethyl starch 130/0.4" -"ChEMBL:1201550","denileukin diftitox" -"ChEMBL:2106347","dimethisterone anhydrous" -"ChEMBL:1484","nicardipine" -"ChEMBL:1729579","lisinopril" -"ChEMBL:1201830","rilonacept" -"ChEMBL:507870","telavancin" -"ChEMBL:668","protriptyline" -"ChEMBL:407","flumazenil" -"ChEMBL:850","sparfloxacin" -"ChEMBL:614","pyrazinamide" -"ChEMBL:2218885","verteporfin" -"ChEMBL:1201356","methylergonovine" -"ChEMBL:667","acetylcholine" -"ChEMBL:1580","pentostatin" -"ChEMBL:20","acetazolamide" -"ChEMBL:3039498","grapiprant" -"ChEMBL:1201562","interferon beta-1a" -"ChEMBL:2104404","emodepside" -"ChEMBL:1262","oxiconazole" -"ChEMBL:1617","rifaximin" -"ChEMBL:1103","furazolidone" -"ChEMBL:473417","vismodegib" -"ChEMBL:1297","fenoprofen" -"ChEMBL:91397","rupatadine" -"ChEMBL:897","probenecid" -"ChEMBL:595","pioglitazone" -"ChEMBL:1201201","methamphetamine" -"ChEMBL:863","cysteine" -"ChEMBL:1201321","difenoxin" -"ChEMBL:900","orphenadrine" -"ChEMBL:1201625","cholestyramine" -"ChEMBL:811","brompheniramine" -"ChEMBL:1123","dicyclomine" -"ChEMBL:1420","pralidoxime" -"ChEMBL:905","rizatriptan" -"ChEMBL:960","leflunomide" -"ChEMBL:581","fosinoprilat" -"ChEMBL:101253","vatalanib" -"ChEMBL:1021","nepafenac" -"ChEMBL:184412","dronedarone" -"ChEMBL:608","probucol" -"ChEMBL:487253","bendamustine" -"ChEMBL:1532","quinethazone" -"ChEMBL:1201247","goserelin" -"ChEMBL:525076","enfuvirtide" -"ChEMBL:84158","tiapride" -"ChEMBL:847","oxamniquine" -"ChEMBL:640","procainamide" -"ChEMBL:1697767","phenyramidol" -"ChEMBL:1077","bromfenac" -"ChEMBL:1201213","isoetharine" -"ChEMBL:2107342","gamithromycin" -"ChEMBL:1541","cefixime" -"ChEMBL:1555183","fudosteine" -"ChEMBL:1082","amoxicillin anhydrous" -"ChEMBL:571","ketoprofen" -"ChEMBL:498466","tiamulin" -"ChEMBL:535","sunitinib" -"ChEMBL:231068","flibanserin" -"ChEMBL:1201189","ammonia n-13" -"ChEMBL:3137309","venetoclax" -"ChEMBL:100259","uridine" -"ChEMBL:1238","azelaic acid" -"ChEMBL:770","tolazoline" -"ChEMBL:1617285","cefsulodin" -"ChEMBL:2110824","buserelin" -"ChEMBL:185073","pancuronium" -"ChEMBL:142438","nitrogen" -"ChEMBL:1537","azlocillin" -"ChEMBL:1755","conivaptan" -"ChEMBL:1201263","hydrocortamate" -"ChEMBL:52440","dextromethorphan" -"ChEMBL:1200686","pimecrolimus" -"ChEMBL:2105224","pholcodine" -"ChEMBL:416146","etoricoxib" -"ChEMBL:409153","isavuconazole" -"ChEMBL:3137327","omega-3-carboxylic acids" -"ChEMBL:1072","bumetanide" -"ChEMBL:2107720","kebuzone" -"ChEMBL:1444","letrozole" -"ChEMBL:629","amitriptyline" -"ChEMBL:2111038","thenium" -"ChEMBL:578","enalapril" -"ChEMBL:973","teriflunomide" -"ChEMBL:108436","pelargonic acid" -"ChEMBL:187709","triparanol" -"ChEMBL:1660","rifapentine" -"ChEMBL:3833408","magaldrate anhydrous" -"ChEMBL:7728","hexobarbital" -"ChEMBL:44657","etoposide" -"ChEMBL:1294","quinidine" -"ChEMBL:295433","orbifloxacin" -"ChEMBL:1201335","glycopyrronium" -"ChEMBL:1201039","benzthiazide" -"ChEMBL:1201129","decitabine" -"ChEMBL:1419","sibutramine" -"ChEMBL:1599","cephapirin" -"ChEMBL:403664","bleomycin" -"ChEMBL:2105345","propanidid" -"ChEMBL:118","celecoxib" -"ChEMBL:125","miltefosine" -"ChEMBL:1201283","polymyxin b" -"ChEMBL:1200370","benzoyl peroxide" -"ChEMBL:1296","cefotiam" -"ChEMBL:2104786","pantethine" -"ChEMBL:1670","mitotane" -"ChEMBL:814","fluvoxamine" -"ChEMBL:1201248","cisatracurium" -"ChEMBL:1697766","perazine" -"ChEMBL:2146121","calcium" -"ChEMBL:90593","prasterone" -"ChEMBL:514674","deoxycholic acid" -"ChEMBL:157548","danofloxacin" -"ChEMBL:1201242","indecainide" -"ChEMBL:1615784","tetrofosmin" -"ChEMBL:1628227","doxepin" -"ChEMBL:1586","beclomethasone" -"ChEMBL:637","venlafaxine" -"ChEMBL:1518","propylthiouracil" -"ChEMBL:1366","auranofin" -"ChEMBL:533","ibutilide" -"ChEMBL:119443","ergonovine" -"ChEMBL:1301","hydroxystilbamidine" -"ChEMBL:1200596","chloroxine" -"ChEMBL:304902","clothiapine" -"ChEMBL:6","indomethacin" -"ChEMBL:1763","hydroflumethiazide" -"ChEMBL:605846","olodaterol" -"ChEMBL:2108675","dupilumab" -"ChEMBL:1434","minocycline" -"ChEMBL:1201563","interferon beta-1b" -"ChEMBL:790","chlorhexidine" -"ChEMBL:430","gemifloxacin" -"ChEMBL:493","bromocriptine" -"ChEMBL:713","entecavir anhydrous" -"ChEMBL:272080","isepamicin" -"ChEMBL:1213351","propoxyphene" -"ChEMBL:1909072","pipamazine" -"ChEMBL:167911","dichlorvos" -"ChEMBL:2170177","pci-34051" -"ChEMBL:249837","methacycline" -"ChEMBL:524004","mepenzolate" -"ChEMBL:417","epirubicin" -"ChEMBL:152067","talinolol" -"ChEMBL:2106329","lenampicillin" -"ChEMBL:848","lenalidomide" -"ChEMBL:211471","neostigmine" -"ChEMBL:1393","spironolactone" -"ChEMBL:1200714","chlormezanone" -"ChEMBL:1397","posaconazole" -"ChEMBL:1263","salmeterol" -"ChEMBL:1201753","pitavastatin" -"ChEMBL:891","cloxacillin" -"ChEMBL:1201784","hexaminolevulinate" -"ChEMBL:1200790","methyprylon" -"ChEMBL:396778","safinamide" -"ChEMBL:198362","rivaroxaban" -"ChEMBL:2108546","pegaspargase" -"ChEMBL:608533","midostaurin" -"ChEMBL:1951143","fimasartan" -"ChEMBL:1084926","gne-493" -"ChEMBL:1517","oxytetracycline" -"ChEMBL:1201633","alglucerase" -"ChEMBL:2104461","haloxazolam" -"ChEMBL:1201472","icodextrin" -"ChEMBL:184618","neomycin" -"ChEMBL:419","mafenide" -"ChEMBL:1525","permethrin" -"ChEMBL:1738990","levopropoxyphene" -"ChEMBL:1201774","sapropterin" -"ChEMBL:701","baclofen" -"ChEMBL:3039583","pasireotide" -"ChEMBL:2219418","naloxegol" -"ChEMBL:1257051","tedizolid" -"ChEMBL:1493","flavoxate" -"ChEMBL:139367","peramivir" -"ChEMBL:1773","capecitabine" -"ChEMBL:1172","desloratadine" -"ChEMBL:54","haloperidol" -"ChEMBL:61593","cyclothiazide" -"ChEMBL:1201046","ceforanide" -"ChEMBL:13341","nimetazepam" -"ChEMBL:477","adenosine" -"ChEMBL:61","podofilox" -"ChEMBL:439","sulfadiazine" -"ChEMBL:87708","lofepramine" -"ChEMBL:82970","salicylanilide" -"ChEMBL:12198","alanine" -"ChEMBL:1201505","fibrinolysin" -"ChEMBL:1364","pyridoxine" -"ChEMBL:135","estradiol" -"ChEMBL:1201823","abatacept" -"ChEMBL:1463","flucytosine" -"ChEMBL:1234004","lithium cation" -"ChEMBL:1201012","flurandrenolide" -"ChEMBL:1451","triamcinolone" -"ChEMBL:1234579","nitrous oxide" -"ChEMBL:1605","ceftibuten" -"ChEMBL:1207444","semduramicin" -"ChEMBL:86","metoclopramide" -"ChEMBL:931","halothane" -"ChEMBL:8659","oleic acid" -"ChEMBL:1095777","indacaterol" -"ChEMBL:127592","oxethazaine" -"ChEMBL:1201229","demecarium" -"ChEMBL:1200932","iopamidol" -"ChEMBL:450","metharbital" -"ChEMBL:575060","glutamic acid" -"ChEMBL:1619785","talampicillin" -"ChEMBL:3740903","sultamicillin" -"ChEMBL:1404","ranolazine" -"ChEMBL:1163","atazanavir" -"ChEMBL:1055","chlorthalidone" -"ChEMBL:33986","butorphanol" -"ChEMBL:1200507","iodixanol" -"ChEMBL:1355299","sulfaethidole" -"ChEMBL:1201109","desonide" -"ChEMBL:869","nitrofurazone" -"ChEMBL:57","nevirapine" -"ChEMBL:1201780","carglumic acid" -"ChEMBL:1525287","famphur" -"ChEMBL:2107774","robenacoxib" -"ChEMBL:1481","glimepiride" -"ChEMBL:1200472","quazepam" -"ChEMBL:3833373","avelumab" -"ChEMBL:1215","phenylephrine" -"ChEMBL:560","pentazocine" -"ChEMBL:1743082","ado-trastuzumab emtansine" -"ChEMBL:1201891","deflazacort" -"ChEMBL:1229517","vemurafenib" -"ChEMBL:1201662","desirudin" -"ChEMBL:1201836","ofatumumab" -"ChEMBL:849","triclosan" -"ChEMBL:404520","chlortetracycline" -"ChEMBL:1201560","peginterferon alfa-2a" -"ChEMBL:1200607","perflexane" -"ChEMBL:809","sertraline" -"ChEMBL:483254","panobinostat" -"ChEMBL:266481","glucagon" -"ChEMBL:252556","idebenone" -"ChEMBL:671","thiotepa" -"ChEMBL:611","terazosin" -"ChEMBL:1200690","lypressin" -"ChEMBL:934","metyrapone" -"ChEMBL:1469","phenylbutyric acid" -"ChEMBL:1569746","unithiol" -"ChEMBL:2107417","levlofexidine" -"ChEMBL:2106324","dihydrotachysterol" -"ChEMBL:1200751","mercaptopurine" -"ChEMBL:3187032","diazolidinyl urea" -"ChEMBL:11298","serine" -"ChEMBL:2105689","luliconazole" -"ChEMBL:787","montelukast" -"ChEMBL:1679","leucovorin" -"ChEMBL:57242","azilsartan" -"ChEMBL:1730","cefotaxime" -"ChEMBL:709","alfuzosin" -"ChEMBL:1601669","alfacalcidol" -"ChEMBL:1479","danazol" -"ChEMBL:2105720","lesinurad" -"ChEMBL:1256841","nialamide" -"ChEMBL:1117","idarubicin" -"ChEMBL:211456","ephedrine" -"ChEMBL:277535","bifonazole" -"ChEMBL:1597","dimercaprol" -"ChEMBL:567597","artemisinin" -"ChEMBL:1515","methimazole" -"ChEMBL:621","trazodone" -"ChEMBL:1200391","tromethamine" -"ChEMBL:225071","raltitrexed" -"ChEMBL:542","aminobenzoic acid" -"ChEMBL:96783","xylitol" -"ChEMBL:70927","deferiprone" -"ChEMBL:1615487","iodoxamic acid" -"ChEMBL:316157","cephaloridine" -"ChEMBL:1441","ethionamide" -"ChEMBL:1289601","lenvatinib" -"ChEMBL:1237119","treprostinil" -"ChEMBL:1201330","mersalyl" -"ChEMBL:299175","tretoquinol" -"ChEMBL:782","tolbutamide" -"ChEMBL:474579","cefotetan" -"ChEMBL:24778","silodosin" -"ChEMBL:1201533","thyrotropin alfa" -"ChEMBL:1200666","calcipotriene" -"ChEMBL:1200622","paricalcitol" -"ChEMBL:312311","paroxypropione" -"ChEMBL:1201198","pemirolast" -"ChEMBL:1237132","clevidipine" -"ChEMBL:110458","migalastat" -"ChEMBL:90555","vincristine" -"ChEMBL:689","mannitol" -"ChEMBL:456","ethacrynic acid" -"ChEMBL:1200356","cyclacillin" -"ChEMBL:2105953","cefteram" -"ChEMBL:1201236","carbidopa anhydrous" -"ChEMBL:330546","lactic acid, l-" -"ChEMBL:1387","norethynodrel" -"ChEMBL:2105618","allylestrenol" -"ChEMBL:3561695","poloxamer 338" -"ChEMBL:1249","iodide ion i-123" -"ChEMBL:3039508","naldemedine tosylate" -"ChEMBL:452859","butoctamide" -"ChEMBL:2105667","orvepitant" -"ChEMBL:1201301","mangafodipir" -"ChEMBL:1908316","ectylurea" -"ChEMBL:291747","threonine" -"ChEMBL:1359","ertapenem" -"ChEMBL:521686","olaparib" -"ChEMBL:1200604","tropicamide" -"ChEMBL:30","cimetidine" -"ChEMBL:1630","amodiaquine" -"ChEMBL:1503","omeprazole" -"ChEMBL:1201718","hyaluronidase (human recombinant)" -"ChEMBL:896","hydroxyzine" -"ChEMBL:1200424","pentetate zinc trisodium" -"ChEMBL:457","gemfibrozil" -"ChEMBL:796","methylphenidate" -"ChEMBL:1076347","triclocarban" -"ChEMBL:1201589","omalizumab" -"ChEMBL:529","azithromycin" -"ChEMBL:1086440","triclabendazole" -"ChEMBL:105608","hexamethonium" -"ChEMBL:54922","proline" -"ChEMBL:3833301","barbexaclone" -"ChEMBL:447","secobarbital" -"ChEMBL:357995","bopindolol" -"ChEMBL:1256391","pirfenidone" -"ChEMBL:251940","periciazine" -"ChEMBL:231813","telaprevir" -"ChEMBL:136737","nimustine" -"ChEMBL:1201723","sinecatechins" -"ChEMBL:1483","albendazole" -"ChEMBL:1291","metipranolol" -"ChEMBL:1221","sulconazole" -"ChEMBL:696","ethosuximide" -"ChEMBL:196","ascorbic acid" -"ChEMBL:334966","cangrelor" -"ChEMBL:27769","stanolone" -"ChEMBL:32573","tramazoline" -"ChEMBL:620","clidinium" -"ChEMBL:645","bisoprolol" -"ChEMBL:1371","chlorzoxazone" -"ChEMBL:24147","resorcinol" -"ChEMBL:489411","amorolfine" -"ChEMBL:2110626","triclobisonium" -"ChEMBL:1625","oxybenzone" -"ChEMBL:1464005","ipratropium" -"ChEMBL:981","fenofibric acid" -"ChEMBL:1201255","histrelin" -"ChEMBL:463","aminohippuric acid" -"ChEMBL:744","riluzole" -"ChEMBL:970","halazepam" -"ChEMBL:46516","fluspirilene" -"ChEMBL:2364648","guselkumab" -"ChEMBL:3301675","linaclotide" -"ChEMBL:1237122","carboprost" -"ChEMBL:606258","oleandomycin" -"ChEMBL:81","raloxifene" -"ChEMBL:1311","isosorbide mononitrate" -"ChEMBL:1425","mercaptopurine anhydrous" -"ChEMBL:1044","phenylacetic acid" -"ChEMBL:2096648","urea c-13" -"ChEMBL:1201514","pegademase bovine" -"ChEMBL:127508","azacyclonol" -"ChEMBL:15891","lindane" -"ChEMBL:1201576","rituximab" -"ChEMBL:1201203","benztropine" -"ChEMBL:1194","prilocaine" -"ChEMBL:1200614","ioversol" -"ChEMBL:1189432","olopatadine" -"ChEMBL:255863","nilotinib" -"ChEMBL:2216870","idelalisib" -"ChEMBL:1680","octreotide" -"ChEMBL:545","alcohol" -"ChEMBL:1908841","levoleucovorin" -"ChEMBL:1520","vardenafil" -"ChEMBL:1595","dihydrocodeine" -"ChEMBL:1489254","triacetin" -"ChEMBL:606","misoprostol" -"ChEMBL:1201677","colesevelam" -"ChEMBL:189","milrinone" -"ChEMBL:2303618","uzarin" -"ChEMBL:1480","felodipine" -"ChEMBL:3183658","tetraprenylacetone" -"ChEMBL:188185","bunazosin" -"ChEMBL:1075","moricizine" -"ChEMBL:170052","ibafloxacin" -"ChEMBL:33","levofloxacin" -"ChEMBL:766","cilastatin" -"ChEMBL:1282","imiquimod" -"ChEMBL:231779","apixaban" -"ChEMBL:1222251","inositol" -"ChEMBL:1200732","amcinonide" -"ChEMBL:1513","irbesartan" -"ChEMBL:1201300","iothalamic acid" -"ChEMBL:1510","eletriptan" -"ChEMBL:1200436","oxandrolone" -"ChEMBL:1206440","cyclamic acid" -"ChEMBL:1560","captopril" -"ChEMBL:111","rimonabant" -"ChEMBL:301523","phenylalanine" -"ChEMBL:261641","su11274" -"ChEMBL:1200568","talc" -"ChEMBL:2104624","methitural" -"ChEMBL:1743062","ramucirumab" -"ChEMBL:3544986","perindopril arginine" -"ChEMBL:1201764","fesoterodine" -"ChEMBL:1201352","rapacuronium" -"ChEMBL:159","vinblastine" -"ChEMBL:1182833","mivacurium" -"ChEMBL:269732","tacrolimus anhydrous" -"ChEMBL:2108041","ocrelizumab" -"ChEMBL:1201477","polyestradiol phosphate" -"ChEMBL:998","loratadine" -"ChEMBL:741","lamotrigine" -"ChEMBL:963","oxymorphone" -"ChEMBL:2374220","ledipasvir" -"ChEMBL:1882461","bevonium" -"ChEMBL:1023","bexarotene" -"ChEMBL:17","dichlorphenamide" -"ChEMBL:232202","arbutin" -"ChEMBL:1514715","ethamsylate" -"ChEMBL:1743034","ixekizumab" -"ChEMBL:1213490","romidepsin" -"ChEMBL:1197206","tolonium" -"ChEMBL:205596","cholic acid" -"ChEMBL:218490","dorzolamide" -"ChEMBL:685","mebendazole" -"ChEMBL:592","levorphanol" -"ChEMBL:2108147","streptokinase" -"ChEMBL:1040","calcifediol anhydrous" -"ChEMBL:1200453","docosanol" -"ChEMBL:1200889","metrizamide" -"ChEMBL:1161632","carbonate ion" -"ChEMBL:2110926","etafedrine" -"ChEMBL:1305","antazoline" -"ChEMBL:1201328","carphenazine" -"ChEMBL:1371412","tioxidazole" -"ChEMBL:1201446","bentoquatam" -"ChEMBL:1201368","perindoprilat" -"ChEMBL:481","irinotecan" -"ChEMBL:465","dronabinol" -"ChEMBL:360055","triethylgallamine" -"ChEMBL:130","chloramphenicol" -"ChEMBL:289469","granisetron" -"ChEMBL:1201469","gramicidin" -"ChEMBL:1051","latanoprost" -"ChEMBL:1231","oxybutynin" -"ChEMBL:1685","dezocine" -"ChEMBL:852","melphalan" -"ChEMBL:1732","dihydroergotamine" -"ChEMBL:20835","aceclidine" -"ChEMBL:636","rivastigmine" -"ChEMBL:1200934","norgestimate" -"ChEMBL:1622","folic acid" -"ChEMBL:607","meperidine" -"ChEMBL:877","tranexamic acid" -"ChEMBL:2051960","carbazochrome" -"ChEMBL:1697841","isometheptene" -"ChEMBL:3039567","sodium glycerophosphate" -"ChEMBL:516","cyproheptadine" -"ChEMBL:1589896","hexoprenaline" -"ChEMBL:760","anagrelide" -"ChEMBL:946","azatadine" -"ChEMBL:18","ethoxzolamide" -"ChEMBL:2103752","ziconotide" -"ChEMBL:1413","ciclopirox" -"ChEMBL:387675","daptomycin" -"ChEMBL:1399124","syrosingopine" -"ChEMBL:1697744","erdosteine" -"ChEMBL:2079587","stanozolol" -"ChEMBL:1201327","acetrizoic acid" -"ChEMBL:282052","methaqualone" -"ChEMBL:376359","alogliptin" -"ChEMBL:447701","fluciclovine f-18" -"ChEMBL:2106589","enocitabine" -"ChEMBL:122","rofecoxib" -"ChEMBL:1201131","piperonyl butoxide" -"ChEMBL:936","diphenidol" -"ChEMBL:1201556","becaplermin" -"ChEMBL:1200689","nitric oxide" -"ChEMBL:2108078","parathyroid hormone" -"ChEMBL:2108429","mepolizumab" -"ChEMBL:1271","pentolinium" -"ChEMBL:409","bicalutamide" -"ChEMBL:1201365","ramiprilat" -"ChEMBL:276568","cefprozil anhydrous" -"ChEMBL:705","alitretinoin" -"ChEMBL:451483","plicamycin" -"ChEMBL:1684","bendroflumethiazide" -"ChEMBL:436921","doxycycline anhydrous" -"ChEMBL:590799","camostat" -"ChEMBL:1201561","peginterferon alfa-2b" -"ChEMBL:1398031","mecamylamine" -"ChEMBL:990","butenafine" -"ChEMBL:1495","oxyphencyclimine" -"ChEMBL:1318150","aspoxicillin" -"ChEMBL:1201568","pegfilgrastim" -"ChEMBL:1683590","eribulin" -"ChEMBL:267744","ticrynafen" -"ChEMBL:1449","ticarcillin" -"ChEMBL:223520","kanamycin a" -"ChEMBL:193240","roflumilast" -"ChEMBL:865","valdecoxib" -"ChEMBL:2110651","tiemonium" -"ChEMBL:86715","procyclidine" -"ChEMBL:493982","vorapaxar" -"ChEMBL:544","mequinol" -"ChEMBL:1373","modafinil" -"ChEMBL:21","sulfanilamide" -"ChEMBL:2107254","cloxazolam" -"ChEMBL:1290","penbutolol" -"ChEMBL:409803","angiotensin amide" -"ChEMBL:1384","kanamycin" -"ChEMBL:1276258","fondaparinux" -"ChEMBL:1193","pheniramine" -"ChEMBL:502896","cetraxate" -"ChEMBL:471","sotalol" -"ChEMBL:66092","laquinimod" -"ChEMBL:1200593","gadoteridol" -"ChEMBL:1643","ribavirin" -"ChEMBL:1200386","prednicarbate" -"ChEMBL:2103827","droxidopa" -"ChEMBL:1112","aripiprazole" -"ChEMBL:2133806","jnj-38877605" -"ChEMBL:412873","sparteine" -"ChEMBL:1201273","protokylol" -"ChEMBL:1697851","thiopropazate" -"ChEMBL:728","prochlorperazine" -"ChEMBL:584","nelfinavir" -"ChEMBL:2103774","tibolone" -"ChEMBL:1742992","blinatumomab" -"ChEMBL:2105131","mefruside" -"ChEMBL:435298","esflurbiprofen" -"ChEMBL:2104662","alfaprostol" -"ChEMBL:108358","tiazofurin" -"ChEMBL:325041","bortezomib" -"ChEMBL:1201865","velaglucerase alfa" -"ChEMBL:1790041","ranitidine" -"ChEMBL:1201517","perfluoropolymethylisopropyl ether" -"ChEMBL:1534","riboflavin" -"ChEMBL:428647","paclitaxel" -"ChEMBL:3544926","obiltoxaximab" -"ChEMBL:1201668","nesiritide" -"ChEMBL:2104993","vortioxetine" -"ChEMBL:229383","nystatin" -"ChEMBL:1201608","muromonab-cd3" -"ChEMBL:121","rosiglitazone" -"ChEMBL:1725880","trepibutone" -"ChEMBL:2108738","nivolumab" -"ChEMBL:757","nandrolone" -"ChEMBL:461101","eltrombopag" -"ChEMBL:1590","pseudoephedrine" -"ChEMBL:91","miconazole" -"ChEMBL:517712","atropine" -"ChEMBL:2103756","sulfomyxin" -"ChEMBL:1200868","phenyl aminosalicylate" -"ChEMBL:13","metoprolol" -"ChEMBL:1098","bupivacaine" -"ChEMBL:511142","buprenorphine" -"ChEMBL:1908311","mequitazine" -"ChEMBL:22150","chlorcyclizine" -"ChEMBL:1079","tizanidine" -"ChEMBL:1788389","stibophen" -"ChEMBL:2048484","canagliflozin anhydrous" -"ChEMBL:1201261","tyropanic acid" -"ChEMBL:446","sulfamethazine" -"ChEMBL:3707227","atezolizumab" -"ChEMBL:2048028","lifitegrast" -"ChEMBL:1614","deslanoside" -"ChEMBL:386051","pd173955" -"ChEMBL:1488165","pidotimod" -"ChEMBL:1201666","lepirudin" -"ChEMBL:2105458","thenalidine" -"ChEMBL:506871","veliparib" -"ChEMBL:95855","nicarbazin" -"ChEMBL:1709464","phenazepam" -"ChEMBL:558","mexiletine" -"ChEMBL:729","lopinavir" -"ChEMBL:1201293","acamprosate" -"ChEMBL:218394","boceprevir" -"ChEMBL:3301678","monoctanoin" -"ChEMBL:451887","carfilzomib" -"ChEMBL:407135","colistin" -"ChEMBL:1354","sodium acetate" -"ChEMBL:37390","proxyphylline" -"ChEMBL:638","voriconazole" -"ChEMBL:1201117","methocarbamol" -"ChEMBL:17962","histidine" -"ChEMBL:1464","warfarin" -"ChEMBL:1208","cinoxacin" -"ChEMBL:1201747","alcaftadine" -"ChEMBL:494","iloprost" -"ChEMBL:502835","nintedanib" -"ChEMBL:1201438","aldesleukin" -"ChEMBL:250270","lercanidipine" -"ChEMBL:3741702","delamanid" -"ChEMBL:480","lansoprazole" -"ChEMBL:1328219","teflubenzuron" -"ChEMBL:559","dextrothyroxine" -"ChEMBL:1346","darifenacin" -"ChEMBL:996","cefoxitin" -"ChEMBL:1377","proguanil" -"ChEMBL:2110562","chlormerodrin" -"ChEMBL:48361","dabigatran" -"ChEMBL:131","prednisolone" -"ChEMBL:2040681","spinosad" -"ChEMBL:1655","toremifene" -"ChEMBL:37161","fenbendazole" -"ChEMBL:924","zoledronic acid anhydrous" -"ChEMBL:417007","sacubitrilat" -"ChEMBL:632","betamethasone" -"ChEMBL:452231","teniposide" -"ChEMBL:622","etodolac" -"ChEMBL:243712","amisulpride" -"ChEMBL:36","pyrimethamine" -"ChEMBL:1743087","vedolizumab" -"ChEMBL:1963684","peginesatide acetate" -"ChEMBL:592435","derenofylline" -"ChEMBL:1407943","clemizole" -"ChEMBL:1546","hydroxyamphetamine" -"ChEMBL:2010601","ivacaftor" -"ChEMBL:1323","darunavir" -"ChEMBL:37853","cloprostenol" -"ChEMBL:846","calcitriol" -"ChEMBL:898","diflunisal" -"ChEMBL:15770","sulindac" -"ChEMBL:1321","procarbazine" -"ChEMBL:911","zolpidem" -"ChEMBL:655","midazolam" -"ChEMBL:1144","pravastatin" -"ChEMBL:1583","bacampicillin" -"ChEMBL:445","nortriptyline" -"ChEMBL:695","trimethadione" -"ChEMBL:1201139","megestrol" -"ChEMBL:1201295","bitolterol" -"ChEMBL:1248","fluoride ion f-18" -"ChEMBL:158","aztreonam" -"ChEMBL:942","bisacodyl" -"ChEMBL:1566","acarbose" -"ChEMBL:1192519","benazeprilat" -"ChEMBL:177","amikacin" -"ChEMBL:41355","ezogabine" -"ChEMBL:358040","norfenefrine" -"ChEMBL:511115","cilomilast" -"ChEMBL:1095","ethotoin" -"ChEMBL:1697771","rebamipide" -"ChEMBL:444633","rifabutin" -"ChEMBL:451","chlordiazepoxide" -"ChEMBL:2111099","maropitant" -"ChEMBL:1256","isoflurane" -"ChEMBL:781","mazindol" -"ChEMBL:455","sulfacetamide" -"ChEMBL:1200585","oxymetholone" -"ChEMBL:3137342","dinutuximab" -"ChEMBL:1908315","gemeprost" -"ChEMBL:2109104","betiatide" -"ChEMBL:2354773","aurothioglucose" -"ChEMBL:312448","xylometazoline" -"ChEMBL:1477","cerivastatin" -"ChEMBL:2106989","menthol, (+)-" -"ChEMBL:982","nalmefene" -"ChEMBL:70","morphine" -"ChEMBL:41","fluoxetine" -"ChEMBL:785","ritodrine" -"ChEMBL:93","zileuton" -"ChEMBL:1206211","anhydrous dextrose" -"ChEMBL:1743070","siltuximab" -"ChEMBL:1069","valsartan" -"ChEMBL:1200574","sodium chloride" -"ChEMBL:1187011","domiphen" -"ChEMBL:1743047","necitumumab" -"ChEMBL:1231871","carbon dioxide" -"ChEMBL:1201268","methscopolamine" -"ChEMBL:1443577","sulfachlorpyridazine" -"ChEMBL:1101","biperiden" -"ChEMBL:468837","heptabarbital" -"ChEMBL:631","propafenone" -"ChEMBL:1372","oxiglutatione" -"ChEMBL:1201585","trastuzumab" -"ChEMBL:270190","alvimopan anhydrous" -"ChEMBL:1017","telmisartan" -"ChEMBL:267044","levosulpiride" -"ChEMBL:1085","acetophenazine" -"ChEMBL:1668","rescinnamine" -"ChEMBL:808","econazole" -"ChEMBL:1200963","bimatoprost" -"ChEMBL:459","methyldopa anhydrous" -"ChEMBL:1200766","silver sulfadiazine" -"ChEMBL:134","clonidine" -"ChEMBL:878","metolazone" -"ChEMBL:1619","cladribine" -"ChEMBL:113313","capromorelin" -"ChEMBL:2110703","tiletamine" -"ChEMBL:3085436","viomycin" -"ChEMBL:84","topotecan" -"ChEMBL:22587","itraconazole" -"ChEMBL:2111164","trolnitrate" -"ChEMBL:1094966","pirbuterol" -"ChEMBL:1200660","isosorbide" -"ChEMBL:1200959","methdilazine" -"ChEMBL:305380","bupranolol" -"ChEMBL:193","nifedipine" -"ChEMBL:1200544","cephalexin" -"ChEMBL:1200359","sulfameter" -"ChEMBL:297302","benperidol" -"ChEMBL:1697847","polysorbate 80" -"ChEMBL:1201095","chlormerodrin hg-197" -"ChEMBL:1727","cephalexin anhydrous" -"ChEMBL:834","pamidronic acid" -"ChEMBL:59","dopamine" -"ChEMBL:1574","phentermine" -"ChEMBL:1324","tolcapone" -"ChEMBL:1378","thiethylperazine" -"ChEMBL:803","cytarabine" -"ChEMBL:1360","atracurium" -"ChEMBL:2","prazosin" -"ChEMBL:170988","phenformin" -"ChEMBL:492","etidocaine" -"ChEMBL:264374","bezafibrate" -"ChEMBL:56367","nimesulide" -"ChEMBL:1200438","tioconazole" -"ChEMBL:602","cysteamine" -"ChEMBL:3186254","d&c yellow no. 10" -"ChEMBL:180570","medronic acid" -"ChEMBL:1201239","iodamide" -"ChEMBL:772","reserpine" -"ChEMBL:1201613","insulin glulisine" -"ChEMBL:94","physostigmine" -"ChEMBL:2103758","pramlintide" -"ChEMBL:71","chlorpromazine" -"ChEMBL:1046","aminocaproic acid" -"ChEMBL:1742996","brodalumab" -"ChEMBL:1389","levonorgestrel" -"ChEMBL:1516","olmesartan" -"ChEMBL:268869","sulfamethoxypyridazine" -"ChEMBL:1224","acrivastine" -"ChEMBL:267495","nalfurafine" -"ChEMBL:976","praziquantel" -"ChEMBL:369475","codeine anhydrous" -"ChEMBL:2108336","lixisenatide" -"ChEMBL:2111101","pimavanserin" -"ChEMBL:939","gefitinib" -"ChEMBL:1265","adapalene" -"ChEMBL:1235872","sucrosofate" -"ChEMBL:753","phenoxybenzamine" -"ChEMBL:2110563","cyanocobalamin" -"ChEMBL:1789941","ruxolitinib" -"ChEMBL:2110809","captodiame" -"ChEMBL:2103784","cosyntropin" -"ChEMBL:1094","felbamate" -"ChEMBL:453","sulfisoxazole" -"ChEMBL:527","piroxicam" -"ChEMBL:1139","epoprostenol" -"ChEMBL:452","clonazepam" -"ChEMBL:431","spirapril" -"ChEMBL:2107117","timiperone" -"ChEMBL:2105737","sonidegib" -"ChEMBL:1789843","belimumab" -"ChEMBL:1487","atorvastatin" -"ChEMBL:1201210","propiomazine" -"ChEMBL:657","diphenhydramine" -"ChEMBL:2108184","crofelemer" -"ChEMBL:1201467","estrogens, conjugated synthetic b" -"ChEMBL:547","isotretinoin" -"ChEMBL:34259","methotrexate" -"ChEMBL:1491","amlodipine" -"ChEMBL:1524273","phthalylsulfathiazole" -"ChEMBL:1200862","metyrosine" -"ChEMBL:1201631","insulin human" -"ChEMBL:914","fexofenadine" -"ChEMBL:1201216","dapiprazole" -"ChEMBL:1306","terconazole" -"ChEMBL:1201716","mecasermin" -"ChEMBL:1185","zolmitriptan" -"ChEMBL:820","busulfan" -"ChEMBL:8085","lysine" -"ChEMBL:1004","doxylamine" -"ChEMBL:87563","gabexate" -"ChEMBL:471737","ivabradine" -"ChEMBL:44884","ethambutol" -"ChEMBL:415324","tranilast" -"ChEMBL:1201225","iodine" -"ChEMBL:2107841","albiglutide" -"ChEMBL:832","sulfinpyrazone" -"ChEMBL:346977","fonazine" -"ChEMBL:254219","digitoxin" -"ChEMBL:2110725","vinflunine" -"ChEMBL:473","dofetilide" -"ChEMBL:1200346","gadodiamide" -"ChEMBL:1138","ezetimibe" -"ChEMBL:104","clotrimazole" -"ChEMBL:528","ceftizoxime" -"ChEMBL:2221250","capreomycin" -"ChEMBL:305187","ifenprodil" -"ChEMBL:374478","rifampin" -"ChEMBL:2103867","plecanatide" -"ChEMBL:408513","belinostat" -"ChEMBL:600","acetylcysteine" -"ChEMBL:887","rasagiline" -"ChEMBL:2108670","bezlotoxumab" -"ChEMBL:127487","cyclomethycaine" -"ChEMBL:2105348","ranimustine" -"ChEMBL:553025","vinorelbine" -"ChEMBL:386630","testosterone" -"ChEMBL:49080","clenbuterol" -"ChEMBL:2104426","framycetin" -"ChEMBL:511","pyrilamine" -"ChEMBL:1201466","estrogens, conjugated synthetic a" -"ChEMBL:416","methoxsalen" -"ChEMBL:1697845","norethandrolone" -"ChEMBL:44354","ceftazidime" -"ChEMBL:313833","tranylcypromine" -"ChEMBL:3799986","pramipexole" -"ChEMBL:661","alprazolam" -"ChEMBL:2109540","alirocumab" -"ChEMBL:503565","vinbarbital" -"ChEMBL:885","emtricitabine" -"ChEMBL:404","tazobactam" -"ChEMBL:643","promethazine" -"ChEMBL:2068237","cisplatin" -"ChEMBL:945","amiloride" -"ChEMBL:1888176","trospium" -"ChEMBL:3127326","ombitasvir" -"ChEMBL:1201824","alglucosidase alfa" -"ChEMBL:1201587","alemtuzumab" -"ChEMBL:1644","cefadroxil anhydrous" -"ChEMBL:374731","telbivudine" -"ChEMBL:1201834","canakinumab" -"ChEMBL:3301669","dalbavancin" -"ChEMBL:659","galantamine" -"ChEMBL:2095208","cobicistat" -"ChEMBL:985","urea" -"ChEMBL:498847","secnidazole" -"ChEMBL:1201772","prasugrel" -"ChEMBL:409542","retapamulin" -"ChEMBL:253376","bromhexine" -"ChEMBL:1201538","insulin lispro" -"ChEMBL:434","isoproterenol" -"ChEMBL:730","nitroglycerin" -"ChEMBL:1587","polythiazide" -"ChEMBL:635","prednisone" -"ChEMBL:926","dobutamine" -"ChEMBL:109","valproic acid" -"ChEMBL:972","selegiline" -"ChEMBL:372795","streptomycin" -"ChEMBL:1742994","brentuximab vedotin" -"ChEMBL:1615438","levocabastine" -"ChEMBL:2023898","daclatasvir" -"ChEMBL:1261","anhydrous citric acid" -"ChEMBL:2104700","moperone" -"ChEMBL:126","linezolid" -"ChEMBL:714","albuterol" -"ChEMBL:1885437","eprazinone" -"ChEMBL:1762","tocainide" -"ChEMBL:1697829","ceftezole" -"ChEMBL:1531","etonogestrel" -"ChEMBL:1448","niclosamide" -"ChEMBL:762","oxymetazoline" -"ChEMBL:1382","tolterodine" -"ChEMBL:262777","vancomycin" -"ChEMBL:1194666","diethylpropion" -"ChEMBL:72","desipramine" -"ChEMBL:1863513","ingenol mebutate" -"ChEMBL:1477036","docusate" -"ChEMBL:562318","pf-2545920" -"ChEMBL:964","disulfiram" -"ChEMBL:12","diazepam" -"ChEMBL:1200357","latamoxef" -"ChEMBL:416956","mefloquine" -"ChEMBL:398440","chloroxylenol" -"ChEMBL:2109168","dextran 40" -"ChEMBL:1169","aminosalicylic acid" -"ChEMBL:1201319","metaraminol" -"ChEMBL:1136","telithromycin" -"ChEMBL:799","cilostazol" -"ChEMBL:31","gatifloxacin anhydrous" -"ChEMBL:1237026","tesamorelin" -"ChEMBL:504","dimethyl sulfoxide" -"ChEMBL:422","trifluoperazine" -"ChEMBL:92915","aminopentamide" -"ChEMBL:1201271","buclizine" -"ChEMBL:1442422","dibenzepin" -"ChEMBL:1168","ramipril" -"ChEMBL:1200368","bentiromide" -"ChEMBL:389621","hydrocortisone" -"ChEMBL:2105567","cefalonium" -"ChEMBL:206253","netupitant" -"ChEMBL:1201264","methantheline" -"ChEMBL:1601","cefonicid" -"ChEMBL:2111107","sugammadex" -"ChEMBL:2104900","pipazethate" -"ChEMBL:1096562","methyl aminolevulinate" -"ChEMBL:2103877","efinaconazole" -"ChEMBL:1757","fosfomycin" -"ChEMBL:3544909","calcifediol" -"ChEMBL:1201196","sertaconazole" -"ChEMBL:438","sulfamerazine" -"ChEMBL:1445","fluoxymesterone" -"ChEMBL:1774461","florbetapir f-18" -"ChEMBL:344159","tolvaptan" -"ChEMBL:2028019","cariprazine" -"ChEMBL:507674","cefoperazone" -"ChEMBL:1200598","fosfestrol" -"ChEMBL:2105605","ufenamate" -"ChEMBL:9967","pirenzepine" -"ChEMBL:1229","oseltamivir" -"ChEMBL:1201646","inulin" -"ChEMBL:1161681","nitrite ion" -"ChEMBL:317052","regadenoson anhydrous" -"ChEMBL:1082407","enzalutamide" -"ChEMBL:1475","trioxsalen" -"ChEMBL:3545311","brigatinib" -"ChEMBL:1963681","avanafil" -"ChEMBL:2110862","dimethoxanate" -"ChEMBL:1237025","pegloticase" -"ChEMBL:1946170","regorafenib" -"ChEMBL:1201187","maraviroc" -"ChEMBL:1242","phenazopyridine" -"ChEMBL:2107457","itopride" -"ChEMBL:1796997","helium" -"ChEMBL:717","medroxyprogesterone" -"ChEMBL:1201619","aprotinin" -"ChEMBL:1201294","diphenoxylate" -"ChEMBL:1201626","chymopapain" -"ChEMBL:1200810","doxercalciferol" -"ChEMBL:2096635","urea c-14" -"ChEMBL:373742","vasopressin" -"ChEMBL:1279","frovatriptan" -"ChEMBL:893","dicloxacillin" -"ChEMBL:1399","anastrozole" -"ChEMBL:1388","monobenzone" -"ChEMBL:1682","sorbitol" -"ChEMBL:1789844","ipilimumab" -"ChEMBL:1174","eptifibatide" -"ChEMBL:3039597","gentamicin" -"ChEMBL:55643","copper" -"ChEMBL:1201243","ipodic acid" -"ChEMBL:1201217","dyclonine" -"ChEMBL:1868702","gestrinone" -"ChEMBL:1774055","az-960" -"ChEMBL:1466","dicumarol" -"ChEMBL:1201224","cefmenoxime" -"ChEMBL:1201380","diflorasone" -"ChEMBL:514","lomustine" -"ChEMBL:18442","plerixafor" -"ChEMBL:6622","isosorbide dinitrate" -"ChEMBL:1200640","ferrous fumarate" -"ChEMBL:1514","levomethadyl" -"ChEMBL:1489","azacitidine" -"ChEMBL:1231649","carbomycin a" -"ChEMBL:186","cefepime" -"ChEMBL:108541","picric acid" -"ChEMBL:13828","oxatomide" -"ChEMBL:127","meropenem anhydrous" -"ChEMBL:2135460","terlipressin" -"ChEMBL:484","adefovir" -"ChEMBL:2105637","delafloxacin" -"ChEMBL:185","fluorouracil" -"ChEMBL:189963","palbociclib" -"ChEMBL:221959","tofacitinib" -"ChEMBL:1201219","vecuronium" -"ChEMBL:36633","oxiracetam" -"ChEMBL:1201825","ranibizumab" -"ChEMBL:2104761","ticarbodine" -"ChEMBL:1210954","balofloxacin" -"ChEMBL:1619528","pipenzolate" -"ChEMBL:1485","arginine" -"ChEMBL:2103868","cabozantinib s-malate" -"ChEMBL:476","dacarbazine" -"ChEMBL:398435","ticagrelor" -"ChEMBL:1201758","bepotastine" -"ChEMBL:1167","spectinomycin" -"ChEMBL:1450","atovaquone" -"ChEMBL:2110773","cimetropium" -"ChEMBL:19224","papaverine" -"ChEMBL:1187833","umeclidinium" -"ChEMBL:1201096","krypton kr-81m" -"ChEMBL:1200979","dexpanthenol" -"ChEMBL:1274","nilutamide" -"ChEMBL:1190","decamethonium" -"ChEMBL:1200522","avobenzone" -"ChEMBL:1351","carboplatin" -"ChEMBL:932","dipyridamole" -"ChEMBL:154126","ormeloxifene" -"ChEMBL:477874","flurothyl" -"ChEMBL:2096649","ecamsule" -"ChEMBL:593","delavirdine" -"ChEMBL:1179047","chloroprocaine" -"ChEMBL:1421","dasatinib" -"ChEMBL:367463","pranoprofen" -"ChEMBL:1731","mezlocillin" -"ChEMBL:2104987","teduglutide" -"ChEMBL:1200455","iohexol" -"ChEMBL:1460","didanosine" -"ChEMBL:429910","dapagliflozin" -"ChEMBL:301267","artemotil" -"ChEMBL:1336","sorafenib" -"ChEMBL:607710","chlorphenesin carbamate" -"ChEMBL:1863515","glucarpidase" -"ChEMBL:1337","nitisinone" -"ChEMBL:224436","josamycin" -"ChEMBL:1370","budesonide" -"ChEMBL:1605443","mebrofenin" -"ChEMBL:861","mephenytoin" -"ChEMBL:3544537","deacetylbisacodyl" -"ChEMBL:509924","diflucortolone" -"ChEMBL:425","olsalazine" -"ChEMBL:1016","candesartan" -"ChEMBL:1186894","amrubicin" -"ChEMBL:3707372","voxilaprevir" -"ChEMBL:2106357","florantyrone" -"ChEMBL:3545062","velpatasvir" -"ChEMBL:1201420","urokinase" -"ChEMBL:1314","tiopronin" -"ChEMBL:316257","dimyristoylphosphatidylcholine, dl-" -"ChEMBL:1550","phytonadione" -"ChEMBL:698","tetracaine" -"ChEMBL:3545432","ixazomib citrate" -"ChEMBL:968","flurazepam" -"ChEMBL:1201112","nelarabine" -"ChEMBL:27810","celiprolol" -"ChEMBL:2108766","pyrethrum extract" -"ChEMBL:566752","florbetaben f-18" -"ChEMBL:2103872","ceftolozane" -"ChEMBL:1308","fomepizole" -"ChEMBL:290578","cambendazole" -"ChEMBL:395429","oxytocin" -"ChEMBL:1201148","meprednisone" -"ChEMBL:6273","fleroxacin" -"ChEMBL:708","ziprasidone" -"ChEMBL:2103846","ulipristal" -"ChEMBL:472566","zoxazolamine" -"ChEMBL:61946","caramiphen" -"ChEMBL:672","fenofibrate" -"ChEMBL:1328","pentagastrin" -"ChEMBL:1618279","revaprazan" -"ChEMBL:1198857","vilanterol" -"ChEMBL:85","risperidone" -"ChEMBL:47",".alpha.-tocopherol, dl-" -"ChEMBL:572","nitrofurantoin" -"ChEMBL:19019","naltrexone" -"ChEMBL:777","clavulanic acid" -"ChEMBL:1201199","leuprolide" -"ChEMBL:1111","ambrisentan" -"ChEMBL:1236962","omipalisib" -"ChEMBL:454446","cefditoren" -"ChEMBL:13209","nitrazepam" -"ChEMBL:1437065","nitromide" -"ChEMBL:3084803","astromicin" -"ChEMBL:290916","edaravone" -"ChEMBL:42336","methionine" -"ChEMBL:1200736","magnesium carbonate" -"ChEMBL:285802","zotepine" -"ChEMBL:274323","aspartic acid" -"ChEMBL:112","acetaminophen" -"ChEMBL:488","aminoglutethimide" -"ChEMBL:54661","flupentixol" -"ChEMBL:1110","alosetron" -"ChEMBL:2108727","talimogene laherparepvec" -"ChEMBL:1565476","apazone" -"ChEMBL:1440","tetracycline" -"ChEMBL:1200468","malathion" -"ChEMBL:254328","abiraterone" -"ChEMBL:2105293","phenaglycodol" -"ChEMBL:771","cycloserine" -"ChEMBL:1098319","2-mercaptoethanesulfonic acid" -"ChEMBL:1453","uzarigenin" -"ChEMBL:2108989","asparaginase" -"ChEMBL:702","piperacillin anhydrous" -"ChEMBL:1515611","bromisoval" -"ChEMBL:43452","pomalidomide" -"ChEMBL:2106161","epitiostanol" -"ChEMBL:888","gemcitabine" -"ChEMBL:1182657","tiotropium" -"ChEMBL:563","flurbiprofen" -"ChEMBL:114655","nylidrin" -"ChEMBL:1166","argatroban anhydrous" -"ChEMBL:1200454","valganciclovir hcl" -"ChEMBL:1199324","fosaprepitant" -"ChEMBL:1257","enflurane" -"ChEMBL:3137326","deutetrabenazine" -"ChEMBL:2107875","patiromer" -"ChEMBL:870","alendronic acid" -"ChEMBL:1201828","eculizumab" -"ChEMBL:161","ceftriaxone" -"ChEMBL:2108726","technetium tc-99m tilmanocept" -"ChEMBL:1643895","ramosetron" -"ChEMBL:3182355","trenbolone" -"ChEMBL:1146","cefamandole" -"ChEMBL:617","cephalothin" -"ChEMBL:580","lorazepam" -"ChEMBL:354541","lomitapide" -"ChEMBL:957","bosentan" -"ChEMBL:233406","sodium sulfate anhydrous" -"ChEMBL:279516","indoramin" -"ChEMBL:466246","laninamivir" -"ChEMBL:1544","liothyronine" -"ChEMBL:220491","brinzolamide" -"ChEMBL:459265","gentian violet cation" -"ChEMBL:503","lovastatin" -"ChEMBL:902","famotidine" -"ChEMBL:3301572","nusinersen" -"ChEMBL:954","clomiphene" -"ChEMBL:175691","rilpivirine" -"ChEMBL:1201497","insulin glargine" -"ChEMBL:810","temozolomide" -"ChEMBL:561","lomefloxacin" -"ChEMBL:651","methadone" -"ChEMBL:1200733","desflurane" -"ChEMBL:397420","acenocoumarol" -"ChEMBL:1201358","benzphetamine" -"ChEMBL:2111030","prothipendyl" -"ChEMBL:1472","protirelin" -"ChEMBL:2103737","hydroxocobalamin" -"ChEMBL:424","salicylic acid" -"ChEMBL:2107834","riociguat" -"ChEMBL:1062","hydroxyprogesterone" -"ChEMBL:2110596","azapetine" -"ChEMBL:1068","oxcarbazepine" -"ChEMBL:650","methylprednisolone" -"ChEMBL:1201670","sargramostim" -"ChEMBL:703","succinylcholine" -"ChEMBL:54976","tryptophan" -"ChEMBL:1201584","abciximab" -"ChEMBL:427","mechlorethamine" -"ChEMBL:80","naloxone" -"ChEMBL:92870","lidoflazine" -"ChEMBL:466659","pentaerythritol tetranitrate" -"ChEMBL:1527608","doxofylline" -"ChEMBL:1201607","natalizumab" -"ChEMBL:1201445","calcitonin salmon" -"ChEMBL:656","oxycodone" -"ChEMBL:819","oxacillin" -"ChEMBL:2105317","prostalene" -"ChEMBL:572964","sulfate ion" -"ChEMBL:1201468","estrogens, esterified" -"ChEMBL:428","trovafloxacin" -"ChEMBL:25","aspirin" -"ChEMBL:24828","vandetanib" -"ChEMBL:49","buspirone" -"ChEMBL:1473","fluticasone propionate" -"ChEMBL:1224207","trabectedin" -"ChEMBL:1196","proparacaine" -"ChEMBL:1083659","suvorexant" -"ChEMBL:1189513","furaltadone" -"ChEMBL:1201056","sulfacytine" -"ChEMBL:2110788","benzilonium" -"ChEMBL:1687","tubocurarine" -"ChEMBL:458769","ethopabate" -"ChEMBL:3137343","pembrolizumab" -"ChEMBL:1241","tripelennamine" -"ChEMBL:1201539","insulin pork" -"ChEMBL:1237044","tramadol" -"ChEMBL:1201577","cetuximab" -"ChEMBL:58","mitoxantrone" -"ChEMBL:1428","nimodipine" -"ChEMBL:69998","firocoxib" -"ChEMBL:1441961","sofalcone" -"ChEMBL:1431","metformin" -"ChEMBL:1200945","pentetate calcium trisodium" -"ChEMBL:633","amiodarone" -"ChEMBL:1490300","polystyrene sulfonic acid" -"ChEMBL:1201570","anakinra" -"ChEMBL:1743263","dihydro-.alpha.-ergocryptine" -"ChEMBL:677","levonordefrin" -"ChEMBL:1200608","octinoxate" -"ChEMBL:225072","pemetrexed" -"ChEMBL:1200685","xenon xe-133" -"ChEMBL:1430","penicillamine" -"ChEMBL:92401","iproniazid" -"ChEMBL:2105909","almecillin" -"ChEMBL:989","fluocinolone acetonide" -"ChEMBL:1201863","dexlansoprazole" -"ChEMBL:779","tadalafil" -"ChEMBL:1148","torsemide" -"ChEMBL:1405447","menadiol" -"ChEMBL:1697849","pyrrobutamine" -"ChEMBL:2107192","salcolex" -"ChEMBL:63857","phenolphthalein" -"ChEMBL:1201244","rocuronium" -"ChEMBL:1200","benoxinate" -"ChEMBL:1621","paliperidone" -"ChEMBL:1972224","n-acetyltyrosine" -"ChEMBL:1165","moexipril" -"ChEMBL:403","sulbactam" -"ChEMBL:16699","elliptinium" -"ChEMBL:1539","sulfadoxine" -"ChEMBL:550","pilocarpine" -"ChEMBL:1742982","aflibercept" -"ChEMBL:1000","cetirizine" -"ChEMBL:2108311","asfotase alfa" -"ChEMBL:148","imipenem anhydrous" -"ChEMBL:978","methacholine" -"ChEMBL:1423","pimozide" -"ChEMBL:641","atomoxetine" -"ChEMBL:1201826","idursulfase" -"ChEMBL:967","temazepam" -"ChEMBL:1201605","daclizumab" -"ChEMBL:1201649","estrogens, conjugated" -"ChEMBL:416755","oxolinic acid" -"ChEMBL:579","spiraprilat" -"ChEMBL:1521","zaleplon" -"ChEMBL:853","zalcitabine" -"ChEMBL:43068","valine" -"ChEMBL:1201317","triclofos" -"ChEMBL:2110588","eliglustat" -"ChEMBL:1182210","benzethonium" -"ChEMBL:1008","bepridil" -"ChEMBL:114","saquinavir" -"ChEMBL:509","meclofenamic acid" -"ChEMBL:1289","haloprogin" -"ChEMBL:1197792","bialamicol" -"ChEMBL:1233","carisoprodol" -"ChEMBL:541","benzoic acid" -"ChEMBL:1201274","levobetaxolol" -"ChEMBL:2103875","trametinib" -"ChEMBL:1435","cefazolin" -"ChEMBL:177756","fluorescein" -"ChEMBL:3301934","alphaprodine" -"ChEMBL:171679","aspartame" -"ChEMBL:1237046","rolitetracycline" -"ChEMBL:35","furosemide" -"ChEMBL:1200656","natamycin" -"ChEMBL:178803","blonanserin" -"ChEMBL:716","quetiapine" -"ChEMBL:830","eflornithine" -"ChEMBL:506247","tannic acid" -"ChEMBL:599","meloxicam" -"ChEMBL:1463345","canrenone" -"ChEMBL:2107215","hydroxyphenamate" -"ChEMBL:61006","phenylpropanolamine" -"ChEMBL:1295","butoconazole" -"ChEMBL:1200490","cetrorelix" -"ChEMBL:601","aminolevulinic acid" -"ChEMBL:1201345","tetradecyl hydrogen sulfate (ester)" -"ChEMBL:1482","bethanechol" -"ChEMBL:1201405","moexiprilat" -"ChEMBL:691","ethinyl estradiol" -"ChEMBL:727","thioguanine" -"ChEMBL:2103855","telotristat" -"ChEMBL:191083","methylene blue cation" -"ChEMBL:639","azelastine" -"ChEMBL:2106411","dihydro-.beta.-ergocryptine mesylate" -"ChEMBL:3792763","nonoxynol-9" -"ChEMBL:2104385","carbomycin" -"ChEMBL:1688530","oritavancin" -"ChEMBL:1554","dactinomycin" -"ChEMBL:1725","iopromide" -"ChEMBL:14376","iloperidone" -"ChEMBL:867","iopanoic acid" -"ChEMBL:163","ritonavir" -"ChEMBL:1237","lisinopril anhydrous" -"ChEMBL:1200584","potassium aminosalicylate" -"ChEMBL:2105395","ospemifene" -"ChEMBL:2108611","inotuzumab ozogamicin" -"ChEMBL:1218","ramelteon" -"ChEMBL:315985","eslicarbazepine" -"ChEMBL:1303","rotigotine" -"ChEMBL:111861","cortisone" -"ChEMBL:3544921","cerliponase alfa" -"ChEMBL:115","indinavir" -"ChEMBL:2325741","azd5363" -"ChEMBL:2105722","nomegestrol" -"ChEMBL:2108052","starch, corn" -"ChEMBL:776","metaproterenol" -"ChEMBL:505132","helvolic acid" -"ChEMBL:454","butalbital" -"ChEMBL:22","trimethoprim" -"ChEMBL:582","isopropyl alcohol" -"ChEMBL:2105300","repirinast" -"ChEMBL:1237022","tocilizumab" -"ChEMBL:1200673","xenon xe-127" -"ChEMBL:1201193","levobupivacaine" -"ChEMBL:1200706","aluminum hydroxide" -"ChEMBL:14060","phenol" -"ChEMBL:1093","articaine" -"ChEMBL:1651913","oxyfedrine" -"ChEMBL:1201288","dantrolene" -"ChEMBL:1585","pipobroman" -"ChEMBL:1200515","deserpidine" -"ChEMBL:1214","carbenicillin" -"ChEMBL:429","labetalol" -"ChEMBL:604608","fructose" -"ChEMBL:222863","ouabain" -"ChEMBL:60745","edrophonium" -"ChEMBL:1570","sulfoxone" -"ChEMBL:1164729","febuxostat" -"ChEMBL:1201165","quinestrol" -"ChEMBL:1201185","lanreotide" -"ChEMBL:2108027","dulaglutide" -"ChEMBL:1764","levomepromazine" -"ChEMBL:1201457","cellulose sodium phosphate" -"ChEMBL:1525826","sulfalene" -"ChEMBL:53","apomorphine" -"ChEMBL:2105435","simfibrate" -"ChEMBL:1201388","fludrocortisone" -"ChEMBL:1002","levalbuterol" -"ChEMBL:1581","perindopril" -"ChEMBL:1171837","ponatinib" -"ChEMBL:1626","clemastine" -"ChEMBL:1201754","rufinamide" -"ChEMBL:1201392","flumethasone" -"ChEMBL:1201632","imiglucerase" -"ChEMBL:1200774","fluprednisolone" -"ChEMBL:1474900","olprinone" -"ChEMBL:1618102","butylscopolamine" -"ChEMBL:1726","nisoldipine" -"ChEMBL:1909300","heparin" -"ChEMBL:2096655","cyanocobalamin co-57" -"ChEMBL:285674","estazolam" -"ChEMBL:1200936","penicillin g procaine" -"ChEMBL:1533","desogestrel" -"ChEMBL:537","hydroquinone" -"ChEMBL:585","triamterene" -"ChEMBL:110","benznidazole" -"ChEMBL:1788401","cyclobendazole" -"ChEMBL:833","ticlopidine" -"ChEMBL:841","loperamide" -"ChEMBL:435","hydrochlorothiazide" -"ChEMBL:3301587","durvalumab" -"ChEMBL:1201266","lodoxamide" -"ChEMBL:2105979","amisometradine" -"ChEMBL:2107885","reteplase" -"ChEMBL:1201827","panitumumab" -"ChEMBL:1201636","hyaluronidase" -"ChEMBL:1201204","cefpiramide" -"ChEMBL:1689063","avibactam" -"ChEMBL:1201822","galsulfase" -"ChEMBL:1235535","nicotinyl alcohol" -"ChEMBL:1042","cholecalciferol" -"ChEMBL:1738797","alectinib" -"ChEMBL:52","masoprocol" -"ChEMBL:1502","pantoprazole" -"ChEMBL:239243","taurine" -"ChEMBL:2111014","pentapiperium" -"ChEMBL:2107455","iguratimod" -"ChEMBL:410414","dirlotapide" -"ChEMBL:154","naproxen" -"ChEMBL:1201835","ustekinumab" -"ChEMBL:1743010","elotuzumab" -"ChEMBL:1887666","parathiazine" -"ChEMBL:360328","lorcaserin" -"ChEMBL:1201496","insulin aspart" -"ChEMBL:2141296","ixazomib" -"ChEMBL:1201586","palivizumab" -"ChEMBL:443052","tavaborole" -"ChEMBL:1362","fluoride ion" -"ChEMBL:1106","epinastine" -"ChEMBL:249856","enoximone" -"ChEMBL:1496806","pasiniazid" -"ChEMBL:941","imatinib" -"ChEMBL:1201227","cycrimine" -"ChEMBL:437","sulfathiazole" -"ChEMBL:1256472","cytarabine hydrochloride" -"ChEMBL:12856","inamrinone" -"ChEMBL:51149","gallopamil" -"ChEMBL:22108","dimethindene" -"ChEMBL:829","trimeprazine" -"ChEMBL:806","flutamide" -"ChEMBL:1115","pyridostigmine" -"ChEMBL:273264","nafamostat" -"ChEMBL:502","donepezil" -"ChEMBL:1712170","ethylmorphine" -"ChEMBL:2096654","hemin" -"ChEMBL:1070","nabumetone" -"ChEMBL:679","epinephrine" -"ChEMBL:17423","vesnarinone" -"ChEMBL:98","vorinostat" -"ChEMBL:222813","zanamivir" -"ChEMBL:1751","digoxin" -"ChEMBL:76","chloroquine" -"ChEMBL:1079604","metaxalone" -"ChEMBL:415606","degarelix" -"ChEMBL:3833369","fish oil" -"ChEMBL:956","suprofen" -"ChEMBL:567","perphenazine" -"ChEMBL:414357","exenatide" -"ChEMBL:1742990","belatacept" -"ChEMBL:1566956","troxipide" -"ChEMBL:3039471","dirithromycin" -"ChEMBL:106","fluconazole" -"ChEMBL:1201760","besifloxacin" -"ChEMBL:2108200","dimethicone" -"ChEMBL:468","thalidomide" -"ChEMBL:2105075","floctafenine" -"ChEMBL:1725250","oxapium" -"ChEMBL:570","triflupromazine" -"ChEMBL:1200937","dalfopristin" -"ChEMBL:297362","xylazine" -"ChEMBL:1201340","diphemanil" -"ChEMBL:1237021","lurasidone" -"ChEMBL:1457","hydrocodone" -"ChEMBL:1173055","rucaparib" -"ChEMBL:2105385","phenoperidine" -"ChEMBL:1201206","pipecuronium" -"ChEMBL:42710","eugenol" -"ChEMBL:746","nedocromil" -"ChEMBL:916","tirofiban" -"ChEMBL:1231723","polidocanol" -"ChEMBL:2104381","cyanocobalamin co-58" -"ChEMBL:925","tyrosine" -"ChEMBL:315838","encainide" -"ChEMBL:1540","penciclovir" -"ChEMBL:1488","uracil mustard" -"ChEMBL:1722501","pyrithyldione" -"ChEMBL:844","brimonidine" -"ChEMBL:1293",".beta.-carotene" -"ChEMBL:1760","terbutaline" -"ChEMBL:514800","apremilast" -"ChEMBL:1229211","dolutegravir" -"ChEMBL:842","chlorothiazide" -"ChEMBL:566534","artemether" -"ChEMBL:1189679","palonosetron" -"ChEMBL:1200737","colfosceril palmitate" -"ChEMBL:647","apraclonidine" -"ChEMBL:908","chlorprothixene" -"ChEMBL:2111066","isothipendyl" -"ChEMBL:1100","paramethadione" -"ChEMBL:484785","crisaborole" -"ChEMBL:1200342","paramethasone acetate" -"ChEMBL:290960","nifurtimox" -"ChEMBL:1201313","chlophedianol" -"ChEMBL:531","pergolide" -"ChEMBL:2109038","imciromab pentetate" -"ChEMBL:423","betaxolol" -"ChEMBL:422648","prulifloxacin" -"ChEMBL:404215","pridinol" -"ChEMBL:601773","dihydroergocristine" -"ChEMBL:70972","seratrodast" -"ChEMBL:815","dinoprost" -"ChEMBL:646","triazolam" -"ChEMBL:594","emedastine" -"ChEMBL:160","cyclosporine" -"ChEMBL:1200623","ethylestrenol" -"ChEMBL:1200853","dydrogesterone" -"ChEMBL:2109060","licorice" -"ChEMBL:573","niacin" -"ChEMBL:358150","etofibrate" -"ChEMBL:343633","esatenolol" -"ChEMBL:288441","bosutinib" -"ChEMBL:2111176","valethamate" -"ChEMBL:1201179","lapatinib" -"ChEMBL:15721","nifuroxime" -"ChEMBL:490","paroxetine" -"ChEMBL:930","glutamine" -"ChEMBL:862","guanfacine" -"ChEMBL:500","pindolol" -"ChEMBL:460","molindone" -"ChEMBL:1561","miglitol" -"ChEMBL:1201520","urofollitropin" -"ChEMBL:478120","marbofloxacin" -"ChEMBL:2107857","metreleptin" -"ChEMBL:1201222","lisdexamfetamine" -"ChEMBL:513","carmustine" -"ChEMBL:2366014","tiquizium" -"ChEMBL:1963683","tafluprost" -"ChEMBL:773","glycine" -"ChEMBL:1200761","chlorotrianisene" -"ChEMBL:190","theophylline anhydrous" -"ChEMBL:137","metronidazole" -"ChEMBL:88","cyclophosphamide anhydrous" -"ChEMBL:1418176","methandrostenolone" -"ChEMBL:25202","tamibarotene" -"ChEMBL:42","clozapine" -"ChEMBL:523","nordazepam" -"ChEMBL:90","histamine" -"ChEMBL:221886","sisomicin" -"ChEMBL:47050","penfluridol" -"ChEMBL:1200922","mebutamate" -"ChEMBL:152231","amosulalol" -"ChEMBL:184","acyclovir" -"ChEMBL:918","phenacemide" -"ChEMBL:654","mirtazapine" -"ChEMBL:783","nateglinide" -"ChEMBL:1089221","bendazac" -"ChEMBL:1201480","polytetrafluoroethylene" -"ChEMBL:569","procaine" -"ChEMBL:9225","hexestrol" -"ChEMBL:634","alfentanil" -"ChEMBL:1414320","suxibuzone" -"ChEMBL:1201522","technetium tc-99m albumin aggregated" -"ChEMBL:258918","mesterolone" -"ChEMBL:376140","tigecycline" -"ChEMBL:2159122","eluxadoline" -"ChEMBL:128","sumatriptan" -"ChEMBL:1582","dromostanolone" -"ChEMBL:192","sildenafil" -"ChEMBL:83668","tolnaftate" -"ChEMBL:498","chlorpropamide" -"ChEMBL:1239","benzyl benzoate" -"ChEMBL:1064","simvastatin" -"ChEMBL:1201251","arbutamine" -"ChEMBL:1200866","perflubron" -"ChEMBL:603","zafirlukast" -"ChEMBL:316004","lenperone" -"ChEMBL:56337","epalrestat" -"ChEMBL:2108350","conestat alfa" -"ChEMBL:1233511","fytic acid" -"ChEMBL:1413199","diphenadione" -"ChEMBL:294199","capsaicin" -"ChEMBL:2110700","penthienate" -"ChEMBL:385517","saxagliptin anhydrous" -"ChEMBL:1071","oxaprozin" -"ChEMBL:356479","chlordantoin" -"ChEMBL:87385","zuclopenthixol" -"ChEMBL:2364655","evolocumab" -"ChEMBL:827","dexmethylphenidate" -"ChEMBL:440","thiamylal" -"ChEMBL:1201431","dornase alfa" -"ChEMBL:19","methazolamide" -"ChEMBL:683","clofibric acid" -"ChEMBL:2028663","dabrafenib" -"ChEMBL:1201197","alatrofloxacin" -"ChEMBL:1201355","ceruletide" -"ChEMBL:395110","pecazine" -"ChEMBL:174","ampicillin" -"ChEMBL:267548","protoporphyrin" -"ChEMBL:719","mupirocin" -"ChEMBL:673","pargyline" -"ChEMBL:1201864","dienogest" -"ChEMBL:475903","cp 154526 hydrochloride" -"ChEMBL:1747","tobramycin" -"ChEMBL:1201320","esomeprazole" -"ChEMBL:548","dinoprostone" -"ChEMBL:276832","hydralazine" -"ChEMBL:2365712","dihydroergocornine" -"ChEMBL:1542","azathioprine" -"ChEMBL:1276308","mifepristone" -"ChEMBL:3317857","vaborbactam" -"ChEMBL:1545","tizoxanide" -"ChEMBL:855","triprolidine" -"ChEMBL:16","phenytoin" -"ChEMBL:32838","fumagillin" -"ChEMBL:16694","phenprocoumon" -"ChEMBL:1736151","etafenone" -"ChEMBL:1819440","ornipressin" -"ChEMBL:1467","allopurinol" -"ChEMBL:405","amphetamine" -"ChEMBL:472","glyburide" -"ChEMBL:1200559","lactic acid, dl-" -"ChEMBL:496","hexachlorophene" -"ChEMBL:1201479","polyethylene glycol 3350" -"ChEMBL:1443","nafcillin" -"ChEMBL:1987462","bamethan" -"ChEMBL:168815","cevimeline" -"ChEMBL:1201593","alteplase" -"ChEMBL:607400","brivaracetam" -"ChEMBL:8","ciprofloxacin" -"ChEMBL:1447","lincomycin" -"ChEMBL:186720","phenyltoloxamine" -"ChEMBL:452076","cilnidipine" -"ChEMBL:1201256","trimethobenzamide" -"ChEMBL:564","promazine" -"ChEMBL:1201776","tapentadol" -"ChEMBL:1236970","zinc cation" -"ChEMBL:2304327","colistimethate" -"ChEMBL:1201134","lubiprostone" -"ChEMBL:455706","calusterone" -"ChEMBL:1201220","diatrizoic acid" -"ChEMBL:1744","phendimetrazine" -"ChEMBL:254316","raltegravir" -"ChEMBL:24646","pimobendan" -"ChEMBL:29","penicillin g" -"ChEMBL:1219","rabeprazole" -"ChEMBL:1201027","glycopyrrolate" -"ChEMBL:21731","maprotiline" -"ChEMBL:7413","methohexital" -"ChEMBL:464345","gluconic acid" -"ChEMBL:1623992","piperidolate" -"ChEMBL:1201151","mestranol" -"ChEMBL:1118","desvenlafaxine" -"ChEMBL:1865135","timepidium" -"ChEMBL:2220442","fluvastatin" -"ChEMBL:707","doxazosin" -"ChEMBL:204656","elvitegravir" -"ChEMBL:3343679","iodide ion i-125" -"ChEMBL:556","deferoxamine" -"ChEMBL:1509","drospirenone" -"ChEMBL:1201564","interferon gamma-1b" -"ChEMBL:76370","tegaserod" -"ChEMBL:182","ganciclovir" -"ChEMBL:1652","ambenonium" -"ChEMBL:979","meprobamate" -"ChEMBL:1197","hexylcaine" -"ChEMBL:1450486","thiphenamil" -"ChEMBL:715","olanzapine" -"ChEMBL:1201614","calcitonin human" -"ChEMBL:2063090","grazoprevir anhydrous" -"ChEMBL:461522","dipyrone" -"ChEMBL:11","imipramine" -"ChEMBL:2104816","tybamate" -"ChEMBL:329203","cyclopentamine" -"ChEMBL:1754","doxapram" -"ChEMBL:1200971","cephaloglycin anhydrous" -"ChEMBL:2105897","barium sulfate" -"ChEMBL:1201346","balsalazide" -"ChEMBL:2108709","collagenase clostridium histolyticum" -"ChEMBL:103","progesterone" -"ChEMBL:1623738","thonzylamine" -"ChEMBL:1741","clarithromycin" -"ChEMBL:367149","doconexent" -"ChEMBL:3","nicotine" -"ChEMBL:92161","phenocoll" -"ChEMBL:1374379","benzonatate" -"ChEMBL:338802","sulfaguanidine" -"ChEMBL:1385514","dichlorisone acetate" -"ChEMBL:1201191","levocetirizine" -"ChEMBL:220492","topiramate" -"ChEMBL:1229846","phenoxyethanol" -"ChEMBL:1490","trihexyphenidyl" -"ChEMBL:940","gabapentin" -"ChEMBL:181","diazoxide" -"ChEMBL:2105570","egualen" -"ChEMBL:1873475","ibrutinib" -"ChEMBL:3545336","savolitinib" -"ChEMBL:95889","betaine" -"ChEMBL:1201173","medrysone" -"ChEMBL:550348","deferasirox" -"ChEMBL:1237023","denosumab" -"ChEMBL:2368925","dolasetron" -"ChEMBL:1200570","meglumine" -"ChEMBL:1766","desoximetasone" -"ChEMBL:1201270","methenamine" -"ChEMBL:532","erythromycin" -"ChEMBL:1096","amlexanox" -"ChEMBL:1750","clofarabine" -"ChEMBL:609109","thioproperazine" -"ChEMBL:69308","pelubiprofen" -"ChEMBL:267345","amphotericin b" -"ChEMBL:1276010","undecylenic acid" -"ChEMBL:1380","abacavir" -"ChEMBL:1398373","pirarubicin" -"ChEMBL:1200845","halcinonide" -"ChEMBL:797","phensuximide" -"ChEMBL:3301668","carbetocin" -"ChEMBL:46740","bazedoxifene" -"ChEMBL:2205250","laidlomycin" -"ChEMBL:1577","methyclothiazide" -"ChEMBL:1201334","triptorelin" -"ChEMBL:564829","milciclib" -"ChEMBL:24","atenolol" -"ChEMBL:1411979","methapyrilene" -"ChEMBL:2108677","peginterferon beta-1a" -"ChEMBL:666","foscarnet" -"ChEMBL:575","methicillin" -"ChEMBL:692","glycerin" -"ChEMBL:3039514","elbasvir" -"UniProt:P10912","GHR" -"UniProt:P48048","KCNJ1" -"UniProt:Q02383","SEMG2" -"UniProt:Q15438","CYTH1" -"UniProt:P31266","Rbpj" -"UniProt:Q9EQ14","IL23A" -"UniProt:Q13873","BMPR2" -"UniProt:Q9GZQ4","NMUR2" -"UniProt:Q86UE8","TLK2" -"UniProt:Q8ND56","LSM14A" -"UniProt:Q9QPN3","NEF" -"UniProt:Q6FHJ7","SFRP4" -"UniProt:Q9UHK6","AMACR" -"UniProt:Q6AI12","ANR40" -"UniProt:Q9NY15","STAB1" -"UniProt:Q86YB8","ERO1B" -"UniProt:Q9UQD0","SCN8A" -"UniProt:Q8IXK0","PHC2" -"UniProt:Q17RN3","FAM98C" -"UniProt:Q659C4","LARP1B" -"UniProt:P61218","POLR2F" -"UniProt:Q5SSG8","MUC21" -"UniProt:P62258","YWHAE" -"UniProt:Q96AA8","JKIP2" -"UniProt:Q8N1M1","BEST3" -"UniProt:Q96ER3","SAAL1" -"UniProt:P00431","CCPR" -"UniProt:Q9BWP8","COLEC11" -"UniProt:Q8BGG7","UBS3B" -"UniProt:Q5M8T2","SLC35D3" -"UniProt:O95202","LETM1" -"UniProt:P13984","GTF2F2" -"UniProt:Q9H5V9","CXorf56" -"UniProt:Q7RTS5","OTOP3" -"UniProt:P13746","HLA-A" -"UniProt:H3BS89","TMEM178B" -"UniProt:O15315","RAD51B" -"UniProt:P0DJD3","RBY1A" -"UniProt:Q5QGZ9","CLEC12A" -"UniProt:P40482","SEC24" -"UniProt:P52926","HMGA2" -"UniProt:P40078","NSA2" -"UniProt:P43235","CTSK" -"UniProt:Q9UJW0","DCTN4" -"UniProt:P14079","TAX" -"UniProt:P50616","TOB1" -"UBERON:0002370","thymus" -"UBERON:0004105","subungual region" -"UBERON:0035139","anterior nasal spine of maxilla" -"UBERON:0007798","vascular system" -"UBERON:0001134","skeletal muscle tissue" -"UBERON:0001013","adipose tissue" -"UBERON:0002239","floating rib" -"UBERON:0001000","vas deferens" -"UBERON:0002707","corticospinal tract" -"UBERON:0014542","cervical division of cord spinal central canal" -"UBERON:0001708","jaw skeleton" -"UBERON:0000160","intestine" -"UBERON:0001982","capillary" -"UBERON:0002418","cartilage tissue" -"UBERON:0002228","rib" -"CL:0000518","phagocyte (sensu Vertebrata)" -"UBERON:0004315","distal phalanx of pedal digit 1" -"UBERON:0004388","epiphysis of fibula" -"UBERON:0016422","compact bone of long bone" -"UBERON:0001430","distal carpal bone 1" -"UBERON:0003638","manual digit 4 phalanx" -"UBERON:0001906","subthalamic nucleus" -"UBERON:0002012","pulmonary artery" -"UBERON:0001445","skeleton of pes" -"UBERON:0001199","mucosa of stomach" -"UBERON:0001802","posterior segment of eyeball" -"UBERON:0004614","mammalian cervical vertebra 5" -"UBERON:0004338","proximal phalanx of manual digit 1" -"UBERON:0011277","nail of manual digit 5" -"UBERON:0002217","synovial joint" -"CL:0000835","myeloblast" -"UBERON:0000017","exocrine pancreas" -"UBERON:0004101","nasolabial region" -"UBERON:0002870","dorsal motor nucleus of vagus nerve" -"UBERON:0002515","periosteum" -"UBERON:0002037","cerebellum" -"UBERON:0009568","trunk region of vertebral column" -"UBERON:0002490","frontal suture" -"UBERON:0002046","thyroid gland" -"UBERON:0008196","muscle of pectoral girdle" -"UBERON:0001224","renal pelvis" -"UBERON:0002401","visceral pleura" -"UBERON:0017690","internal surface of frontal bone" -"UBERON:0002101","limb" -"UBERON:0001043","esophagus" -"UBERON:0001275","pubis" -"UBERON:0004601","rib 1" -"UBERON:0002336","corpus callosum" -"UBERON:0011566","lumen of esophagus" -"UBERON:0001045","midgut" -"UBERON:0005200","thoracic mammary gland" -"UBERON:0001535","vertebral artery" -"UBERON:0003865","distal phalanx of manus" -"CL:0000891","foam cell" -"UBERON:0001871","temporal lobe" -"UBERON:0001352","external acoustic meatus" -"UBERON:0004099","joint space of elbow" -"UBERON:0003252","thoracic rib cage" -"UBERON:0016430","palmar branch of median nerve" -"UBERON:0006922","cervix squamous epithelium" -"UBERON:0001771","pupil" -"UBERON:0001777","substantia propria of cornea" -"UBERON:0003128","cranium" -"UBERON:0000016","endocrine pancreas" -"UBERON:0002492","sagittal suture" -"CL:0000738","leukocyte" -"UBERON:0006658","interphalangeal joint" -"UBERON:0004167","orbitofrontal cortex" -"UBERON:0001873","caudate nucleus" -"UBERON:0004014","labium minora" -"UBERON:0001434","skeletal system" -"UBERON:0001516","abdominal aorta" -"UBERON:0003640","pedal digit 1 phalanx" -"UBERON:0001765","mammary duct" -"UBERON:0006865","metaphysis of femur" -"UBERON:0003897","axial muscle" -"UBERON:0000998","seminal vesicle" -"UBERON:0001135","smooth muscle tissue" -"UBERON:0005402","philtrum" -"UBERON:0004337","distal phalanx of manual digit 1" -"UBERON:0002453","ethmoid sinus" -"UBERON:0002369","adrenal gland" -"UBERON:0007156","inferior thyroid vein" -"UBERON:0016459","posterior pole of lens" -"UBERON:0004784","heart ventricle wall" -"UBERON:0002390","hematopoietic system" -"UBERON:0008788","posterior cranial fossa" -"UBERON:0014376","thenar muscle" -"CL:0000625","CD8-positive, alpha-beta T cell" -"UBERON:0001274","ischium" -"UBERON:0001876","amygdala" -"UBERON:0002019","accessory XI nerve" -"UBERON:0006657","glenoid fossa" -"UBERON:0006849","scapula" -"UBERON:0017672","abdominal viscera" -"UBERON:0009972","ureteropelvic junction" -"UBERON:0001049","neural tube" -"UBERON:0000045","ganglion" -"UBERON:0001994","hyaline cartilage tissue" -"UBERON:0004367","Descemet's membrane" -"UBERON:0010222","anatomical line between pupils" -"UBERON:0001951","epithelium of nasopharynx" -"UBERON:0009552","distal segment of manual digit" -"UBERON:0001638","vein" -"UBERON:0008340","nasal bridge" -"UBERON:0001068","skin of back" -"UBERON:0001528","radio-ulnar joint" -"UBERON:0002488","helix" -"UBERON:0001052","rectum" -"UBERON:0001950","neocortex" -"UBERON:0000451","prefrontal cortex" -"UBERON:0002020","gray matter" -"UBERON:0001956","cartilage of bronchus" -"UBERON:0002203","vasculature of eye" -"UBERON:0001088","urine" -"UBERON:0004316","distal phalanx of pedal digit 2" -"UBERON:0003379","cardiac muscle of right atrium" -"UBERON:0000018","compound eye" -"UBERON:0001631","thoracic duct" -"UBERON:0001159","sigmoid colon" -"UBERON:0001621","coronary artery" -"UBERON:0004771","posterior nasal aperture" -"UBERON:0000323","late embryo" -"UBERON:0001423","radius bone" -"UBERON:0009564","distal limb integumentary appendage" -"UBERON:0001350","coccyx" -"UBERON:0006072","cervical region of vertebral column" -"UBERON:0002397","maxilla" -"UBERON:0004086","brain ventricle" -"UBERON:0002030","nipple" -"UBERON:0001835","lower lip" -"UBERON:0002702","middle frontal gyrus" -"UBERON:0001954","Ammon's horn" -"UBERON:0035133","longitudinal arch of pes" -"UBERON:0006558","lymphatic part of lymphoid system" -"UBERON:0001850","lacrimal drainage system" -"UBERON:0014477","thoracic skeleton" -"UBERON:0001367","external anal sphincter" -"UBERON:0004358","caput epididymis" -"UBERON:0002691","ventral tegmental area" -"UBERON:0001431","distal carpal bone 2" -"UBERON:0003703","extrahepatic bile duct" -"UBERON:0010740","bone of appendage girdle complex" -"UBERON:0004816","larynx epithelium" -"UBERON:0001377","quadriceps femoris" -"UBERON:0001383","muscle of leg" -"UBERON:0001826","nasal cavity mucosa" -"UBERON:0014851","chorda tendinea of left ventricle" -"UBERON:0007722","interphalangeal joint of manus" -"UBERON:0004769","diaphysis" -"UBERON:0003650","metatarsal bone of digit 1" -"UBERON:0014693","inferior alveolar artery" -"UBERON:6003624","adult brain" -"UBERON:0003631","pedal digit 1" -"UBERON:0000014","zone of skin" -"UBERON:0002371","bone marrow" -"UBERON:0012352","mesangial matrix" -"UBERON:0016405","pulmonary capillary" -"UBERON:0003642","pedal digit 3 phalanx" -"UBERON:0001874","putamen" -"UBERON:0000947","aorta" -"UBERON:0004811","endometrium epithelium" -"UBERON:0001702","eyelash" -"UBERON:0002099","cardiac septum" -"UBERON:0013540","Brodmann (1909) area 9" -"UBERON:0010171","strand of hair of face" -"UBERON:0007023","adult organism" -"UBERON:0004252","hindlimb stylopod muscle" -"UBERON:0006664","greater palatine artery" -"UBERON:0004384","epiphysis of femur" -"UBERON:0010996","articular cartilage of joint" -"UBERON:0003881","CA1 field of hippocampus" -"UBERON:0011220","mastoid process of temporal bone" -"UBERON:0003649","metacarpal bone of digit 5" -"UBERON:0001132","parathyroid gland" -"UBERON:0001831","parotid gland" -"UBERON:0002471","zeugopod" -"UBERON:0000997","mammalian vulva" -"UBERON:0013541","Brodmann (1909) area 10" -"UBERON:0008962","forelimb bone" -"UBERON:0000922","embryo" -"UBERON:0004089","midface" -"UBERON:0002000","gluteal muscle" -"UBERON:0001870","frontal cortex" -"UBERON:0004412","proximal epiphysis of femur" -"UBERON:0013698","strand of pubic hair" -"UBERON:0004390","epiphysis of metacarpal bone" -"UBERON:0001091","calcareous tooth" -"UBERON:0001225","cortex of kidney" -"CL:0000084","T cell" -"UBERON:0014386","vertebral endplate" -"UBERON:0002483","trabecular bone tissue" -"UBERON:0013699","strand of axillary hair" -"UBERON:0005273","nail bed" -"UBERON:0001439","compact bone tissue" -"UBERON:0001111","intercostal muscle" -"UBERON:0000167","oral cavity" -"UBERON:0002392","nasolacrimal duct" -"UBERON:0002084","heart left ventricle" -"UBERON:0004313","distal phalanx of manual digit 4" -"UBERON:0004480","musculature of limb" -"UBERON:0001450","calcaneus" -"UBERON:0004359","corpus epididymis" -"UBERON:0014892","skeletal muscle organ" -"UBERON:0001707","nasal cavity" -"UBERON:0001280","liver parenchyma" -"UBERON:0002038","substantia nigra" -"UBERON:0019207","chorioretinal region" -"UBERON:0002021","occipital lobe" -"UBERON:0013766","epicanthal fold" -"UBERON:0003653","metatarsal bone of digit 4" -"UBERON:0001448","metatarsal bone" -"UBERON:0000074","renal glomerulus" -"UBERON:0000006","islet of Langerhans" -"UBERON:0001630","muscle organ" -"UBERON:0004819","kidney epithelium" -"UBERON:0004528","alveolar ridge of mandible" -"UBERON:0018552","lateral incisor tooth" -"UBERON:0000363","reticuloendothelial system" -"UBERON:0002372","tonsil" -"UBERON:0001273","ilium" -"UBERON:0001886","choroid plexus" -"UBERON:0000059","large intestine" -"UBERON:0011576","supraorbital ridge" -"UBERON:0003866","middle phalanx of pes" -"UBERON:0012241","male urethral meatus" -"UBERON:0012254","abdominal aorta artery" -"UBERON:0001723","tongue" -"UBERON:0002110","gall bladder" -"UBERON:0000043","tendon" -"UBERON:0002224","thoracic cavity" -"UBERON:0002378","muscle of abdomen" -"UBERON:0000355","pharyngeal mucosa" -"UBERON:0002127","inferior olivary complex" -"UBERON:0001578","orbicularis oculi muscle" -"UBERON:0001649","glossopharyngeal nerve" -"UBERON:0002349","myocardium" -"UBERON:0007371","superior surface of tongue" -"UBERON:0002491","lambdoid suture" -"UBERON:0000102","lung vasculature" -"UBERON:0004797","blood vessel layer" -"UBERON:0001496","ascending aorta" -"UBERON:0001051","hypopharynx" -"UBERON:0001259","mucosa of urinary bladder" -"UBERON:0001783","optic disc" -"UBERON:0001757","pinna" -"UBERON:0009835","anterior cingulate cortex" -"UBERON:0001255","urinary bladder" -"UBERON:0001614","superficial temporal artery" -"UBERON:0004090","periorbital region" -"UBERON:0001365","sacro-iliac joint" -"UBERON:0002245","cerebellar hemisphere" -"UBERON:0001733","soft palate" -"UBERON:0003868","proximal phalanx of pes" -"UBERON:0011677","trunk vertebra" -"UBERON:0003975","internal female genitalia" -"UBERON:0001786","fovea centralis" -"UBERON:0003451","lower jaw incisor" -"UBERON:0002476","lateral globus pallidus" -"UBERON:0002185","bronchus" -"UBERON:0000964","cornea" -"UBERON:0002058","main ciliary ganglion" -"CL:0000097","mast cell" -"UBERON:0001438","metaphysis" -"UBERON:0004801","cervix epithelium" -"UBERON:0002384","connective tissue" -"UBERON:0001819","palpebral fissure" -"UBERON:0000004","nose" -"CL:0000795","CD8-positive, alpha-beta regulatory T cell" -"CL:0000492","CD4-positive helper T cell" -"CL:0000767","basophil" -"CL:0000232","erythrocyte" -"UBERON:0003911","choroid plexus epithelium" -"UBERON:0002347","thoracic vertebra" -"UBERON:0008266","periodontal ligament" -"UBERON:0003654","metatarsal bone of digit 5" -"UBERON:0011931","nasal hair" -"UBERON:0010887","tragus" -"UBERON:0004993","mucosa of sigmoid colon" -"UBERON:0004320","middle phalanx of manual digit 2" -"UBERON:0001495","pectoral muscle" -"UBERON:0002207","xiphoid process" -"UBERON:0001016","nervous system" -"UBERON:0002137","aortic valve" -"CL:0000111","peripheral neuron" -"UBERON:0017716","thenar eminence" -"UBERON:0002795","frontal pole" -"UBERON:0007774","secondary dentition" -"UBERON:0003729","mouth mucosa" -"UBERON:0001760","frontal sinus" -"UBERON:0002242","nucleus pulposus" -"UBERON:0001893","telencephalon" -"UBERON:0003637","manual digit 3 phalanx" -"UBERON:0010708","pectoral complex" -"CL:0000125","glial cell" -"UBERON:0005956","outflow part of left ventricle" -"UBERON:0002293","costochondral joint" -"UBERON:0003864","middle phalanx of manus" -"UBERON:0003862","pedal digit 4 phalanx" -"UBERON:0001235","adrenal cortex" -"UBERON:0007808","adipose tissue of abdominal region" -"UBERON:0002079","left cardiac atrium" -"UBERON:0003672","dentition" -"UBERON:0003700","temporomandibular joint" -"UBERON:0002129","cerebellar cortex" -"UBERON:0000924","ectoderm" -"UBERON:0018254","skeletal musculature" -"UBERON:0001716","secondary palate" -"UBERON:0011156","facial skeleton" -"CL:0000000","cell type" -"UBERON:0016476","primary incisor tooth" -"UBERON:0002134","tricuspid valve" -"CL:0000576","monocyte" -"UBERON:0016413","medullary cavity of long bone" -"UBERON:0010260","umbilical blood vessel" -"UBERON:0014543","lumbar division of spinal cord central canal" -"UBERON:0009198","craniofacial suture" -"UBERON:0009773","renal tubule" -"UBERON:0001728","nasopharynx" -"UBERON:0001985","corneal endothelium" -"UBERON:0004314","distal phalanx of manual digit 5" -"UBERON:0001153","caecum" -"UBERON:0018405","inferior alveolar nerve" -"UBERON:0005366","olfactory lobe" -"UBERON:0003652","metatarsal bone of digit 3" -"UBERON:0002374","metacarpal bone" -"UBERON:0017670","bony part of cervical vertebral arch" -"UBERON:0001012","head of radius" -"UBERON:0001897","dorsal plus ventral thalamus" -"UBERON:0000981","femur" -"UBERON:0012074","bony part of hard palate" -"UBERON:0002501","oval window" -"UBERON:0000989","penis" -"UBERON:0011876","body of tongue" -"UBERON:0004339","vault of skull" -"UBERON:0002411","clitoris" -"UBERON:0003706","laryngeal vocal fold" -"UBERON:0002395","talus" -"UBERON:0035550","superficial vein" -"UBERON:0001988","feces" -"UBERON:0002264","olfactory bulb" -"UBERON:0014411","greater sciatic notch" -"UBERON:0001264","pancreas" -"UBERON:0002106","spleen" -"UBERON:0000979","tibia" -"UBERON:0000475","organism subdivision" -"UBERON:0004714","septum pellucidum" -"UBERON:0004410","distal epiphysis of fibula" -"UBERON:0004611","rib 12" -"UBERON:0006767","head of femur" -"UBERON:0011859","internal acoustic meatus" -"UBERON:0011273","nail of manual digit 1" -"UBERON:0001021","nerve" -"UBERON:0004360","cauda epididymis" -"UBERON:0009768","distal interphalangeal joint" -"UBERON:0004535","cardiovascular system" -"UBERON:0001987","placenta" -"UBERON:0003635","pedal digit 5" -"UBERON:0003685","cranial suture" -"UBERON:0014437","iliac crest" -"UBERON:0002389","manual digit" -"CL:0000235","macrophage" -"UBERON:0000990","reproductive system" -"UBERON:0006074","lumbar region of vertebral column" -"UBERON:0001713","lower eyelid" -"UBERON:0002489","coronal suture" -"UBERON:0001112","latissimus dorsi muscle" -"UBERON:0001882","nucleus accumbens" -"UBERON:0010163","eyebrow" -"UBERON:0001435","carpal bone" -"UBERON:0001359","cerebrospinal fluid" -"UBERON:0001905","pineal body" -"UBERON:0003646","metacarpal bone of digit 2" -"UBERON:0001908","optic tract" -"UBERON:0000159","anal canal" -"UBERON:0003863","pedal digit 5 phalanx" -"UBERON:0001004","respiratory system" -"UBERON:0003622","manual digit 2" -"UBERON:0003645","metacarpal bone of digit 1" -"UBERON:0004096","odontoid process of cervical vertebra 2" -"UBERON:0003839","forelimb joint" -"UBERON:0001285","nephron" -"UBERON:0002198","neurohypophysis" -"UBERON:0002387","pes" -"UBERON:0000317","colonic mucosa" -"UBERON:0002016","pulmonary vein" -"UBERON:0001684","mandible" -"UBERON:0011282","nail of pedal digit 5" -"CL:0000094","granulocyte" -"UBERON:0004904","neuron projection bundle connecting eye with brain" -"UBERON:0003641","pedal digit 2 phalanx" -"UBERON:0000974","neck" -"UBERON:0010709","pelvic complex" -"UBERON:0001875","globus pallidus" -"UBERON:0010743","meningeal cluster" -"UBERON:0000916","abdomen" -"UBERON:0001173","biliary tree" -"UBERON:0004548","left eye" -"UBERON:0009973","ureterovesical junction" -"UBERON:0002244","premaxilla" -"UBERON:0010890","pelvic complex muscle" -"UBERON:0009834","dorsolateral prefrontal cortex" -"UBERON:0000996","vagina" -"UBERON:0002500","zygomatic arch" -"UBERON:0001734","palatine uvula" -"UBERON:0002018","synovial membrane of synovial joint" -"UBERON:0002094","interventricular septum" -"CL:0002319","neural cell" -"UBERON:0010707","appendage girdle complex" -"UBERON:0002771","middle temporal gyrus" -"UBERON:0004571","systemic arterial system" -"UBERON:0001490","elbow joint" -"UBERON:0000992","female gonad" -"UBERON:0004864","vasculature of retina" -"UBERON:0003651","metatarsal bone of digit 2" -"UBERON:0010418","urethral opening" -"UBERON:0001769","iris" -"UBERON:0001676","occipital bone" -"UBERON:0006333","snout" -"UBERON:0011110","humeroulnar joint" -"UBERON:0004118","vasculature of iris" -"UBERON:0000995","uterus" -"UBERON:0004489","musculature of manus" -"UBERON:0010230","eyeball of camera-type eye" -"UBERON:0002114","duodenum" -"UBERON:0003648","metacarpal bone of digit 4" -"UBERON:0001027","sensory nerve" -"UBERON:0004471","musculature of pectoral girdle" -"UBERON:0004317","distal phalanx of pedal digit 3" -"UBERON:0011111","humeroradial joint" -"UBERON:0001697","orbit of skull" -"UBERON:0001508","arch of aorta" -"UBERON:0002005","enteric nervous system" -"UBERON:0013554","Brodmann (1909) area 23" -"UBERON:0001965","substantia nigra pars compacta" -"UBERON:0004454","tarsal region" -"UBERON:0007830","pelvic girdle bone/zone" -"CL:0000771","eosinophil" -"UBERON:0000945","stomach" -"UBERON:0005409","alimentary part of gastrointestinal system" -"UBERON:0004473","musculature of face" -"UBERON:0000165","mouth" -"UBERON:0003721","lingual nerve" -"UBERON:0000991","gonad" -"UBERON:0000081","metanephros" -"UBERON:0002465","lymphoid system" -"UBERON:0003723","vestibular nerve" -"UBERON:0001348","brown adipose tissue" -"UBERON:0006919","tongue squamous epithelium" -"UBERON:0003714","neural tissue" -"UBERON:0000029","lymph node" -"UBERON:0002285","telencephalic ventricle" -"UBERON:0003647","metacarpal bone of digit 3" -"UBERON:0000082","adult mammalian kidney" -"UBERON:0000012","somatic nervous system" -"UBERON:0001847","lobule of pinna" -"UBERON:0001213","intestinal villus" -"UBERON:0004785","respiratory system mucosa" -"UBERON:0000970","eye" -"UBERON:0003450","upper jaw incisor" -"UBERON:0004681","vestibular system" -"UBERON:0000948","heart" -"UBERON:0007723","interphalangeal joint of manual digit 1" -"UBERON:0008949","lower lobe of lung" -"UBERON:0000019","camera-type eye" -"UBERON:0004085","labium majora" -"UBERON:0000966","retina" -"UBERON:0002356","perineum" -"UBERON:0009132","peroneus" -"UBERON:0000955","brain" -"UBERON:0003867","distal phalanx of pes" -"UBERON:0007116","primary dentition" -"CL:0000542","lymphocyte" -"UBERON:0001473","lymphatic vessel" -"UBERON:0001437","epiphysis" -"UBERON:0016525","frontal lobe" -"UBERON:0006914","squamous epithelium" -"UBERON:0003695","metacarpophalangeal joint" -"UBERON:0001775","ciliary body" -"UBERON:0001890","forebrain" -"UBERON:0001732","pharyngeal tonsil" -"UBERON:0000007","pituitary gland" -"UBERON:0018551","central incisor tooth" -"UBERON:0009567","nail of pedal digit" -"UBERON:0002407","pericardium" -"UBERON:0003633","pedal digit 3" -"UBERON:0001686","auditory ossicle bone" -"UBERON:0008948","upper lobe of lung" -"UBERON:0002107","liver" -"UBERON:0001586","internal jugular vein" -"UBERON:0004362","pharyngeal arch 1" -"UBERON:0003704","intrahepatic bile duct" -"UBERON:0003655","molar tooth" -"UBERON:0001637","artery" -"UBERON:0002504","lesser trochanter" -"UBERON:0001464","hip" -"UBERON:0002385","muscle tissue" -"UBERON:0002589","lateral corticospinal tract" -"UBERON:0001705","nail" -"UBERON:0002097","skin of body" -"UBERON:0004092","hypothalamus-pituitary axis" -"UBERON:0014852","chorda tendinea of right ventricle" -"CL:0002079","pancreatic ductal cell" -"CL:0008002","skeletal muscle fiber" -"UBERON:0004249","manual digit bone" -"UBERON:0006863","proximal metaphysis of femur" -"UBERON:0005236","osseus labyrinth vestibule" -"UBERON:0001456","face" -"UBERON:0005448","greater omentum" -"UBERON:0010365","odontoid tissue" -"UBERON:0002420","basal ganglion" -"UBERON:0001463","manual digit 1" -"UBERON:0001824","mucose of larynx" -"UBERON:0003512","lung blood vessel" -"UBERON:0001166","pylorus" -"UBERON:0001015","musculature" -"UBERON:0001388","gastrocnemius" -"UBERON:0000044","dorsal root ganglion" -"UBERON:0019254","upper eyelash" -"UBERON:0002196","adenohypophysis" -"UBERON:0005056","external female genitalia" -"UBERON:0001424","ulna" -"UBERON:0008856","stomach muscularis externa" -"CL:0000188","cell of skeletal muscle" -"UBERON:0002095","mesentery" -"UBERON:0000468","multicellular organism" -"UBERON:0001174","common bile duct" -"UBERON:0002074","hair shaft" -"UBERON:0001443","chest" -"UBERON:0002113","kidney" -"UBERON:0001236","adrenal medulla" -"UBERON:0001155","colon" -"UBERON:0002358","peritoneum" -"UBERON:0002333","pulmonary trunk" -"UBERON:0002363","dura mater" -"UBERON:0000178","blood" -"UBERON:0003822","forelimb stylopod" -"UBERON:0011648","jaw muscle" -"UBERON:0001891","midbrain" -"UBERON:0010746","iliac blade" -"UBERON:0000033","head" -"UBERON:0002736","lateral nuclear group of thalamus" -"UBERON:0013678","anatomical line between inner canthi" -"UBERON:0010952","frontalis muscle belly" -"UBERON:0011143","upper urinary tract" -"UBERON:0013750","metaphysis of tibia" -"CL:0002198","oncocyte" -"UBERON:0004481","musculature of upper limb" -"UBERON:0000976","humerus" -"UBERON:0007119","neck of femur" -"UBERON:0011973","epiphysis of phalanx of pes" -"UBERON:0000010","peripheral nervous system" -"UBERON:0001017","central nervous system" -"UBERON:0002412","vertebra" -"UBERON:0002298","brainstem" -"UBERON:0000310","breast" -"UBERON:0004511","skeletal muscle tissue of rectus abdominis" -"UBERON:0012240","urethral meatus" -"UBERON:0004572","arterial system" -"UBERON:0004657","mandible condylar process" -"UBERON:0001737","larynx" -"UBERON:0004727","cochlear nerve" -"UBERON:0003823","hindlimb zeugopod" -"CL:0000218","myelinating Schwann cell" -"UBERON:0001896","medulla oblongata" -"UBERON:0002381","pectoralis major" -"UBERON:0011818","superficial fascia" -"UBERON:0001143","hepatic vein" -"UBERON:0002236","costal cartilage" -"UBERON:0001773","sclera" -"UBERON:0003502","neck blood vessel" -"UBERON:0016426","proximal interphalangeal joint of little finger" -"UBERON:0007709","superior cerebellar peduncle of pons" -"UBERON:0004263","upper arm skin" -"UBERON:0003496","head blood vessel" -"UBERON:0003632","pedal digit 2" -"UBERON:0001681","nasal bone" -"UBERON:0003701","calcaneal tendon" -"UBERON:0001507","biceps brachii" -"CL:0000842","mononuclear cell" -"UBERON:0002331","umbilical cord" -"UBERON:0002234","proximal phalanx of manus" -"UBERON:0006956","buccal mucosa" -"UBERON:0007318","saphenous vein" -"UBERON:0001269","acetabular part of hip bone" -"UBERON:0004449","cerebral artery" -"UBERON:0003407","cartilage of nasal septum" -"UBERON:0003625","manual digit 5" -"UBERON:0001706","nasal septum" -"UBERON:0016466","antihelix" -"CL:0000015","male germ cell" -"UBERON:0003699","pubic symphysis" -"UBERON:0004476","musculature of shoulder" -"UBERON:0000057","urethra" -"UBERON:0019255","lower eyelash" -"UBERON:0010946","occipitofrontalis muscle" -"UBERON:0002190","subcutaneous adipose tissue" -"CL:0000236","B cell" -"UBERON:0000982","skeletal joint" -"UBERON:0013683","left dorsal thalamus" -"UBERON:0002103","hindlimb" -"UBERON:0006689","frenulum of tongue" -"UBERON:0001304","germinal epithelium of ovary" -"UBERON:0002108","small intestine" -"UBERON:0005440","ductus arteriosus" -"UBERON:0008188","tendon of biceps brachii" -"UBERON:0009565","nail of manual digit" -"UBERON:0001577","facial muscle" -"UBERON:0001474","bone element" -"UBERON:0003129","skull" -"UBERON:0002221","fontanelle" -"UBERON:0013777","skin of palm of manus" -"UBERON:0001042","chordate pharynx" -"UBERON:0014445","acetabular fossa" -"UBERON:0002265","olfactory tract" -"UBERON:0003244","epithelium of mammary gland" -"UBERON:0003604","trachea cartilage" -"UBERON:0002377","muscle of neck" -"UBERON:0004106","crus of ear" -"UBERON:0001691","external ear" -"UBERON:0001772","corneal epithelium" -"UBERON:0016442","median palatine suture" -"UBERON:0016416","anterior chest" -"UBERON:0001823","nasal cartilage" -"UBERON:0001605","ciliary muscle" -"UBERON:0002081","cardiac atrium" -"UBERON:0005030","mucosa of paranasal sinus" -"UBERON:0001867","cartilage of external ear" -"UBERON:0001814","brachial nerve plexus" -"UBERON:0006920","esophagus squamous epithelium" -"UBERON:0009680","set of upper jaw teeth" -"UBERON:0001497","muscle of pelvic girdle" -"UBERON:0002080","heart right ventricle" -"UBERON:0001532","internal carotid artery" -"UBERON:0001003","skin epidermis" -"UBERON:0003674","cuspid" -"UBERON:0000056","ureter" -"UBERON:0003697","abdominal wall" -"UBERON:0002400","parietal pleura" -"CL:0000775","neutrophil" -"UBERON:0001154","vermiform appendix" -"UBERON:0001601","extra-ocular muscle" -"UBERON:0001379","vastus lateralis" -"UBERON:0009767","proximal interphalangeal joint" -"UBERON:0000935","anterior commissure" -"UBERON:0002078","right cardiac atrium" -"UBERON:0007616","layer of synovial tissue" -"UBERON:0004319","distal phalanx of pedal digit 5" -"UBERON:0004288","skeleton" -"UBERON:0001809","enteric ganglion" -"UBERON:0001105","clavicle bone" -"UBERON:0002289","midbrain cerebral aqueduct" -"UBERON:0006683","posterior fontanelle" -"UBERON:0008878","palmar part of manus" -"UBERON:0004660","mandible coronoid process" -"UBERON:0010414","omental fat pad" -"UBERON:0002027","stratum corneum of epidermis" -"UBERON:0002435","striatum" -"UBERON:0001287","proximal convoluted tubule" -"UBERON:0004467","musculature of pharynx" -"UBERON:0004804","oviduct epithelium" -"UBERON:0016462","periorbital skin" -"UBERON:0002728","entorhinal cortex" -"UBERON:0001834","upper lip" -"UBERON:0001817","lacrimal gland" -"UBERON:0003951","ocular fundus" -"UBERON:0007250","lingual tonsil" -"UBERON:0004711","jugular vein" -"UBERON:0001447","tarsal bone" -"UBERON:0002135","mitral valve" -"UBERON:0001785","cranial nerve" -"UBERON:0002413","cervical vertebra" -"UBERON:0001515","thoracic aorta" -"UBERON:0002345","descending thoracic aorta" -"UBERON:0002082","cardiac ventricle" -"UBERON:0002567","basal part of pons" -"UBERON:0001449","phalanx of pes" -"UBERON:0001825","paranasal sinus" -"UBERON:0002073","hair follicle" -"UBERON:0000988","pons" -"CL:0000558","reticulocyte" -"UBERON:0001509","triceps brachii" -"CL:0000623","natural killer cell" -"UBERON:0018226","pulmonary part of lymphatic system" -"UBERON:0001465","knee" -"UBERON:0001098","incisor tooth" -"UBERON:0001165","pyloric antrum" -"UBERON:0004482","musculature of lower limb" -"UBERON:0001442","skeleton of manus" -"UBERON:0000362","renal medulla" -"UBERON:0005969","eye trabecular meshwork" -"UBERON:0003889","fallopian tube" -"UBERON:0000956","cerebral cortex" -"UBERON:0003623","manual digit 3" -"UBERON:0006566","left ventricle myocardium" -"UBERON:0002742","lamina of septum pellucidum" -"UBERON:0001846","internal ear" -"UBERON:0001044","saliva-secreting gland" -"UBERON:0001976","epithelium of esophagus" -"UBERON:0000977","pleura" -"UBERON:0001301","epididymis" -"UBERON:0004407","distal epiphysis of radius" -"UBERON:0005620","primary palate" -"UBERON:0002031","epithelium of bronchus" -"UBERON:0001894","diencephalon" -"UBERON:0004406","distal epiphysis of femur" -"UBERON:0002352","atrioventricular node" -"UBERON:0008833","great auricular nerve" -"UBERON:0001820","sweat gland" -"UBERON:0008200","forehead" -"UBERON:0000965","lens of camera-type eye" -"UBERON:0002410","autonomic nervous system" -"UBERON:0000941","cranial nerve II" -"UBERON:0000401","mandibular ramus" -"UBERON:0002402","pleural cavity" -"UBERON:0001640","celiac artery" -"UBERON:0003292","meninx of spinal cord" -"CL:0000023","oocyte" -"UBERON:0003636","manual digit 2 phalanx" -"UBERON:0002343","abdomen musculature" -"UBERON:0001567","cheek" -"UBERON:0003466","forelimb zeugopod bone" -"UBERON:0003690","fused sacrum" -"UBERON:0002132","dentate nucleus" -"UBERON:0000388","epiglottis" -"UBERON:0010425","internal naris" -"UBERON:0006533","rectus extraocular muscle" -"UBERON:0002291","central canal of spinal cord" -"CL:0002336","buccal mucosa cell" -"UBERON:0003126","trachea" -"CL:0000083","epithelial cell of pancreas" -"UBERON:0006003","integumentary adnexa" -"UBERON:0001782","pigmented layer of retina" -"UBERON:0000975","sternum" -"UBERON:0000467","anatomical system" -"UBERON:0002240","spinal cord" -"UBERON:0001647","facial nerve" -"UBERON:0002510","anterior fontanel" -"CL:0000169","type B pancreatic cell" -"UBERON:0005351","paraflocculus" -"UBERON:0001461","elbow" -"UBERON:0005928","external naris" -"UBERON:0001125","serratus ventralis" -"CL:0002092","bone marrow cell" -"UBERON:0013748","ulnar metaphysis" -"UBERON:0004646","infraorbital artery" -"UBERON:0000053","macula lutea" -"UBERON:0001427","radiale" -"UBERON:0001295","endometrium" -"UBERON:0001062","anatomical entity" -"UBERON:0002367","prostate gland" -"UBERON:0010747","body of ilium" -"UBERON:0016446","hair of head" -"UBERON:0001604","levator palpebrae superioris" -"CL:0000912","helper T cell" -"UBERON:0004465","musculature of neck" -"UBERON:0002477","medial globus pallidus" -"CL:0011001","spinal cord motor neuron" -"CL:0000128","oligodendrocyte" -"UBERON:0002146","pulmonary valve" -"UBERON:0006059","falx cerebri" -"UBERON:0002398","manus" -"UBERON:0002355","pelvic region of trunk" -"UBERON:0002414","lumbar vertebra" -"UBERON:0002100","trunk" -"UBERON:0002048","lung" -"UBERON:0000933","pharyngeal muscle" -"UBERON:0004382","epiphysis of humerus" -"UBERON:0002517","basicranium" -"UBERON:0006073","thoracic region of vertebral column" -"UBERON:0004452","carpal region" -"UBERON:0001949","gingival epithelium" -"UBERON:0001245","anus" -"UBERON:0003687","foramen magnum" -"CL:0002328","bronchial epithelial cell" -"UBERON:0013771","line connecting laterally paired nipples" -"CL:0000655","secondary oocyte" -"UBERON:0001162","cardia of stomach" -"UBERON:0003027","cingulate cortex" -"UBERON:0001486","hip joint" -"UBERON:0001296","myometrium" -"UBERON:0001756","middle ear" -"UBERON:0016412","central part of body of bony vertebral centrum" -"UBERON:0001690","ear" -"UBERON:0001385","tibialis anterior" -"UBERON:0001619","ophthalmic artery" -"UBERON:0000002","uterine cervix" -"UBERON:0001466","pedal digit" -"UBERON:0007844","cartilage element" -"UBERON:0004312","distal phalanx of manual digit 3" -"UBERON:0004087","vena cava" -"UBERON:0001476","deltoid" -"UBERON:0005384","nasal cavity epithelium" -"UBERON:0004387","epiphysis of phalanx of manus" -"UBERON:0001776","optic choroid" -"UBERON:0001075","bony vertebral centrum" -"UBERON:0002116","ileum" -"UBERON:0000473","testis" -"UBERON:0002446","patella" -"UBERON:0001620","central retinal artery" -"UBERON:0002394","bile duct" -"UBERON:0002495","long bone" -"UBERON:0001485","knee joint" -"UBERON:0002988","first dorsal interosseous of manus" -"UBERON:0017717","hypothenar eminence" -"UBERON:0007118","umbilicus" -"UBERON:0001300","scrotum" -"UBERON:0001764","maxillary sinus" -"UBERON:0003101","male organism" -"UBERON:0001645","trigeminal nerve" -"UBERON:0000407","sympathetic trunk" -"UBERON:0000399","jejunal mucosa" -"CL:0000019","sperm" -"UBERON:0018408","infra-orbital nerve" -"UBERON:0004736","metanephric glomerulus" -"UBERON:0001160","fundus of stomach" -"UBERON:0000331","ileal mucosa" -"UBERON:0008341","columella nasi" -"UBERON:0010166","coat of hair" -"UBERON:0019246","palmar skin crease" -"UBERON:0004318","distal phalanx of pedal digit 4" -"UBERON:0001898","hypothalamus" -"UBERON:0007106","chorionic villus" -"UBERON:0001766","anterior chamber of eyeball" -"UBERON:0007227","superior vestibular nucleus" -"UBERON:0004395","epiphysis of first metatarsal bone" -"UBERON:0002405","immune system" -"UBERON:0001446","fibula" -"CL:0000233","platelet" -"UBERON:0001130","vertebral column" -"UBERON:0001844","cochlea" -"UBERON:0000479","tissue" -"UBERON:0001231","nephron tubule" -"UBERON:0001467","shoulder" -"UBERON:0005438","coronary sinus" -"UBERON:0002450","decidua" -"UBERON:0004385","epiphysis of radius" -"UBERON:0003624","manual digit 4" -"UBERON:0001828","gingiva" -"UBERON:0006483","Brodmann (1909) area 46" -"UBERON:0007721","interphalangeal joint of pes" -"UBERON:0002085","interatrial septum" -"UBERON:0001675","trigeminal ganglion" -"UBERON:0002581","postcentral gyrus" -"UBERON:0001066","intervertebral disk" -"UBERON:0005363","inferior vagus X ganglion" -"UBERON:0008338","plantar part of pes" -"UBERON:0001724","sphenoidal sinus" -"UBERON:0001812","palpebral conjunctiva" -"UBERON:0001502","interosseous muscle of manus" -"UBERON:0002017","portal vein" -"UBERON:0002436","primary visual cortex" -"UBERON:0004277","eye muscle" -"UBERON:0017671","bony part of vertebral arch of first sacral vertebra" -"UBERON:0001840","semicircular canal" -"UBERON:0001436","phalanx of manus" -"UBERON:0003221","phalanx" -"CL:0000100","motor neuron" -"UBERON:0008772","proximal epiphysis of tibia" -"CL:0000038","erythroid progenitor cell" -"CL:0000764","erythroid lineage cell" -"UBERON:0001663","cerebral vein" -"UBERON:0010358","arch of centrum of vertebra" -"UBERON:0001872","parietal lobe" -"UBERON:0007120","premolar tooth" -"UBERON:0002544","digit" -"UBERON:0008775","proximal epiphysis of fibula" -"UBERON:0014398","respiratory muscle" -"UBERON:0004103","alveolar ridge" -"UBERON:0001556","lower urinary tract" -"UBERON:0001646","abducens nerve" -"UBERON:0003100","female organism" -"UBERON:0001683","jugal bone" -"UBERON:0002270","hyaloid artery" -"UBERON:0000403","scalp" -"UBERON:0001184","renal artery" -"UBERON:0001653","facial vein" -"UBERON:0010172","bulb of aorta" -"UBERON:0001103","diaphragm" -"UBERON:0001752","enamel" -"UBERON:0002360","meninx" -"CL:0000115","endothelial cell" -"UBERON:0000369","corpus striatum" -"UBERON:0004311","distal phalanx of manual digit 2" -"UBERON:0001966","substantia nigra pars reticulata" -"UBERON:0004720","cerebellar vermis" -"UBERON:0000474","female reproductive system" -"UBERON:0001981","blood vessel" -"UBERON:0000173","amniotic fluid" -"UBERON:0003216","hard palate" -"UBERON:0034908","scapular muscle" -"UBERON:0001712","upper eyelid" -"UBERON:0002470","autopod region" -"CL:0000178","Leydig cell" -"UBERON:0004084","genital labium" -"UBERON:0003634","pedal digit 4" -"UBERON:0010262","operculum of brain" -"UBERON:0002115","jejunum" -"UBERON:0001648","vestibulocochlear nerve" -"UBERON:0005467","platysma" -"UBERON:0001711","eyelid" -"UBERON:0002661","superior frontal gyrus" -"UBERON:0001833","lip" -"UBERON:0003606","limb long bone" -"UBERON:0007750","metatarsophalangeal joint of pedal digit 1" -"UBERON:0002362","arachnoid mater" -"UBERON:0007277","presumptive hindbrain" -"UBERON:0003639","manual digit 5 phalanx" -"UBERON:0012128","nose tip" -"UBERON:0002437","cerebral hemisphere white matter" -"UBERON:0001911","mammary gland" -"UBERON:0003620","manual digit 1 phalanx" -"UBERON:0001779","iris stroma" -"UBERON:0001037","strand of hair" -"UBERON:0008199","chin" -"UBERON:0004323","middle phalanx of manual digit 5" -"ChEMBL:25146","amfenac" -"ChEMBL:1200799","travoprost" -"ChEMBL:831","loxapine" -"ChEMBL:3187365","asenapine" -"ChEMBL:1697737","clotiazepam" -"ChEMBL:1286","levetiracetam" -"ChEMBL:493682","denopamine" -"ChEMBL:439849","vilazodone" -"ChEMBL:237500","linagliptin" -"ChEMBL:642","acebutolol" -"ChEMBL:469","ketorolac" -"ChEMBL:129","zidovudine" -"ChEMBL:1201837","ecallantide" -"ChEMBL:1007","gonadorelin" -"ChEMBL:1572","netilmicin" -"ChEMBL:55400","proflavine" -"ChEMBL:817","tolazamide" -"ChEMBL:583","grepafloxacin" -"ChEMBL:1575","estramustine" -"ChEMBL:2103749","bivalirudin" -"ChEMBL:1024","ifosfamide" -"ChEMBL:1201833","golimumab" -"ChEMBL:83906","iodoalphionic acid" -"ChEMBL:3545110","ribociclib" -"ChEMBL:455917","chloral hydrate" -"ChEMBL:549473","dipyrithione" -"ChEMBL:1743068","secukinumab" -"ChEMBL:1200558","bacitracin" -"ChEMBL:1200338","pinacidil anhydrous" -"ChEMBL:105","mitomycin" -"ChEMBL:22097","lormetazepam" -"ChEMBL:426926","arbekacin" -"ChEMBL:46","ondansetron" -"ChEMBL:1752","dyphylline" -"ChEMBL:1201195","cefmetazole" -"ChEMBL:761","naphazoline" -"ChEMBL:1738","dexrazoxane" -"ChEMBL:2107516","budralazine" -"ChEMBL:1054","trichlormethiazide" -"ChEMBL:141","lamivudine" -"ChEMBL:1043","dapsone" -"ChEMBL:597","phentolamine" -"ChEMBL:191","losartan" -"ChEMBL:70418","clobazam" -"ChEMBL:117785","tetrabenazine" -"ChEMBL:97137","robenidine" -"ChEMBL:286452","alfatradiol" -"ChEMBL:778","dexmedetomidine" -"ChEMBL:589586","monomethyl fumarate" -"ChEMBL:1201147","octocrylene" -"ChEMBL:1771","clopidogrel" -"ChEMBL:432103","pirmenol" -"ChEMBL:2104895","setiptiline" -"ChEMBL:384467","dexamethasone" -"ChEMBL:32","moxifloxacin" -"ChEMBL:1201404","mometasone" -"ChEMBL:1131","acitretin" -"ChEMBL:245807","oxyphenisatin" -"ChEMBL:2108730","sarilumab" -"ChEMBL:1471","aprepitant" -"ChEMBL:2110774","chlorphenoxamine" -"ChEMBL:1405","estrone" -"UniProt:Q9NQ89","C12orf4" -"UniProt:Q9Y320","TMX2" -"UniProt:Q5T084","AMY1B" -"UniProt:Q8N1I0","DOCK4" -"UniProt:Q9H2B2","SYT4" -"UniProt:O60840","CACNA1F" -"UniProt:O75355","ENTPD3" -"UniProt:Q12439","YO21A" -"UniProt:Q9BXD5","NPL" -"UniProt:Q9BSJ8","ESYT1" -"UniProt:Q9UJP4","KLHL21" -"UniProt:Q62696","DLG1" -"UniProt:Q9HC77","CENPJ" -"UniProt:P47884","OR1D4" -"UniProt:O40931","O40931" -"UniProt:Q9H0Q3","FXYD6" -"UniProt:Q92832","NELL1" -"UniProt:Q9BPW5","RASL11B" -"UniProt:P34931","HS71L" -"UniProt:P82930","MRPS34" -"UniProt:P46952","HAAO" -"UniProt:P14781","CNTN1" -"UniProt:P38736","GOSR1" -"UniProt:P12945","NAT1" -"UniProt:Q96BK5","PINX1" -"UniProt:Q29940","HLA-B" -"UniProt:Q24JP5","TMEM132A" -"UniProt:P29083","GTF2E1" -"UniProt:Q9HB20","PLEKHA3" -"UniProt:O95210","STBD1" -"UniProt:Q9P281","BAHCC1" -"UniProt:P62068","USP46" -"UniProt:P08238","HS90B" -"UniProt:Q0D2H9","GOG8D" -"UniProt:Q2TAC6","KIF19" -"UniProt:Q3SY05","LINC00303" -"UniProt:Q9NPI9","KCNJ16" -"UniProt:Q86W42","THOC6" -"UniProt:Q9NUQ2","PLCE" -"UniProt:Q5TC12","ATPAF1" -"UniProt:Q9Y375","NDUFAF1" -"UniProt:Q5SZK8","FREM2" -"UniProt:Q9BTE3","MCMBP" -"UniProt:A6NLP5","TTC36" -"UniProt:Q92982","NINJ1" -"UniProt:P16112","ACAN" -"UniProt:P55197","MLLT10" -"UniProt:O75154","RAB11FIP3" -"UniProt:Q9P215","POGK" -"UniProt:Q8N0V1","ZNAS1" -"UniProt:Q9Y3R0","GRIP1" -"UniProt:Q5JU00","TCTE1" -"UniProt:P32942","ICAM3" -"UniProt:O00339","MATN2" -"UniProt:Q8NFZ5","TNIP2" -"UniProt:Q9NQA5","TRPV5" -"UniProt:A6NDB9","PALM3" -"UniProt:O15014","ZNF609" -"UniProt:P57087","JAM2" -"UniProt:Q96NA2","RILP" -"UniProt:Q61140","Bcar1" -"UniProt:O75095","MEGF6" -"UniProt:Q9H1J7","WNT5B" -"UniProt:A0A1B0GTW0","A0A1B0GTW0" -"UniProt:Q9NYN1","RASL12" -"UniProt:P11047","LAMC1" -"UniProt:Q16719","KYNU" -"UniProt:Q13323","BIK" -"UniProt:Q9NPZ5","B3GAT2" -"UniProt:P00734","F2" -"UniProt:Q6P1J6","PLB1" -"UniProt:P05013","IFNA6" -"UniProt:Q9H2U1","DHX36" -"UniProt:Q9UBU8","MO4L1" -"UniProt:P13674","P4HA1" -"UniProt:Q9BX66","SRBS1" -"UniProt:P35610","SOAT1" -"UniProt:Q70CQ3","USP30" -"UniProt:Q9Y235","APOBEC2" -"UniProt:Q9UIG4","PS1C2" -"UniProt:Q9BYN7","ZN341" -"UniProt:Q96LI6","HSFY2" -"UniProt:P51956","NEK3" -"UniProt:Q92530","PSMF1" -"UniProt:Q9Y6D5","ARFGEF2" -"UniProt:Q9H244","P2RY12" -"UniProt:Q9H977","WDR54" -"UniProt:Q60598","Cttn" -"UniProt:P35321","SPRR1A" -"UniProt:Q8WVH0","CPLX3" -"UniProt:P48050","KCNJ4" -"UniProt:P15170","GSPT1" -"UniProt:P23945","FSHR" -"UniProt:Q9UNS1","TIMELESS" -"UniProt:A8MPS7","YDJC" -"UniProt:Q9NXJ5","PGPEP1" -"UniProt:Q9P2Y4","ZNF219" -"UniProt:Q9P225","DNAH2" -"UniProt:P01358", -"UniProt:A2AGT5","CKAP5" -"UniProt:Q7L1Q6","BZW1" -"UniProt:Q9H2D6","TRIOBP" -"UniProt:P14867","GABRA1" -"UniProt:P38084","BAP2" -"UniProt:Q09013","DMPK" -"UniProt:D6R9N7","USP17L18" -"UniProt:P62508","ESRRG" -"UniProt:Q9ULK4","MED23" -"UniProt:O15296","ALOX15B" -"UniProt:Q60393","botG" -"UniProt:Q7RTS1","BHLHA15" -"UniProt:Q9HBU1","BARX1" -"UniProt:P53012","SCS3" -"UniProt:Q9UI26","IPO11" -"UniProt:Q7Z2X4","PCLI1" -"UniProt:Q96KP1","EXOC2" -"UniProt:Q12156","AIM7" -"UniProt:Q8IYB5","SMAP1" -"UniProt:Q96RU3","FNBP1" -"UniProt:Q8NDY8","TMEM52" -"UniProt:Q05922","DUS2" -"UniProt:Q9NZJ4","SACS" -"UniProt:P28039","AOAH" -"UniProt:Q07960","RHG01" -"UniProt:Q9UFG5","CS025" -"UniProt:P23142","FBLN1" -"UniProt:Q06520","ST2A1" -"UniProt:P78411","IRX5" -"UniProt:Q9Y6N5","SQRD" -"UniProt:P26842","CD27" -"UniProt:Q8IYJ3","SYTL1" -"UniProt:P46459","NSF" -"UniProt:Q66K89","E4F1" -"UniProt:Q8N8D9","C5orf56" -"UniProt:Q96K80","ZC3HA" -"UniProt:Q9UEE9","CFDP1" -"UniProt:Q5T6V7","Q5T6V7" -"UniProt:Q9H000","MKRN2" -"UniProt:Q3BBV0","NBPF1" -"UniProt:Q8TBZ3","WDR20" -"UniProt:A6NFY7","SDHAF1" -"UniProt:P30046","DDT" -"UniProt:Q96A84","EMID1" -"UniProt:Q9NRS4","TMPRSS4" -"UniProt:O14669","PRRG2" -"UniProt:O95813","CER1" -"UniProt:Q8TBN0","RAB3IL1" -"UniProt:Q13188","STK3" -"UniProt:Q53TS8","C2CD6" -"UniProt:Q03395","ROM1" -"UniProt:O94898","LRIG2" -"UniProt:P04958","tetX" -"UniProt:Q8NG95","OR7G3" -"UniProt:Q96Q07","BTBD9" -"UniProt:Q9H1A7","RPB1C" -"UniProt:Q96JB8","MPP4" -"UniProt:Q86YT6","MIB1" -"UniProt:Q6IE81","JADE1" -"UniProt:O14829","PPEF1" -"UniProt:Q12476","AIR2" -"UniProt:Q9Y342","PLLP" -"UniProt:Q53XK0","Q53XK0" -"UniProt:Q7Z398","ZNF550" -"UniProt:P48668","KRT6C" -"UniProt:Q8WWR8","NEU4" -"UniProt:P49756","RBM25" -"UniProt:Q9H3H5","DPAGT1" -"UniProt:Q9BXW4","MLP3C" -"UniProt:O15041","SEMA3E" -"UniProt:Q7KZN9","COX15" -"UniProt:Q16586","SGCA" -"UniProt:Q96JN8","NEURL4" -"UniProt:Q96AZ1","MT21B" -"UniProt:P04259","KRT6B" -"UniProt:Q8IWQ3","BRSK2" -"UniProt:O95166","GBRAP" -"UniProt:P10644","PRKAR1A" -"UniProt:P17066","HSPA6" -"UniProt:Q9NUQ6","SPATS2L" -"UniProt:Q9BPW9","DHRS9" -"UniProt:Q01484","ANK2" -"UniProt:Q3ZCN5","OTOGL" -"UniProt:Q8TBZ8","ZN564" -"UniProt:Q8NI36","WDR36" -"UniProt:Q9Y5Y4","PTGDR2" -"UniProt:Q96KN3","PKNOX2" -"UniProt:P32247","BRS3" -"UniProt:Q9Y2H0","DLGAP4" -"UniProt:Q86UA6","RIP" -"UniProt:A8MVX0","ARHGEF33" -"UniProt:O00499","BIN1" -"UniProt:Q8IVE3","PKHH2" -"UniProt:Q9BYR6","KRA33" -"UniProt:Q7Z6Z6","PNPLA5" -"UniProt:Q14154","DELE" -"UniProt:Q5TAH2","SLC9C2" -"UniProt:P53702","CCHL" -"UniProt:Q9H5I1","SUV92" -"UniProt:Q9NTK1","C10orf10" -"UniProt:P02538","KRT6A" -"UniProt:Q9H0B6","KLC2" -"UniProt:Q8BFZ4","FXL21" -"UniProt:Q8N6G5","CSGALNACT2" -"UniProt:P46060","RAGP1" -"UniProt:Q9GZQ8","MLP3B" -"UniProt:Q9UHI5","SLC7A8" -"UniProt:P01160","NPPA" -"UniProt:A0A0S2Z507","A0A0S2Z507" -"UniProt:O95865","DDAH2" -"UniProt:O60662","KLHL41" -"UniProt:Q32P28","P3H1" -"UniProt:P06730","EIF4E" -"UniProt:Q90VU7","Q90VU7" -"UniProt:O76039","CDKL5" -"UniProt:Q8NHQ8","RASSF8" -"UniProt:Q9NQV5","PRDM11" -"UniProt:Q96MW5","COG8" -"UniProt:Q3KNT9","TMEM95" -"UniProt:P53602","MVD" -"UniProt:Q9HB55","CYP3A43" -"UniProt:O75716","STK16" -"UniProt:Q8N3J5","PPM1K" -"UniProt:Q9Y2X8","UBE2D4" -"UniProt:Q9BVK2","ALG8" -"UniProt:Q6P9A3","ZNF549" -"UniProt:Q9HB14","KCNK13" -"UniProt:Q5VV67","PPRC1" -"UniProt:Q86YR5","GPSM1" -"UniProt:A6NIX2","WTIP" -"UniProt:Q8WWZ3","EDARADD" -"UniProt:Q9HA47","UCK1" -"UniProt:Q8TBB6","SLC7A14" -"UniProt:Q07075","ENPEP" -"UniProt:P01569","IFNA5" -"UniProt:Q08752","PPID" -"UniProt:Q5SQS8","C10orf120" -"UniProt:Q8WTW3","COG1" -"UniProt:Q9H7T3","C10orf95" -"UniProt:Q6ZRI0","OTOG" -"UniProt:Q96S90","LYSM1" -"UniProt:A5D8V6","VP37C" -"UniProt:Q9P0N5","TMEM216" -"UniProt:Q99757","TXN2" -"UniProt:Q5JUK3","KCNT1" -"UniProt:Q9Y2G0","EFR3B" -"UniProt:Q8IY67","RAVER1" -"UniProt:Q99958","FOXC2" -"UniProt:Q49AS9","Q49AS9" -"UniProt:P33261","CYP2C19" -"UniProt:P49418","AMPH" -"UniProt:A0A087WUM8","A0A087WUM8" -"UniProt:Q8IUH8","SPPL2C" -"UniProt:Q9Y5X0","SNX10" -"UniProt:O95363","FARS2" -"UniProt:Q63HR2","TNS2" -"UniProt:P13051","UNG" -"UniProt:Q9BQT9","CLSTN3" -"UniProt:Q9GZV1","ANKR2" -"UniProt:Q8WUA2","PPIL4" -"UniProt:Q96EB6","SIRT1" -"UniProt:Q9Y2S2","CRYL1" -"UniProt:Q6PD62","CTR9" -"UniProt:Q6KC79","NIPBL" -"UniProt:Q9Y2C9","TLR6" -"UniProt:O75528","TADA3" -"UniProt:P35218","CA5A" -"UniProt:O43312","MTSS1" -"UniProt:P35348","ADRA1A" -"UniProt:Q6GMV2","SMYD5" -"UniProt:P47895","ALDH1A3" -"UniProt:Q9Y221","NIP7" -"UniProt:O95447","LCA5L" -"UniProt:Q9BRI3","SLC30A2" -"UniProt:O00468","AGRN" -"UniProt:Q16204","CCDC6" -"UniProt:Q02575","HEN1" -"UniProt:A0A024RA76","A0A024RA76" -"UniProt:Q14204","DYNC1H1" -"UniProt:O12160","MINT-5231866" -"UniProt:O60641","SNAP91" -"UniProt:A2AUM9","CE152" -"UniProt:Q8IZ69","TRMT2A" -"UniProt:P51786","ZNF157" -"UniProt:P49589","CARS" -"UniProt:Q9H2L4","TMM60" -"UniProt:Q00721","NSP3" -"UniProt:Q9Y3P9","RBGP1" -"UniProt:Q16625","OCLN" -"UniProt:Q96LW1","ZNF354B" -"UniProt:Q15399","TLR1" -"UniProt:P51817","PRKX" -"UniProt:P19075","TSPAN8" -"UniProt:O75351","VPS4B" -"UniProt:Q14156","EFR3A" -"UniProt:P52701","MSH6" -"UniProt:Q8TCT8","SPPL2A" -"UniProt:Q96IY1","NSL1" -"UniProt:Q9ERH7","HIPK3" -"UniProt:Q8N3D4","EHBP1L1" -"UniProt:Q9UMS5","PHTF1" -"UniProt:P35719","MRP8" -"UniProt:Q8IXP5","C11orf53" -"UniProt:O43143","DHX15" -"UniProt:Q9ULQ1","TPCN1" -"UniProt:P97287","MCL1" -"UniProt:P29466","CASP1" -"UniProt:Q4KMG0","CDON" -"UniProt:Q96CJ1","EAF2" -"UniProt:P54849","EMP1" -"UniProt:Q562F6","SGO2" -"UniProt:Q6ZRQ5","MMS22L" -"UniProt:A5PKW4","PSD" -"UniProt:Q8AVJ9","FZD7B" -"UniProt:Q8TDN7","ACER1" -"UniProt:Q75WM6","H1FNT" -"UniProt:P12023","A4" -"UniProt:O60671","RAD1" -"UniProt:P22897","MRC1" -"UniProt:Q6P9G8","Q6P9G8" -"UniProt:Q16676","FOXD1" -"UniProt:P31749","AKT1" -"UniProt:P54731","FAF1" -"UniProt:Q9BYV9","BACH2" -"UniProt:P04053","TDT" -"UniProt:Q7Z4L9","PPP1R42" -"UniProt:O43490","PROM1" -"UniProt:Q15834","CC85B" -"UniProt:O43318","MAP3K7" -"UniProt:Q08639","Tfdp1" -"UniProt:Q9NR56","MBNL1" -"UniProt:P30462","HLA-B" -"UniProt:P40692","MLH1" -"UniProt:Q6ZT21","TMPPE" -"UniProt:Q8IYS0","GRM1C" -"UniProt:Q61097","KSR1" -"UniProt:Q8NBL3","TMEM178A" -"UniProt:Q9BYL1","SAMD10" -"UniProt:J3QRH5","J3QRH5" -"UniProt:P57737","CORO7" -"UniProt:Q86VF7","NRAP" -"UniProt:Q5VWM5","PRAMEF15" -"UniProt:Q6NUP7","PPP4R4" -"UniProt:P43378","PTN9" -"UniProt:Q9Y3Y4","PYGO1" -"UniProt:Q8TC76","FAM110B" -"UniProt:P02654","APOC1" -"UniProt:Q6ZSY5","PPP1R3F" -"UniProt:Q7Z6L1","TCPR1" -"UniProt:Q8TBF8","FAM81A" -"UniProt:P55957","BID" -"UniProt:Q4LDR2","CTXN3" -"UniProt:P20585","MSH3" -"UniProt:O76003","GLRX3" -"UniProt:P25686","DNAJB2" -"UniProt:O00590","ACKR2" -"UniProt:Q5VZV1","MT21C" -"UniProt:P35523","CLCN1" -"UniProt:O95947","TBX6" -"UniProt:Q9UGC6","RGS17" -"UniProt:H0YB98","H0YB98" -"UniProt:Q6PK04","CCDC137" -"UniProt:Q16270","IGFBP7" -"UniProt:O95897","NOE2" -"UniProt:Q9Y5U9","IER3IP1" -"UniProt:Q53R41","FASTKD1" -"UniProt:Q86TS9","MRPL52" -"UniProt:P78329","CYP4F2" -"UniProt:O14641","DVL2" -"UniProt:P20337","RAB3B" -"UniProt:Q99N57","RAF1" -"UniProt:Q86TI0","TBC1D1" -"UniProt:Q7Z736","PLEKHH3" -"UniProt:O43781","DYRK3" -"UniProt:P17568","NDUFB7" -"UniProt:P26583","HMGB2" -"UniProt:O15304","SIVA1" -"UniProt:Q9ULM0","PLEKHH1" -"UniProt:P52799","EFNB2" -"UniProt:Q9P107","GMIP" -"UniProt:Q96ND8","ZNF583" -"UniProt:P50539","MXI1" -"UniProt:Q9Y2D5","AKAP2" -"UniProt:Q8NB59","SYT14" -"UniProt:O60678","PRMT3" -"UniProt:Q9NY12","GAR1" -"UniProt:Q9NR34","MAN1C1" -"UniProt:Q9Y6M0","PRSS21" -"UniProt:P17948","VGFR1" -"UniProt:Q08945","SSRP1" -"UniProt:P49798","RGS4" -"UniProt:P49908","SELENOP" -"UniProt:P15622","ZNF250" -"UniProt:Q9C0A6","SETD5" -"UniProt:P52736","ZN133" -"UniProt:P47897","QARS" -"UniProt:Q8IYE0","CC146" -"UniProt:P25637","YIH1" -"UniProt:A6NNZ2","Tubulin" -"UniProt:Q9BRU9","UTP23" -"UniProt:Q6ZRY4","RBPS2" -"UniProt:P02753","RBP4" -"UniProt:C3PTT6","C3PTT6" -"UniProt:O60296","TRAK2" -"UniProt:O43402","EMC8" -"UniProt:Q9Q2G4","Q9Q2G4" -"UniProt:Q13885","TUBB2A" -"UniProt:Q6UQ28","PLET1" -"UniProt:Q8V2D1","Q8V2D1" -"UniProt:P15884","TCF4" -"UniProt:Q8N6U2","CL033" -"UniProt:Q5VWQ0","RSBN1" -"UniProt:Q9BXS4","TMM59" -"UniProt:P07315","CRYGC" -"UniProt:P14927","UQCRB" -"UniProt:P30038","ALDH4A1" -"UniProt:Q6ZVD8","PHLP2" -"UniProt:P42685","FRK" -"UniProt:Q8IV56","PRR15" -"UniProt:Q96BW1","UPRT" -"UniProt:Q9BS31","ZNF649" -"UniProt:Q9P273","TENM3" -"UniProt:P04921","GYPC" -"UniProt:P53350","PLK1" -"UniProt:Q5UIP0","RIF1" -"UniProt:Q9HBE4","IL21" -"UniProt:P62191","PRS4" -"UniProt:Q9Y5B9","SP16H" -"UniProt:O94772","LY6H" -"UniProt:Q16570","ACKR1" -"UniProt:P04731","MT1A" -"UniProt:Q86VD9","PIGZ" -"UniProt:P78344","IF4G2" -"UniProt:Q9H2A9","CHST8" -"UniProt:P35813","PPM1A" -"UniProt:Q16643","DREB" -"UniProt:P0DMU9","CT45A" -"UniProt:Q9BTT0","ANP32E" -"UniProt:P04155","TFF1" -"UniProt:P56378","C14orf2" -"UniProt:Q03154","ACY1" -"UniProt:Q8NI77","KIF18A" -"UniProt:Q9UJX5","ANAPC4" -"UniProt:Q7Z3B1","NEGR1" -"UniProt:P33993","MCM7" -"UniProt:P42765","ACAA2" -"UniProt:P22695","UQCRC2" -"UniProt:P35585","AP1M1" -"UniProt:P10620","MGST1" -"UniProt:P11215","ITGAM" -"UniProt:Q16760","DGKD" -"UniProt:Q5RIX9","E2F7" -"UniProt:O76061","STC2" -"UniProt:O14543","SOCS3" -"UniProt:Q9H0S4","DDX47" -"UniProt:Q14106","TOB2" -"UniProt:Q5VWC8","HACD4" -"UniProt:P97302","BACH1" -"UniProt:P18669","PGAM1" -"UniProt:Q9UJM3","ERRFI" -"UniProt:Q9BRG1","VPS25" -"UniProt:Q30KQ4","DEFB116" -"UniProt:Q96IK5","GMCL1" -"UniProt:Q02446","SP4" -"UniProt:Q9Y2Q9","MRPS28" -"UniProt:O94763","RMP" -"UniProt:P35176","CYPD" -"UniProt:Q16772","GSTA3" -"UniProt:P49682","CXCR3" -"UniProt:P58004","SESN2" -"UniProt:Q9UQK1","PPP1R3C" -"UniProt:Q6IMN6","CAPR2" -"UniProt:P02724","GYPA" -"UniProt:P16333","NCK1" -"UniProt:Q8IZJ6","TDH" -"UniProt:Q924S8","SPRE1" -"UniProt:P54826","GAS1" -"UniProt:P17544","ATF7" -"UniProt:Q6P2S7","TTC41P" -"UniProt:O15037","KHNYN" -"UniProt:Q96QB1","DLC1" -"UniProt:Q9NSP4","CENPM" -"UniProt:Q9NS56","TOPORS" -"UniProt:P60022","DEFB1" -"UniProt:P48443","RXRG" -"UniProt:Q10570","CPSF1" -"UniProt:Q6UXY8","TMC5" -"UniProt:Q8NHC7","OR14C36" -"UniProt:Q9Y6F7","CDY2A" -"UniProt:P14920","DAO" -"UniProt:Q5TCQ9","MAGI3" -"UniProt:Q9NP70","AMBN" -"UniProt:Q8IZC6","COL27A1" -"UniProt:P62241","RPS8" -"UniProt:Q8IVF5","TIAM2" -"UniProt:P25372","TRX3" -"UniProt:O94905","ERLIN2" -"UniProt:Q96TE0","Q96TE0" -"UniProt:Q6UX39","AMTN" -"UniProt:P35226","BMI1" -"UniProt:Q8NDP4","ZNF439" -"UniProt:Q8WTQ1","DEFB104A" -"UniProt:Q9JHL1","NHRF2" -"UniProt:P51693","APLP1" -"UniProt:Q9BQ87","TBL1Y" -"UniProt:P06239","LCK" -"UniProt:O08785","Clock" -"UniProt:Q8N7H5","PAF1" -"UniProt:Q8N9J2","Q8N9J2" -"UniProt:Q7Z3U7","MON2" -"UniProt:P63000","RAC1" -"UniProt:Q9UNE7","STUB1" -"UniProt:Q8TD19","NEK9" -"UniProt:P37088","SCNN1A" -"UniProt:P22361","HNF1A" -"UniProt:Q04637","EIF4G1" -"UniProt:Q75V66","ANO5" -"UniProt:Q92777","SYN2" -"UniProt:Q6IQ43","Q6IQ43" -"UniProt:O14686","KMT2D" -"UniProt:P0C774","V" -"UniProt:Q5JTZ9","AARS2" -"UniProt:P49643","PRIM2" -"UniProt:P61160","ACTR2" -"UniProt:P59103","DAOA" -"UniProt:Q96M91","CFAP53" -"UniProt:Q96N58","ZN578" -"UniProt:Q7Z7K0","CMC1" -"UniProt:Q5BKX8","MURC" -"UniProt:Q9HC84","MUC5B" -"UniProt:P16402","HIST1H1D" -"UniProt:P36222","CHI3L1" -"UniProt:O00268","TAF4" -"UniProt:P23415","GLRA1" -"UniProt:Q6ZSI9","CAPN12" -"UniProt:Q8IWA0","WDR75" -"UniProt:Q9H2M9","RAB3GAP2" -"UniProt:P15153","RAC2" -"UniProt:Q96I24","FUBP3" -"UniProt:Q3LHN2","KR192" -"UniProt:Q96AZ6","ISG20" -"UniProt:Q53H12","AGK" -"UniProt:Q8IWL1","SFTPA2" -"UniProt:Q8NCR0","B3GALNT2" -"UniProt:Q5TEC3","ZN697" -"UniProt:Q6P5Z2","PKN3" -"UniProt:Q14094","CCNI" -"UniProt:O76082","SLC22A5" -"UniProt:P06213","INSR" -"UniProt:Q92952","KCNN1" -"UniProt:Q05586","GRIN1" -"UniProt:O43615","TIM44" -"UniProt:O60518","RANBP6" -"UniProt:P25635","PWP2" -"UniProt:Q9UBL9","P2RX2" -"UniProt:P07949","RET" -"UniProt:B1AH88","TSPO" -"UniProt:O15013","ARHGEF10" -"UniProt:Q6FGS1","Q6FGS1" -"UniProt:Q8N302","AGGF1" -"UniProt:V9HWG0","V9HWG0" -"UniProt:Q9H4G0","EPB41L1" -"UniProt:Q8TEW6","DOK4" -"UniProt:P21266","GSTM3" -"UniProt:Q9UKD2","MRTO4" -"UniProt:P97710","SHPS1" -"UniProt:P23193","TCEA1" -"UniProt:P17812","CTPS1" -"UniProt:P31213","SRD5A2" -"UniProt:A0A087WW39","A0A087WW39" -"UniProt:P02545","LMNA" -"UniProt:P21912","SDHB" -"UniProt:Q9BZR6","RTN4R" -"UniProt:P11387","TOP1" -"UniProt:P11274","BCR" -"UniProt:Q9NZQ9","TMOD4" -"UniProt:Q9Y2I8","WDR37" -"UniProt:A2IDD5","CCDC78" -"UniProt:Q62559","Ift52" -"UniProt:O60506","HNRPQ" -"UniProt:Q92765","FRZB" -"UniProt:Q8NGN6","OR10G7" -"UniProt:Q86UK7","ZNF598" -"UniProt:O75204","TMEM127" -"UniProt:Q9Y698","CACNG2" -"UniProt:Q9BVM2","DPCD" -"UniProt:Q00587","CDC42EP1" -"UniProt:O43772","SLC25A20" -"UniProt:Q2M1Z3","ARHGAP31" -"UniProt:Q6P5W2","Q6P5W2" -"UniProt:Q86V87","FAM160B2" -"UniProt:Q8VBX6","MPDZ" -"UniProt:P00995","SPINK1" -"UniProt:O14521","SDHD" -"UniProt:Q96F10","SAT2" -"UniProt:Q9NZI8","IGF2BP1" -"UniProt:Q14103","HNRNPD" -"UniProt:P08123","COL1A2" -"UniProt:Q9BXI3","5NT1A" -"UniProt:Q8WZ19","KCTD13" -"UniProt:Q9Y2R4","DDX52" -"UniProt:Q06178","NMA1" -"UniProt:Q02509","OC90" -"UniProt:P09544","WNT2" -"UniProt:Q10587","TEF" -"UniProt:A8MT70","ZBBX" -"UniProt:P61244","MAX" -"UniProt:O14983","ATP2A1" -"UniProt:Q9UJ42","GPR160" -"UniProt:O55005","Robo1" -"UniProt:P37058","HSD17B3" -"UniProt:Q8TEQ8","PIGO" -"UniProt:Q8NC56","LEMD2" -"UniProt:Q76FK4","NOL8" -"UniProt:O00203","AP3B1" -"UniProt:P10600","TGFB3" -"UniProt:Q8NFF5","FLAD1" -"UniProt:P14210","HGF" -"UniProt:Q5TA31","RNF187" -"UniProt:P0DJ88","ESFU2" -"UniProt:Q9EQJ9","MAGI3" -"UniProt:Q6AWC2","WWC2" -"UniProt:P49354","FNTA" -"UniProt:O15528","CYP27B1" -"UniProt:Q9UGI9","PRKAG3" -"UniProt:Q8N3Y3","LARGE2" -"UniProt:P63122","ERVK-8" -"UniProt:Q9UJ04","TSYL4" -"UniProt:P62999","RAC1" -"UniProt:P14735","IDE" -"UniProt:O60333","KIF1B" -"UniProt:Q15124","PGM5" -"UniProt:Q9BY60","GABARAPL3" -"UniProt:O94874","UFL1" -"UniProt:Q96CS4","ZNF689" -"UniProt:P35462","DRD3" -"UniProt:Q7Z6A9","BTLA" -"UniProt:P40337","VHL" -"UniProt:Q5H9J7","BEX5" -"UniProt:Q9Y5X9","LIPG" -"UniProt:P61580","ERVK-10" -"UniProt:P03247","E1BS" -"UniProt:P51168","SCNN1B" -"UniProt:O43805","SSNA1" -"UniProt:P02452","COL1A1" -"UniProt:Q8N5T2","TBC1D19" -"UniProt:Q9Y261","FOXA2" -"UniProt:P69700","VPU" -"UniProt:Q9BYE4","SPRR2G" -"UniProt:Q9NPC3","CCNB1IP1" -"UniProt:Q8N8Q9","NIPA2" -"UniProt:Q9P2H3","IFT80" -"UniProt:Q8N339","MT1M" -"UniProt:Q9UBN1","CACNG4" -"UniProt:Q8IWW6","ARHGAP12" -"UniProt:Q96QS1","TSPAN32" -"UniProt:Q7L8W6","DPH6" -"UniProt:Q9H9Q4","NHEJ1" -"UniProt:Q1RN33","Q1RN33" -"UniProt:Q96LI9","CXorf58" -"UniProt:Q2M2Z5","KIZ" -"UniProt:P23198","CBX3" -"UniProt:P55041","GEM" -"UniProt:Q8IYS8","BD1L2" -"UniProt:Q8N3Z6","ZCHC7" -"UniProt:Q5TAX3","ZCCHC11" -"UniProt:Q9BV90","SNR25" -"UniProt:Q7Z4G4","TRM11" -"UniProt:Q9NUC0","SRTD4" -"UniProt:Q03188","CENPC" -"UniProt:J3KQ70","J3KQ70" -"UniProt:Q8NEM2","SHCBP" -"UniProt:Q5U5Z8","AGBL2" -"UniProt:P60852","ZP1" -"UniProt:Q9P003","CNIH4" -"UniProt:Q8NEG7","DENND6B" -"UniProt:Q9HD23","MRS2" -"UniProt:Q86W10","CYP4Z1" -"UniProt:Q9ULR0","ISY1" -"UniProt:Q5TAQ9","DCAF8" -"UniProt:Q0VAM2","RASGEF1B" -"UniProt:Q920D5","CASPC" -"UniProt:Q99616","CCL13" -"UniProt:Q8N6N2","TTC9B" -"UniProt:P05113","IL5" -"UniProt:Q6DHY5","TBC1D3G" -"UniProt:P04222","HLA-C" -"UniProt:Q6PGQ1","DRIC1" -"UniProt:Q8TEU7","RAPGEF6" -"UniProt:P54763","Ephb2" -"UniProt:P24468","NR2F2" -"UniProt:P49773","HINT1" -"UniProt:P15248","IL9" -"UniProt:Q92995","USP13" -"UniProt:Q75T13","PGAP1" -"UniProt:P52597","HNRPF" -"UniProt:Q6UWB4","PRSS55" -"UniProt:P20671","HIST1H2AD" -"UniProt:Q9UPU7","TBD2B" -"UniProt:Q6P4F2","FDX2" -"UniProt:P31269","HXA9" -"UniProt:O14976","GAK" -"UniProt:Q7RTV2","GSTA5" -"UniProt:Q14973","SLC10A1" -"UniProt:O95760","IL33" -"UniProt:Q8NEG0","FA71C" -"UniProt:Q9Y4P9","SPEF1" -"UniProt:Q9NZ09","UBAP1" -"UniProt:Q9NZP8","C1RL" -"UniProt:Q9EPV5","APAF" -"UniProt:Q7RTR2","NLRC3" -"UniProt:Q5T7W7","TSTD2" -"UniProt:Q9Y6C7","L3R2A" -"UniProt:Q91AU0","Q91AU0" -"UniProt:Q9UMR3","TBX20" -"UniProt:Q99598","TSNAX" -"UniProt:O43463","SUV91" -"UniProt:Q9BXG8","SPZ1" -"UniProt:A2A3K4","PTPDC1" -"UniProt:Q9H8N7","ZNF395" -"UniProt:A0PJK1","SLC5A10" -"UniProt:P00441","SOD1" -"UniProt:Q9Y6J8","STYXL1" -"UniProt:P28356","HOXD9" -"UniProt:P30499","HLA-C" -"UniProt:Q5FYA8","ARSH" -"UniProt:Q7L5A3","F214B" -"UniProt:Q9P021","CRIPT" -"UniProt:Q8TE02","ELP5" -"UniProt:P13646","KRT13" -"UniProt:Q86X76","NIT1" -"UniProt:Q86TJ5","ZNF554" -"UniProt:Q8NE31","FAM13C" -"UniProt:Q9Y3C0","CCD53" -"UniProt:P05423","POLR3D" -"UniProt:P20702","ITGAX" -"UniProt:A4D2B0","MBLAC1" -"UniProt:Q9UER7","DAXX" -"UniProt:Q9UBQ0","VPS29" -"UniProt:P16562","CRISP2" -"UniProt:Q8N895","ZN366" -"UniProt:P0CG21","NHLC4" -"UniProt:O00219","HAS3" -"UniProt:Q9HBY8","SGK2" -"UniProt:O95999","BCL10" -"UniProt:Q9H5Z1","DHX35" -"UniProt:Q14152","EIF3A" -"UniProt:Q8IXH7","NELFCD" -"UniProt:Q7L8S5","OTU6A" -"UniProt:Q6P1W5","CA094" -"UniProt:Q86UN6","AKAP14" -"UniProt:Q9P013","CWC15" -"UniProt:Q9UPY6","WASF3" -"UniProt:P29016","CD1B" -"UniProt:Q9UNH7","SNX6" -"UniProt:P42944","GZF3" -"UniProt:P48307","TFPI2" -"UniProt:Q2WGJ6","KLH38" -"UniProt:Q4ZHG4","FNDC1" -"UniProt:P83917","CBX1" -"UniProt:O75694","NUP155" -"UniProt:Q9Y4E8","UBP15" -"UniProt:Q8NG27","PJA1" -"UniProt:P10321","HLA-C" -"UniProt:Q495T6","MMEL1" -"UniProt:Q01220","A52" -"UniProt:O95336","PGLS" -"UniProt:P07858","CTSB" -"UniProt:P09012","SNRPA" -"UniProt:Q9Y289","SLC5A6" -"UniProt:Q7Z6I5","SPT12" -"UniProt:Q96MG8","PCMTD1" -"UniProt:Q8NGG4","OR8H1" -"UniProt:Q8NBJ7","SUMF2" -"UniProt:Q9H8H2","DDX31" -"UniProt:P97836","Dlgap1" -"UniProt:Q9UKU7","ACAD8" -"UniProt:Q14393","GAS6" -"UniProt:P07996","THBS1" -"UniProt:Q92989","CLP1" -"UniProt:Q8NAV2","C8orf58" -"UniProt:Q5FWF7","FBX48" -"UniProt:Q96RF0","SNX18" -"UniProt:Q8WU90","ZC3H15" -"UniProt:Q96SN7","ORAI2" -"UniProt:P15309","ACPP" -"UniProt:Q6ZVT0","TTLL10" -"UniProt:P62312","LSM6" -"UniProt:P26232","CTNNA2" -"UniProt:O43896","KIF1C" -"UniProt:Q96IR7","HPDL" -"UniProt:Q8NFY9","KBTBD8" -"UniProt:Q9Z0F3","B2L10" -"UniProt:Q96P88","GNRHR2" -"UniProt:Q8IW36","ZN695" -"UniProt:Q9NX46","ADPRHL2" -"UniProt:P48200","IREB2" -"UniProt:Q9H307","PININ" -"UniProt:O15230","LAMA5" -"UniProt:Q8IVL5","P3H2" -"UniProt:Q6P499","NPAL3" -"UniProt:P01767","IGHV3-53" -"UniProt:Q8TBU1","Q8TBU1" -"UniProt:Q96SL4","GPX7" -"UniProt:Q9UBY5","LPAR3" -"UniProt:A2NXD2","IGLV" -"UniProt:O75159","SOCS5" -"UniProt:P54105","CLNS1A" -"UniProt:P38775","YHK5" -"UniProt:P01743","IGHV1-46" -"UniProt:P53173","ERV14" -"UniProt:P24903","CYP2F1" -"UniProt:A0A0C4DG62","A0A0C4DG62" -"UniProt:P01614","IGKV2D-40" -"UniProt:Q9ULB5","CDH7" -"UniProt:Q8N365","CIART" -"UniProt:P21145","MAL" -"UniProt:Q5NV64","IGLV3-16" -"UniProt:Q96SZ4","ZSCAN10" -"UniProt:Q9Y5R2","MMP24" -"UniProt:Q9BRF8","CPPED1" -"UniProt:Q01081","U2AF1L5;U2AF1" -"UniProt:Q6JQN1","ACAD10" -"UniProt:P01715","IGLV3-1" -"UniProt:Q9NUK0","MBNL3" -"UniProt:Q7L2R6","ZN765" -"UniProt:P01814","IGHV2-70" -"UniProt:P11607","AT2A2" -"UniProt:P52895","AKR1C2" -"UniProt:Q96CT2","KLHL29" -"UniProt:Q587J8","KHDC3L" -"UniProt:B8Q183","B8Q183" -"UniProt:Q6FIE9","Q6FIE9" -"UniProt:P56557","TM50B" -"UniProt:O95183","VAMP5" -"UniProt:B5MCU0","B5MCU0" -"UniProt:Q9NVC3","S38A7" -"UniProt:Q01860","POU5F1" -"UniProt:Q9Y2J0","RP3A" -"UniProt:Q9UQ72","PSG11" -"UniProt:Q3SYF9","KRTAP19-7" -"UniProt:Q9UHP7","Q9UHP73" -"UniProt:P36001","FOLC" -"UniProt:O75771","RAD51D" -"UniProt:Q16557","PSG3" -"UniProt:Q9H9I0","Q9H9I0" -"UniProt:Q9H8M2","BRD9" -"UniProt:Q8TAV3","CYP2W1" -"UniProt:Q6T423","SLC22A25" -"UniProt:Q5BJH7","YIF1B" -"UniProt:Q6FHL7","Q6FHL7" -"UniProt:P01764","IGHV3-23" -"UniProt:P49447","CY561" -"UniProt:Q8N5B7","CERS5" -"UniProt:Q5JXC2","MIIP" -"UniProt:O88453","SAFB1" -"UniProt:O14683","TP53I11" -"UniProt:P21757","MSR1" -"UniProt:A8K9C1","A8K9C1" -"UniProt:Q96L14","C170L" -"UniProt:P19438","TNFRSF1A" -"UniProt:Q9NRP0","OSTC" -"UniProt:Q96GC6","ZNF274" -"UniProt:O43313","ATMIN" -"UniProt:O95147","DUSP14" -"UniProt:Q6DKI2","LEG9C" -"UniProt:Q0VAF6","SYCN" -"UniProt:Q8NFR9","IL17RE" -"UniProt:Q96SI9","STRBP" -"UniProt:Q5NV86","IGLV10-54" -"UniProt:Q96F15","GIMA5" -"UniProt:Q3L8U1","CHD9" -"UniProt:P03101","VL1" -"UniProt:Q6N021","TET2" -"UniProt:Q969Q5","RAB24" -"UniProt:Q9BZJ7","GPR62" -"UniProt:Q8WXW3","PIBF1" -"UniProt:P43026","GDF5" -"UniProt:Q4G176","ACSF3" -"UniProt:Q9NP99","TREM1" -"UniProt:Q70CQ1","UBP49" -"UniProt:A0A0A0MQT4","A0A0A0MQT4" -"UniProt:Q00796","SORD" -"UniProt:O95630","STAMBP" -"UniProt:P54920","SNAA" -"UniProt:P04211","IGLV7-43" -"UniProt:Q86VM6","Q86VM6" -"UniProt:Q92686","NRGN" -"UniProt:Q8NEX5","WFDC9" -"UniProt:Q92526","CCT6B" -"UniProt:Q12967","RALGDS" -"UniProt:Q5NV61","IGLV4-3" -"UniProt:Q12318","PSY3" -"UniProt:O94817","ATG12" -"UniProt:A0M8Q6","IGLC7" -"UniProt:P11296","opaC" -"UniProt:O75056","SDC3" -"UniProt:Q5J8X5","M4A13" -"UniProt:Q5SWW7","CJ055" -"UniProt:A2BDD9","A2BDD9" -"UniProt:Q5NV91","IGLV3-27" -"UniProt:O15484","CAPN5" -"UniProt:Q96SB4","SRPK1" -"UniProt:O95424","DEXI" -"UniProt:Q7L5L3","GDPD3" -"UniProt:Q9Y624","F11R" -"UniProt:Q9H9J4","USP42" -"UniProt:Q15004","PCLAF" -"UniProt:P01768","IGHV3-30" -"UniProt:P62879","GNB2" -"UniProt:O00337","SLC28A1" -"UniProt:A8K932","A8K932" -"UniProt:Q96A25","T106A" -"UniProt:Q96AP7","ESAM" -"UniProt:P09131","SLC10A3" -"UniProt:Q969W9","PMEPA1" -"UniProt:Q76NM5","eba-140" -"UniProt:Q96CG8","CTHRC1" -"UniProt:Q53GL6","Q53GL6" -"UniProt:Q9BT04","FUZ" -"UniProt:Q6NXQ0","Q6NXQ0" -"UniProt:Q13427","PPIG" -"UniProt:P01877","IGHA2" -"UniProt:Q4L180","FILIP1L" -"UniProt:P78524","ST5" -"UniProt:P16278","GLB1" -"UniProt:Q04882","opaJ" -"UniProt:P0C746","HBZ" -"UniProt:Q9BRS2","RIOK1" -"UniProt:Q9H1E5","TMX4" -"UniProt:P04433","IGKV3-11" -"UniProt:P17516","AKR1C4" -"UniProt:Q5VWP3","MLIP" -"UniProt:Q9BTV4","TMEM43" -"UniProt:O95376","ARI2" -"UniProt:Q15561","TEAD4" -"UniProt:A0A087WXN0","A0A087WXN0" -"UniProt:P27449","VATL" -"UniProt:P62306","SNRPF" -"UniProt:Q9UQ74","PSG8" -"UniProt:Q9HAV5","EDA2R" -"UniProt:Q13356","PPIL2" -"UniProt:Q17RM4","CCDC142" -"UniProt:A2A3L6","TTC24" -"UniProt:Q6ZVH7","ESPNL" -"UniProt:Q14055","COL9A2" -"UniProt:O95907","SLC16A8" -"UniProt:Q9BYR5","KRTAP4-2" -"UniProt:Q8IUX7","AEBP1" -"UniProt:O14657","TOR1B" -"UniProt:Q9C0J8","WDR33" -"UniProt:P49757","NUMB" -"UniProt:Q8N9N2","ASCC1" -"UniProt:Q9H4A6","GOLP3" -"UniProt:Q9NZL6","RGL1" -"UniProt:Q9H5U6","ZCCHC4" -"UniProt:Q69YG0","TMM42" -"UniProt:O75936","BBOX1" -"UniProt:O75897","SULT1C4" -"UniProt:Q86UY0","Q86UY0" -"UniProt:Q13093","PLA2G7" -"UniProt:P32614","FRDS" -"UniProt:P52823","STC1" -"UniProt:Q8NGE5","OR10A7" -"UniProt:Q9BUY1","Q9BUY1" -"UniProt:Q9NPF7","IL23A" -"UniProt:Q12946","FOXF1" -"UniProt:P11908","PRPS2" -"UniProt:B1AHB0","B1AHB0" -"UniProt:G5E943","G5E943" -"UniProt:Q12830","BPTF" -"UniProt:Q7Z4W3","KR193" -"UniProt:Q77UV9","Q77UV9" -"UniProt:A6NKN8","PCP4L1" -"UniProt:Q96NB1","FOPNL" -"UniProt:Q5TA45","INT11" -"UniProt:Q96GM8","TOE1" -"UniProt:Q56P03","EAPP" -"UniProt:Q8N8Z6","DCBLD1" -"UniProt:Q70IA6","MOB2" -"UniProt:O95436","SLC34A2" -"UniProt:Q96MZ0","GDAP1L1" -"UniProt:Q16762","TST" -"UniProt:Q9HCN3","TMEM8A" -"UniProt:Q96N77","ZNF641" -"UniProt:Q96Q89","KIF20B" -"UniProt:Q64143","P55G" -"UniProt:Q9NWW9","HRSL2" -"UniProt:Q8TCD5","NT5C" -"UniProt:P55263","ADK" -"UniProt:O95977","S1PR4" -"UniProt:Q0VD86","INCA1" -"UniProt:P26436","ACRV1" -"UniProt:Q9BXT6","MOV10L1" -"UniProt:Q96QG7","MTMR9" -"UniProt:Q8N7B1","HORMAD2" -"UniProt:Q15776","ZKSCAN8" -"UniProt:O95992","CH25H" -"UniProt:Q8TCF1","ZFAND1" -"UniProt:Q9H1K1","ISCU" -"UniProt:Q9H6R3","ACSS3" -"UniProt:P22694","KAPCB" -"UniProt:Q9NRN7","ADPPT" -"UniProt:P22314","UBA1" -"UniProt:Q96C23","GALM" -"UniProt:P01599","IGKV1-17" -"UniProt:Q9UBF8","PI4KB" -"UniProt:P49914","MTHFS" -"UniProt:Q309B1","TRIM16L" -"UniProt:Q9NZC7","WWOX" -"UniProt:Q6P2C6","Q6P2C6" -"UniProt:Q9GZX6","IL22" -"UniProt:O43660","PLRG1" -"UniProt:A6NFD8","HELT" -"UniProt:P30685","HLA-B" -"UniProt:Q3SXZ3","ZNF718" -"UniProt:Q53ET0","CRTC2" -"UniProt:Q53S33","BOLA3" -"UniProt:D9YZU9","D9YZU9" -"UniProt:O95007","OR6B1" -"UniProt:Q61249","IGBP1" -"UniProt:Q6ZV73","FGD6" -"UniProt:P86479","PR20C" -"UniProt:Q9NSK7","C19orf12" -"UniProt:Q6RSH7","VHLL" -"UniProt:O15151","MDM4" -"UniProt:Q96SZ5","ADO" -"UniProt:Q8N6G6","ADAMTSL1" -"UniProt:P55287","CDH11" -"UniProt:Q86V25","VASH2" -"UniProt:Q13555","CAMK2G" -"UniProt:A8MVW0","FAM171A2" -"UniProt:O43704","ST1B1" -"UniProt:Q86SH2","ZAR1" -"UniProt:Q7Z5P4","HSD17B13" -"UniProt:Q96DX8","RTP4" -"UniProt:Q99487","PAFAH2" -"UniProt:Q96P15","SERPINB11" -"UniProt:P15144","ANPEP" -"UniProt:P35499","SCN4A" -"UniProt:Q9UJC3","HOOK1" -"UniProt:Q643R3","LPCAT4" -"UniProt:O60928","KCNJ13" -"UniProt:P01127","PDGFB" -"UniProt:Q16827","PTPRO" -"UniProt:P26439","HSD3B2" -"UniProt:A0A087WZP6","A0A087WZP6" -"UniProt:P63211","GNGT1" -"UniProt:P05093","CYP17A1" -"UniProt:Q8N7X0","ADGB" -"UniProt:Q9NS71","GKN1" -"UniProt:A2RUT3","TMM89" -"UniProt:Q9NPI5","NMRK2" -"UniProt:O95263","PDE8B" -"UniProt:Q8WZ59","TM190" -"UniProt:Q16654","PDK4" -"UniProt:P20794","MAK" -"UniProt:Q6PI48","DARS2" -"UniProt:P28330","ACADL" -"UniProt:Q5BN46","C9orf116" -"UniProt:P48169","GABRA4" -"UniProt:Q9HA64","FN3KRP" -"UniProt:A6NNL5","C15orf61" -"UniProt:Q13454","TUSC3" -"UniProt:O43915","VEGFD" -"UniProt:Q8IYX1","TBC21" -"UniProt:O14926","FSCN2" -"UniProt:P31391","SSTR4" -"UniProt:P62962","PROF1" -"UniProt:Q7L3V2","BOP" -"UniProt:P19801","AOC1" -"UniProt:P26572","MGAT1" -"UniProt:Q8N5F7","NKAP" -"UniProt:Q53EU6","GPAT3" -"UniProt:P26599","PTBP1" -"UniProt:A6NI15","MSGN1" -"UniProt:Q96I99","SUCLG2" -"UniProt:Q96N28","PRELID3A" -"UniProt:Q86XT9","TMEM219" -"UniProt:Q13620","CUL4B" -"UniProt:P43694","GATA4" -"UniProt:Q9H939","PPIP2" -"UniProt:O95990","FAM107A" -"UniProt:P08637","FCGR3A" -"UniProt:A1L190","SYCE3" -"UniProt:Q53SF7","COBLL1" -"UniProt:Q8NG76","OR2T33" -"UniProt:Q7Z692","CEACAM19" -"UniProt:Q6UWJ1","TMCO3" -"UniProt:Q9UL49","TCFL5" -"UniProt:Q92622","RUBCN" -"UniProt:Q9HCF6","TRPM3" -"UniProt:Q8N1C3","Gamma-aminobutyric acid receptor subunit gamma-1" -"UniProt:Q6SJ93","FAM111B" -"UniProt:Q9UK00","C3orf18" -"UniProt:Q14626","IL11RA" -"UniProt:Q96LB4","ATP6V1G3" -"UniProt:Q5GH76","XKR4" -"UniProt:Q86Y78","LYPD6" -"UniProt:P12644","BMP4" -"UniProt:Q15005","SPCS2" -"UniProt:Q6PB44","PTN23" -"UniProt:Q13405","MRPL49" -"UniProt:P25208","NFYB" -"UniProt:Q9Y282","ERGIC3" -"UniProt:Q7L8L6","FAKD5" -"UniProt:Q16696","CYP2A13" -"UniProt:Q8NGT7","OR2A12" -"UniProt:P48029","SLC6A8" -"UniProt:Q13449","LSAMP" -"UniProt:Q9NR22","PRMT8" -"UniProt:Q0P6D6","CCDC15" -"UniProt:Q9H553","ALG2" -"UniProt:P0C646","OR52Z1" -"UniProt:Q93088","BHMT" -"UniProt:P02533","KRT14" -"UniProt:Q9PST7","Q9PST7" -"UniProt:Q7D8E1","trx-2" -"UniProt:Q9Y257","KCNK6" -"UniProt:Q96S52","PIGS" -"UniProt:A0A087WYT4","A0A087WYT4" -"UniProt:P04350","TUBB4A" -"UniProt:Q96NY9","MUS81" -"UniProt:Q14584","ZNF266" -"UniProt:Q8NDV3","SMC1B" -"UniProt:P49675","STAR" -"UniProt:Q15777","MPPD2" -"UniProt:Q96JB2","COG3" -"UniProt:Q9Y6G5","COMMD10" -"UniProt:P30690","porB" -"UniProt:Q15185","PTGES3" -"UniProt:Q9BXS1","IDI2" -"UniProt:Q8NGS0","OR1N1" -"UniProt:Q8NEB5","PLPP5" -"UniProt:Q8NET4","RGAG1" -"UniProt:Q9P1W3","TMEM63C" -"UniProt:P04141","CSF2" -"UniProt:Q96LK0","CEP19" -"UniProt:P32324","EFT1" -"UniProt:P60903","S100A10" -"UniProt:P08686","CYP21A2" -"UniProt:Q6IWH7","ANO7" -"UniProt:Q6PEV8","FAM199X" -"UniProt:Q7RTY1","SLC16A9" -"UniProt:P0DJD9","PGA5" -"UniProt:P05305","EDN1" -"UniProt:P35070","BTC" -"UniProt:Q6UWW8","CES3" -"UniProt:O75889","O75889" -"UniProt:P46019","PHKA2" -"UniProt:Q06418","TYRO3" -"UniProt:Q92945","KHSRP" -"UniProt:Q6GPH6","ITPRIPL1" -"UniProt:Q8WWZ1","IL1F10" -"UniProt:P02689","MYP2" -"UniProt:Q8N9F7","GDPD1" -"UniProt:Q7Z3T1","OR2W3" -"UniProt:P13647","KRT5" -"UniProt:Q5QGT7","RTP2" -"UniProt:Q5T9A4","ATAD3B" -"UniProt:P15538","CYP11B1" -"UniProt:Q6PEW1","ZCH12" -"UniProt:P45880","VDAC2" -"UniProt:Q9UN88","GABRQ" -"UniProt:P35325","SPRR2B" -"UniProt:Q8IUD6","RNF135" -"UniProt:V9HW40","V9HW40" -"UniProt:Q15038","DAZP2" -"UniProt:Q96LR7","CB050" -"UniProt:Q64LD2","WDR25" -"UniProt:Q99ML9","RN111" -"UniProt:O43396","TXNL1" -"UniProt:O15492","RGS16" -"UniProt:Q5BKY6","YV018" -"UniProt:P0C5J1","FAM86B2" -"UniProt:Q8N3X1","FNBP4" -"UniProt:Q5HYR2","DMRTC1B" -"UniProt:Q9GZS1","POLR1E" -"UniProt:Q9UBZ4","APEX2" -"UniProt:O60829","PAGE4" -"UniProt:Q9H8Y8","GORS2" -"UniProt:P25103","TACR1" -"UniProt:Q9Y6E7","SIRT4" -"UniProt:Q13823","GNL2" -"UniProt:Q6L9T8","FAM72D" -"UniProt:Q9BXP8","PAPPA2" -"UniProt:Q9BXF9","TEKT3" -"UniProt:P53803","POLR2K" -"UniProt:P55081","MFAP1" -"UniProt:Q9BWH2","FUND2" -"UniProt:P30048","PRDX3" -"UniProt:Q9NWC5","TMEM45A" -"UniProt:Q13106","ZNF154" -"UniProt:Q13882","PTK6" -"UniProt:Q9BVC6","TMEM109" -"UniProt:Q6NVW7","Q6NVW7" -"UniProt:Q9HCH0","NCKAP5L" -"UniProt:Q99808","SLC29A1" -"UniProt:P03363","POL" -"UniProt:Q03989","ARI5A" -"UniProt:Q13508","ART3" -"UniProt:Q8IWL8","STH" -"UniProt:Q9Y240","CLC11" -"UniProt:Q6ZP95","Q6ZP95" -"UniProt:O60885","BRD4" -"UniProt:P39946","LIS1" -"UniProt:Q29836","HLA-B" -"UniProt:Q7Z7N9","TMEM179B" -"UniProt:Q8IV03","LUR1L" -"UniProt:Q5TCH4","CYP4A22" -"UniProt:Q9H3S3","TMPRSS5" -"UniProt:Q8N5G2","MACOI" -"UniProt:Q9BYQ5","KRTAP4-6" -"UniProt:P62161","CALM" -"UniProt:Q9BQG2","NUDT12" -"UniProt:Q9BVQ0","Q9BVQ0" -"UniProt:Q14914","PTGR1" -"UniProt:Q96P11","NSUN5" -"UniProt:P21452","TACR2" -"UniProt:P46779","RPL28" -"UniProt:A0A0C4DFQ0","A0A0C4DFQ0" -"UniProt:Q5VWN6","F208B" -"UniProt:P04435","TCRB" -"UniProt:O14562","UBFD1" -"UniProt:O95988","TCL1B" -"UniProt:Q8TBZ2","MYCBPAP" -"UniProt:Q9P2W3","GBG13" -"UniProt:Q6ZSS3","ZNF621" -"UniProt:Q6UXX9","RSPO2" -"UniProt:P11801","KPSH1" -"UniProt:Q14534","SQLE" -"UniProt:Q9NQR1","KMT5A" -"UniProt:Q9P2G1","ANKIB1" -"UniProt:Q8IZU2","WDR17" -"UniProt:O14757","CHEK1" -"UniProt:Q13790","APOF" -"UniProt:Q99755","PIP5K1A" -"UniProt:Q13227","GPS2" -"UniProt:P82932","RT06" -"UniProt:Q5JVS0","HABP4" -"UniProt:Q9NWT6","HIF1AN" -"UniProt:Q9BZV1","UBXN6" -"UniProt:Q52LR7","EPC2" -"UniProt:Q9H4T2","ZSCAN16" -"UniProt:P12838","DEFA4" -"UniProt:Q8N8J6","ZNF615" -"UniProt:O75956","CDKA2" -"UniProt:Q9Y251","HPSE" -"UniProt:Q9NWU1","OXSM" -"UniProt:P01766","IGHV3-13" -"UniProt:Q6YBV0","SLC36A4" -"UniProt:P14651","HOXB3" -"UniProt:Q9H299","SH3BGRL3" -"UniProt:P47736","RAP1GAP" -"UniProt:Q8NG35","DEFB105A" -"UniProt:Q8IW50","FAM219A" -"UniProt:Q1A5X6","IQCJ" -"UniProt:Q9NU19","TB22B" -"UniProt:O95171","SCEL" -"UniProt:Q9ULH7","MKL2" -"UniProt:O43663","PRC1" -"UniProt:Q96BU1","S100PBP" -"UniProt:Q9Y6N8","CDH10" -"UniProt:P30545","ADA2B" -"UniProt:Q2T9K0","TMEM44" -"UniProt:Q9UHG3","PCYOX" -"UniProt:Q96S65","CSRN1" -"UniProt:Q5TA79","LCE2A" -"UniProt:Q8N7G0","PO5F2" -"UniProt:Q9HCY8","S10AE" -"UniProt:O75865","TRAPPC6A" -"UniProt:Q96CB9","NSUN4" -"UniProt:Q5JS37","NHLRC3" -"UniProt:Q7Z7M9","GALNT5" -"UniProt:Q01338","ADA2A" -"UniProt:Q9BTC0","DIDO1" -"UniProt:Q502W6","VWA3B" -"UniProt:Q7Z5L7","PODN" -"UniProt:P51797","CLCN6" -"UniProt:Q9HBH0","RHOF" -"UniProt:Q9UNW8","GPR132" -"UniProt:Q9BXL8","CDCA4" -"UniProt:Q12926","ELAVL2" -"UniProt:Q99595","TIMM17A" -"UniProt:Q5VTL7","FNDC7" -"UniProt:Q8IWR1","TRI59" -"UniProt:P56282","DPOE2" -"UniProt:P47870","GABRB2" -"UniProt:Q96B67","ARRD3" -"UniProt:Q92478","CLC2B" -"UniProt:Q8N4L5","Q8N4L5" -"UniProt:Q6P280","ZNF529" -"UniProt:Q8N8Y5","ZFP41" -"UniProt:P04233","HG2A" -"UniProt:O60318","MCM3AP" -"UniProt:Q8WW36","ZCH13" -"UniProt:Q69YU5","C12orf73" -"UniProt:Q86WA9","SLC26A11" -"UniProt:Q2TAP0","GOG7B" -"UniProt:Q16850","CYP51A1" -"UniProt:Q06055","ATP5G2" -"UniProt:Q53FZ2","ACSM3" -"UniProt:A0A0B4J1V1","IGHV3-21" -"UniProt:Q92565","RAPGEF5" -"UniProt:P52790","HK3" -"UniProt:Q9P0S9","TM14C" -"UniProt:Q8CFI0","NED4L" -"UniProt:P03409","TAX" -"UniProt:Q07092","COL16A1" -"UniProt:Q12950","FOXD4" -"UniProt:Q86XI2","NCAPG2" -"UniProt:Q4VXU2","PABPC1L" -"UniProt:O96013","PAK4" -"UniProt:Q8N9B5","JMY" -"UniProt:P06133","UGT2B4" -"UniProt:Q9NPD7","NRN1" -"UniProt:Q5VYX0","RNLS" -"UniProt:Q96CW9","NTNG2" -"UniProt:Q9Y5U4","INSIG2" -"UniProt:P58397","ATS12" -"UniProt:O00341","SLC1A7" -"UniProt:P82921","MRPS21" -"UniProt:P08195","4F2" -"UniProt:Q6UXS9","CASP12" -"UniProt:Q9Y6M9","NDUFB9" -"UniProt:Q8NGB8","OR4F15" -"UniProt:Q6ZTA4","TRIM67" -"UniProt:Q9HAS0","C17orf75" -"UniProt:Q96CS3","FAF2" -"UniProt:D0ZRB2","SLRP" -"UniProt:P18206","VCL" -"UniProt:Q68DY9","ZNF772" -"UniProt:Q96B01","RAD51AP1" -"UniProt:Q9BV35","SLC25A23" -"UniProt:Q9UPN7","PPP6R1" -"UniProt:Q05D60","DEUP1" -"UniProt:Q9H6D3","XKR8" -"UniProt:Q15669","RHOH" -"UniProt:Q1MX18","INSC" -"UniProt:Q0VDD8","DNAH14" -"UniProt:O00567","NOP56" -"UniProt:Q6QHC5","DEGS2" -"UniProt:Q9H334","FOXP1" -"UniProt:O08722","Unc5b" -"UniProt:Q4VNC0","ATP13A5" -"UniProt:Q8NFP4","MDGA1" -"UniProt:Q96HA4","C1orf159" -"UniProt:P20339","RAB5A" -"UniProt:Q8NEH6","MNS1" -"UniProt:Q12791","KCNMA1" -"UniProt:Q9UN76","SLC6A14" -"UniProt:Q05086","UBE3A" -"UniProt:Q9H300","PARL" -"UniProt:Q2MV58","TCTN1" -"UniProt:P09326","CD48" -"UniProt:Q01740","FMO1" -"UniProt:P15090","FABP4" -"UniProt:Q02556","IRF8" -"UniProt:Q8WVY7","UBLCP1" -"UniProt:Q9Y4B6","VPRBP" -"UniProt:Q62921","HOIL1" -"UniProt:Q9Y3A6","TMED5" -"UniProt:Q9H3Z4","DNAJC5" -"UniProt:O95073","FSBP" -"UniProt:P32019","INPP5B" -"UniProt:Q9UI09","NDUFA12" -"UniProt:Q8WX39","LCN9" -"UniProt:Q8TF09","DYNLRB2" -"UniProt:P46695","IEX1" -"UniProt:Q6JVE5","LCN12" -"UniProt:P07203","GPX1" -"UniProt:Q9P2N5","RBM27" -"UniProt:P40879","SLC26A3" -"UniProt:P41226","UBA7" -"UniProt:Q12834","CDC20" -"UniProt:Q9UBT2","SAE2" -"UniProt:Q15916","ZBTB6" -"UniProt:P17020","ZNF16" -"UniProt:P48436","SOX9" -"UniProt:O00463","TRAF5" -"UniProt:Q02318","CYP27A1" -"UniProt:Q8IX07","FOG1" -"UniProt:Q9Y6K9","IKBKG" -"UniProt:P15173","MYOG" -"UniProt:D6RA61","USP17L22" -"UniProt:O15266","SHOX" -"UniProt:Q9BVI4","NOC4L" -"UniProt:O60312","ATP10A" -"UniProt:Q96DA2","RAB39B" -"UniProt:Q99489","DDO" -"UniProt:Q8WUZ0","BCL7C" -"UniProt:Q13634","CDH18" -"UniProt:P42768","WAS" -"UniProt:P23497","SP100" -"UniProt:O43683","BUB1" -"UniProt:Q6IPM2","IQCE" -"UniProt:P41161","ETV5" -"UniProt:P98187","CYP4F8" -"UniProt:Q08345","DDR1" -"UniProt:P47041","BIT61" -"UniProt:P51159","RAB27A" -"UniProt:Q9HBI6","CYP4F11" -"UniProt:Q9H814","PHAX" -"UniProt:Q5VV43","KIAA0319" -"UniProt:O14842","FFAR1" -"UniProt:Q8IZ52","CHPF" -"UniProt:Q9Y3D5","MRPS18C" -"UniProt:P78317","RNF4" -"UniProt:Q9H707","ZNF552" -"UniProt:Q12769","NUP160" -"UniProt:Q9Y2Q3","GSTK1" -"UniProt:P04843","RPN1" -"UniProt:P21741","MDK" -"UniProt:Q9P0M4","IL17C" -"UniProt:P45481","Crebbp" -"UniProt:Q9H6I2","SOX17" -"UniProt:Q9BPU9","B9D2" -"UniProt:Q5BIX2","Q5BIX2" -"UniProt:P50221","MEOX1" -"UniProt:Q9UJA5","TRMT6" -"UniProt:Q12765","SCRN1" -"UniProt:Q9NRF8","CTPS2" -"UniProt:Q9ERU9","RBP2" -"UniProt:Q9BZM3","GSX2" -"UniProt:O60237","PPP1R12B" -"UniProt:P03502","NS1" -"UniProt:P10720","PF4V1" -"UniProt:A8MXV4","NUDT19" -"UniProt:Q05952","STP2" -"UniProt:P98174","FGD1" -"UniProt:Q13490","BIRC2" -"UniProt:Q8NEU8","DP13B" -"UniProt:Q8NDZ4","C3orf58" -"UniProt:Q00604","NDP" -"UniProt:O75293","GA45B" -"UniProt:Q9BZL6","PRKD2" -"UniProt:J3KNW4","J3KNW4" -"UniProt:Q7Z628","NET1" -"UniProt:Q5SRN2","C6orf10" -"UniProt:P11465","PSG2" -"UniProt:A0A0C4DFM5","A0A0C4DFM5" -"UniProt:P45985","MP2K4" -"UniProt:P61916","NPC2" -"UniProt:Q8N2Q7","NLGN1" -"UniProt:Q13642","FHL1" -"UniProt:Q8IXJ6","SIR2" -"UniProt:Q969T9","WBP2" -"UniProt:Q7L591","DOK3" -"UniProt:Q9Z2Q6","SEPT5" -"UniProt:P15515","HTN1" -"UniProt:Q6TQR6","L" -"UniProt:P15336","ATF2" -"UniProt:Q86UA1","PRPF39" -"UniProt:P35625","TIMP3" -"UniProt:P29590","PML" -"UniProt:P49754","VPS41" -"UniProt:P30793","GCH1" -"UniProt:Q9MZE0","C1QBP" -"UniProt:A7XYQ1","SOBP" -"UniProt:Q6IPE9","Q6IPE9" -"UniProt:Q14683","SMC1A" -"UniProt:P39059","COL15A1" -"UniProt:P58505","C21orf58" -"UniProt:P61264","STX1B" -"UniProt:Q8NBN7","RDH13" -"UniProt:Q92797","SYMPK" -"UniProt:Q75MR5","Q75MR5" -"UniProt:P52566","ARHGDIB" -"UniProt:Q8TD57","DNAH3" -"UniProt:Q9NVV4","MTPAP" -"UniProt:P62263","RPS14" -"UniProt:Q9P0L0","VAPA" -"UniProt:P55064","AQP5" -"UniProt:Q59GP6","Q59GP6" -"UniProt:P53634","CTSC" -"UniProt:Q9NQX1","PRDM5" -"UniProt:B7ZAQ6","GPR89A" -"UniProt:Q86UW9","DTX2" -"UniProt:Q9H582","ZNF644" -"UniProt:P40424","PBX1" -"UniProt:Q9BYD3","MRPL4" -"UniProt:Q9UL45","BLOC1S6" -"UniProt:Q8IXI2","RHOT1" -"UniProt:Q14318","FKBP8" -"UniProt:P01780","IGHV3-7" -"UniProt:Q8N5N8","Q8N5N8" -"UniProt:P60843","IF4A1" -"UniProt:P09497","CLTB" -"UniProt:Q9Y6V7","DDX49" -"UniProt:Q01826","SATB1" -"UniProt:O15020","SPTBN2" -"UniProt:Q6P4A8","PLBD1" -"UniProt:A0A087X188","A0A087X188" -"UniProt:Q96QP1","ALPK1" -"UniProt:Q58F21","BRDT" -"UniProt:Q02086","SP2" -"UniProt:Q9BVX2","T106C" -"UniProt:Q9NQ55","PPAN" -"UniProt:Q9JJY3","NSMA2" -"UniProt:Q9UHI6","DDX20" -"UniProt:Q13586","STIM1" -"UniProt:Q9P2F8","SIPA1L2" -"UniProt:Q9NVX7","KBTBD4" -"UniProt:Q8WXD0","RXFP2" -"UniProt:Q8NAF0","ZN579" -"UniProt:Q9BZW7","TSG10" -"UniProt:Q9NPG2","NGB" -"UniProt:Q06889","EGR3" -"UniProt:P17301","ITGA2" -"UniProt:P53708","ITGA8" -"UniProt:Q8WWX0","ASB5" -"UniProt:J3KQ47","J3KQ47" -"UniProt:Q6UX41","BTNL8" -"UniProt:Q92837","FRAT1" -"UniProt:P0C739","BNL2A" -"UniProt:O60281","ZNF292" -"UniProt:A1XBS5","FAM92A" -"UniProt:Q96FT7","ASIC4" -"UniProt:Q6UVY6","MOXD1" -"UniProt:P30512","HLA-A" -"UniProt:P26343","DAL80" -"UniProt:P50391","NPY4R" -"UniProt:P31948","STIP1" -"UniProt:O15455","TLR3" -"UniProt:O60449","LY75" -"UniProt:Q9Y2G5","POFUT2" -"UniProt:Q8NAT1","POMGNT2" -"UniProt:Q9H875","PRKRIP1" -"UniProt:O95452","GJB6" -"UniProt:Q86V42","F124A" -"UniProt:Q9QWI6","SRCIN1" -"UniProt:Q6BCY4","CYB5R2" -"UniProt:P40199","CEACAM6" -"UniProt:Q8TBK2","SETD6" -"UniProt:Q53GI4","Q53GI4" -"UniProt:P49279","SLC11A1" -"UniProt:P22532","SPRR2D" -"UniProt:P01040","CSTA" -"UniProt:Q5T890","ERCC6L2" -"UniProt:Q77CE4","GN" -"UniProt:P26882","PPID" -"UniProt:O15212","PFDN6" -"UniProt:Q9NZV7","ZIM2" -"UniProt:Q7Z2D5","PLPPR4" -"UniProt:O00410","IPO5" -"UniProt:Q9UHJ9","PGAP2" -"UniProt:Q01130","SRSF2" -"UniProt:Q9UK28","TMEM59L" -"UniProt:P15018","LIF" -"UniProt:O15440","ABCC5" -"UniProt:Q9P055","JKAMP" -"UniProt:Q9UKM7","MAN1B1" -"UniProt:Q8NI37","PPTC7" -"UniProt:Q6X4W1","NSMF" -"UniProt:Q9H0E3","SAP130" -"UniProt:Q8IYM1","SEPT12" -"UniProt:P00740","F9" -"UniProt:Q01955","COL4A3" -"UniProt:Q9BRQ6","CHCHD6" -"UniProt:Q16621","NFE2" -"UniProt:P61812","TGFB2" -"UniProt:P13500","CCL2" -"UniProt:P22102","GART" -"UniProt:Q06389","NCS1" -"UniProt:Q14767","LTBP2" -"UniProt:Q6P1Q0","LETMD1" -"UniProt:Q9HCN6","GP6" -"UniProt:Q96KC8","DNJC1" -"UniProt:Q05195","MAD1" -"UniProt:O15372","EIF3H" -"UniProt:Q9BQR3","PRSS27" -"UniProt:Q9UNK4","PLA2G2D" -"UniProt:Q86VV8","RTTN" -"UniProt:Q8NFQ5","BPIFB6" -"UniProt:O95182","NDUFA7" -"UniProt:Q96T17","MAP7D2" -"UniProt:Q8NC42","RNF149" -"UniProt:O15033","AREL1" -"UniProt:Q9UHW9","SLC12A6" -"UniProt:Q8IUM7","NPAS4" -"UniProt:Q149N8","SHPRH" -"UniProt:Q8IY34","SLC15A3" -"UniProt:Q9H8H0","NOL11" -"UniProt:Q92673","SORL1" -"UniProt:Q8N6U8","GPR161" -"UniProt:Q08J23","NSUN2" -"UniProt:P13535","MYH8" -"UniProt:Q96LD4","TRIM47" -"UniProt:Q6ZQN5","FOXI2" -"UniProt:Q60520","Sin3a" -"UniProt:Q8TB24","RIN3" -"UniProt:O60763","USO1" -"UniProt:P27482","CALL3" -"UniProt:Q05CH4","Q05CH4" -"UniProt:P56537","IF6" -"UniProt:A6NM10","AQP12B" -"UniProt:Q13487","SNAPC2" -"UniProt:Q9NX53","MUT7B" -"UniProt:E9PQ53","NDUFC2-KCTD14" -"UniProt:Q96P56","CATSPER2" -"UniProt:Q8IVQ6","ZDHHC21" -"UniProt:Q99665","IL12RB2" -"UniProt:Q8NCV1","ADAD2" -"UniProt:Q99607","ELF4" -"UniProt:P07359","GP1BA" -"UniProt:Q9P258","RCC2" -"UniProt:Q9H900","ZWILCH" -"UniProt:P30039","PBLD" -"UniProt:Q9Y2M0","FAN1" -"UniProt:Q96RS6","NUDC1" -"UniProt:O60783","MRPS14" -"UniProt:Q8WXI3","ASB10" -"UniProt:P12724","RNASE3" -"UniProt:Q9UHY1","NRBP1" -"UniProt:O95197","RTN3" -"UniProt:Q33E94","RFX4" -"UniProt:Q8TAC2","JOSD2" -"UniProt:Q9H0V1","TM168" -"UniProt:Q06710","PAX8" -"UniProt:Q14183","DOC2A" -"UniProt:Q8TCE9","PPL13" -"UniProt:Q7RTU3","OLIG3" -"UniProt:Q96N87","SLC6A18" -"UniProt:Q9UJQ1","LAMP5" -"UniProt:Q7Z6B7","SRGAP1" -"UniProt:P55268","LAMB2" -"UniProt:O60894","RAMP1" -"UniProt:Q5TF39","MFSD4B" -"UniProt:Q7LC44","ARC" -"UniProt:O75952","CABYR" -"UniProt:Q96GW7","BCAN" -"UniProt:Q9HBH7","BEX1" -"UniProt:P51504","ZNF80" -"UniProt:Q5T9G4","ARMC12" -"UniProt:P33176","KINH" -"UniProt:Q9UM21","MGAT4A" -"UniProt:Q8N2F6","ARMC10" -"UniProt:Q8N4P6","LRRC71" -"UniProt:P58753","TIRAP" -"UniProt:P13693","TCTP" -"UniProt:Q9NYW8","RBAK" -"UniProt:Q8NHW6","OTOSP" -"UniProt:Q7RTP0","NIPA1" -"UniProt:Q9GZZ8","LACRT" -"UniProt:Q8N9V2","TRIML1" -"UniProt:O14494","PLPP1" -"UniProt:P00546","CDK1" -"UniProt:Q2KHR3","QSER1" -"UniProt:Q7RTU9","STRC" -"UniProt:Q96FE5","LINGO1" -"UniProt:Q05322","VP24" -"UniProt:P36776","LONP1" -"UniProt:P31415","CASQ1" -"UniProt:P06126","CD1A" -"UniProt:Q9NXF7","DCAF16" -"UniProt:Q9H6X5","C19orf44" -"UniProt:Q96FL9","GALNT14" -"UniProt:Q9NRG0","CHRAC1" -"UniProt:Q7L273","KCTD9" -"UniProt:Q17RF5","ODAPH" -"UniProt:P51460","INSL3" -"UniProt:O55042","SYUA" -"UniProt:O60911","CTSV" -"UniProt:Q9NSE2","CISH" -"UniProt:P80365","HSD11B2" -"UniProt:Q5VWQ8","DAB2IP" -"UniProt:P13686","ACP5" -"UniProt:O60508","CDC40" -"UniProt:Q6T4P5","PLPPR3" -"UniProt:P18428","LBP" -"UniProt:O43768","ENSA" -"UniProt:Q9NNX6","CD209" -"UniProt:Q14439","GPR176" -"UniProt:Q8NGG3","OR5T3" -"UniProt:Q9Y2D2","SLC35A3" -"UniProt:Q969W1","ZDHHC16" -"UniProt:O14950","ML12B" -"UniProt:P13056","NR2C1" -"UniProt:Q58EX7","PKHG4" -"UniProt:P49821","NDUFV1" -"UniProt:Q8NGU9","GPR150" -"UniProt:Q96A28","SLAMF9" -"UniProt:O15155","BET1" -"UniProt:Q14894","CRYM" -"UniProt:Q9Y265","RUVB1" -"UniProt:Q8WW24","TEKT4" -"UniProt:P43116","PTGER2" -"UniProt:Q9BXS6","NUSAP1" -"UniProt:P13130","SS100" -"UniProt:Q8WWW8","GAB3" -"UniProt:Q8NG92","OR13H1" -"UniProt:Q9GZV9","FGF23" -"UniProt:Q8NHA4","OR2AE1" -"UniProt:Q9Y4C5","CHST2" -"UniProt:P10589","NR2F1" -"UniProt:Q8NGH9","OR52E4" -"UniProt:O15178","T" -"UniProt:Q9BV19","CA050" -"UniProt:Q16589","CCNG2" -"UniProt:P29128","ICP0" -"UniProt:Q8NGP6","OR5M8" -"UniProt:Q14929","ZNF169" -"UniProt:Q96RT7","TUBGCP6" -"UniProt:Q9GZM8","NDEL1" -"UniProt:O43808","SLC25A17" -"UniProt:Q96LC7","SIGLEC10" -"UniProt:O76000","OR2B3" -"UniProt:Q9C091","GREB1L" -"UniProt:O96008","TOMM40" -"UniProt:Q9NP78","ABCB9" -"UniProt:Q4VNC1","ATP13A4" -"UniProt:Q96HA8","NTAQ1" -"UniProt:Q8NGY9","OR2L8" -"UniProt:F5HDE4","ORF45" -"UniProt:Q8IY17","PNPLA6" -"UniProt:Q96FJ2","DYL2" -"UniProt:Q86YM7","HOMER1" -"UniProt:A3KFT3","OR2M5" -"UniProt:Q6IEY1","OR4F3" -"UniProt:Q9NQQ7","SLC35C2" -"UniProt:Q68D86","C102B" -"UniProt:P10909","CLUS" -"UniProt:P13127","CAPZA1" -"UniProt:P47753","CAZA1" -"UniProt:P08912","CHRM5" -"UniProt:Q9NVP2","ASF1B" -"UniProt:Q15024","EXOSC7" -"UniProt:P51864","TDGF1P3" -"UniProt:P28358","HOXD10" -"UniProt:P49286","MTR1B" -"UniProt:P68366","TUBA4A" -"UniProt:Q9H0C3","TMEM117" -"UniProt:O95006","OR2F2" -"UniProt:O76001","OR2J3" -"UniProt:Q9P2Y5","UVRAG" -"UniProt:Q15617","OR8G1" -"UniProt:Q9UKN7","MYO15A" -"UniProt:Q8NGJ0","OR5A1" -"UniProt:P55290","CDH13" -"UniProt:Q9H2W1","MS4A6A" -"UniProt:Q8IXW5","RPAP2" -"UniProt:P26231","CTNA1" -"UniProt:P12487","env" -"UniProt:Q9NP95","FGF20" -"UniProt:Q96CB8","INTS12" -"UniProt:Q9P2D0","IBTK" -"UniProt:O43707","ACTN4" -"UniProt:P56671","MAZ" -"UniProt:P15927","RPA2" -"UniProt:P47893","OR3A2" -"UniProt:P39729","RBG1" -"UniProt:Q8TC24","Q8TC24" -"UniProt:P17423","KHSE" -"UniProt:Q8NH64","OR51A7" -"UniProt:Q9P2K3","RCOR3" -"UniProt:Q15620","OR8B8" -"UniProt:P15260","IFNGR1" -"UniProt:P01824","IGHV4-39" -"UniProt:Q8IUA7","ABCA9" -"UniProt:A6ND48","OR14I1" -"UniProt:Q8N5N4","C3orf22" -"UniProt:O15083","ERC2" -"UniProt:B3KMH2","B3KMH2" -"UniProt:P51606","RENBP" -"UniProt:Q9NS86","LANCL2" -"UniProt:Q8NCK3","ZN485" -"UniProt:P49903","SEPHS1" -"UniProt:P0C645","OR4E1" -"UniProt:Q8WUD1","RAB2B" -"UniProt:Q8NGX5","OR10K1" -"UniProt:P33032","MC5R" -"UniProt:Q8NC06","ACBD4" -"UniProt:Q5XG85","U633C" -"UniProt:Q9NZP2","OR6C2" -"UniProt:O14974","MYPT1" -"UniProt:Q9UBF2","COPG2" -"UniProt:Q9H074","PAIP1" -"UniProt:Q8NH53","OR52N1" -"UniProt:Q9H845","ACAD9" -"UniProt:Q16394","EXT1" -"UniProt:A6NMS3","OR5K4" -"UniProt:O76013","KRT36" -"UniProt:Q07864","POLE" -"UniProt:P05480","Src" -"UniProt:Q7Z4N8","P4HA3" -"UniProt:P54219","SLC18A1" -"UniProt:Q8NES3","LFNG" -"UniProt:P16188","HLA-A" -"UniProt:Q9BT49","THAP7" -"UniProt:Q15619","OR1C1" -"UniProt:Q8NGC5","OR6J1" -"UniProt:O96007","MOCS2" -"UniProt:Q9QX74","SHAN2" -"UniProt:Q8ND25","ZNRF1" -"UniProt:O94967","WDR47" -"UniProt:O95995","GAS8" -"UniProt:Q96FM1","PGAP3" -"UniProt:P04746","AMYP" -"UniProt:Q96FV9","THOC1" -"UniProt:P51828","ADCY7" -"UniProt:A8MYU2","KCNU1" -"UniProt:Q9Y585","OR1A2" -"UniProt:Q8NGX2","OR2T35" -"UniProt:Q9UPS6","SETD1B" -"UniProt:P17275","JUNB" -"UniProt:Q6EEV6","SUMO4" -"UniProt:Q8WZ92","OR5P2" -"UniProt:P56134","ATPK" -"UniProt:Q99PU7","BAP1" -"UniProt:Q8N8L6","ARL10" -"UniProt:Q8NH02","OR2T29" -"UniProt:O14662","STX16" -"UniProt:A8KA13","A8KA13" -"UniProt:Q9BQP7","MGME1" -"UniProt:Q86VQ3","TXND2" -"UniProt:Q86WV5","TEN1L" -"UniProt:Q9HCS7","XAB2" -"UniProt:Q6IFN5","OR7E24" -"UniProt:P40818","USP8" -"UniProt:Q96CS2","HAUS1" -"UniProt:P78383","S35B1" -"UniProt:Q7Z4K8","TRIM46" -"UniProt:Q99MK9","RASF1" -"UniProt:P17707","AMD1" -"UniProt:Q96MU6","ZNF778" -"UniProt:O95968","SG1D1" -"UniProt:Q693B1","KCTD11" -"UniProt:P19397","CD53" -"UniProt:Q8WUJ1","CYB5D2" -"UniProt:O14735","CDIPT" -"UniProt:L7RT22","L7RT22" -"UniProt:Q8N2M4","TM86A" -"UniProt:Q14139","UBE4A" -"UniProt:Q8N2K1","UBE2J2" -"UniProt:P40471","AYR1" -"UniProt:P20073","ANXA7" -"UniProt:Q96R30","OR2V2" -"UniProt:O75525","KHDRBS3" -"UniProt:Q6UWL2","SUSD1" -"UniProt:Q13105","ZBT17" -"UniProt:P15646","FBRL" -"UniProt:Q9H0W5","CCDC8" -"UniProt:Q9BYS1","KRA15" -"UniProt:Q92520","FAM3C" -"UniProt:Q96SR6","ZNF382" -"UniProt:P62834","RAP1A" -"UniProt:P14907","NSP1" -"UniProt:P50076","ALG10" -"UniProt:P49792","RANBP2" -"UniProt:Q8NFW9","MYRIP" -"UniProt:P48549","KCNJ3" -"UniProt:Q96P65","QRFPR" -"UniProt:Q9BQB4","SOST" -"UniProt:Q06278","AOX1" -"UniProt:Q14533","KRT81" -"UniProt:Q8IV01","SYT12" -"UniProt:P40107","GMT1" -"UniProt:Q9H477","RBKS" -"UniProt:Q92664","GTF3A" -"UniProt:Q9GZU2","PEG3" -"UniProt:P03182","EAR" -"UniProt:P01148","GNRH1" -"UniProt:P23760","PAX3" -"UniProt:Q9HBK9","AS3MT" -"UniProt:Q02153","GUCY1B3" -"UniProt:Q9NWH9","SLTM" -"UniProt:Q6L8H2","KRA53" -"UniProt:P47088","GPI14" -"UniProt:Q96QK1","VPS35" -"UniProt:P47190","PMT3" -"UniProt:Q9Y3R4","NEU2" -"UniProt:Q5BKU9","OXLD1" -"UniProt:Q9UPM9","B9D1" -"UniProt:P28702","RXRB" -"UniProt:Q13066","GAGE2C" -"UniProt:Q8TF08","COX7B2" -"UniProt:Q6PCD5","RFWD3" -"UniProt:Q6NUS6","TCTN3" -"UniProt:Q8NHV4","NEDD1" -"UniProt:P40533","TED1" -"UniProt:Q8N1B3","CCNQ" -"UniProt:Q04941","PLP2" -"UniProt:P21575","Dnm1" -"UniProt:Q9NP72","RAB18" -"UniProt:Q9HCG8","CWC22" -"UniProt:A2VCK2","DCDC2B" -"UniProt:Q9BX95","SGPP1" -"UniProt:P32458","CDC11" -"UniProt:P59047","NLRP5" -"UniProt:Q92956","TNFRSF14" -"UniProt:P85037","FOXK1" -"UniProt:Q9UJT1","TUBD1" -"UniProt:P49189","ALDH9A1" -"UniProt:Q96SU4","OSBPL9" -"UniProt:Q9NPD8","UBE2T" -"UniProt:Q9Y2A4","ZNF443" -"UniProt:Q6ZU15","SEPT14" -"UniProt:O15244","SLC22A2" -"UniProt:Q6ZW76","ANKS3" -"UniProt:Q9NUP7","TRMT13" -"UniProt:Q06144","ORM2" -"UniProt:Q6PL45","BRICD5" -"UniProt:A6NDG6","PGP" -"UniProt:P38695","HXT5" -"UniProt:Q5TA50","CPTP" -"UniProt:Q6ISP9","Q6ISP9" -"UniProt:P61077","UB2D3" -"UniProt:P23786","CPT2" -"UniProt:Q96T23","RSF1" -"UniProt:Q6ZQW0","IDO2" -"UniProt:Q05BL1","Q05BL1" -"UniProt:O43790","KRT86" -"UniProt:Q9BQI7","PSD2" -"UniProt:Q9NUH8","TM14B" -"UniProt:Q9NZR1","TMOD2" -"UniProt:P97477","Aurka" -"UniProt:Q8NFP9","NBEA" -"UniProt:Q9H095","IQCG" -"UniProt:A8MUX0","KRTAP16-1" -"UniProt:P01120","RAS2" -"UniProt:P0CL81","GAGE12I" -"UniProt:Q86WV8","Q86WV8" -"UniProt:P42857","NSG1" -"UniProt:P20783","NTF3" -"UniProt:Q6Y1H2","HACD2" -"UniProt:Q9UBH0","IL36RN" -"UniProt:P07476","IVL" -"UniProt:Q8IUE6","HIST2H2AB" -"UniProt:P04019","VE6" -"UniProt:Q9ULV8","CBLC" -"UniProt:Q9H583","HEATR1" -"UniProt:Q8N945","PRELID2" -"UniProt:Q9UGM5","FETUB" -"UniProt:Q86TY3","C14orf37" -"UniProt:Q13643","FHL3" -"UniProt:P51800","CLCNKA" -"UniProt:Q8TB61","S35B2" -"UniProt:P35637","FUS" -"UniProt:P07332","FES" -"UniProt:Q8N8U9","BMPER" -"UniProt:Q8WWM9","CYGB" -"UniProt:Q9C0C9","UBE2O" -"UniProt:P0CL82","GAGE12I" -"UniProt:Q96PX9","PLEKHG4B" -"UniProt:B7UM99","TIR" -"UniProt:P08727","K1C19" -"UniProt:P03495","NS1" -"UniProt:Q8NH19","O10AG" -"UniProt:Q6RW13","AGTRAP" -"UniProt:P46098","HTR3A" -"UniProt:Q03697","YMD8" -"UniProt:Q96C55","ZN524" -"UniProt:Q969S0","S35B4" -"UniProt:Q6ZW33","MICALCL" -"UniProt:P54707","ATP12A" -"UniProt:P43355","MAGA1" -"UniProt:Q8WWP7","GIMA1" -"UniProt:Q86X45","LRRC6" -"UniProt:Q96HP0","DOCK6" -"UniProt:P38842","YHU0" -"UniProt:P55061","BI1" -"UniProt:Q9BVG9","PTDSS2" -"UniProt:Q14847","LASP1" -"UniProt:Q99805","TM9SF2" -"UniProt:Q9H6S0","YTHDC2" -"UniProt:Q5T0Z8","C6orf132" -"UniProt:P14091","CTSE" -"UniProt:Q92764","KRT35" -"UniProt:Q16617","NKG7" -"UniProt:O00180","KCNK1" -"UniProt:Q9Y2R9","MRPS7" -"UniProt:Q96EC8","YIPF6" -"UniProt:Q9UHF5","IL17B" -"UniProt:P97288","5HT4R" -"UniProt:Q6P9A2","GALNT18" -"UniProt:P09238","MMP10" -"UniProt:Q9H116","GZF1" -"UniProt:P17386","VE6" -"UniProt:Q7Z6J0","SH3RF1" -"UniProt:Q9WTL8","Arntl" -"UniProt:Q09472","EP300" -"UniProt:P03366","POL" -"UniProt:Q8N7K0","ZN433" -"UniProt:Q92914","FGF11" -"UniProt:P48147","PREP" -"UniProt:P61981","YWHAG" -"UniProt:Q8WYA1","ARNTL2" -"UniProt:P40857","HACD" -"UniProt:O15551","CLDN3" -"UniProt:Q9H2P9","DPH5" -"UniProt:Q9BWL3","C1orf43" -"UniProt:Q502X0","MORN2" -"UniProt:Q96EL2","MRPS24" -"UniProt:Q8WUE5","CT55" -"UniProt:Q86UW1","SLC51A" -"UniProt:Q99571","P2RX4" -"UniProt:P29371","TACR3" -"UniProt:Q17RD9","Q17RD9" -"UniProt:Q7Z2T5","TRMT1L" -"UniProt:P20417","PTN1" -"UniProt:Q9P127","LUZP4" -"UniProt:Q06810","OPY2" -"UniProt:Q9Y5J9","TIMM8B" -"UniProt:Q9Y3T9","NOC2L" -"UniProt:O15525","MAFG" -"UniProt:Q8WY54","PPM1E" -"UniProt:Q2VYF4","LETM2" -"UniProt:Q5JXB2","UBE2NL" -"UniProt:O95236","APOL3" -"UniProt:O75064","DENND4B" -"UniProt:P17030","ZNF25" -"UniProt:Q9BYC5","FUT8" -"UniProt:Q9UQC9","CLCA2" -"UniProt:Q8WVV4","POF1B" -"UniProt:Q969Z4","RELT" -"UniProt:Q14145","KEAP1" -"UniProt:Q9Y4A5","TRRAP" -"UniProt:Q3SX64","OD3L2" -"UniProt:Q8TAK6","OLIG1" -"UniProt:Q9BSE2","TMEM79" -"UniProt:Q0WX57","USP17L24" -"UniProt:P21291","CSRP1" -"UniProt:Q8TBM8","DNAJB14" -"UniProt:Q8TBB0","THAP6" -"UniProt:O43307","ARHGEF9" -"UniProt:Q13526","PIN1" -"UniProt:P69726","vpr" -"UniProt:O75638","CTAG2" -"UniProt:Q9UHL3","FAM153A" -"UniProt:Q13393","PLD1" -"UniProt:Q92830","KAT2A" -"UniProt:Q93073","SBP2L" -"UniProt:Q3SY69","ALDH1L2" -"UniProt:O75129","ASTN2" -"UniProt:Q6ZMN7","PDZRN4" -"UniProt:O15400","STX7" -"UniProt:Q8N4F7","RNF175" -"UniProt:P11362","FGFR1" -"UniProt:O00327","ARNTL" -"UniProt:Q6PKG0","LARP1" -"UniProt:Q7L3S4","ZNF771" -"UniProt:O15015","ZNF646" -"UniProt:P63096","GNAI1" -"UniProt:Q9UMZ3","PTPRQ" -"UniProt:Q96RN5","MED15" -"UniProt:P53611","RABGGTB" -"UniProt:Q8N690","DEFB119" -"UniProt:Q9H0T7","RAB17" -"UniProt:Q6P4D5","FAM122C" -"UniProt:Q9Y6X0","SETBP1" -"UniProt:Q96NJ3","ZNF285" -"UniProt:Q5VYK3","ECM29" -"UniProt:Q9H6F5","CCDC86" -"UniProt:O96005","CLPTM1" -"UniProt:A6NEQ0","RBY1E" -"UniProt:P06703","S10A6" -"UniProt:Q12692","H2AZ" -"UniProt:C9JR72","KBTBD13" -"UniProt:Q8N5J4","SPIC" -"UniProt:Q9UBL0","ARPP21" -"UniProt:Q14863","POU6F1" -"UniProt:P37840","SNCA" -"UniProt:Q96CM8","ACSF2" -"UniProt:Q4G0N8","SLC9C1" -"UniProt:P24821","TNC" -"UniProt:O43464","HTRA2" -"UniProt:Q9BRK0","REEP2" -"UniProt:Q9UG01","IFT172" -"UniProt:Q4VB56","Q4VB56" -"UniProt:Q8WVI7","PPP1R1C" -"UniProt:P50548","ERF" -"UniProt:P01709","IGLV2-8" -"UniProt:Q96A57","TMEM230" -"UniProt:Q66K14","TBC1D9B" -"UniProt:Q9NRV9","HEBP1" -"UniProt:Q8N5C8","TAB3" -"UniProt:P57078","RIPK4" -"UniProt:Q9NP73","ALG13" -"UniProt:Q9BUJ2","HNRL1" -"UniProt:P63098","CANB1" -"UniProt:O14514","BAI1" -"UniProt:A6NDE8","GAGE12H" -"UniProt:P40325","HUA1" -"UniProt:Q2HR73","VIRF4" -"UniProt:Q8N9W6","BOLL" -"UniProt:Q5SQH8","C6orf136" -"UniProt:Q8IYI0","CT196" -"UniProt:P82987","ADAMTSL3" -"UniProt:A6NNB3","IFITM5" -"UniProt:Q9UDW3","ZMAT5" -"UniProt:Q194T2","Q194T2" -"UniProt:Q6ZR08","DNAH12" -"UniProt:P35548","MSX2" -"UniProt:P22059","OSBP" -"UniProt:P01111","NRAS" -"UniProt:Q9NYF8","BCLF1" -"UniProt:P42830","CXCL5" -"UniProt:Q96DC9","OTUB2" -"UniProt:Q15643","TRIP11" -"UniProt:P23297","S10A1" -"UniProt:Q1MSJ5","CSPP1" -"UniProt:O95631","NTN1" -"UniProt:Q96P53","WDFY2" -"UniProt:Q9NS15","LTBP3" -"UniProt:Q8TDI7","TMC2" -"UniProt:Q8WXH5","SOCS4" -"UniProt:P25445","FAS" -"UniProt:Q17R31","TATDN3" -"UniProt:Q5VWG9","TAF3" -"UniProt:O94826","TOMM70" -"UniProt:Q99081","TCF12" -"UniProt:P0CG34","TMSB15B" -"UniProt:P51452","DUS3" -"UniProt:Q16880","UGT8" -"UniProt:Q5JXX5","GLRA4" -"UniProt:P46091","GPR1" -"UniProt:Q8N488","RYBP" -"UniProt:B3KPU6","B3KPU6" -"UniProt:Q15051","IQCB1" -"UniProt:P32121","ARRB2" -"UniProt:Q3MIP1","ITPRIPL2" -"UniProt:O43920","NDUFS5" -"UniProt:Q15436","SEC23A" -"UniProt:Q6DD88","ATL3" -"UniProt:Q9Y6H5","SNCAIP" -"UniProt:Q00688","FKBP3" -"UniProt:Q8CFN2","CDC42" -"UniProt:P11413","G6PD" -"UniProt:Q9BVP2","GNL3" -"UniProt:Q9H161","ALX4" -"UniProt:A1L3X0","ELOVL7" -"UniProt:Q9UBN6","TNFRSF10D" -"UniProt:Q96SB8","SMC6" -"UniProt:Q9P0U3","SENP1" -"UniProt:P32505","NAB2" -"UniProt:Q9HBM6","TAF9B" -"UniProt:P48023","FASLG" -"UniProt:Q8TF47","ZFP90" -"UniProt:P11684","SCGB1A1" -"UniProt:P36980","CFHR2" -"UniProt:Q9UPN4","CEP131" -"UniProt:Q5VUG0","SFMBT2" -"UniProt:Q96EU7","C1GALT1C1" -"UniProt:Q9BSA9","TMEM175" -"UniProt:Q96QE2","SLC2A13" -"UniProt:Q9NRX1","PNO1" -"UniProt:Q9Y2X9","ZN281" -"UniProt:Q16666","IF16" -"UniProt:Q9UNA1","ARHGAP26" -"UniProt:Q93063","EXT2" -"UniProt:Q9Y2V0","C15orf41" -"UniProt:Q12906","ILF3" -"UniProt:P04745","AMY1B" -"UniProt:Q9BUZ4","TRAF4" -"UniProt:O43147","SGSM2" -"UniProt:Q96PM9","ZNF385A" -"UniProt:P35467","S10A1" -"UniProt:Q13765","NACA" -"UniProt:P12882","MYH1" -"UniProt:P02745","C1QA" -"UniProt:Q8IZ96","CMTM1" -"UniProt:Q96JP9","CDHR1" -"UniProt:Q9BT17","MTG1" -"UniProt:P02746","C1QB" -"UniProt:P49019","HCAR3" -"UniProt:Q6PJ61","FBX46" -"UniProt:O60309","LRRC37A3" -"UniProt:Q9BQ50","TREX2" -"UniProt:Q5W0Q7","USPL1" -"UniProt:P06858","LPL" -"UniProt:Q1HG43","DUOXA1" -"UniProt:Q96IX9","A26L1" -"UniProt:A7KAX9","RHG32" -"UniProt:Q13310","PABPC4" -"UniProt:A4D1S0","KLRG2" -"UniProt:P49006","MARCKSL1" -"UniProt:Q14686","NCOA6" -"UniProt:Q7Z418","KCNK18" -"UniProt:P08648","ITGA5" -"UniProt:P78563","ADARB1" -"UniProt:Q15878","CACNA1E" -"UniProt:Q7KZS0","Q7KZS0" -"UniProt:Q9Y2W7","KCNIP3" -"UniProt:Q96M89","CCDC138" -"UniProt:Q9NRD1","FBXO6" -"UniProt:Q7Z5L0","VMO1" -"UniProt:P06733","ENO1" -"UniProt:O43299","AP5Z1" -"UniProt:Q2HXU8","CLEC12B" -"UniProt:P62491","RAB11A" -"UniProt:Q16280","CNGA2" -"UniProt:Q8TB93","Q8TB93" -"UniProt:Q8TCT1","PHOSPHO1" -"UniProt:Q969H0","FBXW7" -"UniProt:O75170","PPP6R2" -"UniProt:Q92552","MRPS27" -"UniProt:Q9NXS2","QPCTL" -"UniProt:Q2T9J0","TYSND1" -"UniProt:Q9C0D9","SELENOI" -"UniProt:Q8IYY4","DZIP1L" -"UniProt:A7MD48","SRRM4" -"UniProt:Q68D51","DENND2C" -"UniProt:Q49AM3","TTC31" -"UniProt:Q99JJ1","Q99JJ1" -"UniProt:O75461","E2F6" -"UniProt:Q9NVV2","C19orf73" -"UniProt:P30518","AVPR2" -"UniProt:P38894","FLO5" -"UniProt:Q8TE58","ADAMTS15" -"UniProt:P30487","HLA-B" -"UniProt:Q49AA0","ZFP69" -"UniProt:Q01968","OCRL" -"UniProt:Q6ZMV8","ZNF730" -"UniProt:O00626","CCL22" -"UniProt:Q96K75","ZNF514" -"UniProt:Q3YBA8","Q3YBA8" -"UniProt:Q9BSK1","ZNF577" -"UniProt:Q5SNV9","C1orf167" -"UniProt:P30042","C21orf33" -"UniProt:Q9NPG3","UBN1" -"UniProt:Q92876","KLK6" -"UniProt:Q6P387","C16orf46" -"UniProt:P52434","POLR2H" -"UniProt:A0A0B4J1Y2","A0A0B4J1Y2" -"UniProt:Q8NHL6","LILRB1" -"UniProt:P0C206","REX" -"UniProt:P31276","HOXC13" -"UniProt:P61970","NTF2" -"UniProt:Q9UJX3","ANAPC7" -"UniProt:Q969K3","RNF34" -"UniProt:Q9BQY4","RHXF2" -"UniProt:Q9NPF0","CD320" -"UniProt:P04406","GAPDH" -"UniProt:A7MCY6","TBKB1" -"UniProt:Q86UL8","MAGI2" -"UniProt:Q8NGF1","OR52R1" -"UniProt:P36021","SLC16A2" -"UniProt:Q8IZD6","SLC22A15" -"UniProt:Q9BPY3","F118B" -"UniProt:P32246","CCR1" -"UniProt:Q12800","TFCP2" -"UniProt:P0DI82","TRAPPC2" -"UniProt:Q9JK71","MAGI3" -"UniProt:Q9Y2H1","STK38L" -"UniProt:Q99942","RNF5" -"UniProt:Q6ZVT6","C3orf67" -"UniProt:P43363","MAGEA10" -"UniProt:P40967","PMEL" -"UniProt:P16035","TIMP2" -"UniProt:Q8TED0","UTP15" -"UniProt:P63279","UBC9" -"UniProt:Q9NRH1","YAED1" -"UniProt:P46439","GSTM5" -"UniProt:O43752","STX6" -"UniProt:Q8TE30","Q8TE30" -"UniProt:Q8NGP8","OR5M1" -"UniProt:Q8NBN3","TMEM87A" -"UniProt:G2XKQ0","G2XKQ0" -"UniProt:Q12931","TRAP1" -"UniProt:P02747","C1QC" -"UniProt:P32320","CDA" -"UniProt:Q9H6H4","REEP4" -"UniProt:Q14728","MFSD10" -"UniProt:Q9NS73","MBIP" -"UniProt:Q7Z3E5","ARMC9" -"UniProt:P29017","CD1C" -"UniProt:P23634","ATP2B4" -"UniProt:Q53SE7","Q53SE7" -"UniProt:Q8TE77","SSH3" -"UniProt:Q96CN7","ISOC1" -"UniProt:Q96JB3","HIC2" -"UniProt:Q9H7Z6","KAT8" -"UniProt:A8MVS5","HIDE1" -"UniProt:O43719","HTATSF1" -"UniProt:Q7Z2W9","MRPL21" -"UniProt:Q9UJ78","ZMYM5" -"UniProt:Q03938","ZNF90" -"UniProt:Q8TDY8","IGDCC4" -"UniProt:P41146","OPRL1" -"UniProt:Q9Y4P1","ATG4B" -"UniProt:Q9Y2C2","UST" -"UniProt:Q92733","PRCC" -"UniProt:P48735","IDH2" -"UniProt:Q61187","TS101" -"UniProt:Q8N4Q0","ZADH2" -"UniProt:Q9H5C5","Q9H5C5" -"UniProt:Q9UIF7","MUTYH" -"UniProt:Q13127","REST" -"UniProt:Q86UU0","BCL9L" -"UniProt:Q9H3U1","UN45A" -"UniProt:Q9BUE6","ISCA1" -"UniProt:P25774","CTSS" -"UniProt:O60486","PLXNC1" -"UniProt:O95838","GLP2R" -"UniProt:Q5GAN3","RNASE13" -"UniProt:Q6P158","DHX57" -"UniProt:Q9UJX4","ANAPC5" -"UniProt:P17019","ZNF708" -"UniProt:Q8N4I8","Q8N4I8" -"UniProt:Q6UXZ3","CD300LD" -"UniProt:Q96MM3","ZFP42" -"UniProt:Q9R1L5","MAST1" -"UniProt:Q96ES6","MFSD3" -"UniProt:Q6FGJ9","Q6FGJ9" -"UniProt:A5PLK6","RGSL1" -"UniProt:Q9BZM2","PLA2G2F" -"UniProt:Q8TCA0","LRC20" -"UniProt:Q5JPE7","NOMO2" -"UniProt:P51795","CLCN5" -"UniProt:Q92817","EVPL" -"UniProt:Q922Y0","DYRK3" -"UniProt:Q9H7D7","WDR26" -"UniProt:Q8NFZ4","NLGN2" -"UniProt:Q9UHG2","PCSK1N" -"UniProt:P56199","ITGA1" -"UniProt:O43294","TGFB1I1" -"UniProt:Q8NHY0","B4GALNT2" -"UniProt:O15127","SCAMP2" -"UniProt:Q9NY46","SCN3A" -"UniProt:Q9BRL6","SRSF8" -"UniProt:Q9H089","LSG1" -"UniProt:Q7L8T7","Q7L8T7" -"UniProt:Q6ZMY6","WDR88" -"UniProt:Q96ED9","HOOK2" -"UniProt:Q86WB7","UNC93A" -"UniProt:Q14699","RFTN1" -"UniProt:Q92854","SEMA4D" -"UniProt:P30481","HLA-B" -"UniProt:Q13698","CACNA1S" -"UniProt:Q8NGY6","OR6N2" -"UniProt:Q9HC96","CAPN10" -"UniProt:Q9H490","PIGU" -"UniProt:Q9UGI6","KCNN3" -"UniProt:Q8WXA9","SREK1" -"UniProt:Q86VR8","FJX1" -"UniProt:P08393","ICP0" -"UniProt:Q5JTD0","TJAP1" -"UniProt:Q6AZW8","ZN660" -"UniProt:P41143","OPRD1" -"UniProt:Q99956","DUSP9" -"UniProt:Q9NYV6","RRN3" -"UniProt:P58549","FXYD7" -"UniProt:Q8ND82","Z280C" -"UniProt:Q99684","GFI1" -"UniProt:Q8IV08","PLD3" -"UniProt:Q9ULG1","INO80" -"UniProt:P53677","AP3M2" -"UniProt:Q6KCM7","SLC25A25" -"UniProt:Q86Z14","KLB" -"UniProt:Q15848","ADIPOQ" -"UniProt:Q13145","BAMBI" -"UniProt:Q8N6N7","ACBD7" -"UniProt:P62805","HIST1H4A" -"UniProt:Q9H3E2","SNX25" -"UniProt:Q9BZE1","MRPL37" -"UniProt:Q9Y6H8","GJA3" -"UniProt:Q32MQ0","ZNF750" -"UniProt:Q9H6Z4","RANBP3" -"UniProt:Q86UK0","ABCA12" -"UniProt:Q53HC5","KLH26" -"UniProt:P18440","NAT1" -"UniProt:Q6UX34","CB082" -"UniProt:Q6PXP3","SLC2A7" -"UniProt:Q7KZQ1","Q7KZQ1" -"UniProt:Q9Y5K6","CD2AP" -"UniProt:Q96CM3","RPUSD4" -"UniProt:Q9NS93","TM7SF3" -"UniProt:Q96L21","RPL10L" -"UniProt:P41159","LEP" -"UniProt:Q712K3","UB2R2" -"UniProt:P22217","TRX1" -"UniProt:Q14690","RRP5" -"UniProt:Q75QN2","INTS8" -"UniProt:Q99829","CPNE1" -"UniProt:Q9UPA5","BSN" -"UniProt:Q15008","PSMD6" -"UniProt:A0A075B6P5","IGKV2-28" -"UniProt:Q96HQ0","ZNF419" -"UniProt:Q9UBS3","DNAJB9" -"UniProt:Q8N6M3","FITM2" -"UniProt:Q8NEZ5","FBXO22" -"UniProt:A6NHL2","TUBAL3" -"UniProt:Q9BUU2","METTL22" -"UniProt:Q9P2I0","CPSF2" -"UniProt:Q13185","CBX3" -"UniProt:P00748","F12" -"UniProt:P01036","CYTS" -"UniProt:O35718","Socs3" -"UniProt:Q07889","SOS1" -"UniProt:Q8IUB9","KR191" -"UniProt:Q96KR7","PHACTR3" -"UniProt:Q8NFW5","DMBX1" -"UniProt:O75426","FBXO24" -"UniProt:Q8IZL8","PELP1" -"UniProt:O60271","JIP4" -"UniProt:P15907","ST6GAL1" -"UniProt:Q9HCC9","ZFYVE28" -"UniProt:P06753","TPM3" -"UniProt:P61026","RAB10" -"UniProt:P24610","PAX3" -"UniProt:Q9UKU6","TRHDE" -"UniProt:P43354","NR4A2" -"UniProt:Q4G0R1","Q4G0R1" -"UniProt:Q9UBU3","GHRL" -"UniProt:Q6IA17","SIGIRR" -"UniProt:P48380","RFX3" -"UniProt:Q8IY37","DHX37" -"UniProt:Q9NZV8","KCND2" -"UniProt:O75478","TADA2A" -"UniProt:Q08AF8","GOG8F" -"UniProt:Q86UX6","STK32C" -"UniProt:Q3LI81","KRTAP27-1" -"UniProt:P35606","COPB2" -"UniProt:P12235","SLC25A4" -"UniProt:Q5T6C5","ATXN7L2" -"UniProt:Q8N465","D2HGDH" -"UniProt:P62945","RPL41" -"UniProt:P57103","SLC8A3" -"UniProt:Q8TC07","TBC15" -"UniProt:O75830","SPI2" -"UniProt:Q9Y244","POMP" -"UniProt:Q06330","RBPJ" -"UniProt:Q495N2","SLC36A3" -"UniProt:Q9NQR9","G6PC2" -"UniProt:P47985","UQCRFS1" -"UniProt:P0DN79","CBS" -"UniProt:Q13615","MTMR3" -"UniProt:Q8NGA8","OR4F17" -"UniProt:Q6W0C5","DPPA3" -"UniProt:P10082","PYY" -"UniProt:Q9BPV8","P2RY13" -"UniProt:Q9UM13","ANAPC10" -"UniProt:P55773","CCL23" -"UniProt:P30519","HMOX2" -"UniProt:Q9UJU5","FOXD3" -"UniProt:Q969R2","OSBP2" -"UniProt:Q8WV74","NUDT8" -"UniProt:Q96CE8","TM4SF18" -"UniProt:Q8WXF3","RLN3" -"UniProt:Q9NNW7","TXNRD2" -"UniProt:Q96GD0","PDXP" -"UniProt:P15151","PVR" -"UniProt:Q8R511","FNBP1" -"UniProt:P07766","CD3E" -"UniProt:Q6P1N9","TATDN1" -"UniProt:Q9JHQ5","LZTL1" -"UniProt:Q8IV13","CCNJL" -"UniProt:Q4ZJI4","SLC9B1" -"UniProt:Q7Z614","SNX20" -"UniProt:O15347","HMGB3" -"UniProt:Q13242","SRSF9" -"UniProt:Q8TF76","HASP" -"UniProt:P10153","RNASE2" -"UniProt:Q86WG3","ATCAY" -"UniProt:Q9NRN5","OLFML3" -"UniProt:Q9NXZ2","DDX43" -"UniProt:Q6PIK1","Q6PIK1" -"UniProt:I6L899","GOLGA8R" -"UniProt:P16298","PPP3CB" -"UniProt:Q6IAQ1","Q6IAQ1" -"UniProt:Q6UXZ4","UNC5D" -"UniProt:O14656","TOR1A" -"UniProt:Q2QGD7","ZXDC" -"UniProt:Q8CCI5","RYBP" -"UniProt:P49901","MCSP" -"UniProt:O00501","CLDN5" -"UniProt:Q9H7H0","METTL17" -"UniProt:P27958","POLG" -"UniProt:Q8NEY4","ATP6V1C2" -"UniProt:Q96ME7","ZNF512" -"UniProt:Q15884","FAM189A2" -"UniProt:Q96A35","MRPL24" -"UniProt:Q99075","HBEGF" -"UniProt:P35241","RDX" -"UniProt:Q5MJ68","SPDYC" -"UniProt:Q96MX6","WDR92" -"UniProt:Q9Y2B9","PKIG" -"UniProt:Q96PB8","LRRC3B" -"UniProt:Q05519","SRSF11" -"UniProt:Q6PDM6","Q6PDM6" -"UniProt:Q8WY36","BBX" -"UniProt:P10072","HKR1" -"UniProt:O00634","NTN3" -"UniProt:Q96QA5","GSDMA" -"UniProt:Q9UKI8","TLK1" -"UniProt:Q9ULC3","RAB23" -"UniProt:Q8IV53","DENND1C" -"UniProt:Q8IUX8","EGFL6" -"UniProt:Q9Y5E7","PCDHB2" -"UniProt:Q969M7","UBE2F" -"UniProt:Q92547","TOPB1" -"UniProt:B0QZ18","B0QZ18" -"UniProt:Q8IW03","SIAH3" -"UniProt:Q9Y617","PSAT1" -"UniProt:Q969W3","F104A" -"UniProt:Q92544","TM9SF4" -"UniProt:Q6UWL6","KIRREL2" -"UniProt:P51668","UB2D1" -"UniProt:Q8N7S2","DNAJC5G" -"UniProt:O43924","PDE6D" -"UniProt:Q9UKS6","PACN3" -"UniProt:A8MT69","STRA13" -"UniProt:Q96Q35","ALS2CR12" -"UniProt:O15432","SLC31A2" -"UniProt:P19224","UGT1A6" -"UniProt:P33908","MAN1A1" -"UniProt:Q8WWF8","CAPSL" -"UniProt:Q92828","CORO2A" -"UniProt:P11926","DCOR" -"UniProt:O15482","TEX28" -"UniProt:A0A0A0MSI2","A0A0A0MSI2" -"UniProt:Q9GZT8","NIF3L" -"UniProt:Q08ER8","ZNF543" -"UniProt:A6NGE4","DCAF8L1" -"UniProt:Q92734","TFG" -"UniProt:G5E9X6","G5E9X6" -"UniProt:P68254","1433T" -"UniProt:Q9UMS4","PRP19" -"UniProt:Q8TER0","SNED1" -"UniProt:Q96EL3","MRPL53" -"UniProt:Q13322","GRB10" -"UniProt:P34913","EPHX2" -"UniProt:Q6P602","Q6P602" -"UniProt:Q9UKA9","PTBP2" -"UniProt:Q9BVW6","SMIM2" -"UniProt:B4DWU0","B4DWU0" -"UniProt:Q969V5","MUL1" -"UniProt:Q9NP97","DLRB1" -"UniProt:K7ENM7","K7ENM7" -"UniProt:O43670","ZNF207" -"UniProt:P13995","MTHFD2" -"UniProt:P36402","TCF7" -"UniProt:Q13057","COASY" -"UniProt:O75683","SURF6" -"UniProt:Q96C19","EFHD2" -"UniProt:P49915","GUAA" -"UniProt:Q9Y258","CCL26" -"UniProt:Q5TGI0","FAXC" -"UniProt:P52848","NDST1" -"UniProt:Q9BYQ0","KRTAP9-8" -"UniProt:P05814","CASB" -"UniProt:Q8NHQ1","CEP70" -"UniProt:Q5UAW9","GPR157" -"UniProt:Q9JMK2","Csnk1e" -"UniProt:Q86TG7","PEG10" -"UniProt:Q8TDQ1","CD300LF" -"UniProt:Q8N283","ANKRD35" -"UniProt:P01242","GH2" -"UniProt:Q13115","DUSP4" -"UniProt:Q9Y664","KPTN" -"UniProt:Q99928","GABRG3" -"UniProt:A1A4S6","ARHGAP10" -"UniProt:Q8NBS9","TXNDC5" -"UniProt:Q8N7Q0","Q8N7Q0" -"UniProt:Q969T7","NT5C3B" -"UniProt:P54619","PRKAG1" -"UniProt:P30047","GCHFR" -"UniProt:O95070","YIF1A" -"UniProt:Q2NL98","VMAC" -"UniProt:Q6ZT98","TTLL7" -"UniProt:Q6ZNQ3","LRRC69" -"UniProt:Q9P287","BCCIP" -"UniProt:Q5HYN5","CT451" -"UniProt:P01130","LDLR" -"UniProt:Q9NSC5","HOMER3" -"UniProt:P09017","HXC4" -"UniProt:Q9NR45","NANS" -"UniProt:Q6NUQ1","RINT1" -"UniProt:Q5TBC7","B2L15" -"UniProt:Q9HAV7","GRPEL1" -"UniProt:P89079","E4OR1" -"UniProt:Q8N3E9","PLCD3" -"UniProt:Q8N5Z9","Q8N5Z9" -"UniProt:Q8NB78","KDM1B" -"UniProt:Q30KQ5","DB115" -"UniProt:Q6PB66","LPPRC" -"UniProt:Q496H8","NRN1L" -"UniProt:P31274","HXC9" -"UniProt:Q03020","ISU1" -"UniProt:Q8NCS7","SLC44A5" -"UniProt:O75155","CAND2" -"UniProt:Q6L8G9","KRA56" -"UniProt:Q6P5W5","SLC39A4" -"UniProt:Q96M83","CCDC7" -"UniProt:O96006","ZBED1" -"UniProt:P08050","Gja1" -"UniProt:Q8N436","CPXM2" -"UniProt:Q9Y6R0","NUMBL" -"UniProt:Q8N1K5","THMS1" -"UniProt:Q6ICU9","Q6ICU9" -"UniProt:A8MWA4","ZNF705E" -"UniProt:P20265","PO3F2" -"UniProt:Q9H295","DCSTAMP" -"UniProt:P03116","VE1" -"UniProt:Q9BQS6","HSPB9" -"UniProt:Q6ICB0","DESI1" -"UniProt:P06746","POLB" -"UniProt:Q8N9N8","EIF1A" -"UniProt:Q6ZTZ1","MSANTD1" -"UniProt:P50395","GDI2" -"UniProt:O43678","NDUFA2" -"UniProt:Q9Y3I0","RTCB" -"UniProt:Q96PC3","AP1S3" -"UniProt:Q5VSY0","GKAP1" -"UniProt:Q9UKV5","AMFR" -"UniProt:Q9H171","ZBP1" -"UniProt:Q9Y216","MTMR7" -"UniProt:Q96BZ9","TBC1D20" -"UniProt:Q2KHT4","GSG1" -"UniProt:Q9H1Y3","OPN3" -"UniProt:P11117","ACP2" -"UniProt:Q06587","RING1" -"UniProt:P97784","Cry1" -"UniProt:A6ZKI3","F127A" -"UniProt:Q53R12","TM4SF20" -"UniProt:Q9H3Y6","SRMS" -"UniProt:O75563","SKAP2" -"UniProt:P19490","GRIA1" -"UniProt:P51149","RAB7A" -"UniProt:P31819","env" -"UniProt:Q9GZN4","PRSS22" -"UniProt:P07360","CO8G" -"UniProt:Q5T0G8","Q5T0G8" -"UniProt:P22680","CYP7A1" -"UniProt:O00515","LAD1" -"UniProt:Q96PQ6","ZN317" -"UniProt:O15552","FFAR2" -"UniProt:Q32ZL2","PLPPR5" -"UniProt:Q9Y616","IRAK3" -"UniProt:Q70J99","UNC13D" -"UniProt:Q9H967","WDR76" -"UniProt:P13637","ATP1A3" -"UniProt:Q9Y6N6","LAMC3" -"UniProt:P29452","Casp1" -"UniProt:Q62245","Sos1" -"UniProt:O60812","HNRC1" -"UniProt:P30989","NTSR1" -"UniProt:Q13477","MADCAM1" -"UniProt:Q9UKX7","NUP50" -"UniProt:Q9HD15","SRA1" -"UniProt:P14902","IDO1" -"UniProt:Q86UV6","TRIM74" -"UniProt:Q9NVL8","CC198" -"UniProt:Q14565","DMC1" -"UniProt:Q9H2F5","EPC1" -"UniProt:Q8NH56","OR52N5" -"UniProt:O15218","GPR182" -"UniProt:Q7Z2W7","TRPM8" -"UniProt:P23582","NPPC" -"UniProt:Q92674","CENPI" -"UniProt:P49961","ENTPD1" -"UniProt:B2RV13","C17orf105" -"UniProt:Q676U5","ATG16L1" -"UniProt:O14908","GIPC1" -"UniProt:P26358","DNMT1" -"UniProt:P18089","ADRA2B" -"UniProt:P24043","LAMA2" -"UniProt:C9JLR9","C11orf95" -"UniProt:A0A087WSW0","A0A087WSW0" -"UniProt:Q96MD7","C9orf85" -"UniProt:Q96AQ3","Q96AQ3" -"UniProt:P53671","LIMK2" -"UniProt:Q9H694","BICC1" -"UniProt:Q6J4K2","SLC8B1" -"UniProt:P60409","KRTAP10-7" -"UniProt:P51114","FXR1" -"UniProt:O60806","TBX19" -"UniProt:Q9BX84","TRPM6" -"UniProt:Q9HCB6","SPON1" -"UniProt:P84085","ARF5" -"UniProt:Q9NZD4","AHSP" -"UniProt:P07195","LDHB" -"UniProt:Q15041","ARL6IP1" -"UniProt:Q13472","TOP3A" -"UniProt:P29322","EPHA8" -"UniProt:Q15785","TOM34" -"UniProt:P23327","HRC" -"UniProt:Q495A1","TIGIT" -"UniProt:Q9NS85","CA10" -"UniProt:P23528","CFL1" -"UniProt:Q7L1I2","SV2B" -"UniProt:Q9UBS5","GABBR1" -"UniProt:Q13002","GRIK2" -"UniProt:P78386","KRT85" -"UniProt:Q5NV80","IGLV7-43" -"UniProt:Q64337","SQSTM" -"UniProt:O60909","B4GALT2" -"UniProt:Q16790","CA9" -"UniProt:O95425","SVIL" -"UniProt:Q6ZRC1","C4orf50" -"UniProt:Q9Y6S9","RPS6KL1" -"UniProt:P09105","HBAT" -"UniProt:P32971","TNFSF8" -"UniProt:Q96BZ8","LENG1" -"UniProt:P11310","ACADM" -"UniProt:Q969E4","TCEAL3" -"UniProt:P0CJ71","MTRNR2L4" -"UniProt:Q9Y5Z7","HCFC2" -"UniProt:Q9UJ96","KCNG2" -"UniProt:Q9UNX3","RPL26L1" -"UniProt:O60841","EIF5B" -"UniProt:Q9BXN1","ASPN" -"UniProt:P16219","ACADS" -"UniProt:Q16658","FSCN1" -"UniProt:O60687","SRPX2" -"UniProt:Q8NEC7","GSTCD" -"UniProt:Q86VH4","LRRTM4" -"UniProt:Q02080","MEF2B" -"UniProt:Q8IYU4","UBQLN" -"UniProt:Q86XR8","CEP57" -"UniProt:O00401","WASL" -"UniProt:Q9H201","EPN3" -"UniProt:P30679","GNA15" -"UniProt:P41968","MC3R" -"UniProt:Q9NPR2","SEMA4B" -"UniProt:P17029","ZKSCAN1" -"UniProt:Q8WW62","TMED6" -"UniProt:Q9UFC0","LRWD1" -"UniProt:Q9UBB4","ATXN10" -"UniProt:Q8NFM4","ADCY4" -"UniProt:P28845","HSD11B1" -"UniProt:Q5FWF5","ESCO1" -"UniProt:Q7RTN6","STRADA" -"UniProt:Q86SJ6","DSG4" -"UniProt:Q9BYX7","POTEKP" -"UniProt:P49748","ACADVL" -"UniProt:Q8N3R3","TCAIM" -"UniProt:Q10588","BST1" -"UniProt:Q9Z1B5","MD2L1" -"UniProt:O75477","ERLIN1" -"UniProt:P35612","ADD2" -"UniProt:O00194","RAB27B" -"UniProt:O95707","POP4" -"UniProt:P01854","IGHE" -"UniProt:O14519","CDKA1" -"UniProt:O15169","AXIN1" -"UniProt:Q9P2E3","ZNFX1" -"UniProt:Q8NBL1","POGLUT1" -"UniProt:A6NLX4","TMEM210" -"UniProt:P13349","MYF5" -"UniProt:Q8WUW1","BRK1" -"UniProt:Q5SQ64","LY6G6F" -"UniProt:O95750","FGF19" -"UniProt:P14222","PRF1" -"UniProt:P31260","HOXA10" -"UniProt:Q9Y2V3","RAX" -"UniProt:P70315","Was" -"UniProt:Q8WTQ4","C16orf78" -"UniProt:Q8TCW7","ZPLD1" -"UniProt:Q9BPX6","MICU1" -"UniProt:O75409","HYPM" -"UniProt:Q96RD7","PANX1" -"UniProt:Q13231","CHIT1" -"UniProt:Q86VS3","IQCH" -"UniProt:Q9NQ92","COPRS" -"UniProt:Q9UK45","LSM7" -"UniProt:Q6ZR52","ZNF493" -"UniProt:Q5VW38","GPR107" -"UniProt:Q6UXC1","MAMDC4" -"UniProt:P29622","SERPINA4" -"UniProt:Q6UXK2","ISLR2" -"UniProt:Q9NPC7","MYNN" -"UniProt:Q9Y2L8","ZKSC5" -"UniProt:P45954","ACADSB" -"UniProt:Q01433","AMPD2" -"UniProt:Q04118","PRB3" -"UniProt:Q8N4L1","TMEM151A" -"UniProt:P57764","GSDMD" -"UniProt:Q02779","MAP3K10" -"UniProt:Q9NPQ8","RIC8A" -"UniProt:O14628","ZNF195" -"UniProt:Q8NGE2","OR2AP1" -"UniProt:A0A024R644","A0A024R644" -"UniProt:Q9BR11","ZSWIM1" -"UniProt:Q9NYZ3","GTSE1" -"UniProt:Q63604","Ntrk2" -"UniProt:P13473","LAMP2" -"UniProt:P79101","CPSF3" -"UniProt:P00558","PGK1" -"UniProt:Q9BR77","CCDC77" -"UniProt:P32780","GTF2H1" -"UniProt:P17028","ZNF24" -"UniProt:P05976","MYL1" -"UniProt:P04626","ERBB2" -"UniProt:Q92731","ESR2" -"UniProt:P35346","SSTR5" -"UniProt:Q8IXT5","RB12B" -"UniProt:Q9H4Y5","GSTO2" -"UniProt:Q9BRX8","FAM213A" -"UniProt:P53004","BLVRA" -"UniProt:Q9UBI4","STOML1" -"UniProt:P49005","POLD2" -"UniProt:Q99612","KLF6" -"UniProt:Q8N5Z0","AADAT" -"UniProt:Q9UIL4","KIF25" -"UniProt:Q8NEM8","AGBL3" -"UniProt:Q16831","UPP1" -"UniProt:P17036","ZNF3" -"UniProt:Q14807","KIF22" -"UniProt:Q9UIS9","MBD1" -"UniProt:Q8WUP2","FBLIM1" -"UniProt:Q9NVC6","MED17" -"UniProt:Q9HD89","RETN" -"UniProt:O75914","PAK3" -"UniProt:P24557","TBXAS1" -"UniProt:Q9NPY3","CD93" -"UniProt:P28223","HTR2A" -"UniProt:Q63629","Q63629" -"UniProt:O75558","STX11" -"UniProt:Q99583","MNT" -"UniProt:Q7Z4U5","C6orf201" -"UniProt:Q9BXL7","CARD11" -"UniProt:Q92696","RABGGTA" -"UniProt:Q969M2","GJA10" -"UniProt:O14793","MSTN" -"UniProt:Q96PR1","KCNC2" -"UniProt:O15121","DEGS1" -"UniProt:Q16526","CRY1" -"UniProt:Q9BS57","Q9BS57" -"UniProt:Q9UKP4","ADAMTS7" -"UniProt:Q9H6S3","EPS8L2" -"UniProt:Q8NBP7","PCSK9" -"UniProt:Q13196","Q13196" -"UniProt:O75069","TMCC2" -"UniProt:Q2TAA5","ALG11" -"UniProt:Q04712","RRN11" -"UniProt:Q9UHM6","OPN4" -"UniProt:Q5H9F3","BCORL1" -"UniProt:Q16478","GRIK5" -"UniProt:Q5T1R4","HIVEP3" -"UniProt:P49750","YLPM1" -"UniProt:Q9NQ60","EQTN" -"UniProt:Q9H2K8","TAOK3" -"UniProt:Q9BZI7","UPF3B" -"UniProt:Q9BPZ2","SPIN2B" -"UniProt:A4D1I3","A4D1I3" -"UniProt:Q9H4D0","CLSTN2" -"UniProt:P42127","ASIP" -"UniProt:O76050","NEURL1" -"UniProt:Q96PZ2","FAM111A" -"UniProt:P36383","GJC1" -"UniProt:Q9Y2K3","MYH15" -"UniProt:O00115","DNASE2" -"UniProt:P21333","FLNA" -"UniProt:Q96EN8","MOCOS" -"UniProt:Q99969","RARRES2" -"UniProt:O43296","ZNF264" -"UniProt:Q96MV8","ZDHHC15" -"UniProt:Q6UXN9","WDR82" -"UniProt:O60353","FZD6" -"UniProt:Q6UX27","VSTM1" -"UniProt:Q8NF99","ZNF397" -"UniProt:Q9Y2I6","NINL" -"UniProt:P48357","LEPR" -"UniProt:Q5VZF2","MBNL2" -"UniProt:Q9UBN4","TRPC4" -"UniProt:P01571","IFNA17" -"UniProt:P49760","CLK2" -"UniProt:Q9Y4R7","TTLL3" -"UniProt:Q8WVM7","STAG1" -"UniProt:Q92748","THRSP" -"UniProt:Q9UKL4","GJD2" -"UniProt:P23560","BDNF" -"UniProt:P28336","NMBR" -"UniProt:P62256","UBE2H" -"UniProt:Q3UQN2","FCHO2" -"UniProt:Q12965","MYO1E" -"UniProt:Q76EJ3","SLC35D2" -"UniProt:Q96F81","DISP1" -"UniProt:Q8N1W1","ARHGEF28" -"UniProt:Q923J1","TRPM7" -"UniProt:P06727","APOA4" -"UniProt:Q9P2N7","KLHL13" -"UniProt:Q3SYA9","P12L1" -"UniProt:Q8TD08","MAPK15" -"UniProt:A1L390","PLEKHG3" -"UniProt:P09237","MMP7" -"UniProt:P47992","XCL1" -"UniProt:O00423","EML1" -"UniProt:P21579","SYT1" -"UniProt:Q96QT6","PHF12" -"UniProt:P18887","XRCC1" -"UniProt:Q7Z6Z7","HUWE1" -"UniProt:Q8IWZ3","ANKHD1" -"UniProt:Q9NR28","DIABLO" -"UniProt:P01116","KRAS" -"UniProt:P23975","SLC6A2" -"UniProt:P30419","NMT1" -"UniProt:P32519","ELF1" -"UniProt:P42263","GRIA3" -"UniProt:A2VEC9","SSPO" -"UniProt:Q778I9","Q778I9" -"UniProt:Q9H2A7","CXCL16" -"UniProt:P54098","POLG" -"UniProt:P04114","APOB" -"UniProt:Q9BZE3","BARHL1" -"UniProt:Q5SW96","LDLRAP1" -"UniProt:Q96PS1","FANCD2OS" -"UniProt:O43182","ARHGAP6" -"UniProt:P38159","RBMX" -"UniProt:Q96I27","ZN625" -"UniProt:P07239","DUSP" -"UniProt:Q9BZF1","OSBPL8" -"UniProt:O94805","ACTL6B" -"UniProt:P34981","TRHR" -"UniProt:O43414","ERI3" -"UniProt:Q6Q759","SPAG17" -"UniProt:Q15165","PON2" -"UniProt:Q07325","CXCL9" -"UniProt:P0C7N8","OR9G9" -"UniProt:Q6GV28","TMEM225" -"UniProt:Q8K1P7","SMCA4" -"UniProt:Q9P2J3","KLHL9" -"UniProt:Q9HCT0","FGF22" -"UniProt:P46020","PHKA1" -"UniProt:P20849","COL9A1" -"UniProt:P27169","PON1" -"UniProt:Q12829","RAB40B" -"UniProt:Q96KX0","LYZL4" -"UniProt:P28221","HTR1D" -"UniProt:O95857","TSPAN13" -"UniProt:Q96EY4","TMA16" -"UniProt:O94910","AGRL1" -"UniProt:Q9UPP1","PHF8" -"UniProt:P25054","APC" -"UniProt:Q9NTZ6","RBM12" -"UniProt:Q9HCI5","MAGE1" -"UniProt:Q92581","SLC9A6" -"UniProt:Q9NT99","LRRC4B" -"UniProt:P05813","CRYBA1" -"UniProt:Q16740","CLPP" -"UniProt:Q9H013","ADA19" -"UniProt:P07306","ASGR1" -"UniProt:Q9Y6A5","TACC3" -"UniProt:Q02325","PLGLB1" -"UniProt:Q99962","SH3GL2" -"UniProt:Q96NS5","ASB16" -"UniProt:Q05707","COL14A1" -"UniProt:Q5T7P8","SYT6" -"UniProt:Q76N32","CEP68" -"UniProt:Q86SJ2","AMGO2" -"UniProt:Q08170","SRSF4" -"UniProt:Q6RI45","BRWD3" -"UniProt:Q9P227","ARHGAP23" -"UniProt:P10914","IRF1" -"UniProt:Q16513","PKN2" -"UniProt:Q69YU3","ANKRD34A" -"UniProt:O00541","PES1" -"UniProt:Q99795","GPA33" -"UniProt:Q8IVS2","MCAT" -"UniProt:A0A0S2Z3D2","A0A0S2Z3D2" -"UniProt:Q00G26","PLIN5" -"UniProt:Q9Y520","PRRC2C" -"UniProt:P14649","MYL6B" -"UniProt:Q64010","CRK" -"UniProt:Q8IV61","RASGRP3" -"UniProt:A0A1B0GVF2","A0A1B0GVF2" -"UniProt:P28066","PSA5" -"UniProt:Q9BT43","POLR3GL" -"UniProt:Q8WXD9","CSKI1" -"UniProt:P19827","ITIH1" -"UniProt:Q6NUI1","CCDC144NL" -"UniProt:P0C870","JMJD7" -"UniProt:Q86WR7","PRSR2" -"UniProt:Q86WZ0","HEATR4" -"UniProt:P38168","YBK0" -"UniProt:P11216","PYGB" -"UniProt:Q5TIA1","MEI1" -"UniProt:P49687","NU145" -"UniProt:V9HW80","V9HW80" -"UniProt:Q96BM1","ANKRD9" -"UniProt:Q9UKT9","IKZF3" -"UniProt:Q9Y5L2","HILPDA" -"UniProt:P53112","PEX14" -"UniProt:Q9HB15","KCNK12" -"UniProt:A8MV81","HIG1C" -"UniProt:P20061","TCN1" -"UniProt:Q14532","KRT32" -"UniProt:B8A4K4","B8A4K4" -"UniProt:Q8NGI1","OR56B2P" -"UniProt:Q6P461","ACSM6" -"UniProt:Q7Z624","CAMKMT" -"UniProt:Q8TE69","CXorf40A" -"UniProt:Q3LI70","KR196" -"UniProt:Q96NZ9","PRAP1" -"UniProt:A0A1B0GUU1","ZNF385C" -"UniProt:Q9BWV1","BOC" -"UniProt:A0A0S2Z5X4","A0A0S2Z5X4" -"UniProt:Q5T4B2","GT253" -"UniProt:Q14997","PSME4" -"UniProt:O75884","RBBP9" -"UniProt:P51959","CCNG1" -"UniProt:Q8NCF5","NFATC2IP" -"UniProt:Q92835","SHIP1" -"UniProt:A1L4B6","A1L4B6" -"UniProt:Q96M61","MAGBI" -"UniProt:O14827","RASGRF2" -"UniProt:O43255","SIAH2" -"UniProt:Q96MN5","TCEANC2" -"UniProt:Q02771","PT117" -"UniProt:O54692","ZW10" -"UniProt:Q9UM11","FZR1" -"UniProt:P32831","NGR1" -"UniProt:Q96EE4","CCDC126" -"UniProt:Q96HH9","GRAM3" -"UniProt:Q9NRA1","PDGFC" -"UniProt:Q15018","FAM175B" -"UniProt:Q9UIB8","SLAF5" -"UniProt:Q63767","BCAR1" -"UniProt:A2RU54","HMX2" -"UniProt:Q8NG68","TTL" -"UniProt:A8MVU1","NCF1C" -"UniProt:P38635","HIS9" -"UniProt:Q01064","PDE1B" -"UniProt:Q8N0U1","Q8N0U1" -"UniProt:O60765","ZNF354A" -"UniProt:Q9ULD9","ZNF608" -"UniProt:Q8IWB9","TEX2" -"UniProt:Q9UN42","ATP1B4" -"UniProt:Q9R190","Mta2" -"UniProt:P32119","PRDX2" -"UniProt:Q9UJU2","LEF1" -"UniProt:Q9BWT6","MND1" -"UniProt:Q8WV41","SNX33" -"UniProt:Q9HAZ1","CLK4" -"UniProt:Q9HC97","GPR35" -"UniProt:P17538","CTRB1" -"UniProt:Q8NCB2","CAMKV" -"UniProt:P18825","ADA2C" -"UniProt:Q99878","HIST1H2AJ" -"UniProt:Q8IUC2","KRA81" -"UniProt:P15421","GYPE" -"UniProt:Q8WUJ3","CEMIP" -"UniProt:P09661","RU2A" -"UniProt:O60496","DOK2" -"UniProt:Q9H7B4","SMYD3" -"UniProt:Q96JH8","RADIL" -"UniProt:A5YM69","ARHGEF35" -"UniProt:P13682","ZNF35" -"UniProt:Q8IW70","TMEM151B" -"UniProt:P30838","AL3A1" -"UniProt:Q8WV16","DCAF4" -"UniProt:Q9BQC3","DPH2" -"UniProt:O43264","ZW10" -"UniProt:Q9BQ51","PDCD1LG2" -"UniProt:Q9UBB9","TFP11" -"UniProt:O14727","APAF1" -"UniProt:Q9UGR2","ZC3H7B" -"UniProt:P51841","GUCY2F" -"UniProt:O95833","CLIC3" -"UniProt:Q8NAT2","TDRD5" -"UniProt:Q96AH0","SOSB2" -"UniProt:Q9P0V9","SEPT10" -"UniProt:O15194","CTDSPL" -"UniProt:Q8NBT2","SPC24" -"UniProt:Q9BST9","RTKN" -"UniProt:Q63373","NRX1B" -"UniProt:Q8TAE8","G45IP" -"UniProt:P60328","KRTAP12-3" -"UniProt:Q6UWY0","ARSK" -"UniProt:O75529","TAF5L" -"UniProt:Q92896","GLG1" -"UniProt:O00231","PSD11" -"UniProt:P38792","RRP4" -"UniProt:Q9NUM3","S39A9" -"UniProt:Q01976","ADPP" -"UniProt:P07355","ANXA2" -"UniProt:Q9NPH2","INO1" -"UniProt:Q7LBR1","CHMP1B" -"UniProt:Q9UBV2","SEL1L" -"UniProt:Q9Y2H8","ZNF510" -"UniProt:Q96P69","GPR78" -"UniProt:Q15102","PA1B3" -"UniProt:Q96IU4","ABHD14B" -"UniProt:Q9NWB7","IFT57" -"UniProt:Q05901","CHRNB3" -"UniProt:P56748","CLD8" -"UniProt:K7Y1A2","K7Y1A2" -"UniProt:P13796","LCP1" -"UniProt:Q5TYW1","ZNF658" -"UniProt:A6NNF4","ZNF726" -"UniProt:A8K660","A8K660" -"UniProt:P57739","CLDN2" -"UniProt:Q9Z0G0","GIPC1" -"UniProt:P49024","PAXI" -"UniProt:Q9NZP0","OR6C3" -"UniProt:Q9CPY3","CDCA5" -"UniProt:P22748","CA4" -"UniProt:Q02156","PRKCE" -"UniProt:Q9NUQ8","ABCF3" -"UniProt:Q5VXT5","SYPL2" -"UniProt:Q15323","KRT31" -"UniProt:P68036","UBE2L3" -"UniProt:Q9Y383","LC7L2" -"UniProt:P0DJD1","RGPD2" -"UniProt:I6L8A6","I6L8A6" -"UniProt:Q5JTJ3","COA6" -"UniProt:B9A6K1","B9A6K1" -"UniProt:Q9R194","Cry2" -"UniProt:Q9Y4G6","TLN2" -"UniProt:O75679","RFPL3" -"UniProt:Q8N3S3","PHTF2" -"UniProt:P0C7T5","ATX1L" -"UniProt:Q9BV86","NTMT1" -"UniProt:Q3LHN1","KRTAP21-3" -"UniProt:Q8WUB8","PHF10" -"UniProt:Q8N4P2","TTC30B" -"UniProt:P0C7X2","ZNF688" -"UniProt:O95379","TFIP8" -"UniProt:Q9H3Q1","CDC42EP4" -"UniProt:O43520","ATP8B1" -"UniProt:P30050","RPL12" -"UniProt:P06463","VE6" -"UniProt:Q9NQ88","TIGAR" -"UniProt:Q9UL46","PSME2" -"UniProt:Q2Q1W2","TRIM71" -"UniProt:Q9H4Q3","PRDM13" -"UniProt:A0AVF1","TTC26" -"UniProt:Q96AB3","ISOC2" -"UniProt:Q6P589","TNFAIP8L2" -"UniProt:Q9ULL1","PLEKHG1" -"UniProt:O75319","DUSP11" -"UniProt:Q7Z5P9","MUC19" -"UniProt:Q86U38","NOP9" -"UniProt:P68400","CSNK2A1" -"UniProt:Q0PNE2","ELP6" -"UniProt:Q9H9Z2","LIN28A" -"UniProt:Q9H992","MARCH7" -"UniProt:Q14691","GINS1" -"UniProt:Q3E793","YA044" -"UniProt:Q9NXE4","SMPD4" -"UniProt:O43491","E41L2" -"UniProt:Q9Y259","CHKB" -"UniProt:Q9NX05","FAM120C" -"UniProt:Q93070","ART4" -"UniProt:Q5JXA9","SIRPB2" -"UniProt:P07196","NEFL" -"UniProt:P49190","PTH2R" -"UniProt:Q6Y7W6","GIGYF2" -"UniProt:Q4KMP7","TBC1D10B" -"UniProt:Q8N344","MIER2" -"UniProt:P62906","RL10A" -"UniProt:O43439","CBFA2T2" -"UniProt:Q96F07","CYFIP2" -"UniProt:P46781","RPS9" -"UniProt:P01834","IGKC" -"UniProt:P00813","ADA" -"UniProt:Q9NXK6","PAQR5" -"UniProt:Q07266","DBN1" -"UniProt:Q9NZW4","DSPP" -"UniProt:A0A0C4DFY5","A0A0C4DFY5" -"UniProt:P16152","CBR1" -"UniProt:Q6FI91","Q6FI91" -"UniProt:Q92604","LPGAT1" -"UniProt:Q99618","CDCA3" -"UniProt:B3KS81","SRRM5" -"UniProt:Q8NDW4","ZN248" -"UniProt:Q7Z5J4","RAI1" -"UniProt:Q14938","NFIX" -"UniProt:Q6XD76","ASCL4" -"UniProt:Q9H0H0","INTS2" -"UniProt:Q15750","TAB1" -"UniProt:O00746","NME4" -"UniProt:Q8N554","ZNF276" -"UniProt:P54277","PMS1" -"UniProt:P46093","GPR4" -"UniProt:P57727","TMPRSS3" -"UniProt:Q6ZW31","SYDE1" -"UniProt:O60431","OR1I1" -"UniProt:P79483","HLA-DRB3" -"UniProt:Q13219","PAPPA" -"UniProt:O60256","PRPSAP2" -"UniProt:P20749","BCL3" -"UniProt:Q8IYX0","ZNF679" -"UniProt:Q2M3A8","MRAS1" -"UniProt:Q9Y4L1","HYOU1" -"UniProt:A8MXV6","CDRT15L2" -"UniProt:Q80U93","NU214" -"UniProt:Q9H857","NT5DC2" -"UniProt:O43169","CYB5B" -"UniProt:P04324","NEF" -"UniProt:O00189","AP4M1" -"UniProt:P20848", -"UniProt:Q9Y566","SHANK1" -"UniProt:P47211","GALR1" -"UniProt:Q57230","HA-33" -"UniProt:P59551","TAS2R60" -"UniProt:P85299","PRR5" -"UniProt:Q53RD9","FBLN7" -"UniProt:P02751","FN1" -"UniProt:B0YJ81","HACD1" -"UniProt:Q9NZJ5","EIF2AK3" -"UniProt:Q6UXP7","FAM151B" -"UniProt:P80404","ABAT" -"UniProt:Q96AN5","TMEM143" -"UniProt:Q71RG4","TMUB2" -"UniProt:P21730","C5AR1" -"UniProt:P0C221","CCDC175" -"UniProt:Q12982","BNIP2" -"UniProt:Q92496","CFHR4" -"UniProt:Q9P0V3","SH3B4" -"UniProt:Q16667","CDKN3" -"UniProt:O75962","TRIO" -"UniProt:Q6UN15","FIP1L1" -"UniProt:Q6UXB4","CLEC4G" -"UniProt:P04899","GNAI2" -"UniProt:P0DJI8","SAA1" -"UniProt:Q12907","LMAN2" -"UniProt:Q5TG30","ARHGAP40" -"UniProt:Q9UBL6","CPNE7" -"UniProt:Q96RD6","PANX2" -"UniProt:Q05940","SLC18A2" -"UniProt:O14807","MRAS" -"UniProt:Q86WK9","MPRA" -"UniProt:Q96B33","CLDN23" -"UniProt:Q5VT79","ANXA8L1" -"UniProt:P08962","CD63" -"UniProt:Q9HC10","OTOF" -"UniProt:P48539","PCP4" -"UniProt:Q96S38","RPS6KC1" -"UniProt:Q2TAA2","IAH1" -"UniProt:P12755","SKI" -"UniProt:Q29495","SNAT" -"UniProt:P0C024","NUDT7" -"UniProt:P18507","GABRG2" -"UniProt:Q96I82","KAZALD1" -"UniProt:O60285","NUAK1" -"UniProt:C9J202","ALG1L2" -"UniProt:Q16877","PFKFB4" -"UniProt:Q2I0M5","RSPO4" -"UniProt:A6NI61","MYMK" -"UniProt:Q8NF50","DOCK8" -"UniProt:P0DMR3","ATXN8OS" -"UniProt:Q9P0N8","MARCH2" -"UniProt:A6NFN3","RBFOX3" -"UniProt:P98153","DGCR2" -"UniProt:P59910","DNAJB13" -"UniProt:Q9BRG2","SH23A" -"UniProt:Q8IZJ1","UNC5B" -"UniProt:Q9ULD2","MTUS1" -"UniProt:Q6AI08","HEATR6" -"UniProt:Q13523","PRP4B" -"UniProt:Q9H112","CST11" -"UniProt:Q8NFB2","TMEM185A" -"UniProt:O94989","ARHGEF15" -"UniProt:Q9Y2H5","PLEKHA6" -"UniProt:P01286","GHRH" -"UniProt:P62330","ARF6" -"UniProt:Q19AV6","ZSWIM7" -"UniProt:Q9BS86","ZPBP" -"UniProt:Q96FV2","SCRN2" -"UniProt:Q9NQ86","TRIM36" -"UniProt:P78312","FAM193A" -"UniProt:Q8TC41","RNF217" -"UniProt:Q9Y256","RCE1" -"UniProt:P61619","SEC61A1" -"UniProt:Q03405","PLAUR" -"UniProt:Q00577","PURA" -"UniProt:P50416","CPT1A" -"UniProt:Q9NP85","NPHS2" -"UniProt:P20444","Prkca" -"UniProt:Q13627","DYRK1A" -"UniProt:Q504Y3","ZCWPW2" -"UniProt:Q7L0X0","TRIL" -"UniProt:P23293","BUR1" -"UniProt:Q01664","TFAP4" -"UniProt:Q9Y2D8","ADIP" -"UniProt:Q6X4T0","C12orf54" -"UniProt:Q96RK0","CIC" -"UniProt:A0A0C4DH14","A0A0C4DH14" -"UniProt:P0DJD8","PGA3" -"UniProt:O95299","NDUFA10" -"UniProt:O15111","CHUK" -"UniProt:P45452","MMP13" -"UniProt:Q9NZM6","PKD2L2" -"UniProt:Q6UX98","ZDH24" -"UniProt:Q6P1K8","GTF2H2C" -"UniProt:Q6FI35","Q6FI35" -"UniProt:P47813","EIF1AX" -"UniProt:P09884","POLA1" -"UniProt:O00139","KIF2A" -"UniProt:Q8NB91","FANCB" -"UniProt:O43181","NDUFS4" -"UniProt:Q9NX95","SYBU" -"UniProt:Q92538","GBF1" -"UniProt:P29400","COL4A5" -"UniProt:Q9H2F9","CCDC68" -"UniProt:P43115","PTGER3" -"UniProt:P0C0S5","H2AFZ" -"UniProt:Q13107","UBP4" -"UniProt:Q8TF46","DI3L1" -"UniProt:Q86SH4","PRNT" -"UniProt:Q8WTP8","AEN" -"UniProt:Q96N03","VSTM2L" -"UniProt:Q9H7V2","SYNG1" -"UniProt:Q80V24","VGLL4" -"UniProt:O00264","PGRC1" -"UniProt:Q5T2E6","C10orf76" -"UniProt:Q8NFH5","NUP35" -"UniProt:O15270","SPTLC2" -"UniProt:A0A0A0MSS3","A0A0A0MSS3" -"UniProt:Q92824","PCSK5" -"UniProt:P14652","HOXB2" -"UniProt:Q9NP86","CABP5" -"UniProt:Q86VL0","Q86VL0" -"UniProt:P52741","ZNF134" -"UniProt:P09016","HOXD4" -"UniProt:Q9C029","TRIM7" -"UniProt:Q2VPD4","BMAL2" -"UniProt:Q9H672","ASB7" -"UniProt:Q6P9B6","TLDC1" -"UniProt:Q71H61","ILDR2" -"UniProt:P09936","UCHL1" -"UniProt:Q02094","RHAG" -"UniProt:Q9UHC3","ASIC3" -"UniProt:Q9H6T3","RPAP3" -"UniProt:Q8TCC3","MRPL30" -"UniProt:P26233","CTNB" -"UniProt:Q04912","MST1R" -"UniProt:P41229","KDM5C" -"UniProt:P60891","PRPS1" -"UniProt:Q8NGR3","OR1K1" -"UniProt:Q68CZ6","HAUS3" -"UniProt:Q8WXS8","ADAMTS14" -"UniProt:Q9BXR6","CFHR5" -"UniProt:Q3LI59","KRTAP21-2" -"UniProt:Q8N158","GPC2" -"UniProt:Q9Y2L1","RRP44" -"UniProt:Q7Z783","Q7Z783" -"UniProt:P01699","IGLV1-44" -"UniProt:Q06250","WIT1" -"UniProt:P15311","EZR" -"UniProt:Q9UKL0","RCOR1" -"UniProt:P00739","HPR" -"UniProt:Q9NY93","DDX56" -"UniProt:Q5W111","SPRY7" -"UniProt:Q99547","MPHOSPH6" -"UniProt:Q15485","FCN2" -"UniProt:Q9UBP0","SPAST" -"UniProt:Q15046","KARS" -"UniProt:Q9H0U3","MAGT1" -"UniProt:Q8TC20","CAGE1" -"UniProt:O60513","B4GALT4" -"UniProt:Q8IWS0","PHF6" -"UniProt:Q9NQX7","ITM2C" -"UniProt:Q53GD3","SLC44A4" -"UniProt:A0A0C4DH25","IGKV3D-20" -"UniProt:Q5T1N1","AKNAD1" -"UniProt:Q9Y324","FCF1" -"UniProt:Q8N9S9","SNX31" -"UniProt:Q96GI9","Q96GI9" -"UniProt:C9JJ37","BTBD19" -"UniProt:Q9BT92","TCHP" -"UniProt:Q8TAV4","STML3" -"UniProt:P08519","APOA" -"UniProt:Q99217","AMELX" -"UniProt:A6NI79","CCDC69" -"UniProt:Q8N0U6","CF218" -"UniProt:O60879","DIAPH2" -"UniProt:Q9NYP3","DONSON" -"UniProt:Q3B7T3","BEAN1" -"UniProt:Q9NRL2","BAZ1A" -"UniProt:O14863","ZNT4" -"UniProt:P14550","AKR1A1" -"UniProt:Q5M9N0","CCDC158" -"UniProt:Q6P6C2","ALKBH5" -"UniProt:P27635","RPL10" -"UniProt:Q96JQ2","CLMN" -"UniProt:Q9UBS4","DNAJB11" -"UniProt:Q8IZF2","ADGRF5" -"UniProt:P50897","PPT1" -"UniProt:O95976","IGSF6" -"UniProt:Q9UKI3","VPREB3" -"UniProt:P53337","ERV29" -"UniProt:Q8TDJ6","DMXL2" -"UniProt:P33151","CDH5" -"UniProt:Q8NGF9","OR4X2" -"UniProt:Q9HAI6","CXorf21" -"UniProt:Q5NV62","IGLV8-61" -"UniProt:P11297","Opacity" -"UniProt:Q9NPP4","NLRC4" -"UniProt:P57054","PIGP" -"UniProt:Q8NBQ7","AQP11" -"UniProt:P30274","CCNA2" -"UniProt:Q969Y0","NXPE3" -"UniProt:Q92901","RPL3L" -"UniProt:Q04881","Opacity" -"UniProt:Q96NL3","ZN599" -"UniProt:P00519","ABL1" -"UniProt:Q5NV69","IGLV1-40" -"UniProt:A0A0A0MT36","IGKV6D-21" -"UniProt:Q9BZZ5","API5" -"UniProt:Q9BY84","DUSP16" -"UniProt:O14512","SOCS7" -"UniProt:P31431","SDC4" -"UniProt:Q9UPR6","ZFR2" -"UniProt:Q9BZW4","TM6SF2" -"UniProt:Q9H0A9","SPATC1L" -"UniProt:Q99XV0","Q99XV0" -"UniProt:O95196","CSPG5" -"UniProt:Q9UPU9","SMAG1" -"UniProt:Q01780","EXOSX" -"UniProt:Q9NR97","TLR8" -"UniProt:P80748","IGLV3-21" -"UniProt:Q5NV68","IGLV5-37" -"UniProt:Q3UZ39","LRRF1" -"UniProt:P20674","COX5A" -"UniProt:O75027","ABCB7" -"UniProt:Q03350","TSP2" -"UniProt:Q9BUQ8","DDX23" -"UniProt:O75912","DGKI" -"UniProt:Q96HZ4","HES6" -"UniProt:Q96I59","NARS2" -"UniProt:P01619","IGKV3-20" -"UniProt:P0C0E4","RAB40AL" -"UniProt:P30510","HLA-C" -"UniProt:O00458","IFRD1" -"UniProt:P20853","CYP2A7" -"UniProt:Q7L2Z9","CENPQ" -"UniProt:P01591","JCHAIN" -"UniProt:Q9Y6M5","SLC30A1" -"UniProt:Q495W5","FUT11" -"UniProt:P51810","GPR143" -"UniProt:Q9NYU1","UGGT2" -"UniProt:Q5TEU4","NDUFAF5" -"UniProt:Q07820","MCL1" -"UniProt:Q8IVV8","NKAIN4" -"UniProt:O00591","GABRP" -"UniProt:P29172","TAU" -"UniProt:Q6IAW1","Q6IAW1" -"UniProt:P31040","SDHA" -"UniProt:O75427","LRCH4" -"UniProt:P01717","IGLV3-25" -"UniProt:O95972","BMP15" -"UniProt:Q96MF2","STAC3" -"UniProt:A8MV65","VGLL3" -"UniProt:Q96GV9","CE030" -"UniProt:A0A075B6S6","IGKV2D-30" -"UniProt:P50148","GNAQ" -"UniProt:P52849","NDST2" -"UniProt:P01714","IGLV3-19" -"UniProt:O14530","TXND9" -"UniProt:P52738","ZNF140" -"UniProt:Q9NR82","KCNQ5" -"UniProt:O43934","MFSD11" -"UniProt:Q16635","TAZ" -"UniProt:Q8WXK4","ASB12" -"UniProt:Q9NZD1","GPC5D" -"UniProt:P47224","MSS4" -"UniProt:Q6ZV89","SH2D5" -"UniProt:Q9BUF7","CRB3" -"UniProt:Q99726","SLC30A3" -"UniProt:P06280","GLA" -"UniProt:Q63722","JAG1" -"UniProt:P05154","SERPINA5" -"UniProt:Q9UDX4","SEC14L3" -"UniProt:Q8WUK8","Q8WUK8" -"UniProt:Q6ZMI0","PPP1R21" -"UniProt:Q13409","DYNC1I2" -"UniProt:Q8WXJ9","ASB17" -"UniProt:P36897","TGFBR1" -"UniProt:Q8N2S1","LTBP4" -"UniProt:Q75MW2","ZNF767P" -"UniProt:Q9UI42","CPA4" -"UniProt:Q14C86","GAPVD1" -"UniProt:Q9UM47","NOTCH3" -"UniProt:Q8TDN1","KCNG4" -"UniProt:Q6P9G4","TMEM154" -"UniProt:Q9NYG8","KCNK4" -"UniProt:O75947","ATP5H" -"UniProt:Q9Y6R9","CCDC61" -"UniProt:O60547","GMDS" -"UniProt:Q86TV6","TTC7B" -"UniProt:O00154","ACOT7" -"UniProt:Q9C0F1","CEP44" -"UniProt:Q6DHV7","ADAL" -"UniProt:O60284","ST18" -"UniProt:O15516","CLOCK" -"UniProt:O75376","NCOR1" -"UniProt:Q9HAW4","CLSPN" -"UniProt:P04118","CLPS" -"UniProt:P17361","N1" -"UniProt:Q62141","SIN3B" -"UniProt:Q8TCG2","PI4K2B" -"UniProt:Q6ZMG9","CERS6" -"UniProt:Q8TD16","BICD2" -"UniProt:Q9UBD3","XCL2" -"UniProt:Q9H0E7","USP44" -"UniProt:Q77PU6","U90" -"UniProt:Q86XR2","FAM129C" -"UniProt:P35251","RFC1" -"UniProt:P32354","MCM10" -"UniProt:Q9NQ36","SCUBE2" -"UniProt:Q16552","IL17A" -"UniProt:Q14956","GPNMB" -"UniProt:O95994","AGR2" -"UniProt:Q9BXT4","TDRD1" -"UniProt:Q9NW38","FANCL" -"UniProt:P53296","ATF2" -"UniProt:P41499","Ptpn11" -"UniProt:Q96JN2","CCDC136" -"UniProt:Q8TBY8","PMFBP1" -"UniProt:Q15637","SF01" -"UniProt:P08034","GJB1" -"UniProt:Q6IPU0","CENPP" -"UniProt:Q8IWA4","MFN1" -"UniProt:Q9Y5X2","SNX8" -"UniProt:P78348","ASIC1" -"UniProt:Q9BQ69","MACD1" -"UniProt:Q8IZ20","ZNF683" -"UniProt:Q9R044","Nphs1" -"UniProt:P22749","GNLY" -"UniProt:Q6PHR2","ULK3" -"UniProt:Q99932","SPAG8" -"UniProt:P09758","TACSTD2" -"UniProt:Q70IA8","MOB3C" -"UniProt:Q9H1K0","RBSN" -"UniProt:Q9H9Y2","RPF1" -"UniProt:Q3KNW1","SNAI3" -"UniProt:Q06481","APLP2" -"UniProt:G5E962","G5E962" -"UniProt:O15131","IMA6" -"UniProt:Q99439","CNN2" -"UniProt:Q9UBR4","LHX3" -"UniProt:Q96JS3","PGBD1" -"UniProt:Q9NRS6","SNX15" -"UniProt:P11049","CD37" -"UniProt:P15172","MYOD1" -"UniProt:Q9NTW7","ZF64B" -"UniProt:Q6T4R5","NHS" -"UniProt:Q8WVC0","LEO1" -"UniProt:P68106","FKBP1B" -"UniProt:Q03981","CSN9" -"UniProt:Q86XJ5","Q86XJ5" -"UniProt:Q9ULW3","ABT1" -"UniProt:Q9H7X3","ZN696" -"UniProt:Q8WVI0","SMIM4" -"UniProt:P17980","PRS6A" -"UniProt:Q62747","SYT7" -"UniProt:Q8WUU8","TM174" -"UniProt:Q7L8J4","3BP5L" -"UniProt:Q8N1N4","K2C78" -"UniProt:P08754","GNAI3" -"UniProt:Q8N4L4","SPEM1" -"UniProt:P52164","MAX" -"UniProt:Q03860","TVP15" -"UniProt:Q8NHH9","ATL2" -"UniProt:Q9HB07","MYG1" -"UniProt:Q9UFD9","RIM3A" -"UniProt:Q9NZH8","IL36G" -"UniProt:Q12972","PPP1R8" -"UniProt:P51178","PLCD1" -"UniProt:O60422","ONECUT3" -"UniProt:Q96EP0","RNF31" -"UniProt:P22415","USF1" -"UniProt:Q8N4P3","HDDC3" -"UniProt:O96019","ACL6A" -"UniProt:Q9BX10","GTPB2" -"UniProt:Q9BZJ0","CRNKL1" -"UniProt:O75167","PHACTR2" -"UniProt:Q96LT7","C9orf72" -"UniProt:Q92569","P55G" -"UniProt:Q8WUM4","PDCD6IP" -"UniProt:Q8NBT3","TMEM145" -"UniProt:Q9HB29","IL1RL2" -"UniProt:Q8TD17","ZN398" -"UniProt:Q9NWZ3","IRAK4" -"UniProt:Q9BW71","HIRIP3" -"UniProt:P43119","PTGIR" -"UniProt:P83731","RL24" -"UniProt:P55199","ELL" -"UniProt:Q9BV36","MLPH" -"UniProt:Q15388","TOMM20" -"UniProt:Q9GZM7","TINAGL1" -"UniProt:P48051","KCNJ6" -"UniProt:Q9NXE8","CWC25" -"UniProt:Q9HCN8","SDF2L1" -"UniProt:O75352","MPDU1" -"UniProt:Q13191","CBLB" -"UniProt:P58335","ANTXR2" -"UniProt:Q9BSM1","PCGF1" -"UniProt:Q86VE3","SATL1" -"UniProt:O43283","MAP3K13" -"UniProt:Q7Z309","FAM122B" -"UniProt:O00469","PLOD2" -"UniProt:Q3MIX3","ADCK5" -"UniProt:Q9BRX5","PSF3" -"UniProt:O15060","ZBT39" -"UniProt:P04585","GAG-POL" -"UniProt:Q30154","HLA-DRB5" -"UniProt:Q8TAP8","PPP1R35" -"UniProt:O43614","HCRTR2" -"UniProt:O75182","SIN3B" -"UniProt:Q9FD10","SSEJ" -"UniProt:Q12948","FOXC1" -"UniProt:Q969Q4","ARL11" -"UniProt:P52789","HXK2" -"UniProt:Q2Y0W8","SLC4A8" -"UniProt:Q8ND94","LRRN4CL" -"UniProt:P35243","RCVRN" -"UniProt:Q96H43","Q96H43" -"UniProt:Q9GZU8","FAM192A" -"UniProt:Q2TAL6","VWC2" -"UniProt:O43281","EFS" -"UniProt:Q6PL24","TMED8" -"UniProt:O15287","FANCG" -"UniProt:P23416","GLRA2" -"UniProt:Q7Z340","ZNF551" -"UniProt:Q9Y5W5","WIF1" -"UniProt:P04040","CAT" -"UniProt:A0A0A0MR80","A0A0A0MR80" -"UniProt:P35249","RFC4" -"UniProt:Q7Z5Q1","CPEB2" -"UniProt:O95751","LDOC1" -"UniProt:Q9BSD7","NTPCR" -"UniProt:Q9NZN3","EHD3" -"UniProt:Q8N8W4","PNPLA1" -"UniProt:Q9H2X0","CHRD" -"UniProt:Q9Y5W9","SNX11" -"UniProt:Q6QAJ8","TMEM220" -"UniProt:Q15973","ZNF124" -"UniProt:O15068","MCF2L" -"UniProt:Q6U736","OPN5" -"UniProt:Q96FT9","IFT43" -"UniProt:Q9DH70","Q9DH70" -"UniProt:Q00973","B4GALNT1" -"UniProt:Q9NVI7","ATAD3A" -"UniProt:A6NJ78","METTL15" -"UniProt:Q2M3G0","ABCB5" -"UniProt:P19214","eba-175" -"UniProt:Q9H869","YY1AP1" -"UniProt:O43823","AKAP8" -"UniProt:Q96KK3","KCNS1" -"UniProt:Q8IWV2","CNTN4" -"UniProt:Q9HCU5","PREB" -"UniProt:Q8BG26","RUSC1" -"UniProt:Q9UKM9","RALY" -"UniProt:Q9BQ24","ZFY21" -"UniProt:Q7Z6W1","TMCO2" -"UniProt:Q99447","PCYT2" -"UniProt:Q9GZR7","DDX24" -"UniProt:P13533","MYH6" -"UniProt:Q6IEG0","SNRNP48" -"UniProt:Q8IX19","MCEM1" -"UniProt:P58317","ZN121" -"UniProt:O60245","PCDH7" -"UniProt:Q59EK9","RUNDC3A" -"UniProt:P03070","LT" -"UniProt:Q9Y287","ITM2B" -"UniProt:P12612","TCPA" -"UniProt:P62195","PRS8" -"UniProt:Q15428","SF3A2" -"UniProt:Q6ZV29","PNPLA7" -"UniProt:Q96PB7","OLFM3" -"UniProt:Q8WXQ8","CPA5" -"UniProt:A0A0C4DGW6","A0A0C4DGW6" -"UniProt:Q86Y38","XYLT1" -"UniProt:Q9NNW5","WDR6" -"UniProt:Q5VU62","Q5VU62" -"UniProt:Q8IUY3","GRAM2" -"UniProt:P68510","Ywhah" -"UniProt:Q8IWU2","LMTK2" -"UniProt:Q8WZ55","BSND" -"UniProt:Q9BQG0","MBB1A" -"UniProt:Q96S94","CCNL2" -"UniProt:O95848","NUDT14" -"UniProt:O60844","ZG16" -"UniProt:Q9H115","SNAB" -"UniProt:Q53GA4","PHLDA2" -"UniProt:O35587","TMEDA" -"UniProt:P20393","NR1D1" -"UniProt:Q92616","GCN1" -"UniProt:Q717R9","CYS1" -"UniProt:P0C2S0","CTXN2" -"UniProt:P03204","EBNA6" -"UniProt:P68104","EF1A1" -"UniProt:Q9NXG6","P4HTM" -"UniProt:P79114","MYO10" -"UniProt:P78337","PITX1" -"UniProt:Q96E66","LRTOMT" -"UniProt:Q9UNS2","CSN3" -"UniProt:Q7Z7E8","UB2Q1" -"UniProt:Q6PIA0","Q6PIA0" -"UniProt:Q96MI9","AGBL1" -"UniProt:Q6ZU35","KIAA1211" -"UniProt:Q9H3U7","SMOC2" -"UniProt:Q9Y6F6","MRVI1" -"UniProt:Q96BP3","PPWD1" -"UniProt:Q96G46","DUS3L" -"UniProt:Q13315","ATM" -"UniProt:Q9P267","MBD5" -"UniProt:O15146","MUSK" -"UniProt:Q9NSY1","BMP2K" -"UniProt:Q6UXV1","IZUMO2" -"UniProt:Q8N163","CCAR2" -"UniProt:E7ERA6","RNF223" -"UniProt:O75925","PIAS1" -"UniProt:Q9UM63","PLAGL1" -"UniProt:P07098","LIPF" -"UniProt:Q3KQU3","MA7D1" -"UniProt:O60701","UGDH" -"UniProt:Q9H0J9","PARP12" -"UniProt:P24278","ZBT25" -"UniProt:Q9Z2D6","MECP2" -"UniProt:P09960","LTA4H" -"UniProt:Q92954","PRG4" -"UniProt:Q96AQ2","TMEM125" -"UniProt:Q9BR09","NEURL2" -"UniProt:Q9H1C7","CYSTM1" -"UniProt:Q86TG1","TMEM150A" -"UniProt:Q7Z4V5","HDGR2" -"UniProt:Q9NWU2","GID8" -"UniProt:Q9UKA8","RCAN3" -"UniProt:Q13702","RAPSN" -"UniProt:Q9H361","PABP3" -"UniProt:Q8WVP7","LMBR1" -"UniProt:P0C7T8","TMEM253" -"UniProt:P78358","CTG1B" -"UniProt:P11716","RYR1" -"UniProt:A7MBM2","DISP2" -"UniProt:O75888","TNFSF13" -"UniProt:Q9HCK0","ZBT26" -"UniProt:Q96PC5","MIA2" -"UniProt:Q96NU7","AMDHD1" -"UniProt:Q7RTU1","TCF23" -"UniProt:Q9H267","VPS33B" -"UniProt:Q15198","PDGFRL" -"UniProt:O94919","ENDOD1" -"UniProt:P15085","CPA1" -"UniProt:Q99944","EGFL8" -"UniProt:P05877","env" -"UniProt:O00481","BTN3A1" -"UniProt:Q8IX30","SCUB3" -"UniProt:O43290","SNUT1" -"UniProt:P09919","CSF3" -"UniProt:Q5GJ75","TNFAIP8L3" -"UniProt:P04271","S100B" -"UniProt:P04608","TAT" -"UniProt:A6NNN8","SLC38A8" -"UniProt:P51965","UBE2E1" -"UniProt:Q8WWF1","C1orf54" -"UniProt:Q8NC51","PAIRB" -"UniProt:P31641","SLC6A6" -"UniProt:Q15782","CHI3L2" -"UniProt:Q9H4M3","FBXO44" -"UniProt:Q6UB98","ANKRD12" -"UniProt:Q5VY80","RAET1L" -"UniProt:Q12846","STX4" -"UniProt:P03407","NEF" -"UniProt:Q6SZW1","SARM1" -"UniProt:Q92859","NEO1" -"UniProt:Q15646","OASL" -"UniProt:Q9UL17","TBX21" -"UniProt:Q14681","KCTD2" -"UniProt:Q9H1H9","KIF13A" -"UniProt:Q8TDW4","ST7L" -"UniProt:Q9H0R6","QRSL1" -"UniProt:Q02790","FKBP4" -"UniProt:Q91132","VCO3" -"UniProt:P30043","BLVRB" -"UniProt:Q13253","NOG" -"UniProt:Q9Y5P1","OR51B2" -"UniProt:Q8N1G4","LRRC47" -"UniProt:Q9CR42","ANKR1" -"UniProt:O14578","CIT" -"UniProt:Q8N8D7","NKAIN3" -"UniProt:Q6UUV7","CRTC3" -"UniProt:P05089","ARG1" -"UniProt:Q6P1K1","SLC48A1" -"UniProt:Q8ND24","RNF214" -"UniProt:Q8NGB2","OR4C5" -"UniProt:P04908","HIST1H2AE" -"UniProt:Q5JTV8","TOR1AIP1" -"UniProt:O95389","WISP3" -"UniProt:Q8IWZ4","TRIM48" -"UniProt:Q8IWI9","MGAP" -"UniProt:P78362","SRPK2" -"UniProt:P46926","GNPDA1" -"UniProt:Q16828","DUSP6" -"UniProt:P38868","YHY0" -"UniProt:O43524","FOXO3" -"UniProt:Q68BL7","OLFML2A" -"UniProt:Q9H293","IL25" -"UniProt:O75417","POLQ" -"UniProt:Q643R0","Q643R0" -"UniProt:Q3LI73","KRTAP19-4" -"UniProt:O95169","NDUFB8" -"UniProt:Q8IZS5","OFCC1" -"UniProt:P11464","PSG1" -"UniProt:Q86SE9","PCGF5" -"UniProt:Q9UGI0","ZRANB1" -"UniProt:Q9BV57","ADI1" -"UniProt:O60760","HPGDS" -"UniProt:P40198","CEACAM3" -"UniProt:P26954","IL3B2" -"UniProt:P04424","ASL" -"UniProt:O95544","NADK" -"UniProt:P61236","YPEL3" -"UniProt:Q8IZS8","CACNA2D3" -"UniProt:Q9GZY8","MFF" -"UniProt:Q9BVA1","TUBB2B" -"UniProt:Q9DLK6","Q9DLK6" -"UniProt:P02585","TNNC2" -"UniProt:P50284","TNR3" -"UniProt:Q96CF2","CHM4C" -"UniProt:Q8IWG5","Q8IWG5" -"UniProt:P07910","HNRPC" -"UniProt:Q9NP71","MLXIPL" -"UniProt:Q9UBP6","METTL1" -"UniProt:Q9BZR9","TRIM8" -"UniProt:Q99608","NDN" -"UniProt:P40446","YIQ5" -"UniProt:O95528","SLC2A10" -"UniProt:Q9H607","OCEL1" -"UniProt:Q9Y2F9","BTBD3" -"UniProt:Q8WXS3","BAALC" -"UniProt:Q9H2X6","HIPK2" -"UniProt:Q15113","PCOC1" -"UniProt:O08736","CASPC" -"UniProt:Q6IAN0","DHRS7B" -"UniProt:A8MX34","KRTAP29-1" -"UniProt:P0C7X5","ZNF806" -"UniProt:Q8WUT9","SLC25A43" -"UniProt:A6NED2","RCCD1" -"UniProt:Q9NSB4","KRT82" -"UniProt:Q17RS7","GEN1" -"UniProt:Q6P2I3","FAHD2B" -"UniProt:P28062","PSMB8" -"UniProt:Q9BYE7","PCGF6" -"UniProt:Q68EM7","ARHGAP17" -"UniProt:Q76TK5","Q76TK5" -"UniProt:Q9H4S2","GSX1" -"UniProt:Q08050","FOXM1" -"UniProt:Q96EY7","PTCD3" -"UniProt:P07307","ASGR2" -"UniProt:Q9JLY0","SOCS6" -"UniProt:Q9UKV3","ACINU" -"UniProt:Q7Z6L0","PRRT2" -"UniProt:P51805","PLXNA3" -"UniProt:P55058","PLTP" -"UniProt:Q08397","LOXL1" -"UniProt:Q6L8Q7","PDE12" -"UniProt:Q96HP8","TMEM176A" -"UniProt:Q29718","HLA-B" -"UniProt:Q9UHD2","TBK1" -"UniProt:Q8NHS3","MFSD8" -"UniProt:Q9NP90","RAB9B" -"UniProt:Q9UBK9","UXT" -"UniProt:P05162","LEG2" -"UniProt:Q5VZ19","TDRD10" -"UniProt:Q9H427","KCNK15" -"UniProt:Q0VDD7","CS057" -"UniProt:Q5JS13","RALGPS1" -"UniProt:P32453","ATP11" -"UniProt:P04920","SLC4A2" -"UniProt:Q9Y4D8","HECTD4" -"UniProt:A0A0A0MT77","A0A0A0MT77" -"UniProt:P05160","F13B" -"UniProt:Q5T870","PRR9" -"UniProt:P05120","SERPINB2" -"UniProt:Q15526","SURF1" -"UniProt:P54886","ALDH18A1" -"UniProt:Q9NZC3","GDE1" -"UniProt:P53845","YIF1" -"UniProt:Q96EP1","CHFR" -"UniProt:Q96MK2","RIPR3" -"UniProt:Q5T2D3","OTUD3" -"UniProt:Q02641","CACNB1" -"UniProt:Q8N183","NDUFAF2" -"UniProt:O00483","NDUFA4" -"UniProt:Q5U3C3","TMEM164" -"UniProt:Q8NFA0","UBP32" -"UniProt:I3L3J2","I3L3J2" -"UniProt:Q16795","NDUFA9" -"UniProt:Q9BSH4","TACO1" -"UniProt:Q9H228","S1PR5" -"UniProt:O75688","PPM1B" -"UniProt:Q92685","ALG3" -"UniProt:P12955","PEPD" -"UniProt:Q8IVI9","NOSTN" -"UniProt:Q15768","EFNB3" -"UniProt:Q63481","RAB7L" -"UniProt:O00217","NDUFS8" -"UniProt:Q8IZS6","TCTE3" -"UniProt:Q9BY67","CADM1" -"UniProt:O15318","POLR3G" -"UniProt:Q8TCX1","DYNC2LI1" -"UniProt:Q99442","SEC62" -"UniProt:A6NN14","ZNF729" -"UniProt:A6NI73","LILRA5" -"UniProt:Q02363","ID2" -"UniProt:P35659","DEK" -"UniProt:Q9H213","MAGH1" -"UniProt:P03897","ND3" -"UniProt:Q9Y2Q0","ATP8A1" -"UniProt:O75594","PGLYRP1" -"UniProt:Q9Y285","FARSA" -"UniProt:Q9UIK4","DAPK2" -"UniProt:P40087","DDI1" -"UniProt:Q9BYV2","TRI54" -"UniProt:Q9UN79","SOX13" -"UniProt:Q9Y3V2","RWDD3" -"UniProt:P78504","JAG1" -"UniProt:Q9H2C0","GAN" -"UniProt:Q9UBW5","BIN2" -"UniProt:Q08357","SLC20A2" -"UniProt:P04819","DNLI1" -"UniProt:Q7RTV0","PHF5A" -"UniProt:Q12891","HYAL2" -"UniProt:Q86UA3","Q86UA3" -"UniProt:P70218","M4K1" -"UniProt:Q96CD0","FBXL8" -"UniProt:P04046","PUR1" -"UniProt:Q9NZK5","ADA2" -"UniProt:P48201","ATP5G3" -"UniProt:C9JH25","PRRT4" -"UniProt:Q8WXI4","ACOT11" -"UniProt:Q9NZD2","GLTP" -"UniProt:O75251","NDUFS7" -"UniProt:P12104","FABP2" -"UniProt:Q9H8Y1","VRTN" -"UniProt:P0CE72","ONCO" -"UniProt:Q9BZ95","NSD3" -"UniProt:Q6UXN2","TREML4" -"UniProt:Q05048","CSTF1" -"UniProt:O60294","TYW4" -"UniProt:Q7Z7G2","CPLX4" -"UniProt:Q8WTW4","NPRL2" -"UniProt:Q96NS8","CLUP3" -"UniProt:O14924","RGS12" -"UniProt:Q9UH03","SEPT3" -"UniProt:P22692","IGFBP4" -"UniProt:Q8WU03","GLYATL2" -"UniProt:Q5D0E6","DALD3" -"UniProt:C9JBD0","KRBOX1" -"UniProt:Q9Y2H9","MAST1" -"UniProt:Q9BXJ1","C1QTNF1" -"UniProt:O15240","VGF" -"UniProt:P0CW00","TSPY8" -"UniProt:Q9P1W8","SIRPG" -"UniProt:P07099","EPHX1" -"UniProt:P00709","LALBA" -"UniProt:P50579","METAP2" -"UniProt:Q96MR9","ZNF560" -"UniProt:Q96BN8","OTULIN" -"UniProt:Q12417","PRP46" -"UniProt:Q2T9L4","CO059" -"UniProt:P29353","SHC1" -"UniProt:Q68DV7","RNF43" -"UniProt:Q9Y376","CAB39" -"UniProt:A2RUB6","CCDC66" -"UniProt:O60725","ICMT" -"UniProt:Q6ZVA0","Q6ZVA0" -"UniProt:Q9H0H3","KLHL25" -"UniProt:Q9Y6A4","CFA20" -"UniProt:Q9BX79","STRA6" -"UniProt:Q5ZPR3","CD276" -"UniProt:P01601","IGKV1D-16" -"UniProt:P61204","ARF3" -"UniProt:Q86VE0","MYPOP" -"UniProt:Q9H2F3","HSD3B7" -"UniProt:Q5NV66","IGLV2-33" -"UniProt:Q9Y6A2","CYP46A1" -"UniProt:Q9NUP1","BLOC1S4" -"UniProt:P26371","KRA59" -"UniProt:P58658","EVA1C" -"UniProt:Q9BXI9","C1QTNF6" -"UniProt:A6NKD9","CC85C" -"UniProt:P40189","IL6RB" -"UniProt:P36405","ARL3" -"UniProt:O60504","VINEX" -"UniProt:Q9UID6","ZN639" -"UniProt:O88900","GRB14" -"UniProt:Q68871","Q68871" -"UniProt:Q9BVC4","MLST8" -"UniProt:Q8WYA6","CTNNBL1" -"UniProt:Q5T753","LCE1E" -"UniProt:O43572","AKAP10" -"UniProt:Q9UEU0","VTI1B" -"UniProt:Q9P0W2","HM20B" -"UniProt:P01135","TGFA" -"UniProt:Q17RW2","COL24A1" -"UniProt:Q52M93","ZNF585B" -"UniProt:Q9NUL7","DDX28" -"UniProt:Q14162","SREC" -"UniProt:A1L0U7","A1L0U7" -"UniProt:O14802","POLR3A" -"UniProt:Q9Y3E7","CHMP3" -"UniProt:O60861","GAS7" -"UniProt:Q5TA76","LCE3A" -"UniProt:A1L3A9","A1L3A9" -"UniProt:A0A0C4DFN0","A0A0C4DFN0" -"UniProt:Q9Y6C2","EMILIN1" -"UniProt:Q86SF2","GALNT7" -"UniProt:Q8N4C7","STX19" -"UniProt:Q7Z3Y9","K1C26" -"UniProt:O95259","KCNH1" -"UniProt:Q15435","PP1R7" -"UniProt:Q8TDN6","BRIX1" -"UniProt:Q9UIJ5","ZDHHC2" -"UniProt:Q95604","HLA-C" -"UniProt:O95782","AP2A1" -"UniProt:Q06124","PTPN11" -"UniProt:O14896","IRF6" -"UniProt:Q96B36","AKT1S1" -"UniProt:Q8N9R8","SCAI" -"UniProt:P59045","NLRP11" -"UniProt:Q3U108","ARI5A" -"UniProt:P16989","YBOX3" -"UniProt:Q9UJM8","HAO1" -"UniProt:Q8NEY1","NAV1" -"UniProt:P48775","TDO2" -"UniProt:Q9DBR0","AKAP8" -"UniProt:Q9BSG5","RTBDN" -"UniProt:Q9BXJ4","C1QTNF3" -"UniProt:Q08981","ACM1" -"UniProt:P13284","GILT" -"UniProt:Q02224","CENPE" -"UniProt:Q13467","FZD5" -"UniProt:Q6AZZ1","TRIM68" -"UniProt:Q9ULI2","RIMKLB" -"UniProt:O75818","RPP40" -"UniProt:Q6IBN1","Q6IBN1" -"UniProt:Q9BY27","DGC6L" -"UniProt:Q8TAQ5","ZN420" -"UniProt:Q3LI68","KRTAP22-2" -"UniProt:P41180","CASR" -"UniProt:P50452","SERPINB8" -"UniProt:Q9UPY3","DICER1" -"UniProt:Q9UIL1","SCOC" -"UniProt:Q9NPA5","ZF64A" -"UniProt:Q14032","BAAT" -"UniProt:Q86XX4","FRAS1" -"UniProt:Q9H0R4","HDHD2" -"UniProt:Q15020","SART3" -"UniProt:Q16644","MAPKAPK3" -"UniProt:Q8N0Z3","SPICE" -"UniProt:Q53NU3","Q53NU3" -"UniProt:B6SEH8","ERVV-1" -"UniProt:Q99611","SEPHS2" -"UniProt:P35247","SFTPD" -"UniProt:O75674","TM1L1" -"UniProt:Q5JXX7","TMM31" -"UniProt:A0A087WWA7","A0A087WWA7" -"UniProt:Q9Y6K5","OAS3" -"UniProt:Q5TA78","LCE4A" -"UniProt:Q86Y79","PTH" -"UniProt:Q8N0U8","VKORC1L1" -"UniProt:P42025","ACTR1B" -"UniProt:Q6NUJ2","CK087" -"UniProt:O76041","NEBL" -"UniProt:P41252","IARS" -"UniProt:Q9NYY1","IL20" -"UniProt:P14923","JUP" -"UniProt:Q6P1A2","LPCAT3" -"UniProt:Q9UBT3","DKK4" -"UniProt:Q14146","URB2" -"UniProt:Q9UGL9","CRCT1" -"UniProt:O95258","SLC25A14" -"UniProt:Q6ZPD8","DGAT2L6" -"UniProt:Q5VYV0","FOXB2" -"UniProt:Q9BUN8","DERL1" -"UniProt:P43004","SLC1A2" -"UniProt:Q8N5I2","ARRD1" -"UniProt:Q03181","PPARD" -"UniProt:Q06547","GABP1" -"UniProt:Q9NWT1","PK1IP" -"UniProt:Q92730","RND1" -"UniProt:P17050","NAGA" -"UniProt:Q8IXY8","PPIL6" -"UniProt:O15514","POLR2D" -"UniProt:Q9Y4I1","MYO5A" -"UniProt:Q96FW1","OTUB1" -"UniProt:P25233","NECD" -"UniProt:Q504Y2","PKDCC" -"UniProt:Q8TF64","GIPC3" -"UniProt:Q9NQX3","GPHN" -"UniProt:O95140","MFN2" -"UniProt:O00238","BMPR1B" -"UniProt:Q9UHD9","UBQLN2" -"UniProt:P03346","GAG" -"UniProt:Q63932","MP2K2" -"UniProt:Q3LI64","KRA61" -"UniProt:Q6PIU1","KCNV1" -"UniProt:O75165","DNAJC13" -"UniProt:A0A0C4DFT9","A0A0C4DFT9" -"UniProt:Q9H2G4","TSPYL2" -"UniProt:P26374","CHML" -"UniProt:Q6MZT1","RGS7BP" -"UniProt:Q13867","BLMH" -"UniProt:O60925","PFD1" -"UniProt:Q96N21","AP4AT" -"UniProt:Q9NVG8","TBC1D13" -"UniProt:P98170","XIAP" -"UniProt:Q9BSH5","HDHD3" -"UniProt:P13942","COL11A2" -"UniProt:Q9Y5R4","HEMK1" -"UniProt:A4FTV9","A4FTV9" -"UniProt:P03466","NP" -"UniProt:Q5VTT5","MYOM3" -"UniProt:Q9BSW2","CRACR2A" -"UniProt:Q9Y276","BCS1L" -"UniProt:P25205","MCM3" -"UniProt:Q9UK12","ZNF222" -"UniProt:Q9Y3A4","RRP7A" -"UniProt:Q53GT1","KLHL22" -"UniProt:Q8WUT4","LRRN4" -"UniProt:P22531","SPRR2E" -"UniProt:P23441","NKX21" -"UniProt:Q86YI8","PHF13" -"UniProt:Q9H7R0","ZNF442" -"UniProt:Q86SX3","CN080" -"UniProt:P04229","HLA-DRB1" -"UniProt:Q9BYC8","MRPL32" -"UniProt:O13539","THP2" -"UniProt:P06899","HIST1H2BJ" -"UniProt:P20273","CD22" -"UniProt:Q10586","DBP" -"UniProt:O14986","PIP5K1B" -"UniProt:O95759","TBC1D8" -"UniProt:Q9UQB8","BAIP2" -"UniProt:Q9P2J8","ZN624" -"UniProt:P36382","GJA5" -"UniProt:Q9H3C7","GGNBP2" -"UniProt:A6NFR6","C5ORF60" -"UniProt:Q8NBQ5","HSD17B11" -"UniProt:Q9ULJ7","ANKRD50" -"UniProt:Q719H9","KCTD1" -"UniProt:P07814","SYEP" -"UniProt:O75844","ZMPSTE24" -"UniProt:Q13509","TUBB3" -"UniProt:P59539","TAS2R45" -"UniProt:O95049","TJP3" -"UniProt:Q8N859","ZNF713" -"UniProt:P80297","MT1X" -"UniProt:Q8TAG6","C8orf46" -"UniProt:Q16206","ENOX2" -"UniProt:Q9P275","USP36" -"UniProt:Q9Y575","ASB3" -"UniProt:Q14157","UBAP2L" -"UniProt:Q9UJJ7","RPUSD1" -"UniProt:P27816","MAP4" -"UniProt:A0A1B0GVH4","PRSS51" -"UniProt:P32298","GRK4" -"UniProt:Q969K7","TMM54" -"UniProt:Q6RVD6","SPAT8" -"UniProt:P16615","ATP2A2" -"UniProt:P62081","RPS7" -"UniProt:P61571","ERVK-21" -"UniProt:O43309","ZSC12" -"UniProt:Q9H5N1","RABE2" -"UniProt:Q9ULU4","ZMYND8" -"UniProt:P23471","PTPRZ1" -"UniProt:Q9Y6K0","CEPT1" -"UniProt:Q9Y2K1","ZBTB1" -"UniProt:Q96PE5","OPALIN" -"UniProt:Q9WVH4","FOXO3" -"UniProt:P38260","FES1" -"UniProt:P02795","MT2A" -"UniProt:Q9GZT3","SLIRP" -"UniProt:P51587","BRCA2" -"UniProt:Q10981","FUT2" -"UniProt:Q9H469","FBXL15" -"UniProt:Q8WVX3","C4ORF3" -"UniProt:Q7Z7B8","DEFB128" -"UniProt:Q9UK80","USP21" -"UniProt:P55001","MFAP2" -"UniProt:P61570","ERVK-25" -"UniProt:Q9UGN4","CD300A" -"UniProt:A4IF30","SLC35F4" -"UniProt:Q6KB66","KRT80" -"UniProt:P78332","RBM6" -"UniProt:Q80ZW7","Q80ZW7" -"UniProt:P28907","CD38" -"UniProt:Q8IZ63","PRR22" -"UniProt:O75051","PLXNA2" -"UniProt:Q9HAW9","UGT1A8" -"UniProt:Q15415","RBY1F" -"UniProt:Q8WWM1","XAGE5" -"UniProt:Q6ZT07","TBC1D9" -"UniProt:Q5JQC9","AKAP4" -"UniProt:Q9NWR8","MCUB" -"UniProt:Q5T5Y3","CAMSAP1" -"UniProt:Q9BRR8","GPATCH1" -"UniProt:Q9UEY8","ADD3" -"UniProt:Q14940","SLC9A5" -"UniProt:Q8IYU8","MICU2" -"UniProt:O75795","UGT2B17" -"UniProt:Q30KP8","DEFB136" -"UniProt:Q53HC9","EIPR1" -"UniProt:Q9BQI4","CCDC3" -"UniProt:O00160","MYO1F" -"UniProt:Q12860","CNTN1" -"UniProt:Q5TYM5","FAM72A" -"UniProt:F4ZW62","F4ZW62" -"UniProt:P32321","DCTD" -"UniProt:Q96GS6","AB17A" -"UniProt:Q9GZW8","MS4A7" -"UniProt:P17041","ZNF32" -"UniProt:Q92990","GLMN" -"UniProt:P60413","KRTAP10-12" -"UniProt:P35236","PTPN7" -"UniProt:P21605","E3" -"UniProt:Q8WWC4","C2orf47" -"UniProt:Q9HAU4","SMURF2" -"UniProt:Q14554","PDIA5" -"UniProt:Q9BUM1","G6PC3" -"UniProt:O75106","AOC2" -"UniProt:P0DMV9","HSPA1B" -"UniProt:Q8NH90","OR5AK2" -"UniProt:P11509","CYP2A6" -"UniProt:Q8WY91","THAP4" -"UniProt:Q99848","EBNA1BP2" -"UniProt:Q9H0R1","AP5M1" -"UniProt:Q96K58","ZNF668" -"UniProt:Q8IXR9","C12orf56" -"UniProt:Q9Y2E6","DTX4" -"UniProt:Q5JQS6","GCSAML" -"UniProt:Q495M3","SLC36A2" -"UniProt:Q5VW00","DCAF12L2" -"UniProt:Q9NRE1","MMP26" -"UniProt:P02765","AHSG" -"UniProt:P15328","FOLR1" -"UniProt:Q9BYX2","TBC1D2" -"UniProt:Q96GX9","MTNB" -"UniProt:B2R9H7","B2R9H7" -"UniProt:Q08211","DHX9" -"UniProt:P62913","RPL11" -"UniProt:Q9BRK4","LZTS2" -"UniProt:Q9NRF9","POLE3" -"UniProt:Q9H4I0","RAD21L1" -"UniProt:P22392","NME2" -"UniProt:Q9Y2E8","SL9A8" -"UniProt:P46777","RPL5" -"UniProt:O75533","SF3B1" -"UniProt:Q68EN5","KIAA0895L" -"UniProt:Q5T6M2","CF122" -"UniProt:Q8N8S7","ENAH" -"UniProt:A0A0C4DG94","A0A0C4DG94" -"UniProt:O00548","DLL1" -"UniProt:Q86SE5","RALYL" -"UniProt:A2RRH5","WDR27" -"UniProt:P31350","RIR2" -"UniProt:O14791","APOL1" -"UniProt:Q8IZ73","RPUSD2" -"UniProt:P30450","HLA-A" -"UniProt:Q96HC4","PDLIM5" -"UniProt:Q15751","HERC1" -"UniProt:P61567","ERVK-7" -"UniProt:Q8TC90","CCER1" -"UniProt:A0A0C4DGW7","A0A0C4DGW7" -"UniProt:Q8N8D1","PDCD7" -"UniProt:P17097","ZNF7" -"UniProt:Q6L8H4","KRA51" -"UniProt:P19525","EIF2AK2" -"UniProt:Q9NWH2","TMEM242" -"UniProt:O95390","GDF11" -"UniProt:Q9BQ52","ELAC2" -"UniProt:Q91YW3","DNJC3" -"UniProt:Q14571","ITPR2" -"UniProt:Q9NRP7","STK36" -"UniProt:Q5EBM0","CMPK2" -"UniProt:Q969Y2","GTPBP3" -"UniProt:P46684","ZIC1" -"UniProt:Q96JX3","SERAC1" -"UniProt:Q8WZ75","ROBO4" -"UniProt:O14979","HNRNPDL" -"UniProt:Q9NWZ8","GEMIN8" -"UniProt:O76087","GAGE12I" -"UniProt:Q8NEZ4","KMT2C" -"UniProt:Q2TBF2","WSCD2" -"UniProt:Q8IUW3","SPATA2L" -"UniProt:Q02127","DHODH" -"UniProt:O95025","SEMA3D" -"UniProt:Q96KP4","CNDP2" -"UniProt:Q96ER9","CCDC51" -"UniProt:O75828","CBR3" -"UniProt:Q6ZVW3","Q6ZVW3" -"UniProt:Q96RI1","NR1H4" -"UniProt:Q7RTS3","PTF1A" -"UniProt:Q02930","CREB5" -"UniProt:Q9Y5U8","MPC1" -"UniProt:Q86XE3","MICU3" -"UniProt:A6NNT2","C16orf96" -"UniProt:Q85601","REX" -"UniProt:Q9BXA5","SUCNR1" -"UniProt:Q9NW07","ZNF358" -"UniProt:A6NFQ7","DPRX" -"UniProt:Q5T3J3","LRIF1" -"UniProt:Q9GZT9","EGLN1" -"UniProt:P60468","SC61B" -"UniProt:Q5TGL8","PXDC1" -"UniProt:Q92908","GATA6" -"UniProt:Q9H1K6","MESD1" -"UniProt:Q2VPK5","CTU2" -"UniProt:O00400","SLC33A1" -"UniProt:Q8N6D2","RNF182" -"UniProt:Q8IUC0","KRTAP13-1" -"UniProt:Q13423","NNT" -"UniProt:Q8N142","ADSSL1" -"UniProt:Q6ZWT7","MBOAT2" -"UniProt:O60260","PRKN" -"UniProt:Q8WW43","APH1B" -"UniProt:Q9UM19","HPCL4" -"UniProt:P04632","CAPNS1" -"UniProt:Q96MT8","CEP63" -"UniProt:Q15572","TAF1C" -"UniProt:P21359","NF1" -"UniProt:Q6NUM9","RETSAT" -"UniProt:Q9UNP4","ST3GAL5" -"UniProt:Q6NT52","CGB2" -"UniProt:P31995","FCGR2C;FCGR2B" -"UniProt:Q8IU57","IFNLR1" -"UniProt:O75116","ROCK2" -"UniProt:O15054","KDM6B" -"UniProt:Q92878","RAD50" -"UniProt:P56696","KCNQ4" -"UniProt:Q96SJ8","TSPAN18" -"UniProt:Q92608","DOCK2" -"UniProt:Q2NKX9","CB068" -"UniProt:O60603","TLR2" -"UniProt:Q96SC8","DMRTA2" -"UniProt:P63166","Sumo1" -"UniProt:P22147","XRN1" -"UniProt:P07911","UMOD" -"UniProt:Q9NZ72","STMN3" -"UniProt:Q99633","PRP18" -"UniProt:Q9H6B4","CLMP" -"UniProt:P55209","NP1L1" -"UniProt:P48509","CD151" -"UniProt:P07602","PSAP" -"UniProt:O43897","TLL1" -"UniProt:Q53T94","TAF1B" -"UniProt:Q6NXT2","H3C" -"UniProt:P56704","WNT3A" -"UniProt:K4P3M7","K4P3M7" -"UniProt:P49753","ACOT2" -"UniProt:Q9Y3Q0","NAALAD2" -"UniProt:Q8WW01","TSEN15" -"UniProt:Q5VYY2","LIPM" -"UniProt:O95936","EOMES" -"UniProt:Q05923","DUSP2" -"UniProt:O75326","SEMA7A" -"UniProt:P05771","PRKCB" -"UniProt:Q9P2K6","KLH42" -"UniProt:Q6VVX0","CYP2R1" -"UniProt:Q9UKE5","TNIK" -"UniProt:Q8IVV2","LOXHD1" -"UniProt:P29401","TKT" -"UniProt:P30049","ATP5D" -"UniProt:Q5T686","AVPI1" -"UniProt:Q8ND71","GIMAP8" -"UniProt:Q99570","PI3R4" -"UniProt:Q8WYP3","RIN2" -"UniProt:Q8IW41","MAPKAPK5" -"UniProt:P36954","POLR2I" -"UniProt:Q9H2G9","GO45" -"UniProt:Q6UX72","B3GNT9" -"UniProt:Q9NVI1","FANCI" -"UniProt:Q9ULJ6","ZMIZ1" -"UniProt:O75648","TRMU" -"UniProt:O00116","AGPS" -"UniProt:Q9NQ50","RM40" -"UniProt:Q86YD5","LDLRAD3" -"UniProt:P10745","RBP3" -"UniProt:Q9NQX0","PRDM6" -"UniProt:P06454","PTMA" -"UniProt:Q12824","SMARCB1" -"UniProt:Q14781","CBX2" -"UniProt:Q15042","RAB3GAP1" -"UniProt:Q15363","TMED2" -"UniProt:Q86YN6","PPARGC1B" -"UniProt:Q9BX63","BRIP1" -"UniProt:Q5VWW1","C1QL3" -"UniProt:Q6P2Q9","PRPF8" -"UniProt:Q9Y2J2","EPB41L3" -"UniProt:Q9NWV8","BABAM1" -"UniProt:Q9NUA8","ZBTB40" -"UniProt:O14730","RIOK3" -"UniProt:P0C7W6","CCDC172" -"UniProt:P54284","CACB3" -"UniProt:Q9BTV6","DPH7" -"UniProt:E5LBV4","E5LBV4" -"UniProt:Q8N145","LGI3" -"UniProt:Q8N3J9","ZNF664" -"UniProt:Q9UGM1","CHRNA9" -"UniProt:Q14542","SLC29A2" -"UniProt:Q15573","TAF1A" -"UniProt:Q07869","PPARA" -"UniProt:P14653","HOXB1" -"UniProt:Q9UNW1","MINPP1" -"UniProt:P62760","VISL1" -"UniProt:Q86XM0","CATSPERD" -"UniProt:P55789","GFER" -"UniProt:Q9UHD8","SEPT9" -"UniProt:Q96DZ1","ERLEC1" -"UniProt:Q9NYY3","PLK2" -"UniProt:O95602","POLR1A" -"UniProt:O15392","BIRC5" -"UniProt:P49918","CDKN1C" -"UniProt:P35240","NF2" -"UniProt:Q86UY6","NAA40" -"UniProt:P50222","MEOX2" -"UniProt:Q9GZR5","ELOVL4" -"UniProt:Q8NCM8","DYNC2H1" -"UniProt:P15502","ELN" -"UniProt:P15692","VEGFA" -"UniProt:P51686","CCR9" -"UniProt:Q9BXY8","BEX2" -"UniProt:Q96RP9","GFM1" -"UniProt:Q92698","RAD54L" -"UniProt:P08572","COL4A2" -"UniProt:Q53H47","SETMAR" -"UniProt:Q9BY31","ZNF717" -"UniProt:Q6GPH4","XAF1" -"UniProt:Q99986","VRK1" -"UniProt:Q8TAA9","VANGL1" -"UniProt:Q9NXU5","ARL15" -"UniProt:Q8WXR4","MYO3B" -"UniProt:P02549","SPTA1" -"UniProt:Q01459","CTBS" -"UniProt:Q15599","NHRF2" -"UniProt:P25089","FPR3" -"UniProt:A0A0C4DGQ7","A0A0C4DGQ7" -"UniProt:Q8NFT2","STEAP2" -"UniProt:O15031","PLXB2" -"UniProt:G8B999","G8B999" -"UniProt:Q5K4E3","PRSS36" -"UniProt:O35253","SMAD7" -"UniProt:Q08509","EPS8" -"UniProt:Q9BWD1","ACAT2" -"UniProt:Q14410","GK2" -"UniProt:P46948","RRP41" -"UniProt:P03375","env" -"UniProt:P58062","ISK7" -"UniProt:Q7L1T6","CYB5R4" -"UniProt:Q5T5D7","ZNF684" -"UniProt:Q9HBG7","LY9" -"UniProt:Q9P1Y6","PHRF1" -"UniProt:Q92743","HTRA1" -"UniProt:Q8IY47","KBTBD2" -"UniProt:Q8VC66","ADIP" -"UniProt:P11597","CETP" -"UniProt:G8BCH3","G8BCH3" -"UniProt:P31345","PB2" -"UniProt:Q8NHJ6","LILRB4" -"UniProt:P20309","CHRM3" -"UniProt:Q13562","NEUROD1" -"UniProt:Q13291","SLAF1" -"UniProt:Q96JP5","ZFP91" -"UniProt:P07305","H1F0" -"UniProt:P63172","DYLT1" -"UniProt:Q9BZL1","UBL5" -"UniProt:Q8N9V6","ANKRD53" -"UniProt:Q03721","KCNC4" -"UniProt:Q6T310","RASL11A" -"UniProt:Q6P9A1","ZNF530" -"UniProt:P0C7A2","FAM153B" -"UniProt:Q6ZNC4","ZNF704" -"UniProt:Q8N7C0","LRC52" -"UniProt:P30443","HLA-A" -"UniProt:P57105","SYJ2B" -"UniProt:P52803","EFNA5" -"UniProt:O43791","SPOP" -"UniProt:Q8CFU8","T53I2" -"UniProt:Q8N441","FGFRL1" -"UniProt:P49116","NR2C2" -"UniProt:P19021","PAM" -"UniProt:Q9HCX4","TRPC7" -"UniProt:Q99698","LYST" -"UniProt:Q96PE3","INPP4A" -"UniProt:Q8IVM8","SLC22A9" -"UniProt:P21146","ARBK1" -"UniProt:P61296","HAND2" -"UniProt:P41235","HNF4A" -"UniProt:P05161","ISG15" -"UniProt:Q9BYJ1","ALOXE3" -"UniProt:Q01118","SCN7A" -"UniProt:Q15392","DHCR24" -"UniProt:Q07837","SLC3A1" -"UniProt:Q6ZMB5","TMEM184A" -"UniProt:P25298","RNA14" -"UniProt:Q9UHV2","SRTD1" -"UniProt:Q6PJP8","DCLRE1A" -"UniProt:Q9UBM8","MGAT4C" -"UniProt:P05164","MPO" -"UniProt:Q9NZM4","GLTSCR1" -"UniProt:Q8N474","SFRP1" -"UniProt:P22310","UGT1A4" -"UniProt:P0DJM0","inlA" -"UniProt:P21439","ABCB4" -"UniProt:P52945","PDX1" -"UniProt:O15360","FANCA" -"UniProt:Q14244","MAP7" -"UniProt:Q13591","SEMA5A" -"UniProt:P22001","KCNA3" -"UniProt:Q9NS00","C1GALT1" -"UniProt:A2RU56","A2RU56" -"UniProt:Q14409","GK3P" -"UniProt:Q8TAE7","KCNG3" -"UniProt:Q9BZD4","NUF2" -"UniProt:Q8TCJ2","STT3B" -"UniProt:P38151","PBP2" -"UniProt:Q8NBI6","XXYLT1" -"UniProt:Q8N8I0","SAMD12" -"UniProt:Q8IX03","WWC1" -"UniProt:O43674","NDUFB5" -"UniProt:Q6NS38","ALKBH2" -"UniProt:Q9UBY8","CLN8" -"UniProt:O75635","SERPINB7" -"UniProt:Q7Z7J7","LHFPL4" -"UniProt:Q6ZN66","GBP6" -"UniProt:P01589","IL2RA" -"UniProt:Q9NRJ3","CCL28" -"UniProt:O60927","PPP1R11" -"UniProt:Q6P444","MTFR2" -"UniProt:P46977","STT3A" -"UniProt:Q8TBH0","ARRDC2" -"UniProt:A1Z199","A1Z199" -"UniProt:Q8WXA2","PATE1" -"UniProt:Q4J6C6","PREPL" -"UniProt:Q6PKC0","Q6PKC0" -"UniProt:Q8N196","SIX5" -"UniProt:Q69FE3","Q69FE3" -"UniProt:Q13489","BIRC3" -"UniProt:P49187","MK10" -"UniProt:Q9NVR2","INTS10" -"UniProt:Q9NQ76","MEPE" -"UniProt:Q9BQY6","WFDC6" -"UniProt:Q5JVL4","EFHC1" -"UniProt:Q70SY1","CREB3L2" -"UniProt:Q9BUB7","TMEM70" -"UniProt:P19835","CEL" -"UniProt:P38283","SLI15" -"UniProt:Q9HD34","LYRM4" -"UniProt:P25098","GRK2" -"UniProt:Q68DK2","ZFYVE26" -"UniProt:Q99LI8","HGS" -"UniProt:P00523","SRC" -"UniProt:O88508","Dnmt3a" -"UniProt:Q9BS18","ANAPC13" -"UniProt:A5D917","A5D917" -"UniProt:Q9H0C5","BTBD1" -"UniProt:Q9BTD3","TM121" -"UniProt:P34152","FAK1" -"UniProt:Q9BU76","MMTAG2" -"UniProt:O95278","EPM2A" -"UniProt:Q6ZVN8","HFE2" -"UniProt:Q9GZM3","POLR2J3" -"UniProt:P0CW18","PRSS56" -"UniProt:Q14586","ZNF267" -"UniProt:P56381","ATP5E" -"UniProt:Q9Y6E2","BZW2" -"UniProt:Q14185","DOCK1" -"UniProt:G8BA52","G8BA52" -"UniProt:Q9HBJ0","PLAC1" -"UniProt:Q9UKK3","PARP4" -"UniProt:Q8NGH3","OR2D3" -"UniProt:Q86VV4","RNB3L" -"UniProt:P08567","PLEK" -"UniProt:Q6VVB1","NHLRC1" -"UniProt:P62380","TBPL1" -"UniProt:O14901","KLF11" -"UniProt:P12872","MLN" -"UniProt:C5MHM7","C5MHM7" -"UniProt:A6NFE3","EFCAB10" -"UniProt:P22309","UGT1A1" -"UniProt:Q8WWY3","PRPF31" -"UniProt:A6PVL3","KNCN" -"UniProt:Q9Y4D7","PLXND1" -"UniProt:P20823","HNF1A" -"UniProt:Q8TB72","PUM2" -"UniProt:P51161","FABP6" -"UniProt:P22105","TNXB" -"UniProt:Q9Y6W8","ICOS" -"UniProt:P34130","NTF4" -"UniProt:O00519","FAAH" -"UniProt:Q96PV4","PNMA5" -"UniProt:P01891","HLA-A" -"UniProt:Q8NE22","SETD9" -"UniProt:P04792","HSPB1" -"UniProt:Q5F1R6","DNAJC21" -"UniProt:O94983","CAMTA2" -"UniProt:Q9BZE2","PUS3" -"UniProt:P19652","ORM2" -"UniProt:Q03014","HHEX" -"UniProt:O15047","SET1A" -"UniProt:Q9HCE9","ANO8" -"UniProt:Q92759","GTF2H4" -"UniProt:O14975","SLC27A2" -"UniProt:P07864","LDHC" -"UniProt:Q96E29","MTERF3" -"UniProt:Q5BKZ1","ZN326" -"UniProt:P45974","USP5" -"UniProt:Q15645","TRIP13" -"UniProt:O94811","TPPP" -"UniProt:B2RXH2","KDM4E" -"UniProt:Q96HH6","TMM19" -"UniProt:Q96P48","ARAP1" -"UniProt:Q12805","EFEMP1" -"UniProt:P01893","HLA-H" -"UniProt:Q8TDB4","MGARP" -"UniProt:Q05209","PTN12" -"UniProt:O94929","ABLIM3" -"UniProt:Q96RP8","KCNA7" -"UniProt:Q8IYQ7","THNSL1" -"UniProt:Q86U06","RBM23" -"UniProt:Q14643","ITPR1" -"UniProt:O95819","MAP4K4" -"UniProt:Q5T2D2","TREML2" -"UniProt:Q8NCG7","DGLB" -"UniProt:Q96PU9","ODF3" -"UniProt:O60930","RNASEH1" -"UniProt:Q8N257","HIST3H2BB" -"UniProt:Q8N6Q3","CD177" -"UniProt:Q96KM6","Z512B" -"UniProt:P61579","ERVK-25" -"UniProt:Q9UMX9","SLC45A2" -"UniProt:A6NLF2","ELOA3D" -"UniProt:P57075","UBASH3A" -"UniProt:A0A0C4DGJ5","A0A0C4DGJ5" -"UniProt:Q9Y3C8","UFC1" -"UniProt:Q9Y663","HS3ST3A1" -"UniProt:Q2LD37","KIAA1109" -"UniProt:Q9UC07","ZNF69" -"UniProt:P0DMU7","CT45A5" -"UniProt:Q8IZI9","IFNL3" -"UniProt:Q6ZMT1","STAC2" -"UniProt:Q53ZZ1","Q53ZZ1" -"UniProt:Q9H9S5","FKRP" -"UniProt:P51608","MECP2" -"UniProt:Q9UDV6","ZN212" -"UniProt:P09038","FGF2" -"UniProt:Q13769","THOC5" -"UniProt:Q16655","MAR1" -"UniProt:P50570","DNM2" -"UniProt:Q0VF96","CGNL1" -"UniProt:Q6PML9","SLC30A9" -"UniProt:Q496Y0","LONF3" -"UniProt:P63173","RL38" -"UniProt:P51160","PDE6C" -"UniProt:Q9NZQ8","TRPM5" -"UniProt:Q9P270","SLAIN2" -"UniProt:Q62120","JAK2" -"UniProt:Q52M75","CE027" -"UniProt:Q13547","HDAC1" -"UniProt:Q8NI22","MCFD2" -"UniProt:P11388","TOP2A" -"UniProt:Q9NT22","EMILIN3" -"UniProt:Q9UKR0","KLK12" -"UniProt:Q9H4Q4","PRDM12" -"UniProt:Q9D1P2","KAT8" -"UniProt:P55008","AIF1" -"UniProt:Q9Y4K0","LOXL2" -"UniProt:Q9BV73","CEP250" -"UniProt:P37231","PPARG" -"UniProt:O14638","ENPP3" -"UniProt:P01563","IFNA2" -"UniProt:Q9P0U4","CXXC1" -"UniProt:O14617","AP3D1" -"UniProt:Q8NHB8","OR5K2" -"UniProt:Q8N108","MIER1" -"UniProt:Q2HR75","ICP27" -"UniProt:Q08AM6","VAC14" -"UniProt:Q9H6L5","RETREG1" -"UniProt:Q8TF44","C2CD4C" -"UniProt:Q2PPJ7","RALGAPA2" -"UniProt:Q96EH5","RPL39L" -"UniProt:O60522","TDRD6" -"UniProt:O55245","TTHY" -"UniProt:Q9Y473","ZN175" -"UniProt:Q96CV9","OPTN" -"UniProt:Q9H400","LIME1" -"UniProt:Q9HB90","RRAGC" -"UniProt:Q14764","MVP" -"UniProt:P33764","S100A3" -"UniProt:Q14574","DSC3" -"UniProt:Q3LI67","KRTAP6-3" -"UniProt:Q6DJT9","PLAG1" -"UniProt:Q15833","STXBP2" -"UniProt:P39724","AIM1" -"UniProt:Q96B02","UBE2W" -"UniProt:Q8WXH2","JPH3" -"UniProt:P08949","NMB" -"UniProt:P29375","KDM5A" -"UniProt:P28300","LOX" -"UniProt:P24071","FCAR" -"UniProt:Q7Z6R9","AP2D" -"UniProt:P61581","ERVK-24" -"UniProt:Q15527","SURF2" -"UniProt:Q7Z5B4","RIC3" -"UniProt:O43818","RRP9" -"UniProt:Q63HM9","PLCX3" -"UniProt:P02144","MB" -"UniProt:Q969T4","UB2E3" -"UniProt:P43686","PSMC4" -"UniProt:Q13671","RIN1" -"UniProt:Q8IY50","SLC35F3" -"UniProt:O43708","GSTZ1" -"UniProt:Q05397","PTK2" -"UniProt:Q96AG3","SLC25A46" -"UniProt:Q60592","MAST2" -"UniProt:Q9H788","SH24A" -"UniProt:P62685","ERVK-8" -"UniProt:Q9BVV6","KIAA0586" -"UniProt:Q9NPA2","MMP25" -"UniProt:O43684","BUB3" -"UniProt:Q13563","PKD2" -"UniProt:Q9UBT6","POLK" -"UniProt:Q6NVV3","NIPAL1" -"UniProt:O00488","ZN593" -"UniProt:Q9H8Y5","ANKZF1" -"UniProt:P49917","LIG4" -"UniProt:O14503","BHLHE40" -"UniProt:J3KMY6","J3KMY6" -"UniProt:P35869","AHR" -"UniProt:Q13546","RIPK1" -"UniProt:Q13651","IL10RA" -"UniProt:Q9NS37","ZHANG" -"UniProt:A6NNM8","TTLL13P" -"UniProt:Q6BDI9","REP15" -"UniProt:Q5JST6","EFHC2" -"UniProt:Q09161","NCBP1" -"UniProt:Q9BQ31","KCNS3" -"UniProt:A6NMB1","SIGLEC16" -"UniProt:P17535","JUND" -"UniProt:Q6ZW97","Q6ZW97" -"UniProt:O95406","CNIH1" -"UniProt:P51575","P2RX1" -"UniProt:P63120","ERVK-19" -"UniProt:Q9UPG8","PLAL2" -"UniProt:Q15928","ZNF141" -"UniProt:Q3SY00","T10IP" -"UniProt:Q16581","C3AR1" -"UniProt:Q9P0S2","COX16" -"UniProt:P28347","TEAD1" -"UniProt:Q6ZN30","BNC2" -"UniProt:Q96KN9","GJD4" -"UniProt:Q8NA29","MFSD2A" -"UniProt:Q9Y3B4","SF3B6" -"UniProt:P54256","HAP1" -"UniProt:A0A0C4DG38","A0A0C4DG38" -"UniProt:P07478","PRSS2" -"UniProt:Q5VST9","OBSCN" -"UniProt:Q8N6Q1","TMC5A" -"UniProt:P10265","ERVK-10" -"UniProt:P09486","SPARC" -"UniProt:Q8TC36","SUN5" -"UniProt:Q96II5","Q96II5" -"UniProt:Q12446","LAS17" -"UniProt:A8K2U0","A2ML1" -"UniProt:Q8N0W4","NLGN4X" -"UniProt:Q14135","VGLL4" -"UniProt:P18754","RCC1" -"UniProt:Q6ZN54","DEF8" -"UniProt:F5H3M2","F5H3M2" -"UniProt:P01562","IFNA1" -"UniProt:O15145","ARPC3" -"UniProt:Q8N6T7","SIRT6" -"UniProt:Q9BXF6","RAB11FIP5" -"UniProt:Q8NI08","NCOA7" -"UniProt:Q99943","AGPAT1" -"UniProt:Q9BRP8","PYM1" -"UniProt:Q9BXT5","TEX15" -"UniProt:O14931","NCR3" -"UniProt:Q5VVJ2","MYSM1" -"UniProt:P04234","CD3D" -"UniProt:Q9Y587","AP4S1" -"UniProt:A2RRP1","NBAS" -"UniProt:Q9Y286","SIGLEC7" -"UniProt:Q9BYQ6","KR411" -"UniProt:P21860","ERBB3" -"UniProt:P43361","MAGA8" -"UniProt:Q99758","ABCA3" -"UniProt:P01344","IGF2" -"UniProt:O95050","INMT" -"UniProt:Q9BVW5","TIPIN" -"UniProt:Q7Z388","DPY19L4" -"UniProt:Q9NQG7","HPS4" -"UniProt:Q9Y5Y6","ST14" -"UniProt:Q92802","N42L2" -"UniProt:Q96T68","SETDB2" -"UniProt:Q5JR12","PPM1J" -"UniProt:A9UGY9","A9UGY9" -"UniProt:Q6P3S6","FBX42" -"UniProt:Q9Y6Y1","CAMTA1" -"UniProt:Q96NU0","CNTNAP3B" -"UniProt:Q969F9","HPS3" -"UniProt:Q9H4H8","FA83D" -"UniProt:P55060","XPO2" -"UniProt:Q9UJ70","NAGK" -"UniProt:Q8N9F0","NAT8L" -"UniProt:Q9BY11","PACN1" -"UniProt:Q14315","FLNC" -"UniProt:P28068","HLA-DMB" -"UniProt:P12074","COX6A1" -"UniProt:P04264","KRT1" -"UniProt:Q96A49","SYAP1" -"UniProt:A5D8T8","CL18A" -"UniProt:P20133","PGTB2" -"UniProt:P25067","COL8A2" -"UniProt:Q8IZU3","SYCP3" -"UniProt:O00559","EBAG9" -"UniProt:Q6UXQ4","CB066" -"UniProt:Q5VTT2","C9orf135" -"UniProt:Q13618","CUL3" -"UniProt:P61106","RAB14" -"UniProt:Q15319","POU4F3" -"UniProt:Q9NV29","TM100" -"UniProt:Q63538","MK12" -"UniProt:Q12134","HUA2" -"UniProt:Q6PII5","HAGHL" -"UniProt:Q9NYB0","TE2IP" -"UniProt:Q8N6V4","C10orf53" -"UniProt:Q96AQ7","CIDEC" -"UniProt:Q9H8E5","Q9H8E5" -"UniProt:Q96C57","CL043" -"UniProt:Q7L190","DPPA4" -"UniProt:P28004","PRP45" -"UniProt:Q96GA3","LTV1" -"UniProt:P16473","TSHR" -"UniProt:Q9UF33","EPHA6" -"UniProt:P30990","NTS" -"UniProt:Q14108","SCARB2" -"UniProt:Q8NBJ5","COLGALT1" -"UniProt:Q9Y3A2","UTP11" -"UniProt:Q08AI6","SLC38A11" -"UniProt:Q99572","P2RX7" -"UniProt:Q811U4","MFN1" -"UniProt:Q9UPZ3","HPS5" -"UniProt:Q8TE82","SH3TC1" -"UniProt:O75414","NME6" -"UniProt:O60516","4EBP3" -"UniProt:Q96JJ6","JPH4" -"UniProt:Q8NCP5","ZBT44" -"UniProt:O14776","TCRG1" -"UniProt:Q86X24","HORM1" -"UniProt:Q9PTD7","CING" -"UniProt:O60934","NBN" -"UniProt:Q8IV48","ERI1" -"UniProt:Q7Z5Q5","POLN" -"UniProt:Q9BV29","CO057" -"UniProt:Q9UQ49","NEU3" -"UniProt:Q8N4C9","C17orf78" -"UniProt:O43734","TRAF3IP2" -"UniProt:P01579","IFNG" -"UniProt:Q9UK61","FAM208A" -"UniProt:P09693","CD3G" -"UniProt:Q13887","KLF5" -"UniProt:Q6P1X5","TAF2" -"UniProt:Q9UBU7","DBF4" -"UniProt:Q08426","EHHADH" -"UniProt:Q8NBT0","POC1A" -"UniProt:Q01534","TSPY3" -"UniProt:Q96A72","MGN2" -"UniProt:Q16602","CALCRL" -"UniProt:O75581","LRP6" -"UniProt:P07737","PFN1" -"UniProt:Q9Y6B7","AP4B1" -"UniProt:Q8IXH8","CDH26" -"UniProt:O60443","GSDME" -"UniProt:O15066","KIF3B" -"UniProt:Q5T6X5","GPRC6A" -"UniProt:P37275","ZEB1" -"UniProt:Q96EF6","FBX17" -"UniProt:Q9ULV1","FZD4" -"UniProt:Q9NSV4","DIAPH3" -"UniProt:Q6UX82","LYPD8" -"UniProt:Q13018","PLA2R1" -"UniProt:P13645","KRT10" -"UniProt:Q8NA69","CS045" -"UniProt:A5A3E0","POTEF" -"UniProt:Q86VX2","COMMD7" -"UniProt:P83859","QRFP" -"UniProt:Q5SRE7","PHYD1" -"UniProt:Q6ZMZ0","RNF19B" -"UniProt:Q9HCM7","FBRSL1" -"UniProt:Q9UBB5","MBD2" -"UniProt:P12977","EBNA3" -"UniProt:Q3U4G3","XXLT1" -"UniProt:P10242","MYB" -"UniProt:Q8N1Q8","THEM5" -"UniProt:P17027","ZNF23" -"UniProt:P41217","CD200" -"UniProt:Q13470","TNK1" -"UniProt:Q9NXV2","KCTD5" -"UniProt:O43167","ZBTB24" -"UniProt:Q9H2H8","PPIL3" -"UniProt:Q8IXL9","IQCF2" -"UniProt:P56277","CMC4" -"UniProt:Q9H2M3","BHMT2" -"UniProt:Q6ZNW5","GDPGP1" -"UniProt:Q5TG92","C1orf195" -"UniProt:Q9BYT1","SLC17A9" -"UniProt:Q01705","Notch1" -"UniProt:Q9Y2K7","KDM2A" -"UniProt:O75143","ATG13" -"UniProt:P26006","ITGA3" -"UniProt:Q96RI0","F2RL3" -"UniProt:P04080","CSTB" -"UniProt:Q9NQ30","ESM1" -"UniProt:P25801","RBTN2" -"UniProt:P17509","HXB6" -"UniProt:Q9H902","REEP1" -"UniProt:Q14919","DRAP1" -"UniProt:Q5K4L6","SLC27A3" -"UniProt:P26645","MARCS" -"UniProt:Q9HA38","ZMAT3" -"UniProt:Q6IAZ5","Q6IAZ5" -"UniProt:Q9P2B2","PTGFRN" -"UniProt:P20231","TPSAB1" -"UniProt:Q92736","RYR2" -"UniProt:Q8WWZ8","OIT3" -"UniProt:Q0VAF8","Q0VAF8" -"UniProt:Q8TD47","RPS4Y2" -"UniProt:Q96SD1","DCLRE1C" -"UniProt:Q9NRF2","SH2B1" -"UniProt:P0CJ62","RITA1" -"UniProt:Q8NGR4","OR5C1" -"UniProt:P17405","SMPD1" -"UniProt:Q17RD7","SYT16" -"UniProt:Q5QNW6","HIST2H2BF" -"UniProt:P04085","PDGFA" -"UniProt:Q96FX7","TRMT61A" -"UniProt:Q93038","TNFRSF25" -"UniProt:Q8NFQ6","BPIFC" -"UniProt:Q7Z7F7","MRPL55" -"UniProt:P38871","SSP1" -"UniProt:Q6QNY0","BLOC1S3" -"UniProt:P13688","CEACAM1" -"UniProt:Q9NWA0","MED9" -"UniProt:P10451","SPP1" -"UniProt:Q99819","ARHGDIG" -"UniProt:Q96KJ4","MSLNL" -"UniProt:P56915","GSC" -"UniProt:Q8TAG9","EXOC6" -"UniProt:Q8TE57","ADAMTS16" -"UniProt:Q9NP55","BPIA1" -"UniProt:Q6IC98","GRAM4" -"UniProt:Q9UBR1","UPB1" -"UniProt:Q9P283","SEMA5B" -"UniProt:A6NMA1","TRPC5OS" -"UniProt:P35372","OPRM1" -"UniProt:Q92752","TNR" -"UniProt:O95965","ITGBL1" -"UniProt:Q8NC74","RB8NL" -"UniProt:P01008","SERPINC1" -"UniProt:P56279","TCL1A" -"UniProt:Q8N4J0","CARNMT1" -"UniProt:A7Y3Z3","A7Y3Z3" -"UniProt:O43149","ZZEF1" -"UniProt:O95229","ZWINT" -"UniProt:O14668","PRRG1" -"UniProt:Q14140","SRTD2" -"UniProt:G8HBG2","G8HBG2" -"UniProt:Q8NEP9","ZNF555" -"UniProt:Q06265","EXOSC9" -"UniProt:Q9NVZ3","NECAP2" -"UniProt:Q9UFN0","NPS3A" -"UniProt:P0CG04","IGLC1" -"UniProt:Q9BYU1","PBX4" -"UniProt:Q99750","MDFI" -"UniProt:Q8NEB9","PK3C3" -"UniProt:O95571","ETHE1" -"UniProt:P39052","Dnm2" -"UniProt:P22413","ENPP1" -"UniProt:Q9Y4X1","UGT2A1" -"UniProt:Q99719","SEPT5" -"UniProt:P22211","NPR1" -"UniProt:Q8IYJ1","CPNE9" -"UniProt:A6NHT5","HMX3" -"UniProt:Q9UJW3","DNMT3L" -"UniProt:Q9UKY4","POMT2" -"UniProt:Q26366","VG" -"UniProt:Q9H4B7","TUBB1" -"UniProt:P0C671","CF222" -"UniProt:Q9NX62","IMPAD1" -"UniProt:Q9UBV8","PEF1" -"UniProt:O95297","MPZL1" -"UniProt:Q9Y6H6","KCNE3" -"UniProt:Q9C0C2","TNKS1BP1" -"UniProt:P52616","fljB" -"UniProt:P00738","HP" -"UniProt:Q62925","M3K1" -"UniProt:Q9BTT4","MED10" -"UniProt:P48741","HSPA7" -"UniProt:P56179","DLX6" -"UniProt:P01282","VIP" -"UniProt:Q86YV9","HPS6" -"UniProt:Q6ICL0","Q6ICL0" -"UniProt:P41785","prgJ" -"UniProt:Q96JC9","EAF1" -"UniProt:Q8N6R1","SERP2" -"UniProt:Q9BXN2","CLEC7A" -"UniProt:Q13613","MTMR1" -"UniProt:O95832","CLDN1" -"UniProt:O00167","EYA2" -"UniProt:Q9Y336","SIGLEC9" -"UniProt:P51948","MNAT1" -"UniProt:Q4ADV7","RIC1" -"UniProt:Q9Y232","CDYL1" -"UniProt:Q9H596","DUS21" -"UniProt:Q9UJW9","SRTD3" -"UniProt:P51788","CLCN2" -"UniProt:Q5VUJ6","LRCH2" -"UniProt:O75347","TBCA" -"UniProt:Q96MT4","CF195" -"UniProt:Q96FA3","PELI1" -"UniProt:P04196","HRG" -"UniProt:P50993","ATP1A2" -"UniProt:O95427","PIGN" -"UniProt:Q0VFZ6","CCDC173" -"UniProt:Q7Z429","GRINA" -"UniProt:Q96EV8","DTNBP1" -"UniProt:Q92903","CDS1" -"UniProt:Q9NQH7","XPNPEP3" -"UniProt:O95402","MED26" -"UniProt:P21734","UBC1" -"UniProt:Q9H1C3","GLT8D2" -"UniProt:P40126","DCT" -"UniProt:A1E959","ODAM" -"UniProt:P25311","ZA2G" -"UniProt:Q14203","DCTN1" -"UniProt:P49902","NT5C2" -"UniProt:Q06609","RAD51" -"UniProt:Q96M27","PRRC1" -"UniProt:O60831","PRAF2" -"UniProt:Q9Y5J3","HEY1" -"UniProt:Q9NWX6","THG1L" -"UniProt:Q6PIY5","C1orf228" -"UniProt:A0A0C4DGM4","A0A0C4DGM4" -"UniProt:Q96GT9","XAGE2" -"UniProt:Q9BQD7","FAM173A" -"UniProt:Q9NVX0","HAUS2" -"UniProt:Q06546","GABPA" -"UniProt:Q6ZMW2","ZNF782" -"UniProt:Q9NY72","SCN3B" -"UniProt:Q96EK4","THA11" -"UniProt:O60704","TPST2" -"UniProt:Q3KNW5","SLC10A6" -"UniProt:Q5TZA2","CROCC" -"UniProt:Q9Y3R5","DOPEY2" -"UniProt:P04426","WNT1" -"UniProt:Q8NHE4","ATP6V0E2" -"UniProt:Q6P2D0","ZFP1" -"UniProt:O75808","CAPN15" -"UniProt:Q9BV47","DUS26" -"UniProt:Q8N307","MUC20" -"UniProt:Q7L9D0","Q7L9D0" -"UniProt:Q96DR8","MUCL1" -"UniProt:Q8IU60","DCP2" -"UniProt:P29803","ODPAT" -"UniProt:O00232","PSMD12" -"UniProt:Q6I9Y2","THOC7" -"UniProt:Q92536","SLC7A6" -"UniProt:O60218","AKR1B10" -"UniProt:P05878","env" -"UniProt:Q6QEF8","CORO6" -"UniProt:Q5VWX1","KHDRBS2" -"UniProt:Q9Y2P7","ZNF256" -"UniProt:Q04726","TLE3" -"UniProt:O14523","C2CD2L" -"UniProt:Q8NFH8","REPS2" -"UniProt:Q86X27","RGPS2" -"UniProt:Q6ZNH5","ZN497" -"UniProt:Q92567","FAM168A" -"UniProt:O14618","CCS" -"UniProt:P32908","SMC1" -"UniProt:Q8N446","ZN843" -"UniProt:Q9NUI1","DECR2" -"UniProt:P47972","NPTX2" -"UniProt:P30926","CHRNB4" -"UniProt:Q15825","CHRNA6" -"UniProt:Q9UMZ2","SYNRG" -"UniProt:A0A0G2JLS1","A0A0G2JLS1" -"UniProt:Q8N122","RPTOR" -"UniProt:Q6ZVM7","TM1L2" -"UniProt:P62851","RS25" -"UniProt:Q9Y3F4","STRAP" -"UniProt:I6L9I8","I6L9I8" -"UniProt:P17181","IFNAR1" -"UniProt:Q3E7X9","RS28A" -"UniProt:Q3TQ03","CIART" -"UniProt:Q86WT1","TTC30A" -"UniProt:Q6A162","KRT40" -"UniProt:O60356","NUPR1" -"UniProt:Q9UL54","TAOK2" -"UniProt:Q8NER1","TRPV1" -"UniProt:Q9BWX1","PHF7" -"UniProt:Q9Y291","MRPS33" -"UniProt:Q5T5A8","LCE3C" -"UniProt:O76074","PDE5A" -"UniProt:O54784","Dapk3" -"UniProt:Q15181","PPA1" -"UniProt:Q5VVQ6","YOD1" -"UniProt:P06307","CCK" -"UniProt:Q8TAY7","FAM110D" -"UniProt:A8MQ03","CRTP1" -"UniProt:O75820","ZNF189" -"UniProt:Q9R000","ITBP2" -"UniProt:P28496","LAC1" -"UniProt:Q14592","ZNF460" -"UniProt:Q8WU67","ABHD3" -"UniProt:P05882","env" -"UniProt:Q02161","RHD" -"UniProt:P32239","CCKBR" -"UniProt:Q61550","RAD21" -"UniProt:Q8N6M9","ZFN2A" -"UniProt:Q8IY31","IFT20" -"UniProt:Q8TCU6","PREX1" -"UniProt:Q8N684","CPSF7" -"UniProt:Q14149","MORC3" -"UniProt:P07093","SERPINE2" -"UniProt:Q969F2","NKD2" -"UniProt:Q9GZZ1","NAA50" -"UniProt:O15321","TM9SF1" -"UniProt:Q7Z3D4","LYSMD3" -"UniProt:Q96C10","DHX58" -"UniProt:O14933","UBE2L6" -"UniProt:Q2M3T9","HYAL4" -"UniProt:Q9H7X7","IFT22" -"UniProt:P15735","PHKG2" -"UniProt:P0C7Q6","SLC35G6" -"UniProt:Q9Y2U9","KLHDC2" -"UniProt:P20142","PGC" -"UniProt:P21917","DRD4" -"UniProt:Q9NVD7","PARVA" -"UniProt:P39687","AN32A" -"UniProt:A0A087WYW1","A0A087WYW1" -"UniProt:O60858","TRIM13" -"UniProt:Q5T0T0","MARCH8" -"UniProt:Q4G0G3","Q4G0G3" -"UniProt:B1AQ61","B1AQ61" -"UniProt:Q8N0Z8","PUSL1" -"UniProt:Q9NQX6","ZNF331" -"UniProt:O94889","KLHL18" -"UniProt:P38936","CDN1A" -"UniProt:Q8WU39","MZB1" -"UniProt:Q5HYJ1","TECRL" -"UniProt:O95067","CCNB2" -"UniProt:Q15464","SHB" -"UniProt:O94927","HAUS5" -"UniProt:P08581","MET" -"UniProt:Q9H2W2","MIXL1" -"UniProt:O94906","PRPF6" -"UniProt:P39023","RL3" -"UniProt:Q12981","BNIP1" -"UniProt:Q96G23","CERS2" -"UniProt:P40227","TCPZ" -"UniProt:Q6WBX8","RAD9B" -"UniProt:P0C1Z6","TFPT" -"UniProt:Q9BXS9","SLC26A6" -"UniProt:Q96NX5","CAMK1G" -"UniProt:Q9H9Y6","RPA2" -"UniProt:Q8CIG8","ANM5" -"UniProt:P30281","CCND3" -"UniProt:P36955","SERPINF1" -"UniProt:P20366","TAC1" -"UniProt:P29084","GTF2E2" -"UniProt:Q8NG84","OR2AK2" -"UniProt:A6NLX3","SPDE4" -"UniProt:P34995","PTGER1" -"UniProt:Q9NQY0","BIN3" -"UniProt:P35613","BSG" -"UniProt:Q8NH03","OR2T3" -"UniProt:Q00526","CDK3" -"UniProt:O95551","TDP2" -"UniProt:P55786","NPEPPS" -"UniProt:Q9UM73","ALK" -"UniProt:O75940","SMNDC1" -"UniProt:Q2M296","MTHFSD" -"UniProt:Q62976","KCMA1" -"UniProt:Q8NBJ9","SIDT2" -"UniProt:Q9Y334","VWA7" -"UniProt:P15923","TCF3" -"UniProt:Q7KZF4","SND1" -"UniProt:Q9UDT6","CLIP2" -"UniProt:Q9HCZ1","ZNF334" -"UniProt:P68871","HBB" -"UniProt:Q53GC0","Q53GC0" -"UniProt:Q99549","MPP8" -"UniProt:Q96EV2","RBM33" -"UniProt:Q14656","TMEM187" -"UniProt:Q17R98","ZN827" -"UniProt:Q6ZUS6","CCDC149" -"UniProt:O15403","SLC16A6" -"UniProt:P69905","HBA1;HBA2" -"UniProt:D3DUQ6","D3DUQ6" -"UniProt:O76062","TM7SF2" -"UniProt:Q9NPC4","A4GALT" -"UniProt:Q9BY42","RTFDC1" -"UniProt:P0DP91","ERCC6" -"UniProt:P51589","CYP2J2" -"UniProt:Q9UNH5","CDC14A" -"UniProt:Q8IVM0","CCDC50" -"UniProt:Q9NYD6","HOXC10" -"UniProt:Q8NCC3","PLA2G15" -"UniProt:P0CG08","GPR89A" -"UniProt:Q9NXR7","BRE" -"UniProt:Q7Z6V5","ADAT2" -"UniProt:P69892","HBG2" -"UniProt:Q9BZK7","TBL1XR1" -"UniProt:O43422","P52K" -"UniProt:Q9NQG5","RPRD1B" -"UniProt:Q9NRY2","SOSSC" -"UniProt:Q96AX2","RAB37" -"UniProt:P05111","INHA" -"UniProt:Q9Y4R8","TELO2" -"UniProt:P23059","NAA38" -"UniProt:P08921","CD2" -"UniProt:Q15653","IKBB" -"UniProt:Q9BQB6","VKORC1" -"UniProt:Q8N0S2","SYCE1" -"UniProt:Q3KR16","PLEKHG6" -"UniProt:P30711","GSTT1" -"UniProt:P41231","P2RY2" -"UniProt:Q6NXG1","ESRP1" -"UniProt:P33527","ABCC1" -"UniProt:O41951","O41951" -"UniProt:Q7RTS7","KRT74" -"UniProt:Q8NA47","CCDC63" -"UniProt:Q9Y2S7","POLDIP2" -"UniProt:Q92597","NDRG1" -"UniProt:P34896","GLYC" -"UniProt:P21918","DRD5" -"UniProt:P49736","MCM2" -"UniProt:P63252","KCNJ2" -"UniProt:A0A250WEQ4","A0A250WEQ4" -"UniProt:Q6ICH7","ASPHD2" -"UniProt:Q9UGN5","PARP2" -"UniProt:P15822","HIVEP1" -"UniProt:O95935","TBX18" -"UniProt:Q9FKS5","CYC1B" -"UniProt:Q9GZN2","TGIF2" -"UniProt:B7Z6K7","ZNF814" -"UniProt:P58872","RHBDL3" -"UniProt:Q9GZY6","LAT2" -"UniProt:Q8IXJ9","ASXL1" -"UniProt:Q03169","TNFAIP2" -"UniProt:Q96B86","RGMA" -"UniProt:P10588","NR2F6" -"UniProt:Q9NQC7","CYLD" -"UniProt:P55851","UCP2" -"UniProt:O95843","GUCA1C" -"UniProt:Q99380","OST4" -"UniProt:P07108","DBI" -"UniProt:Q9NWM3","CUEDC1" -"UniProt:Q8IZ83","ALDH16A1" -"UniProt:Q92482","AQP3" -"UniProt:Q9BTV7","CABL2" -"UniProt:Q13049","TRIM32" -"UniProt:Q12329","HSP42" -"UniProt:P49723","RIR4" -"UniProt:Q9H0P0","NT5C3A" -"UniProt:A6NFZ4","FAM24A" -"UniProt:Q6ZQY3","GADL1" -"UniProt:Q9GZN0","GPR88" -"UniProt:A0A024A2C9","A0A024A2C9" -"UniProt:P49368","TCPG" -"UniProt:Q969E2","SCAM4" -"UniProt:P29033","GJB2" -"UniProt:Q9UJT2","TSKS" -"UniProt:Q5D862","FLG2" -"UniProt:O95125","ZNF202" -"UniProt:Q00722","PLCB2" -"UniProt:Q8NER5","ACVR1C" -"UniProt:P12111","COL6A3" -"UniProt:O95294","RASAL1" -"UniProt:M0R160","M0R160" -"UniProt:Q9NV58","RNF19A" -"UniProt:O75752","B3GALNT1" -"UniProt:Q9Y394","DHRS7" -"UniProt:Q9Y3P8","SIT1" -"UniProt:Q8TE76","MORC4" -"UniProt:Q5BJH2","TMEM128" -"UniProt:Q9BU23","LMF2" -"UniProt:Q9NWH7","SPATA6" -"UniProt:P00451","F8" -"UniProt:P12110","COL6A2" -"UniProt:Q5SV17","TMEM240" -"UniProt:P07585","DCN" -"UniProt:Q8N3K9","CMYA5" -"UniProt:Q13069","GAGE5" -"UniProt:Q86WV2","Q86WV2" -"UniProt:P04839","CYBB" -"UniProt:P08476","INHBA" -"UniProt:Q8IZD2","KMT2E" -"UniProt:O15181","cd21" -"UniProt:P29122","PCSK6" -"UniProt:P01185","AVP" -"UniProt:O75971","SNAPC5" -"UniProt:P01912","HLA-DRB1" -"UniProt:P57721","PCBP3" -"UniProt:P08603","CFH" -"UniProt:P80370","DLK1" -"UniProt:Q8N5H7","SH2D3C" -"UniProt:Q99929","ASCL2" -"UniProt:P15428","HPGD" -"UniProt:Q8N8X9","MB213" -"UniProt:Q8TAA3","PSMA8" -"UniProt:Q9Y2C5","SLC17A4" -"UniProt:Q9UBB6","NCDN" -"UniProt:P18858","LIG1" -"UniProt:O75054","IGSF3" -"UniProt:Q06187","BTK" -"UniProt:O88351","IKKB" -"UniProt:B3EWG3","FAM25C" -"UniProt:P01317","INS" -"UniProt:Q8TB03","CX038" -"UniProt:O95872","GPAN1" -"UniProt:Q96QR1","SCGB3A1" -"UniProt:Q9UFW8","CGBP1" -"UniProt:E9PB15","PTGES3L" -"UniProt:P61964","WDR5" -"UniProt:O43159","RRP8" -"UniProt:O60481","ZIC3" -"UniProt:Q8WYK0","ACOT12" -"UniProt:Q86XW9","NME9" -"UniProt:Q9Y672","ALG6" -"UniProt:Q5XKE5","K2C79" -"UniProt:Q8TAN2","Q8TAN2" -"UniProt:Q96BY6","DOCK10" -"UniProt:P07550","ADRB2" -"UniProt:O75469","NR1I2" -"UniProt:Q08493","PDE4C" -"UniProt:F4HZB2","BCHA1" -"UniProt:Q9H165","BCL11A" -"UniProt:P11440","Cdk1" -"UniProt:P09488","GSTM1" -"UniProt:A4D2J0","A4D2J0" -"UniProt:P61289","PSME3" -"UniProt:P56945","BCAR1" -"UniProt:Q12161","PSH1" -"UniProt:A0AV02","S12A8" -"UniProt:Q695T7","SLC6A19" -"UniProt:P59542","TAS2R19" -"UniProt:O75084","FZD7" -"UniProt:Q92839","HAS1" -"UniProt:O43699","SIGLEC6" -"UniProt:Q8AZK7","EBNA5" -"UniProt:Q01546","KRT76" -"UniProt:Q9NZN5","ARHGC" -"UniProt:Q96G27","WBP1" -"UniProt:P04181","OAT" -"UniProt:Q86TB9","PATL1" -"UniProt:Q9NR09","BIRC6" -"UniProt:Q15569","TESK1" -"UniProt:P13667","PDIA4" -"UniProt:Q96BQ1","FAM3D" -"UniProt:Q8IUR7","ARMC8" -"UniProt:Q14508","WFDC2" -"UniProt:P30485","HLA-B" -"UniProt:Q9BXT2","CACNG6" -"UniProt:Q96SQ5","ZN587" -"UniProt:Q8NGG7","OR8A1" -"UniProt:Q92558","WASF1" -"UniProt:Q00816","REG1" -"UniProt:Q86T29","ZNF605" -"UniProt:P13671","C6" -"UniProt:Q60987","FOXG1" -"UniProt:P09972","ALDOC" -"UniProt:Q86X60","FAM72B" -"UniProt:Q9Y471", -"UniProt:P98194","ATP2C1" -"UniProt:Q4KTX9","Q4KTX9" -"UniProt:Q9P2K8","EIF2AK4" -"UniProt:Q9ULD6","INTU" -"UniProt:Q96HU1","SGSM3" -"UniProt:Q86XK2","FBX11" -"UniProt:P30479","HLA-B" -"UniProt:O75310","UGT2B11" -"UniProt:P32189","GK" -"UniProt:Q96MH2","HEXI2" -"UniProt:O14893","GEMIN2" -"UniProt:Q9HC78","ZBTB20" -"UniProt:P10515","DLAT" -"UniProt:Q8TAU3","ZN417" -"UniProt:P47755","CAPZA2" -"UniProt:Q9Y247","FA50B" -"UniProt:Q9UH17","APOBEC3B" -"UniProt:Q9BQS8","FYCO1" -"UniProt:Q8IUQ4","SIAH1" -"UniProt:Q9H9S0","NANOG" -"UniProt:Q05516","ZBTB16" -"UniProt:Q3LI72","KRTAP19-5" -"UniProt:Q8NFJ6","PROKR2" -"UniProt:Q9HBH5","RDH14" -"UniProt:Q49AR9","Q49AR9" -"UniProt:Q9BXS5","AP1M1" -"UniProt:P30531","SLC6A1" -"UniProt:Q8IVV7","GID4" -"UniProt:Q8IY44","Q8IY44" -"UniProt:Q4LDE5","SVEP1" -"UniProt:O94819","KBTBD11" -"UniProt:Q86XN7","PROSER1" -"UniProt:Q03111","MLLT1" -"UniProt:O76009","KRT33A" -"UniProt:Q9H9G7","AGO3" -"UniProt:P11172","UMPS" -"UniProt:P78549","NTHL1" -"UniProt:P30520","ADSS" -"UniProt:P25787","PSMA2" -"UniProt:A6NNE9","MARCH11" -"UniProt:O43248","HOXC11" -"UniProt:Q8NGN7","OR10D4P" -"UniProt:Q3BBV1","NBPF9" -"UniProt:Q9NUJ3","T11L1" -"UniProt:Q8WY21","SORCS1" -"UniProt:Q14011","CIRBP" -"UniProt:O00472","ELL2" -"UniProt:Q9BTY2","FUCO2" -"UniProt:P51858","HDGF" -"UniProt:P05230","FGF1" -"UniProt:Q8NE65","ZNF738" -"UniProt:P32004","L1CAM" -"UniProt:Q6ZUJ8","PIK3AP1" -"UniProt:Q71RC2","LARP4" -"UniProt:P07947","YES" -"UniProt:O00141","SGK1" -"UniProt:O96020","CCNE2" -"UniProt:Q8TBC5","ZSC18" -"UniProt:Q7Z5K2","WAPL" -"UniProt:Q9NX24","NHP2" -"UniProt:P51814","ZNF41" -"UniProt:Q8IUX1","TMEM126B" -"UniProt:Q8WUY8","NAT14" -"UniProt:P50219","MNX1" -"UniProt:Q9BZM1","PLA2G12A" -"UniProt:O75531","BANF1" -"UniProt:P32243","OTX2" -"UniProt:Q4FZB7","KMT5B" -"UniProt:P52732","KIF11" -"UniProt:Q13641","TPBG" -"UniProt:Q9H987","SYNPO2L" -"UniProt:Q6UWB1","IL27RA" -"UniProt:Q8WV92","MITD1" -"UniProt:Q6P2H8","TMEM53" -"UniProt:Q5CZA5","ZNF805" -"UniProt:Q6P531","GGT6" -"UniProt:Q9NZU7","CABP1" -"UniProt:Q6PDB4","ZNF880" -"UniProt:Q8NDW8","TT21A" -"UniProt:Q8N3A8","PARP8" -"UniProt:Q969V6","MKL1" -"UniProt:P51523","ZNF84" -"UniProt:Q8NC69","KCTD6" -"UniProt:Q9UMQ6","CAPN11" -"UniProt:P28329","CHAT" -"UniProt:Q9NUM4","TMEM106B" -"UniProt:Q8TBP0","TBC1D16" -"UniProt:P10599","THIO" -"UniProt:Q96JB6","LOXL4" -"UniProt:Q04741","EMX1" -"UniProt:Q7L775","EPMIP" -"UniProt:Q9BUR4","WRAP53" -"UniProt:P12271","RLBP1" -"UniProt:Q9NYL9","TMOD3" -"UniProt:Q9BSI4","TINF2" -"UniProt:Q9BZV2","SLC19A3" -"UniProt:P08235","NR3C2" -"UniProt:Q9UNA4","POLI" -"UniProt:Q3B726","TWISTNB" -"UniProt:A1A4H1","A1A4H1" -"UniProt:P32578","SIP1" -"UniProt:P49458","SRP09" -"UniProt:Q8WTV1","THAP3" -"UniProt:P24864","CCNE1" -"UniProt:O95600","KLF8" -"UniProt:O95257","GA45G" -"UniProt:Q6UX65","DRAM2" -"UniProt:Q8WU02","Q8WU02" -"UniProt:Q8IY33","MILK2" -"UniProt:Q9P0J0","NDUFA13" -"UniProt:Q9H0E9","BRD8" -"UniProt:P07311","ACYP1" -"UniProt:P17214","EST1" -"UniProt:O14862","AIM2" -"UniProt:Q9P2A4","ABI3" -"UniProt:O95170","CDRT1" -"UniProt:P15918","RAG1" -"UniProt:Q8N3L3","TXLNB" -"UniProt:Q5XKK7","FAM219B" -"UniProt:Q9NZ01","TECR" -"UniProt:Q92624","APBP2" -"UniProt:O15273","TCAP" -"UniProt:Q9Y2L6","FRMD4B" -"UniProt:P50461","CSRP3" -"UniProt:Q96AH8","RAB7B" -"UniProt:Q9GZN1","ACTR6" -"UniProt:Q5T742","C10orf25" -"UniProt:Q8WXB1","METTL21A" -"UniProt:Q86WQ0","NR2CA" -"UniProt:P28799","GRN" -"UniProt:P41250","GARS" -"UniProt:P78423","CX3CL1" -"UniProt:Q03164","KMT2A" -"UniProt:Q9NWQ9","CN119" -"UniProt:Q494X3","ZN404" -"UniProt:Q16777","HIST2H2AC" -"UniProt:O95045","UPP2" -"UniProt:Q9H147","TDIF1" -"UniProt:Q2TAC2","CCDC57" -"UniProt:P0CW01","TSPY1" -"UniProt:Q8NA61","SPERT" -"UniProt:Q96KP6","TNIP3" -"UniProt:Q96T76","MMS19" -"UniProt:Q9ULW2","FZD10" -"UniProt:Q8IWD4","CCDC117" -"UniProt:Q9UF02","CACNG5" -"UniProt:Q96MT1","RNF145" -"UniProt:Q14671","PUM1" -"UniProt:Q5JVG8","ZNF506" -"UniProt:Q08623","HDHD1" -"UniProt:P21731","TBXA2R" -"UniProt:P61829","ATP9" -"UniProt:Q86YL7","PDPN" -"UniProt:P55895","RAG2" -"UniProt:Q99728","BARD1" -"UniProt:Q15286","RAB35" -"UniProt:Q14C61","Q14C61" -"UniProt:O14904","WNT9A" -"UniProt:A4D0V7","CPED1" -"UniProt:Q2QD12","RPEL1" -"UniProt:Q9Y600","CSAD" -"UniProt:P51449","RORC" -"UniProt:Q08043","ACTN3" -"UniProt:Q8WXF1","PSPC1" -"UniProt:P38128","SMP1" -"UniProt:Q99541","PLIN2" -"UniProt:O00429","DNM1L" -"UniProt:Q9BYR9","KRTAP2-4" -"UniProt:O14746","TERT" -"UniProt:Q9UKS7","IKZF2" -"UniProt:Q5NUL3","FFAR4" -"UniProt:O60674","JAK2" -"UniProt:O15357","INPPL1" -"UniProt:Q8TD84","DSCAML1" -"UniProt:Q9NX38","FAM206A" -"UniProt:P17022","ZNF18" -"UniProt:P08311","CTSG" -"UniProt:P78330","PSPH" -"UniProt:Q8IUF1","CBWD2" -"UniProt:Q9GZP0","PDGFD" -"UniProt:Q96IZ5","RBM41" -"UniProt:P0DJJ0","SRGAP2C" -"UniProt:P13196","ALAS1" -"UniProt:Q13637","RAB32" -"UniProt:Q5JQC4","CT47A1" -"UniProt:Q05823","RNASEL" -"UniProt:Q9BQ75","CMSS1" -"UniProt:O95758","PTBP3" -"UniProt:P01871","IGHM" -"UniProt:Q8NEQ5","C1orf162" -"UniProt:P26045","PTPN3" -"UniProt:Q15048","LRRC14" -"UniProt:Q96IU2","ZBED3" -"UniProt:Q9ULE6","PALD" -"UniProt:Q6ZSS7","MFSD6" -"UniProt:Q8WUR7","C15orf40" -"UniProt:Q6AW86","ZNF324B" -"UniProt:Q9UPV9","TRAK1" -"UniProt:P36542","ATPG" -"UniProt:P49639","HOXA1" -"UniProt:Q9Y4Z0","LSM4" -"UniProt:Q07866","KLC1" -"UniProt:Q06630","MHR1" -"UniProt:O75122","CLAP2" -"UniProt:Q15714","TSC22D1" -"UniProt:Q15935","ZNF77" -"UniProt:O43916","CHST1" -"UniProt:Q6PKD1","KIF5C" -"UniProt:Q9BTD8","RBM42" -"UniProt:O00233","PSMD9" -"UniProt:O54943","Per2" -"UniProt:Q15287","RNPS1" -"UniProt:Q92747","ARC1A" -"UniProt:Q9NRB3","CHST12" -"UniProt:Q9NYV8","TAS2R14" -"UniProt:P24046","GABRR1" -"UniProt:Q8N988","ZNF557" -"UniProt:P12429","ANXA3" -"UniProt:Q8N5I4","DHRSX" -"UniProt:Q6NT89","TRNP1" -"UniProt:Q9C0A0","CNTNAP4" -"UniProt:P04582","env" -"UniProt:P36639","NUDT1" -"UniProt:Q9H898","ZMAT4" -"UniProt:Q9NQU5","PAK6" -"UniProt:O43193","MLNR" -"UniProt:O95206","PCDH8" -"UniProt:P20648","ATP4A" -"UniProt:P01374","LTA" -"UniProt:P48729","KC1A" -"UniProt:Q9NQ84","GPRC5C" -"UniProt:Q86UP9","LHFPL3" -"UniProt:Q8WVJ2","NUDC2" -"UniProt:O75309","CDH16" -"UniProt:Q8IXS6","PALM2" -"UniProt:A0A0S2Z4G9","A0A0S2Z4G9" -"UniProt:Q8IZ57","NRSN1" -"UniProt:O75112","LDB3" -"UniProt:P83110","HTRA3" -"UniProt:Q12020","SRL2" -"UniProt:O00418","EEF2K" -"UniProt:F1T0A5","F1T0A5" -"UniProt:Q96MI6","PPM1M" -"UniProt:O00186","STXBP3" -"UniProt:Q9Y228","T3JAM" -"UniProt:P48281","VDR" -"UniProt:Q96GY3","LIN37" -"UniProt:P68543","UBX2A" -"UniProt:P11150","LIPC" -"UniProt:O15264","MAPK13" -"UniProt:Q9UI32","GLS2" -"UniProt:Q9NNX1","TUFT1" -"UniProt:P17927","CR1" -"UniProt:Q9NSA0","SLC22A11" -"UniProt:Q86UW2","SLC51B" -"UniProt:Q8WTR7","ZN473" -"UniProt:Q9H169","STMN4" -"UniProt:Q8NBJ4","GOLM1" -"UniProt:Q08048","Hgf" -"UniProt:Q86UP3","ZFHX4" -"UniProt:P50120","RBP2" -"UniProt:Q14186","TFDP1" -"UniProt:Q4LDG9","DNAL1" -"UniProt:Q9GZV7","HPLN2" -"UniProt:Q9HCP0","CSNK1G1" -"UniProt:Q8N8G2","VGLL2" -"UniProt:P22891","PROZ" -"UniProt:P45379","TNNT2" -"UniProt:Q96A32","MYLPF" -"UniProt:Q9UK33","ZN580" -"UniProt:A5HZZ4","A5HZZ4" -"UniProt:P0CI25","TRI49" -"UniProt:Q3UJB9","EDC4" -"UniProt:P21941","MATN1" -"UniProt:O95716","RAB3D" -"UniProt:Q8WWX8","SLC5A11" -"UniProt:Q9UMX5","NENF" -"UniProt:Q9BQ08","RETNLB" -"UniProt:Q9NXT0","ZNF586" -"UniProt:P01375","TNF" -"UniProt:O75390","CS" -"UniProt:A6NEN9","CXorf65" -"UniProt:Q29983","MICA" -"UniProt:O75031","HSF2B" -"UniProt:P61599","NAA20" -"UniProt:Q8N998","CCD89" -"UniProt:Q6P1K2","PMF1" -"UniProt:Q96D16","Q96D16" -"UniProt:Q9UKT6","FBXL21" -"UniProt:Q96BZ4","PLD4" -"UniProt:P52888","THOP1" -"UniProt:Q12794","HYAL1" -"UniProt:Q92572","AP3S1" -"UniProt:Q969V1","MCHR2" -"UniProt:O14653","GOSR2" -"UniProt:Q86US8","SMG6" -"UniProt:Q61091","FZD8" -"UniProt:Q6UW01","CBLN3" -"UniProt:Q7RTX1","TAS1R1" -"UniProt:Q5VUJ9","EFCAB2" -"UniProt:P49913","CAMP" -"UniProt:P30484","HLA-B" -"UniProt:P49817","Cav1" -"UniProt:P14905","CBS2" -"UniProt:Q9TNN7","HLA-C" -"UniProt:Q9BYC2","OXCT2" -"UniProt:P21246","PTN" -"UniProt:Q9UJ83","HACL1" -"UniProt:Q6TDU7","CASC1" -"UniProt:Q9NZL3","ZNF224" -"UniProt:Q15078","CD5R1" -"UniProt:Q9BW27","NUP85" -"UniProt:Q12774","ARHGEF5" -"UniProt:Q04207","TF65" -"UniProt:Q9NQL2","RRAGD" -"UniProt:Q14296","FASTK" -"UniProt:P28069","POU1F1" -"UniProt:Q9H9P5","UNKL" -"UniProt:P13010","XRCC5" -"UniProt:A5X5Y0","HTR3E" -"UniProt:P78371","TCPB" -"UniProt:P0CG30","GSTT2B" -"UniProt:Q68DQ2","CRYBG3" -"UniProt:Q6NYC8","PPR18" -"UniProt:Q96FX8","PERP" -"UniProt:O75437","ZNF254" -"UniProt:Q3SXZ7","TTLL9" -"UniProt:P69891","HBG1" -"UniProt:Q8TD23","ZNF675" -"UniProt:Q6GTX8","LAIR1" -"UniProt:Q9Y2K2","SIK3" -"UniProt:Q56UN5","MAP3K19" -"UniProt:P25440","BRD2" -"UniProt:Q62765","NLGN1" -"UniProt:Q8N8C0","ZNF781" -"UniProt:Q9UGB7","MIOX" -"UniProt:Q53FE4","C4orf17" -"UniProt:O15116","LSM1" -"UniProt:P62324","BTG1" -"UniProt:Q68DX3","FRMPD2" -"UniProt:Q86SR1","GALNT10" -"UniProt:O76036","NCR1" -"UniProt:P59095","STARD6" -"UniProt:Q8N6T3","ARFGAP1" -"UniProt:Q99576","TSC22D3" -"UniProt:Q8TDN4","CABL1" -"UniProt:Q13336","SLC14A1" -"UniProt:Q96T88","UHRF1" -"UniProt:A4D127","A4D127" -"UniProt:Q9Y2Z0","SUGT1" -"UniProt:O94955","RHOBTB3" -"UniProt:Q9NS82","SLC7A10" -"UniProt:Q86Y37","CACL1" -"UniProt:A0A0A0MTT2","A0A0A0MTT2" -"UniProt:O95619","YETS4" -"UniProt:P0C6T2","OST4" -"UniProt:Q9P0K1","ADAM22" -"UniProt:P50990","TCPQ" -"UniProt:Q9P2R6","RERE" -"UniProt:Q8TDX6","CSGALNACT1" -"UniProt:O14579","COPE" -"UniProt:Q8WW22","DNAJA4" -"UniProt:Q9UGP8","SEC63" -"UniProt:Q6P3W7","SCYL2" -"UniProt:Q02085","SNAI1" -"UniProt:Q96BI3","APH1A" -"UniProt:Q9BZM6","ULBP1" -"UniProt:Q9Y2T3","GDA" -"UniProt:Q6FGM0","Q6FGM0" -"UniProt:Q9Y5S8","NOX1" -"UniProt:P31629","HIVEP2" -"UniProt:Q8IVK1","GLYCAM1" -"UniProt:Q8N8Z8","ZNF441" -"UniProt:Q99218","AMELY" -"UniProt:Q96G42","KLD7B" -"UniProt:O95361","TRI16" -"UniProt:P30466","HLA-B" -"UniProt:Q32M84","BTBD16" -"UniProt:A8K4G0","CD300LB" -"UniProt:Q9UNN5","FAF1" -"UniProt:Q9C0D3","ZY11B" -"UniProt:Q5T4T6","SYCP2L" -"UniProt:Q8TCV5","WFDC5" -"UniProt:Q9JJ66","CDC20" -"UniProt:P20700","LMNB1" -"UniProt:Q12767","TMM94" -"UniProt:P09382","LGALS1" -"UniProt:Q9QR71","ORF73" -"UniProt:Q6PJQ5","FOXR2" -"UniProt:Q9H6D7","HAUS4" -"UniProt:Q99426","TBCB" -"UniProt:Q96LB0","MRGPRX3" -"UniProt:Q14849","STARD3" -"UniProt:O60307","MAST3" -"UniProt:Q9NQF3","SERHL" -"UniProt:Q5SW24","DACT2" -"UniProt:Q969X1","TMBIM1" -"UniProt:Q03173","ENAH" -"UniProt:P24844","MYL9" -"UniProt:B7ZLI8","B7ZLI8" -"UniProt:P25343","RV161" -"UniProt:Q99504","EYA3" -"UniProt:Q13617","CUL2" -"UniProt:Q9BYN8","MRPS26" -"UniProt:Q8NDN9","RCBTB1" -"UniProt:Q86YS7","C2CD5" -"UniProt:O94907","DKK1" -"UniProt:O60895","RAMP2" -"UniProt:P45877","PPIC" -"UniProt:P14635","CCNB1" -"UniProt:Q7L0Y3","TRMT10C" -"UniProt:P23468","PTPRD" -"UniProt:Q6UXH8","CCBE1" -"UniProt:Q14995","NR1D2" -"UniProt:Q9H1J5","WNT8A" -"UniProt:Q1W6H9","F110C" -"UniProt:O00443","PIK3C2A" -"UniProt:Q9H1Q7","PCED1A" -"UniProt:Q6UWH6","TEX261" -"UniProt:Q9NXC2","GFOD1" -"UniProt:P35235","Ptpn11" -"UniProt:Q15032","R3HDM1" -"UniProt:O43310","CTIF" -"UniProt:P50991","TCPD" -"UniProt:Q9Y6H3","ATP23" -"UniProt:Q9UBS8","RNF14" -"UniProt:Q8NGP9","OR5AR1" -"UniProt:Q9Y6F1","PARP3" -"UniProt:P78562","PHEX" -"UniProt:Q8NGE9","OR9Q2" -"UniProt:Q13829","BACD2" -"UniProt:Q8WUY9","DEPDC1B" -"UniProt:Q9UI14","PRAF1" -"UniProt:B4DX44","ZNF736" -"UniProt:Q9BZC1","CELF4" -"UniProt:Q7RTU4","BHLHA9" -"UniProt:Q66K64","DCAF15" -"UniProt:O14764","GABRD" -"UniProt:Q8N5V2","NGEF" -"UniProt:Q96CW6","SLC7A6OS" -"UniProt:P11831","SRF" -"UniProt:Q8NDL9","AGBL5" -"UniProt:Q9UHQ1","NARF" -"UniProt:O94952","FBXO21" -"UniProt:Q12874","SF3A3" -"UniProt:P10145","CXCL8" -"UniProt:Q8N4L8","CCD24" -"UniProt:Q01518","CAP1" -"UniProt:Q9H6Y5","MAGIX" -"UniProt:P01133","EGF" -"UniProt:P08473","MME" -"UniProt:P08842","STS" -"UniProt:Q9H792","PEAK1" -"UniProt:O15397","IPO8" -"UniProt:Q8WW34","TM239" -"UniProt:P23284","PPIB" -"UniProt:Q8IWE2","FAM114A1" -"UniProt:P50851","LRBA" -"UniProt:Q9UNN8","PROCR" -"UniProt:P14672","SLC2A4" -"UniProt:P35354","PTGS2" -"UniProt:Q8IY51","TIGD4" -"UniProt:Q12797","ASPH" -"UniProt:Q969H8","MYDGF" -"UniProt:P51857","AKR1D1" -"UniProt:P15625","SYFA" -"UniProt:Q7Z6I8","C5orf24" -"UniProt:Q86YT9","JAML" -"UniProt:P78368","CSNK1G2" -"UniProt:Q9HB58","SP110" -"UniProt:Q8IYB4","PEX5L" -"UniProt:Q8WW12","PCNP" -"UniProt:Q9Y6R4","M3K4" -"UniProt:Q8N5D0","WDTC1" -"UniProt:Q80UI5","Q80UI5" -"UniProt:B2R9Y1","B2R9Y1" -"UniProt:P30480","HLA-B" -"UniProt:Q8TAI1","TYMOS" -"UniProt:P58107","EPPK1" -"UniProt:Q9BQA5","HINFP" -"UniProt:Q9HAB3","SLC52A2" -"UniProt:Q16775","HAGH" -"UniProt:P34972","CNR2" -"UniProt:Q9Y448","SKAP" -"UniProt:O43399","TPD54" -"UniProt:Q8IVF6","ANKRD18A" -"UniProt:B1AHH5","B1AHH5" -"UniProt:Q9Y2Z2","MTO1" -"UniProt:P10176","COX8A" -"UniProt:Q9NRC8","SIRT7" -"UniProt:Q8NGD1","OR4N2" -"UniProt:Q99959","PKP2" -"UniProt:Q9NYM9","BET1L" -"UniProt:Q02388","COL7A1" -"UniProt:Q9Y5Y0","FLVCR1" -"UniProt:Q9NQB0","TCF7L2" -"UniProt:P31268","HXA7" -"UniProt:Q04671","OCA2" -"UniProt:Q99288","DET1" -"UniProt:P0C7V8","DCAF8L2" -"UniProt:P54802","NAGLU" -"UniProt:P35192","MAC1" -"UniProt:P25116","F2R" -"UniProt:P07901","HS90A" -"UniProt:Q15940","ZNF726P1" -"UniProt:P14415","ATP1B2" -"UniProt:P43487","RANBP1" -"UniProt:Q8IYX8","CEP57L1" -"UniProt:Q9Y2K6","UBP20" -"UniProt:Q96S44","TP53RK" -"UniProt:Q96CC6","RHBDF1" -"UniProt:Q9BYR8","KRTAP3-1" -"UniProt:P23769","GATA2" -"UniProt:O09106","Hdac1" -"UniProt:Q96B97","SH3KBP1" -"UniProt:Q14865","ARID5B" -"UniProt:Q9NXN4","GDAP2" -"UniProt:P98198","ATP8B2" -"UniProt:P11229","CHRM1" -"UniProt:O15085","ARHGEF11" -"UniProt:Q9H9H5","MAP6D1" -"UniProt:Q07666","KHDRBS1" -"UniProt:O75368","SH3L1" -"UniProt:Q9P0K9","FRRS1L" -"UniProt:Q9HC07","TMEM165" -"UniProt:P49619","DGKG" -"UniProt:P11802","CDK4" -"UniProt:D3DTR7","D3DTR7" -"UniProt:P05919","VPU" -"UniProt:Q9H2C2","ARV1" -"UniProt:A6NM03","OR2AG2" -"UniProt:P07741","APRT" -"UniProt:Q13464","ROCK1" -"UniProt:Q9Y385","UBE2J1" -"UniProt:Q9ULU8","CADPS" -"UniProt:Q8NEN0","ARMC2" -"UniProt:P01011","SERPINA3" -"UniProt:Q15642","TRIP10" -"UniProt:Q8NA66","CNBD1" -"UniProt:P43320","CRYBB2" -"UniProt:Q15043","SLC39A14" -"UniProt:Q8WUK0","PTPMT1" -"UniProt:P38340","NTM1" -"UniProt:Q8NCI6","GLB1L3" -"UniProt:P01023","A2M" -"UniProt:Q5H9R4","ARMCX4" -"UniProt:Q70626","env" -"UniProt:O95500","CLDN14" -"UniProt:P04581","env" -"UniProt:Q99062","CSF3R" -"UniProt:A6NGG3","C9orf92" -"UniProt:O60239","3BP5" -"UniProt:O75443","TECTA" -"UniProt:Q8N2C7","UNC80" -"UniProt:O95714","HERC2" -"UniProt:Q9UBC0","ONECUT1" -"UniProt:P52292","KPNA2" -"UniProt:A8MXY4","ZNF99" -"UniProt:O43364","HOXA2" -"UniProt:O15182","CETN3" -"UniProt:O00635","TRIM38" -"UniProt:Q9HBI1","PARVB" -"UniProt:P31997","CEACAM8" -"UniProt:O60216","RAD21" -"UniProt:P02656","APOC3" -"UniProt:Q0IIM8","TBC1D8B" -"UniProt:Q9BZL3","SMIM3" -"UniProt:O14492","SH2B2" -"UniProt:O95076","ALX3" -"UniProt:Q04900","CD164" -"UniProt:Q5T4J0","GCNT6" -"UniProt:Q8WU57","Q8WU57" -"UniProt:P62259","Ywhae" -"UniProt:Q18PE1","DOK7" -"UniProt:Q8NCA9","ZN784" -"UniProt:P39962","KC13" -"UniProt:P23819","GRIA2" -"UniProt:Q5JUW0","KRBOX4" -"UniProt:Q8TC59","PIWIL2" -"UniProt:Q0VAF9","Q0VAF9" -"UniProt:P13611","VCAN" -"UniProt:O75113","N4BP1" -"UniProt:Q8N3Y1","FBXW8" -"UniProt:Q12836","ZP4" -"UniProt:Q64151","SEM4C" -"UniProt:P0C853","BAAS2" -"UniProt:Q8TBQ9","TMEM167A" -"UniProt:P59773","KIAA1024L" -"UniProt:Q8N5S3","C2orf73" -"UniProt:Q8NEJ0","DUSP18" -"UniProt:Q5T1S8","NCMAP" -"UniProt:Q7Z5J1","HSD11B1L" -"UniProt:P62873","GNB1" -"UniProt:Q9Y535","POLR3H" -"UniProt:Q9NPJ1","MKKS" -"UniProt:Q8TBE1","CNIH3" -"UniProt:P24385","CCND1" -"UniProt:O15164","TRIM24" -"UniProt:P09601","HMOX1" -"UniProt:Q08257","CRYZ" -"UniProt:Q9BTU6","PI4K2A" -"UniProt:Q9NVR5","DNAAF2" -"UniProt:Q8WWM7","ATXN2L" -"UniProt:Q8N9Q2","SR1IP" -"UniProt:P14921","ETS1" -"UniProt:Q99946","PRRT1" -"UniProt:A2RRL7","TMEM213" -"UniProt:P18577","RHCE" -"UniProt:Q9BQ04","RBM4B" -"UniProt:P40238","MPL" -"UniProt:Q86YJ6","THNSL2" -"UniProt:Q17RY0","CPEB4" -"UniProt:O15350","TP73" -"UniProt:Q06251","YL177" -"UniProt:Q9NSA3","CNBP1" -"UniProt:P29320","EPHA3" -"UniProt:Q6PJH3","Q6PJH3" -"UniProt:Q9H981","ARP8" -"UniProt:Q9NS28","RGS18" -"UniProt:O14792","HS3ST1" -"UniProt:Q15306","IRF4" -"UniProt:P46721","SLCO1A2" -"UniProt:P18077","RPL35A" -"UniProt:P23276","KEL" -"UniProt:P13285","LMP2" -"UniProt:Q9HD43","PTPRH" -"UniProt:Q8IZP7","HS6ST3" -"UniProt:O14717","TRDMT1" -"UniProt:Q9UKJ8","ADAM21" -"UniProt:Q96JM7","L3MBTL3" -"UniProt:Q15596","NCOA2" -"UniProt:P62314","SMD1" -"UniProt:Q96FI4","NEIL1" -"UniProt:Q8WVB3","HEXDC" -"UniProt:Q9Y3L5","RAP2C" -"UniProt:Q9H8E8","KAT14" -"UniProt:O95198","KLHL2" -"UniProt:O00743","PPP6C" -"UniProt:O43325","LYRM1" -"UniProt:P98078","DAB2" -"UniProt:Q96AM0","Q96AM0" -"UniProt:P22607","FGFR3" -"UniProt:A7E2F4","GOLGA8A" -"UniProt:P30459","HLA-A" -"UniProt:Q15061","WDR43" -"UniProt:Q9Y3C5","RNF11" -"UniProt:Q9BVS4","RIOK2" -"UniProt:P10124","SRGN" -"UniProt:A0A0B4J1X8","IGHV3-43" -"UniProt:P24623","CRYAA" -"UniProt:Q9BSD3","RHNO1" -"UniProt:B7ZLH0","B7ZLH0" -"UniProt:Q8C6B2","Rtkn" -"UniProt:P01857","IGHG1" -"UniProt:P31314","TLX1" -"UniProt:O15439","ABCC4" -"UniProt:Q9R1E0","FOXO1" -"UniProt:Q6ZS30","NBEAL1" -"UniProt:P55085","F2RL1" -"UniProt:P08151","GLI1" -"UniProt:Q6UW88","EPGN" -"UniProt:Q9NS62","THSD1" -"UniProt:Q96I76","GPATCH3" -"UniProt:Q9NP91","SLC6A20" -"UniProt:Q8TF62","ATP8B4" -"UniProt:Q9BWT7","CAR10" -"UniProt:Q9UFF9","CNOT8" -"UniProt:Q9BV94","EDEM2" -"UniProt:P78543","BTG2" -"UniProt:O76054","SEC14L2" -"UniProt:O92837","O92837" -"UniProt:Q9WU42","Ncor2" -"UniProt:C0H5X2","C0H5X2" -"UniProt:O75385","ULK1" -"UniProt:Q6F5E7","TXNRD3NB" -"UniProt:A0A024R4S4","A0A024R4S4" -"UniProt:Q9NYW1","TAS2R9" -"UniProt:P07288","KLK3" -"UniProt:Q60974","Ncor1" -"UniProt:P17947","SPI1" -"UniProt:Q9Y692","GMEB1" -"UniProt:O95785","WIZ" -"UniProt:P52746","ZNF142" -"UniProt:Q96BR1","SGK3" -"UniProt:Q86W74","ANKRD46" -"UniProt:O60882","MMP20" -"UniProt:O95190","OAZ2" -"UniProt:Q9NW68","BSDC1" -"UniProt:Q5VVY1","METTL11B" -"UniProt:Q63787","P85A" -"UniProt:Q15116","PDCD1" -"UniProt:Q9BS75","Q9BS75" -"UniProt:Q15475","SIX1" -"UniProt:Q08619","IFI5B" -"UniProt:Q8JL80","SEMA" -"UniProt:P07477","PRSS1" -"UniProt:Q8ND04","SMG8" -"UniProt:O35867","NEB1" -"UniProt:Q8IVH2","FOXP4" -"UniProt:Q61160","FADD" -"UniProt:P42702","LIFR" -"UniProt:Q9BSL1","UBAC1" -"UniProt:Q12181","NDOR1" -"UniProt:O60397", -"UniProt:P21453","S1PR1" -"UniProt:P62910","RPL32" -"UniProt:Q5T653","MRPL2" -"UniProt:P51787","KCNQ1" -"UniProt:Q7Z3J2","C16orf62" -"UniProt:A0A087WY89","A0A087WY89" -"UniProt:Q5Y7A7","HLA-DRB1" -"UniProt:Q9Y2G7","ZFP30" -"UniProt:Q3YEC7","RABL6" -"UniProt:Q9C0G6","DNAH6" -"UniProt:Q14493","SLBP" -"UniProt:O15520","FGF10" -"UniProt:P01567","IFNA7" -"UniProt:Q8N0Y2","ZNF444" -"UniProt:Q61115","Ptch1" -"UniProt:Q8NEM1","ZNF680" -"UniProt:Q8N9B4","ANKRD42" -"UniProt:P0CD91","AQY1" -"UniProt:Q9Y231","FUT9" -"UniProt:Q9ULX7","CA14" -"UniProt:P11766","ADH5" -"UniProt:Q71RH2","FAM57B" -"UniProt:Q2M2W7","C17orf58" -"UniProt:P78395","PRAME" -"UniProt:Q9NVR7","TBCCD1" -"UniProt:Q9NWB1","RFOX1" -"UniProt:P86397","RPP14" -"UniProt:O15162","PLS1" -"UniProt:Q7KZ85","SUPT6H" -"UniProt:Q96M98","PACRG" -"UniProt:O60637","TSPAN3" -"UniProt:Q9ULJ1","ODF2L" -"UniProt:P11245","NAT2" -"UniProt:P35179","SC61G" -"UniProt:Q7L576","CYFP1" -"UniProt:P26992","CNTFR" -"UniProt:P82914","RT15" -"UniProt:Q9HBL6","LRTM1" -"UniProt:Q15404","RSU1" -"UniProt:P54198","HIRA" -"UniProt:Q14240","IF4A2" -"UniProt:P60410","KR108" -"UniProt:Q9BXC9","BBS2" -"UniProt:O60706","ABCC9" -"UniProt:Q96AB6","NTAN1" -"UniProt:P06310","IGKV2-30" -"UniProt:Q9H3S4","TPK1" -"UniProt:Q16890","TPD52L1" -"UniProt:P32455","GBP1" -"UniProt:Q96M02","C10orf90" -"UniProt:Q95168","ZO2" -"UniProt:P40560","YIA1" -"UniProt:O60304","ZNF500" -"UniProt:Q9BZW2","SLC13A1" -"UniProt:Q96MA1","DMRTB1" -"UniProt:P47914","RL29" -"UniProt:Q15654","TRIP6" -"UniProt:Q6P1L6","ZN343" -"UniProt:Q8TF42","UBS3B" -"UniProt:P0CG40","SP9" -"UniProt:Q96PF2","TSSK2" -"UniProt:Q9NUU7","DDX19A" -"UniProt:A0FGR8","ESYT2" -"UniProt:Q13371","PHLP" -"UniProt:Q14773","ICAM4" -"UniProt:A0A183","LCE6A" -"UniProt:Q14332","FZD2" -"UniProt:Q6J272","F166A" -"UniProt:Q96BV0","ZNF775" -"UniProt:Q9HBM0","VEZT" -"UniProt:P62917","RL8" -"UniProt:Q96NE9","FRMD6" -"UniProt:O14830","PPEF2" -"UniProt:Q9BRV3","SLC50A1" -"UniProt:Q14151","SAFB2" -"UniProt:Q01147","Creb1" -"UniProt:Q6ZRT6","PRR23B" -"UniProt:Q9H5H4","ZN768" -"UniProt:Q02386","ZNF45" -"UniProt:Q5QJ74","TBCEL" -"UniProt:Q7Z3V5","ZNF571" -"UniProt:P06331","IGHV4-34" -"UniProt:Q6P4A7","SFXN4" -"UniProt:Q6ZUM4","ARHGAP27" -"UniProt:Q5SRE5","NU188" -"UniProt:Q6ZNI0","GCNT7" -"UniProt:O43390","HNRPR" -"UniProt:Q9HC58","SLC24A3" -"UniProt:Q00653","NFKB2" -"UniProt:Q9NY57","STK32B" -"UniProt:Q9NRY5","FAM114A2" -"UniProt:P38986","ASPG1" -"UniProt:P16284","PECA1" -"UniProt:Q15056","EIF4H" -"UniProt:P24592","IGFBP6" -"UniProt:P32562","CDC5" -"UniProt:Q6PIJ6","FBXO38" -"UniProt:P60900","PSA6" -"UniProt:Q9Y3U8","RL36" -"UniProt:P49140","SKI" -"UniProt:Q14005","IL16" -"UniProt:Q9NR96","TLR9" -"UniProt:B4DXR9","ZNF732" -"UniProt:A2AGH6","MED12" -"UniProt:Q7Z713","ANKRD37" -"UniProt:P22528","SPRR1B" -"UniProt:Q9ESJ1","CABL1" -"UniProt:Q9H777","ELAC1" -"UniProt:P18405","SRD5A1" -"UniProt:Q8IZJ4","RGL4" -"UniProt:Q96GX1","TCTN2" -"UniProt:Q5THK1","PRR14L" -"UniProt:Q8NHY3","GA2L2" -"UniProt:Q6XZF7","DNMBP" -"UniProt:P08588","ADRB1" -"UniProt:Q8N782","ZNF525" -"UniProt:P19784","CSNK2A2" -"UniProt:P69723","vif" -"UniProt:Q9Y5E4","PCDHB5" -"UniProt:P46956","PHO86" -"UniProt:O15353","FOXN1" -"UniProt:P49862","KLK7" -"UniProt:P21709","EPHA1" -"UniProt:Q9Y5I2","PCDHA10" -"UniProt:P29372","3MG" -"UniProt:Q9H8M5","CNNM2" -"UniProt:Q8IX12","CCAR1" -"UniProt:Q6UVK1","CSPG4" -"UniProt:P01568","IFNA21" -"UniProt:Q9NX65","ZSCAN32" -"UniProt:Q9NX00","TMEM160" -"UniProt:Q9Y5F1","PCDHB12" -"UniProt:O15034","RIMBP2" -"UniProt:Q7KZI7","MARK2" -"UniProt:Q9Y5E8","PCDHB15" -"UniProt:Q9UBA6","C6orf48" -"UniProt:P40305","IFI27" -"UniProt:P17936","IGFBP3" -"UniProt:O00148","DDX39A" -"UniProt:P09630","HOXC6" -"UniProt:Q8TE67","EPS8L3" -"UniProt:Q16288","NTRK3" -"UniProt:Q99527","GPER1" -"UniProt:Q14790","CASP8" -"UniProt:O95932","TGM6" -"UniProt:Q9NP50","FA60A" -"UniProt:Q9Y5F8","PCDHGB7" -"UniProt:P46985","MNN11" -"UniProt:Q53RY4","KRTCAP3" -"UniProt:Q9Y5G4","PCDHGA9" -"UniProt:P53252","PIL1" -"UniProt:Q9H7Z7","PTGES2" -"UniProt:Q8IZJ3", -"UniProt:Q9Y5F0","PCDHB13" -"UniProt:Q8IZV2","CKLF8" -"UniProt:P08243","ASNS" -"UniProt:Q2M2D7","TBC1D28" -"UniProt:Q9Y5I0","PCDHA13" -"UniProt:P12318","FCGR2A" -"UniProt:P56556","NDUFA6" -"UniProt:Q9P2X0","DPM3" -"UniProt:Q9H5L6","THAP9" -"UniProt:Q9HAJ7","SAP30L" -"UniProt:O60669","SLC16A7" -"UniProt:P50552","VASP" -"UniProt:P36941","LTBR" -"UniProt:P28476","GABRR2" -"UniProt:Q9UJQ4","SALL4" -"UniProt:P48995","TRPC1" -"UniProt:Q96CQ1","SLC25A36" -"UniProt:Q9Y5J1","UTP18" -"UniProt:Q9Y615","ACTL7A" -"UniProt:Q9UN66","PCDHB8" -"UniProt:P25024","CXCR1" -"UniProt:Q86V71","ZNF429" -"UniProt:P98084","APBA2" -"UniProt:Q13387","JIP2" -"UniProt:Q9UQ90","SPG7" -"UniProt:Q9BUL9","RPP25" -"UniProt:P60321","NANOS2" -"UniProt:Q07986","YL036" -"UniProt:Q62219","TGFI1" -"UniProt:Q9Y5H5","PCDHA9" -"UniProt:Q96LI5","CNOT6L" -"UniProt:Q06986","SIAH2" -"UniProt:Q13258","PTGDR" -"UniProt:Q9NRJ7","PCDHB16" -"UniProt:Q8NFR7","CC148" -"UniProt:Q155Q3","DIXDC1" -"UniProt:Q8NAJ2","CI106" -"UniProt:P00338","LDHA" -"UniProt:Q96MS0","ROBO3" -"UniProt:Q5VUD6","FA69B" -"UniProt:P51648","ALDH3A2" -"UniProt:Q9NSB8","HOMER2" -"UniProt:Q14188","TFDP2" -"UniProt:Q13465","MECOM" -"UniProt:P62993","GRB2" -"UniProt:Q08648","SPAG11B" -"UniProt:Q16620","NTRK2" -"UniProt:Q9Y5E6","PCDHB3" -"UniProt:P70478","APC" -"UniProt:Q13085","ACACA" -"UniProt:P17342","NPR3" -"UniProt:Q86SX6","GLRX5" -"UniProt:Q9BW72","HIGD2A" -"UniProt:Q9HAP6","LIN7B" -"UniProt:O43447","PPIH" -"UniProt:Q96JA1","LRIG1" -"UniProt:Q9BPZ7","MAPKAP1" -"UniProt:P56555","DSCR4" -"UniProt:Q92508","PIEZO1" -"UniProt:Q9BSJ6","FA64A" -"UniProt:Q96PE6","ZIM3" -"UniProt:P21926","CD9" -"UniProt:Q8N4V1","MMGT1" -"UniProt:Q9Y5F3","PCDHB1" -"UniProt:O60292","SIPA1L3" -"UniProt:Q13330","MTA1" -"UniProt:P31937","HIBADH" -"UniProt:Q9Y5H3","PCDHGA10" -"UniProt:O75845","SC5D" -"UniProt:P27694","RPA1" -"UniProt:P41240","CSK" -"UniProt:Q9NUL3","STAU2" -"UniProt:Q8N1F1","C1AS1" -"UniProt:Q9Y5E2","PCDHB7" -"UniProt:Q96MS3","GLT1D1" -"UniProt:Q14676","MDC1" -"UniProt:Q9Y5E1","PCDHB9" -"UniProt:Q86WC6","PPR27" -"UniProt:Q9Y5H6","PCDHA8" -"UniProt:P0CI00","ZNF705B" -"UniProt:Q8WWZ7","ABCA5" -"UniProt:Q5GLZ8","HERC4" -"UniProt:Q86W34","AMZ2" -"UniProt:Q8IZD9","DOCK3" -"UniProt:Q9Y5E5","PCDHB4" -"UniProt:Q9H936","SLC25A22" -"UniProt:O15123","ANGPT2" -"UniProt:Q9UHE5","NAT8" -"UniProt:Q8IWU6","SULF1" -"UniProt:Q8N398","VWA5B2" -"UniProt:Q14CZ8","HEPACAM" -"UniProt:P42695","NCAPD3" -"UniProt:P35789","ZNF93" -"UniProt:P02750","LRG1" -"UniProt:Q9ULZ1","APLN" -"UniProt:O43529","CHST10" -"UniProt:Q9P1Z2","CALCOCO1" -"UniProt:Q6UXT9","ABH15" -"UniProt:O75969","AKAP3" -"UniProt:P16455","MGMT" -"UniProt:Q8TDQ0","HAVCR2" -"UniProt:Q9UBX8","B4GALT6" -"UniProt:Q5VXI9","LIPN" -"UniProt:Q6ZSJ8","C1orf122" -"UniProt:Q9P016","THYN1" -"UniProt:Q9Y5U2","TSSC4" -"UniProt:Q53S58","TMEM177" -"UniProt:Q8N6Y0","USBP1" -"UniProt:Q9NR55","BATF3" -"UniProt:P08559","PDHA1" -"UniProt:Q9Y5N5","N6AMT1" -"UniProt:Q7Z2W4","ZCCHV" -"UniProt:P60010","ACT" -"UniProt:Q9NXH9","TRMT1" -"UniProt:P22459","KCNA4" -"UniProt:P33778","HIST1H2BB" -"UniProt:Q9NTX5","ECHD1" -"UniProt:Q9Y673","ALG5" -"UniProt:Q67020","Q67020" -"UniProt:Q9NS39","ADARB2" -"UniProt:Q7Z589","EMSY" -"UniProt:Q96EH3","MASU1" -"UniProt:Q8NAM6","ZSCA4" -"UniProt:A0PJX4","SHSA3" -"UniProt:P15408","FOSL2" -"UniProt:Q9UBM4","OPTC" -"UniProt:Q8NC26","ZNF114" -"UniProt:P40454","PTPA1" -"UniProt:Q99613","EIF3C" -"UniProt:Q03519","TAP2" -"UniProt:Q07157","TJP1" -"UniProt:Q92621","NUP205" -"UniProt:Q711Q0","C10orf71" -"UniProt:A6NMX2","EIF4E1B" -"UniProt:P09683","SECR" -"UniProt:J3QRU1","J3QRU1" -"UniProt:Q15758","SLC1A5" -"UniProt:Q9P1Q0","VPS54" -"UniProt:Q13394","MB211" -"UniProt:Q8N742","Q8N742" -"UniProt:Q9H172","ABCG4" -"UniProt:P61573","ERVK-9" -"UniProt:Q7Z769","SLC35E3" -"UniProt:P34947","GRK5" -"UniProt:P14678","SNRPB" -"UniProt:P27918","CFP" -"UniProt:P52209","PGD" -"UniProt:P45592","COF1" -"UniProt:P98175","RBM10" -"UniProt:Q03518","TAP1" -"UniProt:Q58A44","PCOTH" -"UniProt:O15382","BCAT2" -"UniProt:P21781","FGF7" -"UniProt:P19404","NDUFV2" -"UniProt:Q9BYD5","CNFN" -"UniProt:P18847","ATF3" -"UniProt:P55289","CDH12" -"UniProt:Q9NWL9","Q9NWL9" -"UniProt:Q6UXM1","LRIG3" -"UniProt:Q9BPX1","HSD17B14" -"UniProt:O95221","OR5F1" -"UniProt:P01906","HLA-DQA2" -"UniProt:Q59EV6","Q59EV6" -"UniProt:Q9BYZ6","RHOBTB2" -"UniProt:Q8WYK2","JDP2" -"UniProt:Q0P6D2","FAM69C" -"UniProt:Q99525","H4G" -"UniProt:A0A0C4DH73","IGKV1-12" -"UniProt:O95167","NDUFA3" -"UniProt:Q9H4K1","RIBC2" -"UniProt:A6NFN9","ANKUB1" -"UniProt:A8MWS1","KIR3DP1" -"UniProt:P53933","APP1" -"UniProt:Q8TDX7","NEK7" -"UniProt:P78314","SH3BP2" -"UniProt:P78537","BLOC1S1" -"UniProt:Q16825","PTN21" -"UniProt:A0JP07","A0JP07" -"UniProt:P11151","LIPL" -"UniProt:Q14953","KIR2DS5" -"UniProt:Q9NY65","EHHADH;TUBA8" -"UniProt:Q9NQS7","INCENP" -"UniProt:P02042","HBD" -"UniProt:Q99706","KIR2DL4" -"UniProt:Q6ZMY3","SPOCD1" -"UniProt:E9PEI4","E9PEI4" -"UniProt:P0CG12","CHTF8" -"UniProt:Q8TD43","TRPM4" -"UniProt:A6NGB0","TMEM191C" -"UniProt:Q96PY6","NEK1" -"UniProt:O60519","CRBL2" -"UniProt:Q13875","MOBP" -"UniProt:Q9JLV5","CUL3" -"UniProt:Q8N3Y7","SDR16C5" -"UniProt:P32464","HYM1" -"UniProt:Q03923","ZNF85" -"UniProt:Q9NRW4","DUSP22" -"UniProt:O75711","SCRG1" -"UniProt:Q9Y275","TNFSF13B" -"UniProt:Q96T75","DSCR8" -"UniProt:Q9HD20","ATP13A1" -"UniProt:O43247","TEX33" -"UniProt:P63127","ERVK-9" -"UniProt:P18085","ARF4" -"UniProt:Q53FW8","Q53FW8" -"UniProt:A0A0S2Z6P0","A0A0S2Z6P0" -"UniProt:P40473","POG1" -"UniProt:P40302","PSA6" -"UniProt:O95471","CLDN7" -"UniProt:P34925","RYK" -"UniProt:Q96NI6","LRFN5" -"UniProt:Q6PFW1","PPIP5K1" -"UniProt:P43632","KIR2DS4" -"UniProt:P28161","GSTM2" -"UniProt:Q9H2G2","SLK" -"UniProt:Q8N109","KIR2DL5A" -"UniProt:Q2M2E3","ODF4" -"UniProt:P98095","FBLN2" -"UniProt:Q7Z5R6","AB1IP" -"UniProt:P30455","HLA-A" -"UniProt:P63126","ERVK-9" -"UniProt:Q96B96","TM159" -"UniProt:Q13491","GPM6B" -"UniProt:P47900","P2RY1" -"UniProt:Q6DN72","FCRL6" -"UniProt:Q9NWT8","AURKAIP1" -"UniProt:Q9H2R5","KLK15" -"UniProt:P53805","RCAN1" -"UniProt:P43630","KIR3DL2" -"UniProt:Q9NRQ5","SMCO4" -"UniProt:P18075","BMP7" -"UniProt:C9JJH3","USP17L10" -"UniProt:Q96PP4","TSG13" -"UniProt:Q9NPG8","ZDHHC4" -"UniProt:P0DMU8","CT45A5" -"UniProt:O15533","TAPBP" -"UniProt:Q96D46","NMD3" -"UniProt:Q9BQ95","ECSIT" -"UniProt:Q8TAM4","Q8TAM4" -"UniProt:Q9UHH9","IP6K2" -"UniProt:Q8NHQ9","DDX55" -"UniProt:Q9UPQ4","TRIM35" -"UniProt:Q92499","DDX1" -"UniProt:Q8IZD4","DCP1B" -"UniProt:O43598","DNPH1" -"UniProt:P27338","MAOB" -"UniProt:Q9NXG0","CNTLN" -"UniProt:Q14954","KIR2DS1" -"UniProt:Q9BZG8","DPH1" -"UniProt:O15209","ZBT22" -"UniProt:Q9Y5J7","TIM9" -"UniProt:Q8WU08","STK32A" -"UniProt:P55771","PAX9" -"UniProt:P55212","CASP6" -"UniProt:Q14593","ZNF273" -"UniProt:P20472","PVALB" -"UniProt:Q9NV06","DCAF13" -"UniProt:Q8WZA0","LZIC" -"UniProt:O95249","GOSR1" -"UniProt:Q8N1F7","NUP93" -"UniProt:Q8TEA7","TBCK" -"UniProt:Q13557","CAMK2D" -"UniProt:P05107","ITGB2" -"UniProt:Q6PJ05","Q6PJ05" -"UniProt:P09529","INHBB" -"UniProt:Q8N126","CADM3" -"UniProt:V9GYM8","V9GYM8" -"UniProt:Q6WN34","CHRDL2" -"UniProt:P53174","PRM8" -"UniProt:Q9H061","TMEM126A" -"UniProt:P49590","HARS2" -"UniProt:Q5EG05","CARD16" -"UniProt:Q9HCE7","SMURF1" -"UniProt:Q6NXT6","TAPT1" -"UniProt:Q86VQ0","LCA5" -"UniProt:Q9NPF8","ADAP2" -"UniProt:P19875","CXCL2" -"UniProt:Q5JRA6","MIA3" -"UniProt:P47121","YJ41" -"UniProt:Q674R7","ATG9B" -"UniProt:P0DMV0","CT45A5" -"UniProt:Q9UBK2","PPARGC1A" -"UniProt:P05386","RPLP1" -"UniProt:Q02858","Tek" -"UniProt:Q8NGC6","OR4K17" -"UniProt:Q9Y426","C2CD2" -"UniProt:Q12974","PTP4A2" -"UniProt:Q9NX61","TMEM161A" -"UniProt:Q8NCW5","NAXE" -"UniProt:Q3UXZ6","FA81A" -"UniProt:Q9P2B4","CT2NL" -"UniProt:A0A0S2Z528","A0A0S2Z528" -"UniProt:Q9J0X9","Q9J0X9" -"UniProt:Q9NQ94","A1CF" -"UniProt:P70175","Dlg3" -"UniProt:Q96F46","IL17RA" -"UniProt:P10768","ESD" -"UniProt:P25799","NFKB1" -"UniProt:Q06033","ITIH3" -"UniProt:P03129","VE7" -"UniProt:Q9NRL3","STRN4" -"UniProt:O95071","UBR5" -"UniProt:Q08E93","F27E3" -"UniProt:O75915","PRAF3" -"UniProt:Q16595","FXN" -"UniProt:Q9Y6I4","USP3" -"UniProt:P03433","PA" -"UniProt:Q5I0X4","CF226" -"UniProt:Q6GQW0","BTBDB" -"UniProt:Q8NAP1","GATS" -"UniProt:Q96PD4","IL17F" -"UniProt:Q6ZN11","ZNF793" -"UniProt:Q5VSL9","STRP1" -"UniProt:Q13118","KLF10" -"UniProt:Q8N9M1","C19orf47" -"UniProt:Q8N0V4","LGI2" -"UniProt:P12018","VPREB1" -"UniProt:Q6NUT2","DPY19L2" -"UniProt:Q80U62","RUBIC" -"UniProt:Q8TBE7","SLC35G2" -"UniProt:Q5VZQ5","TEX36" -"UniProt:Q8IY92","SLX4" -"UniProt:P12493","gag" -"UniProt:O75864","PPP1R37" -"UniProt:Q62179","SEM4B" -"UniProt:Q8WWZ4","ABCA10" -"UniProt:Q99502","EYA1" -"UniProt:Q92504","S39A7" -"UniProt:Q8TCY5","MRAP" -"UniProt:A2ACV6","A2ACV6" -"UniProt:P16330","CN37" -"UniProt:Q6PJG2","EMSA1" -"UniProt:Q9UKW4","VAV3" -"UniProt:Q13136","LIPA1" -"UniProt:Q91YD9","Wasl" -"UniProt:P54860","UFD2" -"UniProt:Q5I0G3","MDH1B" -"UniProt:Q9C0B5","ZDHHC5" -"UniProt:Q96BH3","ELSPBP1" -"UniProt:Q2NKX8","ERC6L" -"UniProt:Q9NYG5","ANAPC11" -"UniProt:Q9Y694","SLC22A7" -"UniProt:Q7TSY8","SGO2" -"UniProt:Q9BX69","CARD6" -"UniProt:P27515","URK1" -"UniProt:O60477","BRNP1" -"UniProt:P97346","NXN" -"UniProt:A9YTQ3","AHRR" -"UniProt:Q9BSJ5","C17orf80" -"UniProt:P16581","SELE" -"UniProt:P49660","SSR4" -"UniProt:O15091","KIAA0391" -"UniProt:Q14141","SEPT6" -"UniProt:P61021","RAB5B" -"UniProt:Q86UU5","GGN" -"UniProt:P53816","HRSL3" -"UniProt:Q9E7P0","Q9E7P0" -"UniProt:Q8N0Z9","VSIG10" -"UniProt:Q80TE2","Q80TE2" -"UniProt:Q5VYM1","C9orf131" -"UniProt:P51943","Ccna2" -"UniProt:Q5RKV6","EXOSC6" -"UniProt:P61421","ATP6V0D1" -"UniProt:Q8R4I7","NETO1" -"UniProt:Q8N614","TMEM156" -"UniProt:Q6PL18","ATAD2" -"UniProt:Q14114","LRP8" -"UniProt:O43815","STRN" -"UniProt:Q9NY97","B3GNT2" -"UniProt:Q6ULP2","AFTPH" -"UniProt:Q9BY49","PECR" -"UniProt:Q9H2A2","ALDH8A1" -"UniProt:P46660","AINX" -"UniProt:P06732","CKM" -"UniProt:Q9BRL7","SEC22C" -"UniProt:P42345","MTOR" -"UniProt:Q13349","ITGAD" -"UniProt:Q96AV8","E2F7" -"UniProt:Q9NP77","SSU72" -"UniProt:O55106","STRN" -"UniProt:P35438","Grin1" -"UniProt:O75460","ERN1" -"UniProt:Q96BA4","Q96BA4" -"UniProt:Q9Y4C1","KDM3A" -"UniProt:O94880","PHF14" -"UniProt:P60709","ACTB" -"UniProt:O14531","DPYL4" -"UniProt:P01730","CD4" -"UniProt:Q6P9B9","INTS5" -"UniProt:P18760","Cfl1" -"UniProt:Q9BWV3","CDADC1" -"UniProt:P22339","GA45B" -"UniProt:P98179","RBM3" -"UniProt:Q96PN6","ADCY10" -"UniProt:Q9ULX3","NOB1" -"UniProt:Q9WUH7","SEM4G" -"UniProt:P01763","IGHV3-48" -"UniProt:Q8TDX5","ACMSD" -"UniProt:P15209","Ntrk2" -"UniProt:Q9UK17","KCND3" -"UniProt:Q5VU36","SPATA31A5" -"UniProt:A2RUC4","TYW5" -"UniProt:P62841","RS15" -"UniProt:P48556","PSMD8" -"UniProt:Q9U4X0","ebl1" -"UniProt:Q00889","PSG6" -"UniProt:Q8NI17","IL31RA" -"UniProt:Q8NAG6","ANKLE1" -"UniProt:Q6IQ32","ADNP2" -"UniProt:Q92783","STAM" -"UniProt:Q9ULW8","PADI3" -"UniProt:Q9UHC9","NPC1L1" -"UniProt:Q9Y5H1","PCDHGA2" -"UniProt:Q9C0J9","BHLHE41" -"UniProt:Q13501","SQSTM1" -"UniProt:Q6PIU2","NCEH1" -"UniProt:Q9NPF4","OSGEP" -"UniProt:O95453","PARN" -"UniProt:Q0VG06","FAAP100" -"UniProt:O60610","DIAPH1" -"UniProt:P28023","DCTN1" -"UniProt:Q9Y5H2","PCDHGA11" -"UniProt:Q02821","IMA1" -"UniProt:Q3SY46","KR133" -"UniProt:Q9Y5G5","PCDHGA8" -"UniProt:P06748","NPM" -"UniProt:Q96IY4","CPB2" -"UniProt:Q96RJ6","FER3L" -"UniProt:Q96GM5","SMRD1" -"UniProt:Q13761","RUNX3" -"UniProt:Q9Y5G8","PCDHGA5" -"UniProt:O60499","STX10" -"UniProt:Q15027","ACAP1" -"UniProt:O75695","RP2" -"UniProt:Q9P291","ARMX1" -"UniProt:P55036","PSMD4" -"UniProt:O75298","RTN2" -"UniProt:Q99856","ARID3A" -"UniProt:O96001","PPP1R17" -"UniProt:Q9UN67","PCDHB10" -"UniProt:Q9C099","LRRCC1" -"UniProt:Q969Q1","TRIM63" -"UniProt:Q92766","RREB1" -"UniProt:O94759","TRPM2" -"UniProt:Q5TCM9","LCE5A" -"UniProt:P0C7P3","SLFN14" -"UniProt:Q08708","CD300C" -"UniProt:Q9Y6X5","ENPP4" -"UniProt:P32238","CCKAR" -"UniProt:Q9UK97","FBXO9" -"UniProt:Q9Y5G1","PCDHGB3" -"UniProt:P03169","VIE1" -"UniProt:Q96IM9","DYDC2" -"UniProt:P46678","BDP1" -"UniProt:Q04759","PRKCQ" -"UniProt:P55259","GP2" -"UniProt:Q92521","PIGB" -"UniProt:A8K8Y5","A8K8Y5" -"UniProt:Q7Z407","CSMD3" -"UniProt:Q9Y5E9","PCDHB14" -"UniProt:Q6UW32","IGFL1" -"UniProt:Q9Y5W7","SNX14" -"UniProt:Q92886","NGN1" -"UniProt:Q92535","PIGC" -"UniProt:O15537","RS1" -"UniProt:Q5SXM1","ZNF678" -"UniProt:O95149","SNUPN" -"UniProt:Q5EBL8","PDZD11" -"UniProt:Q6DD87","ZNF787" -"UniProt:Q96KA5","CLPTM1L" -"UniProt:P0CG20","PRR35" -"UniProt:P19174","PLCG1" -"UniProt:P06401","PGR" -"UniProt:Q8N1H7","S6OS1" -"UniProt:Q99952","PTN18" -"UniProt:P43699","NKX2-1" -"UniProt:Q6H3X3","RAET1G" -"UniProt:Q9Y5F6","PCDHGC5" -"UniProt:Q08209","PPP3CA" -"UniProt:O95867","LY6G6C" -"UniProt:Q13541","4EBP1" -"UniProt:Q9UNA3","A4GNT" -"UniProt:Q969U6","FBXW5" -"UniProt:P55017","SLC12A3" -"UniProt:O75093","SLIT1" -"UniProt:Q969L2","MAL2" -"UniProt:Q96JC1","VPS39" -"UniProt:Q9Y5F2","PCDHB11" -"UniProt:Q9BY12","SCAPER" -"UniProt:Q5MY95","ENTPD8" -"UniProt:A0PJZ3","GXYLT2" -"UniProt:Q96EK6","GNPNAT1" -"UniProt:Q6NT55","CYP4F22" -"UniProt:Q96BY7","ATG2B" -"UniProt:Q6P5X5","CV039" -"UniProt:Q6ZS86","GK5" -"UniProt:Q15003","NCAPH" -"UniProt:Q6UY27","PATE2" -"UniProt:Q9HB89","NMUR1" -"UniProt:Q6ZS27","ZNF662" -"UniProt:Q8WVP5","TNFAIP8L1" -"UniProt:Q9Y5G7","PCDHGA6" -"UniProt:P60006","ANAPC15" -"UniProt:P51654","GPC3" -"UniProt:Q96EZ8","MCRS1" -"UniProt:Q9NZM5","NOP53" -"UniProt:Q9UHB4","NDOR1" -"UniProt:Q9Y5H0","PCDHGA3" -"UniProt:Q2NKQ1","SGSM1" -"UniProt:Q5NV75","IGLV3-22" -"UniProt:Q14D33","RTP5" -"UniProt:Q9UL18","AGO1" -"UniProt:P56470","LEG4" -"UniProt:Q9UN70","PCDHGC3" -"UniProt:O95837","GNA14" -"UniProt:Q96FX9","Q96FX9" -"UniProt:P61601","NCALD" -"UniProt:Q96QD5","DEPDC7" -"UniProt:B2RUY7","VWC2L" -"UniProt:Q68DK7","MSL1" -"UniProt:Q2VIQ3","KIF4B" -"UniProt:Q9BRT8","CBWD1" -"UniProt:Q86YC2","PALB2" -"UniProt:A4D161","F221A" -"UniProt:Q76RH3","Q76RH3" -"UniProt:Q9Y666","SLC12A7" -"UniProt:P41223","BUD31" -"UniProt:P46108","CRK" -"UniProt:Q6P9F7","LRRC8B" -"UniProt:Q8N8Q8","COX18" -"UniProt:Q6NXN4","D19P1" -"UniProt:O60225","SSX5" -"UniProt:Q8TCJ0","FBX25" -"UniProt:O60330","PCDHGA12" -"UniProt:Q96D53","COQ8B" -"UniProt:Q9Y6D9","MAD1L1" -"UniProt:P30536","TSPO" -"UniProt:Q9H094","NBPF3" -"UniProt:Q96LX7","CCDC17" -"UniProt:P08069","IGF1R" -"UniProt:Q96R05","RET7" -"UniProt:P25101","EDNRA" -"UniProt:Q92997","DVL3" -"UniProt:Q96SW2","CRBN" -"UniProt:P33681","CD80" -"UniProt:P16389","KCNA2" -"UniProt:O95620","DUS4L" -"UniProt:Q8IUH5","ZDHHC17" -"UniProt:A8K1J0","A8K1J0" -"UniProt:O43493","TGON2" -"UniProt:O94916","NFAT5" -"UniProt:Q05BQ5","MBTD1" -"UniProt:Q9UHX1","PUF60" -"UniProt:P07919","UQCRH" -"UniProt:Q9H8P0","SRD5A3" -"UniProt:Q8WWG9","KCNE4" -"UniProt:P59543","TAS2R20" -"UniProt:Q6L9W6","B4GALNT3" -"UniProt:Q99102","MUC4" -"UniProt:P43627","KIR2DL2" -"UniProt:P21796","VDAC1" -"UniProt:P05549","TFAP2A" -"UniProt:Q6MZQ0","PRR5L" -"UniProt:Q5H8A4","PIGG" -"UniProt:Q8IWV1","LAX1" -"UniProt:Q8NCE0","TSEN2" -"UniProt:Q9HB71","CYBP" -"UniProt:P43250","GRK6" -"UniProt:Q92637","FCGR1B" -"UniProt:P55317","FOXA1" -"UniProt:O14907","TX1B3" -"UniProt:P01303","NPY" -"UniProt:Q05682","CALD1" -"UniProt:Q8VSD5","Q8VSD5" -"UniProt:Q9UQB9","AURKC" -"UniProt:O75787","ATP6AP2" -"UniProt:Q96EH8","NEURL3" -"UniProt:Q14050","COL9A3" -"UniProt:P09496","CLTA" -"UniProt:Q9Y219","JAG2" -"UniProt:E9PK97","E9PK97" -"UniProt:Q9Y4F4","CREC1" -"UniProt:Q9UGJ0","PRKAG2" -"UniProt:O60359","CACNG3" -"UniProt:Q07379","YD057" -"UniProt:P17861","XBP1" -"UniProt:Q16864","ATP6V1F" -"UniProt:P58417","NXPH1" -"UniProt:Q9NRM1","ENAM" -"UniProt:Q5VV42","CDKAL1" -"UniProt:Q4VC05","BCL7A" -"UniProt:P10276","RARA" -"UniProt:P31785","IL2RG" -"UniProt:Q9NXW9","ALKB4" -"UniProt:O95264","HTR3B" -"UniProt:O60825","PFKFB2" -"UniProt:Q68J44","DUPD1" -"UniProt:P37268","FDFT1" -"UniProt:Q9UHB7","AFF4" -"UniProt:P49454","CENPF" -"UniProt:Q53QZ3","ARHGAP15" -"UniProt:Q02297","NRG1" -"UniProt:O43567","RNF13" -"UniProt:Q9P0J6","MRPL36" -"UniProt:Q8N9W4","GOLGA6L2" -"UniProt:Q9Y3M2","CBY1" -"UniProt:P11532","DMD" -"UniProt:Q86WA6","BPHL" -"UniProt:P61019","RAB2A" -"UniProt:O18973","RABX5" -"UniProt:P11169","SLC2A3" -"UniProt:P35568","IRS1" -"UniProt:Q7Z4P5","GDF7" -"UniProt:P59052","B3AS1" -"UniProt:Q6TFL3","CCDC171" -"UniProt:P42081","CD86" -"UniProt:O60568","PLOD3" -"UniProt:Q07912","ACK1" -"UniProt:A8MQB3","C17orf51" -"UniProt:Q96C00","ZBTB9" -"UniProt:P26440","IVD" -"UniProt:Q9ULT0","TTC7A" -"UniProt:Q9UIR0","BTNL2" -"UniProt:Q9NWQ8","PHAG1" -"UniProt:Q9UQF2","MAPK8IP1" -"UniProt:Q15080","NCF4" -"UniProt:O95407","TNF6B" -"UniProt:Q7Z3K3","POGZ" -"UniProt:Q9UQR0","SCML2" -"UniProt:Q32MN6","Q32MN6" -"UniProt:Q15052","ARHGEF6" -"UniProt:P38744","PHS" -"UniProt:O35973","Per1" -"UniProt:Q13224","GRIN2B" -"UniProt:Q8WV83","SLC35F5" -"UniProt:Q9P253","VPS18" -"UniProt:O75953","DNJB5" -"UniProt:P28700","RXRA" -"UniProt:P05937","CALB1" -"UniProt:Q6IN51","Q6IN51" -"UniProt:Q6FIF0","ZFAND6" -"UniProt:O43291","SPINT2" -"UniProt:Q13428","TCOF1" -"UniProt:Q9HCE0","EPG5" -"UniProt:Q7Z408","CSMD2" -"UniProt:Q9NZC9","SMARCAL1" -"UniProt:Q5SZL2","CEP85L" -"UniProt:Q3MIV0","KRTAP22-1" -"UniProt:Q03579","LIP1" -"UniProt:Q15427","SF3B4" -"UniProt:P61224","RAP1B" -"UniProt:Q9Y5X1","SNX9" -"UniProt:Q9BZF3","OSBPL6" -"UniProt:Q14738","PPP2R5D" -"UniProt:Q6NVH9","Q6NVH9" -"UniProt:O14964","HGS" -"UniProt:P01034","CST3" -"UniProt:P89055","P89055" -"UniProt:Q8IY18","SMC5" -"UniProt:A6QL63","BTBD11" -"UniProt:Q6UWP7","LCLAT1" -"UniProt:Q86UP0","CDH24" -"UniProt:Q8IWV7","UBR1" -"UniProt:Q96H96","COQ2" -"UniProt:Q16559","TAL2" -"UniProt:A0A0S2Z5R8","A0A0S2Z5R8" -"UniProt:P51808","DYLT3" -"UniProt:O43184","ADAM12" -"UniProt:Q9BSV6","TSEN34" -"UniProt:Q5JTC6","AMER1" -"UniProt:Q8WXE9","STON2" -"UniProt:O15527","OGG1" -"UniProt:P06396","GSN" -"UniProt:Q9HC62","SENP2" -"UniProt:Q9P104","DOK5" -"UniProt:Q96L73","NSD1" -"UniProt:Q9NZ94","NLGN3" -"UniProt:P48047","ATPO" -"UniProt:P24534","EF1B" -"UniProt:P0CG39","POTEJ" -"UniProt:Q86W56","BPHL" -"UniProt:Q9BW60","ELOVL1" -"UniProt:Q8NFY4","SEMA6D" -"UniProt:Q8WWA6","Q8WWA6" -"UniProt:Q86Y01","DTX1" -"UniProt:Q5JUK9","PAGE3" -"UniProt:P59190","RAB15" -"UniProt:Q9NXR1","NDE1" -"UniProt:Q9Y5G6","PCDHGA7" -"UniProt:Q9BRP4","PAAF1" -"UniProt:P29341","PABP1" -"UniProt:Q14CN2","CLCA4" -"UniProt:Q9BQL6","FERMT1" -"UniProt:Q8NGB4","OR4S1" -"UniProt:Q9H7L2","KIR3DX1" -"UniProt:Q5MNZ9","WIPI1" -"UniProt:O95365","ZBT7A" -"UniProt:Q9Y5F9","PCDHGB6" -"UniProt:A0A0C4DGP8","A0A0C4DGP8" -"UniProt:P20807","CAPN3" -"UniProt:O60890","OPHN1" -"UniProt:P52272","HNRPM" -"UniProt:O75072","FKTN" -"UniProt:Q9UHX3","ADGRE2" -"UniProt:O60248","SOX15" -"UniProt:Q8WVZ1","ZDHHC19" -"UniProt:Q96FB5","RRNAD1" -"UniProt:P61626","LYZ" -"UniProt:Q04695","KRT17" -"UniProt:P56706","WNT7B" -"UniProt:P02671","FGA" -"UniProt:Q92834","RPGR" -"UniProt:P35900","KRT20" -"UniProt:Q9UN71","PCDHGB4" -"UniProt:A0A0S2Z4M1","A0A0S2Z4M1" -"UniProt:Q86VF5","MOGAT3" -"UniProt:Q9Y5G9","PCDHGA4" -"UniProt:Q8IYD2","KLHDC8A" -"UniProt:Q8NFZ3","NLGN4Y" -"UniProt:P27824","CALX" -"UniProt:Q9H410","DSN1" -"UniProt:Q9UPQ3","AGAP1" -"UniProt:Q96HV5","TM41A" -"UniProt:O14468","YO304" -"UniProt:P10073","ZSC22" -"UniProt:P02647","APOA1" -"UniProt:P80162","CXCL6" -"UniProt:Q71RC9","SMIM5" -"UniProt:Q5U5X8","FAM222A" -"UniProt:Q9UPY5","XCT" -"UniProt:Q9Y5H4","PCDHGA1" -"UniProt:Q04656","ATP7A" -"UniProt:Q60I27","AL2CL" -"UniProt:Q9Y5G2","PCDHGB2" -"UniProt:Q9NS91","RAD18" -"UniProt:Q8IYR2","SMYD4" -"UniProt:Q9NPH3","IL1AP" -"UniProt:Q96QD9","FYTTD1" -"UniProt:Q924I2","M4K3" -"UniProt:P28067","DMA" -"UniProt:O75923","DYSF" -"UniProt:Q9BUB4","ADAT1" -"UniProt:Q9NZK7","PLA2G2E" -"UniProt:Q92529","SHC3" -"UniProt:Q13751","LAMB3" -"UniProt:Q9NSA2","KCND1" -"UniProt:Q96DN2","VWCE" -"UniProt:Q86XZ4","SPATS2" -"UniProt:Q8N5N7","MRPL50" -"UniProt:Q9H1N7","SLC35B3" -"UniProt:P02649","APOE" -"UniProt:A6NK44","GLOD5" -"UniProt:Q01590","SED5" -"UniProt:A0A140LJL1","A0A140LJL1" -"UniProt:Q9NW82","WDR70" -"UniProt:Q9R064","GORS2" -"UniProt:Q8IVA1","PCP2" -"UniProt:P78318","IGBP1" -"UniProt:Q5T2W1","NHRF3" -"UniProt:P13760","2B14" -"UniProt:Q9Z2S7","TSC22D3" -"UniProt:Q13326","SGCG" -"UniProt:P21281","ATP6V1B2" -"UniProt:Q96GL9","FAM163A" -"UniProt:Q9Y5G0","PCDHGB5" -"UniProt:P53076","VID30" -"UniProt:Q99714","HSD17B10" -"UniProt:P26718","KLRK1" -"UniProt:O95399","UTS2" -"UniProt:P51572","BCAP31" -"UniProt:Q7L311","ARMCX2" -"UniProt:Q8N461","FBXL16" -"UniProt:Q13569","TDG" -"UniProt:Q9NYW3","TAS2R7" -"UniProt:O60479","DLX3" -"UniProt:Q9ULP9","TBC1D24" -"UniProt:Q96NL6","SCLT1" -"UniProt:A8K8V0","ZN785" -"UniProt:P46100","ATRX" -"UniProt:Q8IY63","AMOTL1" -"UniProt:Q8NGJ4","OR52E2" -"UniProt:P0CG35","TMSB15B" -"UniProt:Q5KSL6","DGKK" -"UniProt:Q9ULL8","SHROOM4" -"UniProt:Q9NX57","RAB20" -"UniProt:Q6ZMS7","ZN783" -"UniProt:P38109","YBY9" -"UniProt:Q9P2K5","MYEF2" -"UniProt:Q147U1","ZNF846" -"UniProt:P17600","SYN1" -"UniProt:Q8N3H0","FAM19A2" -"UniProt:Q96FN5","KIF12" -"UniProt:Q9Y5F7","PCDHGC4" -"UniProt:Q8N9N7","LRRC57" -"UniProt:P32248","CCR7" -"UniProt:A2A368","MAGEB16" -"UniProt:Q13003","GRIK3" -"UniProt:P15056","BRAF" -"UniProt:Q9BTE2","Q9BTE2" -"UniProt:Q8WUF8","FAM172A" -"UniProt:Q8TDM5","SPACA4" -"UniProt:Q9H4L4","SENP3" -"UniProt:C9JLJ4","USP17L13" -"UniProt:P82909","MRPS36" -"UniProt:O94779","CNTN5" -"UniProt:P61769","B2M" -"UniProt:Q9Y5C1","ANGPTL3" -"UniProt:Q92851","CASP10" -"UniProt:P61572","ERVK-19" -"UniProt:O75604","UBP2" -"UniProt:Q7RTY9","PRSS41" -"UniProt:Q14994","NR1I3" -"UniProt:Q96AF5","Q96AF5" -"UniProt:O00255","MEN1" -"UniProt:Q9NP98","MYOZ1" -"UniProt:Q8N5Z5","KCTD17" -"UniProt:Q96B49","TOMM6" -"UniProt:Q99558","MAP3K14" -"UniProt:Q69383","ERVK-6" -"UniProt:P63125","ERVK-25" -"UniProt:P63130","ERVK-7" -"UniProt:Q8N878","FRMD1" -"UniProt:O95158","NXPH4" -"UniProt:Q9GZS0","DNAI2" -"UniProt:Q05639","EEF1A2" -"UniProt:A0A1B0GTK8","A0A1B0GTK8" -"UniProt:Q9Y691","KCNMB2" -"UniProt:Q6GPI1","CTRB2" -"UniProt:Q9P2F5","STOX2" -"UniProt:O94760","DDAH1" -"UniProt:Q7Z6P3","RAB44" -"UniProt:Q8NET5","NFAM1" -"UniProt:P16662","UGT2B7" -"UniProt:P38206","RFT1" -"UniProt:Q6YP21","KYAT3" -"UniProt:P0CB47","UBTFL1" -"UniProt:P53621","COPA" -"UniProt:P22732","SLC2A5" -"UniProt:Q99467","CD180" -"UniProt:Q6UB35","MTHFD1L" -"UniProt:Q9H8G1","ZNF430" -"UniProt:Q9HCM1","KIAA1551" -"UniProt:Q6UXH9","PAMR1" -"UniProt:Q5MCW4","ZNF569" -"UniProt:Q9P243","ZFAT" -"UniProt:P09917","ALOX5" -"UniProt:Q9UBX7","KLK11" -"UniProt:B2R8Y4","B2R8Y4" -"UniProt:P03951","F11" -"UniProt:Q8WV22","NSMCE1" -"UniProt:Q96C03","MID49" -"UniProt:Q9Y233","PDE10A" -"UniProt:Q9UNL4","ING4" -"UniProt:Q86VI1","EXOC3L1" -"UniProt:Q9NWN3","FBXO34" -"UniProt:P05198","IF2A" -"UniProt:P03952","KLKB1" -"UniProt:Q9NV35","NUDT15" -"UniProt:P13501","CCL5" -"UniProt:P00973","OAS1" -"UniProt:Q12899","TRIM26" -"UniProt:O14544","SOCS6" -"UniProt:P25453","DMC1" -"UniProt:Q9UBU2","DKK2" -"UniProt:Q8NHP8","PLBD2" -"UniProt:Q9Y4P8","WIPI2" -"UniProt:Q14644","RASA3" -"UniProt:P20930","FLG" -"UniProt:Q9BTP7","FAAP24" -"UniProt:P10646","TFPI" -"UniProt:Q9P126","CLEC1B" -"UniProt:P01889","HLA-B" -"UniProt:O14594","NCAN" -"UniProt:Q6ZRV2","FAM83H" -"UniProt:Q8WXK1","ASB15" -"UniProt:Q8NA19","LMBL4" -"UniProt:Q8N612","FAM160A2" -"UniProt:Q9NTJ4","MAN2C1" -"UniProt:Q96EW2","HBAP1" -"UniProt:Q13507","TRPC3" -"UniProt:Q15628","TRADD" -"UniProt:Q6ZYL4","GTF2H5" -"UniProt:Q8TEX9","IPO4" -"UniProt:Q8TE59","ADAMTS19" -"UniProt:O14771","ZNF213" -"UniProt:Q92551","IP6K1" -"UniProt:Q9Y3Q8","T22D4" -"UniProt:Q96L92","SNX27" -"UniProt:Q9NRZ9","HELLS" -"UniProt:P31689","DNJA1" -"UniProt:Q6B9Z1","IGFL4" -"UniProt:Q8IX15","HOMEZ" -"UniProt:Q5VZL5","ZMYM4" -"UniProt:Q8N371","KDM8" -"UniProt:Q96P70","IPO9" -"UniProt:Q9Y678","COPG1" -"UniProt:P63215","GBG3" -"UniProt:Q9UKZ4","TENM1" -"UniProt:P12931","SRC" -"UniProt:Q5T5C0","STXBP5" -"UniProt:Q9HD64","XAGE1E" -"UniProt:Q96NL1","TMEM74" -"UniProt:P36149","BET3" -"UniProt:Q5HY92","FIGN" -"UniProt:Q9H0W8","SMG9" -"UniProt:Q8WWE8","Q8WWE8" -"UniProt:Q8WXH0","SYNE2" -"UniProt:Q5TGY1","TMCO4" -"UniProt:Q9Y547","HSPB11" -"UniProt:O15229","KMO" -"UniProt:Q12083","MLH3" -"UniProt:Q96S42","NODAL" -"UniProt:P51671","CCL11" -"UniProt:Q08881","ITK" -"UniProt:P23588","EIF4B" -"UniProt:Q60680","IKKA" -"UniProt:Q9UGQ3","SLC2A6" -"UniProt:Q9BWT1","CDCA7" -"UniProt:Q9Y5S2","MRCKB" -"UniProt:P59991","KRTAP12-2" -"UniProt:O95347","SMC2" -"UniProt:Q8NGZ3","OR13G1" -"UniProt:Q70Z35","PREX2" -"UniProt:P08571","CD14" -"UniProt:Q13352","ITGB3BP" -"UniProt:Q9H019","MFR1L" -"UniProt:Q9UQM7","KCC2A" -"UniProt:Q9Y657","SPIN1" -"UniProt:Q3LFD5","USP41" -"UniProt:P07384","CAPN1" -"UniProt:Q6ZUT9","DENND5B" -"UniProt:P01911","HLA-DRB1" -"UniProt:Q96G03","PGM2" -"UniProt:Q9NYK6","EURL" -"UniProt:Q8NEC5","CATSPER1" -"UniProt:P09211","GSTP1" -"UniProt:Q86WP2","GPBP1" -"UniProt:Q96LM5","CD045" -"UniProt:Q8TDM6","DLG5" -"UniProt:E1X6C6","E1X6C6" -"UniProt:Q8N584","TTC39C" -"UniProt:P55072","VCP" -"UniProt:Q14524","SCN5A" -"UniProt:Q9JXV4","Q9JXV4" -"UniProt:Q9UIF9","BAZ2A" -"UniProt:Q9NX74","DUS2" -"UniProt:P12109","COL6A1" -"UniProt:Q8TDI0","CHD5" -"UniProt:A0A0C5B5G6","RNR1" -"UniProt:P62424","RL7A" -"UniProt:Q9BRQ5","ORAI3" -"UniProt:Q969W8","ZNF566" -"UniProt:P46013","KI67" -"UniProt:P30491","HLA-B" -"UniProt:Q5UE93","PI3R6" -"UniProt:P03377","env" -"UniProt:O60583","CCNT2" -"UniProt:Q9BX51","GGTLC1" -"UniProt:P20290","BTF3" -"UniProt:Q96AQ6","PBIP1" -"UniProt:Q9BYZ8","REG4" -"UniProt:O93077","O93077" -"UniProt:P56270","MAZ" -"UniProt:Q62077","Plcg1" -"UniProt:Q6ZRR5","TMEM136" -"UniProt:Q9P035","HACD3" -"UniProt:P15116","CADH2" -"UniProt:Q701N4","KRTAP5-2" -"UniProt:P11940","PABP1" -"UniProt:Q8N3X6","LCORL" -"UniProt:Q9BXX0","EMILIN2" -"UniProt:Q96ME1","FBXL18" -"UniProt:Q14CW9","ATXN7L3" -"UniProt:Q96AL5","Q96AL5" -"UniProt:O43795","MYO1B" -"UniProt:Q9NVP4","DZANK1" -"UniProt:Q01094","E2F1" -"UniProt:Q96F44","TRIM11" -"UniProt:Q8NC01","CLC1A" -"UniProt:P18124","RL7" -"UniProt:Q9UH62","ARMCX3" -"UniProt:P25398","RS12" -"UniProt:P82675","MRPS5" -"UniProt:P48163","ME1" -"UniProt:A8MVS1","ZNF705F" -"UniProt:Q12905","ILF2" -"UniProt:P14616","INSRR" -"UniProt:P55345","ANM2" -"UniProt:Q8BHK6","SLAF7" -"UniProt:Q86Y26","NUTM1" -"UniProt:P60763","RAC3" -"UniProt:Q13247","SRSF6" -"UniProt:Q9Y6T7","DGKB" -"UniProt:P15384","KCNA3" -"UniProt:A0A0G2JJX2","A0A0G2JJX2" -"UniProt:A0AVI4","TMEM129" -"UniProt:Q8N0V3","RBFA" -"UniProt:P59541","TAS2R30" -"UniProt:P46776","RL27A" -"UniProt:A9QPL9","A9QPL9" -"UniProt:Q9Z252","Lin7b" -"UniProt:Q6VN20","RANBP10" -"UniProt:Q11130","FUT7" -"UniProt:P11474","ESRRA" -"UniProt:Q5SZD4","GLYATL3" -"UniProt:Q9NQ29","LUC7L" -"UniProt:O14978","ZNF263" -"UniProt:Q8TF68","ZNF384" -"UniProt:H3BQL7","H3BQL7" -"UniProt:Q9H832","UBE2Z" -"UniProt:Q9BZE4","NOG1" -"UniProt:Q7Z4T8","GALNTL5" -"UniProt:Q9UKX5","ITGA11" -"UniProt:P05923","VPU" -"UniProt:Q96S55","WRNIP1" -"UniProt:Q969Q0","RL36L" -"UniProt:Q6P6B1","ERIC5" -"UniProt:O14867","BACH1" -"UniProt:P30457","HLA-A" -"UniProt:Q7Z7H5","TMED4" -"UniProt:Q14669","TRIPC" -"UniProt:Q9ULE3","DENND2A" -"UniProt:Q5H8A3","NMS" -"UniProt:O14782","KIF3C" -"UniProt:P0CG47","UBB" -"UniProt:Q8IVL6","P3H3" -"UniProt:O75192","PEX11A" -"UniProt:P04580","env" -"UniProt:Q92966","SNAPC3" -"UniProt:Q00613","HSF1" -"UniProt:Q02447","SP3" -"UniProt:Q9UEU5","GAGE2E" -"UniProt:Q9Y468","LMBL1" -"UniProt:P09132","SRP19" -"UniProt:Q9H2K0","MTIF3" -"UniProt:P26368","U2AF2" -"UniProt:Q9UMY1","NOL7" -"UniProt:Q9UN36","NDRG2" -"UniProt:P17693","HLA-G" -"UniProt:Q9NP62","GCM1" -"UniProt:P55011","SLC12A2" -"UniProt:P23467","PTPRB" -"UniProt:P36578","RL4" -"UniProt:Q5U5Q3","MEX3C" -"UniProt:P59901","LILRA4" -"UniProt:Q8NH93","OR1L3" -"UniProt:Q9H3R5","CENPH" -"UniProt:P36956","SREBF1" -"UniProt:Q9NPI1","BRD7" -"UniProt:P03378","env" -"UniProt:A0PJW6","TMEM223" -"UniProt:Q6H8Q1","ABLIM2" -"UniProt:P04583","env" -"UniProt:P06881","CALCA" -"UniProt:Q96AT9","RPE" -"UniProt:P20155","ISK2" -"UniProt:Q96NX9","DACH2" -"UniProt:Q00610","CLH1" -"UniProt:P84098","RL19" -"UniProt:Q9UQ26","RIMS2" -"UniProt:O95298","NDUFC2" -"UniProt:Q8NGG6","OR8B12" -"UniProt:Q1EHW4","SAP25" -"UniProt:O00270","GPR31" -"UniProt:P59598","ASXL1" -"UniProt:Q9NYW4","TAS2R5" -"UniProt:P47134","BIR1" -"UniProt:Q9H6E5","TUT1" -"UniProt:P23511","NFYA" -"UniProt:Q969P5","FBXO32" -"UniProt:Q12912","LRMP" -"UniProt:Q15431","SYCP1" -"UniProt:Q0D2N8","Q0D2N8" -"UniProt:O95644","NFATC1" -"UniProt:Q8NG11","TSPAN14" -"UniProt:Q96HI0","SENP5" -"UniProt:Q32MZ4","LRRFIP1" -"UniProt:P69699","VPU" -"UniProt:P55073","IOD3" -"UniProt:P58743","SLC26A5" -"UniProt:Q16659","MAPK6" -"UniProt:P05546","SERPIND1" -"UniProt:Q8NFJ8","BHLHE22" -"UniProt:Q9Y5S9","RBM8A" -"UniProt:P35527","KRT9" -"UniProt:Q16585","SGCB" -"UniProt:Q9UQ53","MGAT4B" -"UniProt:Q8WV48","CCDC107" -"UniProt:Q96A23","CPNE4" -"UniProt:Q9GZP9","DERL2" -"UniProt:Q8N960","CEP120" -"UniProt:P30988","CALCR" -"UniProt:P53384","NUBP1" -"UniProt:I6L996","I6L996" -"UniProt:P03431","PB1" -"UniProt:Q9NQW8","CNGB3" -"UniProt:Q9UHV5","RAPGEFL1" -"UniProt:Q9NV88","INTS9" -"UniProt:P62072","TIM10" -"UniProt:Q9UMR7","CLEC4A" -"UniProt:O60361","NME2P1" -"UniProt:Q9Y6N3","CLCA3P" -"UniProt:Q12866","MERTK" -"UniProt:Q92918","M4K1" -"UniProt:Q9H6E4","CCDC134" -"UniProt:Q9UIG8","SLCO3A1" -"UniProt:P78363","ABCA4" -"UniProt:Q5VTE0","EEF1A1P5" -"UniProt:Q8TAP9","MPLKIP" -"UniProt:Q13503","MED21" -"UniProt:A4D0S4","LAMB4" -"UniProt:Q8NBV8","SYT8" -"UniProt:Q8IZK6","MCOLN2" -"UniProt:Q15528","MED22" -"UniProt:Q07978","YL031" -"UniProt:P53829","CAF40" -"UniProt:Q8VDD9","PHIP" -"UniProt:Q9NZN4","EHD2" -"UniProt:Q14161","GIT2" -"UniProt:Q8WU76","SCFD2" -"UniProt:Q53TN4","CYBRD1" -"UniProt:Q05738","SRY" -"UniProt:Q8N8A2","ANR44" -"UniProt:O96009","NAPSA" -"UniProt:Q9Y5Y7","LYVE1" -"UniProt:Q9Y6F8","CDY1" -"UniProt:P62328","TYB4" -"UniProt:Q9Y6Z7","COLEC10" -"UniProt:Q7Z5S9","TMEM144" -"UniProt:Q96NI8","ZNF570" -"UniProt:E9PH57","E9PH57" -"UniProt:P06537","NR3C1" -"UniProt:Q8N326","CJ111" -"UniProt:Q9HAC8","UBTD1" -"UniProt:Q8N7R7","CCNYL1" -"UniProt:Q9HAH1","ZNF556" -"UniProt:Q9H840","GEMI7" -"UniProt:Q9UL52","TM11E" -"UniProt:Q9HC36","MRM3" -"UniProt:Q8N5H3","FAM89B" -"UniProt:P62799","H4" -"UniProt:Q9UBI6","GBG12" -"UniProt:P06756","ITAV" -"UniProt:V9HW53","V9HW53" -"UniProt:J3QL71","J3QL71" -"UniProt:P16056","MET" -"UniProt:Q8IV76","PASD1" -"UniProt:P42892","ECE1" -"UniProt:Q11128","FUT5" -"UniProt:Q9BVG8","KIFC3" -"UniProt:Q99536","VAT1" -"UniProt:P23708","NFYA" -"UniProt:Q9BTM1","H2AFJ" -"UniProt:Q8IVC4","ZNF584" -"UniProt:Q9NRD8","DUOX2" -"UniProt:P60880","SNAP25" -"UniProt:Q9Y490","TLN1" -"UniProt:Q8NFH3","NUP43" -"UniProt:Q9H8W3","FAM204A" -"UniProt:Q9Y278","HS3ST2" -"UniProt:Q9Y5I7","CLDN16" -"UniProt:Q15672","TWIST1" -"UniProt:Q9BWW8","APOL6" -"UniProt:Q8N6F1","CLDN19" -"UniProt:Q86SQ9","DHDDS" -"UniProt:P16671","CD36" -"UniProt:Q8BT07","CEP55" -"UniProt:P38232","REG2" -"UniProt:P20333","TNFRSF1B" -"UniProt:P35498","SCN1A" -"UniProt:Q9BYF1","ACE2" -"UniProt:Q9BYJ9","YTHD1" -"UniProt:P55000","SLURP1" -"UniProt:O75636","FCN3" -"UniProt:Q9NR80","ARHGEF4" -"UniProt:Q13438","OS9" -"UniProt:Q4G163","FBX43" -"UniProt:Q9H158","PCDHAC1" -"UniProt:Q13362","PPP2R5C" -"UniProt:Q9BW66","CINP" -"UniProt:Q7Z3I7","ZN572" -"UniProt:Q93ED6","Q93ED6" -"UniProt:Q8IV36","HID1" -"UniProt:B4DNA4","B4DNA4" -"UniProt:A9UHW6","MIF4GD" -"UniProt:Q9BYG8","GSDMC" -"UniProt:Q96K21","ANCHR" -"UniProt:Q15911","ZFHX3" -"UniProt:Q96T91","GPHA2" -"UniProt:Q6XYQ8","SYT10" -"UniProt:Q12918","KLRB1" -"UniProt:Q9NX04","CA109" -"UniProt:P57735","RAB25" -"UniProt:P01215","CGA" -"UniProt:P13073","COX4I1" -"UniProt:P40567","MSL1" -"UniProt:P35739","Ntrk1" -"UniProt:Q6IFG1","OR52E8" -"UniProt:Q9BRV8","SIKE1" -"UniProt:Q99963","SH3G3" -"UniProt:Q9BTL4","IER2" -"UniProt:Q8N5C7","DTWD1" -"UniProt:P22004","BMP6" -"UniProt:Q9NVR0","KLH11" -"UniProt:Q7Z5V6","PPP1R32" -"UniProt:Q9UN74","PCDHA4" -"UniProt:Q9Y613","FHOD1" -"UniProt:O14981","BTAF1" -"UniProt:Q86YW7","GPHB5" -"UniProt:Q9UN72","PCDHA7" -"UniProt:Q9Y5B8","NDK7" -"UniProt:Q9Y2T4","2ABG" -"UniProt:Q8NH79","OR6X1" -"UniProt:Q6Q0C0","TRAF7" -"UniProt:P22894","MMP8" -"UniProt:P63331","PP2AA" -"UniProt:Q7Z572","SPATA21" -"UniProt:P20396","TRH" -"UniProt:E9PSE9","E9PSE9" -"UniProt:Q9BZW8","CD244" -"UniProt:A2RUQ5","C17orf102" -"UniProt:Q8TD31","CCHCR1" -"UniProt:Q6PHW0","IYD" -"UniProt:Q9UMX2","OAZ3" -"UniProt:Q15858","SCN9A" -"UniProt:Q9UL62","TRPC5" -"UniProt:Q96GX5","MASTL" -"UniProt:P30154","2AAB" -"UniProt:P03406","NEF" -"UniProt:P0C6I1","C" -"UniProt:O95222","OR6A2" -"UniProt:P45984","MK09" -"UniProt:A1L3X4","MT1DP" -"UniProt:Q8TDG4","HELQ" -"UniProt:Q8NGZ6","OR6F1" -"UniProt:Q86YP4","GATAD2A" -"UniProt:Q14596","NBR1" -"UniProt:P60372","KR104" -"UniProt:Q9Y5I1","PCDHA11" -"UniProt:Q15759","MAPK11" -"UniProt:Q9GZM6","OR8D2" -"UniProt:Q96HB5","CC120" -"UniProt:Q9BQA1","MEP50" -"UniProt:Q06413","MEF2C" -"UniProt:Q06411","SP382" -"UniProt:Q12888","TP53B" -"UniProt:Q15293","RCN1" -"UniProt:O14548","COX7A2L" -"UniProt:Q9Y3C7","MED31" -"UniProt:Q9Y5G3","PCDHGB1" -"UniProt:Q8NGL6","OR4A15" -"UniProt:P51685","CCR8" -"UniProt:Q93062","RBPMS" -"UniProt:Q8WTP9","XAGE3" -"UniProt:I6L9F6","I6L9F6" -"UniProt:Q8TAP4","Q8TAP44" -"UniProt:P58182","OR12D2" -"UniProt:Q9Y534","CSDC2" -"UniProt:Q9NQ35","NRIP3" -"UniProt:O14939","PLD2" -"UniProt:H3BUJ7","H3BUJ7" -"UniProt:P0C5Y9","H2AFB1" -"UniProt:Q9UIW0","VAX2" -"UniProt:Q96LR5","UBE2E2" -"UniProt:Q06190","P2R3A" -"UniProt:Q8NG78","OR8G5" -"UniProt:Q8C0J2","ATG16L1" -"UniProt:Q7Z7F0","K0907" -"UniProt:O75311","GLRA3" -"UniProt:A6NHG9","OR5H14" -"UniProt:Q7Z7C7","STRA8" -"UniProt:Q9H8T0","AKTIP" -"UniProt:Q9Y570","PPME1" -"UniProt:Q13045","FLII" -"UniProt:A0A087WVP0","A0A087WVP0" -"UniProt:O94842","TOX4" -"UniProt:Q9BRQ0","PYGO2" -"UniProt:Q9Y5E3","PCDHB6" -"UniProt:O95150","TNFSF15" -"UniProt:O76002","OR2J2" -"UniProt:Q8NFV4","ABHD11" -"UniProt:P09217","KPCZ" -"UniProt:Q9HBX9","RXFP1" -"UniProt:Q9Y5H9","PCDHA2" -"UniProt:Q8NGY3","OR6K3" -"UniProt:Q9HAT8","PELI2" -"UniProt:Q9Y5I4","PCDHAC2" -"UniProt:P42843","SKP2" -"UniProt:Q6ZRS4","CCDC129" -"UniProt:P63010","AP2B1" -"UniProt:Q66LE6","2ABD" -"UniProt:Q71F23","CENPU" -"UniProt:Q6YHU6","THADA" -"UniProt:Q8NEM7","SUPT20H" -"UniProt:Q02833","RASSF7" -"UniProt:Q15173","2A5B" -"UniProt:Q6IQ20","NAPEPLD" -"UniProt:Q8IWF6","DENND6A" -"UniProt:Q8N5Y2","MSL3" -"UniProt:Q9BUR5","APOO" -"UniProt:Q9NTJ5","SACM1L" -"UniProt:Q969K4","ABTB1" -"UniProt:P31358","CD52" -"UniProt:P35080","PROF2" -"UniProt:A0A087WUI6","A0A087WUI6" -"UniProt:Q00325","SLC25A3" -"UniProt:A0A0C4DGS5","A0A0C4DGS5" -"UniProt:Q75MZ5","Q75MZ5" -"UniProt:P43365","MAGAC" -"UniProt:Q8NGV5","OR13D1" -"UniProt:Q2TAA8","TSNAXIP1" -"UniProt:Q14624","ITIH4" -"UniProt:O43261","LEU1" -"UniProt:Q16537","2A5E" -"UniProt:Q9BZJ4","SLC25A39" -"UniProt:P51003","PAPOLA" -"UniProt:Q8NH21","OR4F5" -"UniProt:Q8NFT8","DNER" -"UniProt:Q9UN75","PCDHA12" -"UniProt:P27815","PDE4A" -"UniProt:Q8IYS1","P20D2" -"UniProt:Q96KN8","HRASLS5" -"UniProt:Q9Y5P8","P2R3B" -"UniProt:O00716","E2F3" -"UniProt:Q8NGS1","OR1J4" -"UniProt:O15539","RGS5" -"UniProt:P10845","botA" -"UniProt:Q9NPF5","DMAP1" -"UniProt:Q16512","PKN1" -"UniProt:Q9Y5H8","PCDHA3" -"UniProt:P25631","YCU1" -"UniProt:Q9Y5H7","PCDHA5" -"UniProt:Q96Q77","CIB3" -"UniProt:Q8NEG4","FAM83F" -"UniProt:P30488","HLA-B" -"UniProt:Q86XP0","PLA2G4D" -"UniProt:Q969J2","ZKSCAN4" -"UniProt:Q9BSY4","CHCHD5" -"UniProt:Q9UHK0","NUFP1" -"UniProt:Q96A08","HIST1H2BA" -"UniProt:P31273","HXC8" -"UniProt:Q96EI5","TCEAL4" -"UniProt:Q5VTR2","BRE1A" -"UniProt:P51674","GPM6A" -"UniProt:Q8NH60","OR52J3" -"UniProt:Q14119","VEZF1" -"UniProt:P51809","VAMP7" -"UniProt:Q8NGF7","OR5B17" -"UniProt:P60842","IF4A1" -"UniProt:Q92541","RTF1" -"UniProt:Q9UQ10","DHDH" -"UniProt:Q9Y2V2","CHSP1" -"UniProt:Q96HW7","INTS4" -"UniProt:Q9UKD1","GMEB2" -"UniProt:Q13072","BAGE1" -"UniProt:O60262","GBG7" -"UniProt:P26641","EF1G" -"UniProt:Q7L5N7","LPCAT2" -"UniProt:P60412","KR10B" -"UniProt:Q9Y4C2","TCAF1" -"UniProt:P22575","TIP" -"UniProt:Q15257","PPP2R4" -"UniProt:A0A0C4DFM2","A0A0C4DFM2" -"UniProt:P01222","TSHB" -"UniProt:Q9Y5I3","PCDHA1" -"UniProt:Q99592","ZBTB18" -"UniProt:Q3MJ16","PLA2G4E" -"UniProt:Q8NGE8","OR4D9" -"UniProt:P50591","TNF10" -"UniProt:Q8NGQ5","OR9Q1" -"UniProt:Q12481","RRP36" -"UniProt:Q9C0D0","PHACTR1" -"UniProt:Q68DA7","FMN1" -"UniProt:Q9Y2M2","SSUH2" -"UniProt:A0A087X295","A0A087X295" -"UniProt:O14777","NDC80" -"UniProt:A0A0A6YYJ4","A0A0A6YYJ4" -"UniProt:Q16829","DUSP7" -"UniProt:P26196","DDX6" -"UniProt:P60510","PP4C" -"UniProt:Q9Y234","LIPT1" -"UniProt:P10070","GLI2" -"UniProt:Q9NYA3","GOG6A" -"UniProt:Q0VDG4","SCRN3" -"UniProt:P05181","CYP2E1" -"UniProt:Q8WWB3","DYDC1" -"UniProt:O94985","CLSTN1" -"UniProt:A1A580","KR231" -"UniProt:Q9BSY9","DESI2" -"UniProt:Q9H4A5","GLP3L" -"UniProt:Q8N0X7","SPART" -"UniProt:Q8N7C3","TRIMM" -"UniProt:O95479","H6PD" -"UniProt:Q99689","FEZ1" -"UniProt:Q9UMY4","SNX12" -"UniProt:O75164","KDM4A" -"UniProt:P52742","ZN135" -"UniProt:Q7L2H7","EIF3M" -"UniProt:Q9UBT7","CTNL1" -"UniProt:Q9UPE1","SRPK3" -"UniProt:Q9UBY0","SLC9A2" -"UniProt:Q8N6M6","C9orf3" -"UniProt:P55327","TPD52" -"UniProt:P10266","ERVK-10" -"UniProt:Q8TEK3","DOT1L" -"UniProt:Q53XC2","Q53XC2" -"UniProt:O60507","TPST1" -"UniProt:Q6FHV6","Q6FHV6" -"UniProt:P0DJD7","PGA4" -"UniProt:O15524","SOCS1" -"UniProt:Q07002","CDK18" -"UniProt:Q9EPI6","NSMF" -"UniProt:Q8N6N6","NATD1" -"UniProt:Q8TDV2","GPR148" -"UniProt:Q9BTV5","FSD1" -"UniProt:Q14195","DPYSL3" -"UniProt:Q8N392","ARHGAP18" -"UniProt:Q9BZP6","CHIA" -"UniProt:Q8TDT2","GP152" -"UniProt:Q8IXR5","FAM178B" -"UniProt:Q96A29","SLC35C1" -"UniProt:P11972","SST2" -"UniProt:P03122","VE2" -"UniProt:O96018","APBA3" -"UniProt:A4D1W7","A4D1W7" -"UniProt:Q9Y6R7","FCGBP" -"UniProt:Q13794","APR" -"UniProt:Q8TES7","FBF1" -"UniProt:Q13601","KRR1" -"UniProt:P21802","FGFR2" -"UniProt:P36896","ACVR1B" -"UniProt:A0A087WWP8","A0A087WWP8" -"UniProt:Q9H2L5","RASF4" -"UniProt:Q9HCD5","NCOA5" -"UniProt:P63129","ERVK-24" -"UniProt:P12277","CKB" -"UniProt:Q5U623","ATF7IP2" -"UniProt:O15496","PLA2G10" -"UniProt:Q9UII6","DS13B" -"UniProt:Q5T0N5","FNBP1L" -"UniProt:Q9GZL7","WDR12" -"UniProt:Q9NXF1","TEX10" -"UniProt:Q96A05","ATP6V1E2" -"UniProt:A6NM11","LRRC37A2" -"UniProt:P61927","RPL37" -"UniProt:Q96CP6","GRAMD1A" -"UniProt:Q8N5I9","C12orf45" -"UniProt:Q8NEP4","CQ047" -"UniProt:Q8IYD8","FANCM" -"UniProt:Q01726","MC1R" -"UniProt:Q9Z325","DPM2" -"UniProt:Q6UWX4","HIPL2" -"UniProt:P35700","PRDX1" -"UniProt:Q6Q595","SCS22" -"UniProt:P61565","ERVK-21" -"UniProt:Q15477","SKIV2L" -"UniProt:P50749","RASF2" -"UniProt:O71037","ERVK-19" -"UniProt:D6RJB6","USP17L20" -"UniProt:Q6P1J9","CDC73" -"UniProt:Q8IXI1","RHOT2" -"UniProt:Q9NUT2","ABCB8" -"UniProt:P21583","KITLG" -"UniProt:P63209","SKP1" -"UniProt:Q9UKF2","ADAM30" -"UniProt:Q06830","PRDX1" -"UniProt:O95997","PTTG1" -"UniProt:Q8WUX2","CHAC2" -"UniProt:Q86UY5","FAM83A" -"UniProt:Q09470","KCNA1" -"UniProt:Q63009","ANM1" -"UniProt:P49715","CEBPA" -"UniProt:Q6N043","ZNF280D" -"UniProt:Q6IRU7","CEP78" -"UniProt:Q96DI8","Q96DI8" -"UniProt:Q9BRD0","BUD13" -"UniProt:Q86W47","KCNMB4" -"UniProt:C9JG97","C9JG97" -"UniProt:Q8NG48","LINS1" -"UniProt:O95847","SLC25A27" -"UniProt:P30613","PKLR" -"UniProt:O95484","CLDN9" -"UniProt:Q70Z44","HTR3D" -"UniProt:P63267","ACTG2" -"UniProt:Q7L9L4","MOB1B" -"UniProt:P61582","ERVK-7" -"UniProt:Q8WVV5","BTN2A2" -"UniProt:Q14562","DHX8" -"UniProt:Q9UMX1","SUFU" -"UniProt:Q8NE63","HIPK4" -"UniProt:P02666","CASB" -"UniProt:Q69384","ERVK-6" -"UniProt:P12883","MYH7" -"UniProt:Q5JYT7","KIAA1755" -"UniProt:Q9HAA0","Q9HAA0" -"UniProt:P38011","GBLP" -"UniProt:P32418","SLC8A1" -"UniProt:O15213","WDR46" -"UniProt:Q8N7C7","RNF148" -"UniProt:O92972","POLG" -"UniProt:P46821","MAP1B" -"UniProt:Q7LDI9","ERVK-6" -"UniProt:O14607","UTY" -"UniProt:Q9NVS2","MRPS18A" -"UniProt:P61566","ERVK-24" -"UniProt:P11498","PC" -"UniProt:Q60979","Q60979" -"UniProt:O75151","PHF2" -"UniProt:P62683","ERVK-21" -"UniProt:P21817","RYR1" -"UniProt:O94761","RECQL4" -"UniProt:Q147X3","NAA30" -"UniProt:Q14093","CYLC2" -"UniProt:A0A0A0MQU8","A0A0A0MQU8" -"UniProt:Q96MY7","F161B" -"UniProt:Q9UKA1","FBXL5" -"UniProt:Q9H8W5","TRIM45" -"UniProt:Q9P2S6","ANKMY1" -"UniProt:O75509","TNR21" -"UniProt:Q2KJY2","KIF26B" -"UniProt:Q4U2R8","SLC22A6" -"UniProt:O14879","IFIT3" -"UniProt:P30939","HTR1F" -"UniProt:Q5SGD2","PPM1L" -"UniProt:P20062","TCN2" -"UniProt:Q9NS84","CHST7" -"UniProt:P60983","GMFB" -"UniProt:Q4VX62","C6orf99" -"UniProt:Q8IVL1","NAV2" -"UniProt:P53396","ACLY" -"UniProt:Q9BXU1","STK31" -"UniProt:Q5EB52","MEST" -"UniProt:Q8WXH6","RAB40A" -"UniProt:Q8NHB1","OR2V1" -"UniProt:Q8NE09","RGS22" -"UniProt:Q8NCG5","CHST4" -"UniProt:Q9UHV8","LGALS13" -"UniProt:A1L4K1","FSD2" -"UniProt:Q05193","DNM1" -"UniProt:Q86VU5","COMTD1" -"UniProt:Q8IUX4","APOBEC3F" -"UniProt:O75379","VAMP4" -"UniProt:E5KS60","E5KS60" -"UniProt:Q9NPJ6","MED4" -"UniProt:Q5VY09","IER5" -"UniProt:Q9NX52","RHBDL2" -"UniProt:Q8TBA6","GOLGA5" -"UniProt:O15375","SLC16A5" -"UniProt:Q9C037","TRIM4" -"UniProt:O95473","SYNGR4" -"UniProt:Q9Y6K8","AK5" -"UniProt:P31483","TIA1" -"UniProt:Q6HA08","ASTL" -"UniProt:O75077","ADAM23" -"UniProt:Q96KQ4","ASPP1" -"UniProt:Q9UKK6","NXT1" -"UniProt:P05452","CLEC3B" -"UniProt:Q92870","APBB2" -"UniProt:Q86X83","COMMD2" -"UniProt:Q96LL4","CH048" -"UniProt:Q9UD71","PPP1R1B" -"UniProt:Q5VTD9","GFI1B" -"UniProt:Q2TB18","ASTE1" -"UniProt:Q8IYX7","SAXO1" -"UniProt:Q8TAL5","C9orf43" -"UniProt:Q9UNX4","WDR3" -"UniProt:Q6NSZ9","ZSCAN25" -"UniProt:Q96N16","JKIP1" -"UniProt:O95563","MPC2" -"UniProt:Q8TD22","SFXN5" -"UniProt:Q9H0Y0","ATG10" -"UniProt:P57053","H2BFS" -"UniProt:P31016","Dlg4" -"UniProt:P48060","GLIPR1" -"UniProt:P04578","ENV" -"UniProt:P84101","SERF2" -"UniProt:Q8NDV1","ST6GALNAC3" -"UniProt:Q306T3","Q306T3" -"UniProt:Q9NUZ1","ACOXL" -"UniProt:P23381","WARS" -"UniProt:Q92754","AP2C" -"UniProt:Q9H4M9","EHD1" -"UniProt:Q6URK8","TEPP" -"UniProt:Q99677","LPAR4" -"UniProt:Q8NEV9","IL27" -"UniProt:O89100","GRAP2" -"UniProt:Q15013","MAD2L1BP" -"UniProt:A1A5C7","SLC22A23" -"UniProt:Q9P0J7","KCMF1" -"UniProt:Q99766","ATP5S" -"UniProt:Q5VZ72","IZUMO3" -"UniProt:Q8N394","TMTC2" -"UniProt:P08240","SRPRA" -"UniProt:Q99880","HIST1H2BL" -"UniProt:P05997","COL5A2" -"UniProt:P49588","AARS" -"UniProt:P0C263","SBK2" -"UniProt:Q29960","HLA-C" -"UniProt:P0C881","RSPH10B" -"UniProt:Q9BUV8","C20orf24" -"UniProt:Q7L8A9","VASH1" -"UniProt:Q92985","IRF7" -"UniProt:Q5VZE5","NAA35" -"UniProt:Q86VM9","ZC3H18" -"UniProt:Q02928","CYP4A11" -"UniProt:P81877","SSBP2" -"UniProt:P40225","THPO" -"UniProt:Q9H0U4","RAB1B" -"UniProt:Q9BXE9","VN1R3" -"UniProt:Q8N2G8","GHDC" -"UniProt:Q13625","ASPP2" -"UniProt:Q9H0A6","RNF32" -"UniProt:Q6ZMV9","KIF6" -"UniProt:P14060","HSD3B1" -"UniProt:Q8NAN2","MIGA1" -"UniProt:Q3LI83","KRTAP24-1" -"UniProt:Q2TB72","Q2TB72" -"UniProt:Q96KX1","C4orf36" -"UniProt:Q702N8","XIRP1" -"UniProt:Q9UIM3","FKBPL" -"UniProt:O75663","TIPRL" -"UniProt:Q8NCC5","SLC37A3" -"UniProt:P54787","VPS9" -"UniProt:O14640","DVL1" -"UniProt:Q77E16","Q77E16" -"UniProt:Q9UEG4","ZNF629" -"UniProt:O95373","IPO7" -"UniProt:P36544","ACHA7" -"UniProt:Q96JZ2","HSH2D" -"UniProt:P51116","FXR2" -"UniProt:Q8CIE6","COPA" -"UniProt:Q9HCS4","TCF7L1" -"UniProt:O15405","TOX3" -"UniProt:Q8N448","LNX2" -"UniProt:O75487","GPC4" -"UniProt:Q9HCN2","TP53AIP1" -"UniProt:Q8NGF4","OR5AP2" -"UniProt:P61793","LPAR1" -"UniProt:Q9UPS8","ANKRD26" -"UniProt:Q9H1P3","OSBPL2" -"UniProt:Q6EEV4","POLR2M" -"UniProt:Q6UWJ8","CD164L2" -"UniProt:Q8N228","SCML4" -"UniProt:Q5TF58","IFFO2" -"UniProt:Q13685","AAMP" -"UniProt:Q99683","M3K5" -"UniProt:Q9NHX6","Gug" -"UniProt:Q12799","TCP10" -"UniProt:Q96K30","RITA1" -"UniProt:P30101","PDIA3" -"UniProt:P20908","COL5A1" -"UniProt:O00124","UBXN8" -"UniProt:Q8TAB5","CA216" -"UniProt:Q96EM0","L3HYPDH" -"UniProt:Q15545","TAF7" -"UniProt:A0AVK6","E2F8" -"UniProt:O43765","SGTA" -"UniProt:Q9BYP9","KRTAP9-9" -"UniProt:O95260","ATE1" -"UniProt:Q92610","ZN592" -"UniProt:P04217","A1BG" -"UniProt:Q5MJ70","SPDYA" -"UniProt:P39060","COL18A1" -"UniProt:Q8N8U2","CDYL2" -"UniProt:Q8NA72","POC5" -"UniProt:Q9ULW6","NP1L2" -"UniProt:O00555","CACNA1A" -"UniProt:Q6ZUJ4","C3orf62" -"UniProt:Q9EPL2","CSTN1" -"UniProt:Q8N7Q3","ZNF676" -"UniProt:Q86UP6","CUZD1" -"UniProt:Q96PJ5","FCRL4" -"UniProt:O95433","AHSA1" -"UniProt:Q8N8N7","PTGR2" -"UniProt:Q69YI7","NAIF1" -"UniProt:P56856","CLDN18" -"UniProt:P30490","HLA-B" -"UniProt:Q60996","PPP2R5C" -"UniProt:P40617","ARL4A" -"UniProt:Q96JT2","SLC45A3" -"UniProt:Q9BQ67","GRWD1" -"UniProt:P13405","Rb1" -"UniProt:V9HW60","V9HW60" -"UniProt:Q49AJ0","FAM135B" -"UniProt:Q499Z4","ZN672" -"UniProt:Q13033","STRN3" -"UniProt:Q9DBG3","AP2B1" -"UniProt:Q9NY37","ASIC5" -"UniProt:Q7Z569","BRAP" -"UniProt:Q8N7U7","TPRX1" -"UniProt:Q8WUU4","ZNF296" -"UniProt:Q8WV24","PHLA1" -"UniProt:P60014","KR10A" -"UniProt:P06731","CEACAM5" -"UniProt:O00321","ETV2" -"UniProt:P30556","AGTR1" -"UniProt:P35544","FAU" -"UniProt:P00797","REN" -"UniProt:A6NHQ4","EPOP" -"UniProt:Q8TEC5","SH3RF2" -"UniProt:Q9NXL2","ARHGEF38" -"UniProt:Q92904","DAZL" -"UniProt:Q587J7","TDRD12" -"UniProt:P18799","env" -"UniProt:Q9H2S5","RNF39" -"UniProt:Q9H628","RERGL" -"UniProt:P06702","S10A9" -"UniProt:Q9HAH7","FBRS" -"UniProt:Q5TA89","HES5" -"UniProt:O00623","PEX12" -"UniProt:Q9CWR8","DNM3L" -"UniProt:P09110","ACAA1" -"UniProt:Q13370","PDE3B" -"UniProt:Q14515","SPARCL1" -"UniProt:Q8IWL2","SFTPA1" -"UniProt:Q9UGK8","SRGEF" -"UniProt:Q7Z494","NPHP3" -"UniProt:Q9Y2W6","TDRKH" -"UniProt:Q9ULC5","ACSL5" -"UniProt:Q96L50","LLR1" -"UniProt:O15259","NPHP1" -"UniProt:Q9Y6D0","SELK" -"UniProt:Q5W041","ARMC3" -"UniProt:Q9NSG2","C1orf112" -"UniProt:P01019","AGT" -"UniProt:Q9P2S5","WRAP73" -"UniProt:Q9UK32","KS6A6" -"UniProt:P15313","ATP6V1B1" -"UniProt:Q14440","Q14440" -"UniProt:Q96IK0","TMEM101" -"UniProt:O43278","SPINT1" -"UniProt:Q8NH81","OR10G6" -"UniProt:Q9H8U3","ZFAND3" -"UniProt:Q6UXD5","SEZ6L2" -"UniProt:P47928","ID4" -"UniProt:Q9Y3B7","RM11" -"UniProt:Q9BXY4","RSPO3" -"UniProt:P54819","AK2" -"UniProt:Q9UM22","EPDR1" -"UniProt:Q8NCE2","MTMR14" -"UniProt:A6PVS8","LRIQ3" -"UniProt:O75554","WBP4" -"UniProt:A0A0D9SEJ5","A0A0D9SEJ5" -"UniProt:Q03933","HSF2" -"UniProt:P62861","FAU" -"UniProt:Q6XUX3","DSTYK" -"UniProt:Q5HYI7","MTX3" -"UniProt:A8MVA2","KRTAP9-6" -"UniProt:Q86XH1","IQCA1" -"UniProt:Q3E7B2","COA3" -"UniProt:P59535","TAS2R40" -"UniProt:Q14CS0","UBX2B" -"UniProt:Q05655","PRKCD" -"UniProt:Q9HC29","NOD2" -"UniProt:A1IGU5","ARHGEF37" -"UniProt:P11686","SFTPC" -"UniProt:Q96EQ0","SGTB" -"UniProt:Q15109","AGER" -"UniProt:Q02642","NACB1" -"UniProt:Q96PN8","TSSK3" -"UniProt:Q76KD6","SPATC1" -"UniProt:P24539","AT5F1" -"UniProt:Q15057","ACAP2" -"UniProt:P30085","CMPK1" -"UniProt:Q9BY14","TEX101" -"UniProt:P07988","SFTPB" -"UniProt:Q96RY7","IFT140" -"UniProt:Q14209","E2F2" -"UniProt:P42262","GRIA2" -"UniProt:Q8IYB7","DIS3L2" -"UniProt:Q8NFJ5","GPRC5A" -"UniProt:Q16587","ZNF74" -"UniProt:O14832","PHYH" -"UniProt:Q15814","TBCC" -"UniProt:Q86SI9","C5orf38" -"UniProt:P78410","BTN3A2" -"UniProt:O19137","CPSF4" -"UniProt:Q96RU2","USP28" -"UniProt:Q5SW79","CE170" -"UniProt:Q3LI58","KRTAP21-1" -"UniProt:Q14722","KCNAB1" -"UniProt:A6NIK2","LRRC10B" -"UniProt:Q9Y2Q5","LAMTOR2" -"UniProt:Q16342","PDCD2" -"UniProt:P49207","RPL34" -"UniProt:Q5HY98","ZNF766" -"UniProt:Q9NRA2","SLC17A5" -"UniProt:Q8IZW8","TNS4" -"UniProt:Q9H819","DNAJC18" -"UniProt:Q9NQT6","FSCN3" -"UniProt:Q96PU4","UHRF2" -"UniProt:Q9BY78","RNF26" -"UniProt:P78545","ELF3" -"UniProt:P13726","F3" -"UniProt:Q96JG8","MAGED4B" -"UniProt:P15529","CD46" -"UniProt:P25147","inlB" -"UniProt:P52435","POLR2J" -"UniProt:Q96T55","KCNK16" -"UniProt:P00480","OTC" -"UniProt:Q08AM8","Q08AM8" -"UniProt:Q9NUW8","TDP1" -"UniProt:P30461","HLA-B" -"UniProt:O75400","PR40A" -"UniProt:Q7Z5L9","IRF2BP2" -"UniProt:O00241","SIRPB1" -"UniProt:Q9Z179","SHCBP" -"UniProt:P32114","PAX2" -"UniProt:Q99593","TBX5" -"UniProt:Q53GS9","USP39" -"UniProt:Q9UBX0","HESX1" -"UniProt:P23942","PRPH2" -"UniProt:Q68G75","LEMD1" -"UniProt:Q9NYZ1","TV23B" -"UniProt:O43556","SGCE" -"UniProt:Q8TBZ5","ZN502" -"UniProt:Q9H3S7","PTN23" -"UniProt:Q9BPX4","Q9BPX4" -"UniProt:Q07973","CYP24A1" -"UniProt:Q9HAK2","COE2" -"UniProt:P32926","DSG3" -"UniProt:Q8TCU3","SLC7A13" -"UniProt:Q9UL26","RAB22A" -"UniProt:Q96DT7","ZBTB10" -"UniProt:Q0ZGT2","NEXN" -"UniProt:Q92917","GPKOW" -"UniProt:Q13835","PKP1" -"UniProt:Q9BV23","ABHD6" -"UniProt:P35326","SPR2A" -"UniProt:Q6ZMY9","ZNF517" -"UniProt:Q96L12","CALR3" -"UniProt:Q96M53","TBATA" -"UniProt:Q99700","ATXN2" -"UniProt:Q9H8V3","ECT2" -"UniProt:Q6DCB0","Q6DCB0" -"UniProt:P19419","ELK1" -"UniProt:Q9Y5P4","COL4A3BP" -"UniProt:P57071","PRDM15" -"UniProt:Q96DR4","STARD4" -"UniProt:Q13162","PRDX4" -"UniProt:Q9BZ23","PANK2" -"UniProt:P14384","CPM" -"UniProt:A8K2R3","A8K2R3" -"UniProt:O14645","IDLC" -"UniProt:Q9UHQ4","BCAP29" -"UniProt:O95817","BAG3" -"UniProt:Q9BWV2","SPATA9" -"UniProt:P51826","AFF3" -"UniProt:Q96L08","SUSD3" -"UniProt:Q96T52","IMMP2L" -"UniProt:K9M1U5","IFNL4" -"UniProt:Q8WZ74","CTTNBP2" -"UniProt:O60240","PLIN1" -"UniProt:Q96DE0","NUDT16" -"UniProt:Q96HN2","AHCYL2" -"UniProt:Q8TB92","HMGCLL1" -"UniProt:Q9Y6X8","ZHX2" -"UniProt:Q9P0X4","CAC1I" -"UniProt:O95944","NCR2" -"UniProt:Q8N511","TMEM199" -"UniProt:Q8WVF2","UCMA" -"UniProt:Q6S9Z5","ZNF474" -"UniProt:A0A024R4Q5","A0A024R4Q5" -"UniProt:Q9H3Q3","G3ST2" -"UniProt:O14647","CHD2" -"UniProt:Q9UJZ1","STOML2" -"UniProt:Q8N8K9","KIAA1958" -"UniProt:P12035","KRT3" -"UniProt:Q6PEY0","GJB7" -"UniProt:Q5TEJ8","THEMIS2" -"UniProt:Q8NFU5","IPMK" -"UniProt:Q96J84","KIRREL" -"UniProt:Q8R5G7","ARAP3" -"UniProt:Q9HB03","ELOVL3" -"UniProt:Q4KMQ2","ANO6" -"UniProt:Q6W4X9","MUC6" -"UniProt:P78385","KRT83" -"UniProt:Q99674","CGREF1" -"UniProt:Q9P1U1","ACTR3B" -"UniProt:Q9P0W8","SPATA7" -"UniProt:Q8IZU1","FAM9A" -"UniProt:P15086","CPB1" -"UniProt:Q3KNV8","PCGF3" -"UniProt:Q8NCT3","KIAA0895" -"UniProt:Q13510","ASAH1" -"UniProt:P42261","GRIA1" -"UniProt:Q8N4V2","SVOP" -"UniProt:Q9UIW2","PLXNA1" -"UniProt:P26678","PLN" -"UniProt:Q99456","KRT12" -"UniProt:Q9BR39","JPH2" -"UniProt:Q96HT8","MR1L1" -"UniProt:P08697","SERPINF2" -"UniProt:Q9Y2X3","NOP58" -"UniProt:Q6IQ08","Q6IQ08" -"UniProt:P26651","ZFP36" -"UniProt:Q8N3R9","MPP5" -"UniProt:Q9H2V7","SPNS1" -"UniProt:Q3SY77","UGT3A2" -"UniProt:Q9Y239","NOD1" -"UniProt:Q9BYG4","PAR6G" -"UniProt:Q10471","GALNT2" -"UniProt:Q8WXI7","MUC16" -"UniProt:O75600","GCAT" -"UniProt:Q9BXU2","TEX13B" -"UniProt:P24298","GPT" -"UniProt:Q2Q067","Q2Q067" -"UniProt:P22760","AADAC" -"UniProt:P00505","GOT2" -"UniProt:Q09FC8","ZN415" -"UniProt:Q99490","AGAP2" -"UniProt:Q5T4S7","UBR4" -"UniProt:Q9GZP1","NRSN2" -"UniProt:Q02410","APBA1" -"UniProt:P51148","RAB5C" -"UniProt:P35228","NOS2" -"UniProt:Q14689","DIP2A" -"UniProt:Q05315","CLC" -"UniProt:Q99717","SMAD5" -"UniProt:Q9UPX0","IGSF9B" -"UniProt:P53539","FOSB" -"UniProt:Q14116","IL18" -"UniProt:P61588","RND3" -"UniProt:Q969R5","LMBL2" -"UniProt:P61225","RAP2B" -"UniProt:P08138","TNR16" -"UniProt:Q9UNN4","GTF2A1L" -"UniProt:Q6ZS11","RINL" -"UniProt:Q92688","AN32B" -"UniProt:Q9NQ25","SLAMF7" -"UniProt:P35367","HRH1" -"UniProt:Q9P2J9","PDP2" -"UniProt:O75955","FLOT1" -"UniProt:Q9BXJ9","NAA15" -"UniProt:O00213","APBB1" -"UniProt:Q5STP9","Q5STP9" -"UniProt:A0A0A0MQZ8","A0A0A0MQZ8" -"UniProt:Q9BXF3","CECR2" -"UniProt:A0A0S2Z4D7","A0A0S2Z4D7" -"UniProt:Q96RD9","FCRL5" -"UniProt:P27797","CALR" -"UniProt:P53582","METAP1" -"UniProt:P31512","FMO4" -"UniProt:Q16348","S15A2" -"UniProt:Q96JM2","ZNF462" -"UniProt:Q6IED9","DGAT2L7P" -"UniProt:P78352","DLG4" -"UniProt:Q9P2Z0","THA10" -"UniProt:O94925","GLS" -"UniProt:O95372","LYPA2" -"UniProt:Q13443","ADAM9" -"UniProt:Q14500","KCNJ12" -"UniProt:A6NKD2","TSPY2" -"UniProt:Q9H4B4","PLK3" -"UniProt:P01583","IL1A" -"UniProt:Q8NEA9","GMCLL" -"UniProt:Q0Z7S8","FABP9" -"UniProt:O75909","CCNK" -"UniProt:Q92502","STARD8" -"UniProt:Q16665","HIF1A" -"UniProt:Q8IU85","CAMK1D" -"UniProt:O94911","ABCA8" -"UniProt:Q96F45","ZNF503" -"UniProt:Q9NSD9","SYFB" -"UniProt:Q99666","RGPD5" -"UniProt:O43508","TNFSF12" -"UniProt:Q6UY11","DLK2" -"UniProt:P28072","PSB6" -"UniProt:Q7Z4H7","HAUS6" -"UniProt:P08621","RU17" -"UniProt:Q8NCQ7","PROCA1" -"UniProt:P38703","LAG1" -"UniProt:Q80W00","PP1RA" -"UniProt:Q9UKJ1","PILRA" -"UniProt:Q92585","MAML1" -"UniProt:Q5TFG8","ZC2HC1B" -"UniProt:O43852","CALU" -"UniProt:P61011","SRP54" -"UniProt:Q15562","TEAD2" -"UniProt:Q8NGP4","OR5M3" -"UniProt:Q5VTB9","RNF220" -"UniProt:P14317","HCLS1" -"UniProt:Q07954","LRP1" -"UniProt:Q96J88","EPSTI1" -"UniProt:Q8WVZ9","KBTBD7" -"UniProt:Q15434","RBMS2" -"UniProt:O95398","RAPGEF3" -"UniProt:A6NK53","ZNF233" -"UniProt:Q8TB69","ZNF519" -"UniProt:O94921","CDK14" -"UniProt:Q8IWE4","DCUN1D3" -"UniProt:Q9UMX3","BOK" -"UniProt:Q8WVE0","N6AMT2" -"UniProt:Q13131","PRKAA1" -"UniProt:Q9Y4G8","RAPGEF2" -"UniProt:Q9NWU5","MRPL22" -"UniProt:O39474","O39474" -"UniProt:A2KUC3","IGHV" -"UniProt:Q9H210","OR2D2" -"UniProt:P25791","LMO2" -"UniProt:Q15166","PON3" -"UniProt:Q8NH59","OR51Q1" -"UniProt:Q99594","TEAD3" -"UniProt:Q5BVD1","C3orf52" -"UniProt:P33552","CKS2" -"UniProt:Q8TBP6","SLC25A40" -"UniProt:P52594","AGFG1" -"UniProt:Q13177","PAK2" -"UniProt:Q53FA7","TP53I3" -"UniProt:Q9BV38","WDR18" -"UniProt:Q9H3G5","CPVL" -"UniProt:Q96L03","SPT17" -"UniProt:Q8N568","DCLK2" -"UniProt:Q9H0I3","CCDC113" -"UniProt:O88917","AGRL1" -"UniProt:Q09028","RBBP4" -"UniProt:A6NJB7","PRR19" -"UniProt:O75677","RFPL1" -"UniProt:Q9P2U7","SLC17A7" -"UniProt:P54274","TERF1" -"UniProt:Q9BVA0","KATNB1" -"UniProt:Q8N144","GJD3" -"UniProt:Q6PB30","CSAG1" -"UniProt:Q9NQ31","AKIP1" -"UniProt:O46385","SVIL" -"UniProt:O60673","REV3L" -"UniProt:Q6FI13","HIST2H2AA3" -"UniProt:P39547","UIP3" -"UniProt:P22460","KCNA5" -"UniProt:Q9NX45","CCDC169-SOHLH2" -"UniProt:P54108","CRISP3" -"UniProt:Q9Y5V3","MAGED1" -"UniProt:P78380","OLR1" -"UniProt:P0CF51","TRGC1" -"UniProt:Q9UBZ9","REV1" -"UniProt:Q7Z2K6","ERMP1" -"UniProt:Q96LD8","SENP8" -"UniProt:P31151","S10A7" -"UniProt:Q8TDC3","BRSK1" -"UniProt:P25911","Lyn" -"UniProt:Q96JE7","SEC16B" -"UniProt:Q96QA6","YPEL2" -"UniProt:Q9BQ65","USB1" -"UniProt:Q96T60","PNKP" -"UniProt:P0DP24","CALM2;CALM3;CALM1" -"UniProt:P60660","MYL6" -"UniProt:Q96LT9","RNPC3" -"UniProt:Q8NE62","CHDH" -"UniProt:Q9NR81","ARHGEF3" -"UniProt:O95136","S1PR2" -"UniProt:P41227","NAA10" -"UniProt:O00254","F2RL2" -"UniProt:P53701","HCCS" -"UniProt:Q7Z6M1","RABEPK" -"UniProt:P11717","MPRI" -"UniProt:Q9Y2H2","INPP5F" -"UniProt:Q9NZT2","OGFR" -"UniProt:A6H8Y1","BDP1" -"UniProt:P27544","CERS1" -"UniProt:Q494W8","CHRFAM7A" -"UniProt:Q9Y2I9","TBC1D30" -"UniProt:Q9H790","EXO5" -"UniProt:P35803","GPM6B" -"UniProt:Q9Y3E5","PTRH2" -"UniProt:Q9Y619","SLC25A15" -"UniProt:P50135","HNMT" -"UniProt:P68105","EF1A1" -"UniProt:P40070","LSM4" -"UniProt:Q9NY26","SLC39A1" -"UniProt:Q13347","EIF3I" -"UniProt:P22304","IDS" -"UniProt:Q8NB50","ZFP62" -"UniProt:Q9BVJ6","UTP14A" -"UniProt:Q8TEL6","TP4AP" -"UniProt:W5RWE1","W5RWE1" -"UniProt:Q16543","CDC37" -"UniProt:P03230","LMP1" -"UniProt:Q9NRC1","ST7" -"UniProt:P49910","ZN165" -"UniProt:Q06945","SOX4" -"UniProt:Q15723","ELF2" -"UniProt:Q9UQ03","COR2B" -"UniProt:Q5VT66","MARC1" -"UniProt:Q99884","SLC6A7" -"UniProt:Q9HAU8","RNPEPL1" -"UniProt:Q9Y2C4","EXOG" -"UniProt:A1A4Y4","IRGM" -"UniProt:Q9UNZ2","NSF1C" -"UniProt:A8K571","A8K571" -"UniProt:Q14342","Q14342" -"UniProt:Q9Y4W2","LAS1L" -"UniProt:P28676","GCA" -"UniProt:Q96MA6","AK8" -"UniProt:Q6NVY1","HIBCH" -"UniProt:Q9P2F6","ARHGAP20" -"UniProt:Q9GZV8","PRDM14" -"UniProt:Q61473","SOX17" -"UniProt:Q00266","MAT1A" -"UniProt:P12314","FCGR1A" -"UniProt:Q12840","KIF5A" -"UniProt:Q9BWN1","PRR14" -"UniProt:Q9P2T1","GMPR2" -"UniProt:P22033","MUT" -"UniProt:Q16254","E2F4" -"UniProt:Q15424","SAFB1" -"UniProt:Q5SZQ8","CELF3" -"UniProt:Q8NBB4","ZSCAN1" -"UniProt:P48510","DSK2" -"UniProt:P35269","GTF2F1" -"UniProt:Q9Y651","SOX21" -"UniProt:Q92800","EZH1" -"UniProt:P54762","EPHB1" -"UniProt:Q8IWZ6","BBS7" -"UniProt:Q9ULD8","KCNH3" -"UniProt:Q9Y572","RIPK3" -"UniProt:Q8NET6","CHST13" -"UniProt:Q9Y4J8","DTNA" -"UniProt:Q921E6","Eed" -"UniProt:P30837","ALDH1B1" -"UniProt:Q6PIW4","FIGNL1" -"UniProt:Q969U7","PSMG2" -"UniProt:P50402","EMD" -"UniProt:Q4KMZ1","IQCC" -"UniProt:A1A5B4","ANO9" -"UniProt:Q15058","KIF14" -"UniProt:Q8IYU2","HACE1" -"UniProt:Q6WKZ4","RAB11FIP1" -"UniProt:P19526","FUT1" -"UniProt:Q9C0H5","ARHGAP39" -"UniProt:Q9C0E4","GRIP2" -"UniProt:Q13825","AUH" -"UniProt:P59826","BPIB3" -"UniProt:Q5TDP6","LGSN" -"UniProt:Q9HAP2","MLXIP" -"UniProt:Q92611","EDEM1" -"UniProt:Q8TC84","FANK1" -"UniProt:Q99IB8","Genome" -"UniProt:O00244","ATOX1" -"UniProt:Q9H772","GREM2" -"UniProt:Q02248","CTNB1" -"UniProt:O88712","CTBP1" -"UniProt:Q08431","MFGE8" -"UniProt:Q96RT1","ERBIN" -"UniProt:P34741","SDC2" -"UniProt:Q9H204","MED28" -"UniProt:P00387","CYB5R3" -"UniProt:B2RXF5","ZBTB42" -"UniProt:Q9NQC8","IFT46" -"UniProt:Q8NBH2","KY" -"UniProt:O94886","TMEM63A" -"UniProt:Q15050","RRS1" -"UniProt:Q8N119","MMP21" -"UniProt:P56749","CLDN12" -"UniProt:Q8TDC0","MYOZ3" -"UniProt:P11171","EPB41" -"UniProt:Q71RS6","SLC24A5" -"UniProt:Q13404","UB2V1" -"UniProt:P25713","MT3" -"UniProt:P60766","Cdc42" -"UniProt:Q6W3E5","GDPD4" -"UniProt:Q13516","OLIG2" -"UniProt:P18054","ALOX12" -"UniProt:P20871","env" -"UniProt:Q96JL9","ZNF333" -"UniProt:Q86UX7","FERMT3" -"UniProt:Q5VWK5","IL23R" -"UniProt:O94854","KIAA0754" -"UniProt:Q5JZY3","EPHA10" -"UniProt:Q9Y493","ZAN" -"UniProt:Q8IV42","PSTK" -"UniProt:P48448","ALDH3B2" -"UniProt:Q8NHX9","TPCN2" -"UniProt:Q9UI15","TAGLN3" -"UniProt:Q9BV97","ZNF747" -"UniProt:Q13099","IFT88" -"UniProt:P40197","GP5" -"UniProt:Q92643","PIGK" -"UniProt:Q96ID5","IGSF21" -"UniProt:Q96EQ8","RNF125" -"UniProt:Q9Y6Y8","S23IP" -"UniProt:Q765P7","MTSS1L" -"UniProt:Q5SRD1","TIMM23B" -"UniProt:Q9GZP7","VN1R1" -"UniProt:P12978","EBNA2" -"UniProt:P00167","CYB5A" -"UniProt:Q8IZE3","SCYL3" -"UniProt:O76038","SCGN" -"UniProt:Q7Z3Z0","KRT25" -"UniProt:Q9UQP3","TNN" -"UniProt:Q8WYA0","IFT81" -"UniProt:Q13907","IDI1" -"UniProt:P50502","F10A1" -"UniProt:Q8TDU9","RXFP4" -"UniProt:D6RBD3","D6RBD3" -"UniProt:Q63ZE4","SLC22A10" -"UniProt:Q4U2R6","MRPL51" -"UniProt:P34901","Sdc4" -"UniProt:Q8NB15","ZNF511" -"UniProt:Q92841","DDX17" -"UniProt:Q86UN2","RTN4RL1" -"UniProt:Q30KR1","DEFB109P1" -"UniProt:P02786","TFRC" -"UniProt:P19622","EN2" -"UniProt:Q99836","MYD88" -"UniProt:P23927","CRYAB" -"UniProt:Q9C0E8","LNPK" -"UniProt:Q495B1","ANKDD1A" -"UniProt:Q8NCL9","APCDD1L" -"UniProt:O15232","MATN3" -"UniProt:A8MPX8","PP2D1" -"UniProt:P30542","AA1R" -"UniProt:P28838","LAP3" -"UniProt:Q05033","Opacity" -"UniProt:O15231","ZNF185" -"UniProt:Q96GN5","CDA7L" -"UniProt:O15217","GSTA4" -"UniProt:Q8IYS4","C16orf71" -"UniProt:Q8N755","PQLC3" -"UniProt:Q8TCT0","CERK" -"UniProt:Q9P202","WHRN" -"UniProt:O00221","IKBE" -"UniProt:P16767","UL36" -"UniProt:P55089","UCN" -"UniProt:Q9BWI9","Q9BWI9" -"UniProt:Q6IF63","OR52W1" -"UniProt:Q8VCW4","UN93B" -"UniProt:A8KAD6","A8KAD6" -"UniProt:P57775","FBXW4" -"UniProt:Q92564","DCUN1D4" -"UniProt:O75343","GUCY1B2" -"UniProt:Q6V4L9","Q6V4L9" -"UniProt:Q8IZP1","TBC1D3C" -"UniProt:Q5NV84","IGLV2-11" -"UniProt:Q93079","HIST1H2BH" -"UniProt:Q71UI9","H2AFV" -"UniProt:O95047","OR2A4" -"UniProt:Q6UWU4","C6orf89" -"UniProt:Q5FYB1","ARSI" -"UniProt:P46379","BAG6" -"UniProt:Q96BM0","IFI27L1" -"UniProt:P41247","PNPLA4" -"UniProt:Q62226","Shh" -"UniProt:Q9HBT8","Z286A" -"UniProt:P82970","HMGN5" -"UniProt:Q99418","CYH2" -"UniProt:Q9NYQ3","HAO2" -"UniProt:Q9BYP7","WNK3" -"UniProt:Q641Q3","METRNL" -"UniProt:Q9NX02","NLRP2" -"UniProt:Q96CW5","GCP3" -"UniProt:Q9P296","C5AR2" -"UniProt:Q86SG6","NEK8" -"UniProt:Q9H342","OR51J1" -"UniProt:Q93084","ATP2A3" -"UniProt:A5D6W6","FITM1" -"UniProt:Q9BUN5","CCDC28B" -"UniProt:Q9Z2F7","BNI3L" -"UniProt:P30550","GRPR" -"UniProt:O00512","BCL9" -"UniProt:P28070","PSMB4" -"UniProt:P0C623","OR4Q2" -"UniProt:P62158","CALM" -"UniProt:P10155","TROVE2" -"UniProt:Q9UGF7","OR12D3" -"UniProt:Q9Y3D0","FAM96B" -"UniProt:P22061","PCMT1" -"UniProt:Q9BTE7","DCUN1D5" -"UniProt:Q9BY77","POLDIP3" -"UniProt:Q8NGC0","OR5AU1" -"UniProt:Q14142","TRIM14" -"UniProt:P67809","YBX1" -"UniProt:O43323","DHH" -"UniProt:Q9H7P6","MVB12B" -"UniProt:O76076","WISP2" -"UniProt:Q9BZR8","BCL2L14" -"UniProt:Q86XK3","SFR1" -"UniProt:Q9NYV9","TAS2R13" -"UniProt:Q6IPX1","TBC1D3C" -"UniProt:Q9NPA8","ENY2" -"UniProt:Q8TAU0","NKX2-3" -"UniProt:Q15811","ITSN1" -"UniProt:Q8CHC4","SYNJ1" -"UniProt:Q8NB16","MLKL" -"UniProt:Q96RD0","OR8B2" -"UniProt:Q4VCS5","AMOT" -"UniProt:Q92823","NRCAM" -"UniProt:Q9BUH8","BEGAIN" -"UniProt:P30453","HLA-A" -"UniProt:P75390","ODPA" -"UniProt:Q30201","HFE" -"UniProt:Q86VI3","IQGAP3" -"UniProt:P01597","IGKV1-39" -"UniProt:P21306","ATP5E" -"UniProt:Q96Q15","SMG1" -"UniProt:P75392","ODP2" -"UniProt:Q9TQE0","HLA-DRB1" -"UniProt:P35914","HMGCL" -"UniProt:P43353","ALDH3B1" -"UniProt:Q6V4L5","Q6V4L5" -"UniProt:Q6PJE2","POMZP3" -"UniProt:P25789","PSA4" -"UniProt:Q04878","opaE" -"UniProt:P62837","UBE2D2" -"UniProt:Q5T764","IFT1B" -"UniProt:O94986","CEP152" -"UniProt:O43257","ZNHI1" -"UniProt:O15504","NUPL2" -"UniProt:Q3KRB8","ARHGAP11B" -"UniProt:P20639","K3" -"UniProt:Q9C0B9","ZCCHC2" -"UniProt:Q6VUC0","TFAP2E" -"UniProt:Q86WV1","SKAP1" -"UniProt:Q96N22","ZNF681" -"UniProt:Q9BWD3","F127B" -"UniProt:Q5JUQ0","FAM78A" -"UniProt:O43187","IRAK2" -"UniProt:A6NIJ9","OR6C70" -"UniProt:Q16633","OBF1" -"UniProt:Q7Z4L5","TTC21B" -"UniProt:Q9BVN2","RUSC1" -"UniProt:Q969P6","TOP1MT" -"UniProt:Q86WI3","NLRC5" -"UniProt:Q9UL03","INTS6" -"UniProt:P33750","DCA13" -"UniProt:Q6P3W2","DNAJC24" -"UniProt:Q8IWX8","CHERP" -"UniProt:Q12165","ATPD" -"UniProt:Q8IXM3","MRPL41" -"UniProt:P17858","PFKL" -"UniProt:Q86Z20","CC125" -"UniProt:P46063","RECQ1" -"UniProt:Q4VC44","FLYWCH1" -"UniProt:Q17RA5","CMAS1" -"UniProt:Q9Y2W1","THRAP3" -"UniProt:Q9NZN8","CNOT2" -"UniProt:P07251","ATP1" -"UniProt:Q8WXF8","DEDD2" -"UniProt:Q9NQV6","PRD10" -"UniProt:Q8NG83","OR2M3" -"UniProt:P75391","ODPB" -"UniProt:P02748","C9" -"UniProt:Q7Z434","MAVS" -"UniProt:Q9HB21","PKHA1" -"UniProt:Q9UKR3","KLK13" -"UniProt:Q9NQS5","GPR84" -"UniProt:Q9H0K6","PUS7L" -"UniProt:Q00056","HOXA4" -"UniProt:Q96S06","LMF1" -"UniProt:Q3SY89","ELOA3B" -"UniProt:Q99459","CDC5L" -"UniProt:Q7Z5A9","FAM19A1" -"UniProt:P38567","SPAM1" -"UniProt:P26640","VARS" -"UniProt:P50336","PPOX" -"UniProt:P09622","DLD" -"UniProt:P01593","IGKV1D-33" -"UniProt:Q86X53","ERICH1" -"UniProt:P75393","DLDH" -"UniProt:R4GMX3","R4GMX3" -"UniProt:Q9BSF8","BTBD10" -"UniProt:Q5JR59","MTUS2" -"UniProt:Q96I36","COX14" -"UniProt:Q96CS7","PLEKHB2" -"UniProt:O14744","PRMT5" -"UniProt:Q8BUN5","Smad3" -"UniProt:Q7Z6G3","NECA2" -"UniProt:Q2M5E4","RGS21" -"UniProt:Q6V4L1","Q6V4L1" -"UniProt:Q96D03","DDT4L" -"UniProt:Q29865","HLA-C" -"UniProt:Q86V81","ALYREF" -"UniProt:Q9BRP7","FDXA1" -"UniProt:Q147X8","Q147X8" -"UniProt:O60381","HBP1" -"UniProt:Q7Z7L8","C11orf96" -"UniProt:O75934","SPF27" -"UniProt:Q14118","DAG1" -"UniProt:Q64364","ARF" -"UniProt:Q7TSJ6","LATS2" -"UniProt:Q5S007","LRRK2" -"UniProt:Q8IW24","Q8IW24" -"UniProt:Q6TCH4","PAQR6" -"UniProt:O75881","CYP7B1" -"UniProt:Q8NGH8","OR56A4" -"UniProt:Q9NVU0","POLR3E" -"UniProt:Q9H963","ZNF702P" -"UniProt:P25786","PSA1" -"UniProt:Q9H205","O2AG1" -"UniProt:O95772","STARD3NL" -"UniProt:P0DI80","SMIM6" -"UniProt:Q86Y46","KRT73" -"UniProt:Q8N2A8","PLD6" -"UniProt:Q63HM1","AFMID" -"UniProt:Q6NUK1","SLC25A24" -"UniProt:Q9NUQ7","UFSP2" -"UniProt:P10911","MCF2" -"UniProt:O94887","FARP2" -"UniProt:Q7LGC8","CHST3" -"UniProt:Q8WWB5","PIHD2" -"UniProt:P08700","IL3" -"UniProt:P55039","DRG2" -"UniProt:Q96S97","MYADM" -"UniProt:P51825","AFF1" -"UniProt:Q8NI38","IKBD" -"UniProt:Q92542","NCSTN" -"UniProt:P14543","NID1" -"UniProt:Q92794","KAT6A" -"UniProt:Q16612","NREP" -"UniProt:Q9NQT8","KIF13B" -"UniProt:Q96NG8","ZNF582" -"UniProt:Q00532","CDKL1" -"UniProt:Q8NGC7","OR11H6" -"UniProt:Q61327","SC6A3" -"UniProt:Q9UPW8","UNC13A" -"UniProt:A6NNW6","ENO4" -"UniProt:Q86UQ4","ABCA13" -"UniProt:P30084","ECHS1" -"UniProt:Q14DJ8","Q14DJ8" -"UniProt:P70398","USP9X" -"UniProt:P62701","RS4X" -"UniProt:P02461","COL3A1" -"UniProt:Q9BY15","ADGRE3" -"UniProt:P61575","ERVK-8" -"UniProt:O75689","ADAP1" -"UniProt:Q9UK41","VPS28" -"UniProt:P21580","TNFAIP3" -"UniProt:Q5SVJ3","C1orf100" -"UniProt:Q9H078","CLPB" -"UniProt:Q6ZSG2","FAM196A" -"UniProt:Q96T37","RBM15" -"UniProt:Q96PY5","FMNL2" -"UniProt:Q16401","PSMD5" -"UniProt:Q9NZH6","IL37" -"UniProt:Q06495","SLC34A1" -"UniProt:Q9BZX2","UCK2" -"UniProt:P13232","IL7" -"UniProt:Q15760","GPR19" -"UniProt:Q9BRJ6","C7orf50" -"UniProt:Q6PIQ7","Q6PIQ7" -"UniProt:Q9UBE8","NLK" -"UniProt:P46092","CCR10" -"UniProt:Q53QW1","TEX44" -"UniProt:Q8NGW6","OR6K6" -"UniProt:Q15274","NADC" -"UniProt:Q6PH85","DCUN1D2" -"UniProt:Q5VT25","MRCKA" -"UniProt:P49842","STK19" -"UniProt:P52948","NUP98" -"UniProt:Q6UXH1","CREL2" -"UniProt:A6NGU5","GGT3P" -"UniProt:Q13951","PEBB" -"UniProt:P55145","MANF" -"UniProt:Q8TEM1","NUP210" -"UniProt:Q9BT08","Q9BT08" -"UniProt:A5PL33","KRBA1" -"UniProt:Q6ECI4","ZNF470" -"UniProt:Q8IWX7","UNC45B" -"UniProt:Q91YQ1","RAB7L" -"UniProt:Q80U70","Suz12" -"UniProt:P80108","GPLD1" -"UniProt:Q99627","COPS8" -"UniProt:Q7Z601","GPR142" -"UniProt:O94850","DEND" -"UniProt:Q15560","TCEA2" -"UniProt:Q9Y262","EIF3L" -"UniProt:Q9WV55","VAPA" -"UniProt:Q99435","NELL2" -"UniProt:Q16613","AANAT" -"UniProt:Q6ZNA4","RN111" -"UniProt:Q13153","PAK1" -"UniProt:Q96MU7","YTHDC1" -"UniProt:C9JN71","ZNF878" -"UniProt:O43927","CXCL13" -"UniProt:Q92583","CCL17" -"UniProt:O15544","GR6" -"UniProt:Q9UKT7","FBXL3" -"UniProt:Q7L1W4","LRRC8D" -"UniProt:P22362","CCL1" -"UniProt:Q08857","Cd36" -"UniProt:Q0D2K0","NIPAL4" -"UniProt:P49761","CLK3" -"UniProt:P17658","KCNA6" -"UniProt:P23515","OMG" -"UniProt:Q9WMX2","POLG" -"UniProt:P13864","Dnmt1" -"UniProt:P36575","ARRC" -"UniProt:Q8TB73","NDNF" -"UniProt:O14745","SLC9A3R1" -"UniProt:Q96LR4","F19A4" -"UniProt:Q3LXA3","TKFC" -"UniProt:O95340","PAPSS2" -"UniProt:Q2NL67","PARP6" -"UniProt:P29536","LMOD1" -"UniProt:Q9H1V8","SLC6A17" -"UniProt:Q7Z6M4","MTEF4" -"UniProt:O35526","STX1A" -"UniProt:Q9NWZ5","UCKL1" -"UniProt:Q9UJU6","DBNL" -"UniProt:Q95460","MR1" -"UniProt:A8MU46","SMTNL1" -"UniProt:Q8N8B7","TCEANC" -"UniProt:P24941","CDK2" -"UniProt:P38247","SLM4" -"UniProt:Q9UNL2","SSR3" -"UniProt:Q86VG3","C11orf74" -"UniProt:Q96CV8","Q96CV8" -"UniProt:Q9BYC9","MRPL20" -"UniProt:A6NP61","ZAR1L" -"UniProt:P62826","RAN" -"UniProt:Q9UHF4","IL20RA" -"UniProt:P32856","STX2" -"UniProt:P28288","ABCD3" -"UniProt:Q12933","TRAF2" -"UniProt:Q8WYQ5","DGCR8" -"UniProt:Q9Y3A0","COQ4" -"UniProt:Q9BPW4","APOL4" -"UniProt:Q86UB9","TMEM135" -"UniProt:Q62915","Cask" -"UniProt:Q8NGD0","OR4M1" -"UniProt:Q12988","HSPB3" -"UniProt:P62714","PP2AB" -"UniProt:Q9Y3A3","PHOCN" -"UniProt:Q9UP52","TFR2" -"UniProt:P0C626","OR5G3" -"UniProt:A0A0H3NF38","A0A0H3NF38" -"UniProt:Q68CL5","TPGS2" -"UniProt:P48066","SLC6A11" -"UniProt:Q8IXF0","NPAS3" -"UniProt:Q9ULZ0","TP53TG3" -"UniProt:Q8NGZ2","OR14K1" -"UniProt:A8MWE9","EFCAB8" -"UniProt:Q8NH16","OR2L2" -"UniProt:P51451","BLK" -"UniProt:Q9Y6E0","STK24" -"UniProt:Q9P1Z3","HCN3" -"UniProt:Q3ZAQ7","VMA21" -"UniProt:Q8NGA0","OR7G1" -"UniProt:B8ZZ34","SHISA8" -"UniProt:Q92988","DLX4" -"UniProt:Q8N865","C7orf31" -"UniProt:P04198","MYCN" -"UniProt:P82912","MRPS11" -"UniProt:Q8NGG5","OR8K1" -"UniProt:Q96QE3","ATAD5" -"UniProt:P39976","DLD3" -"UniProt:Q8NFP0","PXT1" -"UniProt:P81274","GPSM2" -"UniProt:Q9GZT4","SRR" -"UniProt:Q8NGQ4","OR10Q1" -"UniProt:Q9NZS9","BFAR" -"UniProt:Q8WZ84","OR8D1" -"UniProt:Q8NGA1","OR1M1" -"UniProt:O00421","CCRL2" -"UniProt:Q9BR84","ZNF559" -"UniProt:Q96L96","ALPK3" -"UniProt:Q9UQ84","EXO1" -"UniProt:Q8NGL1","OR5D18" -"UniProt:Q01973","ROR1" -"UniProt:O60462","NRP2" -"UniProt:O00411","POLRMT" -"UniProt:Q8NGP0","OR4C13" -"UniProt:Q00887","PSG9" -"UniProt:Q13636","RAB31" -"UniProt:P0C672","TSPAN19" -"UniProt:Q9GZU5","NYX" -"UniProt:P97924","KALRN" -"UniProt:Q9BYV7","BCO2" -"UniProt:Q8NGC2","OR4E2" -"UniProt:P82664","MRPS10" -"UniProt:Q6EIG7","CLEC6A" -"UniProt:P02489","CRYAA;CRYAA2" -"UniProt:Q92503","SEC14L1" -"UniProt:P04075","ALDOA" -"UniProt:P46934","NEDD4" -"UniProt:P41587","VIPR2" -"UniProt:Q8NH49","OR4X1" -"UniProt:Q8IWL3","HSCB" -"UniProt:O75841","UPK1B" -"UniProt:Q8IYV9","IZUMO1" -"UniProt:A6QL64","ANKRD36" -"UniProt:Q9UBC2","EPS15L1" -"UniProt:Q9H346","OR52D1" -"UniProt:P0C7N5","OR8U9" -"UniProt:Q8IVL0","NAV3" -"UniProt:A0A0C3SFZ9","A0A0C3SFZ9" -"UniProt:Q9NUG6","PDRG1" -"UniProt:Q8NGR2","OR1L6" -"UniProt:P05881","env" -"UniProt:Q15361","TTF1" -"UniProt:Q5SRH9","TTC39A" -"UniProt:O60234","GMFG" -"UniProt:O75131","CPNE3" -"UniProt:P12273","PIP" -"UniProt:P53833","POP3" -"UniProt:Q96R47","OR2A14" -"UniProt:Q6DKI1","RPL7L1" -"UniProt:P50995","ANXA11" -"UniProt:Q8NH50","OR8K5" -"UniProt:Q9Z2B5","E2AK3" -"UniProt:E7ERP6","E7ERP6" -"UniProt:Q8NH42","OR4K13" -"UniProt:P37238","PPARG" -"UniProt:A6NJ69","IGIP" -"UniProt:Q8NGX6","OR10R2" -"UniProt:Q9BWF2","TRAIP" -"UniProt:Q8NGE0","OR10AD1" -"UniProt:O60784","TOM1" -"UniProt:O00506","STK25" -"UniProt:Q14192","FHL2" -"UniProt:Q8NGL4","OR5D13" -"UniProt:O43166","SIPA1L1" -"UniProt:Q9C0A1","ZFHX2" -"UniProt:O75367","H2AY" -"UniProt:O00470","MEIS1" -"UniProt:Q9UHV9","PFD2" -"UniProt:P33316","DUT" -"UniProt:P24390","KDELR1" -"UniProt:Q8N7E2","ZNF645" -"UniProt:Q8N4Z0","RAB42" -"UniProt:Q14181","POLA2" -"UniProt:P05451","REG1A" -"UniProt:Q68CK6","ACSM2B" -"UniProt:Q8IYP9","ZDHHC23" -"UniProt:Q01432","AMPD3" -"UniProt:Q9C0H6","KLHL4" -"UniProt:Q96EY8","MMAB" -"UniProt:Q8N0Y3","OR4N4" -"UniProt:Q99933","BAG1" -"UniProt:Q13496","MTM1" -"UniProt:O60308","CEP104" -"UniProt:Q8NEM0","MCPH1" -"UniProt:Q9H461","FZD8" -"UniProt:Q9NS18","GLRX2" -"UniProt:A8MXT2","MAGEB17" -"UniProt:P52943","CRIP2" -"UniProt:Q96R27","OR2M4" -"UniProt:Q6ZUT3","FRMD7" -"UniProt:P07948","LYN" -"UniProt:P41002","CCNF" -"UniProt:Q8NGT0","OR13C9" -"UniProt:P53041","PPP5" -"UniProt:P13598","ICAM2" -"UniProt:Q96I15","SCLY" -"UniProt:Q8NGS6","OR13C3" -"UniProt:Q8NHC5","OR14A16" -"UniProt:Q8N387","MUC15" -"UniProt:Q8IVH4","MMAA" -"UniProt:A6NGD5","ZSCAN5C" -"UniProt:Q9NZ20","PLA2G3" -"UniProt:Q8N9H6","C8orf31" -"UniProt:P0CV99","TSPY1" -"UniProt:Q96BM9","ARL8A" -"UniProt:Q9Y250","LZTS1" -"UniProt:P22079","LPO" -"UniProt:Q9BRT9","GINS4" -"UniProt:Q08AG7","MZT1" -"UniProt:A6NM62","LRRC53" -"UniProt:Q86Y07","VRK2" -"UniProt:Q04771","ACVR1" -"UniProt:Q9Y4C4","MFHA1" -"UniProt:P60981","DEST" -"UniProt:P41567","EIF1" -"UniProt:Q53Y01","Q53Y01" -"UniProt:Q9NWW6","NMRK1" -"UniProt:P09912","IFI6" -"UniProt:Q9H8W4","PKHF2" -"UniProt:O60721","SLC24A1" -"UniProt:P47898","HTR5A" -"UniProt:Q9Y6M1","IF2B2" -"UniProt:Q8N9N5","BANP" -"UniProt:Q14966","ZNF638" -"UniProt:Q969S9","RRF2M" -"UniProt:Q8WZA1","POMGNT1" -"UniProt:P0DN77","OPN1MW" -"UniProt:P49025","Cit" -"UniProt:Q9BY89","KIAA1671" -"UniProt:Q13795","ARFRP1" -"UniProt:Q9Y4X5","ARIH1" -"UniProt:Q15819","UBE2V2" -"UniProt:P32745","SSR3" -"UniProt:Q13368","MPP3" -"UniProt:Q49A26","GLYR1" -"UniProt:Q13576","IQGA2" -"UniProt:O75891","ALDH1L1" -"UniProt:Q96KN7","RPGRIP1" -"UniProt:Q63155","DCC" -"UniProt:Q14680","MELK" -"UniProt:P35452","HOXD12" -"UniProt:Q9P0P0","RNF181" -"UniProt:Q9BT25","HAUS8" -"UniProt:Q24JT5","Q24JT5" -"UniProt:Q91ZX7","LRP1" -"UniProt:Q5T619","ZN648" -"UniProt:Q02535","ID3" -"UniProt:O14905","WNT9B" -"UniProt:Q86VH5","LRRTM3" -"UniProt:P59510","ADAMTS20" -"UniProt:Q9NTI5","PDS5B" -"UniProt:Q2M3C6","TM266" -"UniProt:Q9NVM1","EVA1B" -"UniProt:P04326","TAT" -"UniProt:Q9Y5Q9","TF3C3" -"UniProt:Q9UN73","PCDHA6" -"UniProt:Q8NEV4","MYO3A" -"UniProt:P47929","LEG7" -"UniProt:Q8IYI8","ZN440" -"UniProt:O00763","ACACB" -"UniProt:P63085","Mapk1" -"UniProt:P07510","CHRNG" -"UniProt:Q66K80","RUAS1" -"UniProt:Q9NRI5","DISC1" -"UniProt:Q8NEA4","FBXO36" -"UniProt:O43739","CYH3" -"UniProt:P15291","B4GALT1" -"UniProt:O43933","PEX1" -"UniProt:Q96S79","RSLAB" -"UniProt:Q9UMX6","GUCA1B" -"UniProt:P23285","CYPB" -"UniProt:P30876","RPB2" -"UniProt:B7ZC32","KIF28P" -"UniProt:O14921","RGS13" -"UniProt:P97313","PRKDC" -"UniProt:Q5HYL7","TMEM196" -"UniProt:Q5T9S5","CCDC18" -"UniProt:Q86V97","KBTB6" -"UniProt:P56181","NDUFV3" -"UniProt:Q16610","ECM1" -"UniProt:Q96PD2","DCBD2" -"UniProt:Q07001","CHRND" -"UniProt:Q9NVE7","PANK4" -"UniProt:Q9Y6B2","EID1" -"UniProt:P20839","IMPDH1" -"UniProt:P53618","COPB1" -"UniProt:P30086","PEBP1" -"UniProt:Q91XV3","BASP1" -"UniProt:Q96P20","NLRP3" -"UniProt:Q16637","SMN2;SMN1" -"UniProt:P26373","RL13" -"UniProt:P24928","RPB1" -"UniProt:A6NFC5","TMEM235" -"UniProt:O75564","JERKY" -"UniProt:P43034","PAFAH1B1" -"UniProt:O35826","GLCNE" -"UniProt:P27361","MAPK3" -"UniProt:Q9UBW8","COPS7A" -"UniProt:P53675","CLTCL1" -"UniProt:Q96P68","OXGR1" -"UniProt:P02100","HBE" -"UniProt:Q6ZUS5","CC121" -"UniProt:Q5TKA1","LIN9" -"UniProt:Q9CQ25","MZT2" -"UniProt:Q9HAV4","XPO5" -"UniProt:Q99747","NAPG" -"UniProt:Q7Z7K2","ZNF467" -"UniProt:Q9H706","GARE1" -"UniProt:Q8N490","PNKD" -"UniProt:Q6P587","FAHD1" -"UniProt:Q9H3V2","MS4A5" -"UniProt:A1YPR0","ZBTB7C" -"UniProt:Q45877","ha70" -"UniProt:Q9R0P5","DEST" -"UniProt:Q6NZ67","MZT2B" -"UniProt:P31946","YWHAB" -"UniProt:P25815","S100P" -"UniProt:P62736","ACTA2" -"UniProt:Q61036","PAK3" -"UniProt:P04618","rev" -"UniProt:P21462","FPR1" -"UniProt:P60893","GPR85" -"UniProt:Q9WV31","ARC" -"UniProt:A0A0F6B1Q8","A0A0F6B1Q8" -"UniProt:P82279","CRB1" -"UniProt:O75626","PRDM1" -"UniProt:Q9BRX2","PELO" -"UniProt:Q53GS7","GLE1" -"UniProt:Q96S96","PEBP4" -"UniProt:Q9NTJ3","SMC4" -"UniProt:Q8N594","MPND" -"UniProt:P78346","RPP30" -"UniProt:O15553","MEFV" -"UniProt:Q61090","Fzd7" -"UniProt:Q9BYG7","MRO" -"UniProt:Q96L93","KIF16B" -"UniProt:P63001","Rac1" -"UniProt:A8K727","A8K727" -"UniProt:Q8NFG4","FLCN" -"UniProt:Q7Z7G0","ABI3BP" -"UniProt:Q15843","NEDD8" -"UniProt:Q921T2","TOIP1" -"UniProt:O43570","CA12" -"UniProt:Q9BZE7","EVG1" -"UniProt:Q6IV72","ZNF425" -"UniProt:Q6NW40","RGMB" -"UniProt:Q09666","AHNK" -"UniProt:O60907","TBL1X" -"UniProt:Q5VT97","SYDE2" -"UniProt:P18872","Gnao1" -"UniProt:P50895","BCAM" -"UniProt:Q2M1P5","KIF7" -"UniProt:P12960","Cntn1" -"UniProt:Q4VC12","MSS51" -"UniProt:Q99731","CCL19" -"UniProt:P02708","CHRNA1" -"UniProt:Q31610","HLA-B" -"UniProt:Q709F0","ACAD11" -"UniProt:Q922F4","Tubb6" -"UniProt:Q6ZWJ1","STXBP4" -"UniProt:Q8N355","Q8N355" -"UniProt:A8MQ27","NEURL1B" -"UniProt:Q629K1","TRIQK" -"UniProt:Q9UBG7","RBPJL" -"UniProt:O00585","CCL21" -"UniProt:P48453","Ppp3cb" -"UniProt:Q68FD5","CLH1" -"UniProt:P59022","DSC10" -"UniProt:P01266","TG" -"UniProt:Q14155","ARHGEF7" -"UniProt:O60264","SMCA5" -"UniProt:Q68EF6","BEGIN" -"UniProt:Q8TEZ7","PAQR8" -"UniProt:Q9H6R4","NOL6" -"UniProt:P07356","Anxa2" -"UniProt:Q9Y6B6","SAR1B" -"UniProt:Q5M9Q1","NKAPL" -"UniProt:P43251","BTD" -"UniProt:P30273","FCER1G" -"UniProt:Q8N5K1","CISD2" -"UniProt:A0A0C4DGV4","A0A0C4DGV4" -"UniProt:Q53EV4","LRRC23" -"UniProt:P59942","MCCD1" -"UniProt:H3BTW2","H3BTW2" -"UniProt:Q496A3","SPATS1" -"UniProt:Q9UBV4","WNT16" -"UniProt:P98168","ZXDA" -"UniProt:P15924","DSP" -"UniProt:O43306","ADCY6" -"UniProt:Q15139","PRKD1" -"UniProt:Q92949","FOXJ1" -"UniProt:Q9NYW5","TAS2R4" -"UniProt:O14958","CASQ2" -"UniProt:Q9H497","TOR3A" -"UniProt:Q9UJA3","MCM8" -"UniProt:Q811T9","DISC1" -"UniProt:Q9P0N9","TBC1D7-LOC100130357;TBC1D7" -"UniProt:P17540","CKMT2" -"UniProt:Q9Y3M8","STARD13" -"UniProt:Q04110","ECM11" -"UniProt:Q9BY32","ITPA" -"UniProt:O60880","SH2D1A" -"UniProt:P10314","HLA-A" -"UniProt:Q9NZH7","IL36B" -"UniProt:Q8N1B4","VPS52" -"UniProt:A8MQT2","GOLGA8B" -"UniProt:P27539","GDF1" -"UniProt:P19634","SLC9A1" -"UniProt:O43555","GNRH2" -"UniProt:Q9BYQ7","KRTAP4-1" -"UniProt:Q9NPC6","MYOZ2" -"UniProt:Q8N5D6","GBGT1" -"UniProt:P13987","CD59" -"UniProt:O75363","BCAS1" -"UniProt:O00294","TULP1" -"UniProt:Q3SXY8","ARL13B" -"UniProt:Q96AW1","VOPP1" -"UniProt:Q3LI54","KRTAP19-8" -"UniProt:Q5VZM2","RRAGB" -"UniProt:Q8N5M1","ATPAF2" -"UniProt:Q6IAA8","LAMTOR1" -"UniProt:Q6P6S3","BSPRY" -"UniProt:Q92911","SLC5A5" -"UniProt:O95801","TTC4" -"UniProt:Q9H7P9","PLEKHG2" -"UniProt:Q8N8I6","CQ055" -"UniProt:Q3ZCM7","TUBB8" -"UniProt:Q6P1Q9","METTL2B" -"UniProt:Q70HW3","SLC25A26" -"UniProt:Q9BV10","ALG12" -"UniProt:O95377","GJB5" -"UniProt:Q7L523","RRAGA" -"UniProt:Q8TAD4","SLC30A5" -"UniProt:P35711","SOX5" -"UniProt:Q8TCG5","CPT1C" -"UniProt:Q0VGL1","LAMTOR4" -"UniProt:O76080","ZFAND5" -"UniProt:Q1EHB4","SLC5A12" -"UniProt:O00631","SLN" -"UniProt:P15407","FOSL1" -"UniProt:Q53HC0","CCD92" -"UniProt:Q63HN8","RNF213" -"UniProt:Q9UPQ8","DOLK" -"UniProt:Q9BYR4","KRTAP4-3" -"UniProt:A4FU49","SH3D21" -"UniProt:P19087","GNAT2" -"UniProt:D3DR40","D3DR40" -"UniProt:O60682","MSC" -"UniProt:O15457","MSH4" -"UniProt:P51993","FUT6" -"UniProt:Q9Y6R1","SLC4A4" -"UniProt:P56385","ATP5I" -"UniProt:P47901","AVPR1B" -"UniProt:Q9NS61","KCNIP2" -"UniProt:Q8WTV0","SCARB1" -"UniProt:P26639","SYTC" -"UniProt:P02743","APCS" -"UniProt:P21728","DRD1" -"UniProt:Q8NBW4","SLC38A9" -"UniProt:Q9NZ53","PODXL2" -"UniProt:P33121","ACSL1" -"UniProt:Q6ZUI0","TPRG1" -"UniProt:Q96T54","KCNK17" -"UniProt:Q86TU7","SETD3" -"UniProt:Q6PEY2","TUBA3E" -"UniProt:Q69YH5","CDCA2" -"UniProt:Q96TA2","YME1L1" -"UniProt:P37288","AVPR1A" -"UniProt:Q9UQG0","ERVK-11" -"UniProt:Q1HG44","DUOXA2" -"UniProt:Q9NPG1","FZD3" -"UniProt:P39996","GTT3" -"UniProt:Q8IVW8","SPNS2" -"UniProt:Q9NP81","SARS2" -"UniProt:Q9BYQ8","KRTAP4-9" -"UniProt:P03107","VL2" -"UniProt:O14980","XPO1" -"UniProt:Q9NTX9","FAM217B" -"UniProt:Q12882","DPYD" -"UniProt:P08913","ADRA2A" -"UniProt:P40205","MYCNOS" -"UniProt:O14625","CXCL11" -"UniProt:Q9NRX4","PHPT1" -"UniProt:B4DXD0","B4DXD0" -"UniProt:Q9H2S6","TNMD" -"UniProt:P81133","SIM1" -"UniProt:P16471","PRLR" -"UniProt:P42166","TMPO" -"UniProt:P63208","SKP1" -"UniProt:Q8N2H3","PYRD2" -"UniProt:Q9NYR8","RDH8" -"UniProt:Q6AI14","SLC9A4" -"UniProt:O95786","DDX58" -"UniProt:Q8N442","GUF1" -"UniProt:P49069","CAMLG" -"UniProt:P07202","TPO" -"UniProt:P24387","CRHBP" -"UniProt:A1A4F0","PQLC2L" -"UniProt:P17813","ENG" -"UniProt:Q8TET4","GANC" -"UniProt:P20226","TBP" -"UniProt:P00374","DHFR" -"UniProt:P40926","MDH2" -"UniProt:O94855","SEC24D" -"UniProt:P04070","PROC" -"UniProt:O43504","LAMTOR5" -"UniProt:Q8NDH6","ICA1L" -"UniProt:Q4VAQ0","Q4VAQ0" -"UniProt:Q86Y25","ZNF354C" -"UniProt:Q3MUY2","PIGY" -"UniProt:P05014","IFNA4" -"UniProt:P58401","NRXN2" -"UniProt:Q969G3","SMARCE1" -"UniProt:Q8TD30","GPT2" -"UniProt:P78357","CNTNAP1" -"UniProt:Q9NXB9","ELOVL2" -"UniProt:Q8TDD2","SP7" -"UniProt:Q96LK8","SPT32" -"UniProt:Q9NRY4","ARHGAP35" -"UniProt:P50454","SERPINH1" -"UniProt:P59537","TAS2R43" -"UniProt:P16066","NPR1" -"UniProt:O43497","CACNA1G" -"UniProt:P43403","ZAP70" -"UniProt:P51397","DAP" -"UniProt:Q5T0B9","ZNF362" -"UniProt:A6NND4","OR2AT4" -"UniProt:Q9H3N8","HRH4" -"UniProt:O15226","NKRF" -"UniProt:Q8IYD1","GSPT2" -"UniProt:Q08116","RGS1" -"UniProt:Q6JVE9","LCN8" -"UniProt:Q96DB5","RMDN1" -"UniProt:O76093","FGF18" -"UniProt:O00305","CACNB4" -"UniProt:P59540","TAS2R46" -"UniProt:Q15391","P2RY14" -"UniProt:Q96PB1","CASD1" -"UniProt:Q5TGZ0","MINOS1" -"UniProt:P10499","KCNA1" -"UniProt:Q83730","MT5" -"UniProt:P13378","HOXD8" -"UniProt:P28827","PTPRM" -"UniProt:Q9UKP3","ITBP2" -"UniProt:Q96GQ7","DDX27" -"UniProt:Q9BQA9","C17orf62" -"UniProt:O35618","MDM4" -"UniProt:P14316","IRF2" -"UniProt:Q02650","PAX5" -"UniProt:A0AVG3","A0AVG3" -"UniProt:Q96CW7","Q96CW7" -"UniProt:Q9CZY3","UB2V1" -"UniProt:P84550","SKOR1" -"UniProt:P43356","MAGA2" -"UniProt:P49711","CTCF" -"UniProt:P53355","DAPK1" -"UniProt:P19099","CYP11B2" -"UniProt:Q9NQV8","PRDM8" -"UniProt:P12504","VIF" -"UniProt:Q13432","UNC119" -"UniProt:D3DR37","D3DR37" -"UniProt:Q9P0S3","ORMDL1" -"UniProt:Q6L8G5","KRTAP5-10" -"UniProt:A0A0J9YY34","A0A0J9YY34" -"UniProt:Q9WUD9","Src" -"UniProt:Q07617","SPAG1" -"UniProt:Q8WWY8","LIPH" -"UniProt:Q9NYW2","TAS2R8" -"UniProt:P28572","SLC6A9" -"UniProt:Q86YR7","MCF2L2" -"UniProt:O15205","UBD" -"UniProt:O14944","EREG" -"UniProt:Q7RTZ2","USP17L1" -"UniProt:A0A0D2X7Z3","A0A0D2X7Z3" -"UniProt:Q9H920","RNF121" -"UniProt:P49356","FNTB" -"UniProt:Q6ZNG1","ZNF600" -"UniProt:Q7RTY0","SLC16A13" -"UniProt:P10398","ARAF" -"UniProt:O95858","TSPAN15" -"UniProt:O00562","PITPNM1" -"UniProt:Q96EK5","KIF1BP" -"UniProt:O00329","PIK3CD" -"UniProt:P78356","PI42B" -"UniProt:B3KQ07","B3KQ07" -"UniProt:Q53GG5","PDLIM3" -"UniProt:Q8NGU1","OR9A1P" -"UniProt:P24530","EDNRB" -"UniProt:Q15847","ADIRF" -"UniProt:Q8IZM9","SLC38A6" -"UniProt:P62487","POLR2G" -"UniProt:O95825","CRYZL1" -"UniProt:Q86UD3","MARCH3" -"UniProt:P58180","OR4D2" -"UniProt:P03468","NA" -"UniProt:Q9H324","ADAMTS10" -"UniProt:Q13748","TUBA3C" -"UniProt:Q92185","ST8SIA1" -"UniProt:O75920","SERF1A" -"UniProt:Q03654","CEF1" -"UniProt:Q14CZ0","CP072" -"UniProt:Q96IJ6","GMPPA" -"UniProt:P17752","TPH1" -"UniProt:P49755","TMEDA" -"UniProt:P60174","TPI1" -"UniProt:Q9NP84","TNFRSF12A" -"UniProt:P02794","FTH1" -"UniProt:P78509","RELN" -"UniProt:Q9UQ05","KCNH4" -"UniProt:O95470","SGPL1" -"UniProt:Q8N7M0","TCTEX1D1" -"UniProt:P53567","CEBPG" -"UniProt:P56559","ARL4C" -"UniProt:Q96EP5","DAZAP1" -"UniProt:Q15910","EZH2" -"UniProt:P15941","MUC1" -"UniProt:Q8TED9","AFAP1L1" -"UniProt:P49638","TTPA" -"UniProt:Q9H8M1","COQ10B" -"UniProt:Q8IWU4","SLC30A8" -"UniProt:Q8NGV0","OR2Y1" -"UniProt:Q7Z2X7","PAGE2" -"UniProt:P56937","HSD17B7" -"UniProt:P28290","SSFA2" -"UniProt:Q86Y82","STX12" -"UniProt:P15976","GATA1" -"UniProt:Q9P2P1","NYNRIN" -"UniProt:P16520","GNB3" -"UniProt:P13498","CYBA" -"UniProt:A0A0B4J2G4","A0A0B4J2G4" -"UniProt:P42566","EPS15" -"UniProt:Q8NH80","OR10D3" -"UniProt:Q96L34","MARK4" -"UniProt:Q13009","TIAM1" -"UniProt:O75616","ERAL1" -"UniProt:P02340","P53" -"UniProt:Q99832","TCPH" -"UniProt:A8K7I4","CLCA1" -"UniProt:P52569","SLC7A2" -"UniProt:O82882","STCE" -"UniProt:Q9BUD6","SPON2" -"UniProt:Q15283","RASA2" -"UniProt:Q9H079","KTBL1" -"UniProt:Q6IEV9","OR4C11" -"UniProt:P35222","CTNNB1" -"UniProt:P81172","HAMP" -"UniProt:Q9HDC5","JPH1" -"UniProt:Q9HC23","PROK2" -"UniProt:Q8NGG2","OR5T2" -"UniProt:Q32MH5","F214A" -"UniProt:Q9P1W9","PIM2" -"UniProt:P23109","AMPD1" -"UniProt:Q6P9G9","ZN449" -"UniProt:Q9UH73","COE1" -"UniProt:Q15303","ERBB4" -"UniProt:Q9NP79","VTA1" -"UniProt:P28335","HTR2C" -"UniProt:Q6ICB4","FAM109B" -"UniProt:P43407","Sdc2" -"UniProt:Q13425","SNTB2" -"UniProt:P55055","NR1H2" -"UniProt:P62847","RPS24" -"UniProt:B2BUF1","B2BUF1" -"UniProt:O14936","CASK" -"UniProt:P05879","env" -"UniProt:P61978","HNRNPK" -"UniProt:P21397","MAOA" -"UniProt:A4D2G3","OR2A25" -"UniProt:O95059","RPP14" -"UniProt:P35570","IRS1" -"UniProt:Q99497","PARK7" -"UniProt:Q8NCX0","CCDC150" -"UniProt:Q53GQ0","DHB12" -"UniProt:Q99759","M3K3" -"UniProt:Q9NYP9","MIS18A" -"UniProt:Q8NG81","OR2M7" -"UniProt:Q15582","TGFBI" -"UniProt:Q9BVJ7","DUS23" -"UniProt:Q96DN6","MBD6" -"UniProt:P0C025","NUDT17" -"UniProt:P39086","GRIK1" -"UniProt:Q9HCJ5","ZSWIM6" -"UniProt:Q9QYW3","PHOCN" -"UniProt:Q9P2D7","DNAH1" -"UniProt:Q52LC2","ATP6AP1L" -"UniProt:Q9EQC9","Cxxc4" -"UniProt:P47094","YJZ3" -"UniProt:Q9NWL6","ASNSD1" -"UniProt:P54725","RAD23A" -"UniProt:Q8IVT5","KSR1" -"UniProt:O76100","OR7A10" -"UniProt:Q8NEX9","SDR9C7" -"UniProt:Q8TEQ6","GEMIN5" -"UniProt:P43360","MAGA6" -"UniProt:Q9UK05","GDF2" -"UniProt:Q15678","PTPN14" -"UniProt:Q76MJ5","ERN2" -"UniProt:Q9HCI7","MSL2" -"UniProt:Q96E35","ZMY19" -"UniProt:P0C2Y1","NBPF7" -"UniProt:P06850","CRH" -"UniProt:Q9GZK6","OR2J1" -"UniProt:O08816","WASL" -"UniProt:Q96QZ7","MAGI1" -"UniProt:Q9NR61","DLL4" -"UniProt:P01112","HRAS" -"UniProt:P83111","LACTB" -"UniProt:Q9H344","OR51I2" -"UniProt:Q8IYL9","GPR65" -"UniProt:O60896","RAMP3" -"UniProt:O60500","NPHS1" -"UniProt:O75718","CRTAP" -"UniProt:Q7Z6J9","TSEN54" -"UniProt:P49411","TUFM" -"UniProt:Q13021","MALL" -"UniProt:Q9P2L0","WDR35" -"UniProt:P19447","ERCC3" -"UniProt:Q14679","TTLL4" -"UniProt:Q499Y1","Q499Y1" -"UniProt:A8MYA2","CXorf49" -"UniProt:Q5J5C9","DEFB121" -"UniProt:Q8NEK5","ZNF548" -"UniProt:O43559","FRS3" -"UniProt:Q2MKA7","RSPO1" -"UniProt:P57082","TBX4" -"UniProt:Q9BWE0","REPIN1" -"UniProt:Q8TBY0","RBM46" -"UniProt:Q9UP83","COG5" -"UniProt:P04624","env" -"UniProt:Q8NGN0","OR4D5" -"UniProt:P32314","FOXN2" -"UniProt:Q03692","COL10A1" -"UniProt:Q7RTR8","TAS2R42" -"UniProt:P03428","PB2" -"UniProt:O15269","SPTLC1" -"UniProt:Q5DID0","UMODL1" -"UniProt:O60404","OR10H3" -"UniProt:Q93074","MED12" -"UniProt:P28482","MAPK1" -"UniProt:Q14324","MYBPC2" -"UniProt:Q86XD5","FAM131B" -"UniProt:A0A1B0GWI1","A0A1B0GWI1" -"UniProt:P39019","RPS19" -"UniProt:Q5TZF3","ANR45" -"UniProt:Q8NB12","SMYD1" -"UniProt:P41440","SLC19A1" -"UniProt:P46087","NOP2" -"UniProt:Q9HC44","GPBP1L1" -"UniProt:P48552","NRIP1" -"UniProt:Q96JJ3","ELMO2" -"UniProt:Q96K62","ZBTB45" -"UniProt:Q02818","NUCB1" -"UniProt:P02730","SLC4A1" -"UniProt:Q9P2X7","DEC1" -"UniProt:Q8IX29","FBXO16" -"UniProt:P86480","PR20D" -"UniProt:Q8N8R3","SLC25A29" -"UniProt:Q13111","CAF1A" -"UniProt:G3V180","G3V180" -"UniProt:Q15011","HERPUD1" -"UniProt:Q92753","RORB" -"UniProt:Q86YJ5","MARCH9" -"UniProt:A6NNA2","SRRM3" -"UniProt:P11308","ERG" -"UniProt:Q9H867","VCPKMT" -"UniProt:P63162","SNRPN" -"UniProt:O43314","PPIP5K2" -"UniProt:Q17RA0","Q17RA0" -"UniProt:O95231","VENTX" -"UniProt:O75486","SUPT3" -"UniProt:Q9H7R5","ZNF665" -"UniProt:Q9BXA7","TSSK1" -"UniProt:P51991","ROA3" -"UniProt:O14967","CLGN" -"UniProt:O43711","TLX3" -"UniProt:Q9BXJ3","C1QT4" -"UniProt:P33240","CSTF2" -"UniProt:Q5I0X7","TTC32" -"UniProt:Q9P0M6","H2AFY2" -"UniProt:Q14642","INPP5A" -"UniProt:Q96HS1","PGAM5" -"UniProt:Q96KG9","SCYL1" -"UniProt:P30414","NKTR" -"UniProt:P07358","C8B" -"UniProt:Q8TAF3","WDR48" -"UniProt:Q14703","MBTPS1" -"UniProt:Q8NH07","OR11H2" -"UniProt:Q8NGI6","OR4D10" -"UniProt:P42773","CDN2C" -"UniProt:Q9H422","HIPK3" -"UniProt:P19971","TYMP" -"UniProt:Q12499","NOP58" -"UniProt:A0A0C4DFT7","A0A0C4DFT7" -"UniProt:Q2TAZ0","ATG2A" -"UniProt:Q96A09","FA46B" -"UniProt:Q9NQX4","MYO5C" -"UniProt:P63044","Vamp2" -"UniProt:Q9UGC7","MTRF1L" -"UniProt:Q9H0A0","NAT10" -"UniProt:Q9UHC7","MKRN1" -"UniProt:Q9Y2L5","TRAPPC8" -"UniProt:P07357","C8A" -"UniProt:Q3MIT2","PUS10" -"UniProt:Q9H040","SPRTN" -"UniProt:Q9Y508","RNF114" -"UniProt:A2RRC6","A2RRC6" -"UniProt:Q9Y2Y8","PRG3" -"UniProt:P08779","KRT16" -"UniProt:P35443","THBS4" -"UniProt:P14859","POU2F1" -"UniProt:Q9NXR5","ANKRD10" -"UniProt:Q96E03","Q96E03" -"UniProt:A6NDS4","TBC3B" -"UniProt:O60684","IMA7" -"UniProt:P43626","KIR2DL1" -"UniProt:Q13094","LCP2" -"UniProt:O88846","RNF4" -"UniProt:Q8TAG5","VSTM2A" -"UniProt:P05627","JUN" -"UniProt:P61764","STXBP1" -"UniProt:Q15014","MO4L2" -"UniProt:Q925T6","GRIP1" -"UniProt:Q2NKJ3","CTC1" -"UniProt:I3L0H3","I3L0H3" -"UniProt:O15371","EIF3D" -"UniProt:P0C1S8","WEE2" -"UniProt:P79522","PRR3" -"UniProt:Q13217","DNAJC3" -"UniProt:Q53EL6","PDCD4" -"UniProt:B4DJ51","B4DJ51" -"UniProt:P30291","WEE1" -"UniProt:Q96AC1","FERMT2" -"UniProt:Q8WW59","SPRY4" -"UniProt:Q14943","KIR3DS1" -"UniProt:Q6ZNL6","FGD5" -"UniProt:O00159","MYO1C" -"UniProt:Q14344","GNA13" -"UniProt:Q15746","MYLK" -"UniProt:Q9UK53","ING1" -"UniProt:Q86TB3","ALPK2" -"UniProt:Q8N743","KIR3DL3" -"UniProt:Q6NUM6","TYW1B" -"UniProt:P0DOE7","MATRX" -"UniProt:Q9H4I8","SERHL2" -"UniProt:Q13023","AKAP6" -"UniProt:O14787","TNPO2" -"UniProt:P36799","VE6" -"UniProt:Q06831","SOX4" -"UniProt:P30505","HLA-C" -"UniProt:O95352","ATG7" -"UniProt:O00303","EIF3F" -"UniProt:Q9NXL9","MCM9" -"UniProt:Q6ZN16","MAP3K15" -"UniProt:Q969M1","TOMM40L" -"UniProt:P19961","AMY2B" -"UniProt:Q9NQL9","DMRT3" -"UniProt:P57723","PCBP4" -"UniProt:P12268","IMDH2" -"UniProt:Q9NWJ2","Q9NWJ2" -"UniProt:Q13319","CDK5R2" -"UniProt:P43351","RAD52" -"UniProt:V9HWJ5","V9HWJ5" -"UniProt:Q8NEG2","C7orf57" -"UniProt:Q96SE7","ZNF347" -"UniProt:Q5W5X9","TTC23" -"UniProt:Q9H1M0","N62CL" -"UniProt:P16083","NQO2" -"UniProt:Q86V21","AACS" -"UniProt:Q99417","MYCBP" -"UniProt:Q8NDB6","FA156" -"UniProt:Q8N697","SLC15A4" -"UniProt:P40261","NNMT" -"UniProt:Q8NBM8","PCYOX1L" -"UniProt:P55211","CASP9" -"UniProt:Q9UIJ7","AK3" -"UniProt:P0C7U1","ASAH2B" -"UniProt:O43868","SLC28A2" -"UniProt:Q12951","FOXI1" -"UniProt:Q8IUB5","WFD13" -"UniProt:O94832","MYO1D" -"UniProt:P08174","CD55" -"UniProt:Q01449","MLRA" -"UniProt:Q63537","SYN2" -"UniProt:P54652","HSPA2" -"UniProt:P56177","DLX1" -"UniProt:O75449","KATNA1" -"UniProt:O60941","DTNB" -"UniProt:Q6UY09","CEACAM20" -"UniProt:Q92570","NR4A3" -"UniProt:P29476","NOS1" -"UniProt:P50607","TUB" -"UniProt:O14595","CTDSP2" -"UniProt:Q86VF2","IGFN1" -"UniProt:Q9NWD8","TMEM248" -"UniProt:P01024","C3" -"UniProt:P09871","C1S" -"UniProt:Q2TAL8","QRIC1" -"UniProt:Q9BTT6","LRRC1" -"UniProt:O15042","SR140" -"UniProt:Q12756","KIF1A" -"UniProt:P48594","SERPINB4" -"UniProt:P46940","IQGAP1" -"UniProt:P49765","VEGFB" -"UniProt:Q9HDD0","HRSL1" -"UniProt:Q04609","FOLH1" -"UniProt:Q03526","Itk" -"UniProt:Q00444","HXC5" -"UniProt:P54922","ADPRH" -"UniProt:Q9H4E5","RHOJ" -"UniProt:Q9HCS5","EPB41L4A" -"UniProt:P49238","CX3CR1" -"UniProt:Q9NZ56","FMN2" -"UniProt:Q9HCH5","SYTL2" -"UniProt:Q9Y5Z4","HEBP2" -"UniProt:Q14CX5","MF13A" -"UniProt:P40991","NOP2" -"UniProt:P24863","CCNC" -"UniProt:Q16560","SNRNP35" -"UniProt:P0C7Q2","ARMS2" -"UniProt:Q9HAU0","PKHA5" -"UniProt:Q9HAW7","UGT1A7" -"UniProt:P48736","PIK3CG" -"UniProt:Q9UKI2","CDC42EP3" -"UniProt:P54727","RD23B" -"UniProt:Q4VW77","Q4VW77" -"UniProt:Q92993","KAT5" -"UniProt:Q49AR2","C5orf22" -"UniProt:Q6DRC5","USPL1" -"UniProt:O94941","UBOX5" -"UniProt:O00311","CDC7" -"UniProt:Q96QV1","HHIP" -"UniProt:P98077","SHC2" -"UniProt:Q9HBB8","CDHR5" -"UniProt:P50549","ETV1" -"UniProt:Q86X59","CQ082" -"UniProt:Q8NAP3","ZBTB38" -"UniProt:Q9P2W9","STX18" -"UniProt:Q96I25","RBM17" -"UniProt:Q9NP92","MRPS30" -"UniProt:Q5HYK9","ZNF667" -"UniProt:P62877","RBX1" -"UniProt:O00187","MASP2" -"UniProt:Q96A33","CCD47" -"UniProt:Q7RTP6","MICAL3" -"UniProt:Q8NG85","OR2L3" -"UniProt:Q5JTY5","CBWD5" -"UniProt:Q9P0W5","IQCJ-SCHIP1" -"UniProt:P09913","IFIT2" -"UniProt:A0A087WVE9","A0A087WVE9" -"UniProt:Q9CPR8","NSE3" -"UniProt:Q8IVU3","HERC6" -"UniProt:P26951","IL3RA" -"UniProt:Q8N508","Q8N508" -"UniProt:P60228","EIF3E" -"UniProt:Q9HBR3","Q9HBR3" -"UniProt:Q9Y646","CPQ" -"UniProt:Q9Y3B6","EMC9" -"UniProt:O94923","GLCE" -"UniProt:Q8N264","RHG24" -"UniProt:Q9BQ15","SOSB1" -"UniProt:P49863","GZMK" -"UniProt:O75330","HMMR" -"UniProt:O94822","LTN1" -"UniProt:Q13410","BTN1A1" -"UniProt:Q9BPZ3","PAIP2" -"UniProt:Q9UHN6","TMEM2" -"UniProt:Q62627","PAWR" -"UniProt:Q6PG48","Q6PG48" -"UniProt:Q3MJ62","ZSC23" -"UniProt:O60524","NEMF" -"UniProt:Q9Y3C4","TPRKB" -"UniProt:O70343","PRGC1" -"UniProt:P09914","IFIT1" -"UniProt:Q96A00","PPP1R14A" -"UniProt:P50747","HLCS" -"UniProt:P49895","DIO1" -"UniProt:Q9Y305","ACOT9" -"UniProt:Q6NUN0","ACSM5" -"UniProt:Q9Y242","TCF19" -"UniProt:Q8N4B4","FBXO39" -"UniProt:P61980","HNRPK" -"UniProt:Q01101","INSM1" -"UniProt:O95926","SYF2" -"UniProt:O75871","CEACAM4" -"UniProt:Q9BY66","KDM5D" -"UniProt:Q92813","DIO2" -"UniProt:O75334","PPFIA2" -"UniProt:Q96BE0","Q96BE0" -"UniProt:Q8IZU8","DSEL" -"UniProt:Q8TF05","PPP4R1" -"UniProt:O76552","O76552" -"UniProt:P11500","HSP90" -"UniProt:Q9HBR0","SLC38A10" -"UniProt:Q9H2S9","IKZF4" -"UniProt:Q7Z5J8","ANKAR" -"UniProt:P60896","SEM1" -"UniProt:Q96QK8","SIM14" -"UniProt:Q8WTU0","DDI1" -"UniProt:Q96MP5","ZSWM3" -"UniProt:Q86XR7","TCAM2" -"UniProt:Q9UKL6","PCTP" -"UniProt:Q8NCU8","LINC00116" -"UniProt:Q8WWQ8","STAB2" -"UniProt:Q15389","ANGPT1" -"UniProt:Q8UYL3","Q8UYL3" -"UniProt:Q9BZA7","PCDH11X" -"UniProt:Q9Y561","LRP12" -"UniProt:Q14164","IKKE" -"UniProt:P40925","MDH1" -"UniProt:Q96JQ5","M4A4A" -"UniProt:Q9NPH5","NOX4" -"UniProt:Q96LA8","PRMT6" -"UniProt:O96028","NSD2" -"UniProt:Q96NB3","ZNF830" -"UniProt:P43308","SSR2" -"UniProt:Q9H4I9","SMDT1" -"UniProt:Q9Y6Y9","LY96" -"UniProt:O43300","LRRTM2" -"UniProt:P33279","E2AK1" -"UniProt:Q8TA94","ZNF563" -"UniProt:P15303","SEC23" -"UniProt:O60811","PRAMEF2" -"UniProt:Q8IXQ6","PARP9" -"UniProt:Q9H313","TTYH1" -"UniProt:Q16649","NFIL3" -"UniProt:Q96H22","CENPN" -"UniProt:Q8IZ16","C7orf61" -"UniProt:Q9Y2U8","LEMD3" -"UniProt:Q9NXL6","SIDT1" -"UniProt:Q61553","FSCN1" -"UniProt:Q6EBC2","IL31" -"UniProt:Q9BXU0","TEX12" -"UniProt:Q9Y2P8","RCL1" -"UniProt:P53667","LIMK1" -"UniProt:D6W5L6","D6W5L6" -"UniProt:Q9H0R8","GBRL1" -"UniProt:Q9H3H1","TRIT1" -"UniProt:Q5FBB7","SGO1" -"UniProt:P15314","IRF1" -"UniProt:Q96RR4","CAMKK2" -"UniProt:Q8IVJ1","SLC41A1" -"UniProt:Q01097","Grin2b" -"UniProt:Q99680","GPR22" -"UniProt:Q9UHL0","DDX25" -"UniProt:P51508","ZNF81" -"UniProt:B2Y833","B2Y833" -"UniProt:P17481","HOXB8" -"UniProt:Q3MI94","Q3MI94" -"UniProt:Q8N129","CNPY4" -"UniProt:P52797","EFNA3" -"UniProt:P56693","SOX10" -"UniProt:Q61171","Prdx2" -"UniProt:Q86TN4","TRPT1" -"UniProt:O75037","KIF21B" -"UniProt:A0A0G2JIA5","A0A0G2JIA5" -"UniProt:A0A0A0MR97","A0A0A0MR97" -"UniProt:Q9HCJ2","LRRC4C" -"UniProt:A8MZA0","A8MZA0" -"UniProt:P63328","Ppp3ca" -"UniProt:Q7Z6N9","Q7Z6N9" -"UniProt:O00461","GOLIM4" -"UniProt:Q9C0K1","SLC39A8" -"UniProt:Q9H9P8","L2HGDH" -"UniProt:Q96PH1","NOX5" -"UniProt:Q16533","SNAPC1" -"UniProt:Q9NWM0","SMOX" -"UniProt:Q4LE39","ARID4B" -"UniProt:Q5TAT6","COL13A1" -"UniProt:Q9BTA9","WAC" -"UniProt:Q9BUY7","EFCAB11" -"UniProt:Q9BTE1","DCTN5" -"UniProt:P06729","CD2" -"UniProt:Q96DT6","ATG4C" -"UniProt:Q08AH1","ACSM1" -"UniProt:Q6ZUV0","ACOT7L" -"UniProt:Q9H2X9","SLC12A5" -"UniProt:P01611","IGKV1D-12" -"UniProt:Q9UI95","MAD2L2" -"UniProt:P84077","ARF1" -"UniProt:Q8NEB7","ACRBP" -"UniProt:P98088","MUC5AC" -"UniProt:Q810U4","Nrcam" -"UniProt:O94991","SLITRK5" -"UniProt:O43763","TLX2" -"UniProt:P35790","CHKA" -"UniProt:Q5DU25","IQEC2" -"UniProt:P15917","lef" -"UniProt:Q13972","RASGRF1" -"UniProt:Q9H9R9","DBNDD1" -"UniProt:Q01844","EWSR1" -"UniProt:P08217","CELA2A" -"UniProt:P43234","CTSO" -"UniProt:P78508","KCNJ10" -"UniProt:P67812","SEC11A" -"UniProt:Q8N7X1","RBMXL3" -"UniProt:O15105","SMAD7" -"UniProt:O08808","DIAP1" -"UniProt:P14778","IL1R1" -"UniProt:Q8C1B7","SEP11" -"UniProt:Q13530","SERINC3" -"UniProt:P62987","UBA52" -"UniProt:O60391","Glutamate receptor ionotropic, NMDA 3B" -"UniProt:Q9BZM4","ULBP3" -"UniProt:Q96SA4","SERINC2" -"UniProt:Q91V61","SFXN3" -"UniProt:Q9BZL4","PP12C" -"UniProt:Q8R0S2","IQEC1" -"UniProt:O15554","KCNN4" -"UniProt:Q0P5Q0","Q0P5Q0" -"UniProt:O95208","EPN2" -"UniProt:O15460","P4HA2" -"UniProt:O35449","PRRT1" -"UniProt:Q9HBJ8","TMEM27" -"UniProt:P97447","FHL1" -"UniProt:Q6PCB0","VWA1" -"UniProt:Q9BX40","LSM14B" -"UniProt:Q9NYG2","ZDHHC3" -"UniProt:P03956","MMP1" -"UniProt:Q9Y6X2","PIAS3" -"UniProt:Q5VZK9","CARMIL1" -"UniProt:Q7LBE3","SLC26A9" -"UniProt:P23280","CA6" -"UniProt:O43921","EFNA2" -"UniProt:Q13797","ITGA9" -"UniProt:Q8IW19","APLF" -"UniProt:Q03714","USA1" -"UniProt:Q70CQ2","USP34" -"UniProt:Q8TE04","PANK1" -"UniProt:Q9NZQ3","NCKIPSD" -"UniProt:Q15555","MAPRE2" -"UniProt:Q86UU1","PHLDB1" -"UniProt:B4DDJ5","B4DDJ5" -"UniProt:P41273","TNFSF9" -"UniProt:P35520","CBS;CBSL" -"UniProt:P14780","MMP9" -"UniProt:Q9Y6H1","CHCHD2" -"UniProt:Q8TDY4","ASAP3" -"UniProt:Q8TAP6","CEP76" -"UniProt:P23763","VAMP1" -"UniProt:Q14061","COX17" -"UniProt:Q8K4G5","ABLM1" -"UniProt:O43424","GRID2" -"UniProt:P68433","H31" -"UniProt:P61982","Ywhag" -"UniProt:P54257","HAP1" -"UniProt:Q9H6L4","ARMC7" -"UniProt:Q16527","CSRP2" -"UniProt:P07205","PGK2" -"UniProt:P62942","FKBP1A" -"UniProt:Q8TDV5","GPR119" -"UniProt:O95429","BAG4" -"UniProt:P14598","NCF1" -"UniProt:P48058","GRIA4" -"UniProt:Q9ULG6","CCPG1" -"UniProt:Q8N9A8","CNEP1R1" -"UniProt:Q9NZ63","CI078" -"UniProt:P60604","UBE2G2" -"UniProt:Q811D0","Dlg1" -"UniProt:Q86VX9","MON1A" -"UniProt:Q9CQV8","Ywhab" -"UniProt:Q9BZS1","FOXP3" -"UniProt:P60602","ROMO1" -"UniProt:P60202","MYPR" -"UniProt:P53794","SLC5A3" -"UniProt:Q9UEW3","MARCO" -"UniProt:Q70EL1","USP54" -"UniProt:P52189","KCNJ4" -"UniProt:Q96DX4","RSPRY1" -"UniProt:Q6PCE3","PGM2L1" -"UniProt:Q02643","GHRHR" -"UniProt:Q96AD5","PNPLA2" -"UniProt:Q04725","TLE2" -"UniProt:Q99807","COQ7" -"UniProt:P39104","PIK1" -"UniProt:Q9H492","MLP3A" -"UniProt:Q9NXJ0","MS4A12" -"UniProt:P10826","RARB" -"UniProt:Q9HD90","NDF4" -"UniProt:Q9NPI6","DCP1A" -"UniProt:O75348","VATG1" -"UniProt:Q9BU02","THTPA" -"UniProt:Q96NL0","RUNDC3B" -"UniProt:Q8WWV3","RTN4IP1" -"UniProt:Q92930","RAB8B" -"UniProt:P54296","MYOM2" -"UniProt:P43628","KIR2DL3" -"UniProt:P59990","KR121" -"UniProt:A2RU30","TESPA1" -"UniProt:Q8BGZ4","CDC23" -"UniProt:Q6B8I1","DUSP13" -"UniProt:Q9BXB5","OSBPL10" -"UniProt:P63220","RPS21" -"UniProt:Q9Y5B0","CTDP1" -"UniProt:Q9ERS5","PKHA2" -"UniProt:P10221","ITP" -"UniProt:Q8N205","SYNE4" -"UniProt:P62244","RPS15A" -"UniProt:Q6UUV9","CRTC1" -"UniProt:O43324","EEF1E1" -"UniProt:Q9Y2D1","ATF5" -"UniProt:Q6P656","CF161" -"UniProt:O00165","HAX1" -"UniProt:Q8TD46","CD200R1" -"UniProt:Q8ZQQ2","SLRP" -"UniProt:Q99675","CGRRF1" -"UniProt:Q9H4B6","SAV1" -"UniProt:Q6GQ04","Q6GQ04" -"UniProt:Q9LBS8","ntnha" -"UniProt:Q14004","CDK13" -"UniProt:Q15156","Q15156" -"UniProt:Q86XR5","PRIMA1" -"UniProt:P02774","GC" -"UniProt:Q0P5U8","Q0P5U8" -"UniProt:O75928","PIAS2" -"UniProt:P05114","HMGN1" -"UniProt:Q9NXX0","Q9NXX0" -"UniProt:P60706","ACTB" -"UniProt:Q45878","ha17" -"UniProt:Q96P26","NT5C1B" -"UniProt:Q8NCN4","RNF169" -"UniProt:Q8N6R0","METTL13" -"UniProt:P30996","botF" -"UniProt:Q8N5X7","EIF4E3" -"UniProt:Q4VAX2","Q4VAX2" -"UniProt:Q8K4B0","Mta1" -"UniProt:P51815","ZNF75D" -"UniProt:Q9HD45","TM9SF3" -"UniProt:Q6NXR4","TTI2" -"UniProt:P17706","PTPN2" -"UniProt:Q16531","DDB1" -"UniProt:P14555","PLA2G2A" -"UniProt:Q9H1R3","MYLK2" -"UniProt:Q9Y281","CFL2" -"UniProt:A0A087WT44","A0A087WT44" -"UniProt:Q9P121","NTM" -"UniProt:Q9H8S9","MOB1A" -"UniProt:Q9HDB5","NRXN3" -"UniProt:P49448","GLUD2" -"UniProt:Q9NSI2","FAM207A" -"UniProt:Q8TD55","PLEKHO2" -"UniProt:Q7Z7B0","FILIP1" -"UniProt:Q6ZTQ3","RASF6" -"UniProt:Q6NTE8","MRNIP" -"UniProt:P19235","EPOR" -"UniProt:P02749","APOH" -"UniProt:Q9C0H9","SRCIN1" -"UniProt:Q9H7T9","AUNIP" -"UniProt:Q9HCU9","BRMS1" -"UniProt:Q9UL01","DSE" -"UniProt:O14559","ARHGAP33" -"UniProt:Q96G25","MED8" -"UniProt:Q16594","TAF9" -"UniProt:Q9HC24","TMBIM4" -"UniProt:P42574","CASP3" -"UniProt:Q6N022","TENM4" -"UniProt:Q9NYP7","ELOVL5" -"UniProt:W5XKT8","SPACA6" -"UniProt:Q9Y279","VSIG4" -"UniProt:O60437","PPL" -"UniProt:O43148","MCES" -"UniProt:P27708","CAD" -"UniProt:Q96NM4","TOX2" -"UniProt:F6RF56","F6RF56" -"UniProt:Q6PJI9","WDR59" -"UniProt:A6NJI9","LRRC72" -"UniProt:Q147U7","SMCO1" -"UniProt:Q96LL9","DJC30" -"UniProt:A7E2U8","C4orf47" -"UniProt:Q8NEY8","PPHLN" -"UniProt:Q9H339","OR51B5" -"UniProt:P07197","NFM" -"UniProt:Q09327","MGAT3" -"UniProt:Q8NF91","SYNE1" -"UniProt:P21217","FUT3" -"UniProt:Q9UJW7","ZNF229" -"UniProt:A8MUV8","ZNF727" -"UniProt:Q9H1K4","SLC25A18" -"UniProt:Q96QS6","PSKH2" -"UniProt:O75061","DNAJC6" -"UniProt:Q6V0I7","FAT4" -"UniProt:P30493","HLA-B" -"UniProt:Q8TDU6","GPBAR1" -"UniProt:O75473","LGR5" -"UniProt:P52961","ART1" -"UniProt:Q9NVN8","GNL3L" -"UniProt:Q96RG2","PASK" -"UniProt:P26447","S10A4" -"UniProt:Q9H1A4","ANAPC1" -"UniProt:O14672","ADAM10" -"UniProt:P13584","CYP4B1" -"UniProt:O75023","LILRB5" -"UniProt:Q5TC79","ZBTB37" -"UniProt:Q8NAX2","KDF1" -"UniProt:Q9NYZ2","SLC25A37" -"UniProt:P11487","FGF3" -"UniProt:Q13042","CDC16" -"UniProt:Q3E731","COX19" -"UniProt:Q9P212","PLCE1" -"UniProt:Q91VJ4","STK38" -"UniProt:Q96JY6","PDLIM2" -"UniProt:Q9UHA4","LAMTOR3" -"UniProt:Q13520","AQP6" -"UniProt:Q8WYQ9","ZCH14" -"UniProt:Q86WH2","RASF3" -"UniProt:Q9Y283","INVS" -"UniProt:Q96DA0","ZG16B" -"UniProt:P62829","RL23" -"UniProt:P19876","CXCL3" -"UniProt:O75691","UTP20" -"UniProt:A0A0G2JN84","A0A0G2JN84" -"UniProt:P04083","ANXA1" -"UniProt:A0A075B6K6","IGLV4-3" -"UniProt:P30501","HLA-C" -"UniProt:Q96RI8","TAAR6" -"UniProt:Q4V9L6","TMEM119" -"UniProt:Q8NFJ9","BBS1" -"UniProt:Q5T7B8","KIF24" -"UniProt:P23490","LOR" -"UniProt:Q9UQ52","CNTN6" -"UniProt:Q66K74","MAP1S" -"UniProt:P0A6F5","CH60" -"UniProt:Q8R3L8","Cdk8" -"UniProt:A0A024R6G0","A0A024R6G0" -"UniProt:Q9UJ37","ST6GALNAC2" -"UniProt:P67828","KC1A" -"UniProt:Q9UHI8","ADAMTS1" -"UniProt:Q96IZ0","PAWR" -"UniProt:O15446","CD3EAP" -"UniProt:P15253","CALR" -"UniProt:P51513","NOVA1" -"UniProt:Q96K76","USP47" -"UniProt:P40217","EIF3I" -"UniProt:Q99715","COL12A1" -"UniProt:Q5H913","ARL13A" -"UniProt:P35504","UGT1A5" -"UniProt:P60953","CDC42" -"UniProt:Q9Y6J9","TAF6L" -"UniProt:P22003","BMP5" -"UniProt:Q13619","CUL4A" -"UniProt:Q9BW61","DDA1" -"UniProt:Q96R28","OR2M2" -"UniProt:Q13952","NFYC" -"UniProt:Q13564","NAE1" -"UniProt:Q8NG66","NEK11" -"UniProt:Q14BN4","SLMAP" -"UniProt:Q8WVE7","TMEM170A" -"UniProt:Q7Z6J6","FRMD5" -"UniProt:P35475","IDUA" -"UniProt:P12757","SKIL" -"UniProt:P16499","PDE6A" -"UniProt:O14627","CDX4" -"UniProt:Q9Y2T7","YBX2" -"UniProt:Q9NUN7","ACER3" -"UniProt:Q9UL19","RARRES3" -"UniProt:Q02108","GUCY1A3" -"UniProt:O00273","DFFA" -"UniProt:P42227","Stat3" -"UniProt:P13928","ANXA8" -"UniProt:O15234","CASC3" -"UniProt:P62750","RL23A" -"UniProt:Q6ZWQ9","Q6ZWQ9" -"UniProt:Q96MT7","CFAP44" -"UniProt:Q96ST3","SIN3A" -"UniProt:Q9UPN9","TRIM33" -"UniProt:Q8WWW0","RASF5" -"UniProt:Q49A17","GALNTL6" -"UniProt:O75822","EIF3J" -"UniProt:P42680","TEC" -"UniProt:Q5BKY9","FAM133B" -"UniProt:P0CAP1","GCOM1" -"UniProt:Q96BR9","ZBT8A" -"UniProt:Q9UJ55","MAGEL2" -"UniProt:Q5T7W0","ZN618" -"UniProt:O95238","SPDEF" -"UniProt:Q5VTQ0","TTC39B" -"UniProt:Q9UET6","FTSJ1" -"UniProt:O00267","SPT5H" -"UniProt:Q9UFE4","CCDC39" -"UniProt:P84022","SMAD3" -"UniProt:Q92576","PHF3" -"UniProt:Q96LT4","SAMD8" -"UniProt:Q9UL15","BAG5" -"UniProt:Q8N162","OR8H2" -"UniProt:Q96BJ8","ELMO3" -"UniProt:O43542","XRCC3" -"UniProt:P59536","TAS2R41" -"UniProt:Q99741","CDC6" -"UniProt:P78415","IRX3" -"UniProt:Q13416","ORC2" -"UniProt:Q8NDM7","CFAP43" -"UniProt:Q6XPS3","TPTE2" -"UniProt:Q8WYP5","AHCTF1" -"UniProt:Q6NW29","RWDD4" -"UniProt:Q86SQ7","SDCCAG8" -"UniProt:P50876","RNF144A" -"UniProt:P46680","AIP1" -"UniProt:Q5VUE5","C1orf53" -"UniProt:Q2MJR0","SPRED3" -"UniProt:Q9Y5N6","ORC6" -"UniProt:P52744","ZNF138" -"UniProt:Q9NYR9","NKIRAS2" -"UniProt:Q86XE5","HOGA1" -"UniProt:Q9BWQ6","YIPF2" -"UniProt:P08651","NFIC" -"UniProt:O95870","ABHGA" -"UniProt:Q9UI33","SCN11A" -"UniProt:P84092","AP2M1" -"UniProt:Q6IBD0","Q6IBD0" -"UniProt:Q5T1M5","FKB15" -"UniProt:Q9BQC6","MRPL57" -"UniProt:O43929","ORC4" -"UniProt:Q9BYZ2","LDHAL6B" -"UniProt:P38570","ITGAE" -"UniProt:Q12999","TSPAN31" -"UniProt:P63103","1433Z" -"UniProt:Q6P5S7","RNASEK" -"UniProt:Q9Y5W3","KLF2" -"UniProt:Q14590","ZNF235" -"UniProt:Q49A88","CCDC14" -"UniProt:O95863","SNAI1" -"UniProt:Q9UQE7","SMC3" -"UniProt:Q9HD40","SEPSECS" -"UniProt:Q15154","PCM1" -"UniProt:O75161","NPHP4" -"UniProt:Q8NCR9","CLRN3" -"UniProt:Q13309","SKP2" -"UniProt:P61313","RPL15" -"UniProt:Q9H237","PORCN" -"UniProt:P13236","CCL4" -"UniProt:Q15796","SMAD2" -"UniProt:O14966","RAB7L" -"UniProt:P16519","PCSK2" -"UniProt:Q16518","RPE65" -"UniProt:Q8N8E2","ZNF513" -"UniProt:Q15797","SMAD1" -"UniProt:P30872","SSTR1" -"UniProt:Q6NXS1","IPP2M" -"UniProt:Q9H2S1","KCNN2" -"UniProt:Q69140","EBNA6" -"UniProt:P42224","STAT1" -"UniProt:Q75N03","CBLL1" -"UniProt:Q9H9A6","LRC40" -"UniProt:Q9Y2I7","PIKFYVE" -"UniProt:Q9Y5A7","NUB1" -"UniProt:H3BV60","TGFBR3L" -"UniProt:Q6VMQ6","ATF7IP" -"UniProt:O14493","CLDN4" -"UniProt:Q9NRY6","PLS3" -"UniProt:P53305","RT27" -"UniProt:Q8TF20","ZNF721" -"UniProt:Q96N11","C7orf26" -"UniProt:Q16653","MOG" -"UniProt:Q9UM54","MYO6" -"UniProt:Q32NB8","PGS1" -"UniProt:P13521","SCG2" -"UniProt:O60755","GALR3" -"UniProt:P0DN86","CGB5" -"UniProt:O75578","ITGA10" -"UniProt:Q9UI36","DACH1" -"UniProt:P16070","CD44" -"UniProt:Q8NHC4","OR10J5" -"UniProt:P52788","SMS" -"UniProt:P39053","DYN1" -"UniProt:P25118","TNR1A" -"UniProt:Q01201","RELB" -"UniProt:Q9Y5Y9","SCN10A" -"UniProt:Q5PP90","Q5PP90" -"UniProt:Q7RTW8","OTOA" -"UniProt:P31872","env" -"UniProt:Q9Y625","GPC6" -"UniProt:Q9BRQ8","AIFM2" -"UniProt:Q8N2E6","TOR2A" -"UniProt:Q9Y6N1","COX11" -"UniProt:Q9NQZ2","UTP3" -"UniProt:P35913","PDE6B" -"UniProt:Q9H1Y0","ATG5" -"UniProt:Q6P4F1","FUT10" -"UniProt:Q9C026","TRIM9" -"UniProt:P56524","HDAC4" -"UniProt:O95445","APOM" -"UniProt:P21815","IBSP" -"UniProt:Q9UBR5","CKLF" -"UniProt:Q9P286","PAK5" -"UniProt:Q14191","WRN" -"UniProt:Q9NX01","TXN4B" -"UniProt:Q96E52","OMA1" -"UniProt:P43268","ETV4" -"UniProt:Q8TCU5","Glutamate receptor ionotropic, NMDA 3A" -"UniProt:P52564","MP2K6" -"UniProt:Q96Q42","ALS2" -"UniProt:Q7Z3C6","ATG9A" -"UniProt:O60337","MARCH6" -"UniProt:Q6FG55","Q6FG55" -"UniProt:Q9UBD5","ORC3" -"UniProt:Q9NQW7","XPNPEP1" -"UniProt:O43913","ORC5" -"UniProt:P59861","DEFB131" -"UniProt:Q8N2H4","SYS1" -"UniProt:P46460","NSF" -"UniProt:A6NDD5","SYNDIG1L" -"UniProt:P02458","COL2A1" -"UniProt:Q6UX04","CWC27" -"UniProt:Q16553","LY6E" -"UniProt:A8K3Q9","A8K3Q9" -"UniProt:Q9H211","CDT1" -"UniProt:Q5T6L9","ERMARD" -"UniProt:O94972","TRIM37" -"UniProt:Q9CSN1","SNW1" -"UniProt:Q9HBE1","PATZ1" -"UniProt:Q6PID8","KLHDC10" -"UniProt:P49951","CLH1" -"UniProt:P08236","GUSB" -"UniProt:P02462","COL4A1" -"UniProt:Q99376","TFR1" -"UniProt:P46527","CDKN1B" -"UniProt:O75420","PERQ1" -"UniProt:O60447","EVI5" -"UniProt:Q02548","PAX5" -"UniProt:P36969","GPX4" -"UniProt:Q9NXC5","MIO" -"UniProt:P98177","FOXO4" -"UniProt:Q05996","ZP2" -"UniProt:Q9BY41","HDAC8" -"UniProt:Q9BVK8","TMEM147" -"UniProt:Q96LR2","LURA1" -"UniProt:P12236","ADT3" -"UniProt:Q16873","LTC4S" -"UniProt:P70056","FOXH1" -"UniProt:Q96PV7","FAM193B" -"UniProt:Q9Y210","TRPC6" -"UniProt:Q9UK13","ZNF221" -"UniProt:Q9Y442","C22orf24" -"UniProt:P48681","NES" -"UniProt:A4QMS7","CE049" -"UniProt:Q92934","BAD" -"UniProt:Q6FI81","CPIN1" -"UniProt:O43353","RIPK2" -"UniProt:Q6NSI1","AR26L" -"UniProt:Q15735","INPP5J" -"UniProt:Q96BA8","CREB3L1" -"UniProt:Q96F25","ALG14" -"UniProt:P36957","DLST" -"UniProt:P56546","CTBP2" -"UniProt:Q9H0N0","RAB6C" -"UniProt:Q93009","USP7" -"UniProt:Q96LT6","CA074" -"UniProt:Q9UBR2","CTSZ" -"UniProt:Q8TEA8","DTD1" -"UniProt:Q9NXR8","ING3" -"UniProt:Q8N4A0","GALNT4" -"UniProt:P35961","env" -"UniProt:Q13554","CAMK2B" -"UniProt:P00492","HPRT1" -"UniProt:Q6PH81","CP087" -"UniProt:Q5XPI4","RNF123" -"UniProt:Q01658","DR1" -"UniProt:Q9NY84","VNN3" -"UniProt:P30680","SSR2" -"UniProt:O95273","CCDB1" -"UniProt:Q9H756","LRRC19" -"UniProt:O15379","HDAC3" -"UniProt:P18564","ITGB6" -"UniProt:Q8NCL4","GALNT6" -"UniProt:Q5VVM6","CCDC30" -"UniProt:P63151","PPP2R2A" -"UniProt:O60412","OR7C2" -"UniProt:Q8NGT1","OR2K2" -"UniProt:Q9JK83","PAR6B" -"UniProt:Q9H6T0","ESRP2" -"UniProt:Q8NI35","PATJ" -"UniProt:O94915","FRYL" -"UniProt:O43292","GPAA1" -"UniProt:Q9BQ16","SPOCK3" -"UniProt:O95460","MATN4" -"UniProt:Q13011","ECH1" -"UniProt:Q15120","PDK3" -"UniProt:Q96NA8","TSNARE1" -"UniProt:Q14765","STAT4" -"UniProt:Q8IYB3","SRRM1" -"UniProt:P84095","RHOG" -"UniProt:Q8NGJ7","OR51A2" -"UniProt:O15173","PGRC2" -"UniProt:Q32P51","RA1L2" -"UniProt:P13929","ENO3" -"UniProt:Q8N9I9","DTX3" -"UniProt:O35158","CDON" -"UniProt:Q8NH01","OR2T11" -"UniProt:Q8TDS5","OXER1" -"UniProt:Q5TIE3","VWA5B1" -"UniProt:Q9P2F9","ZN319" -"UniProt:Q8NGX0","OR11L1" -"UniProt:Q01650","SLC7A5" -"UniProt:O15195","VILL" -"UniProt:Q8IV54","Q8IV54" -"UniProt:Q8NH69","OR5W2" -"UniProt:A0A024R2X5","A0A024R2X5" -"UniProt:Q02543","RL18A" -"UniProt:Q15059","BRD3" -"UniProt:Q9H336","CRISPLD1" -"UniProt:A0A0C4DFQ7","A0A0C4DFQ7" -"UniProt:Q99469","STAC" -"UniProt:P57768","SNX16" -"UniProt:Q86VK4","Q86VK43" -"UniProt:P78381","SLC35A2" -"UniProt:Q17RB8","LONF1" -"UniProt:P61513","RL37A" -"UniProt:Q96BW5","PTER" -"UniProt:Q16674","MIA" -"UniProt:Q14444","CAPR1" -"UniProt:Q14CZ7","FAKD3" -"UniProt:A6NNX1","RIIAD1" -"UniProt:Q8NGC1","OR11G2" -"UniProt:Q9Y5P3","RAI2" -"UniProt:Q9H3P2","NELFA" -"UniProt:Q5QGS0","NEXMIF" -"UniProt:Q6P9H4","CNKSR3" -"UniProt:Q9H0E2","TOLLIP" -"UniProt:Q8NGM9","OR8D4" -"UniProt:Q5XG99","LYSMD4" -"UniProt:Q8NHM5","KDM2B" -"UniProt:Q92786","PROX1" -"UniProt:Q8NEZ2","VPS37A" -"UniProt:Q9Y2B5","VP9D1" -"UniProt:A6NF89","OR6C6" -"UniProt:O15197","EPHB6" -"UniProt:Q03112","MECOM" -"UniProt:Q15651","HMGN3" -"UniProt:Q8NGC4","OR10G3" -"UniProt:Q5NV81","IGLV1-44" -"UniProt:P14753","Epor" -"UniProt:P53218","POP6" -"UniProt:P62495","ETF1" -"UniProt:Q9UJX2","CDC23" -"UniProt:Q6UW78","UQCC3" -"UniProt:Q15615","OR4D1" -"UniProt:Q9Y512","SAM50" -"UniProt:Q9P2R7","SUCLA2" -"UniProt:Q04875","opaG" -"UniProt:O43592","XPOT" -"UniProt:Q8NGE1","OR6C4" -"UniProt:P40312","CYB5" -"UniProt:Q5GAN4","RNASE12" -"UniProt:Q6UWF3","SCIMP" -"UniProt:O00534","VMA5A" -"UniProt:P59672","ANS1A" -"UniProt:P51689","ARSD" -"UniProt:O95415","BRI3" -"UniProt:Q8NH73","OR4S2" -"UniProt:P0C7M4","RHOXF2B" -"UniProt:P68032","ACTC1" -"UniProt:Q6PK18","OGFOD3" -"UniProt:O60229","KALRN" -"UniProt:Q9BVT8","TMUB1" -"UniProt:P20676","NUP1" -"UniProt:P15121","AKR1B1" -"UniProt:Q02985","CFHR3" -"UniProt:Q96H72","SLC39A13" -"UniProt:P22792","CPN2" -"UniProt:O14920","IKBKB" -"UniProt:Q14449","GRB14" -"UniProt:O43819","SCO2" -"UniProt:P61923","COPZ1" -"UniProt:Q08554","DSC1" -"UniProt:Q9NP08","HMX1" -"UniProt:Q9H4Z2","ZNF335" -"UniProt:P63142","KCNA2" -"UniProt:Q99983","OMD" -"UniProt:Q6PF15","KLH35" -"UniProt:Q6MZN7","HCP5" -"UniProt:P51571","SSR4" -"UniProt:Q9QXM1","JMY" -"UniProt:Q8TBC3","SHKB1" -"UniProt:Q9H6Y7","RNF167" -"UniProt:C9JRZ8","AKR1B15" -"UniProt:Q53RC5","Q53RC5" -"UniProt:Q95HA4","Q95HA4" -"UniProt:Q04826","HLA-B" -"UniProt:Q8N4G4","Q8N4G4" -"UniProt:Q14582","MAD4" -"UniProt:Q8NHV1","GIMAP7" -"UniProt:Q8N1D5","C1orf158" -"UniProt:Q9UJ14","GGT7" -"UniProt:P35052","GPC1" -"UniProt:Q14247","SRC8" -"UniProt:P41970","ELK3" -"UniProt:P19532","TFE3" -"UniProt:Q12849","GRSF1" -"UniProt:Q12879","GRIN2A" -"UniProt:Q9H9E1","ANRA2" -"UniProt:Q8N427","NME8" -"UniProt:P19484","TFEB" -"UniProt:O95455","TGDS" -"UniProt:Q9BS26","ERP44" -"UniProt:Q9BR61","ACBD6" -"UniProt:Q9H008","LHPP" -"UniProt:Q9JIL4","NHRF3" -"UniProt:P10635","CYP2D6" -"UniProt:Q86TF7","Q86TF7" -"UniProt:Q9C040","TRIM2" -"UniProt:Q9NYZ4","SIGLEC8" -"UniProt:P51884","LUM" -"UniProt:Q9BQI5","SGIP1" -"UniProt:P43364","MAGAB" -"UniProt:Q9H222","ABCG5" -"UniProt:Q9BWW4","SSBP3" -"UniProt:Q5JU69","TOR2A" -"UniProt:Q9UJV3","MID2" -"UniProt:Q9HCL2","GPAM" -"UniProt:Q04876","opaA" -"UniProt:P24772","B14" -"UniProt:P33260","CYP2C18" -"UniProt:Q92913","FGF13" -"UniProt:Q969Z0","TBRG4" -"UniProt:Q9UKU0","ACSL6" -"UniProt:Q14353","GAMT" -"UniProt:Q16322","KCNA10" -"UniProt:O15254","ACOX3" -"UniProt:P49585","PCYT1A" -"UniProt:Q8WUM9","SLC20A1" -"UniProt:Q6ZWL3","CYP4V2" -"UniProt:P24356","F1" -"UniProt:P08575","PTPRC" -"UniProt:P35408","PTGER4" -"UniProt:P40121","CAPG" -"UniProt:Q14330","GPR18" -"UniProt:Q8IW52","SLITRK4" -"UniProt:P85298","ARHGAP8" -"UniProt:Q96KJ9","COX4I2" -"UniProt:Q8IZX4","TAF1L" -"UniProt:P46937","YAP1" -"UniProt:Q17R60","IMPG1" -"UniProt:Q07000","HLA-C" -"UniProt:Q06210","GFPT1" -"UniProt:P19544","WT1" -"UniProt:Q69YN2","CWF19L1" -"UniProt:P04003","C4BPA" -"UniProt:A4UGR9","XIRP2" -"UniProt:Q6PK81","ZNF773" -"UniProt:Q5DT21","SPINK9" -"UniProt:P15813","CD1D" -"UniProt:Q9H3Y0","CRSPL" -"UniProt:Q9NY64","SLC2A8" -"UniProt:Q96RL6","SIGLEC11" -"UniProt:P18462","HLA-A" -"UniProt:P31949","S100A11" -"UniProt:Q8WWG1","NRG4" -"UniProt:Q8IZY2","ABCA7" -"UniProt:Q9Y399","MRPS2" -"UniProt:Q96IK1","BOD1" -"UniProt:P09455","RBP1" -"UniProt:P28715","ERCC5" -"UniProt:Q9H765","ASB8" -"UniProt:Q7Z2Y8", -"UniProt:P54136","RARS" -"UniProt:P48960","CD97" -"UniProt:O43462","MBTPS2" -"UniProt:Q96J42","TXNDC15" -"UniProt:Q5T1H1","EYS" -"UniProt:Q13478","IL18R1" -"UniProt:P52757","CHN2" -"UniProt:Q14031","COL4A6" -"UniProt:P35270","SPR" -"UniProt:P0CI26","TR49C" -"UniProt:Q13421","MSLN" -"UniProt:C9JQI7","TMEM232" -"UniProt:P35368","ADRA1B" -"UniProt:P15385","KCNA4" -"UniProt:P61604","CH10" -"UniProt:P50440","GATM" -"UniProt:Q13243","SRSF5" -"UniProt:P48165","GJA8" -"UniProt:Q9UPR3","SMG5" -"UniProt:P16871","IL7R" -"UniProt:Q9NQZ7","ENTPD7" -"UniProt:Q96RL1","UIMC1" -"UniProt:Q5SRI9","MANEA" -"UniProt:Q07352","ZFP36L1" -"UniProt:Q9Y618","NCOR2" -"UniProt:Q93075","TATDN2" -"UniProt:Q6V1X1","DPP8" -"UniProt:Q96AX9","MIB2" -"UniProt:Q08581","SLK19" -"UniProt:O43861","ATP9B" -"UniProt:Q86Z02","HIPK1" -"UniProt:Q8TE54","SLC26A7" -"UniProt:O75676","RPS6KA4" -"UniProt:Q9H0D2","ZNF541" -"UniProt:Q15256","PTPRR" -"UniProt:Q9HCC0","MCCC2" -"UniProt:Q9NZ43","USE1" -"UniProt:Q08AT0","Q08AT0" -"UniProt:P61201","CSN2" -"UniProt:Q14DG7","TMEM132B" -"UniProt:Q9HAT0","ROP1A" -"UniProt:Q58HT5","AWAT1" -"UniProt:P06276","BCHE" -"UniProt:P01732","CD8A" -"UniProt:Q9BX70","BTBD2" -"UniProt:Q8NFR3","SPTSSB" -"UniProt:Q59H18","TNNI3K;FPGT-TNNI3K" -"UniProt:O60231","DHX16" -"UniProt:O00574","CXCR6" -"UniProt:Q60953","PML" -"UniProt:Q9HBH9","MKNK2" -"UniProt:Q9BYT5","KRTAP2-2" -"UniProt:O15119","TBX3" -"UniProt:P53278","YG3A" -"UniProt:P05543","SERPINA7" -"UniProt:Q9BZD2","SLC29A3" -"UniProt:Q8NHA8","OR1F12" -"UniProt:P80294","MT1H" -"UniProt:O43623","SNAI2" -"UniProt:Q12955","ANK3" -"UniProt:Q96C24","SYTL4" -"UniProt:Q96J66","ABCC11" -"UniProt:Q8IZ07","ANKRD13A" -"UniProt:P10279","PRIO" -"UniProt:Q5T1C6","THEM4" -"UniProt:Q7KYR7","BTN2A1" -"UniProt:Q5MNZ6","WDR45B" -"UniProt:Q9BUA6","MYL10" -"UniProt:Q60749","KHDR1" -"UniProt:Q9GZN8","CT027" -"UniProt:Q15262","PTPRK" -"UniProt:Q6U949","IG2AS" -"UniProt:O95613","PCNT" -"UniProt:Q6ZN44","UNC5A" -"UniProt:Q9NZT1","CALML5" -"UniProt:Q6KF10","GDF6" -"UniProt:Q96RQ3","MCCC1" -"UniProt:Q9H0X9","OSBPL5" -"UniProt:O43593","HR" -"UniProt:B2CW77","KLLN" -"UniProt:Q7Z4T9","MAATS1" -"UniProt:P55809","OXCT1" -"UniProt:P28562","DUSP1" -"UniProt:Q9IW12","Q9IW12" -"UniProt:Q7Z465","BNIPL" -"UniProt:Q96KR1","ZFR" -"UniProt:P78345","RPP38" -"UniProt:P15514","AREG" -"UniProt:Q9UK99","FBX3" -"UniProt:P49790","NUP153" -"UniProt:P00751","CFB" -"UniProt:Q93008","USP9X" -"UniProt:P56817","BACE1" -"UniProt:P0CL80","GAGE12I" -"UniProt:Q9NW13","RBM28" -"UniProt:Q9NP31","SH2D2A" -"UniProt:P46736","BRCC3" -"UniProt:Q9BYE9","CDHR2" -"UniProt:P06788","VE7" -"UniProt:Q99615","DNAJC7" -"UniProt:P49640","EVX1" -"UniProt:P35221","CTNNA1" -"UniProt:P04183","KITH" -"UniProt:P36871","PGM1" -"UniProt:Q9ULX6","AKP8L" -"UniProt:P97837","DLGP2" -"UniProt:Q14789","GOLGB1" -"UniProt:P51530","DNA2" -"UniProt:Q9WV60","Gsk3b" -"UniProt:Q9BZ11","ADAM33" -"UniProt:P51151","RAB9A" -"UniProt:Q9NX08","COMMD8" -"UniProt:Q86UF1","TSPAN33" -"UniProt:P23510","TNFSF4" -"UniProt:P35414","APLNR" -"UniProt:Q6DKK2","TTC19" -"UniProt:Q12768","WASHC5" -"UniProt:O75541","ZNF821" -"UniProt:P17695","GLRX2" -"UniProt:Q6PID6","TTC33" -"UniProt:O95267","RASGRP1" -"UniProt:O15027","SC16A" -"UniProt:Q9BQ83","SLX1A" -"UniProt:Q9Y697","NFS1" -"UniProt:Q9Y6I7","WSB1" -"UniProt:P35916","FLT4" -"UniProt:Q8IYT8","ULK2" -"UniProt:Q2YD98","UVSSA" -"UniProt:Q8N7B9","EFCAB3" -"UniProt:Q6NSI4","CX057" -"UniProt:Q6P087","RPUSD3" -"UniProt:Q9NRU3","CNNM1" -"UniProt:P40938","RFC3" -"UniProt:P29966","MARCKS" -"UniProt:Q9C005","DPY30" -"UniProt:Q29980","MICB" -"UniProt:P20592","MX2" -"UniProt:P53566","CEBPA" -"UniProt:Q9NVE5","USP40" -"UniProt:Q8N779","Q8N779" -"UniProt:Q9UBL3","ASH2L" -"UniProt:O43866","CD5L" -"UniProt:Q9H098","FAM107B" -"UniProt:Q9NS64","RPRM" -"UniProt:B1AK53","ESPN" -"UniProt:P50225","SULT1A1" -"UniProt:Q96K19","RNF170" -"UniProt:P23470","PTPRG" -"UniProt:P16190","HLA-A" -"UniProt:Q15208","STK38" -"UniProt:O43374","RASA4" -"UniProt:Q9NSU2","TREX1" -"UniProt:Q9UGQ2","CACFD1" -"UniProt:Q719I0","AHSA2" -"UniProt:P08729","KRT7" -"UniProt:Q9UMQ3","BARX2" -"UniProt:Q5JWR5","DOPEY1" -"UniProt:P56746","CLDN15" -"UniProt:Q8NDB2","BANK1" -"UniProt:P55042","RAD" -"UniProt:O94875","SRBS2" -"UniProt:P0DJI6","FCOR" -"UniProt:Q49B96","COX19" -"UniProt:Q12887","COX10" -"UniProt:P31994","FCGR2B" -"UniProt:P12497","GAG-POL" -"UniProt:O95684","FR1OP" -"UniProt:Q96C98","Q96C98" -"UniProt:Q7RTX0","TAS1R3" -"UniProt:O75526","RMXL2" -"UniProt:O15143","ARPC1B" -"UniProt:P26012","ITGB8" -"UniProt:Q6P1L5","F117B" -"UniProt:Q9UP65","PLA2G4C" -"UniProt:O95905","ECD" -"UniProt:Q1KMD3","HNRNPUL2" -"UniProt:Q8N4U5","TCP11L2" -"UniProt:O15529","GPR42" -"UniProt:Q9UNX9","KCNJ14" -"UniProt:Q8IUQ0","CLVS1" -"UniProt:Q8NI51","CTCFL" -"UniProt:P40939","HADHA" -"UniProt:O88551","Cldn1" -"UniProt:O00212","RHOD" -"UniProt:Q5W0N0","C9orf57" -"UniProt:P19785","ESR1" -"UniProt:P09327","VILI" -"UniProt:P54253","ATXN1" -"UniProt:A4D126","ISPD" -"UniProt:Q01581","HMGCS1" -"UniProt:Q7Z5W3","BCDIN3D" -"UniProt:Q9Y5J5","PHLDA3" -"UniProt:Q6L8G4","KR511" -"UniProt:P24855","DNASE1" -"UniProt:P58012","FOXL2" -"UniProt:P84090","ERH" -"UniProt:Q6ZRH7","CATSPERG" -"UniProt:Q96S15","WDR24" -"UniProt:Q6ZW49","PAXI1" -"UniProt:Q92994","BRF1" -"UniProt:Q13568","IRF5" -"UniProt:Q00960","Grin2b" -"UniProt:Q9NUJ7","PLCXD1" -"UniProt:Q9Y2I1","NISCH" -"UniProt:O14949","UQCRQ" -"UniProt:O96011","PEX11B" -"UniProt:Q6NZQ4","PAXI1" -"UniProt:Q9BSH3","NICN1" -"UniProt:P52333","JAK3" -"UniProt:Q15370","ELOB" -"UniProt:Q9NR16","CD163L1" -"UniProt:Q96B23","C18orf25" -"UniProt:Q14160","SCRIB" -"UniProt:Q96F82","Q96F82" -"UniProt:Q8N138","ORMDL3" -"UniProt:Q8TAX7","MUC7" -"UniProt:P55084","HADHB" -"UniProt:Q96P31","FCRL3" -"UniProt:O95139","NDUFB6" -"UniProt:Q8NGB6","OR4M2" -"UniProt:P33992","MCM5" -"UniProt:Q8WVK2","SNRNP27" -"UniProt:Q9UBY9","HSPB7" -"UniProt:Q13190","STX5" -"UniProt:Q16629","SRSF7" -"UniProt:P32571","UBP4" -"UniProt:Q5TBA9","FRY" -"UniProt:Q9Y4U1","MMACHC" -"UniProt:Q68D06","SLFN13" -"UniProt:Q8NGI9","OR5A2" -"UniProt:P11473","VDR" -"UniProt:Q96RW7","HMCN1" -"UniProt:Q8NGJ6","OR51A4" -"UniProt:A6NL26","OR5B21" -"UniProt:Q9QZL0","RIPK3" -"UniProt:Q9UHV7","MED13" -"UniProt:Q9UIL8","PHF11" -"UniProt:P19623","SPEE" -"UniProt:P29558","RBMS1" -"UniProt:Q96GE5","ZNF799" -"UniProt:Q9H340","OR51B6" -"UniProt:Q16623","STX1A" -"UniProt:P18545","PDE6G" -"UniProt:Q96FQ7","CR018" -"UniProt:Q9NV70","EXOC1" -"UniProt:Q96N38","ZNF714" -"UniProt:Q6PDA7","SPAG11B" -"UniProt:A6NDL8","OR6C68" -"UniProt:Q9Y2G4","ANKRD6" -"UniProt:Q9BYV6","TRIM55" -"UniProt:O76099","OR7C1" -"UniProt:Q13733","ATP1A4" -"UniProt:Q6P047","CH074" -"UniProt:Q9NYW6","TAS2R3" -"UniProt:Q2M243","CCDC27" -"UniProt:O43822","C21orf2" -"UniProt:O14718","RRH" -"UniProt:O95396","MOCS3" -"UniProt:Q8NGN2","OR10S1" -"UniProt:Q13505","MTX1" -"UniProt:P52630","STAT2" -"UniProt:P38435","GGCX" -"UniProt:Q13308","PTK7" -"UniProt:Q32MK9","Q32MK9" -"UniProt:O95918","OR2H2" -"UniProt:O95072","REC8" -"UniProt:Q9UII2","ATIF1" -"UniProt:Q8NH83","OR4A5" -"UniProt:Q8TDR0","TRAF3IP1" -"UniProt:Q9UPX6","K1024" -"UniProt:Q8NHB7","OR5K1" -"UniProt:P43121","MCAM" -"UniProt:Q6UB99","ANKRD11" -"UniProt:Q86SQ4","ADGRG6" -"UniProt:Q8NH55","OR52E5" -"UniProt:P14324","FDPS" -"UniProt:A0MZ66","SHTN1" -"UniProt:P20264","POU3F3" -"UniProt:Q8NGK4","OR52K1" -"UniProt:Q9BYB0","SHANK3" -"UniProt:Q8NH92","OR1S1" -"UniProt:Q8TEP8","CEP192" -"UniProt:Q6UX40","TMEM107" -"UniProt:Q12923","PTN13" -"UniProt:O13566","YP123" -"UniProt:Q8TCB6","OR51E1" -"UniProt:Q9NTK5","OLA1" -"UniProt:Q8IXV7","KLHDC8B" -"UniProt:Q9NUN5","LMBRD1" -"UniProt:Q7Z2H8","SLC36A1" -"UniProt:Q9BUY5","ZN426" -"UniProt:Q8IWN7", -"UniProt:Q8IWF9","CCDC83" -"UniProt:O75530","EED" -"UniProt:Q8N127","OR5AS1" -"UniProt:P26022","PTX3" -"UniProt:Q6ZWB6","KCTD8" -"UniProt:P0DJ07","PET100" -"UniProt:P04090","RLN2" -"UniProt:P01833","PIGR" -"UniProt:Q96BA2","Q96BA2" -"UniProt:P25490","YY1" -"UniProt:Q14D04","VEPH1" -"UniProt:Q9Y5K8","ATP6V1D" -"UniProt:P47883","OR3A4P" -"UniProt:Q96C45","ULK4" -"UniProt:Q9H3L0","MMADHC" -"UniProt:H3BUK9","POTEB" -"UniProt:Q8NH43","OR4L1" -"UniProt:P42357","HAL" -"UniProt:Q8NHC6","OR14L1P" -"UniProt:Q9NVH1","DNAJC11" -"UniProt:P01350","GAST" -"UniProt:Q9D1P4","CHRD1" -"UniProt:P06821","M" -"UniProt:Q9GZK7","OR11A1" -"UniProt:O00204","SULT2B1" -"UniProt:A0A075B739","A0A075B739" -"UniProt:Q8IXE1","OR4N5" -"UniProt:P35754","GLRX" -"UniProt:E9PJR5","E9PJR5" -"UniProt:P06931","VE6" -"UniProt:P47888","OR3A3" -"UniProt:Q9P0L1","ZKSCAN7" -"UniProt:Q96G91","P2RY11" -"UniProt:P55318","FOXA3" -"UniProt:Q15836","VAMP3" -"UniProt:Q9C056","NKX6-2" -"UniProt:Q96A65","EXOC4" -"UniProt:Q6IF00","OR2T2" -"UniProt:Q4KMQ1","TPRN" -"UniProt:Q8WUY3","PRUNE2" -"UniProt:P40069","IMB4" -"UniProt:Q16851","UGP2" -"UniProt:Q8WXD2","SCG3" -"UniProt:Q8WZ94","OR5P3" -"UniProt:O94966","USP19" -"UniProt:O00422","SAP18" -"UniProt:Q9H2C5","OR52A5" -"UniProt:Q96HM7","PED1B" -"UniProt:P22914","CRYGS" -"UniProt:Q86YJ7","ANKRD13B" -"UniProt:Q5JQS5","OR2B11" -"UniProt:Q3LI76","KR151" -"UniProt:O15342","ATP6V0E1" -"UniProt:P61326","MAGOH" -"UniProt:P51801","CLCNKB" -"UniProt:Q99988","GDF15" -"UniProt:Q9UNF0","PACSIN2" -"UniProt:Q5SXH7","PKHS1" -"UniProt:Q8TE96","DQX1" -"UniProt:Q9BZE9","ASPSCR1" -"UniProt:Q9UJA2","CRLS1" -"UniProt:Q9Y5P0","OR51B4" -"UniProt:P25025","CXCR2" -"UniProt:Q8NGQ1","OR9G4" -"UniProt:Q15155","NOMO1" -"UniProt:A6NMU1","OR52A4P" -"UniProt:Q8TC27","ADAM32" -"UniProt:Q8N954","GPATCH11" -"UniProt:Q9H2U9","ADAM7" -"UniProt:A6NDY0","PABPN1L" -"UniProt:Q92900","UPF1" -"UniProt:A6NL82","FAM183A" -"UniProt:Q13077","TRAF1" -"UniProt:Q9MYV3","VEGFA" -"UniProt:Q13573","SNW1" -"UniProt:Q6NUK4","REEP3" -"UniProt:Q99523","SORT1" -"UniProt:Q61188","EZH2" -"UniProt:P61587","RND3" -"UniProt:Q04837","SSBP1" -"UniProt:P49796","RGS3" -"UniProt:Q99623","PHB2" -"UniProt:Q6W2J9","BCOR" -"UniProt:P13716","ALAD" -"UniProt:P31942","HNRH3" -"UniProt:Q8NGM8","OR6M1" -"UniProt:Q8TF32","ZNF431" -"UniProt:O76011","KRT34" -"UniProt:Q9Y294","ASF1A" -"UniProt:O75489","NDUFS3" -"UniProt:P01733","TVB1" -"UniProt:Q08369","GATA4" -"UniProt:Q8NGM1","OR4C15" -"UniProt:P30508","HLA-C" -"UniProt:Q8NGU4","OR2I1P" -"UniProt:Q49AN0","CRY2" -"UniProt:P23677","ITPKA" -"UniProt:Q96M94","KLHL15" -"UniProt:A0A087WXL1","A0A087WXL1" -"UniProt:O60656","UGT1A9" -"UniProt:Q9GZU3","TMEM39B" -"UniProt:Q8NGX8","OR6Y1" -"UniProt:Q96RD1","OR6C1" -"UniProt:Q96LU5","IMMP1L" -"UniProt:P17931","LGALS3" -"UniProt:P08908","HTR1A" -"UniProt:Q8TDF6","RASGRP4" -"UniProt:O95271","TNKS" -"UniProt:Q9NQT5","EXOSC3" -"UniProt:O00571","DDX3X" -"UniProt:Q9NR30","DDX21" -"UniProt:P32969","RL9" -"UniProt:Q9NVW2","RLIM" -"UniProt:P10844","botB" -"UniProt:Q8NGD3","OR4K5" -"UniProt:Q9NRE2","TSH2" -"UniProt:P26927","MST1" -"UniProt:P41220","RGS2" -"UniProt:Q2M2I8","AAK1" -"UniProt:Q01469","FABP5" -"UniProt:Q76N89","HECW1" -"UniProt:P09669","COX6C" -"UniProt:Q9UIV8","SERPINB13" -"UniProt:P06782","SNF1" -"UniProt:P0C7T2","OR2T7" -"UniProt:Q8NHW5","RLA0L" -"UniProt:A6NGY5","OR51F1" -"UniProt:P49685","GPR15" -"UniProt:Q12259","YL108" -"UniProt:Q6UWW9","TMEM207" -"UniProt:P39688","Fyn" -"UniProt:Q7L0Q8","RHOU" -"UniProt:Q8NGX3","OR10T2" -"UniProt:P37235","HPCAL1" -"UniProt:P35268","RL22" -"UniProt:O75208","COQ9" -"UniProt:Q96MN2","NLRP4" -"UniProt:Q9Y2Z9","COQ6" -"UniProt:Q8NGJ5","OR51L1" -"UniProt:Q969E8","TSR2" -"UniProt:P0C628","OR5AC1" -"UniProt:P53051","MALX3" -"UniProt:Q9UNI6","DUSP12" -"UniProt:A6NNY8","USP27X" -"UniProt:P07174","Ngfr" -"UniProt:Q8N443","RIBC1" -"UniProt:Q8NGT9","OR2A1" -"UniProt:Q8NA57","CL050" -"UniProt:Q14CM0","FRMPD4" -"UniProt:Q8NGF0","OR52B6" -"UniProt:P97458","PROP1" -"UniProt:Q9P2R3","ANFY1" -"UniProt:Q5VV52","ZNF691" -"UniProt:Q15233","NONO" -"UniProt:P58340","MLF1" -"UniProt:P97471","Smad4" -"UniProt:Q9BQ39","DDX50" -"UniProt:P47881","OR3A1" -"UniProt:Q8IYT3","CCDC170" -"UniProt:Q9BZX4","ROPN1B" -"UniProt:P20023","CR2" -"UniProt:Q96RC9","OR8B4" -"UniProt:Q8WUM0","NU133" -"UniProt:Q5JPI3","C3orf38" -"UniProt:Q8NGT2","OR13J1" -"UniProt:P25322","Ccnd1" -"UniProt:Q12802","AKP13" -"UniProt:O60826","CCDC22" -"UniProt:Q8WZA6","OR1E3" -"UniProt:Q5T5B0","LCE3E" -"UniProt:O15444","CCL25" -"UniProt:Q5T2R2","PDSS1" -"UniProt:Q8N1L9","BATF2" -"UniProt:Q8TB45","DEPTOR" -"UniProt:Q8N628","OR2C3" -"UniProt:Q01628","IFITM3" -"UniProt:Q9H5Z6","F124B" -"UniProt:P06725","UL83" -"UniProt:Q9UIE0","ZNF230" -"UniProt:A6NH00","OR2T8" -"UniProt:Q9NXK8","FBXL12" -"UniProt:O54918","B2L11" -"UniProt:A0A024R0Y4","A0A024R0Y4" -"UniProt:Q8WW33","GTSF1" -"UniProt:Q9NYM4","GPR83" -"UniProt:Q9Y6W5","WASF2" -"UniProt:A5YM72","CARNS1" -"UniProt:P20053","PRP4" -"UniProt:Q02878","RL6" -"UniProt:Q96MG2","JSPR1" -"UniProt:Q96BH1","RNF25" -"UniProt:Q8NGI2","OR52N4" -"UniProt:O00292","LEFTY2" -"UniProt:Q5SWL8","PRAMEF19" -"UniProt:Q8NGC3","OR10G2" -"UniProt:Q8TEJ3","SH3RF3" -"UniProt:Q96P66","GPR101" -"UniProt:P62269","RS18" -"UniProt:Q8NGK5","OR52M1" -"UniProt:P69849","NOMO3" -"UniProt:Q96M29","TEKT5" -"UniProt:O14526","FCHO1" -"UniProt:P51512","MMP16" -"UniProt:P43362","MAGA9" -"UniProt:P21675","TAF1" -"UniProt:B2R550","B2R550" -"UniProt:Q9HB63","NTN4" -"UniProt:O95319","CELF2" -"UniProt:Q9BSG1","ZNF2" -"UniProt:Q8NGK3","OR52K2" -"UniProt:Q9BQE9","BCL7B" -"UniProt:V9HWD0","V9HWD0" -"UniProt:Q9HCG1","ZNF160" -"UniProt:Q03936","ZNF92" -"UniProt:Q06455","RUNX1T1" -"UniProt:O76094","SRP72" -"UniProt:Q9BV44","THUMPD3" -"UniProt:Q8IZP9","ADGRG2" -"UniProt:Q6JBY9","RCSD1" -"UniProt:Q96IQ9","ZN414" -"UniProt:O75690","KRTAP5-8" -"UniProt:Q16563","SYPL1" -"UniProt:Q9Y3N9","OR2W1" -"UniProt:Q8N720","ZN655" -"UniProt:Q86YH6","PDSS2" -"UniProt:O75388","GPR32" -"UniProt:Q66GS9","CEP135" -"UniProt:P63005","LIS1" -"UniProt:P52756","RBM5" -"UniProt:Q8IW40","CCDC103" -"UniProt:P62249","RS16" -"UniProt:Q5XLA6","CARD17" -"UniProt:P86790","CCZ1B" -"UniProt:O75976","CPD" -"UniProt:Q96PE2","ARHGEF17" -"UniProt:Q8WUU5","GATAD1" -"UniProt:Q12770","SCAP" -"UniProt:A0A024RC46","A0A024RC46" -"UniProt:Q5TGJ6","HDGFL1" -"UniProt:P40145","ADCY8" -"UniProt:Q8NG98","OR7D4" -"UniProt:P08887","IL6R" -"UniProt:P05622","PGFRB" -"UniProt:P13612","ITA4" -"UniProt:Q15147","PLCB4" -"UniProt:Q9DCX1","MD2BP" -"UniProt:Q9UHR6","ZNHI2" -"UniProt:O43679","LDB2" -"UniProt:Q9NVP1","DDX18" -"UniProt:Q8WW14","C10ORF82" -"UniProt:Q6IPR3","TYW3" -"UniProt:P15374","UCHL3" -"UniProt:Q9NX70","MED29" -"UniProt:Q15904","ATP6AP1" -"UniProt:Q9NYJ1","COA4" -"UniProt:Q96RB7","OR5M11" -"UniProt:Q53S70","Q53S70" -"UniProt:O14817","TSN4" -"UniProt:Q5T750","C1orf68" -"UniProt:Q53HI1","UNC50" -"UniProt:Q0VG75","Q0VG75" -"UniProt:Q8NGG8","OR8B3" -"UniProt:Q9JLI4","NCOA6" -"UniProt:P48740","MASP1" -"UniProt:Q15629","TRAM1" -"UniProt:P61024","CKS1B" -"UniProt:Q9Y2A7","NCKP1" -"UniProt:Q8N6H7","ARFGAP2" -"UniProt:O60575","SPINK4" -"UniProt:Q0VAK6","LMOD3" -"UniProt:P16220","CREB1" -"UniProt:Q96AE7","TTC17" -"UniProt:P60520","GBRL2" -"UniProt:Q13233","MAP3K1" -"UniProt:P23246","SFPQ" -"UniProt:O75438","NDUFB1" -"UniProt:P47804","RGR" -"UniProt:P20800","EDN2" -"UniProt:Q13361","MFAP5" -"UniProt:Q9H892","TTC12" -"UniProt:O00144","FZD9" -"UniProt:Q9NZJ0","DTL" -"UniProt:Q13451","FKBP5" -"UniProt:A6NHQ2","FBLL1" -"UniProt:Q14CN4","KRT72" -"UniProt:O14763","TNFRSF10B" -"UniProt:Q5TZN3","Q5TZN3" -"UniProt:Q9GIY3","HLA-DRB1" -"UniProt:Q53Z40","Q53Z40" -"UniProt:Q93050","VPP1" -"UniProt:Q91Y86","Mapk8" -"UniProt:Q8NEY3","SPATA4" -"UniProt:Q86TM6","SYVN1" -"UniProt:Q96Q83","ALKB3" -"UniProt:P16860","NPPB" -"UniProt:P01236","PRL" -"UniProt:Q96IS3","RAX2" -"UniProt:Q9NVJ2","ARL8B" -"UniProt:Q99259","GAD1" -"UniProt:Q9NRR4","DROSHA" -"UniProt:Q8NB49","ATP11C" -"UniProt:Q9EPK5","WWTR1" -"UniProt:P51790","CLCN3" -"UniProt:Q15349","RPS6KA2" -"UniProt:Q9Y653","ADGRG1" -"UniProt:P34998","CRHR1" -"UniProt:Q9BT73","PSMG3" -"UniProt:P38935","IGHMBP2" -"UniProt:Q8WX93","PALLD" -"UniProt:P25963","NFKBIA" -"UniProt:Q9Y238","DLEC1" -"UniProt:Q9BX73","TM2D2" -"UniProt:Q8N608","DPP10" -"UniProt:Q6FGU7","Q6FGU7" -"UniProt:Q5T7N3","KANK4" -"UniProt:Q9UNU6","CYP8B1" -"UniProt:P10523","SAG" -"UniProt:P18846","ATF1" -"UniProt:P02602","MYL1" -"UniProt:P25942","CD40" -"UniProt:O95704","APBB3" -"UniProt:Q9NSB2","KRT84" -"UniProt:P55286","CDH8" -"UniProt:Q96QU6","ACCS" -"UniProt:Q8WZ42","TTN" -"UniProt:Q9Y6V0","PCLO" -"UniProt:Q6IA69","NADSYN1" -"UniProt:P04150","NR3C1" -"UniProt:Q15007","FL2D" -"UniProt:Q8IZA0","KIAA0319L" -"UniProt:Q96D42","HAVCR1" -"UniProt:P62307","RUXF" -"UniProt:O15381","NVL" -"UniProt:Q9UJT9","FBXL7" -"UniProt:O00444","PLK4" -"UniProt:Q14028","CNGB1" -"UniProt:Q9P272","KIAA1456" -"UniProt:Q9BYP8","KR171" -"UniProt:P38398","BRCA1" -"UniProt:O95486","SC24A" -"UniProt:P83881","RL36A" -"UniProt:Q6P2H3","CEP85" -"UniProt:Q9NWS8","RMND1" -"UniProt:Q03468","ERCC6" -"UniProt:Q9UBD0","HSFX2" -"UniProt:Q8WVX9","FAR1" -"UniProt:P0C091","FREM3" -"UniProt:Q8N4H5","TOMM5" -"UniProt:Q96N46","TTC14" -"UniProt:P51784","USP11" -"UniProt:Q13158","FADD" -"UniProt:Q7RTX7","CATSPER4" -"UniProt:P03485","M" -"UniProt:P62854","LOC101929876;RPS26" -"UniProt:Q02045","MYL5" -"UniProt:Q9H190","SDCB2" -"UniProt:P60201","PLP1" -"UniProt:P26010","ITB7" -"UniProt:P01721","IGLV6-57" -"UniProt:A6NLU0","RFPL4A" -"UniProt:Q6P3S1","DENND1B" -"UniProt:P47944","MT4" -"UniProt:Q9H0X6","RN208" -"UniProt:Q7Z7H8","RM10" -"UniProt:P04430","IGKV1-16" -"UniProt:Q96PD6","MOGAT1" -"UniProt:O94823","ATP10B" -"UniProt:O15442","MPPED1" -"UniProt:P62070","RRAS2" -"UniProt:Q9GZV3","SLC5A7" -"UniProt:Q9UIG0","BAZ1B" -"UniProt:Q15398","DLGP5" -"UniProt:P19320","VCAM1" -"UniProt:O14874","BCKDK" -"UniProt:Q86U44","METTL3" -"UniProt:P02511","CRYAB" -"UniProt:Q9UBK7","RABL2A" -"UniProt:Q32P44","EML3" -"UniProt:P48739","PITPNB" -"UniProt:Q9UHA7","IL36A" -"UniProt:P22612","PRKACG" -"UniProt:Q60787","Lcp2" -"UniProt:P04062","GBA" -"UniProt:Q969H4","CNKSR1" -"UniProt:Q96BJ3","AIDA" -"UniProt:Q8TCT7","SPPL2B" -"UniProt:P20340","RAB6A" -"UniProt:Q3KR37","GRAMD1B" -"UniProt:J3KQ06","J3KQ06" -"UniProt:Q96MZ4","F218A" -"UniProt:P42336","PIK3CA" -"UniProt:Q9ULF5","SLC39A10" -"UniProt:O43280","TREH" -"UniProt:Q6PCB8","EMB" -"UniProt:P57060","RWD2B" -"UniProt:Q5JPH6","EARS2" -"UniProt:P58511","SI11A" -"UniProt:P61266","STX1B" -"UniProt:Q9Y6J0","CABIN1" -"UniProt:Q07020","RL18" -"UniProt:O95178","NDUFB2" -"UniProt:P29762","RABP1" -"UniProt:Q15070","OXA1L" -"UniProt:Q9UGP4","LIMD1" -"UniProt:P12830","CDH1" -"UniProt:Q96KW9","SPACA7" -"UniProt:Q14982","OPCML" -"UniProt:Q9BWC9","CC106" -"UniProt:Q2M3C7","SPHKAP" -"UniProt:Q99518","FMO2" -"UniProt:Q96HJ5","MS4A3" -"UniProt:Q13572","ITPK1" -"UniProt:Q4G0X9","CCDC40" -"UniProt:P16050","ALOX15" -"UniProt:Q13207","TBX2" -"UniProt:Q6PUV4","CPLX2" -"UniProt:P29374","ARID4A" -"UniProt:O43451","MGAM" -"UniProt:Q9Y215","COLQ" -"UniProt:O00338","SULT1C2" -"UniProt:Q9H6H2","Q9H6H2" -"UniProt:Q9Y222","DMTF1" -"UniProt:O94778","AQP8" -"UniProt:P48547","KCNC1" -"UniProt:Q5SRQ6","Q5SRQ6" -"UniProt:Q6ICL7","SLC35E4" -"UniProt:Q8NHP6","MOSPD2" -"UniProt:Q3SXM5","HSDL1" -"UniProt:Q6IQ19","CCSAP" -"UniProt:O60921","HUS1" -"UniProt:Q9UHP6","RSP14" -"UniProt:Q9UL59","ZNF214" -"UniProt:P61073","CXCR4" -"UniProt:P50213","IDH3A" -"UniProt:Q86W54","SPATA24" -"UniProt:Q91ZR2","SNX18" -"UniProt:P38261","EXO84" -"UniProt:Q61548","AP180" -"UniProt:Q8NG97","OR2Z1" -"UniProt:Q3TI53","SCHI1" -"UniProt:P29067","ARRB2" -"UniProt:Q8N907","DAND5" -"UniProt:Q8N4Q1","CHCHD4" -"UniProt:P62874","Gnb1" -"UniProt:Q6P5R6","RPL22L1" -"UniProt:Q92935","EXTL1" -"UniProt:O95757","HS74L" -"UniProt:Q96K83","ZNF521" -"UniProt:O95405","ZFYVE9" -"UniProt:Q15126","PMVK" -"UniProt:P37802","TAGLN2" -"UniProt:Q96F24","NRBF2" -"UniProt:Q6NUN9","ZNF746" -"UniProt:Q7L1V2","MON1B" -"UniProt:Q9BTN0","LRFN3" -"UniProt:P11499","HS90B" -"UniProt:P99024","TBB5" -"UniProt:P27695","APEX1" -"UniProt:Q6ZNE5","BAKOR" -"UniProt:A0A0C4DFX9","A0A0C4DFX9" -"UniProt:Q53EZ4","CEP55" -"UniProt:Q86Y97","KMT5C" -"UniProt:P57052","RBM11" -"UniProt:P78406","RAE1" -"UniProt:P26687","TWST1" -"UniProt:P32970","CD70" -"UniProt:Q92636","FAN" -"UniProt:P32754","HPD" -"UniProt:A8K0Z3","WASH1" -"UniProt:P38646","HSPA9" -"UniProt:Q12518","ENT1" -"UniProt:P48426","PIP4K2A" -"UniProt:Q9Y5Q6","INSL5" -"UniProt:Q9BZQ8","NIBAN" -"UniProt:P11277","SPTB" -"UniProt:Q8TAA1","RNASE11" -"UniProt:Q8IXS2","CCDC65" -"UniProt:P25446","TNR6" -"UniProt:O14753","OVOL1" -"UniProt:Q14964","RB39A" -"UniProt:I3WAC9","I3WAC9" -"UniProt:Q02831","YP077" -"UniProt:Q9H714","RUBCL" -"UniProt:Q86UW6","N4BP2" -"UniProt:O15294","OGT" -"UniProt:Q66677","VCLAP" -"UniProt:A0A0C4DG49","A0A0C4DG49" -"UniProt:P51141","DVL1" -"UniProt:Q6UXF1","TMEM108" -"UniProt:Q6NUJ5","PWP2B" -"UniProt:P46597","ASMT" -"UniProt:O95803","NDST3" -"UniProt:P08487","PLCG1" -"UniProt:Q6L8H1","KRA54" -"UniProt:Q9BQ90","KLHDC3" -"UniProt:Q5T8D3","ACBD5" -"UniProt:Q86XL3","ANKLE2" -"UniProt:Q6WRI0","IGSF10" -"UniProt:P43007","SLC1A4" -"UniProt:O14815","CAPN9" -"UniProt:Q9Y6X9","MORC2" -"UniProt:Q810C5","Q810C5" -"UniProt:Q2TBE0","C19L2" -"UniProt:Q96K78","AGRG7" -"UniProt:Q969V4","TEKT1" -"UniProt:P30307","CDC25C" -"UniProt:Q8TF40","FNIP1" -"UniProt:O95980","RECK" -"UniProt:Q96M69","LRGUK" -"UniProt:P32902","RT04" -"UniProt:Q9ULS6","KCNS2" -"UniProt:Q8WVS4","WDR60" -"UniProt:Q91ZQ0","VMP1" -"UniProt:Q9ULV0","MYO5B" -"UniProt:Q7Z3Z2","RD3" -"UniProt:O14737","PDCD5" -"UniProt:P49327","FASN" -"UniProt:Q96GC9","VMP1" -"UniProt:Q8N3F8","MILK1" -"UniProt:Q8VHW5","CCG8" -"UniProt:P68373","TBA1C" -"UniProt:Q8IYI6","EXOC8" -"UniProt:Q9HA77","CARS2" -"UniProt:Q92633","LPAR1" -"UniProt:Q5ST30","VARS2" -"UniProt:Q86VW1","SLC22A16" -"UniProt:Q86SS6","SYT9" -"UniProt:O75147","OBSL1" -"UniProt:Q9C0C4","SEM4C" -"UniProt:Q6UXB0","FAM131A" -"UniProt:A6NI56","CCDC154" -"UniProt:P55795","HNRNPH2" -"UniProt:P20916","MAG" -"UniProt:Q9GZU7","CTDS1" -"UniProt:Q96M11","HYLS1" -"UniProt:Q9H1C4","UNC93B1" -"UniProt:Q8WWQ2","HPSE2" -"UniProt:Q8IW45","NNRD" -"UniProt:Q8ND30","PPFIBP2" -"UniProt:A0A0G2JMF6","A0A0G2JMF6" -"UniProt:A0A087WZT3","A0A087WZT3" -"UniProt:Q9Y4D1","DAAM1" -"UniProt:C6GKH1","C6GKH1" -"UniProt:P57076","C21orf59" -"UniProt:Q61221","HIF1A" -"UniProt:P34926","MAP1A" -"UniProt:Q6S5L8","SHC4" -"UniProt:Q86YT5","SLC13A5" -"UniProt:Q8UZC1","Q8UZC1" -"UniProt:P13762","HLA-DRB4" -"UniProt:Q9QUM4","SLAF1" -"UniProt:Q96PX1","RNF157" -"UniProt:Q9Y6W3","CAN7" -"UniProt:A0A0C4DGP0","A0A0C4DGP0" -"UniProt:O75815","BCAR3" -"UniProt:Q9P0J1","PDP1" -"UniProt:Q8WU20","FRS2" -"UniProt:O35625","AXIN1" -"UniProt:Q9NQV7","PRDM9" -"UniProt:Q9Y2Y0","ARL2BP" -"UniProt:P49662","CASP4" -"UniProt:Q04864","REL" -"UniProt:Q9BRZ2","TRIM56" -"UniProt:Q6UY14","ADAMTSL4" -"UniProt:P05015","IFNA16" -"UniProt:Q8IYX4","DND1" -"UniProt:P84074","HPCA" -"UniProt:P05387","RPLP2" -"UniProt:Q15223","NECTIN1" -"UniProt:O15211","RGL2" -"UniProt:Q9H903","MTHFD2L" -"UniProt:Q01344","IL5RA" -"UniProt:P19387","POLR2C" -"UniProt:Q8N1E6","FBXL14" -"UniProt:P49888","SULT1E1" -"UniProt:Q58DX5","NAALADL2" -"UniProt:Q6IPC0","Q6IPC0" -"UniProt:Q9Y3I1","FBXO7" -"UniProt:Q5JS98","Q5JS98" -"UniProt:P07327","ADH1A" -"UniProt:P30533","LRPAP1" -"UniProt:Q16718","NDUA5" -"UniProt:Q86UE6","LRRTM1" -"UniProt:P41221","WNT5A" -"UniProt:Q6UX15","LAYN" -"UniProt:O14841","OPLAH" -"UniProt:Q9UNE0","EDAR" -"UniProt:Q9NVV5","AIG1" -"UniProt:P53673","CRYBA4" -"UniProt:Q9NX40","OCIAD1" -"UniProt:Q6EMB2","TTLL5" -"UniProt:Q6PRD1","GPR179" -"UniProt:O60762","DPM1" -"UniProt:Q9H4B8","DPEP3" -"UniProt:Q9Y4X3","CCL27" -"UniProt:Q8N8E3","CEP112" -"UniProt:O75121","MFAP3L" -"UniProt:Q71UM5","RS27L" -"UniProt:Q9NX76","CMTM6" -"UniProt:O75937","DNAJC8" -"UniProt:P42167","TMPO" -"UniProt:O94933","SLITRK3" -"UniProt:Q9ES28","ARHGEF7" -"UniProt:P61803","DAD1" -"UniProt:P00918","CA2" -"UniProt:Q9BY64","UGT2B28" -"UniProt:Q9NXD2","MTMR10" -"UniProt:Q6IB77","GLYAT" -"UniProt:A0A0S2Z6M9","A0A0S2Z6M9" -"UniProt:Q96FG2","ELMOD3" -"UniProt:Q8N5Y8","PARP16" -"UniProt:Q08334","IL10RB" -"UniProt:Q6P2D8","XRRA1" -"UniProt:Q9NV64","TMEM39A" -"UniProt:P53176","MST27" -"UniProt:Q9NYK1","TLR7" -"UniProt:Q9ULP0","NDRG4" -"UniProt:Q9Y6N7","ROBO1" -"UniProt:Q8IYB8","SUPV3L1" -"UniProt:Q9NQ38","SPINK5" -"UniProt:Q9HCE5","METTL14" -"UniProt:Q9H0U9","TSPYL1" -"UniProt:Q6UW02","CYP20A1" -"UniProt:Q9Y6I3","EPN1" -"UniProt:P03979","TRGV3" -"UniProt:P01860","IGHG3" -"UniProt:Q96HE8","TMEM80" -"UniProt:Q9BYD1","MRPL13" -"UniProt:P01903","HLA-DRA" -"UniProt:Q96E22","NUS1" -"UniProt:Q8NCM2","KCNH5" -"UniProt:Q9UL25","RAB21" -"UniProt:P11488","GNAT1" -"UniProt:P78347","GTF2I" -"UniProt:Q99954","SMR3A" -"UniProt:O75317","USP12" -"UniProt:Q9UBQ7","GRHPR" -"UniProt:O43295","SRGAP3" -"UniProt:Q8WVN8","UBE2Q2" -"UniProt:Q9P2D1","CHD7" -"UniProt:Q02962","PAX2" -"UniProt:Q5TC84","OGFRL1" -"UniProt:Q9NZL9","MAT2B" -"UniProt:P98160","HSPG2" -"UniProt:Q96A10","Q96A10" -"UniProt:O95218","ZRAB2" -"UniProt:P20813","CYP2B6" -"UniProt:O14929","HAT1" -"UniProt:Q8NBZ0","INO80E" -"UniProt:Q9NS68","TNFRSF19" -"UniProt:Q71F56","MED13L" -"UniProt:Q8WYN0","ATG4A" -"UniProt:A7E2Y1","MYH7B" -"UniProt:O95562","SFT2D2" -"UniProt:Q9P0T4","ZN581" -"UniProt:P01308","INS" -"UniProt:Q96PP9","GBP4" -"UniProt:Q9H257","CARD9" -"UniProt:Q96F05","CK024" -"UniProt:Q9Y680","FKBP7" -"UniProt:Q14654","KCNJ11" -"UniProt:A6NC05","C5orf63" -"UniProt:P48232","SNAPN" -"UniProt:P53672","CRYBA2" -"UniProt:Q5VYS8","ZCCHC6" -"UniProt:Q8TDQ7","GNPDA2" -"UniProt:P32242","OTX1" -"UniProt:Q9NPL8","TIDC1" -"UniProt:P84233","H32" -"UniProt:Q9NYV4","CDK12" -"UniProt:O95395","GCNT3" -"UniProt:P23968","VATO" -"UniProt:P34949","MPI" -"UniProt:Q8IZQ1","WDFY3" -"UniProt:Q9UL51","HCN2" -"UniProt:Q9Y446","PKP3" -"UniProt:P52870","SC6B1" -"UniProt:Q9HAD4","WDR41" -"UniProt:Q6ZVD7","STOX1" -"UniProt:P62857","RPS28" -"UniProt:Q8IWG1","WDR63" -"UniProt:Q86UT5","PDZD3" -"UniProt:Q9Y2Z4","YARS2" -"UniProt:O00155","GPR25" -"UniProt:Q96MU5","CQ077" -"UniProt:P00488","F13A1" -"UniProt:Q9UKZ1","CNO11" -"UniProt:Q5JTD7","LRC73" -"UniProt:P07438","MT1B" -"UniProt:Q9HBA9","FOLH1B" -"UniProt:Q6UXI7","VIT" -"UniProt:Q96LP6","C12orf42" -"UniProt:Q8TC05","MDM1" -"UniProt:P29460","IL12B" -"UniProt:Q9H3M7","TXNIP" -"UniProt:P05375","PLMT" -"UniProt:P08670","VIM" -"UniProt:Q92974","ARHGEF2" -"UniProt:Q8N4M1","SLC44A3" -"UniProt:Q93096","TP4A1" -"UniProt:Q9Y608","LRRFIP2" -"UniProt:Q8WUJ0","STYX" -"UniProt:Q13112","CAF1B" -"UniProt:Q9C0J1","B3GNT4" -"UniProt:Q9NZ52","GGA3" -"UniProt:A8CG34","POM121C" -"UniProt:P04275","VWF" -"UniProt:Q96AJ1","CLUAP1" -"UniProt:Q9Y2D0","CA5B" -"UniProt:Q8IUC1","KRTAP11-1" -"UniProt:Q71DI3","HIST2H3A" -"UniProt:Q10469","MGAT2" -"UniProt:Q8NHW4","CC4L" -"UniProt:Q03431","PTH1R" -"UniProt:Q92968","PEX13" -"UniProt:Q9Y5T4","DJC15" -"UniProt:Q6A555","TXNDC8" -"UniProt:P47155","ILM1" -"UniProt:P03179","MTP" -"UniProt:Q9BT81","SOX7" -"UniProt:P58418","CLRN1" -"UniProt:P67870","CSNK2B" -"UniProt:Q96DG6","CMBL" -"UniProt:Q8NHU6","TDRD7" -"UniProt:O60636","TSN2" -"UniProt:Q9NZL4","HPBP1" -"UniProt:Q86VZ6","JAZF1" -"UniProt:Q96A58","RERG" -"UniProt:C5E526","C5E526" -"UniProt:Q9NZE8","MRPL35" -"UniProt:P59797","SELV" -"UniProt:O75896","TUSC2" -"UniProt:Q86WT6","TRIM69" -"UniProt:Q8IZM6","BPGAP1" -"UniProt:P22681","CBL" -"UniProt:O14880","MGST3" -"UniProt:P38484","IFNGR2" -"UniProt:Q8TF45","ZNF418" -"UniProt:Q5TB80","CE162" -"UniProt:Q969S6","TM203" -"UniProt:Q8WYB5","KAT6B" -"UniProt:Q8NCR6","SMRP1" -"UniProt:Q9BXM9","FSD1L" -"UniProt:Q8WVD3","RNF138" -"UniProt:Q6EKJ0","GTF2IRD2B" -"UniProt:Q86U10","ASPG" -"UniProt:Q5XKR9","FAM104B" -"UniProt:P00724","INV2" -"UniProt:Q31612","HLA-B" -"UniProt:Q6N075","MFSD5" -"UniProt:P04629","NTRK1" -"UniProt:Q5J8M3","EMC4" -"UniProt:O60243","HS6ST1" -"UniProt:Q99519","NEU1" -"UniProt:P02792","FTL" -"UniProt:O14957","UQCR11" -"UniProt:Q3SXR9","Q3SXR9" -"UniProt:Q8N6S4","ANKRD13C" -"UniProt:O00628","PEX7" -"UniProt:Q14314","FGL2" -"UniProt:Q8NGD4","OR4K1" -"UniProt:O75503","CLN5" -"UniProt:P02787","TF" -"UniProt:Q9NTQ9","GJB4" -"UniProt:P20160","AZU1" -"UniProt:P9WHH9","lpdC" -"UniProt:O94813","SLIT2" -"UniProt:Q6ZRI8","ARHGAP36" -"UniProt:Q6PIY7","PAPD4" -"UniProt:Q14802","FXYD3" -"UniProt:Q9BSE4","HERPUD2" -"UniProt:P49459","UBE2A" -"UniProt:Q0P6H9","TMEM62" -"UniProt:P49366","DHPS" -"UniProt:Q96HY6","DDRGK1" -"UniProt:O00445","SYT5" -"UniProt:Q4A1L4","BECN1" -"UniProt:Q5JV73","FRMPD3" -"UniProt:O15305","PMM2" -"UniProt:Q8IWT3","CUL9" -"UniProt:P53906","YNO6" -"UniProt:O75712","GJB3" -"UniProt:Q52LG2","KRTAP13-2" -"UniProt:Q13214","SEMA3B" -"UniProt:Q7Z2E3","APTX" -"UniProt:O14775","GNB5" -"UniProt:Q5I7T1","ALG10B" -"UniProt:Q5HYH7","Q5HYH7" -"UniProt:P30825","CTR1" -"UniProt:Q5BJF6","ODF2" -"UniProt:Q9H5X1","FA96A" -"UniProt:Q9H1X1","RSPH9" -"UniProt:Q8IXW0","LMTD2" -"UniProt:P43080","GUCA1A" -"UniProt:P40855","PEX19" -"UniProt:Q70EL3","USP50" -"UniProt:Q8N6T0","C11orf80" -"UniProt:Q53FV1","ORML2" -"UniProt:Q8NHY6","ZFP28" -"UniProt:Q8NFU7","TET1" -"UniProt:Q9UIX4","KCNG1" -"UniProt:O43759","SYNGR1" -"UniProt:Q53FT3","HIKESHI" -"UniProt:P14340","POLG" -"UniProt:P81277","PRLH" -"UniProt:Q96GM1","PLPR2" -"UniProt:Q6ZU52","K0408" -"UniProt:Q9BZG1","RAB34" -"UniProt:P19022","CADH2" -"UniProt:O95989","NUDT3" -"UniProt:Q29RF7","PDS5A" -"UniProt:Q9BQE3","TUBA1C" -"UniProt:Q6ZRS2","SRCAP" -"UniProt:Q06828","FMOD" -"UniProt:Q99735","MGST2" -"UniProt:Q9HBW1","LRRC4" -"UniProt:Q9H254","SPTBN4" -"UniProt:Q9H3J6","C12orf65" -"UniProt:O75618","DEDD" -"UniProt:O95971","CD160" -"UniProt:P02309","H4" -"UniProt:P42701","IL12RB1" -"UniProt:P01588","EPO" -"UniProt:Q86Y33","CDC20B" -"UniProt:P60879","Snap25" -"UniProt:Q96N20","ZNF75A" -"UniProt:P47111","VPS55" -"UniProt:O43521","BCL2L11" -"UniProt:Q96K37","S35E1" -"UniProt:Q6PFD9","NUP98" -"UniProt:P40260","MEP1" -"UniProt:P15169","CPN1" -"UniProt:Q96FZ5","CKLF7" -"UniProt:Q9ULK2","AT7L1" -"UniProt:P27448","MARK3" -"UniProt:O75506","HSBP1" -"UniProt:Q5T2S8","ARMC4" -"UniProt:Q86YQ8","CPNE8" -"UniProt:Q6ZS10","CL17A" -"UniProt:Q96JY0","MAEL" -"UniProt:O43237","DYNC1LI2" -"UniProt:Q02763","TEK" -"UniProt:Q6UWF9","FAM180A" -"UniProt:Q14511","Q145112" -"UniProt:Q8TE60","ADAMTS18" -"UniProt:P48723","HSP13" -"UniProt:P0CK96","SLC35E2B" -"UniProt:Q9H614","Q9H614" -"UniProt:P63086","Mapk1" -"UniProt:P50542","PEX5" -"UniProt:Q6ICL3","TANGO2" -"UniProt:Q86VW0","SESD1" -"UniProt:Q99619","SPSB2" -"UniProt:P82980","RET5" -"UniProt:P05204","HMGN2" -"UniProt:Q9NYL2","MAP3K20" -"UniProt:P00540","MOS" -"UniProt:P51861","CDR1" -"UniProt:Q8N114","SHISA5" -"UniProt:P18195","porB" -"UniProt:Q8CGU4","Agap2" -"UniProt:Q9H310","RHBG" -"UniProt:Q6ZN17","LIN28B" -"UniProt:P56645","PER3" -"UniProt:Q86T90","K1328" -"UniProt:O75800","ZMYND10" -"UniProt:Q8IYA7","MKX" -"UniProt:P40937","RFC5" -"UniProt:Q9H0V9","LMAN2L" -"UniProt:Q9HCR9","PDE11A" -"UniProt:Q9H3H3","C11orf68" -"UniProt:Q9NU23","LYRM2" -"UniProt:Q5T9C2","F102A" -"UniProt:Q9Y3D3","MRPS16" -"UniProt:P53243","YG2A" -"UniProt:Q8NG57","ELOA3" -"UniProt:P51532","SMARCA4" -"UniProt:Q924A0","TF7L2" -"UniProt:P51580","TPMT" -"UniProt:Q76353","Q76353" -"UniProt:Q8IY42","CD019" -"UniProt:Q96DX7","TRIM44" -"UniProt:O00584","RNASET2" -"UniProt:Q504Q3","PAN2" -"UniProt:Q8TDM0","BCAS4" -"UniProt:P54855","UGT2B15" -"UniProt:Q9HAV0","GNB4" -"UniProt:Q5EBL4","RILPL1" -"UniProt:Q8TAS3","Q8TAS3" -"UniProt:Q9P219","CCDC88C" -"UniProt:P05156","CFI" -"UniProt:Q92932","PTPRN2" -"UniProt:A0A0D9SF05","A0A0D9SF05" -"UniProt:P48167","GLRB" -"UniProt:Q8NFF2","SLC24A4" -"UniProt:Q8N9Z0","ZNF610" -"UniProt:P10109","FDX1" -"UniProt:Q8WVZ3","Q8WVZ3" -"UniProt:Q9Y345","SLC6A5" -"UniProt:Q5NV83","IGLV7-46" -"UniProt:O60393","NOBOX" -"UniProt:O14497","ARID1A" -"UniProt:Q8N3V7","SYNPO" -"UniProt:Q13740","ALCAM" -"UniProt:Q14541","HNF4G" -"UniProt:O75145","PPFIA3" -"UniProt:Q9Y3B2","EXOS1" -"UniProt:Q9UKL3","C8AP2" -"UniProt:Q3YBM2","TMEM176B" -"UniProt:Q8N766","EMC1" -"UniProt:Q9Y5Q5","CORIN" -"UniProt:Q14721","KCNB1" -"UniProt:Q8IXQ5","KLHL7" -"UniProt:Q5K651","SAMD9" -"UniProt:Q13363","CTBP1" -"UniProt:Q9H5Y7","SLITRK6" -"UniProt:P25092","GUCY2C" -"UniProt:Q9NVL1","FAM86C1" -"UniProt:Q6ZQR2","CFA77" -"UniProt:P08183","ABCB1" -"UniProt:P31000","VIME" -"UniProt:Q8N271","PROM2" -"UniProt:P08574","CYC1" -"UniProt:O60729","CC14B" -"UniProt:P41238","APOBEC1" -"UniProt:Q9UJV9","DDX41" -"UniProt:Q9P2J5","LARS" -"UniProt:B9A064","IGLL5" -"UniProt:Q92902","HPS1" -"UniProt:Q8WUT1","Q8WUT1" -"UniProt:O00442","RTCA" -"UniProt:P17643","TYRP1" -"UniProt:Q2WEN9","CEACAM16" -"UniProt:Q6NTF9","RHBD2" -"UniProt:Q92527","ANKRD7" -"UniProt:Q9JLQ0","Cd2ap" -"UniProt:Q9BT78","CSN4" -"UniProt:Q5VU57","AGBL4" -"UniProt:P08579","RU2B" -"UniProt:P17482","HXB9" -"UniProt:P29323","EPHB2" -"UniProt:Q86XK7","VSIG1" -"UniProt:P48764","SLC9A3" -"UniProt:P20645","M6PR" -"UniProt:P10997","IAPP" -"UniProt:Q0VD83","APOBR" -"UniProt:O75746","SLC25A12" -"UniProt:Q86Y22","COL23A1" -"UniProt:Q8NET8","TRPV3" -"UniProt:Q6IBB0","Q6IBB0" -"UniProt:Q7Z3S7","CACNA2D4" -"UniProt:Q13422","IKZF1" -"UniProt:P68363","TUBA1B" -"UniProt:Q8N8L2","ZN491" -"UniProt:Q68DY1","ZNF626" -"UniProt:A0A090N7T1","A0A090N7T1" -"UniProt:Q01804","OTUD4" -"UniProt:O95461","LARGE1" -"UniProt:Q13424","SNTA1" -"UniProt:Q8IXK2","GALNT12" -"UniProt:P55196","AFAD" -"UniProt:Q9NY28","GALNT8" -"UniProt:Q9NVK5","FGOP2" -"UniProt:Q02487","DSC2" -"UniProt:Q96ND0","F210A" -"UniProt:Q86UG4","SLCO6A1" -"UniProt:Q13061","TRDN" -"UniProt:Q9BRA2","TXD17" -"UniProt:Q15650","TRIP4" -"UniProt:P00533","EGFR" -"UniProt:P84157","MXRA7" -"UniProt:P14136","GFAP" -"UniProt:Q8N4N8","KIF2B" -"UniProt:Q9UNY5","ZN232" -"UniProt:Q9UPW5","AGTPBP1" -"UniProt:O96015","DNAL4" -"UniProt:Q5TAL4","Q5TAL4" -"UniProt:Q8N660","NBPF15" -"UniProt:Q496J9","SV2C" -"UniProt:P55285","CDH6" -"UniProt:P30492","HLA-B" -"UniProt:Q8N609","TR1L1" -"UniProt:P63104","YWHAZ" -"UniProt:Q8NA54","IQUB" -"UniProt:Q9NQP4","PFDN4" -"UniProt:Q13480","GAB1" -"UniProt:P23458","JAK1" -"UniProt:P06127","CD5" -"UniProt:Q9H081","MIS12" -"UniProt:Q7LBC6","KDM3B" -"UniProt:P60827","C1QTNF8" -"UniProt:Q96J01","THOC3" -"UniProt:Q6PFX7","NYAP1" -"UniProt:P13725","OSM" -"UniProt:A6NM28","ZFP92" -"UniProt:Q96IV6","FXDC2" -"UniProt:Q9NR21","PAR11" -"UniProt:Q6UXG3","CLM9" -"UniProt:Q9NYF3","FAM53C" -"UniProt:Q9H2J7","SLC6A15" -"UniProt:O94913","PCF11" -"UniProt:Q00978","IRF9" -"UniProt:Q8IZ21","PHACTR4" -"UniProt:P12532","CKMT1B" -"UniProt:Q68CR1","SEL1L3" -"UniProt:Q08AM2","Q08AM2" -"UniProt:P23469","PTPRE" -"UniProt:O95393","BMP10" -"UniProt:P03114","VE1" -"UniProt:P55210","CASP7" -"UniProt:Q96PQ0","SORCS2" -"UniProt:P22682","CBL" -"UniProt:Q9NWS1","PARPBP" -"UniProt:P18848","ATF4" -"UniProt:Q9ULQ0","STRIP2" -"UniProt:P30874","SSR2" -"UniProt:Q9H9L4","KANSL2" -"UniProt:Q9Y241","HIGD1A" -"UniProt:Q1ZZU3","SWI5" -"UniProt:Q9GZP4","PITHD1" -"UniProt:Q9UF11","PLEKHB1" -"UniProt:Q8BX09","Rbbp5" -"UniProt:P08218","CEL2B" -"UniProt:Q13277","STX3" -"UniProt:Q68CQ7","GLT8D1" -"UniProt:Q96CN9","GCC1" -"UniProt:Q86SE8","NPM2" -"UniProt:Q9UPY8","MARE3" -"UniProt:Q8NH00","OR2T4" -"UniProt:Q8IWB4","S31A7" -"UniProt:O94988","FAM13A" -"UniProt:Q7L0R7","RNF44" -"UniProt:Q9H1D0","TRPV6" -"UniProt:P52739","ZNF131" -"UniProt:Q99L02","Pagr1a" -"UniProt:Q6VB84","FX4L3" -"UniProt:P61158","ACTR3" -"UniProt:Q6ZQX7","C17orf97" -"UniProt:Q969T3","SNX21" -"UniProt:P51911","CNN1" -"UniProt:P36404","ARL2" -"UniProt:Q6PEX3","KR261" -"UniProt:Q9NTX7","RNF146" -"UniProt:Q6ZMW3","EML6" -"UniProt:Q9C0F3","ZN436" -"UniProt:F1D8N6","F1D8N6" -"UniProt:O75362","ZNF217" -"UniProt:Q9H2K2","TNKS2" -"UniProt:O43194","GPR39" -"UniProt:A7E2V4","ZSWIM8" -"UniProt:Q8TC57","M1AP" -"UniProt:O75382","TRIM3" -"UniProt:P86791","CCZ1B" -"UniProt:Q6XPR3","RPTN" -"UniProt:Q9NZB2","FAM120A" -"UniProt:Q96HD9","ACY3" -"UniProt:B0QYN7","B0QYN7" -"UniProt:P42338","PK3CB" -"UniProt:Q96S99","PLEKHF1" -"UniProt:Q86U70","LDB1" -"UniProt:Q4V328","GRAP1" -"UniProt:P14373","TRIM27" -"UniProt:Q9H609","ZN576" -"UniProt:O15393","TMPRSS2" -"UniProt:Q8N4F0","BPIFB2" -"UniProt:Q8IWE5","PLEKHM2" -"UniProt:O75356","ENTPD5" -"UniProt:Q86X29","LSR" -"UniProt:Q96DI7","SNRNP40" -"UniProt:Q5T754","LCE1F" -"UniProt:Q96AY4","TTC28" -"UniProt:Q8N3U4","STAG2" -"UniProt:Q6UX73","C16orf89" -"UniProt:P63027","VAMP2" -"UniProt:Q9Y2C3","B3GT5" -"UniProt:Q5JRX3","PITRM1" -"UniProt:Q16534","HLF" -"UniProt:Q684P5","RAP1GAP2" -"UniProt:Q96LJ7","DHRS1" -"UniProt:Q14934","NFATC4" -"UniProt:O00487","PSMD14" -"UniProt:Q86Y91","KI18B" -"UniProt:Q8BM65","NYAP2" -"UniProt:P17252","KPCA" -"UniProt:Q9NQ75","CASS4" -"UniProt:G3XAG3","G3XAG3" -"UniProt:P46663","BDKRB1" -"UniProt:Q08AF3","SLFN5" -"UniProt:Q9HAQ2","KIF9" -"UniProt:A6NKL6","TMEM200C" -"UniProt:Q922D4","PP6R3" -"UniProt:Q9NQ33","ASCL3" -"UniProt:P05026","AT1B1" -"UniProt:A8MXZ3","KRTAP9-1" -"UniProt:Q6IS24","WBSCR17" -"UniProt:Q96HR4","Q96HR4" -"UniProt:O95388","WISP1" -"UniProt:Q15622","OR7A5" -"UniProt:Q9NRG1","PRDC1" -"UniProt:Q96NT1","NP1L5" -"UniProt:Q53S99","C2orf83" -"UniProt:Q99733","NAP1L4" -"UniProt:Q6DT37","MRCKG" -"UniProt:P46109","CRKL" -"UniProt:Q13868","EXOS2" -"UniProt:O00398","P2RY10" -"UniProt:P09086","POU2F2" -"UniProt:Q8TE68","EPS8L1" -"UniProt:A0A0G2JJD3","A0A0G2JJD3" -"UniProt:P62994","GRB2" -"UniProt:P58294","PROK1" -"UniProt:Q8WVL7","ANR49" -"UniProt:P36508","ZNF76" -"UniProt:A5K5E5","A5K5E5" -"UniProt:Q8K4V6","Q8K4V6" -"UniProt:Q9ULZ3","ASC" -"UniProt:Q8N4T4","ARHGEF39" -"UniProt:Q9Y5K1","SPO11" -"UniProt:Q8N149","LILRA2" -"UniProt:Q16517","NNAT" -"UniProt:O14925","TIM23" -"UniProt:Q9Y644","RFNG" -"UniProt:Q96RA2","OR7D2" -"UniProt:Q9BV40","VAMP8" -"UniProt:O94888","UBXN7" -"UniProt:Q9UP79","ADAMTS8" -"UniProt:Q8IZP0","ABI1" -"UniProt:Q8N2Z9","CENPS" -"UniProt:A2RRD8","ZNF320" -"UniProt:P27348","YWHAQ" -"UniProt:Q8BRH4","Kmt2c" -"UniProt:Q96ST8","CEP89" -"UniProt:Q92953","KCNB2" -"UniProt:Q16099","GRIK4" -"UniProt:Q9Y6D6","BIG1" -"UniProt:Q9GZS3","WDR61" -"UniProt:Q9H0M4","ZCWPW1" -"UniProt:O75365","PTP4A3" -"UniProt:Q9BWT3","PAPOLG" -"UniProt:Q13445","TMED1" -"UniProt:Q9H156","SLITRK2" -"UniProt:Q8WWT9","S13A3" -"UniProt:A0A0C4DH69","IGKV1-9" -"UniProt:P48382","RFX5" -"UniProt:Q9NYF5","FAM13B" -"UniProt:Q15631","TSN" -"UniProt:Q6NV74","KIAA1211L" -"UniProt:Q96RL7","VPS13A" -"UniProt:Q9UM44","HHLA2" -"UniProt:Q9HBG4","ATP6V0A4" -"UniProt:Q9Y6L6","SLCO1B1" -"UniProt:O15247","CLIC2" -"UniProt:P43432","Il12b" -"UniProt:Q16082","HSPB2" -"UniProt:P0DJI9","SAA2" -"UniProt:P49747","COMP" -"UniProt:Q8IXM2","C17orf49" -"UniProt:Q9NPB9","ACKR4" -"UniProt:P39210","MPV17" -"UniProt:Q56P42","PYDC2" -"UniProt:A2A288","ZC3H12D" -"UniProt:Q9NVV9","THAP1" -"UniProt:Q07120","GFI1" -"UniProt:O95235","KIF20A" -"UniProt:Q2HXL6","EDEM3" -"UniProt:P09989","RIPT" -"UniProt:O95487","SEC24B" -"UniProt:P59768","GNG2" -"UniProt:Q9BUX1","CHAC1" -"UniProt:Q6ZT12","UBR3" -"UniProt:Q9UPQ0","LIMCH1" -"UniProt:Q04880","opaK" -"UniProt:Q9BX59","TPSNR" -"UniProt:Q9Y4E6","WDR7" -"UniProt:P62937","PPIA" -"UniProt:Q7Z6J4","FGD2" -"UniProt:Q96FN4","CPNE2" -"UniProt:Q8N4C8","MINK1" -"UniProt:Q96GC5","MRPL48" -"UniProt:Q9UJL9","ZFP69B" -"UniProt:Q6XE24","RBMS3" -"UniProt:Q9BVM4","GGACT" -"UniProt:Q1ZYL8","IZUMO4" -"UniProt:P63101","Ywhaz" -"UniProt:Q92519","TRIB2" -"UniProt:P24311","COX7B" -"UniProt:Q6X4U4","SOSTDC1" -"UniProt:O15547","P2RX6" -"UniProt:P55075","FGF8" -"UniProt:Q8IWR0","ZC3H7A" -"UniProt:Q8TED1","GPX8" -"UniProt:P49840","GSK3A" -"UniProt:F5GYI3","UBAP1L" -"UniProt:O14593","RFXANK" -"UniProt:Q8TBX8","PIP4K2C" -"UniProt:Q9NVH6","TMLHE" -"UniProt:Q9BYV1","AGXT2" -"UniProt:Q9BPW8","NIPS1" -"UniProt:Q9C0I4","THSD7B" -"UniProt:Q9JJ50","HGS" -"UniProt:Q32Q52","CL074" -"UniProt:Q86YD1","PTOV1" -"UniProt:Q96ID7","Q96ID7" -"UniProt:Q9Y4L5","RNF115" -"UniProt:Q9H871","RMD5A" -"UniProt:P05455","SSB" -"UniProt:P46782","RPS5" -"UniProt:Q06416","POU5F1B" -"UniProt:Q3LHN0","KRTAP25-1" -"UniProt:P52800","Efnb2" -"UniProt:P33076","CIITA" -"UniProt:Q6NXT4","SLC30A6" -"UniProt:Q8NBF6","AVL9" -"UniProt:Q5SYB0","FRMPD1" -"UniProt:Q8IVW6","ARID3B" -"UniProt:O14508","SOCS2" -"UniProt:P16452","EPB42" -"UniProt:Q9BRC7","PLCD4" -"UniProt:P01762","IGHV3-11" -"UniProt:Q9UFP1","FAM198A" -"UniProt:Q9BYD6","MRPL1" -"UniProt:O75628","REM1" -"UniProt:Q9Y3Y2","CHTOP" -"UniProt:Q6PIV2","FOXR1" -"UniProt:Q9UHD0","IL19" -"UniProt:Q8N370","SLC43A2" -"UniProt:P48643","CCT5" -"UniProt:Q9UI08","EVL" -"UniProt:Q9Y2E5","MAN2B2" -"UniProt:Q92506","DHB8" -"UniProt:Q7Z3Q1","SLC46A3" -"UniProt:Q8TD07","RAET1E" -"UniProt:Q7RTY8","TMPRSS7" -"UniProt:Q9H8H3","METTL7A" -"UniProt:Q8NDD1","C1orf131" -"UniProt:Q96MH6","TMEM68" -"UniProt:Q96NR8","RDH12" -"UniProt:Q9UL58","ZNF215" -"UniProt:P01138","NGF" -"UniProt:Q9UN30","SCML1" -"UniProt:Q9EPM5","SYNCI" -"UniProt:Q96E11","MRRF" -"UniProt:P23610","F8A2" -"UniProt:P63167","DYL1" -"UniProt:P40259","CD79B" -"UniProt:P88961","MINT-5262024" -"UniProt:Q5T8I9","HENMT1" -"UniProt:P48595","SERPINB10" -"UniProt:O95985","TOP3B" -"UniProt:Q6PCB5","RSBN1L" -"UniProt:Q8N201","INTS1" -"UniProt:Q9UMS6","SYNP2" -"UniProt:P23743","DGKA" -"UniProt:Q8WV15","T255B" -"UniProt:O94953","KDM4B" -"UniProt:Q8L517","Q8L517" -"UniProt:Q8TBJ4","PLPPR1" -"UniProt:O15303","GRM6" -"UniProt:O15061","SYNEM" -"UniProt:Q5GFL6","VWA2" -"UniProt:Q9H6Q4","NARFL" -"UniProt:P23116","EIF3A" -"UniProt:Q6PCB7","SLC27A1" -"UniProt:Q8NGY0","OR10X1" -"UniProt:Q9H8L6","MMRN2" -"UniProt:P62310","LSM3" -"UniProt:O75508","CLDN11" -"UniProt:Q8N2K0","ABHD12" -"UniProt:Q99788","CMKLR1" -"UniProt:Q8TAC1","RFESD" -"UniProt:Q6PEX7","TEX38" -"UniProt:Q9BTX3","TM208" -"UniProt:Q96AC6","KIFC2" -"UniProt:P25685","DNAJB1" -"UniProt:O00214","LGALS8" -"UniProt:O00193","C11orf58" -"UniProt:Q9Y237","PIN4" -"UniProt:P56159","GFRA1" -"UniProt:Q14134","TRI29" -"UniProt:Q9H9S3","SEC61A2" -"UniProt:Q6UW60","PCSK4" -"UniProt:Q5JSL3","DOCK11" -"UniProt:Q99895","CTRC" -"UniProt:Q5VTE6","ANGEL2" -"UniProt:Q9NVH2","INTS7" -"UniProt:O15235","MRPS12" -"UniProt:Q9BQI0","AIF1L" -"UniProt:O00287","RFXAP" -"UniProt:Q9NRH2","SNRK" -"UniProt:Q5VZ89","DENND4C" -"UniProt:Q9UKT8","FBXW2" -"UniProt:Q96N96","SPATA13" -"UniProt:Q5QP82","DCAF10" -"UniProt:Q9H0L4","CSTF2T" -"UniProt:O14713","ITGB1BP1" -"UniProt:Q8NCA5","FAM98A" -"UniProt:Q9UBC9","SPRR3" -"UniProt:O15550","KDM6A" -"UniProt:Q13607","OR2F1" -"UniProt:Q8TBE0","BAHD1" -"UniProt:Q86V40","TRABD2A" -"UniProt:Q9H7E9","CH033" -"UniProt:A4FU69","EFCAB5" -"UniProt:Q15468","STIL" -"UniProt:Q8NHX4","SPATA3" -"UniProt:A0A0C4DGQ3","A0A0C4DGQ3" -"UniProt:P59998","ARPC4" -"UniProt:Q08174","PCDH1" -"UniProt:Q9NRY7","PLSCR2" -"UniProt:Q3KRA6","C2orf76" -"UniProt:Q6UX71","PLXDC2" -"UniProt:Q30167","HLA-DRB1" -"UniProt:P02818","BGLAP" -"UniProt:Q9UBN7","HDAC6" -"UniProt:Q9H7E2","TDRD3" -"UniProt:Q9HBU9","POPDC2" -"UniProt:Q13237","PRKG2" -"UniProt:Q8N841","TTLL6" -"UniProt:Q9CY25","MIS12" -"UniProt:Q9BYU5","KRTAP2-1" -"UniProt:G4XUV3","G4XUV3" -"UniProt:Q86U86","PBRM1" -"UniProt:Q8WXU2","DNAAF4" -"UniProt:Q9H2B4","SLC26A1" -"UniProt:P63158","HMGB1" -"UniProt:O14796","SH21B" -"UniProt:O95450","ADAMTS2" -"UniProt:Q64368","DAZL" -"UniProt:Q9H0F7","ARL6" -"UniProt:Q9Y5Q8","GTF3C5" -"UniProt:P17542","TAL1" -"UniProt:P12488","env" -"UniProt:Q9Y263","PLAA" -"UniProt:Q9UPN3","MACF1" -"UniProt:Q9H8X2","IPPK" -"UniProt:Q9BZV3","IMPG2" -"UniProt:Q0IIN1","Q0IIN1" -"UniProt:Q15738","NSDHL" -"UniProt:Q9NYJ7","DLL3" -"UniProt:P60369","KRTAP10-3" -"UniProt:O15394","NCAM2" -"UniProt:O14626","GPR171" -"UniProt:P07954","FH" -"UniProt:P28360","MSX1" -"UniProt:P17677","NEUM" -"UniProt:Q96H40","ZNF486" -"UniProt:P18011","IPAB" -"UniProt:P52952","NKX2-5" -"UniProt:Q15029","EFTUD2" -"UniProt:Q13216","ERCC8" -"UniProt:P17302","GJA1" -"UniProt:P23526","AHCY" -"UniProt:Q92623","TTC9" -"UniProt:Q16143","SNCB" -"UniProt:O00170","AIP" -"UniProt:Q9Y2G2","CARD8" -"UniProt:Q01995","TAGLN" -"UniProt:Q8WXI8","CLC4D" -"UniProt:P10636","MAPT" -"UniProt:Q9HBF5","ST20" -"UniProt:P53680","AP2S1" -"UniProt:P43657","LPAR6" -"UniProt:P35557","GCK" -"UniProt:Q96NY8","NECTIN4" -"UniProt:Q12872","SFSWAP" -"UniProt:Q9HBT7","ZNF287" -"UniProt:P25063","CD24" -"UniProt:Q13137","CACO2" -"UniProt:A4PIV7","A4PIV7" -"UniProt:Q496F6","CD300E" -"UniProt:Q99645","EPYC" -"UniProt:Q5T6F2","UBAP2" -"UniProt:Q68G74","LHX8" -"UniProt:Q08499","PDE4D" -"UniProt:O95868","LY6G6D" -"UniProt:Q9Y2T2","AP3M1" -"UniProt:P19883","FST" -"UniProt:Q8IV28","Q8IV28" -"UniProt:P26339","CMGA" -"UniProt:P50281","MMP14" -"UniProt:Q6PJG3","Q6PJG3" -"UniProt:Q925J2","Q925J2" -"UniProt:Q15649","ZNHIT3" -"UniProt:Q9C0F0","ASXL3" -"UniProt:P43146","DCC" -"UniProt:Q86YF9","DZIP1" -"UniProt:Q13705","ACVR2B" -"UniProt:Q96EF0","MTMR8" -"UniProt:Q9NYW7","TAS2R1" -"UniProt:Q06136","KDSR" -"UniProt:P13489","RINI" -"UniProt:O43511","SLC26A4" -"UniProt:Q86WS4","CL040" -"UniProt:P10412","HIST1H1E" -"UniProt:A0A0A0MQQ9","A0A0A0MQQ9" -"UniProt:Q02809","PLOD1" -"UniProt:P43897","TSFM" -"UniProt:Q01453","PMP22" -"UniProt:Q53FP2","TM35A" -"UniProt:P53053","COS12" -"UniProt:Q9UKN5","PRDM4" -"UniProt:Q9UQN3","CHMP2B" -"UniProt:Q96G97","BSCL2" -"UniProt:P08118","MSMB" -"UniProt:O43151","TET3" -"UniProt:Q16821","PPP1R3A" -"UniProt:Q13950","RUNX2" -"UniProt:O95678","KRT75" -"UniProt:Q70E73","RAPH1" -"UniProt:P35184","SQT1" -"UniProt:Q9UKA2","FBXL4" -"UniProt:Q96HD1","CRELD1" -"UniProt:Q9UDY8","MALT1" -"UniProt:Q8IVP9","ZNF547" -"UniProt:A0A0A0MSR2","A0A0A0MSR2" -"UniProt:P16435","POR" -"UniProt:O15156","ZBTB7B" -"UniProt:P04733","MT1F" -"UniProt:Q8IYT4","KATL2" -"UniProt:E7EU14","PPP5D1" -"UniProt:O43242","PSMD3" -"UniProt:P30153","PPP2R1A" -"UniProt:Q09428","ABCC8" -"UniProt:Q9Y6Q1","CAPN6" -"UniProt:Q15118","PDK1" -"UniProt:P40303","PSA4" -"UniProt:Q86XE0","SNX32" -"UniProt:P42330","AKR1C3" -"UniProt:Q8NBI3","DRAXI" -"UniProt:Q13351","KLF1" -"UniProt:Q9WVI4","Gucy1a2" -"UniProt:P26715","KLRC1" -"UniProt:Q9NY27","PPP4R2" -"UniProt:Q9H799","C5orf42" -"UniProt:Q14697","GANAB" -"UniProt:Q86YW5","TREML1" -"UniProt:Q765I0","UTS2B" -"UniProt:Q60809","CNOT7" -"UniProt:O00744","WNT10B" -"UniProt:P35626","GRK3" -"UniProt:Q8N2H9","PELI3" -"UniProt:Q5T011","SZT2" -"UniProt:Q8N3C0","ASCC3" -"UniProt:Q9Y2S0","POLR1D" -"UniProt:Q9Y2G8","DNAJC16" -"UniProt:P13569","CFTR" -"UniProt:Q9NTM9","CUTC" -"UniProt:Q9H598","SLC32A1" -"UniProt:P04637","TP53" -"UniProt:Q9BYI3","FAM126A" -"UniProt:Q9Y2M5","KLH20" -"UniProt:Q14242","SELPLG" -"UniProt:A1A4E9","A1A4E9" -"UniProt:Q92831","KAT2B" -"UniProt:Q9Y2W3","SLC45A1" -"UniProt:P29973","CNGA1" -"UniProt:Q96PK6","RBM14" -"UniProt:P01559","sta1" -"UniProt:Q13936","CACNA1C" -"UniProt:O15062","ZBTB5" -"UniProt:A6BM72","MEGF11" -"UniProt:Q8IYS5","OSCAR" -"UniProt:Q99578","RIT2" -"UniProt:Q8WXB4","ZNF606" -"UniProt:Q8N7F7","UBL4B" -"UniProt:P13866","SLC5A1" -"UniProt:Q9HCC8","GDPD2" -"UniProt:Q9NR48","ASH1L" -"UniProt:Q2HR82","KBZIP" -"UniProt:A6NMZ5","OR4C45" -"UniProt:Q96A22","C11orf52" -"UniProt:Q9ULC8","ZDHHC8" -"UniProt:O00757","FBP2" -"UniProt:Q8NGI3","OR56B1" -"UniProt:Q9HB65","ELL3" -"UniProt:Q08117","AES" -"UniProt:Q8NH67","OR52I2" -"UniProt:Q7LG56","RRM2B" -"UniProt:Q92186","ST8SIA2" -"UniProt:Q8TF63","DCNP1" -"UniProt:U3KQK0","U3KQK0" -"UniProt:Q8NH85","OR5R1" -"UniProt:Q6NVH7","SWAP1" -"UniProt:Q5H9R7","PPP6R3" -"UniProt:P13747","HLA-E" -"UniProt:P23527","HIST1H2BO" -"UniProt:Q9Y315","DERA" -"UniProt:Q9Y484","WDR45" -"UniProt:Q8NGV6","OR5H6" -"UniProt:Q9H015","SLC22A4" -"UniProt:P43003","SLC1A3" -"UniProt:Q5JT25","RAB41" -"UniProt:P51681","CCR5" -"UniProt:Q8NGT5","OR9A2" -"UniProt:P59282","TPPP2" -"UniProt:P51170","SCNN1G" -"UniProt:A0A1B0GVM0","A0A1B0GVM0" -"UniProt:Q8N349","OR2L13" -"UniProt:P18850","ATF6" -"UniProt:Q96I34","PP16A" -"UniProt:Q9HD47","RANGRF" -"UniProt:P0DMS8","ADORA3" -"UniProt:P42229","STA5A" -"UniProt:Q6UWQ7","IGFL2" -"UniProt:A0A0R4J2E8","A0A0R4J2E8" -"UniProt:P27930","IL1R2" -"UniProt:Q13065","GAGE1" -"UniProt:Q99590","SCAF11" -"UniProt:P26717","KLRC2" -"UniProt:P55884","EIF3B" -"UniProt:P50553","ASCL1" -"UniProt:Q14563","SEMA3A" -"UniProt:Q9UM07","PADI4" -"UniProt:Q8NH89","OR5AK3P" -"UniProt:Q08AD1","CAMSAP2" -"UniProt:Q9QXE7","Tbl1x" -"UniProt:Q4ZG55","GREB1" -"UniProt:Q9UBC1","NFKBIL1" -"UniProt:O14804","TAAR5" -"UniProt:Q9Y2J8","PADI2" -"UniProt:Q9NRM0","SLC2A9" -"UniProt:P34982","OR1D2" -"UniProt:Q99624","SLC38A3" -"UniProt:P61254","RPL26" -"UniProt:Q8NH41","OR4K15" -"UniProt:Q9UNT1","RABL2B" -"UniProt:Q7DB74","Q7DB74" -"UniProt:P62277","RS13" -"UniProt:Q9BXM0","PRX" -"UniProt:P13797","PLS3" -"UniProt:Q0D2J5","ZN763" -"UniProt:P41597","CCR2" -"UniProt:Q0VGT2","Gli2" -"UniProt:P0DP23","CALM2;CALM3;CALM1" -"UniProt:Q8NGQ6","OR9I1" -"UniProt:Q62520","ZIC2" -"UniProt:P07320","CRYGD" -"UniProt:Q9BV20","MRI1" -"UniProt:Q9NPB3","CABP2" -"UniProt:Q5L4H4","Q5L4H4" -"UniProt:A1L1A6","IGSF23" -"UniProt:Q9Y6M4","CSNK1G3" -"UniProt:Q9NQG6","MID51" -"UniProt:Q15612","OR1Q1" -"UniProt:O43895","XPNPEP2" -"UniProt:P15036","ETS2" -"UniProt:P07998","RNASE1" -"UniProt:Q8TEB7","RN128" -"UniProt:Q12873","CHD3" -"UniProt:Q6IF42","OR2A2" -"UniProt:O73557","Z" -"UniProt:Q6IEU7","OR5M10" -"UniProt:Q96KX2","CAPZA3" -"UniProt:Q6AI39","GSC1L" -"UniProt:P62633","CNBP" -"UniProt:P80192","M3K9" -"UniProt:Q9BXW6","OSBPL1A" -"UniProt:Q8NH09","OR8S1" -"UniProt:Q04884","opaH" -"UniProt:Q10714","ACE" -"UniProt:P15880","RS2" -"UniProt:P30044","PRDX5" -"UniProt:Q6IF36","OR8G2" -"UniProt:Q969S2","NEIL2" -"UniProt:P04949","fliC" -"UniProt:P42785","PRCP" -"UniProt:Q8N6C5","IGSF1" -"UniProt:P61088","UBE2N" -"UniProt:E9PL17","E9PL17" -"UniProt:A6NEM1","GG6L9" -"UniProt:Q9NRM2","ZNF277" -"UniProt:Q9Y5Y3","GPR45" -"UniProt:P19388","POLR2E" -"UniProt:Q8TC12","RDH11" -"UniProt:Q9P0B6","CC167" -"UniProt:Q8NH37","OR4C3" -"UniProt:Q5JTH9","RRP12" -"UniProt:Q8R349","CDC16" -"UniProt:Q5TEA3","C20orf194" -"UniProt:Q99704","DOK1" -"UniProt:Q8NB25","FAM184A" -"UniProt:P02675","FGB" -"UniProt:Q7L7V1","DHX32" -"UniProt:Q9H0F6","SHARPIN" -"UniProt:O60939","SCN2B" -"UniProt:P60866","RS20" -"UniProt:Q96DT5","DNAH11" -"UniProt:Q9NPB1","NT5M" -"UniProt:P31146","CORO1A" -"UniProt:Q96PL1","SCGB3A2" -"UniProt:Q8N5M9","JAGN1" -"UniProt:Q5XKL5","BTBD8" -"UniProt:Q9UC06","ZNF70" -"UniProt:Q68DC2","ANKS6" -"UniProt:Q8TE12","LMX1A" -"UniProt:O75223","GGCT" -"UniProt:Q07687","DLX2" -"UniProt:P32335","MSS51" -"UniProt:P50463","CSRP3" -"UniProt:Q86X55","CARM1" -"UniProt:Q92890","UFD1L" -"UniProt:Q8WY41","NANOS1" -"UniProt:Q6P5X7","TMEM71" -"UniProt:Q5H9L4","TAF7L" -"UniProt:Q8N5S9","CAMKK1" -"UniProt:Q99543","DNAJC2" -"UniProt:Q14896","MYBPC3" -"UniProt:Q9Y5R8","TPPC1" -"UniProt:Q9UPN6","SCAF8" -"UniProt:O60291","MGRN1" -"UniProt:P56747","CLDN6" -"UniProt:O75152","ZC3H11A" -"UniProt:Q9UF47","DNAJC5B" -"UniProt:Q8N883","ZNF614" -"UniProt:Q96MK3","FAM20A" -"UniProt:P40616","ARL1" -"UniProt:O75843","AP1G2" -"UniProt:O95477","ABCA1" -"UniProt:P51970","NDUFA8" -"UniProt:P24158","PRTN3" -"UniProt:Q8TCD6","PHOP2" -"UniProt:B1AJZ9","FHAD1" -"UniProt:O75462","CRLF1" -"UniProt:Q4ZG74","Q4ZG74" -"UniProt:Q9NP61","ARFG3" -"UniProt:Q6ICG8","WBP2NL" -"UniProt:P14854","COX6B1" -"UniProt:P39656","DDOST" -"UniProt:Q8IZT6","ASPM" -"UniProt:P99999","CYCS" -"UniProt:Q8N5U6","RNF10" -"UniProt:Q9NV12","TMEM140" -"UniProt:Q9BSF4","TIM29" -"UniProt:Q9HD33","MRPL47" -"UniProt:Q8N4S0","CCDC82" -"UniProt:P17096","HMGA1" -"UniProt:Q96SI1","KCTD15" -"UniProt:O43761","SYNGR3" -"UniProt:O14773","TPP1" -"UniProt:Q8TAQ2","SMARCC2" -"UniProt:Q96GE4","CEP95" -"UniProt:Q8IYX3","CCDC116" -"UniProt:P29972","AQP1" -"UniProt:O60303","KIAA0556" -"UniProt:Q76G19","PDZD4" -"UniProt:Q8NEV8","EXPH5" -"UniProt:Q9H6S1","AZI2" -"UniProt:Q9Y576","ASB1" -"UniProt:C9JPN9","USP17L12" -"UniProt:P35991","BTK" -"UniProt:O95428","PAPLN" -"UniProt:P38838","WSS1" -"UniProt:P10244","MYBL2" -"UniProt:Q15049","MLC1" -"UniProt:A0A024R8L2","A0A024R8L2" -"UniProt:Q9Y5K2","KLK4" -"UniProt:Q4VA12","Q4VA12" -"UniProt:P12081","HARS" -"UniProt:P35213","Ywhab" -"UniProt:P51636","CAV2" -"UniProt:P41182","BCL6" -"UniProt:A6NJG6","ARGFX" -"UniProt:P47712","PLA2G4A" -"UniProt:O95180","CACNA1H" -"UniProt:Q8R4K2","IRAK4" -"UniProt:Q52LA3","LIN52" -"UniProt:Q9EQ32","BCAP" -"UniProt:O75436","VPS26A" -"UniProt:Q9BXU9","CABP8" -"UniProt:Q9H3F6","KCTD10" -"UniProt:Q6PF04","ZNF613" -"UniProt:Q8IVS8","GLYCTK" -"UniProt:P00403","COX2" -"UniProt:Q9UNQ2","DIM1" -"UniProt:Q8TCC7","SLC22A8" -"UniProt:Q8TCB0","IFI44" -"UniProt:Q14390","GGTLC2" -"UniProt:Q6ZW13","C16orf86" -"UniProt:Q8N8F7","LSME1" -"UniProt:Q9HCL0","PCDH18" -"UniProt:Q8N9L1","ZIC4" -"UniProt:Q969D9","TSLP" -"UniProt:Q8IUC6","TICAM1" -"UniProt:Q8WU17","RNF139" -"UniProt:Q9UBK5","HCST" -"UniProt:Q6BEB4","SP5" -"UniProt:Q9NP56","PDE7B" -"UniProt:Q9NXX6","NSMCE4A" -"UniProt:Q96S37","SLC22A12" -"UniProt:P04436","T-cell" -"UniProt:Q9BQE5","APOL2" -"UniProt:P18464","HLA-B" -"UniProt:Q9UQB3","CTNND2" -"UniProt:P39880","CUX1" -"UniProt:Q05164","HPF1" -"UniProt:Q03252","LMNB2" -"UniProt:Q659A1","ICE2" -"UniProt:Q3TTA7","CBLB" -"UniProt:P07237","P4HB" -"UniProt:Q7Z3H4","SAMD7" -"UniProt:Q9Y546","LRRC42" -"UniProt:Q9HBL8","NMRAL1" -"UniProt:Q9UPV0","CEP164" -"UniProt:P42704","LRPPRC" -"UniProt:Q8TAX9","GSDMB" -"UniProt:P51687","SUOX" -"UniProt:Q13296","SG2A2" -"UniProt:Q16656","NRF1" -"UniProt:Q2M1K9","ZNF423" -"UniProt:Q5IJ48","CRB2" -"UniProt:P22303","ACHE" -"UniProt:Q12852","M3K12" -"UniProt:Q7Z404","TMC4" -"UniProt:O60931","CTNS" -"UniProt:Q6ZVC0","NYAP1" -"UniProt:Q9C0K7","STRAB" -"UniProt:P07225","PROS1" -"UniProt:Q8IYW5","RNF168" -"UniProt:Q9NVT9","ARMC1" -"UniProt:P14209","CD99" -"UniProt:P32929","CTH" -"UniProt:Q9NW61","PLEKHJ1" -"UniProt:Q9P0W0","IFNK" -"UniProt:Q5SU16","Q5SU16" -"UniProt:O75608","LYPLA1" -"UniProt:P82251","SLC7A9" -"UniProt:Q96LQ0","PPP1R36" -"UniProt:Q13126","MTAP" -"UniProt:A6NH21","SERINC4" -"UniProt:O95081","AGFG2" -"UniProt:P34910","EVI2B" -"UniProt:Q15726","KISS1" -"UniProt:G3V0H7","SLCO1B7" -"UniProt:P38405","GNAL" -"UniProt:P51677","CCR3" -"UniProt:Q6JVE6","LCN10" -"UniProt:Q9H3N1","TMX1" -"UniProt:O95861","BPNT1" -"UniProt:O15165","LDLRAD4" -"UniProt:Q62406","IRAK1" -"UniProt:Q9C0I9","LRRC27" -"UniProt:Q9BZY9","TRIM31" -"UniProt:P61962","DCAF7" -"UniProt:Q8N661","TMEM86B" -"UniProt:Q12980","NPRL3" -"UniProt:O14678","ABCD4" -"UniProt:P56178","DLX5" -"UniProt:P05412","JUN" -"UniProt:Q96HY7","DHTKD1" -"UniProt:Q15717","ELAV1" -"UniProt:Q6UWS5","PET117" -"UniProt:Q9UBG0","MRC2" -"UniProt:Q6DHV5","CC2D2B" -"UniProt:Q5T5J6","SWT1" -"UniProt:Q9Y4X4","KLF12" -"UniProt:Q9UHD4","CIDEB" -"UniProt:Q9NZS2","KLRF1" -"UniProt:Q8N4C6","NIN" -"UniProt:Q8WXF0","SRSF12" -"UniProt:O75582","RPS6KA5" -"UniProt:P55291","CDH15" -"UniProt:P20132","SDS" -"UniProt:Q03013","GSTM4" -"UniProt:Q99626","CDX2" -"UniProt:P13497","BMP1" -"UniProt:Q5RI15","COX20" -"UniProt:Q96B18","DACT3" -"UniProt:O75880","SCO1" -"UniProt:Q9Y5M8","SRPRB" -"UniProt:Q99873","PRMT1" -"UniProt:Q96GJ1","TRM2" -"UniProt:O94776","MTA2" -"UniProt:Q9BVI0","PHF20" -"UniProt:Q9NPE3","NOP10" -"UniProt:O14654","IRS4" -"UniProt:Q96QI5","HS3ST6" -"UniProt:Q96T51","RUFY1" -"UniProt:Q99470","SDF2" -"UniProt:Q99784","OLFM1" -"UniProt:Q13686","ALKBH1" -"UniProt:Q8N0W3","FUK" -"UniProt:Q9UM82","SPATA2" -"UniProt:Q8TBE9","NANP" -"UniProt:P60368","KRTAP10-2" -"UniProt:P78333","GPC5" -"UniProt:Q9H251","CDH23" -"UniProt:Q8IVF7","FMNL3" -"UniProt:Q1A5X7","WHAL1" -"UniProt:P52657","T2AG" -"UniProt:Q96BD0","SLCO4A1" -"UniProt:P15807","MET8" -"UniProt:Q9H5J4","ELOVL6" -"UniProt:Q96LX8","ZN597" -"UniProt:Q5T871","LELP1" -"UniProt:Q9NRD5","PICK1" -"UniProt:P06536","GCR" -"UniProt:Q9NPF2","CHST11" -"UniProt:Q9BYR7","KRTAP3-2" -"UniProt:Q16695","HIST3H3" -"UniProt:Q13574","DGKZ" -"UniProt:Q60989","XIAP" -"UniProt:Q9BVG3","TRI62" -"UniProt:Q86WC4","OSTM1" -"UniProt:Q9NX20","MRPL16" -"UniProt:Q8NAV1","PRPF38A" -"UniProt:O14511","NRG2" -"UniProt:Q8NG94","OR11H1" -"UniProt:O43561","LAT" -"UniProt:Q86XF7","ZNF575" -"UniProt:P35749","MYH11" -"UniProt:O75083","WDR1" -"UniProt:Q8NES8","DEFB124" -"UniProt:Q9NSD7","RXFP3" -"UniProt:P49184","DNASE1L1" -"UniProt:Q9C086","INO80B" -"UniProt:Q9UKP6","UTS2R" -"UniProt:Q96AY3","FKBP10" -"UniProt:A4D1S5","RAB19" -"UniProt:Q96QU1","PCDH15" -"UniProt:O60306","AQR" -"UniProt:P35555","FBN1" -"UniProt:Q53H82","LACTB2" -"UniProt:A0PK00","T120B" -"UniProt:Q7LGA3","HS2ST1" -"UniProt:P0CW20","LIMS4" -"UniProt:Q8N3C7","CLIP4" -"UniProt:Q8N4X5","AFAP1L2" -"UniProt:P20719","HOXA5" -"UniProt:Q3V6T2","CCDC88A" -"UniProt:Q8IWY9","CDAN1" -"UniProt:Q9C0B0","UNK" -"UniProt:Q9Y4M8","CH071" -"UniProt:Q6ZNR0","TMEM91" -"UniProt:Q86U42","PABPN1" -"UniProt:Q86TP1","PRUNE1" -"UniProt:Q8IV04","TB10C" -"UniProt:Q6NZ44","Q6NZ44" -"UniProt:Q13402","MYO7A" -"UniProt:Q86T96","RNF180" -"UniProt:Q5SZI1","LDLRAD2" -"UniProt:Q9Y264","ANGPT4" -"UniProt:Q5TZ20","OR2G6" -"UniProt:Q14457","BECN1" -"UniProt:Q8TER5","ARHGEF40" -"UniProt:P83916","CBX1" -"UniProt:P01742","IGHV1-69" -"UniProt:Q8NE18","NSUN7" -"UniProt:Q04874","opaB" -"UniProt:Q5BKX5","C19ORF54" -"UniProt:P47902","CDX1" -"UniProt:Q9UPR5","SLC8A2" -"UniProt:Q9H641","Q9H641" -"UniProt:O15503","INSIG1" -"UniProt:Q14008","CKAP5" -"UniProt:Q6QHF9","PAOX" -"UniProt:Q9BVQ7","SPATA5L1" -"UniProt:Q13639","HTR4" -"UniProt:Q495M9","USH1G" -"UniProt:Q9UGY1","NOL12" -"UniProt:P49441","INPP1" -"UniProt:Q5T481","RBM20" -"UniProt:Q8N587","ZNF561" -"UniProt:Q5SSQ6","SAPCD1" -"UniProt:Q99748","NRTN" -"UniProt:Q9NYA4","MTMR4" -"UniProt:Q15849","UT2" -"UniProt:Q96QS3","ARX" -"UniProt:Q99877","HIST1H2BN" -"UniProt:Q86XS8","RNF130" -"UniProt:P62140","PPP1CB" -"UniProt:P52294","KPNA1" -"UniProt:Q9P0R6","GSKIP" -"UniProt:P53992","SEC24C" -"UniProt:Q9NZN9","AIPL1" -"UniProt:Q68DI1","ZNF776" -"UniProt:Q5HYA8","TMEM67" -"UniProt:P00491","PNP" -"UniProt:Q96R67","OR4C12" -"UniProt:P08253","MMP2" -"UniProt:Q6PGN9","PSRC1" -"UniProt:A1L306","A1L306" -"UniProt:Q9UJN7","ZNF391" -"UniProt:P52737","ZN136" -"UniProt:A2RRN7","A2RRN7" -"UniProt:O95279","KCNK5" -"UniProt:Q15437","SEC23B" -"UniProt:A0MPS7","A0MPS7" -"UniProt:P20815","CYP3A5" -"UniProt:Q96N76","UROC1" -"UniProt:Q9H8J5","MANSC1" -"UniProt:Q5NV92","IGLV4-69" -"UniProt:O95163","ELP1" -"UniProt:Q9NQZ8","ZNF71" -"UniProt:Q08AG5","ZN844" -"UniProt:P24001","IL32" -"UniProt:P04179","SOD2" -"UniProt:Q05034","Opacity" -"UniProt:Q9UQ88","CDK11A" -"UniProt:Q9Y6C9","MTCH2" -"UniProt:O43681","ASNA1" -"UniProt:Q9UKV8","AGO2" -"UniProt:Q0VDF9","HSPA14" -"UniProt:P18510","IL1RN" -"UniProt:Q9HAT2","SIAE" -"UniProt:P0CG05","IGLC2" -"UniProt:O14788","TNFSF11" -"UniProt:O95810","CAVN2" -"UniProt:Q53G59","KLHL12" -"UniProt:Q8N3P4","VPS8" -"UniProt:P06400","RB1" -"UniProt:O75150","RNF40" -"UniProt:Q8NG06","TRIM58" -"UniProt:O00602","FCN1" -"UniProt:Q9UJD0","RIMS3" -"UniProt:O95069","KCNK2" -"UniProt:Q6FG41","Q6FG41" -"UniProt:Q6P3X3","TTC27" -"UniProt:O00755","WNT7A" -"UniProt:Q8IY57","YAF2" -"UniProt:Q8IUF8","MINA" -"UniProt:P00568","AK1" -"UniProt:Q5HYK7","SH3D19" -"UniProt:Q5QJE6","TDIF2" -"UniProt:Q9BRJ2","MRPL45" -"UniProt:P54132","BLM" -"UniProt:Q16540","MRPL23" -"UniProt:Q9CW03","SMC3" -"UniProt:Q7RTS9","DYM" -"UniProt:O96017","CHEK2" -"UniProt:Q9Y6N9","USH1C" -"UniProt:O75445","USH2A" -"UniProt:P01705","IGLV2-23" -"UniProt:A4GXA9","EME2" -"UniProt:Q99966","CITE1" -"UniProt:O60347","TBC1D12" -"UniProt:P38886","RPN10" -"UniProt:Q8N3J6","CADM2" -"UniProt:Q8NDY6","BHE23" -"UniProt:P41181","AQP2" -"UniProt:Q9Y6Q3","ZFP37" -"UniProt:Q9NZI7","UBP1" -"UniProt:Q8TDD5","MCOLN3" -"UniProt:Q5MJ10","SPXN2" -"UniProt:P98155","VLDLR" -"UniProt:Q13488","TCIRG1" -"UniProt:P49959","MRE11" -"UniProt:Q08629","SPOCK1" -"UniProt:Q86SG7","LYG2" -"UniProt:Q9NQE7","PRSS16" -"UniProt:Q58EX2","SDK2" -"UniProt:Q7L4S7","ARMCX6" -"UniProt:Q8TBK6","ZCH10" -"UniProt:Q14254","FLOT2" -"UniProt:Q8N4N3","KLHL36" -"UniProt:Q86VQ6","TXNRD3" -"UniProt:Q12889","OVGP1" -"UniProt:O60542","PSPN" -"UniProt:Q02952","AKA12" -"UniProt:P56539","CAV3" -"UniProt:Q9H773","DCTP1" -"UniProt:P07451","CA3" -"UniProt:P09471","GNAO1" -"UniProt:O95153","RIMB1" -"UniProt:P0DMM9","SULT1A3" -"UniProt:O43395","PRPF3" -"UniProt:Q8NFT6","DBF4B" -"UniProt:Q9Y2Y4","ZBT32" -"UniProt:Q13608","PEX6" -"UniProt:Q9UKQ2","ADA28" -"UniProt:Q7Z7M8","B3GNT8" -"UniProt:O00409","FOXN3" -"UniProt:P12815","PDCD6" -"UniProt:Q9Y6Q2","STON1" -"UniProt:P49720","PSB3" -"UniProt:Q16816","PHKG1" -"UniProt:Q2KHN1","RN151" -"UniProt:P29350","PTN6" -"UniProt:O75364","PITX3" -"UniProt:P84103","SRSF3" -"UniProt:Q16539","MAPK14" -"UniProt:Q96K12","FAR2" -"UniProt:P41743","KPCI" -"UniProt:Q92523","CPT1B" -"UniProt:A6PVY3","FAM177B" -"UniProt:O15519","CFLAR" -"UniProt:Q80Z96","VANG1" -"UniProt:Q5NV85","IGLV3-12" -"UniProt:P48431","SOX2" -"UniProt:Q96A26","F162A" -"UniProt:P05019","IGF1" -"UniProt:Q6A163","KRT39" -"UniProt:P49023","PAXI" -"UniProt:Q12306","SMT3" -"UniProt:O15355","PPM1G" -"UniProt:Q9H0F5","RNF38" -"UniProt:Q96DW6","SLC25A38" -"UniProt:P18627","LAG3" -"UniProt:P48751","SLC4A3" -"UniProt:Q13287","NMI" -"UniProt:Q9Y4H2","IRS2" -"UniProt:P03496","NS" -"UniProt:Q8N6P7","IL22RA1" -"UniProt:P62502","LCN6" -"UniProt:Q12913","PTPRJ" -"UniProt:Q9H5Q4","TFB2M" -"UniProt:Q8N0X4","CLYBL" -"UniProt:Q9H330","TMEM245" -"UniProt:O95970","LGI1" -"UniProt:Q9Y4Y9","LSM5" -"UniProt:Q08379","GOLGA2" -"UniProt:Q8NB66","UNC13C" -"UniProt:Q99650","OSMR" -"UniProt:P78382","SLC35A1" -"UniProt:P04014","VE1" -"UniProt:Q6ZWH5","NEK10" -"UniProt:P49281","SLC11A2" -"UniProt:Q15742","NAB2" -"UniProt:P55087","AQP4" -"UniProt:P30875","SSR2" -"UniProt:P54315","LIPR1" -"UniProt:Q96SY0","VWA9" -"UniProt:Q9GZX3","CHST6" -"UniProt:Q7Z5Y6","BMP8A" -"UniProt:Q96C11","FGGY" -"UniProt:Q5VVX9","UBE2U" -"UniProt:P67936","TPM4" -"UniProt:Q9NSC2","SALL1" -"UniProt:Q96L33","RHOV" -"UniProt:Q969I6","SLC38A4" -"UniProt:P22557","ALAS2" -"UniProt:O00478","BTN3A3" -"UniProt:Q8WU66","TSPEAR" -"UniProt:P62875","RPAB5" -"UniProt:O60663","LMX1B" -"UniProt:P18031","PTN1" -"UniProt:Q9BQT8","SLC25A21" -"UniProt:Q7L513","FCRLA" -"UniProt:P57073","SOX8" -"UniProt:O14965","AURKA" -"UniProt:Q8BNX1","CLC4G" -"UniProt:Q8N7W2","BEND7" -"UniProt:P43681","CHRNA4" -"UniProt:Q8IU80","TMPRSS6" -"UniProt:Q96FZ7","CHMP6" -"UniProt:Q9H3S5","PIGM" -"UniProt:Q91ZD4","Vangl2" -"UniProt:Q9BZH6","WDR11" -"UniProt:Q6UXF7","CLEC18B" -"UniProt:Q8IY22","CMIP" -"UniProt:Q07343","PDE4B" -"UniProt:P35232","PHB" -"UniProt:Q8TCX5","RHPN1" -"UniProt:Q9ULK6","RNF150" -"UniProt:P43405","KSYK" -"UniProt:A6NF34","ANTXRL" -"UniProt:P12036","NEFH" -"UniProt:Q9Y6X3","MAU2" -"UniProt:P34810","CD68" -"UniProt:P48052","CPA2" -"UniProt:Q9H8M9","EVA1A" -"UniProt:Q14C87","T132D" -"UniProt:Q9BT23","LIMD2" -"UniProt:Q9NR77","PXMP2" -"UniProt:A5LHX3","PSMB11" -"UniProt:D6R901","USP17L21" -"UniProt:P02788","LTF" -"UniProt:Q7Z5L2","R3HCC1L" -"UniProt:Q9GZV5","WWTR1" -"UniProt:Q96KE9","BTBD6" -"UniProt:Q9Y316","MEMO1" -"UniProt:Q4G0J3","LARP7" -"UniProt:Q96GR2","ACSBG1" -"UniProt:P48025","KSYK" -"UniProt:P23919","DTYMK" -"UniProt:P54829","PTN5" -"UniProt:Q16878","CDO1" -"UniProt:O95243","MBD4" -"UniProt:Q96IF1","AJUBA" -"UniProt:Q08ET2","SIGLEC14" -"UniProt:P02766","TTR" -"UniProt:O95185","UNC5C" -"UniProt:Q86VP6","CAND1" -"UniProt:Q9NPR9","GPR108" -"UniProt:A6NMZ7","COL6A6" -"UniProt:Q86VI4","LAPTM4B" -"UniProt:Q9HD26","GOPC" -"UniProt:Q16584","M3K11" -"UniProt:P10916","MYL2" -"UniProt:Q8N7X8","SIGLECL1" -"UniProt:P19793","RXRA" -"UniProt:O14733","MP2K7" -"UniProt:Q9UP95","SLC12A4" -"UniProt:Q6GQQ9","OTU7B" -"UniProt:O43847","NRDC" -"UniProt:Q7L211","ABHD13" -"UniProt:Q6IMI4","SULT6B1" -"UniProt:P00395","COX1" -"UniProt:O95672","ECEL1" -"UniProt:Q549H9","Q549H9" -"UniProt:P30530","UFO" -"UniProt:Q30KQ1","DEFB133" -"UniProt:P15531","NME1" -"UniProt:O43581","SYT7" -"UniProt:Q32M45","ANO4" -"UniProt:Q8WXI9","GATAD2B" -"UniProt:Q9P2N6","KANSL3" -"UniProt:Q8NG75","OR5T1" -"UniProt:Q14657","LAGE3" -"UniProt:O14495","PLPP3" -"UniProt:Q9H4F8","SMOC1" -"UniProt:Q9UQC2","GAB2" -"UniProt:Q9UHR5","SAP30BP" -"UniProt:Q07955","SRSF1" -"UniProt:Q9Y226","SLC22A13" -"UniProt:P08590","MYL3" -"UniProt:Q9Y689","ARL5A" -"UniProt:P10144","GZMB" -"UniProt:Q8WWI5","SLC44A1" -"UniProt:P0C7I6","CCDC159" -"UniProt:P20888","env" -"UniProt:Q13938","CAPS" -"UniProt:Q96NG5","ZNF558" -"UniProt:Q7Z3D6","CN159" -"UniProt:Q13838","DDX39B" -"UniProt:Q8WV07","ORAOV1" -"UniProt:Q9UGK3","STAP2" -"UniProt:P38770","BRL1" -"UniProt:Q6UW56","ATRAID" -"UniProt:Q86T24","KAISO" -"UniProt:Q32M92","C15orf32" -"UniProt:Q96MH7","C5orf34" -"UniProt:Q5MAI5","CDKL4" -"UniProt:Q8TEW0","PARD3" -"UniProt:P49841","GSK3B" -"UniProt:Q5VU92","DC121" -"UniProt:Q9NP94","S39A2" -"UniProt:Q96Q91","SLC4A9" -"UniProt:Q9UF12","PRODH2" -"UniProt:Q9NPD5","SLCO1B3" -"UniProt:O60566","BUB1B" -"UniProt:Q15771","RAB30" -"UniProt:Q9BPX3","NCAPG" -"UniProt:A2RRG2","A2RRG2" -"UniProt:A0PJY2","FEZF1" -"UniProt:Q8WTS1","ABHD5" -"UniProt:P05090","APOD" -"UniProt:Q9ULW0","TPX2" -"UniProt:Q92887","ABCC2" -"UniProt:P45983","MK08" -"UniProt:Q0P5P2","C17orf67" -"UniProt:Q8NBM4","UBAC2" -"UniProt:O75419","CDC45" -"UniProt:Q8TEB9","RHBL4" -"UniProt:Q12078","SMF3" -"UniProt:Q96NN9","AIFM3" -"UniProt:A8K0R7","ZNF839" -"UniProt:Q96EL1","INKA1" -"UniProt:O43173","ST8SIA3" -"UniProt:E5KN55","E5KN55" -"UniProt:P42679","MATK" -"UniProt:Q9H269","VPS16" -"UniProt:Q8TBG9","SYNPR" -"UniProt:P47124","HOC1" -"UniProt:P17023","ZNF19" -"UniProt:Q13148","TARDBP" -"UniProt:P40074","AVT6" -"UniProt:Q8TDD1","DDX54" -"UniProt:Q96GK7","FAHD2A" -"UniProt:Q7L2K0","CP059" -"UniProt:P40152","YNV7" -"UniProt:P11309","PIM1" -"UniProt:P55854","SUMO3" -"UniProt:Q05899","YL297" -"UniProt:Q14833","GRM4" -"UniProt:Q8NEJ9","NGDN" -"UniProt:Q9ULK5","VANGL2" -"UniProt:Q13683","ITGA7" -"UniProt:Q8WYN3","CSRNP3" -"UniProt:Q8TF71","SLC16A10" -"UniProt:Q8N912","C14orf180" -"UniProt:Q9P1T7","MDFIC" -"UniProt:Q9UH99","SUN2" -"UniProt:O43347","MSI1" -"UniProt:Q4G0F5","VPS26B" -"UniProt:Q8N9W8","FAM71D" -"UniProt:O43293","DAPK3" -"UniProt:Q12884","FAP" -"UniProt:Q04969","SPC2" -"UniProt:Q9H270","VPS11" -"UniProt:Q9H7C4","SYNCI" -"UniProt:O00192","ARVCF" -"UniProt:P27701","CD82" -"UniProt:Q9Y3E0","GOT1B" -"UniProt:Q6ZSM3","SLC16A12" -"UniProt:O95295","SNAPN" -"UniProt:Q9BQ49","SMIM7" -"UniProt:P20809","IL11" -"UniProt:Q8WY98","TM234" -"UniProt:O76014","KRT37" -"UniProt:Q9Y303","AMDHD2" -"UniProt:Q15822","CHRNA2" -"UniProt:Q96LW4","PRIMPOL" -"UniProt:Q504T8","MIDN" -"UniProt:Q96AP0","ACD" -"UniProt:Q8TDV0","GP151" -"UniProt:Q99653","CHP1" -"UniProt:Q9Y267","SLC22A14" -"UniProt:Q8TBZ6","TRMT10A" -"UniProt:Q9H9T3","ELP3" -"UniProt:Q9NV56","MRGBP" -"UniProt:I3L0A0","I3L0A0" -"UniProt:Q9Y462","ZNF711" -"UniProt:O08715","AKAP1" -"UniProt:Q86UT8","CCDC84" -"UniProt:Q96MT3","PRICKLE1" -"UniProt:Q9H1J1","UPF3A" -"UniProt:Q9Y2I2","NTNG1" -"UniProt:Q5T4W7","ARTN" -"UniProt:Q12837","POU4F2" -"UniProt:Q6TCH7","PAQR3" -"UniProt:Q9Y6I9","TX264" -"UniProt:Q9GZR1","SENP6" -"UniProt:Q13585","GPR50" -"UniProt:Q8N336","ELMOD1" -"UniProt:Q6UWM7","LCTL" -"UniProt:Q4LEZ3","AARD" -"UniProt:Q8TBY9","WDR66" -"UniProt:Q9BU89","DOHH" -"UniProt:P50748","KNTC1" -"UniProt:Q99466","NOTCH4" -"UniProt:Q13746","Q13746" -"UniProt:P29376","LTK" -"UniProt:Q9ULW5","RAB26" -"UniProt:P22888","LHCGR" -"UniProt:P0C7M8","CLEC2L" -"UniProt:Q6P050","FBXL22" -"UniProt:Q9NPH9","IL26" -"UniProt:Q6NXT1","ANKRD54" -"UniProt:Q8NBD8","T229B" -"UniProt:Q8BFT2","HAUS4" -"UniProt:O60688","YPEL1" -"UniProt:Q01718","MC2R" -"UniProt:P03410","TAX" -"UniProt:Q5THJ4","VPS13D" -"UniProt:Q9BUN1","MENT" -"UniProt:P01137","TGFB1" -"UniProt:Q5TGU0","TSPO2" -"UniProt:Q96DL1","NXPE2" -"UniProt:Q9NV66","TYW1" -"UniProt:Q9NYQ6","CELSR1" -"UniProt:P17152","TMM11" -"UniProt:Q6UWP2","DHRS11" -"UniProt:O88384","VTI1B" -"UniProt:Q9HCQ5","GALNT9" -"UniProt:P37287","PIGA" -"UniProt:Q9P206","KIAA1522" -"UniProt:Q9HBH1","PDF" -"UniProt:Q9UKN8","TF3C4" -"UniProt:Q9UN86","G3BP2" -"UniProt:Q96A46","SLC25A28" -"UniProt:P21589","NT5E" -"UniProt:P09093","CELA3A" -"UniProt:Q96AA3","RFT1" -"UniProt:P30532","CHRNA5" -"UniProt:Q96JF0","ST6GAL2" -"UniProt:Q02577","HEN2" -"UniProt:Q14585","ZNF345" -"UniProt:Q8NI60","COQ8A" -"UniProt:Q6UXI9","NPNT" -"UniProt:Q15366","PCBP2" -"UniProt:Q14435","GALNT3" -"UniProt:P22626","HNRNPA2B1" -"UniProt:Q9GZK3","OR2B2" -"UniProt:P15509","CSF2RA" -"UniProt:P03452","HA" -"UniProt:Q7Z3Z3","PIWIL3" -"UniProt:Q96M93","ADAD1" -"UniProt:P40200","CD96" -"UniProt:Q96ST2","IWS1" -"UniProt:Q502W7","CCDC38" -"UniProt:Q96PS8","AQP10" -"UniProt:O95831","AIFM1" -"UniProt:Q8TAV5","CK045" -"UniProt:Q5ZJW0","Q5ZJW0" -"UniProt:P46059","SLC15A1" -"UniProt:Q495C1","RNF212" -"UniProt:Q6NUI2","GPAT2" -"UniProt:Q96DU3","SLAMF6" -"UniProt:Q460N5","PARP14" -"UniProt:Q9P2P6","STARD9" -"UniProt:Q9BXR0","QTRT1" -"UniProt:O75396","SC22B" -"UniProt:Q13495","MAMLD1" -"UniProt:Q5T6V5","C9orf64" -"UniProt:P25619","HSP30" -"UniProt:Q13342","SP140" -"UniProt:Q9Y5P2","CSAG3" -"UniProt:Q8TDN2","KCNV2" -"UniProt:O75127","PTCD1" -"UniProt:P48551","IFNAR2" -"UniProt:O00712","NFIB" -"UniProt:Q06730","ZNF33A" -"UniProt:Q96E40","SACA9" -"UniProt:Q8N680","ZBTB2" -"UniProt:Q12006","PFA4" -"UniProt:Q00994","BEX3" -"UniProt:Q9UNH6","SNX7" -"UniProt:O00300","TNFRSF11B" -"UniProt:Q6ZVK8","NUD18" -"UniProt:Q16384","SSX1" -"UniProt:P51811","XK" -"UniProt:Q8IY81","FTSJ3" -"UniProt:Q86Z23","C1QL4" -"UniProt:Q6P4Q7","CNNM4" -"UniProt:O60551","NMT2" -"UniProt:O43760","SYNGR2" -"UniProt:P20138","CD33" -"UniProt:Q7Z3S9","NT2NL" -"UniProt:Q9BXL5","HEMGN" -"UniProt:Q53F39","MPPE1" -"UniProt:Q9BTE6","AARSD1" -"UniProt:Q9P2U8","SLC17A6" -"UniProt:Q96E17","RAB3C" -"UniProt:Q8N966","ZDH22" -"UniProt:Q5JPI9","METTL10" -"UniProt:Q8NEE8","TTC16" -"UniProt:Q9NRZ7","PLCC" -"UniProt:Q8IZF0","NALCN" -"UniProt:O75569","PRKRA" -"UniProt:Q8NDH3","NPEPL1" -"UniProt:Q7L3T8","PARS2" -"UniProt:P15812","CD1E" -"UniProt:O43164","PJA2" -"UniProt:P29474","NOS3" -"UniProt:Q9UJ68","MSRA" -"UniProt:Q9UKR5","ERG28" -"UniProt:A2A5Z6","SMUF2" -"UniProt:Q9UHR4","BI2L1" -"UniProt:O43236","SEPT4" -"UniProt:P17655","CAN2" -"UniProt:Q96NR3","PTCHD1" -"UniProt:Q9H813","TMEM206" -"UniProt:Q9H7T0","CATSPERB" -"UniProt:Q86SG2","ANKRD23" -"UniProt:Q96FV3","TSPAN17" -"UniProt:P05362","ICAM1" -"UniProt:Q10472","GALNT1" -"UniProt:Q8NCT1","ARRDC4" -"UniProt:P41594","GRM5" -"UniProt:P32297","CHRNA3" -"UniProt:P48362","HGH1" -"UniProt:Q16385","SSX2" -"UniProt:Q9UN81","LORF1" -"UniProt:Q96HE7","ERO1A" -"UniProt:P35716","SOX11" -"UniProt:Q9H0R3","TM222" -"UniProt:P01584","IL1B" -"UniProt:Q86V38","Q86V38" -"UniProt:Q12382","DGK1" -"UniProt:Q9BYW1","SLC2A11" -"UniProt:Q9NR99","MXRA5" -"UniProt:P63313","TYB10" -"UniProt:Q15019","SEPT2" -"UniProt:Q8WXG6","MADD" -"UniProt:P68402","PAFAH1B2" -"UniProt:Q9GZQ3","COMMD5" -"UniProt:Q8N456","LRC18" -"UniProt:Q86WG5","SBF2" -"UniProt:Q6Q899","Ddx58" -"UniProt:Q96KN2","CNDP1" -"UniProt:E7EWC5","E7EWC5" -"UniProt:P17844","DDX5" -"UniProt:Q49A92","C8orf34" -"UniProt:Q8TCB7","METTL6" -"UniProt:Q9P0U1","TOMM7" -"UniProt:Q7Z6W7","DNAJB7" -"UniProt:Q9NY47","CACNA2D2" -"UniProt:Q6PI97","C11orf88" -"UniProt:Q9BZJ6","GPR63" -"UniProt:Q9UBS0","RPS6KB2" -"UniProt:P35609","ACTN2" -"UniProt:Q86UN3","RTN4RL2" -"UniProt:Q96SE0","ABHD1" -"UniProt:A5D8V7","CCDC151" -"UniProt:P63146","UBE2B" -"UniProt:O95931","CBX7" -"UniProt:Q6PI98","INO80C" -"UniProt:Q5SV97","PERM1" -"UniProt:Q92915","FGF14" -"UniProt:Q8NCR3","C11orf65" -"UniProt:Q7Z412","PEX26" -"UniProt:Q6PIL0","IGHV7-81" -"UniProt:Q96LY2","CCDC74B" -"UniProt:P31943","HNRNPH1" -"UniProt:Q16698","DECR1" -"UniProt:Q5TBK1","N4BP2L1" -"UniProt:Q13474","DRP2" -"UniProt:Q06787","FMR1" -"UniProt:Q8IV77","CNGA4" -"UniProt:Q96EU6","RRP36" -"UniProt:P01624","IGKV3-15" -"UniProt:P54821","PRRX1" -"UniProt:Q5JVF3","PCID2" -"UniProt:P09629","HXB7" -"UniProt:Q8IVD9","NUDC3" -"UniProt:Q9BWH6","RPAP1" -"UniProt:O95503","CBX6" -"UniProt:Q9GZX9","TWSG1" -"UniProt:Q9GZM5","YIPF3" -"UniProt:Q08AH3","ACSM2A" -"UniProt:Q96LM9","C20orf173" -"UniProt:Q9UL42","PNMA2" -"UniProt:Q8VDS3","CBX7" -"UniProt:P20774","OGN" -"UniProt:Q66K66","TMEM198" -"UniProt:O60938","KERA" -"UniProt:Q92804","TAF15" -"UniProt:Q9P2D6","FAM135A" -"UniProt:Q92905","COPS5" -"UniProt:Q96GU1","PAGE5" -"UniProt:Q9NYC9","DNAH9" -"UniProt:P40313","CTRL" -"UniProt:Q86Y56","DNAAF5" -"UniProt:Q549N0","Q549N0" -"UniProt:Q6P179","ERAP2" -"UniProt:Q9UKC9","FBXL2" -"UniProt:O00476","SLC17A3" -"UniProt:O75110","ATP9A" -"UniProt:Q8WWQ0","PHIP" -"UniProt:P16403","HIST1H1C" -"UniProt:Q9Y5Y5","PEX16" -"UniProt:Q13630","TSTA3" -"UniProt:Q9NXG2","THUMPD1" -"UniProt:Q6I9S7","Q6I9S7" -"UniProt:Q9NUD9","PIGV" -"UniProt:P0DI81","TRAPPC2" -"UniProt:Q05D32","CTDSPL2" -"UniProt:Q5H9E4","SLC25A53" -"UniProt:Q6UWY5","OLFML1" -"UniProt:Q6PJW8","CNST" -"UniProt:A6NNP5","CCDC169" -"UniProt:O14598","VCY1B" -"UniProt:O75821","EIF3G" -"UniProt:Q16763","UBE2S" -"UniProt:O43597","SPRY2" -"UniProt:O95498","VNN2" -"UniProt:P13639","EEF2" -"UniProt:A6ND36","FAM83G" -"UniProt:Q9NQ40","SLC52A3" -"UniProt:Q99496","RNF2" -"UniProt:Q16690","DUSP5" -"UniProt:Q3MJ13","WDR72" -"UniProt:Q13536","C1orf61" -"UniProt:Q96A73","P33MX" -"UniProt:P55010","EIF5" -"UniProt:O95219","SNX4" -"UniProt:P51812","RPS6KA3" -"UniProt:Q15554","TERF2" -"UniProt:Q9HB09","BCL2L12" -"UniProt:O75838","CIB2" -"UniProt:P0DP57","LYNX1" -"UniProt:P10243","MYBL1" -"UniProt:Q9UMR2","DDX19B" -"UniProt:Q5JXM2","METTL24" -"UniProt:Q9UGF6","OR5V1" -"UniProt:Q8N9B8","RASGEF1A" -"UniProt:Q5T1V6","DDX59" -"UniProt:P56180","TPTE" -"UniProt:Q9P0Z9","SOX" -"UniProt:Q86V15","CASZ1" -"UniProt:Q6P988","NOTUM" -"UniProt:Q15047","SETDB1" -"UniProt:P0DMV8","HS71A" -"UniProt:Q96M96","FGD4" -"UniProt:O43653","PSCA" -"UniProt:P56962","STX17" -"UniProt:P59646","FXYD4" -"UniProt:Q7L4P6","BEND5" -"UniProt:Q92782","DPF1" -"UniProt:P08582","MELTF" -"UniProt:O94808","GFPT2" -"UniProt:Q5SYC1","CLVS2" -"UniProt:Q96EA4","SPDL1" -"UniProt:Q9Y6A1","POMT1" -"UniProt:Q9BZJ8","GPR61" -"UniProt:Q8N3Z0","PRSS35" -"UniProt:P48664","SLC1A6" -"UniProt:P28328","PEX2" -"UniProt:Q96T83","SLC9A7" -"UniProt:P55157","MTTP" -"UniProt:Q71F55","Q71F55" -"UniProt:O95998","IL18BP" -"UniProt:P08246","ELANE" -"UniProt:Q9UEF7","KL" -"UniProt:O60315","ZEB2" -"UniProt:Q14416","GRM2" -"UniProt:Q9ULM2","ZNF490" -"UniProt:Q9ULM6","CNOT6" -"UniProt:Q5BIV9","SPRN" -"UniProt:Q8N9I0","SYT2" -"UniProt:P11021","GRP78" -"UniProt:Q92922","SMARCC1" -"UniProt:Q8WX92","NELFB" -"UniProt:P07148","FABP1" -"UniProt:Q9Y4H4","GPSM3" -"UniProt:Q6UWT4","CE046" -"UniProt:Q9I9K6","Q9I9K6" -"UniProt:Q4G0N4","NADK2" -"UniProt:Q8TCQ1","MARCH1" -"UniProt:Q99550","MPHOSPH9" -"UniProt:A0PK11","CLRN2" -"UniProt:Q7Z4S9","SH2D6" -"UniProt:Q99453","PHOX2B" -"UniProt:Q14980","NUMA1" -"UniProt:Q9UPZ9","ICK" -"UniProt:Q9Z0S9","PRAF1" -"UniProt:Q9NRX5","SERINC1" -"UniProt:Q9BSE5","AGMAT" -"UniProt:Q9NQW6","ANLN" -"UniProt:Q92805","GOLGA1" -"UniProt:Q8NDX9","LY6G5B" -"UniProt:Q6V9R5","ZNF562" -"UniProt:O60683","PEX10" -"UniProt:Q15486","GUSP1" -"UniProt:Q5BKT4","ALG10" -"UniProt:Q15532","SSXT" -"UniProt:O14772","FPGT" -"UniProt:Q9NZA1","CLIC5" -"UniProt:P43358","MAGA4" -"UniProt:Q5RL73","RBM48" -"UniProt:Q8NEL9","DDHD1" -"UniProt:P14314","PRKCSH" -"UniProt:Q8TEU8","WFIKKN2" -"UniProt:A6NER0","TBC1D3F" -"UniProt:P61966","AP1S1" -"UniProt:P62318","SNRPD3" -"UniProt:Q9P2S2","NRXN2" -"UniProt:P38432","COIL" -"UniProt:P28324","ELK4" -"UniProt:Q16181","SEPT7" -"UniProt:Q8IWX5","SGPP2" -"UniProt:P21549","AGXT" -"UniProt:P63261","ACTG1" -"UniProt:Q9GZT6","CCDC90B" -"UniProt:Q8N4H0","SPATA6L" -"UniProt:Q7Z6G8","ANKS1B" -"UniProt:Q8IX06","GOR" -"UniProt:P83436","COG7" -"UniProt:Q56VL3","OCIAD2" -"UniProt:Q7Z353","HDX" -"UniProt:Q05329","DCE2" -"UniProt:Q6ZTB9","ZN833" -"UniProt:Q96M34","C3orf30" -"UniProt:Q08462","ADCY2" -"UniProt:Q9Z0Y9","NR1H3" -"UniProt:Q12389","DBP10" -"UniProt:P57796","CABP4" -"UniProt:P05388","RLA0" -"UniProt:Q9GZT5","WNT10A" -"UniProt:Q99678","GPR20" -"UniProt:Q99798","ACO2" -"UniProt:O75197","LRP5" -"UniProt:Q9NWM8","FKBP14" -"UniProt:P45844","ABCG1" -"UniProt:Q13415","ORC1" -"UniProt:P13385","TDGF1" -"UniProt:Q9Y2V7","COG6" -"UniProt:Q8WXE1","ATRIP" -"UniProt:Q7Z3B3","KANSL1" -"UniProt:Q8NHW3","MAFA" -"UniProt:Q8K4J6","MKL1" -"UniProt:Q8N715","CC185" -"UniProt:Q13976","PRKG1" -"UniProt:P09001","MRPL3" -"UniProt:Q7Z7A4","PXK" -"UniProt:Q8N4W5","Q8N4W5" -"UniProt:Q9BSK4","FEM1A" -"UniProt:Q9H6U8","ALG9" -"UniProt:Q9UHY7","ENOPH1" -"UniProt:P29275","ADORA2B" -"UniProt:P01602","IGKV1-5" -"UniProt:Q92879","CELF1" -"UniProt:Q9BY50","SEC11C" -"UniProt:Q7Z5Y7","KCTD20" -"UniProt:Q8IXL6","FAM20C" -"UniProt:O60548","FOXD2" -"UniProt:Q6GYQ0","RALGAPA1" -"UniProt:Q9H4E7","DEFI6" -"UniProt:Q96KK5","HIST1H2AH" -"UniProt:P09651","HNRNPA1" -"UniProt:O94788","ALDH1A2" -"UniProt:O00622","CYR61" -"UniProt:Q13535","ATR" -"UniProt:Q156A1", -"UniProt:P78316","NOP14" -"UniProt:Q8N3G9","TMEM130" -"UniProt:P53367","ARFP1" -"UniProt:O75995","SASH3" -"UniProt:P22223","CDH3" -"UniProt:P06241","FYN" -"UniProt:Q9Y3A5","SBDS" -"UniProt:Q5VXJ0","LIPK" -"UniProt:O60259","KLK8" -"UniProt:O14972","DSCR3" -"UniProt:Q68CP4","HGSNAT" -"UniProt:Q9NV23","OLAH" -"UniProt:P35680","HNF1B" -"UniProt:Q96L42","KCNH8" -"UniProt:Q6P6N5","SPRE3" -"UniProt:Q62848","ARFG1" -"UniProt:Q8IZ13","ZBED8" -"UniProt:P68431","HIST1H3A;HIST1H3H;HIST1H3I;HIST1H3J;HIST1H3B;HIST1H3D;HIST1H3E;HIST1H3C;HIST1H3F;HIST1H3G" -"UniProt:O43251","RBFOX2" -"UniProt:Q9HA65","TBC17" -"UniProt:A0A0C4DG60","A0A0C4DG60" -"UniProt:O95749","GGPS1" -"UniProt:A4PIW0","A4PIW0" -"UniProt:B2RXH8","HNRC2" -"UniProt:P25391","LAMA1" -"UniProt:Q9BTM9","URM1" -"UniProt:P34059","GALNS" -"UniProt:Q9NZV5","SELENON" -"UniProt:O95466","FMNL1" -"UniProt:O43677","NDUFC1" -"UniProt:A8MTA8","FAM166B" -"UniProt:Q9HC52","CBX8" -"UniProt:Q9BYR3","KRA44" -"UniProt:P9WIE3","Rv2238c" -"UniProt:A0A0A0MR36","A0A0A0MR36" -"UniProt:Q99814","EPAS1" -"UniProt:Q8IXN7","RIMKLA" -"UniProt:P9WPQ9","bfr" -"UniProt:O60494","CUBN" -"UniProt:P49257","LMAN1" -"UniProt:Q96SF7","TBX15" -"UniProt:Q9BX46","RBM24" -"UniProt:Q15700","DLG2" -"UniProt:Q17RB0","F127C" -"UniProt:Q4G0P3","HYDIN" -"UniProt:P78556","CCL20" -"UniProt:P9WG35","tpx" -"UniProt:Q04879","opaF" -"UniProt:A0A0G2JPH6","A0A0G2JPH6" -"UniProt:P50583","NUDT2" -"UniProt:P78527","PRKDC" -"UniProt:Q8WUH2","TGFA1" -"UniProt:Q86TH1","ADAMTSL2" -"UniProt:Q6NSX1","CCD70" -"UniProt:Q9HAU5","UPF2" -"UniProt:Q6DN12","MCTP2" -"UniProt:P9WQJ7","irtB" -"UniProt:Q5VWJ9","SNX30" -"UniProt:Q86Y28","BAGE4" -"UniProt:Q05469","LIPE" -"UniProt:P48506","GCLC" -"UniProt:Q96D71","REPS1" -"UniProt:P32601","DSS4" -"UniProt:Q13232","NDK3" -"UniProt:O00230","CORT" -"UniProt:P9WN25","glbN" -"UniProt:O75899","GABBR2" -"UniProt:Q96MX3","ZNF48" -"UniProt:Q96E14","RMI2" -"UniProt:O43157","PLXNB1" -"UniProt:P9WQB7","ahpC" -"UniProt:Q9H9V4","RNF122" -"UniProt:P9WIE5","katG" -"UniProt:P80098","CCL7" -"UniProt:P9WGE7","sodB" -"UniProt:P41271","NBL1" -"UniProt:P38891","BCA1" -"UniProt:Q16626","MEA1" -"UniProt:Q16378","PROL4" -"UniProt:P9WIS7","dlaT" -"UniProt:P07902","GALT" -"UniProt:P9WJM5","msrA" -"UniProt:Q4G0X4","KCD21" -"UniProt:Q96IG2","FBXL20" -"UniProt:P00742","F10" -"UniProt:P20248","CCNA2" -"UniProt:P9WQJ9","irtA" -"UniProt:Q9H239","MMP28" -"UniProt:A5PLN7","FAM149A" -"UniProt:Q5NV79","IGLV4-60" -"UniProt:Q68DU8","KCTD16" -"UniProt:Q5VX71","SUSD4" -"UniProt:Q8IXS8","F126B" -"UniProt:A0A0C4DGW9","A0A0C4DGW9" -"UniProt:P04440","HLA-DPB1" -"UniProt:P9WGN5","secG" -"UniProt:Q12904","AIMP1" -"UniProt:P9WG67","trxA" -"UniProt:P41222","PTGDS" -"UniProt:Q96CK0","ZNF653" -"UniProt:P9WQB5","ahpD" -"UniProt:D3DX41","D3DX41" -"UniProt:Q13200","PSMD2" -"UniProt:O95711","LY86" -"UniProt:Q96AY2","EME1" -"UniProt:Q9R1P4","Psma1" -"UniProt:P26885","FKBP2" -"UniProt:P9WGU5","Rv1280c" -"UniProt:P9WGN3","secY" -"UniProt:P04554","PRM2" -"UniProt:P51888","PRELP" -"UniProt:Q9UPU5","USP24" -"UniProt:Q8TE73","DNAH5" -"UniProt:Q96IT6","ARAS1" -"UniProt:P56705","WNT4" -"UniProt:Q96C86","DCPS" -"UniProt:Q9ULL4","PLXNB3" -"UniProt:Q8IYL3","CA174" -"UniProt:Q8WWL7","CCNB3" -"UniProt:Q9UBX1","CTSF" -"UniProt:Q9BVA6","FICD" -"UniProt:O94829","IPO13" -"UniProt:P32577","CSK" -"UniProt:Q9Y343","SNX24" -"UniProt:Q96BY2","MOAP1" -"UniProt:P16444","DPEP1" -"UniProt:P9WGN9","secF" -"UniProt:P40491","FMC1" -"UniProt:Q969W0","SPTSA" -"UniProt:P28331","NDUFS1" -"UniProt:Q92826","HOXB13" -"UniProt:O75643","SNRNP200" -"UniProt:P21695","GPD1" -"UniProt:P9WFZ7","Rv1283c" -"UniProt:Q6UWZ7","ABRAXAS1" -"UniProt:Q8NHU3","SGMS2" -"UniProt:P9WHH1","trxB" -"UniProt:Q96RK4","BBS4" -"UniProt:Q15853","USF2" -"UniProt:Q8IUB3","WF10B" -"UniProt:Q6P2M8","PNCK" -"UniProt:P9WGP1","secD" -"UniProt:Q9H6A0","DENND2D" -"UniProt:Q9Y3B3","TMED7" -"UniProt:P9WNE5","bfrB" -"UniProt:Q8N5U0","C11orf42" -"UniProt:P29692","EEF1D" -"UniProt:P01298","PPY" -"UniProt:Q5EE01","CENPW" -"UniProt:Q9H9A7","RMI1" -"UniProt:O53533","adhE2" -"UniProt:Q8WXK3","ASB13" -"UniProt:P71971","MT2748" -"UniProt:P98161","PKD1" -"UniProt:P51957","NEK4" -"UniProt:Q96PP8","GBP5" -"UniProt:P34903","GABRA3" -"UniProt:Q4KWH8","PLCH1" -"UniProt:Q8IUH3","RBM45" -"UniProt:P9WGP3","secA2" -"UniProt:Q8TAD7","C12orf75" -"UniProt:Q96NZ8","WFKN1" -"UniProt:Q3V5L5","MGT5B" -"UniProt:Q6P3V2","ZNF585A" -"UniProt:Q9BVK6","TMED9" -"UniProt:P0C0S8","HIST1H2AG" -"UniProt:P9WL31","Rv2895c" -"UniProt:Q61006","MUSK" -"UniProt:Q8N0U7","C1orf87" -"UniProt:Q9ULH4","LRFN2" -"UniProt:P27352","GIF" -"UniProt:Q6E0U4","DMKN" -"UniProt:P22455","FGFR4" -"UniProt:P9WNE1","fgd1" -"UniProt:P30275","KCRU" -"UniProt:Q8N3I7","BBS5" -"UniProt:P20711","DDC" -"UniProt:P51432","PLCB3" -"UniProt:Q00597","FANCC" -"UniProt:Q8IYK4","GT252" -"UniProt:P48449","LSS" -"UniProt:P9WGN7","secE" -"UniProt:P42356","PI4KA" -"UniProt:Q9H305","CDIP1" -"UniProt:Q6ISB3","GRHL2" -"UniProt:Q5JSZ5","PRC2B" -"UniProt:O75629","CREG1" -"UniProt:Q99J34","Q99J34" -"UniProt:O76090","BEST1" -"UniProt:P13224","GP1BB" -"UniProt:P21108","PRPS1L1" -"UniProt:A8MT65","ZNF891" -"UniProt:A6NCE7","MAP1LC3B2" -"UniProt:P9WFZ9","Rv1282c" -"UniProt:P17024","ZNF20" -"UniProt:Q9BZB8","CPEB1" -"UniProt:Q8IV20","LACC1" -"UniProt:P31371","FGF9" -"UniProt:P25100","ADRA1D" -"UniProt:F8WCM5","INSR2" -"UniProt:P07204","THBD" -"UniProt:O43865","SAHH2" -"UniProt:P08709","F7" -"UniProt:Q8NBS3","SLC4A11" -"UniProt:Q8WV37","ZNF480" -"UniProt:P9WGE9","sodC" -"UniProt:Q02880","TOP2B" -"UniProt:P28566","5HT1E" -"UniProt:P9WQJ5","Rv1281c" -"UniProt:P9WGP5","secA1" -"UniProt:Q96KN1","FA84B" -"UniProt:P16157","ANK1" -"UniProt:Q9H6X2","ANTXR1" -"UniProt:Q07011","TNFRSF9" -"UniProt:Q5XUX0","FBXO31" -"UniProt:P02814","SMR3B" -"UniProt:Q9NY61","AATF" -"UniProt:Q9Y5Z9","UBIAD1" -"UniProt:O43869","OR2T1" -"UniProt:Q99614","TTC1" -"UniProt:P71828","ggtA" -"UniProt:Q96FE7","P3IP1" -"UniProt:Q5H8C1","FREM1" -"UniProt:P25874","UCP1" -"UniProt:Q9UKX3","MYH13" -"UniProt:Q8IYK8","REM2" -"UniProt:Q86Y34","ADGRG3" -"UniProt:P51153","RAB13" -"UniProt:Q9H3M9","ATXN3L" -"UniProt:Q53FD0","ZC2HC1C" -"UniProt:Q16842","ST3GAL2" -"UniProt:Q15365","PCBP1" -"UniProt:Q9UK55","SERPINA10" -"UniProt:Q12864","CAD17" -"UniProt:Q8IUU6","Q8IUU6" -"UniProt:Q5TCZ1","SH3PXD2A" -"UniProt:P04432","IGKV1D-39" -"UniProt:Q9Y4K4","MAP4K5" -"UniProt:Q7L5Y9","MAEA" -"UniProt:Q14573","ITPR3" -"UniProt:Q9BSB4","ATGA1" -"UniProt:Q76I76","SSH2" -"UniProt:Q9UF72","T73AS" -"UniProt:P30511","HLA-F" -"UniProt:Q96H12","MSANTD3" -"UniProt:Q9P218","COL20A1" -"UniProt:Q93077","HIST1H2AC" -"UniProt:P62157","CALM" -"UniProt:Q15386","UBE3C" -"UniProt:Q4AC99","ACCSL" -"UniProt:P30498","HLA-B" -"UniProt:Q67FW5","B3GNTL1" -"UniProt:Q2UY09","COL28A1" -"UniProt:Q3KP31","ZNF791" -"UniProt:Q9BVV8","C19orf24" -"UniProt:P40481","HPM1" -"UniProt:P20827","EFNA1" -"UniProt:Q99961","SH3GL1" -"UniProt:P39009","DUN1" -"UniProt:Q6R6M4","USP17L2" -"UniProt:Q92630","DYRK2" -"UniProt:O75022","LILRB3" -"UniProt:P48039","MTNR1A" -"UniProt:O15535","ZSC9" -"UniProt:Q8NA70","FA47B" -"UniProt:Q96F85","CNRP1" -"UniProt:P61952","GNG11" -"UniProt:Q9H0Z9","RBM38" -"UniProt:Q9Y661","HS3ST4" -"UniProt:Q96A83","COL26A1" -"UniProt:Q6ZMJ2","SCARA5" -"UniProt:Q16609","LPAL2" -"UniProt:P61009","SPCS3" -"UniProt:Q96P44","COL21A1" -"UniProt:Q9H0B8","CRISPLD2" -"UniProt:Q8NFD2","ANKK1" -"UniProt:P56202","CTSW" -"UniProt:Q8IWF7","U2D2L" -"UniProt:Q9UIF3","TEKT2" -"UniProt:Q86X02","CDR2L" -"UniProt:Q8NFZ0","FBXO18" -"UniProt:Q8IUG1","KRTAP1-3" -"UniProt:Q86UV7","TRIM73" -"UniProt:P09565","IG2R" -"UniProt:P11103","PARP1" -"UniProt:O43715","TRIAP1" -"UniProt:Q9P2G9","KLHL8" -"UniProt:Q9BSG0","PADC1" -"UniProt:Q9BRN9","TM2D3" -"UniProt:Q9UKG9","CROT" -"UniProt:A6NNA5","DRGX" -"UniProt:P58005","SESN3" -"UniProt:Q9NQ69","LHX9" -"UniProt:Q8IVT4","Q8IVT4" -"UniProt:P01703","IGLV1-40" -"UniProt:Q5G014","Q5G014" -"UniProt:Q6V1P9","DCHS2" -"UniProt:Q8IUR0","TRAPPC5" -"UniProt:Q6ZP29","PQLC2" -"UniProt:P54289","CACNA2D1" -"UniProt:Q13889","GTF2H3" -"UniProt:Q14517","FAT1" -"UniProt:Q7L4I2","RSRC2" -"UniProt:O75132","ZBED4" -"UniProt:Q96H86","ZNF764" -"UniProt:P38339","RGD1" -"UniProt:Q7Z5M5","TMC3" -"UniProt:Q7Z4V0","ZN438" -"UniProt:Q15828","CST6" -"UniProt:Q96QE4","LRRC37B" -"UniProt:Q14993","COL19A1" -"UniProt:P10238","ICP27" -"UniProt:Q9NRK6","ABCBA" -"UniProt:Q9H4D5","NXF3" -"UniProt:A6NK75","ZNF98" -"UniProt:Q8WZ73","RFFL" -"UniProt:Q02742","GCNT1" -"UniProt:Q9P278","FNIP2" -"UniProt:Q7L945","ZNF627" -"UniProt:Q8CIH5","Plcg2" -"UniProt:Q8N4W9","ZNF808" -"UniProt:O95342","ABCB11" -"UniProt:Q8N431","RASGEF1C" -"UniProt:Q96T53","MBOAT4" -"UniProt:Q504Y0","SLC39A12" -"UniProt:Q96EZ4","MYEOV" -"UniProt:P10075","GLI4" -"UniProt:Q9NRW1","RAB6B" -"UniProt:Q9UL33","TPC2L" -"UniProt:Q9H7S9","ZN703" -"UniProt:Q8IYA6","CKAP2L" -"UniProt:P09603","CSF1" -"UniProt:Q92796","DLG3" -"UniProt:Q2TAY7","SMU1" -"UniProt:O43820","HYAL3" -"UniProt:Q99712","KCNJ15" -"UniProt:Q9BYX4","IFIH1" -"UniProt:Q93015","NAT6" -"UniProt:P42836","PFA3" -"UniProt:Q06732","ZNF33B" -"UniProt:Q6U841","SLC4A10" -"UniProt:Q05DH4","FAM160A1" -"UniProt:Q8TAI7","REBL1" -"UniProt:P62888","RPL30" -"UniProt:P37108","SRP14" -"UniProt:Q9ERC8","Dscam" -"UniProt:Q96JN0","LCOR" -"UniProt:Q6NZ63","STEAP1B" -"UniProt:Q96GB0","Q96GB0" -"UniProt:P11511","CYP19A1" -"UniProt:P51511","MMP15" -"UniProt:O43156","TTI1" -"UniProt:O14576","DYNC1I1" -"UniProt:Q8NHU0","CT453" -"UniProt:Q14246","ADGRE1" -"UniProt:Q8NBE8","KLHL23" -"UniProt:Q9NZU5","LMCD1" -"UniProt:Q9Y4F3","MARF1" -"UniProt:P14207","FOLR2" -"UniProt:Q9H4A4","RNPEP" -"UniProt:Q9H7N4","SCAF1" -"UniProt:Q8WVN6","SECTM1" -"UniProt:P05141","ADT2" -"UniProt:Q15393","SF3B3" -"UniProt:Q6ZMJ4","IL34" -"UniProt:Q5TZK3","FAM74" -"UniProt:Q1RLL8","Q1RLL8" -"UniProt:O00408","PDE2A" -"UniProt:P31270","HOXA11" -"UniProt:Q13015","MLLT11" -"UniProt:Q15276","RABEP1" -"UniProt:P35237","SERPINB6" -"UniProt:Q6ZMZ3","SYNE3" -"UniProt:Q15119","PDK2" -"UniProt:O15130","NPFF" -"UniProt:Q9NWW0","HCFC1R1" -"UniProt:P10619","CTSA" -"UniProt:Q0VAQ4","SMAGP" -"UniProt:Q96DZ5","CLIP3" -"UniProt:Q96KB5","TOPK" -"UniProt:Q8C4V4","Fbxl3" -"UniProt:Q6NZY7","CDC42EP5" -"UniProt:Q6QNY1","BL1S2" -"UniProt:Q6MZZ7","CAPN13" -"UniProt:P62303","RUXE" -"UniProt:O75394","MRPL33" -"UniProt:Q86TI2","DPP9" -"UniProt:O60476","MAN1A2" -"UniProt:O95561","CA105" -"UniProt:Q7Z4Q2","HEATR3" -"UniProt:Q14566","MCM6" -"UniProt:Q9HCM3","KIAA1549" -"UniProt:Q5RIA9","CBWD5" -"UniProt:P09848","LCT" -"UniProt:P35453","HOXD13" -"UniProt:P18640","Botulinum" -"UniProt:Q9UKK9","NUDT5" -"UniProt:P07101","TH" -"UniProt:O60266","ADCY3" -"UniProt:Q9Y277","VDAC3" -"UniProt:Q13519","PNOC" -"UniProt:Q8WXG9","ADGRV1" -"UniProt:P27144","AK4" -"UniProt:P62316","SMD2" -"UniProt:A8KAH6","A8KAH6" -"UniProt:P14410","SI" -"UniProt:P55198","AF17" -"UniProt:B2RC85","RSPH10B2" -"UniProt:P47086","YJY1" -"UniProt:Q6PIV7","SLC25A34" -"UniProt:Q9H5P4","PDZD7" -"UniProt:P38991","IPL1" -"UniProt:P49321","NASP" -"UniProt:Q9Y6C5","PTCH2" -"UniProt:P57738","TCTA" -"UniProt:P12709","G6PI" -"UniProt:Q9BV81","EMC6" -"UniProt:Q9UIC8","LCMT1" -"UniProt:Q7Z6C6","Q7Z6C6" -"UniProt:P41218","MNDA" -"UniProt:Q92619","HMHA1" -"UniProt:P51955","NEK2" -"UniProt:O60902","SHOX2" -"UniProt:Q86YS3","RAB11FIP4" -"UniProt:Q96DH6","MSI2" -"UniProt:Q9BQW3","EBF4" -"UniProt:Q2M218","ZNF630" -"UniProt:Q9BXI2","SLC25A2" -"UniProt:Q9H1R2","DUSP15" -"UniProt:Q13285","NR5A1" -"UniProt:Q6IB11","Q6IB11" -"UniProt:Q9D0N8","TMM88" -"UniProt:Q9BRP0","OVOL2" -"UniProt:Q99661","KIF2C" -"UniProt:Q8N6K7","SAMD3" -"UniProt:P43243","MATR3" -"UniProt:X6R3R3","X6R3R3" -"UniProt:O70405","ULK1" -"UniProt:O76081","RGS20" -"UniProt:P36313","ICP34" -"UniProt:Q6ZMK1","CYHR1" -"UniProt:Q92599","SEPT8" -"UniProt:Q8WTS6","SETD7" -"UniProt:O75817","POP7" -"UniProt:Q9NP64","NO40" -"UniProt:O95835","LATS1" -"UniProt:Q96JJ7","TMX3" -"UniProt:P56880","CLDN20" -"UniProt:P49916","DNLI3" -"UniProt:Q5T3I0","GPATCH4" -"UniProt:O35244","PRDX6" -"UniProt:P43155","CRAT" -"UniProt:P16014","SCG1" -"UniProt:P13994","CCDC130" -"UniProt:Q9GZZ0","HOXD1" -"UniProt:P20701","ITGAL" -"UniProt:Q99871","HAUS7" -"UniProt:Q8WWL2","SPIRE2" -"UniProt:Q969G6","RFK" -"UniProt:Q12460","NOP56" -"UniProt:Q9H195","MUC3B" -"UniProt:Q13905","RAPGEF1" -"UniProt:P31150","GDI1" -"UniProt:Q14432","PDE3A" -"UniProt:Q9UNP9","PPIE" -"UniProt:Q9H7C9","AAMDC" -"UniProt:Q5T8P6","RBM26" -"UniProt:O41932","O41932" -"UniProt:O14639","ABLM1" -"UniProt:A5PKX9","A5PKX9" -"UniProt:Q9H0R5","GBP3" -"UniProt:Q16515","ASIC2" -"UniProt:Q9Y603","ETV7" -"UniProt:Q8IUD2","RB6I2" -"UniProt:Q14696","MESD" -"UniProt:P09172","DBH" -"UniProt:Q86UV5","USP48" -"UniProt:Q96J92","WNK4" -"UniProt:Q96GW1","Q96GW1" -"UniProt:Q9Y3D8","KAD6" -"UniProt:O75446","SAP30" -"UniProt:Q7L7L0","HIST3H2A" -"UniProt:Q00005","PPP2R2B" -"UniProt:O43379","WDR62" -"UniProt:P48065","S6A12" -"UniProt:Q8N413","SLC25A45" -"UniProt:Q8NGL2","OR5L1" -"UniProt:Q8IYH5","ZZZ3" -"UniProt:Q6UWN5","LYPD5" -"UniProt:Q969F1","GTF3C6" -"UniProt:Q8TDH9","BL1S5" -"UniProt:Q2M389","WASHC4" -"UniProt:Q96KV7","WDR90" -"UniProt:Q7Z591","AKNA" -"UniProt:P17676","CEBPB" -"UniProt:P18828","Sdc1" -"UniProt:O43566","RGS14" -"UniProt:O43474","KLF4" -"UniProt:Q3SYG4","BBS9" -"UniProt:Q9UH77","KLHL3" -"UniProt:O15370","SOX12" -"UniProt:Q6P1M0","SLC27A4" -"UniProt:Q9BXC0","HCAR1" -"UniProt:Q9Y3C6","PPIL1" -"UniProt:Q9HAZ2","PRDM16" -"UniProt:Q86YZ3","HRNR" -"UniProt:Q8IWT1","SCN4B" -"UniProt:P37198","NUP62" -"UniProt:Q96HP4","OXNAD1" -"UniProt:O94964","SOGA1" -"UniProt:Q9BXW9","FANCD2" -"UniProt:Q3ZCT1","ZN260" -"UniProt:Q8N309","LRRC43" -"UniProt:Q9HD67","MYO10" -"UniProt:Q9HAF1","MEAF6" -"UniProt:P09493","TPM1" -"UniProt:A8MTZ0","BBIP1" -"UniProt:Q8N112","LSME2" -"UniProt:O43516","WIPF1" -"UniProt:Q14872","MTF1" -"UniProt:B3EWG6","FAM25C" -"UniProt:P80188","NGAL" -"UniProt:P03372","ESR1" -"UniProt:Q8IUW5","RELL1" -"UniProt:Q3KP44","ANKRD55" -"UniProt:Q96JB5","CK5P3" -"UniProt:P48651","PTDSS1" -"UniProt:Q13796","SHROOM2" -"UniProt:Q9H4A3","WNK1" -"UniProt:Q92769","HDAC2" -"UniProt:Q8N8R7","AL14E" -"UniProt:P52954","LBX1" -"UniProt:Q8NHG7","SVIP" -"UniProt:O43639","NCK2" -"UniProt:Q9NPA0","EMC7" -"UniProt:Q96FS4","SIPA1" -"UniProt:O60675","MAFK" -"UniProt:Q9H2T7","RANBP17" -"UniProt:Q6PIZ9","TRAT1" -"UniProt:Q9UJY4","GGA2" -"UniProt:P30411","BDKRB2" -"UniProt:P52747","ZNF143" -"UniProt:Q8NB46","ANKRD52" -"UniProt:Q15327","ANKRD1" -"UniProt:Q9BYJ0","FGFBP2" -"UniProt:P45381","ASPA" -"UniProt:Q96BD6","SPSB1" -"UniProt:P10301","RRAS" -"UniProt:P53286","BTN2" -"UniProt:Q9ULC0","EMCN" -"UniProt:Q68CZ2","TNS3" -"UniProt:P08708","RPS17" -"UniProt:Q68CQ4","DIEXF" -"UniProt:Q3LI66","KRTAP6-2" -"UniProt:Q93100","PHKB" -"UniProt:P29992","GNA11" -"UniProt:Q8NG31","KNL1" -"UniProt:Q86YN1","DOLPP1" -"UniProt:Q86UC2","RSPH3" -"UniProt:Q8NDI1","EHBP1" -"UniProt:P14618","PKM" -"UniProt:Q8IWB1","IPRI" -"UniProt:Q99996","AKAP9" -"UniProt:Q8N5M4","TTC9C" -"UniProt:Q8NGL3","OR5D14" -"UniProt:Q8IZU9","KIRREL3" -"UniProt:Q9H0B3","K1683" -"UniProt:P54756","EPHA5" -"UniProt:Q8N815","CNTD1" -"UniProt:P11168","SLC2A2" -"UniProt:P22466","GAL" -"UniProt:Q9UK08","GNG8" -"UniProt:Q15022","SUZ12" -"UniProt:Q9Y312","AAR2" -"UniProt:P31327","CPS1" -"UniProt:Q9ULX9","MAFF" -"UniProt:A0PJE2","DHRS12" -"UniProt:Q8IUG5","MYO18B" -"UniProt:P00439","PAH" -"UniProt:Q5T013","HYI" -"UniProt:Q9NUL5","RYDEN" -"UniProt:Q15406","NR6A1" -"UniProt:Q8N2I9","STK40" -"UniProt:Q13283","G3BP1" -"UniProt:Q2TAK8","MUM1" -"UniProt:Q08289","CACNB2" -"UniProt:G5E9B5","G5E9B5" -"UniProt:Q14520","HABP2" -"UniProt:Q13263","TRIM28" -"UniProt:Q6RUI8","C19orf48" -"UniProt:Q9NT68","TENM2" -"UniProt:Q9UH90","FBXO40" -"UniProt:P50750","CDK9" -"UniProt:P51157","RAB28" -"UniProt:Q9NQ48","LZTFL1" -"UniProt:Q9Y5P6","GMPPB" -"UniProt:Q9BUL5","PHF23" -"UniProt:Q92620","DHX38" -"UniProt:P57771","RGS8" -"UniProt:P46199","MTIF2" -"UniProt:Q8IUK5","PLXDC1" -"UniProt:Q92963","RIT1" -"UniProt:Q96L58","B3GALT6" -"UniProt:Q6UWV2","MPZL3" -"UniProt:A2RUR9","CCDC144A" -"UniProt:P35580","MYH10" -"UniProt:Q86VP1","TAX1BP1" -"UniProt:Q6PIF6","MYO7B" -"UniProt:O94827","PLEKHG5" -"UniProt:Q8TCW6","Q8TCW6" -"UniProt:Q9Y4W6","AFG3L2" -"UniProt:Q9Y519","T184B" -"UniProt:Q8TCI5","PIFO" -"UniProt:Q9HCM2","PLXNA4" -"UniProt:Q7L592","NDUFAF7" -"UniProt:P46094","XCR1" -"UniProt:Q7L5D6","GET4" -"UniProt:Q32P41","TRMT5" -"UniProt:Q2PYT4","Q2PYT4" -"UniProt:Q13822","ENPP2" -"UniProt:Q9BYJ4","TRIM34" -"UniProt:Q96MF6","COQ10A" -"UniProt:Q07699","SCN1B" -"UniProt:O15021","MAST4" -"UniProt:Q7Z392","TRAPPC11" -"UniProt:O43427","FIBP" -"UniProt:P51553","IDH3G" -"UniProt:Q8IVG5","SAMD9L" -"UniProt:Q16822","PCK2" -"UniProt:Q15291","RBBP5" -"UniProt:Q5EBH1","RASF5" -"UniProt:Q6ZW61","BBS12" -"UniProt:A2RRL9","A2RRL9" -"UniProt:O43900","PRICKLE3" -"UniProt:P49450","CENPA" -"UniProt:Q8IW92","GLB1L2" -"UniProt:Q03718","NSE5" -"UniProt:Q9BQE4","SELS" -"UniProt:A0A024R4Z4","A0A024R4Z4" -"UniProt:Q9UQF0","ERVW-1" -"UniProt:P40123","CAP2" -"UniProt:Q8N967","LRTM2" -"UniProt:Q9UJY1","HSPB8" -"UniProt:Q13426","XRCC4" -"UniProt:Q16832","DDR2" -"UniProt:Q96MM6","HSPA12B" -"UniProt:P51659","HSD17B4" -"UniProt:Q9BXA6","TSSK6" -"UniProt:Q9BTA0","FAM167B" -"UniProt:Q6IS01","Q6IS01" -"UniProt:P15498","VAV1" -"UniProt:Q8NGR8","OR1L8" -"UniProt:Q5TAB7","RIPPLY2" -"UniProt:Q9Z1S0","BUB1B" -"UniProt:Q86UD0","SAPC2" -"UniProt:P30405","PPIF" -"UniProt:Q8TAM1","BBS10" -"UniProt:P30953","OR1E1" -"UniProt:Q9P1P5","TAAR2" -"UniProt:Q8NHY2","RFWD2" -"UniProt:O94973","AP2A2" -"UniProt:P15848","ARSB" -"UniProt:P31025","LCN1" -"UniProt:Q6IQ26","DENND5A" -"UniProt:Q8NGH7","O52L1" -"UniProt:Q9H1Z4","WDR13" -"UniProt:Q9NPI8","FANCF" -"UniProt:Q3ZCT8","KBTBD12" -"UniProt:P43569","CAF16" -"UniProt:P61968","LMO4" -"UniProt:O75908","SOAT2" -"UniProt:Q96ES5","Q96ES5" -"UniProt:Q9UBF9","MYOT" -"UniProt:P0C7N1","OR8U8" -"UniProt:Q96R08","OR5B12" -"UniProt:Q99XU0","Q99XU0" -"UniProt:Q9HCM4","EPB41L5" -"UniProt:P30447","HLA-A" -"UniProt:O43482","MS18B" -"UniProt:P29459","IL12A" -"UniProt:P09543","CNP" -"UniProt:Q0VG99","MESP2" -"UniProt:Q8NGN4","OR10G9" -"UniProt:P31939","ATIC" -"UniProt:Q7RTU0","TCF24" -"UniProt:P05231","IL6" -"UniProt:Q8TCE6","FAM45A" -"UniProt:Q8NGS4","OR13F1" -"UniProt:Q9CQI9","MED30" -"UniProt:Q9Y4P3","TBL2" -"UniProt:P32529","RPA12" -"UniProt:Q96JM3","CHAMP1" -"UniProt:Q92979","EMG1" -"UniProt:P54791","ORC4" -"UniProt:Q9UG63","ABCF2" -"UniProt:Q38SD2","LRRK1" -"UniProt:Q8NGZ9","OR2T10" -"UniProt:Q8N9M5","TM102" -"UniProt:P30285","Cdk4" -"UniProt:Q96R54","OR14A2" -"UniProt:Q8WXG8","S100Z" -"UniProt:Q8N335","GPD1L" -"UniProt:Q6PF18","MORN3" -"UniProt:A6ND91","ASPDH" -"UniProt:Q8N148","OR6V1" -"UniProt:Q8TAD8","SNIP1" -"UniProt:Q15842","KCNJ8" -"UniProt:O75140","DEPDC5" -"UniProt:Q9NZZ3","CHMP5" -"UniProt:Q6IQ23","PKHA7" -"UniProt:Q91YE8","SYNP2" -"UniProt:Q8N8Q3","ENDOV" -"UniProt:P57081","WDR4" -"UniProt:O14581","OR7A17" -"UniProt:Q13275","SEMA3F" -"UniProt:O75044","SRGP2" -"UniProt:P51649","ALDH5A1" -"UniProt:Q9NYY8","FASTKD2" -"UniProt:P07492","GRP" -"UniProt:Q8NGY2","OR6K2" -"UniProt:P19838","NFKB1" -"UniProt:O95416","SOX14" -"UniProt:Q8TBF4","ZCRB1" -"UniProt:Q9HAS3","SLC28A3" -"UniProt:Q9H633","RPP21" -"UniProt:P22352","GPX3" -"UniProt:Q9BZ29","DOCK9" -"UniProt:Q9H5V8","CDCP1" -"UniProt:Q8N983","RM43" -"UniProt:Q99581","FEV" -"UniProt:O15055","PER2" -"UniProt:P15289","ARSA" -"UniProt:A0A140T8Z8","A0A140T8Z8" -"UniProt:Q9H2C8","OR51V1" -"UniProt:Q6ZMD2","SPNS3" -"UniProt:Q8NB90","SPATA5" -"UniProt:Q6NVU6","UFSP1" -"UniProt:Q8NG80","OR2L5" -"UniProt:Q8IWA6","CCDC60" -"UniProt:O75943","RAD17" -"UniProt:P11441","UBL4A" -"UniProt:Q8NH72","OR4C6" -"UniProt:Q8NGJ8","OR51S1" -"UniProt:Q96PE7","MCEE" -"UniProt:P39875","EXO1" -"UniProt:P42694","HELZ" -"UniProt:P25021","HRH2" -"UniProt:Q16651","PRSS8" -"UniProt:Q14241","ELOA1" -"UniProt:Q14019","COTL1" -"UniProt:Q8NGS3","OR1J1" -"UniProt:Q96BT3","CENPT" -"UniProt:Q9H4X1","RGCC" -"UniProt:Q8NGK6","OR52I1" -"UniProt:Q9H741","C12orf49" -"UniProt:Q13442","PDAP1" -"UniProt:O43749","OR1F1" -"UniProt:P18509","ADCYAP1" -"UniProt:P06465","VE7" -"UniProt:Q9Y4D2","DAGLA" -"UniProt:Q9Y2B0","CNPY2" -"UniProt:Q9UGV2","NDRG3" -"UniProt:P30304","MPIP1" -"UniProt:Q8NGR6","OR1B1" -"UniProt:P49674","KC1E" -"UniProt:Q8NH76","OR56B4" -"UniProt:Q9BR46","C20orf78" -"UniProt:Q9NP58","ABCB6" -"UniProt:Q07890","SOS2" -"UniProt:Q6PJG6","BRAT1" -"UniProt:J3QSH9","J3QSH9" -"UniProt:P01229","LHB" -"UniProt:Q8NGR1","OR13A1" -"UniProt:Q6ZV77","CI139" -"UniProt:P04020","VE7" -"UniProt:Q6P2R3","Q6P2R3" -"UniProt:Q12816","TROP" -"UniProt:Q8TDZ2","MICAL1" -"UniProt:O43747","AP1G1" -"UniProt:A0PJX8","TMEM82" -"UniProt:Q96RD3","OR52E6" -"UniProt:Q9HCE3","ZNF532" -"UniProt:Q9H343","OR51I1" -"UniProt:Q62417","SORBS1" -"UniProt:P03255","E1A" -"UniProt:Q8N7B6","PACRGL" -"UniProt:O43716","GATC" -"UniProt:Q6UB28","METAP1D" -"UniProt:Q96PV6","LENG8" -"UniProt:P0CV98","TSPY3" -"UniProt:Q8NG99","OR7G2" -"UniProt:Q6PIL6","KCIP4" -"UniProt:Q96T66","NMNAT3" -"UniProt:P10415","BCL2" -"UniProt:Q9UEE5","STK17A" -"UniProt:Q96PV0","SYNGAP1" -"UniProt:Q8NGD2","OR4K2" -"UniProt:Q7Z4H4","ADM2" -"UniProt:O15260","SURF4" -"UniProt:P03254","E1A" -"UniProt:P78560","CRADD" -"UniProt:Q8IYF1","ELOA2" -"UniProt:Q8VSP9","OSPF" -"UniProt:P22670","RFX1" -"UniProt:P12107","COL11A1" -"UniProt:Q8ND76","CCNY" -"UniProt:Q07654","TFF3" -"UniProt:Q8NBK3","SUMF1" -"UniProt:A6NM76","OR6C76" -"UniProt:Q8N573","OXR1" -"UniProt:P31750","AKT1" -"UniProt:Q96RE9","ZNF300" -"UniProt:P22354","RM20" -"UniProt:Q15762","CD226" -"UniProt:Q9Y4K3","TRAF6" -"UniProt:P14866","HNRNPL" -"UniProt:Q6P597","KLC3" -"UniProt:Q9NZP5","OR5AC2" -"UniProt:Q13616","CUL1" -"UniProt:Q8TCT6","SPPL3" -"UniProt:Q8WVK7","SKA2" -"UniProt:Q8NGV7","OR5H2" -"UniProt:Q9GZP8","C19orf33" -"UniProt:Q8IWY4","SCUBE1" -"UniProt:P04035","HMGCR" -"UniProt:Q76M96","CCDC80" -"UniProt:Q9H9F9","ARP5" -"UniProt:E9PFK9","E9PFK9" -"UniProt:Q9UBX3","SLC25A10" -"UniProt:O00453","LST1" -"UniProt:P51522","ZNF83" -"UniProt:Q16891","IMMT" -"UniProt:Q9C019","TRI15" -"UniProt:Q14831","GRM7" -"UniProt:Q7L0J3","SV2A" -"UniProt:Q6ZMM2","ADAMTSL5" -"UniProt:Q8NBX0","SCCPDH" -"UniProt:P23219","PTGS1" -"UniProt:A2VDF0","FUOM" -"UniProt:Q8IVF2","AHNAK2" -"UniProt:Q8WV60","PTCD2" -"UniProt:Q9NZJ6","COQ3" -"UniProt:Q13561","DCTN2" -"UniProt:Q9C0I1","MTMR12" -"UniProt:Q8N4E7","FTMT" -"UniProt:Q8IV31","TMEM139" -"UniProt:Q53H54","TRMT12" -"UniProt:P18065","IGFBP2" -"UniProt:Q6Y2X3","DNAJC14" -"UniProt:Q6IQ22","RAB12" -"UniProt:Q8WXI2","CNKSR2" -"UniProt:A0A0G2JPF3","A0A0G2JPF3" -"UniProt:P43304","GPD2" -"UniProt:Q86XT4","TRIM50" -"UniProt:Q15459","SF3A1" -"UniProt:P43357","MAGA3" -"UniProt:Q3SYC2","MOGAT2" -"UniProt:Q8TCT9","HM13" -"UniProt:Q9NY43","BARH2" -"UniProt:P10592","HSP72" -"UniProt:O95199","RCBT2" -"UniProt:Q9Y2N7","HIF3A" -"UniProt:Q9Y314","NOSIP" -"UniProt:Q8N139","ABCA6" -"UniProt:Q5VT06","CE350" -"UniProt:A0JNW5","UHRF1BP1L" -"UniProt:Q86Y13","DZIP3" -"UniProt:Q6ZV65","FAM47E" -"UniProt:Q9Y639","NPTN" -"UniProt:P29508","SERPINB3" -"UniProt:Q9Y272","RASD1" -"UniProt:Q8IZH2","XRN1" -"UniProt:Q68E01","INTS3" -"UniProt:Q6NWY9","PRPF40B" -"UniProt:Q9Y2W2","WBP11" -"UniProt:Q96IT1","ZN496" -"UniProt:Q9UHJ3","SMBT1" -"UniProt:Q5JQF8","PABPC1L2B" -"UniProt:Q9P109","GCNT4" -"UniProt:Q9H9L3","ISG20L2" -"UniProt:Q9BRL8","Q9BRL8" -"UniProt:Q9NPE6","SPAG4" -"UniProt:Q96QH2","PRAM" -"UniProt:P61086","UBE2K" -"UniProt:Q6ZTN6","ANKRD13D" -"UniProt:Q8N8V2","GBP7" -"UniProt:P03139","S" -"UniProt:Q8NHZ8","CDC26" -"UniProt:Q8WW81","Q8WW81" -"UniProt:Q6UXG2","KIAA1324" -"UniProt:Q86UE3","ZNF546" -"UniProt:Q06432","CACNG1" -"UniProt:Q14916","SLC17A1" -"UniProt:P86478","PR20E" -"UniProt:Q86X95","CIR1" -"UniProt:P63244","RACK1" -"UniProt:P13765","HLA-DOB" -"UniProt:P32241","VIPR1" -"UniProt:Q7Z7C8","TAF8" -"UniProt:P31152","MK04" -"UniProt:Q96N64","PWP2A" -"UniProt:Q8IVA8","Q8IVA8" -"UniProt:Q5VZ66","JAKMIP3" -"UniProt:O95864","FADS2" -"UniProt:Q9NQZ5","STARD7" -"UniProt:P02679","FGG" -"UniProt:Q7L4E1","MIGA2" -"UniProt:P49683","PRLHR" -"UniProt:P02763","A1AG1" -"UniProt:P10586","PTPRF" -"UniProt:P07385","CRMA" -"UniProt:Q9BZZ2","SIGLEC1" -"UniProt:A8K3C2","A8K3C2" -"UniProt:Q86UR1","NOXA1" -"UniProt:P35244","RPA3" -"UniProt:Q96TC7","RMD3" -"UniProt:P17010","ZFX" -"UniProt:P81408","F189B" -"UniProt:O95201","ZN205" -"UniProt:Q8N3J3","C17orf53" -"UniProt:Q9Y577","TRIM17" -"UniProt:P36118","NTR2" -"UniProt:P62979","RPS27A" -"UniProt:A6NK59","ASB14" -"UniProt:Q969N2","PIGT" -"UniProt:Q96FN9","DTD2" -"UniProt:Q5TD97","FHL5" -"UniProt:Q9BS91","SLC35A5" -"UniProt:Q9UKP5","ADAMTS6" -"UniProt:Q9NSE4","IARS2" -"UniProt:Q9GZX5","ZN350" -"UniProt:Q8TCW9","PROKR1" -"UniProt:Q8IUR6","CRERF" -"UniProt:Q9H9J2","MRPL44" -"UniProt:Q8NGP2","OR8J1" -"UniProt:O75949","FAM155B" -"UniProt:P01850","TRBC1" -"UniProt:Q96CH1","GPR146" -"UniProt:O75791","GRAP2" -"UniProt:D6RGH6","MCIN" -"UniProt:Q15369","ELOC" -"UniProt:Q01629","IFITM2" -"UniProt:O94901","SUN1" -"UniProt:Q9Y5V0","ZNF706" -"UniProt:P63316","TNNC1" -"UniProt:P55103","INHBC" -"UniProt:Q8K1R7","NEK9" -"UniProt:Q5VU43","MYOME" -"UniProt:P57086","SCND1" -"UniProt:P0C1H6","H2BFM" -"UniProt:O00629","KPNA4" -"UniProt:Q01113","IL9R" -"UniProt:A6H8Z2","FAM221B" -"UniProt:O75175","CNOT3" -"UniProt:A2ABF9","A2ABF9" -"UniProt:Q9UF56","FBXL17" -"UniProt:Q13151","HNRNPA0" -"UniProt:O60563","CCNT1" -"UniProt:P28340","POLD1" -"UniProt:A2RU49","HYKK" -"UniProt:Q9UGI8","TES" -"UniProt:P50479","PDLIM4" -"UniProt:P13423","pagA" -"UniProt:Q8N7P3","CLDN22" -"UniProt:Q9Y2G3","ATP11B" -"UniProt:Q7Z460","CLASP1" -"UniProt:U5TQE9","U5TQE9" -"UniProt:Q7L622","G2E3" -"UniProt:Q9Y227","ENTPD4" -"UniProt:Q96PL5","ERMAP" -"UniProt:Q14320","FAM50A" -"UniProt:Q96ES7","SGF29" -"UniProt:Q9NY25","CLEC5A" -"UniProt:Q8WXC3","PYDC1" -"UniProt:Q9Y4B5","MTCL1" -"UniProt:O75751","SLC22A3" -"UniProt:P01848","TRAC" -"UniProt:Q9UNK0","STX8" -"UniProt:Q8NHR9","PFN4" -"UniProt:P02768","ALB" -"UniProt:Q9BUE0","MED18" -"UniProt:Q9NU22","MDN1" -"UniProt:Q9H7D0","DOCK5" -"UniProt:Q9H611","PIF1" -"UniProt:Q9BXJ2","C1QTNF7" -"UniProt:Q3T8J9","GON4L" -"UniProt:P03950","ANG" -"UniProt:P80511","S100A12" -"UniProt:Q86YE8","ZNF573" -"UniProt:Q13133","NR1H3" -"UniProt:Q9BW83","IFT27" -"UniProt:P61157","ACTR3" -"UniProt:P0CG13","CHTF8" -"UniProt:P38932","VPS45" -"UniProt:Q6PDS3","SARM1" -"UniProt:Q8IZV5","RDH10" -"UniProt:Q8WUN7","UBTD2" -"UniProt:Q86WW8","COA5" -"UniProt:P53142","VPS73" -"UniProt:Q9UNA0","ADAMTS5" -"UniProt:Q8IVN8","SBSPON" -"UniProt:O00533","CHL1" -"UniProt:P35663","CYLC1" -"UniProt:Q6PEZ8","PODNL1" -"UniProt:O60749","SNX2" -"UniProt:Q96CN4","EVI5L" -"UniProt:Q86UD1","OAF" -"UniProt:Q24JU4","Q24JU4" -"UniProt:Q92600","CNOT9" -"UniProt:Q8NEW0","SLC30A7" -"UniProt:Q9NVA4","TMEM184C" -"UniProt:J3KQ12","J3KQ12" -"UniProt:P23258","TUBG1" -"UniProt:P48745","NOV" -"UniProt:Q86XU0","ZNF677" -"UniProt:Q9P1U0","ZNRD1" -"UniProt:Q5HY54","Q5HY54" -"UniProt:Q86XA8","Q86XA8" -"UniProt:P19321","botD" -"UniProt:P20338","RAB4A" -"UniProt:A8MTY0","ZNF724" -"UniProt:O95755","RAB36" -"UniProt:Q02338","BDH1" -"UniProt:B7Z1M9","C2CD4D" -"UniProt:Q02246","CNTN2" -"UniProt:Q9H6Z9","EGLN3" -"UniProt:Q7Z7B1","PIGW" -"UniProt:Q03701","CEBPZ" -"UniProt:P61165","TM258" -"UniProt:Q8N184","ZNF567" -"UniProt:Q9BS34","ZN670" -"UniProt:Q96A70","AZIN2" -"UniProt:P78324","SIRPA" -"UniProt:Q6ZNA5","FRRS1" -"UniProt:Q6P9G0","CYB5D1" -"UniProt:Q8NBF2","NHLRC2" -"UniProt:Q9HC98","NEK6" -"UniProt:Q15835","GRK1" -"UniProt:Q13888","GTF2H2" -"UniProt:Q16650","TBR1" -"UniProt:P08514","ITGA2B" -"UniProt:Q14442","PIGH" -"UniProt:Q9HBW0","LPAR2" -"UniProt:Q5XKP0","C19orf70" -"UniProt:Q9BYG5","PAR6B" -"UniProt:Q9NW64","RBM22" -"UniProt:Q01974","ROR2" -"UniProt:Q8TBJ5","FEZF2" -"UniProt:Q6UXS0","CLEC19A" -"UniProt:Q96LA5","FCRL2" -"UniProt:Q86T82","USP37" -"UniProt:Q9NZW5","MPP6" -"UniProt:P13631","RARG" -"UniProt:P22087","FBRL" -"UniProt:Q8IVB4","SLC9A9" -"UniProt:Q9BZC7","ABCA2" -"UniProt:P78540","ARG2" -"UniProt:Q9H668","STN1" -"UniProt:A0A0C4DFM0","A0A0C4DFM0" -"UniProt:O75607","NPM3" -"UniProt:O95696","BRD1" -"UniProt:P25800","LMO1" -"UniProt:Q6IB98","Q6IB98" -"UniProt:Q99967","CITED2" -"UniProt:Q92556","ELMO1" -"UniProt:B3KUN1","B3KUN1" -"UniProt:Q2KHT3","CLEC16A" -"UniProt:Q9Y5X3","SNX5" -"UniProt:O70551","SRPK1" -"UniProt:Q96GQ5","C16orf58" -"UniProt:Q9BZM5","ULBP2" -"UniProt:Q9GZX7","AICDA" -"UniProt:Q15329","E2F5" -"UniProt:Q15021","NCAPD2" -"UniProt:P10319","HLA-B" -"UniProt:Q9P209","CEP72" -"UniProt:Q6ZPF3","TIAM2" -"UniProt:Q96R69","OR4F4" -"UniProt:Q6UW15","REG3G" -"UniProt:P08684","CYP3A4" -"UniProt:P53779","MK10" -"UniProt:Q6P1L8","MRPL14" -"UniProt:Q969I3","GLYATL1" -"UniProt:Q1K9H5","Q1K9H5" -"UniProt:P10809","HSPD1" -"UniProt:Q9H7X0","NAA60" -"UniProt:Q9JJN6","CNBP1" -"UniProt:A6NKF1","SAC3D1" -"UniProt:Q9Y6L7","TLL2" -"UniProt:O15067","PFAS" -"UniProt:Q9JIY2","HAKAI" -"UniProt:Q9NQC3","RTN4" -"UniProt:Q8TBM7","TMEM254" -"UniProt:O60883","GPR37L1" -"UniProt:P56211","ARPP19" -"UniProt:P46933","APBB1" -"UniProt:Q9HCC6","HES4" -"UniProt:P10687","PLCB1" -"UniProt:Q9UBM1","PEMT" -"UniProt:Q9UBP4","DKK3" -"UniProt:Q9H3S1","SEMA4A" -"UniProt:Q9UHP3","UBP25" -"UniProt:O75829","CNMD" -"UniProt:Q6ZMR3","LDHAL6A" -"UniProt:Q9UK58","CCNL1" -"UniProt:Q8TAF8","LHFPL5" -"UniProt:P29475","NOS1" -"UniProt:Q9P2K1","CC2D2A" -"UniProt:Q9ULV4","COR1C" -"UniProt:Q4VXA5","KHDC1" -"UniProt:Q8IWJ2","GCC2" -"UniProt:Q9Y248","PSF2" -"UniProt:Q5VSG8","MANEAL" -"UniProt:Q9NZ08","ERAP1" -"UniProt:Q9Y2A9","B3GNT3" -"UniProt:Q0GE19","SLC10A7" -"UniProt:Q96D05","C10ORF35" -"UniProt:Q96BX8","MOB3A" -"UniProt:Q13163","MP2K5" -"UniProt:P03923","ND6" -"UniProt:Q8ND90","PNMA1" -"UniProt:Q9H7J1","PPR3E" -"UniProt:P36537","UGT2B10" -"UniProt:Q2TAL5","SMTNL2" -"UniProt:P35998","PSMC2" -"UniProt:Q9Y5K5","UCHL5" -"UniProt:Q8QVZ0","Q8QVZ0" -"UniProt:Q12894","IFRD2" -"UniProt:Q8NF37","LPCAT1" -"UniProt:Q9NYS7","WSB2" -"UniProt:Q2V2M9","FHOD3" -"UniProt:P02775","PPBP" -"UniProt:Q15493","RGN" -"UniProt:Q8N4E4","PDCL2" -"UniProt:Q7L5Y1","ENOSF1" -"UniProt:Q68CZ1","RPGRIP1L" -"UniProt:P00750","PLAT" -"UniProt:P49758","RGS6" -"UniProt:Q92562","FIG4" -"UniProt:Q9NP60","IL1RAPL2" -"UniProt:Q6ZT89","SLC25A48" -"UniProt:Q96HR3","MED30" -"UniProt:O95954","FTCD" -"UniProt:Q07813","BAX" -"UniProt:Q86VN1","VPS36" -"UniProt:Q8TBB5","KLDC4" -"UniProt:Q9Y2K9","STXBP5L" -"UniProt:O95456","PSMG1" -"UniProt:Q96GD3","SCMH1" -"UniProt:P27487","DPP4" -"UniProt:P03928","ATP8" -"UniProt:Q8NHG8","ZNRF2" -"UniProt:P03905","ND4" -"UniProt:Q9NRG4","SMYD2" -"UniProt:Q9H227","GBA3" -"UniProt:Q04828","AKR1C1" -"UniProt:P80217","IFI35" -"UniProt:P00846","ATP6" -"UniProt:Q8TBZ0","CCDC110" -"UniProt:Q5U5U6","Q5U5U6" -"UniProt:P14061","DHB1" -"UniProt:P58499","FAM3B" -"UniProt:P06028","GLPB" -"UniProt:C9J3V5","TEX22" -"UniProt:A0A0A6YYF3","A0A0A6YYF3" -"UniProt:P20336","RAB3A" -"UniProt:P00520","ABL1" -"UniProt:Q98325","MC159L" -"UniProt:Q00496","Botulinum" -"UniProt:Q9UKJ3","GPATCH8" -"UniProt:O75715","GPX5" -"UniProt:P00156","CYTB" -"UniProt:Q9NX14","NDUFB11" -"UniProt:Q8IUZ0","LRRC49" -"UniProt:Q9P086","MED11" -"UniProt:A0A0C4DFS6","A0A0C4DFS6" -"UniProt:Q8IWY8","ZSCAN29" -"UniProt:P11234","RALB" -"UniProt:O43315","AQP9" -"UniProt:Q76RF1","ORF71" -"UniProt:Q9UDV7","ZNF282" -"UniProt:P29728","OAS2" -"UniProt:O43617","TPPC3" -"UniProt:Q96JG9","ZNF469" -"UniProt:Q6NXP2","FAM71F2" -"UniProt:Q8WWA0","ITLN1" -"UniProt:Q00013","EM55" -"UniProt:P50914","RL14" -"UniProt:P22676","CALB2" -"UniProt:P0C7I0","USP17L8" -"UniProt:P12694","BCKDHA" -"UniProt:Q9H1M3","DEFB129" -"UniProt:Q86SQ0","PHLB2" -"UniProt:Q8IZN7","DEFB107A" -"UniProt:O14813","PHOX2A" -"UniProt:Q30KP9","DEFB135" -"UniProt:Q9NZM1","MYOF" -"UniProt:O15243","LEPROT" -"UniProt:Q96HF1","SFRP2" -"UniProt:Q4QY38","DEFB134" -"UniProt:O14613","BORG1" -"UniProt:B3KTP4","B3KTP4" -"UniProt:Q8NET1","DEFB108B" -"UniProt:O43612","HCRT" -"UniProt:Q96HQ2","C2AIL" -"UniProt:P51684","CCR6" -"UniProt:Q8N884","MB21D1" -"UniProt:P20042","EIF2S2" -"UniProt:P52655","TF2AA" -"UniProt:Q13948","CUX1" -"UniProt:Q99460","PSMD1" -"UniProt:P01880","IGHD" -"UniProt:Q9UIG5","PSORS1C1" -"UniProt:O00748","CES2" -"UniProt:Q9H1E1","RNASE7" -"UniProt:Q9Y2K5","R3HDM2" -"UniProt:Q8N688","DEFB123" -"UniProt:A8MXU0","DEFB108P1" -"UniProt:Q16661","GUC2B" -"UniProt:A6NIH7","UNC119B" -"UniProt:Q01523","DEFA5" -"UniProt:P04844","RPN2" -"UniProt:Q5NE16","CATL3" -"UniProt:Q16186","ADRM1" -"UniProt:Q7Z7B7","DEFB132" -"UniProt:Q00LT1","PRCD" -"UniProt:Q9P2M7","CING" -"UniProt:Q86SG5","S100A7A" -"UniProt:S4R322","S4R322" -"UniProt:P15059","SPI-2" -"UniProt:O15263","DEFB4A" -"UniProt:Q567V2","MPV17L2" -"UniProt:A5YKK6","CNOT1" -"UniProt:P36952","SERPINB5" -"UniProt:P55160","NCKAP1L" -"UniProt:Q86XF0","DHFR2" -"UniProt:Q8N687","DEFB125" -"UniProt:Q8N104","DEFB106A" -"UniProt:Q9UIQ6","LCAP" -"UniProt:Q93091","RNASE6" -"UniProt:P11182","DBT" -"UniProt:Q06616","YP174" -"UniProt:Q8IXM6","NRM" -"UniProt:O00754","MAN2B1" -"UniProt:Q9NZF1","PLAC8" -"UniProt:Q27968","DNJC3" -"UniProt:Q15915","ZIC1" -"UniProt:Q8TDL5","BPIFB1" -"UniProt:P59666","DEFA3" -"UniProt:Q91X20","Ash2l" -"UniProt:Q96GZ3","Q96GZ3" -"UniProt:Q30KQ9","DEFB110" -"UniProt:Q8IUZ5","PHYKPL" -"UniProt:Q9UKT4","FBXO5" -"UniProt:Q9NQM4","PIH1D3" -"UniProt:Q9BSU3","NAA11" -"UniProt:P15516","HTN3" -"UniProt:O75391","SPAG7" -"UniProt:P17735","TAT" -"UniProt:P12489","env" -"UniProt:Q8NFH4","NUP37" -"UniProt:O15160","POLR1C" -"UniProt:Q96LB9","PGLYRP3" -"UniProt:P55265","ADAR" -"UniProt:Q5XX13","FBXW10" -"UniProt:Q9H1M4","DEFB127" -"UniProt:Q9HBV2","SPACA1" -"UniProt:O43731","KDELR3" -"UniProt:O00462","MANBA" -"UniProt:Q9H3W5","LRRN3" -"UniProt:Q30KQ6","DEFB114" -"UniProt:O75019","LILRA1" -"UniProt:Q06141","REG3A" -"UniProt:Q08380","LGALS3BP" -"UniProt:O35613","DAXX" -"UniProt:B4DUY5","B4DUY5" -"UniProt:Q11203","ST3GAL3" -"UniProt:A5PKU2","A5PKU2" -"UniProt:P82933","RT09" -"UniProt:Q13202","DUSP8" -"UniProt:P0DP74","DEFB130A" -"UniProt:Q6VY07","PACS1" -"UniProt:Q9HCD6","TANC2" -"UniProt:Q96PD5","PGLYRP2" -"UniProt:P52429","DGKE" -"UniProt:O15467","CCL16" -"UniProt:Q8TAA5","GRPEL2" -"UniProt:Q9BYW3","DEFB126" -"UniProt:P48546","GIPR" -"UniProt:O95822","MLYCD" -"UniProt:Q8WW27","APOBEC4" -"UniProt:P0DP73","DEFB130B" -"UniProt:O75602","SPAG6" -"UniProt:Q9BTX1","NDC1" -"UniProt:Q96CU9","FOXRED1" -"UniProt:Q9UGM3","DMBT1" -"UniProt:Q9ULC6","PADI1" -"UniProt:Q5PRF9","SAMD4B" -"UniProt:P35556","FBN2" -"UniProt:P24723","PRKCH" -"UniProt:Q9UHF7","TRPS1" -"UniProt:Q8NGL7","OR4P4" -"UniProt:P30279","CCND2" -"UniProt:P78559","MAP1A" -"UniProt:P43246","MSH2" -"UniProt:Q9H488","POFUT1" -"UniProt:Q9UBD9","CLCF1" -"UniProt:P0CI01","SPDE6" -"UniProt:Q86X19","TMM17" -"UniProt:Q6FHY5","Q6FHY5" -"UniProt:Q9BXJ0","C1QTNF5" -"UniProt:Q9HCL3","ZFP14" -"UniProt:Q9UHQ9","NB5R1" -"UniProt:O95727","CRTAM" -"UniProt:Q86Y39","NDUFA11" -"UniProt:Q27J81","INF2" -"UniProt:P15559","NQO1" -"UniProt:Q9BU61","NDUFAF3" -"UniProt:P33417","IXR1" -"UniProt:Q9Y467","SALL2" -"UniProt:P41091","EIF2S3" -"UniProt:Q9UIF8","BAZ2B" -"UniProt:Q9Y243","AKT3" -"UniProt:P05177","CYP1A2" -"UniProt:P12821","ACE" -"UniProt:Q14129","DGCR6" -"UniProt:Q16647","PTGIS" -"UniProt:Q8WVE6","TMEM171" -"UniProt:Q8IU68","TMC8" -"UniProt:Q68D10","SPTY2D1" -"UniProt:Q14088","RAB33A" -"UniProt:Q8N619","Q8N619" -"UniProt:Q9UMD9","COL17A1" -"UniProt:P78396","CCNA1" -"UniProt:Q96J65","ABCC12" -"UniProt:P08758","ANXA5" -"UniProt:Q9HBZ2","ARNT2" -"UniProt:P42898","MTHFR" -"UniProt:Q9GZV4","EIF5A2" -"UniProt:Q96A19","CCDC102A" -"UniProt:Q99424","ACOX2" -"UniProt:O43301","HSPA12A" -"UniProt:Q96EP9","SLC10A4" -"UniProt:Q969Z3","MARC2" -"UniProt:Q86V24","ADIPOR2" -"UniProt:Q86XA0","METTL23" -"UniProt:Q9H6B1","ZNF385D" -"UniProt:Q15906","VPS72" -"UniProt:P03989","HLA-B" -"UniProt:Q8WUI4","HDAC7" -"UniProt:P55347","PKNOX1" -"UniProt:Q9H208","OR10A2" -"UniProt:P48067","SLC6A9" -"UniProt:O75325","LRRN2" -"UniProt:Q9BZ19","ANKRD60" -"UniProt:P49247","RPIA" -"UniProt:Q63ZY3","KANK2" -"UniProt:Q03063","DIG1" -"UniProt:A1L429","GAGE12C" -"UniProt:P41595","HTR2B" -"UniProt:Q92847","GHSR" -"UniProt:Q9BWM7","SFXN3" -"UniProt:Q9P242","NYAP2" -"UniProt:P98171","ARHGAP4" -"UniProt:Q9UQ16","DNM3" -"UniProt:Q13239","SLAP1" -"UniProt:Q86TI4","WDR86" -"UniProt:P03891","ND2" -"UniProt:Q96FC9","DDX11" -"UniProt:Q9C0H2","TTYH3" -"UniProt:Q330K2","NDUFAF6" -"UniProt:Q9NQG1","MANBAL" -"UniProt:O43502","RAD51C" -"UniProt:P10827","THRA" -"UniProt:O95394","PGM3" -"UniProt:Q7L7W2","Q7L7W2" -"UniProt:Q92617","NPIPB3" -"UniProt:Q9H2H9","SLC38A1" -"UniProt:P42684","ABL2" -"UniProt:O70445","BARD1" -"UniProt:Q8TE56","ADAMTS17" -"UniProt:Q14469","HES1" -"UniProt:Q96RD2","OR52B2" -"UniProt:Q7Z4H9","FAM220A" -"UniProt:P03886","ND1" -"UniProt:O75874","IDH1" -"UniProt:O75781","PALM" -"UniProt:Q9H0M5","ZNF700" -"UniProt:Q7Z4S6","KIF21A" -"UniProt:Q86UD4","ZN329" -"UniProt:Q8IV16","GPIHBP1" -"UniProt:Q9NZN1","IL1RAPL1" -"UniProt:O60543","CIDEA" -"UniProt:Q9UMS0","NFU1" -"UniProt:Q8TED4","SLC37A2" -"UniProt:Q9BZQ4","NMNAT2" -"UniProt:Q96AX1","VPS33A" -"UniProt:P40394","ADH7" -"UniProt:C9JVI0","USP17L11" -"UniProt:Q99687","MEIS3" -"UniProt:Q99501","GAS2L1" -"UniProt:O43365","HOXA3" -"UniProt:P10828","THRB" -"UniProt:P05112","IL4" -"UniProt:Q53GL7","PARP10" -"UniProt:Q9Y266","NUDC" -"UniProt:P06681","C2" -"UniProt:P05738","RL9A" -"UniProt:Q86WX3","AROS" -"UniProt:P00325","ADH1B" -"UniProt:P20292","ALOX5AP" -"UniProt:P17362","C6" -"UniProt:Q9NZB8","MOCS1" -"UniProt:P16109","SELP" -"UniProt:P17021","ZNF17" -"UniProt:P50053","KHK" -"UniProt:Q8NCK7","SLC16A11" -"UniProt:Q96C92","SDCCAG3" -"UniProt:Q92614","MYO18A" -"UniProt:O54864","SUV91" -"UniProt:P00736","C1R" -"UniProt:P35713","SOX18" -"UniProt:O43676","NDUFB3" -"UniProt:Q96DE9","CXorf40B" -"UniProt:O15120","AGPAT2" -"UniProt:P25354","YCP7" -"UniProt:Q9NV39","PRR34" -"UniProt:P09467","FBP1" -"UniProt:P05062","ALDOB" -"UniProt:O00764","PDXK" -"UniProt:O35889","Afdn" -"UniProt:P12259","F5" -"UniProt:P03999","OPN1SW" -"UniProt:P12034","FGF5" -"UniProt:P41225","SOX3" -"UniProt:Q9UKF7","PITPNC1" -"UniProt:P14625","HSP90B1" -"UniProt:Q86UE4","MTDH" -"UniProt:Q7Z7H3","CATIP" -"UniProt:P60002","ELOF1" -"UniProt:Q8WUA4","GTF3C2" -"UniProt:Q969V3","NCLN" -"UniProt:Q9UJ71","CD207" -"UniProt:Q6P4J0","Q6P4J0" -"UniProt:P51793","CLCN4" -"UniProt:Q08188","TGM3" -"UniProt:Q16281","CNGA3" -"UniProt:P11712","CYP2C9" -"UniProt:Q9Y366","IFT52" -"UniProt:P56975","NRG3" -"UniProt:O96033","MOCS2" -"UniProt:Q9BTZ2","DHRS4" -"UniProt:Q13571","LAPTM5" -"UniProt:O43405","COCH" -"UniProt:Q86WV6","TMEM173" -"UniProt:P48837","NUP57" -"UniProt:Q8N4Y2","CRACR2B" -"UniProt:Q9UKX2","MYH2" -"UniProt:O75179","ANR17" -"UniProt:O75380","NDUFS6" -"UniProt:G1T8E2","G1T8E2" -"UniProt:Q69YQ0","SPECC1L" -"UniProt:Q7Z7G8","VPS13B" -"UniProt:P54760","EPHB4" -"UniProt:Q8N1Q1","CA13" -"UniProt:Q9P032","NDUFAF4" -"UniProt:P35611","ADD1" -"UniProt:Q9UQL6","HDAC5" -"UniProt:Q92625","ANS1A" -"UniProt:Q13257","MD2L1" -"UniProt:P10632","CYP2C8" -"UniProt:Q96HR9","REEP6" -"UniProt:O15239","NDUFA1" -"UniProt:Q16600","ZNF239" -"UniProt:Q70EL2","USP45" -"UniProt:P04066","FUCA1" -"UniProt:Q86WN1","FCHSD1" -"UniProt:P51878","CASP5" -"UniProt:O94892","ZN432" -"UniProt:P0DH78","RNF224" -"UniProt:P21127","CD11B" -"UniProt:Q9BU19","ZNF692" -"UniProt:Q9BTE0","NAT9" -"UniProt:Q96C12","ARMC5" -"UniProt:O94777","DPM2" -"UniProt:Q8NEK8","FA46D" -"UniProt:O95359","TACC2" -"UniProt:Q96SN8","CDK5RAP2" -"UniProt:Q9HCE1","MOV10" -"UniProt:Q8N7M2","ZNF283" -"UniProt:O75553","DAB1" -"UniProt:Q15382","RHEB" -"UniProt:Q9UHY8","FEZ2" -"UniProt:Q9Y2B1","TMEM5" -"UniProt:P55056","APOC4" -"UniProt:Q63768","CRK" -"UniProt:Q9BV99","LRC61" -"UniProt:P04628","WNT1" -"UniProt:P40763","STAT3" -"UniProt:Q5TCX8","M3KL4" -"UniProt:Q03373","DIG2" -"UniProt:P20151","KLK2" -"UniProt:P62304","SNRPE" -"UniProt:Q4AC94","C2CD3" -"UniProt:G3XAG1","G3XAG1" -"UniProt:Q8NGI8","OR5AN1" -"UniProt:Q13087","PDIA2" -"UniProt:Q9QUI1","LRA25" -"UniProt:Q8TF61","FBXO41" -"UniProt:Q9UIA0","CYTH4" -"UniProt:Q5SYE7","NHSL1" -"UniProt:Q9GZU1","MCOLN1" -"UniProt:Q96BT7","ALKBH8" -"UniProt:Q9NRW3","ABC3C" -"UniProt:O14734","ACOT8" -"UniProt:O95096","NKX2-2" -"UniProt:Q13459","MYO9B" -"UniProt:Q96L91","EP400" -"UniProt:P52735","VAV2" -"UniProt:P68133","ACTA1" -"UniProt:A0AVN2","A0AVN2" -"UniProt:Q6ZMH5","SLC39A5" -"UniProt:Q9BQD3","KXD1" -"UniProt:P26998","CRYBB3" -"UniProt:Q9Y605","MOFA1" -"UniProt:P04487","RNB" -"UniProt:Q12979","ABR" -"UniProt:P53999","TCP4" -"UniProt:Q8WTR4","GDPD5" -"UniProt:O14709","ZNF197" -"UniProt:Q92481","TFAP2B" -"UniProt:Q96DZ7","T4S19" -"UniProt:Q6TVW2","Q6TVW2" -"UniProt:Q9NWV4","C1orf123" -"UniProt:Q9UJJ9","GNPTG" -"UniProt:Q6J9G0","STYK1" -"UniProt:P0CJ77","MTRNR2L10" -"UniProt:Q8TD10","MIPO1" -"UniProt:Q9UL68","MYT1L" -"UniProt:O60645","EXOC3" -"UniProt:Q9NTU7","CBLN4" -"UniProt:P58170","OR1D5" -"UniProt:Q96T21","SECISBP2" -"UniProt:Q4V348","ZNF658B" -"UniProt:Q8TB52","FBXO30" -"UniProt:P39990","SNU13" -"UniProt:Q8N9F8","ZNF454" -"UniProt:Q9NX94","WBP1L" -"UniProt:O14604","TMSB4Y" -"UniProt:Q96NG3","TTC25" -"UniProt:P02776","PF4" -"UniProt:Q9HA92","RSAD1" -"UniProt:Q14653","IRF3" -"UniProt:P00450","CP" -"UniProt:Q9BYQ3","KRA93" -"UniProt:Q8TAC9","SCAMP5" -"UniProt:Q96DY7","MTBP" -"UniProt:P04601","nef" -"UniProt:P51816","AFF2" -"UniProt:Q96HH0","Q96HH0" -"UniProt:Q8TDW0","LRRC8C" -"UniProt:O60779","SLC19A2" -"UniProt:A1X283","SH3PXD2B" -"UniProt:Q9H3M0","KCNF1" -"UniProt:P49427","UB2R1" -"UniProt:A6NC86","PINLYP" -"UniProt:Q5HYW2","NHSL2" -"UniProt:P56730","PRSS12" -"UniProt:O75467","ZNF324" -"UniProt:Q9NZP6","NPAP1" -"UniProt:Q8WYQ3","CHCHD10" -"UniProt:Q61477","NBL1" -"UniProt:Q6ZMC9","SIGLEC15" -"UniProt:A0A0B4J2G0","A0A0B4J2G0" -"UniProt:Q9Y483","MTF2" -"UniProt:Q6IPH7","Q6IPH7" -"UniProt:Q9BWJ5","SF3B5" -"UniProt:Q9Y4F5","CEP170B" -"UniProt:O95841","ANGPTL1" -"UniProt:Q9NVV0","TMEM38B" -"UniProt:Q9BYG0","B3GN5" -"UniProt:P06870","KLK1" -"UniProt:Q6ZSG1","RN165" -"UniProt:O75762","TRPA1" -"UniProt:Q3T906","GNPTAB" -"UniProt:Q99729","HNRNPAB" -"UniProt:Q9UNW9","NOVA2" -"UniProt:Q5XUX1","FBXW9" -"UniProt:Q3SXY7","LRIT3" -"UniProt:Q2NL68","PRSR3" -"UniProt:A0A0C4DFT8","A0A0C4DFT8" -"UniProt:Q99383","HRP1" -"UniProt:Q8NHS4","CLHC1" -"UniProt:Q9Y4F9","RIPOR2" -"UniProt:P46414","Cdkn1b" -"UniProt:Q00959","Grin2a" -"UniProt:P07992","ERCC1" -"UniProt:Q92665","RT31" -"UniProt:Q96M63","CCDC114" -"UniProt:P57077","MAP3K7CL" -"UniProt:Q9Y485","DMXL1" -"UniProt:Q9UQ35","SRRM2" -"UniProt:Q9NZV6","MSRB1" -"UniProt:Q5W150","YT011" -"UniProt:Q9H207","OR10A5" -"UniProt:O95881","TXD12" -"UniProt:Q6BDS2","URFB1" -"UniProt:Q9C0G0","ZNF407" -"UniProt:Q9NPI0","TMEM138" -"UniProt:Q9NTN9","SEMA4G" -"UniProt:P50443","SLC26A2" -"UniProt:P0C604","OR4A8" -"UniProt:Q14498","RBM39" -"UniProt:Q7Z6K5","ARPIN" -"UniProt:Q62083","PICK1" -"UniProt:P0C629","OR10J4" -"UniProt:Q9HBM1","SPC25" -"UniProt:Q9ULD4","BRPF3" -"UniProt:Q9HC35","EML4" -"UniProt:P62955","CACNG7" -"UniProt:Q9H444","CHMP4B" -"UniProt:Q9UBC7","GALP" -"UniProt:Q68CJ9","CREB3L3" -"UniProt:O43766","LIAS" -"UniProt:Q9P1Q5","OR1A1" -"UniProt:Q9H6D8","FNDC4" -"UniProt:P01031","C5" -"UniProt:B3KPT9","B3KPT9" -"UniProt:Q3KRA9","ALKBH6" -"UniProt:Q9H209","OR10A4" -"UniProt:Q96KK4","OR10C1" -"UniProt:Q8N2U9","PQLC1" -"UniProt:Q9BUI4","RPC3" -"UniProt:P38077","ATPG" -"UniProt:Q8NEJ1","Q8NEJ1" -"UniProt:P43005","SLC1A1" -"UniProt:Q9BUB5","MKNK1" -"UniProt:O95013","OR4F21" -"UniProt:O15228","GNPAT" -"UniProt:Q16538","GP162" -"UniProt:Q5JNZ3","ZNF311" -"UniProt:O75575","RPC9" -"UniProt:Q9H0C1","ZMY12" -"UniProt:Q92681","RSC1A1" -"UniProt:Q9H0A8","COMMD4" -"UniProt:P59665","DEF1" -"UniProt:Q14526","HIC1" -"UniProt:P33981","TTK" -"UniProt:P01106","MYC" -"UniProt:P07498","CASK" -"UniProt:Q9P1Z0","ZBTB4" -"UniProt:Q6UXN7","TO20L" -"UniProt:Q9UN37","VPS4A" -"UniProt:P38182","ATG8" -"UniProt:P16885","PLCG2" -"UniProt:Q6PGP7","TTC37" -"UniProt:Q8NGQ2","OR6Q1" -"UniProt:Q8NGS7","OR13C8" -"UniProt:Q9H341","OR51M1" -"UniProt:P58173","OR2B6" -"UniProt:Q14623","IHH" -"UniProt:P0CG37","CFC1" -"UniProt:Q3U182","CRTC2" -"UniProt:Q96BW9","TAMM41" -"UniProt:Q9NQN1","OR2S2" -"UniProt:P25105","PTAFR" -"UniProt:Q9BXJ5","C1QT2" -"UniProt:P52293","IMA1" -"UniProt:Q9UJH8","METRN" -"UniProt:P0CW72","BARF1" -"UniProt:P45973","CBX5" -"UniProt:Q6V4L4","Q6V4L4" -"UniProt:Q92539","LPIN2" -"UniProt:Q8NGS9","OR13C2" -"UniProt:Q6NVV7","CDPF1" -"UniProt:P27707","DCK" -"UniProt:Q8NGZ4","OR2G3" -"UniProt:Q8N9L9","ACOT4" -"UniProt:Q13444","ADAM15" -"UniProt:Q9Y3S2","ZN330" -"UniProt:Q96RR1","TWNK" -"UniProt:P08865","RPSA" -"UniProt:Q9BXP2","SLC12A9" -"UniProt:A6NHA9","OR4C46" -"UniProt:P17787","CHRNB2" -"UniProt:Q9HC16","APOBEC3G" -"UniProt:Q9C075","KRT23" -"UniProt:Q8NGI7","OR10V1" -"UniProt:O00299","CLIC1" -"UniProt:Q9H3R0","KDM4C" -"UniProt:Q8NE71","ABCF1" -"UniProt:P58181","OR10A3" -"UniProt:Q8TDY2","RB1CC1" -"UniProt:Q96PF1","TGM7" -"UniProt:P82094","TMF1" -"UniProt:Q6P996","PDXDC1" -"UniProt:Q8NH05","OR4Q3" -"UniProt:P36959","GMPR" -"UniProt:Q96HE9","PRR11" -"UniProt:Q99909","SSX3" -"UniProt:Q62623","CDC20" -"UniProt:Q13542","4EBP2" -"UniProt:Q8WV35","LRC29" -"UniProt:Q13201","MMRN1" -"UniProt:Q8TF74","WIPF2" -"UniProt:P09341","CXCL1" -"UniProt:Q9H9Q2","COPS7B" -"UniProt:Q9H246","C1orf21" -"UniProt:Q3LI63","KRTAP20-1" -"UniProt:Q9H3P7","ACBD3" -"UniProt:O15069","NACAD" -"UniProt:Q8NH61","OR51F2" -"UniProt:Q03113","GNA12" -"UniProt:P98164","LRP2" -"UniProt:O15427","MOT4" -"UniProt:O60290","ZNF862" -"UniProt:Q9BRT3","MIEN1" -"UniProt:Q96Q40","CDK15" -"UniProt:O75354","ENTPD6" -"UniProt:Q8NH54","OR56A3" -"UniProt:Q2M1V0","ISX" -"UniProt:Q16619","CTF1" -"UniProt:A0A0G2JQ02","A0A0G2JQ02" -"UniProt:P67775","PPP2CA" -"UniProt:Q9BYV8","CEP41" -"UniProt:Q49AM7","Q49AM7" -"UniProt:P62699","YPEL5" -"UniProt:Q7Z5N4","SDK1" -"UniProt:Q14289","PTK2B" -"UniProt:Q53EP0","FNDC3B" -"UniProt:Q9NX55","HYPK" -"UniProt:Q8N157","AHI1" -"UniProt:Q6P4E2","Q6P4E2" -"UniProt:P18146","EGR1" -"UniProt:Q8NGS8","OR13C5" -"UniProt:O95677","EYA4" -"UniProt:Q6NSH3","CT455" -"UniProt:Q86WZ6","ZNF227" -"UniProt:Q9Y2Q1","ZNF257" -"UniProt:Q96DV4","MRPL38" -"UniProt:Q8NHA6","OR2W6P" -"UniProt:O76024","WFS1" -"UniProt:Q96EN9","CS060" -"UniProt:Q9NYT6","ZNF226" -"UniProt:Q8J025","APCDD1" -"UniProt:Q9UPM6","LHX6" -"UniProt:Q9BXR5","TLR10" -"UniProt:Q9BY08","EBPL" -"UniProt:Q9H4M7","PLEKHA4" -"UniProt:Q14117","DPYS" -"UniProt:Q8NGR5","OR1L4" -"UniProt:Q7Z3H0","ANR33" -"UniProt:Q6ZNG0","ZNF620" -"UniProt:O00592","PODXL" -"UniProt:Q8NDX5","PHC3" -"UniProt:Q99SU7","SAK" -"UniProt:Q6X9E4","FBXW12" -"UniProt:Q9BZ67","FRMD8" -"UniProt:Q8WUG5","SLC22A17" -"UniProt:Q8NH74","OR10A6" -"UniProt:O60759","CYTIP" -"UniProt:Q8N0Y5","OR8I2" -"UniProt:Q9UM01","SLC7A7" -"UniProt:Q9UPQ7","PDZRN3" -"UniProt:P09727","US11" -"UniProt:P03126","VE6" -"UniProt:Q8VHK2","CSKI1" -"UniProt:Q9Y2T1","AXIN2" -"UniProt:P60484","PTEN" -"UniProt:P23946","CMA1" -"UniProt:Q8N146","OR8H3" -"UniProt:O95255","ABCC6" -"UniProt:Q5THT1","Q5THT1" -"UniProt:Q9ULD5","ZNF777" -"UniProt:Q99551","MTERF1" -"UniProt:Q9UK39","NOCT" -"UniProt:P00830","ATP2" -"UniProt:Q8NGU2","OR9A4" -"UniProt:P49763","PGF" -"UniProt:Q96L46","CAPNS2" -"UniProt:Q3LI61","KRTAP20-2" -"UniProt:Q8IWZ8","SUGP1" -"UniProt:Q8NGH5","OR56A1" -"UniProt:O95476","CNEP1" -"UniProt:Q96AQ1","CCDC74A" -"UniProt:P07738","BPGM" -"UniProt:O95292","VAPB" -"UniProt:Q8WVJ9","TWIST2" -"UniProt:P0C6C1","ANKRD34C" -"UniProt:B4DS77","SHISA9" -"UniProt:Q9BUF5","TUBB6" -"UniProt:Q96RI9","TAAR9" -"UniProt:P10645","CHGA" -"UniProt:Q8N567","ZCCHC9" -"UniProt:P42331","ARHGAP25" -"UniProt:Q9BZF9","UACA" -"UniProt:P08254","MMP3" -"UniProt:Q5T0F9","CC2D1B" -"UniProt:Q99643","SDHC" -"UniProt:Q5JRS4","OR10J3" -"UniProt:Q9H2E6","SEMA6A" -"UniProt:P05129","PRKCG" -"UniProt:Q8NGN3","OR10G4" -"UniProt:P52907","CAZA1" -"UniProt:Q969S8","HDAC10" -"UniProt:O43609","SPRY1" -"UniProt:Q9Y5T5","USP16" -"UniProt:Q9NQ79","CRTAC1" -"UniProt:Q9HCS2","CYP4F12" -"UniProt:P51570","GALK1" -"UniProt:P12491","env" -"UniProt:Q9H1A3","METTL9" -"UniProt:Q9Y3L3","SH3BP1" -"UniProt:Q8N137","CNTRB" -"UniProt:B9EJG8","TMEM150C" -"UniProt:O94900","TOX" -"UniProt:P30483","HLA-B" -"UniProt:P00414","COX3" -"UniProt:A6NCS4","NKX2-6" -"UniProt:P53801","PTTG1IP" -"UniProt:Q80VJ8","KASH5" -"UniProt:Q8TC71","SPATA18" -"UniProt:Q9Y6G9","DYNC1LI1" -"UniProt:O43448","KCNAB3" -"UniProt:P25611","RDS1" -"UniProt:Q499L9","Q499L9" -"UniProt:P41586","ADCYAP1R1" -"UniProt:P03915","ND5" -"UniProt:Q86T75","NBPF11" -"UniProt:Q6P2E9","EDC4" -"UniProt:Q86VH2","KIF27" -"UniProt:O95876","WDPCP" -"UniProt:Q9H0G5","NSRP1" -"UniProt:P00747","PLG" -"UniProt:Q96JI7","SPG11" -"UniProt:Q7Z5G4","GOGA7" -"UniProt:Q13098","GPS1" -"UniProt:C9JE40","PATL2" -"UniProt:P47811","Mapk14" -"UniProt:Q9UBQ5","EIF3K" -"UniProt:Q9NWS0","PIH1D1" -"UniProt:Q8N485","LIX1" -"UniProt:O43548","TGM5" -"UniProt:P30504","HLA-C" -"UniProt:Q92888","ARHG1" -"UniProt:Q9UKI9","POU2F3" -"UniProt:Q10567","AP1B1" -"UniProt:A0JLT2","MED19" -"UniProt:P25325","MPST" -"UniProt:O00391","QSOX1" -"UniProt:Q8TDP1","RNASEH2C" -"UniProt:O43435","TBX1" -"UniProt:Q8N0S6","CENPL" -"UniProt:O75935","DCTN3" -"UniProt:P12490","env" -"UniProt:P28472","GABRB3" -"UniProt:C9J2P7","USP17L15" -"UniProt:Q8IUN9","CLEC10A" -"UniProt:Q9BUT1","BDH2" -"UniProt:Q8N6F7","GCSAM" -"UniProt:P41236","IPP2" -"UniProt:O94812","BAIAP3" -"UniProt:P10767","FGF6" -"UniProt:P15873","PCNA" -"UniProt:P08134","RHOC" -"UniProt:P24522","GADD45A" -"UniProt:A6NEE1","PLEKHD1" -"UniProt:O43525","KCNQ3" -"UniProt:P41439","FOLR3" -"UniProt:P51617","IRAK1" -"UniProt:O95633","FSTL3" -"UniProt:O75792","RNASEH2A" -"UniProt:P01718","IGLV3-27" -"UniProt:O00220","TR10A" -"UniProt:Q66JQ7","KNL1" -"UniProt:Q9NSK0","KLC4" -"UniProt:Q5MJ08","SPANXN4" -"UniProt:P55283","CDH4" -"UniProt:Q9UJK0","TSR3" -"UniProt:Q9UKN1","MUC12" -"UniProt:P35030","PRSS3" -"UniProt:Q8WZ64","ARAP2" -"UniProt:Q8N4C0","C9orf62" -"UniProt:Q9NWS9","ZNF446" -"UniProt:P40151","WRIP1" -"UniProt:A6NFU8","PGPEP1L" -"UniProt:Q12983","BNIP3" -"UniProt:P00181","CP2C2" -"UniProt:Q9BXJ8","T120A" -"UniProt:Q07812","BAX" -"UniProt:Q96G74","OTUD5" -"UniProt:Q6P9F5","TRIM40" -"UniProt:Q9P2N2","ARHGAP28" -"UniProt:Q6JEL2","KLHL10" -"UniProt:Q8WTT0","CLEC4C" -"UniProt:Q13046","PSG7" -"UniProt:P04591","GAG" -"UniProt:O43320","FGF16" -"UniProt:Q8WTQ7","GRK7" -"UniProt:Q86VY4","TSYL5" -"UniProt:Q9H8M7","F188A" -"UniProt:P03901","ND4L" -"UniProt:Q8N0Y7","PGAM4" -"UniProt:Q8WV99","ZFAND2B" -"UniProt:Q8C0V1","TERB1" -"UniProt:P02652","APOA2" -"UniProt:Q68DD2","PLA2G4F" -"UniProt:Q6BAA4","FCRLB" -"UniProt:Q6T424","Q6T424" -"UniProt:Q61824","ADA12" -"UniProt:Q13439","GOLGA4" -"UniProt:P04278","SHBG" -"UniProt:P33947","KDELR2" -"UniProt:Q9Y3T6","R3HCC1" -"UniProt:Q01959","SLC6A3" -"UniProt:Q6ZQN7","SLCO4C1" -"UniProt:Q13228","SELENBP1" -"UniProt:P97764","WBP1" -"UniProt:Q6ZSJ9","SHISA6" -"UniProt:Q9BWX5","GATA5" -"UniProt:Q5VYS4","MEDAG" -"UniProt:P05060","SCG1" -"UniProt:P40460","NDC80" -"UniProt:Q96PT4","DUX3" -"UniProt:O95754","SEMA4F" -"UniProt:Q14376","GALE" -"UniProt:Q13268","DHRS2" -"UniProt:Q9Y5S1","TRPV2" -"UniProt:A4QPB2","LRP5L" -"UniProt:Q8WWN8","ARAP3" -"UniProt:P60329","KR124" -"UniProt:Q99471","PFD5" -"UniProt:Q14766","LTBP1" -"UniProt:Q8IWB7","WDFY1" -"UniProt:Q6NYC1","JMJD6" -"UniProt:Q9H3Y8","PPDPF" -"UniProt:J3KQ26","J3KQ26" -"UniProt:O35179","Sh3gl2" -"UniProt:O60488","ACSL4" -"UniProt:Q9Y6Q5","AP1M2" -"UniProt:P51688","SGSH" -"UniProt:Q8N9I5","FADS6" -"UniProt:P21283","ATP6V1C1" -"UniProt:Q9NUR3","TMEM74B" -"UniProt:O75665","OFD1" -"UniProt:Q9UJ90","KCNE5" -"UniProt:Q5T749","KPRP" -"UniProt:Q7Z698","SPRE2" -"UniProt:P15586","GNS" -"UniProt:Q9Y2P4","SLC27A6" -"UniProt:Q7L2J0","MEPCE" -"UniProt:P41732","TSPAN7" -"UniProt:Q9NVM9","ASUN" -"UniProt:Q6ZU65","UBN2" -"UniProt:Q12929","EPS8" -"UniProt:Q9UMR5","PPT2" -"UniProt:P01123","YPT1" -"UniProt:P19549","env" -"UniProt:Q96EK7","FAM120B" -"UniProt:P17709","HXKG" -"UniProt:Q00403","TF2B" -"UniProt:P31153","MAT2A" -"UniProt:Q12796","PNRC1" -"UniProt:P59544","TAS2R50" -"UniProt:P59046","NLRP12" -"UniProt:Q99705","MCHR1" -"UniProt:Q96JK2","DCAF5" -"UniProt:Q15238","PSG5" -"UniProt:Q9GZY4","COA1" -"UniProt:Q6ZNG9","KRBA2" -"UniProt:P51843","NR0B1" -"UniProt:Q8TAW3","ZNF671" -"UniProt:Q96DU7","ITPKC" -"UniProt:Q96A54","ADIPOR1" -"UniProt:Q62108","DLG4" -"UniProt:Q9UIH9","KLF15" -"UniProt:O60427","FADS1" -"UniProt:Q9BYQ4","KRA92" -"UniProt:Q9UI40","SLC24A2" -"UniProt:O43688","PLPP2" -"UniProt:P17661","DES" -"UniProt:Q9HAT1","LMAN1L" -"UniProt:Q76NI1","KNDC1" -"UniProt:P02771","AFP" -"UniProt:Q9Y4X0","AMMECR1" -"UniProt:P62166","NCS1" -"UniProt:Q9BWM5","ZNF416" -"UniProt:Q9NSI6","BRWD1" -"UniProt:Q61412","VSX2" -"UniProt:Q8NI29","FBXO27" -"UniProt:Q3ZCX4","ZNF568" -"UniProt:P30954","OR10J1" -"UniProt:O00161","SNP23" -"UniProt:P49137","MAPK2" -"UniProt:P16410","CTLA4" -"UniProt:O94868","FCSD2" -"UniProt:Q96RQ1","ERGIC2" -"UniProt:P35858","IGFALS" -"UniProt:Q8NBP0","TTC13" -"UniProt:O14910","LIN7A" -"UniProt:Q9H1I8","ASCC2" -"UniProt:Q14166","TTLL12" -"UniProt:Q15696","ZRSR2" -"UniProt:Q15772","SPEG" -"UniProt:Q6Q0C1","SLC25A47" -"UniProt:Q09019","DMWD" -"UniProt:Q6NSB6","Q6NSB6" -"UniProt:Q96G75","RMD5B" -"UniProt:Q9Y5L4","TIMM13" -"UniProt:P13945","ADRB3" -"UniProt:Q9UM00","TMCO1" -"UniProt:Q969N4","TAAR8" -"UniProt:Q96P50","ACAP3" -"UniProt:O75290","ZNF780A" -"UniProt:P84243","H3F3B;H3F3A" -"UniProt:Q12959","DLG1" -"UniProt:Q9H5F2","CK001" -"UniProt:Q96CA5","BIRC7" -"UniProt:P62317","SMD2" -"UniProt:P60710","Actb" -"UniProt:Q562R1","ACTBL" -"UniProt:Q96JQ0","DCHS1" -"UniProt:Q9UH65","SWAP70" -"UniProt:P46965","SPC1" -"UniProt:Q96Q27","ASB2" -"UniProt:Q3KNS6","ZN829" -"UniProt:Q13614","MTMR2" -"UniProt:Q9NRX2","MRPL17" -"UniProt:Q9NU63","ZFP57" -"UniProt:Q9NVM6","DNAJC17" -"UniProt:Q9Y574","ASB4" -"UniProt:P18433","PTPRA" -"UniProt:Q01196","RUNX1" -"UniProt:Q7LFX5","CHSTF" -"UniProt:P42575","CASP2" -"UniProt:Q96A44","SPSB4" -"UniProt:Q13303","KCNAB2" -"UniProt:P18824","arm" -"UniProt:P21554","CNR1" -"UniProt:Q9UBU9","NXF1" -"UniProt:O60313","OPA1" -"UniProt:P36269","GGT5" -"UniProt:Q8NAE3","CA180" -"UniProt:Q8VDD5","Myh9" -"UniProt:Q9Y2L9","LRCH1" -"UniProt:P0DMN0","SULT1A4" -"UniProt:O15126","SCAMP1" -"UniProt:Q15034","HERC3" -"UniProt:P25940","COL5A3" -"UniProt:Q9UPX8","SHANK2" -"UniProt:Q96HL8","SH3Y1" -"UniProt:Q08909","YO385" -"UniProt:P12270","TPR" -"UniProt:P28289","TMOD1" -"UniProt:Q9Y2Y6","TMEM98" -"UniProt:Q9NRQ2","PLS4" -"UniProt:Q92543","SNX19" -"UniProt:Q92537","SUSD6" -"UniProt:P22307","SCP2" -"UniProt:Q8TC21","ZN596" -"UniProt:Q9NYH9","UTP6" -"UniProt:P56278","MTCP1" -"UniProt:Q7LFL8","CXXC5" -"UniProt:P60568","IL2" -"UniProt:P52798","EFNA4" -"UniProt:Q16548","B2LA1" -"UniProt:Q9UDY2","TJP2" -"UniProt:Q9Y260","Q9Y260" -"UniProt:P18409","MDM10" -"UniProt:Q04205","TENS" -"UniProt:O43541","SMAD6" -"UniProt:P07437","TUBB" -"UniProt:Q9Y397","ZDHHC9" -"UniProt:Q5U5R9","HECTD2" -"UniProt:A8K0Y0","A8K0Y0" -"UniProt:Q9BZ71","PITPNM3" -"UniProt:Q96BD5","PF21A" -"UniProt:P43629","KIR3DL1" -"UniProt:Q08495","DEMA" -"UniProt:Q6NSI3","FAM53A" -"UniProt:Q9BUK0","CHCHD7" -"UniProt:Q9H6L2","TMEM231" -"UniProt:Q8WU68","U2AF1L4" -"UniProt:P61983","1433G" -"UniProt:Q15077","P2RY6" -"UniProt:P14679","TYR" -"UniProt:Q9NQT4","EXOS5" -"UniProt:P12319","FCER1A" -"UniProt:P10092","CALCB" -"UniProt:P49746","THBS3" -"UniProt:P21399","ACO1" -"UniProt:Q8WV28","BLNK" -"UniProt:Q3ZCW2","LGALSL" -"UniProt:Q96RJ3","TNFRSF13C" -"UniProt:Q6PGQ7","BORA" -"UniProt:Q8N9W5","DNAAF3" -"UniProt:P42226","STAT6" -"UniProt:P05108","CYP11A1" -"UniProt:Q8IWT6","LRRC8A" -"UniProt:Q6P2C0","WDR93" -"UniProt:Q9HD42","CHMP1A" -"UniProt:Q9H3K6","BOLA2" -"UniProt:Q6PJ69","TRIM65" -"UniProt:P16573","CEAM1" -"UniProt:Q6P4H8","F173B" -"UniProt:Q8IZF3","AGRF4" -"UniProt:O43526","KCNQ2" -"UniProt:Q9Y3Q7","ADAM18" -"UniProt:B3EWG5","FAM25C" -"UniProt:Q9BPX5","ARPC5L" -"UniProt:Q6ZMB0","B3GNT6" -"UniProt:Q8VDF2","UHRF1" -"UniProt:Q9H496","IFG15" -"UniProt:Q12857","NFIA" -"UniProt:Q14814","MEF2D" -"UniProt:O00142","TK2" -"UniProt:Q9H4L5","OSBL3" -"UniProt:Q9NY91","SLC5A4" -"UniProt:Q9Y5K3","PCYT1B" -"UniProt:Q7L804","RFIP2" -"UniProt:O95671","ASMTL" -"UniProt:Q8N2Y8","RUSC2" -"UniProt:Q66K46","KIF5B" -"UniProt:Q9NVF9","ETNK2" -"UniProt:Q6IQ16","SPOPL" -"UniProt:Q13123","RED" -"UniProt:Q96QV6","HIST1H2AA" -"UniProt:Q6ZVZ8","ASB18" -"UniProt:Q8TEQ0","SNX29" -"UniProt:Q5VV41","ARHGEF16" -"UniProt:Q7Z402","TMC7" -"UniProt:Q9BY79","MFRP" -"UniProt:Q8WYR4","RSPH1" -"UniProt:P52298","NCBP2" -"UniProt:P25554","SGF29" -"UniProt:Q8IUH4","ZDHHC13" -"UniProt:P42677","RPS27" -"UniProt:P40426","PBX3" -"UniProt:Q95IE3","HLA-DRB1" -"UniProt:P11836","MS4A1" -"UniProt:Q93098","WNT8B" -"UniProt:P29074","PTPN4" -"UniProt:O15541","RNF113A" -"UniProt:O75381","PEX14" -"UniProt:Q9NW15","ANO10" -"UniProt:P0C7P0","CISD3" -"UniProt:P98082","DAB2" -"UniProt:Q9Y4B4","ARIP4" -"UniProt:Q6S8J7","POTEA" -"UniProt:Q9NZ42","PSENEN" -"UniProt:Q96NL8","C8orf37" -"UniProt:Q13017","ARHGAP5" -"UniProt:Q6PD74","AAGAB" -"UniProt:O75369","FLNB" -"UniProt:Q8N5A5","ZGPAT" -"UniProt:P47872","SCTR" -"UniProt:Q12962","TAF10" -"UniProt:A6NCW7","USP17L4" -"UniProt:Q9NZU1","FLRT1" -"UniProt:Q15413","RYR3" -"UniProt:Q9BQI3","EIF2AK1" -"UniProt:O43829","ZBT14" -"UniProt:Q14677","CLINT1" -"UniProt:P61353","RPL27" -"UniProt:O14795","UNC13B" -"UniProt:Q9NWW5","CLN6" -"UniProt:Q9NU39","FX4L1" -"UniProt:O60235","TMPRSS11D" -"UniProt:Q9UHC1","MLH3" -"UniProt:P78552","I13R1" -"UniProt:Q8N5W8","FA24B" -"UniProt:O43657","TSPAN6" -"UniProt:Q9BZQ6","EDEM3" -"UniProt:Q16566","CAMK4" -"UniProt:Q9NRR8","CDC42SE1" -"UniProt:P33535","OPRM1" -"UniProt:Q401N2","ZACN" -"UniProt:P29120","PCSK1" -"UniProt:P10721","KIT" -"UniProt:Q15907","RAB11B" -"UniProt:O94851","MICAL2" -"UniProt:P22083","FUT4" -"UniProt:Q6P4R8","NFRKB" -"UniProt:P32589","HSP7F" -"UniProt:Q92785","DPF2" -"UniProt:Q8TCN5","ZNF507" -"UniProt:Q91XC0","Ajuba" -"UniProt:Q6IBS0","TWF2" -"UniProt:Q96DP5","MTFMT" -"UniProt:Q6V0L0","CYP26C1" -"UniProt:Q8TEB1","DCAF11" -"UniProt:Q15067","ACOX1" -"UniProt:Q5T3F8","TMEM63B" -"UniProt:Q99990","VGLL1" -"UniProt:Q569K6","CCDC157" -"UniProt:Q9NQ66","PLCB1" -"UniProt:Q8BHJ5","Tbl1xr1" -"UniProt:P17014","ZNF12" -"UniProt:Q96EJ4","Q96EJ4" -"UniProt:Q02413","DSG1" -"UniProt:Q8IXZ3","SP8" -"UniProt:P17025","ZNF182" -"UniProt:Q3KQV3","ZN792" -"UniProt:P08100","RHO" -"UniProt:P42858","HTT" -"UniProt:Q99250","SCN2A" -"UniProt:Q9BXC1","GPR174" -"UniProt:P15814","IGLL1" -"UniProt:O43909","EXTL3" -"UniProt:Q9ULJ8","NEB1" -"UniProt:Q8NGZ5","OR2G2" -"UniProt:Q969X2","ST6GALNAC6" -"UniProt:P16234","PDGFRA" -"UniProt:Q16630","CPSF6" -"UniProt:O75534","CSDE1" -"UniProt:Q5T6F0","DCAF12" -"UniProt:Q6PI73","LILRA6" -"UniProt:P56192","MARS" -"UniProt:P05534","HLA-A" -"UniProt:Q9Y2D4","EXC6B" -"UniProt:P59827","BPIFB4" -"UniProt:Q86VD7","S2542" -"UniProt:O14770","MEIS2" -"UniProt:Q8N2W9","PIAS4" -"UniProt:Q9NRG9","AAAS" -"UniProt:Q8NCQ5","FBXO15" -"UniProt:Q5TBB1","RNASEH2B" -"UniProt:Q9NPH6","OBP2B" -"UniProt:Q99640","PKMYT1" -"UniProt:Q14832","GRM3" -"UniProt:Q8WWI1","LMO7" -"UniProt:Q8TB68","PRR7" -"UniProt:Q96DC8","ECHDC3" -"UniProt:Q2M2I5","K1C24" -"UniProt:Q96DA6","DNAJC19" -"UniProt:P37059","HSD17B2" -"UniProt:Q9UBP9","GULP1" -"UniProt:Q9NYJ8","TAB2" -"UniProt:Q7Z3Y8","K1C27" -"UniProt:P04216","THY1" -"UniProt:P0DP25","CALM1" -"UniProt:Q9Y487","ATP6V0A2" -"UniProt:P05538","HLA-DQB2" -"UniProt:Q9UMX0","UBQL1" -"UniProt:Q9BRR6","ADPGK" -"UniProt:Q6L8G8","KRA57" -"UniProt:Q16134","ETFDH" -"UniProt:Q99828","CIB1" -"UniProt:Q16778","HIST2H2BE" -"UniProt:Q5NDL2","EOGT" -"UniProt:P84080","ARF1" -"UniProt:Q9UBF6","RBX2" -"UniProt:P35590","TIE1" -"UniProt:P38117","ETFB" -"UniProt:Q9Y252","RNF6" -"UniProt:P38837","NSG1" -"UniProt:Q6NSI8","KIAA1841" -"UniProt:Q15517","CDSN" -"UniProt:Q96C28","ZNF707" -"UniProt:Q9EQG6","Kidins220" -"UniProt:Q96JW4","SLC41A2" -"UniProt:Q13588","GRAP" -"UniProt:Q13164","MAPK7" -"UniProt:P03211","EBNA1" -"UniProt:Q7Z3Y7","K1C28" -"UniProt:Q8NEA6","GLIS3" -"UniProt:Q30KQ7","DEFB113" -"UniProt:P19012","K1C15" -"UniProt:Q99999","GAL3ST1" -"UniProt:Q70JA7","CHSY3" -"UniProt:Q96CD2","COAC" -"UniProt:Q8WW38","ZFPM2" -"UniProt:P54578","USP14" -"UniProt:Q6R327","RICTR" -"UniProt:Q9BRK5","CAB45" -"UniProt:O75444","MAF" -"UniProt:P30203","CD6" -"UniProt:O76083","PDE9A" -"UniProt:Q5T7V8","GORAB" -"UniProt:O15078","CEP290" -"UniProt:Q9NXH8","TOR4A" -"UniProt:P09104","ENO2" -"UniProt:P17017","ZNF14" -"UniProt:Q96PQ1","SIGLEC12" -"UniProt:Q562E7","WDR81" -"UniProt:Q5T1B0","AXDND1" -"UniProt:Q8IWT0","ZBTB8OS" -"UniProt:Q07817","B2CL1" -"UniProt:Q96GS4","BORC6" -"UniProt:Q92858","ATOH1" -"UniProt:Q6IEE7","TMEM132E" -"UniProt:Q9H9C1","VIPAS39" -"UniProt:O75474","FRAT2" -"UniProt:Q96EY9","ADAT3" -"UniProt:P35569","Irs1" -"UniProt:Q8NCD3","HJURP" -"UniProt:P48742","LHX1" -"UniProt:A2PYH4","HFM1" -"UniProt:P19113","HDC" -"UniProt:Q9H0C8","ILKAP" -"UniProt:P58876","HIST1H2BD" -"UniProt:P30626","SORCN" -"UniProt:P04853","HN" -"UniProt:O43505","B4GAT1" -"UniProt:Q15418","RPS6KA1" -"UniProt:O95239","KIF4A" -"UniProt:O15481","MAGB4" -"UniProt:Q9P0K7","RAI14" -"UniProt:Q9H2H0","CXXC4" -"UniProt:Q86W26","NLRP10" -"UniProt:Q9H4I2","ZHX3" -"UniProt:Q8N7U6","EFHB" -"UniProt:P51164","ATP4B" -"UniProt:Q96PE1","AGRA2" -"UniProt:A6NC98","CC88B" -"UniProt:Q86WA8","LONP2" -"UniProt:Q16836","HADH" -"UniProt:Q96MC2","DRC1" -"UniProt:Q9Y3B8","REXO2" -"UniProt:Q12207","NCE2" -"UniProt:Q9NXA8","SIRT5" -"UniProt:Q14525","KT33B" -"UniProt:Q57236","Q57236" -"UniProt:Q71SY5","MED25" -"UniProt:Q96G79","SLC35A4" -"UniProt:Q9Y217","MTMR6" -"UniProt:Q9BX26","SYCP2" -"UniProt:Q96E09","F122A" -"UniProt:P14770","GP9" -"UniProt:P42337","Pik3ca" -"UniProt:A0A087X037","A0A087X037" -"UniProt:Q8IYK2","CCDC105" -"UniProt:Q8N831","TSYL6" -"UniProt:O76015","KRT38" -"UniProt:Q9P232","CNTN3" -"UniProt:P62493","RB11A" -"UniProt:Q8WX94","NLRP7" -"UniProt:Q9BW85","CCD94" -"UniProt:Q14126","DSG2" -"UniProt:P31644","GABRA5" -"UniProt:Q86YD3","TMEM25" -"UniProt:Q14839","CHD4" -"UniProt:O94806","PRKD3" -"UniProt:Q5TAP6","UT14C" -"UniProt:Q9P246","STIM2" -"UniProt:P25385","BOS1" -"UniProt:Q15031","LARS2" -"UniProt:Q92947","GCDH" -"UniProt:Q9HBI5","C3orf14" -"UniProt:Q9BRK3","MXRA8" -"UniProt:Q494U1","PLEKHN1" -"UniProt:A0A0C4ZNX8","A0A0C4ZNX8" -"UniProt:Q86UQ0","ZNF589" -"UniProt:Q8TDF5","NETO1" -"UniProt:Q6PJ21","SPSB3" -"UniProt:Q8IVF1","NUTM2A" -"UniProt:Q9BXB1","LGR4" -"UniProt:Q9GZY0","NXF2B" -"UniProt:Q99569","PKP4" -"UniProt:Q9BPU6","DPYSL5" -"UniProt:J3KR25","J3KR25" -"UniProt:Q9Y3D2","MSRB2" -"UniProt:Q9UIA9","XPO7" -"UniProt:P98173","FAM3A" -"UniProt:Q6ZNE9","RUFY4" -"UniProt:P54710","FXYD2" -"UniProt:Q9H503","BANF2" -"UniProt:Q8NFU1","BEST2" -"UniProt:Q8TCU4","ALMS1" -"UniProt:O14649","KCNK3" -"UniProt:Q8NHC8","OR2T6" -"UniProt:P20618","PSB1" -"UniProt:P01270","PTH" -"UniProt:Q6NUS8","UGT3A1" -"UniProt:Q9UNE2","RPH3AL" -"UniProt:P31513","FMO3" -"UniProt:P02760","AMBP" -"UniProt:Q8NGF8","OR4B1" -"UniProt:P35225","IL13" -"UniProt:P17032","ZNF37A" -"UniProt:Q8NGG0","OR8J3" -"UniProt:Q8NGA2","OR7A2P" -"UniProt:Q5VK71","AKAP8" -"UniProt:Q9HAB8","PPCS" -"UniProt:O15198","SMAD9" -"UniProt:Q9NX78","TMEM260" -"UniProt:P35968","KDR" -"UniProt:Q6IA86","ELP2" -"UniProt:Q03338","PRP3" -"UniProt:Q8NGH6","OR52L2P" -"UniProt:Q8N6V9","TEX9" -"UniProt:Q9NZC2","TREM2" -"UniProt:Q13492","PICALM" -"UniProt:P01213","PDYN" -"UniProt:Q8NGN8","OR4A4P" -"UniProt:Q86YS6","RAB43" -"UniProt:Q99973","TEP1" -"UniProt:Q0ZLH3","PJVK" -"UniProt:Q9C073","FAM117A" -"UniProt:P11161","EGR2" -"UniProt:Q8N6Q8","METTL25" -"UniProt:P46976","GYG1" -"UniProt:Q6ZUX7","LHFPL2" -"UniProt:Q9H1D9","POLR3F" -"UniProt:Q10668","SWI2" -"UniProt:A6NL08","OR6C75" -"UniProt:Q9Y224","CN166" -"UniProt:Q9NQZ6","ZC4H2" -"UniProt:P24752","ACAT1" -"UniProt:Q8N8Y2","VA0D2" -"UniProt:Q5GH77","XKR3" -"UniProt:Q96CG3","TIFA" -"UniProt:O60733","PLA2G6" -"UniProt:Q8NGJ3","OR52E1" -"UniProt:Q9UJ98","STAG3" -"UniProt:Q10571","MN1" -"UniProt:Q05066","SRY" -"UniProt:Q8NH18","OR5J2" -"UniProt:Q10728","Ppp1r12a" -"UniProt:P51582","P2RY4" -"UniProt:Q9UDW1","UQCR10" -"UniProt:Q8IVW4","CDKL3" -"UniProt:P40956","GTS1" -"UniProt:Q9NYF0","DACT1" -"UniProt:Q9P031","CCDC59" -"UniProt:Q6ZN84","CCDC81" -"UniProt:O95866","MPIG6B" -"UniProt:Q99985","SEMA3C" -"UniProt:P01566","IFNA10" -"UniProt:Q5T4F4","ZFYVE27" -"UniProt:Q9P2P5","HECW2" -"UniProt:P78412","IRX6" -"UniProt:P59922","OR2B8P" -"UniProt:Q8NGB9","OR4F6" -"UniProt:P32881","IFNA8" -"UniProt:B4URF5","B4URF5" -"UniProt:Q8NGL0","OR5L2" -"UniProt:Q5T440","IBA57" -"UniProt:Q96RJ0","TAAR1" -"UniProt:Q8NGF6","OR10W1" -"UniProt:A6NCI4","VWA3A" -"UniProt:Q12771","Q12771" -"UniProt:A6NET4","OR5K3" -"UniProt:Q96P71","NECAB3" -"UniProt:Q8NFA2","NOXO1" -"UniProt:Q96LW7","CAR19" -"UniProt:Q86TX2","ACOT1" -"UniProt:Q8NGJ1","OR4D6" -"UniProt:O75593","FOXH1" -"UniProt:O60336","MAPKBP1" -"UniProt:Q6P088","Q6P088" -"UniProt:Q5C9Z4","NOM1" -"UniProt:P19367","HK1" -"UniProt:Q96PZ0","PUS7" -"UniProt:Q5ZUS4","Q5ZUS4" -"UniProt:Q9EQL9","Sharpin" -"UniProt:Q9BRL4","Q9BRL4" -"UniProt:Q8NGP3","OR5M9" -"UniProt:P18615","NELFE" -"UniProt:P15954","COX7C" -"UniProt:Q01415","GALK2" -"UniProt:Q9Y4A9","OR10H1" -"UniProt:O15297","PPM1D" -"UniProt:P80303","NUCB2" -"UniProt:P63241","IF5A1" -"UniProt:Q14694","USP10" -"UniProt:Q8IYR0","CF206" -"UniProt:Q6IFH4","OR6B2" -"UniProt:O43196","MSH5" -"UniProt:Q6YFQ2","COX6B2" -"UniProt:Q9UBE0","SAE1" -"UniProt:O43345","ZNF208" -"UniProt:Q9UDX3","S14L4" -"UniProt:P10746","UROS" -"UniProt:O43914","TYROBP" -"UniProt:O60658","PDE8A" -"UniProt:A6NHC0","CAPN8" -"UniProt:Q8VDQ8","SIR2" -"UniProt:Q13064","MKRN3" -"UniProt:Q7RTT9","SLC29A4" -"UniProt:Q8NH04","OR2T27" -"UniProt:Q01543","FLI1" -"UniProt:Q8N5N6","Q8N5N6" -"UniProt:P49642","PRIM1" -"UniProt:Q8NGY1","OR10Z1" -"UniProt:P35579","MYH9" -"UniProt:Q8NGI4","OR4D11" -"UniProt:Q53T59","HS1BP3" -"UniProt:P51124","GZMM" -"UniProt:O15409","FOXP2" -"UniProt:A6NGA9","TMEM202" -"UniProt:Q96T49","PP16B" -"UniProt:Q8WTR2","DUSP19" -"UniProt:Q00765","REEP5" -"UniProt:A6NCV1","OR6C74" -"UniProt:P57057","SLC37A1" -"UniProt:P59538","TAS2R31" -"UniProt:P36873","PPP1CC" -"UniProt:Q9NR46","SHLB2" -"UniProt:Q8N135","LGI4" -"UniProt:Q9BXS0","COL25A1" -"UniProt:Q13367","AP3B2" -"UniProt:Q8WU79","SMAP2" -"UniProt:P01861","IGHG4" -"UniProt:A1L4F5","A1L4F5" -"UniProt:Q96Q11","TRNT1" -"UniProt:Q5T5P2","KIAA1217" -"UniProt:Q6RFH8","DUX4C" -"UniProt:Q14003","KCNC3" -"UniProt:O95665","NTSR2" -"UniProt:P0C617","OR5AL1" -"UniProt:P0CW19","LIMS3" -"UniProt:Q2TBA0","KLHL40" -"UniProt:Q8NH57","OR52P1P" -"UniProt:Q9NXI6","RN186" -"UniProt:P31271","HOXA13" -"UniProt:Q03167","TGFBR3" -"UniProt:Q8NGG1","OR8J2" -"UniProt:Q9ULY5","CLEC4E" -"UniProt:Q13398","ZNF211" -"UniProt:P01859","IGHG2" -"UniProt:Q6IF82","OR4A47" -"UniProt:P51854","TKTL1" -"UniProt:Q92925","SMARCD2" -"UniProt:Q8NH70","OR4A16" -"UniProt:Q8N6M0","OTUD6B" -"UniProt:Q8IWU9","TPH2" -"UniProt:P25788","PSA3" -"UniProt:Q8N319","C6orf223" -"UniProt:Q15170","TCEAL1" -"UniProt:Q9NYL5","CYP39A1" -"UniProt:P17900","GM2A" -"UniProt:Q9NZD8","SPG21" -"UniProt:P22301","IL10" -"UniProt:Q13043","STK4" -"UniProt:Q86VQ1","GLCCI1" -"UniProt:Q5SQQ9","VAX1" -"UniProt:Q16663","CCL15" -"UniProt:Q99743","NPAS2" -"UniProt:Q9HCK8","CHD8" -"UniProt:O14520","AQP7" -"UniProt:P70168","IMB1" -"UniProt:P62820","RAB1A" -"UniProt:Q9P1A6","DLGAP2" -"UniProt:P06240","Lck" -"UniProt:Q13206","DDX10" -"UniProt:P13727","PRG2" -"UniProt:P09616","hly" -"UniProt:O95256","IL18RAP" -"UniProt:Q96DR5","BPIFA2" -"UniProt:Q9BT22","ALG1" -"UniProt:Q9UK85","DKKL1" -"UniProt:Q13075","NAIP" -"UniProt:Q9H5I5","PIEZO2" -"UniProt:Q8WXA3","RUFY2" -"UniProt:Q86TW2","ADCK1" -"UniProt:Q9HCK4","ROBO2" -"UniProt:P10966","CD8B" -"UniProt:C9J3I9","C5orf58" -"UniProt:P53814","SMTN" -"UniProt:Q9UKR8","TSPAN16" -"UniProt:P07711","CTSL" -"UniProt:Q504U0","CD046" -"UniProt:Q9H173","SIL1" -"UniProt:Q9UBM7","DHCR7" -"UniProt:Q00987","MDM2" -"UniProt:O94830","DDHD2" -"UniProt:A0A0S2Z4A7","A0A0S2Z4A7" -"UniProt:Q96KG7","MEGF10" -"UniProt:Q96SB3","NEB2" -"UniProt:P21953","BCKDHB" -"UniProt:Q8IU89","CERS3" -"UniProt:Q96KQ7","EHMT2" -"UniProt:P61020","RAB5B" -"UniProt:Q8N539","FIBCD1" -"UniProt:Q8NFU0","BEST4" -"UniProt:Q9UGL1","KDM5B" -"UniProt:P30456","HLA-A" -"UniProt:Q96CN5","LRC45" -"UniProt:P57055","DSCR6" -"UniProt:Q53G44","IFI44L" -"UniProt:P53420","COL4A4" -"UniProt:B7ZM81","B7ZM81" -"UniProt:O14810","CPLX1" -"UniProt:P0DP30","CALM" -"UniProt:Q5KU26","COLEC12" -"UniProt:Q7Z449","CYP2U1" -"UniProt:P23409","MYF6" -"UniProt:O76031","CLPX" -"UniProt:P42568","MLLT3" -"UniProt:O95409","ZIC2" -"UniProt:Q6PKH6","DHRS4L2" -"UniProt:I6T1Z2","I6T1Z2" -"UniProt:Q86SU0","ILDR1" -"UniProt:Q8TAV0","FAM76A" -"UniProt:P02741","CRP" -"UniProt:O15431","SLC31A1" -"UniProt:P07200","TGFB1" -"UniProt:Q9NXB0","MKS1" -"UniProt:Q9HCG7","GBA2" -"UniProt:O15040","TECPR2" -"UniProt:P55808","XG" -"UniProt:P49406","MRPL19" -"UniProt:Q8NDC0","MISSL" -"UniProt:Q96NW7","LRRC7" -"UniProt:P06179","fliC" -"UniProt:Q9BYT9","ANO3" -"UniProt:Q9Y6Y0","NS1BP" -"UniProt:O43837","IDH3B" -"UniProt:P43489","TNFRSF4" -"UniProt:P06865","HEXA" -"UniProt:P42126","ECI1" -"UniProt:Q9BUJ0","ABHD14A" -"UniProt:Q6XQN6","NAPRT" -"UniProt:O15265","ATXN7" -"UniProt:P21506","ZNF10" -"UniProt:Q86XN6","ZNF761" -"UniProt:Q9WUN2","Tbk1" -"UniProt:O00625","PIR" -"UniProt:P04180","LCAT" -"UniProt:Q8TBB1","LNX1" -"UniProt:P62990","UBIQ" -"UniProt:Q9NWF4","SLC52A1" -"UniProt:P08319","ADH4" -"UniProt:Q9UKG1","APPL1" -"UniProt:Q5VWZ2","LYPLAL1" -"UniProt:Q9UPU3","SORCS3" -"UniProt:Q9BRT2","UQCC2" -"UniProt:P17213","BPI" -"UniProt:P57729","RAB38" -"UniProt:Q8N6C8","LILRA3" -"UniProt:Q9NSI5","IGSF5" -"UniProt:P02687","MBP" -"UniProt:D6W601","D6W601" -"UniProt:P17157","PHO85" -"UniProt:P98196","ATP11A" -"UniProt:Q14CB8","ARHGAP19" -"UniProt:O60343","TBC1D4" -"UniProt:P01706","IGLV2-11" -"UniProt:Q8N4T0","CPA6" -"UniProt:O94804","STK10" -"UniProt:Q02539","HIST1H1A" -"UniProt:Q2PZI1","D19L1" -"UniProt:O75078","ADAM11" -"UniProt:A0PK05","TMEM72" -"UniProt:P33897","ABCD1" -"UniProt:P12004","PCNA" -"UniProt:Q8IXA5","SPACA3" -"UniProt:O60609","GFRA3" -"UniProt:O00222","GRM8" -"UniProt:F7VJQ1","PRNP" -"UniProt:Q15831","STK11" -"UniProt:P01782","IGHV3-9" -"UniProt:Q5T5U3","ARHGAP21" -"UniProt:Q9NNZ3","DNAJC4" -"UniProt:Q008S8","ECT2L" -"UniProt:Q96PH6","DEFB118" -"UniProt:Q92781","RDH5" -"UniProt:P55769","SNU13" -"UniProt:A6NGB9","WIPF3" -"UniProt:P53583","MPA43" -"UniProt:Q9P015","MRPL15" -"UniProt:O60565","GREM1" -"UniProt:A0A0S2Z6H0","A0A0S2Z6H0" -"UniProt:Q9BSR8","YIPF4" -"UniProt:Q969M3","YIPF5" -"UniProt:Q9H930","SP140L" -"UniProt:Q86VB7","CD163" -"UniProt:Q8TAB3","PCDH19" -"UniProt:Q76MZ3","2AAA" -"UniProt:Q9HAN9","NMNAT1" -"UniProt:Q99697","PITX2" -"UniProt:O75306","NDUFS2" -"UniProt:O95718","ESRRB" -"UniProt:P10275","AR" -"UniProt:P82979","SARNP" -"UniProt:O15049","N4BP3" -"UniProt:Q9NRM6","IL17RB" -"UniProt:Q8TB37","NUBPL" -"UniProt:Q5T8A7","PPP1R26" -"UniProt:O35601","Fyb" -"UniProt:P56703","WNT3" -"UniProt:Q9H6K4","OPA3" -"UniProt:O75344","FKBP6" -"UniProt:O43488","AKR7A2" -"UniProt:P21810","BGN" -"UniProt:Q8NC54","C5orf15" -"UniProt:Q52LW3","ARHGAP29" -"UniProt:P27987","IP3KB" -"UniProt:Q9Y297","BTRC" -"UniProt:Q9NR11","ZNF302" -"UniProt:Q99972","MYOC" -"UniProt:P31930","UQCRC1" -"UniProt:Q5TH74","STPG1" -"UniProt:O75173","ADAMTS4" -"UniProt:Q13261","IL15RA" -"UniProt:Q9UI12","ATP6V1H" -"UniProt:Q9JIS5","SV2A" -"UniProt:A0PJX0","CIB4" -"UniProt:Q6ZSZ6","TSHZ1" -"UniProt:P0CG06","IGLC3" -"UniProt:Q16854","DGUOK" -"UniProt:Q9D752","MD2L2" -"UniProt:O43172","PRPF4" -"UniProt:Q16678","CYP1B1" -"UniProt:O75747","PIK3C2G" -"UniProt:Q9BUG6","ZSA5A" -"UniProt:Q96D96","HVCN1" -"UniProt:P51531","SMARCA2" -"UniProt:P20594","NPR2" -"UniProt:Q9UNQ0","ABCG2" -"UniProt:A8MW92","P20L1" -"UniProt:P16949","STMN1" -"UniProt:P54845","NRL" -"UniProt:P00352","AL1A1" -"UniProt:Q9P0L9","PKD2L1" -"UniProt:Q8IZQ8","MYOCD" -"UniProt:Q5NV89","IGLV2-23" -"UniProt:Q8N6K0","TEX29" -"UniProt:Q14999","CUL7" -"UniProt:Q04877","opaI" -"UniProt:O95251","KAT7" -"UniProt:P20036","HLA-DPA1" -"UniProt:Q9UHP9","SMPX" -"UniProt:Q96KT7","S35G5" -"UniProt:Q5NV90","IGLV3-25" -"UniProt:Q86WJ1","CHD1L" -"UniProt:Q96Q45","TMEM237" -"UniProt:Q16799","RTN1" -"UniProt:Q7Z5H3","RHG22" -"UniProt:O43903","GAS2" -"UniProt:Q9UPM8","AP4E1" -"UniProt:Q8WVF5","KCTD4" -"UniProt:Q9H446","RWDD1" -"UniProt:Q5T3U5","ABCC10" -"UniProt:Q8WWV6","FCAMR" -"UniProt:Q9NQS3","NECTIN3" -"UniProt:Q7Z6M2","FBXO33" -"UniProt:Q9NP80","PNPLA8" -"UniProt:O43633","CHMP2A" -"UniProt:O75335","PPFIA4" -"UniProt:Q96GR4","ZDHHC12" -"UniProt:Q86W50","METTL16" -"UniProt:Q9NR83","SLC2A4RG" -"UniProt:Q96JD6","AKR1E2" -"UniProt:P49407","ARRB1" -"UniProt:O43174","CYP26A1" -"UniProt:Q5NV67","IGLV1-36" -"UniProt:Q7Z3K6","MIER3" -"UniProt:Q8WV93","LACE1" -"UniProt:P26367","PAX6" -"UniProt:Q8WUX9","CHMP7" -"UniProt:Q923E4","SIR1" -"UniProt:O43557","TNF14" -"UniProt:Q5XG92","CES4A" -"UniProt:Q9UQ80","PA2G4" -"UniProt:Q9BW92","TARS2" -"UniProt:O95747","OXSR1" -"UniProt:Q13609","DNASE1L3" -"UniProt:Q6P9F0","CCDC62" -"UniProt:Q9Y3Z3","SAMHD1" -"UniProt:Q5TDH0","DDI2" -"UniProt:O60493","SNX3" -"UniProt:P17174","GOT1" -"UniProt:Q96DD7","SHISA4" -"UniProt:O75323","NIPS2" -"UniProt:P62273","RPS29" -"UniProt:Q8TDW5","SYTL5" -"UniProt:Q9NR20","DYRK4" -"UniProt:Q13332","PTPRS" -"UniProt:Q9NR63","CYP26B1" -"UniProt:Q53H80","AKIR2" -"UniProt:Q13469","NFAC2" -"UniProt:O43918","AIRE" -"UniProt:Q9H093","NUAK2" -"UniProt:O55043","ARHG7" -"UniProt:O00459","PIK3R2" -"UniProt:O43602","DCX" -"UniProt:P22803","TRX2" -"UniProt:O75185","ATP2C2" -"UniProt:Q9NQZ3","DAZ1" -"UniProt:P36551","CPOX" -"UniProt:P40343","VPS27" -"UniProt:Q9Y584","TIMM22" -"UniProt:Q6NXE6","ARMC6" -"UniProt:A8TX70","COL6A5" -"UniProt:O43252","PAPSS1" -"UniProt:P49767","VEGFC" -"UniProt:O94903","PLPBP" -"UniProt:P10253","GAA" -"UniProt:P35573","AGL" -"UniProt:Q9Z2V5","HDAC6" -"UniProt:Q9NZI5","GRHL1" -"UniProt:Q9HAY6","BCO1" -"UniProt:P22725","Wnt5a" -"UniProt:P06737","PYGL" -"UniProt:P48637","GSS" -"UniProt:Q96C36","PYCR2" -"UniProt:Q8IXM7","ODF3L1" -"UniProt:Q9P0I2","EMC3" -"UniProt:Q9BQP9","BPIFA3" -"UniProt:O00182","LGALS9" -"UniProt:Q96HZ7","URAS1" -"UniProt:Q9BUL8","PDCD10" -"UniProt:Q86YB7","ECHDC2" -"UniProt:Q9UPT6","JIP3" -"UniProt:P68306","THB" -"UniProt:P19440","GGT1" -"UniProt:P12272","PTHLH" -"UniProt:P18463","HLA-B" -"UniProt:Q9BV79","MECR" -"UniProt:P31639","SLC5A2" -"UniProt:P47874","OMP" -"UniProt:Q15722","LTB4R" -"UniProt:P87662","P87662" -"UniProt:Q86SG3","DAZ4" -"UniProt:P13804","ETFA" -"UniProt:P19474","RO52" -"UniProt:P00966","ASS1" -"UniProt:Q8NDX2","SLC17A8" -"UniProt:P10074","ZBTB48" -"UniProt:Q9NUQ9","FAM49B" -"UniProt:P27040","Acvr2b" -"UniProt:Q9UNF1","MAGED2" -"UniProt:P57740","NUP107" -"UniProt:Q15390","MTFR1" -"UniProt:Q9BSQ5","CCM2" -"UniProt:Q5JWF8","ACTL10" -"UniProt:Q8WYH8","ING5" -"UniProt:Q3SY84","KRT71" -"UniProt:Q9UP38","FZD1" -"UniProt:O00507","USP9Y" -"UniProt:Q9NP87","POLM" -"UniProt:Q8WZA2","RAPGEF4" -"UniProt:Q4V339","CBWD6" -"UniProt:O43826","SLC37A4" -"UniProt:Q9BYM8","RBCK1" -"UniProt:P16442","ABO" -"UniProt:Q5HZG4","TAF3" -"UniProt:P39877","PLA2G5" -"UniProt:O60346","PHLP1" -"UniProt:Q9BUW7","C9orf16" -"UniProt:Q9BS92","NIPSNAP3B" -"UniProt:Q96MP8","KCTD7" -"UniProt:P09210","GSTA2" -"UniProt:P05091","ALDH2" -"UniProt:P35575","G6PC" -"UniProt:Q9UHA3","RSL24D1" -"UniProt:P11086","PNMT" -"UniProt:Q60825","NPT2A" -"UniProt:Q99865","SPIN2A" -"UniProt:Q6PJG9","LRFN4" -"UniProt:Q86YW9","MD12L" -"UniProt:P43088","PTGFR" -"UniProt:Q9H5J8","TAF1D" -"UniProt:Q13117","DAZ2" -"UniProt:Q9BZG2","ACP4" -"UniProt:Q9HAC7","SUGCT" -"UniProt:B2RXH4","BTBD18" -"UniProt:Q86W92","LIPB1" -"UniProt:Q9H0D6","XRN2" -"UniProt:P12829","MYL4" -"UniProt:P49336","CDK8" -"UniProt:Q9NR90","DAZ3" -"UniProt:P11217","PYGM" -"UniProt:Q96NT5","SLC46A1" -"UniProt:Q96J02","ITCH" -"UniProt:Q9H9D4","ZNF408" -"UniProt:P05783","KRT18" -"UniProt:Q04446","GBE1" -"UniProt:P32502","EI2BB" -"UniProt:L8B1Q7","L8B1Q7" -"UniProt:Q9H9B1","EHMT1" -"UniProt:P01704","IGLV2-14" -"UniProt:P61018","RAB4B" -"UniProt:Q9H0M0","WWP1" -"UniProt:P33402","GCYA2" -"UniProt:P50613","CDK7" -"UniProt:Q8WVD5","RN141" -"UniProt:P05787","KRT8" -"UniProt:P01574","IFNB1" -"UniProt:Q9UQ07","MOK" -"UniProt:P41797","SSA1" -"UniProt:P06789","VE1" -"UniProt:Q6TFL4","KLHL24" -"UniProt:P01615","IGKV2D-28" -"UniProt:Q99965","ADAM2" -"UniProt:P39900","MMP12" -"UniProt:Q96R45","OR2A7" -"UniProt:Q8N140","EID3" -"UniProt:Q8NDX1","PSD4" -"UniProt:Q13461","FOXE3" -"UniProt:P0CG29","GSTT2" -"UniProt:P01225","FSHB" -"UniProt:Q9ULH0","KIDINS220" -"UniProt:Q5R3I4","TTC38" -"UniProt:Q8IZT8","HS3ST5" -"UniProt:O95685","PPR3D" -"UniProt:Q8N118","CYP4X1" -"UniProt:O54781","SRPK2" -"UniProt:P23508","CRCM" -"UniProt:Q9UK23","NAGPA" -"UniProt:Q6P4I2","WDR73" -"UniProt:Q9BZW5","TM6SF1" -"UniProt:O94856","NFASC" -"UniProt:O43155","FLRT2" -"UniProt:P08237","PFKM" -"UniProt:Q9NPJ4","PNRC2" -"UniProt:P01042","KNG1" -"UniProt:Q96EE3","SEH1" -"UniProt:Q9BQS7","HEPH" -"UniProt:Q9UMN6","KMT2B" -"UniProt:Q9BU20","RSG1" -"UniProt:P57678","GEMI4" -"UniProt:Q8NI27","THOC2" -"UniProt:Q685J3","MUC17" -"UniProt:P09888","piiC" -"UniProt:P51450","RORC" -"UniProt:O14498","ISLR" -"UniProt:P30464","HLA-B" -"UniProt:Q8BHN1","TXLNG" -"UniProt:Q5FWF4","ZRAB3" -"UniProt:Q5M775","SPECC1" -"UniProt:Q9H4W6","EBF3" -"UniProt:Q07326","PIGF" -"UniProt:Q9ULZ2","STAP1" -"UniProt:Q9Y5N1","HRH3" -"UniProt:Q8N159","NAGS" -"UniProt:B4URF7","B4URF7" -"UniProt:Q8N1A6","CD033" -"UniProt:O75410","TACC1" -"UniProt:Q9BWG4","SSBP4" -"UniProt:O14490","DLGAP1" -"UniProt:Q8N823","ZNF611" -"UniProt:Q8NI32","LYPD6B" -"UniProt:Q03060","CREM" -"UniProt:P30740","SERPINB1" -"UniProt:O14525","ASTN1" -"UniProt:Q5SQN1","SNP47" -"UniProt:P56182","RRP1" -"UniProt:O43150","ASAP2" -"UniProt:Q9UHB6","LIMA1" -"UniProt:P04437","TCRA" -"UniProt:P13805","TNNT1" -"UniProt:Q9BVV2","FND11" -"UniProt:Q8IWZ5","TRI42" -"UniProt:Q86UR5","RIMS1" -"UniProt:Q16670","ZSC26" -"UniProt:O00257","CBX4" -"UniProt:Q8NHZ7","MB3L2" -"UniProt:A1L3A7","A1L3A7" -"UniProt:Q9ULL5","PRR12" -"UniProt:O95302","FKBP9" -"UniProt:O60830","TIMM17B" -"UniProt:O14818","PSA7" -"UniProt:P16189","HLA-A" -"UniProt:Q9NUJ1","ABHD10" -"UniProt:Q9H1B4","NXF5" -"UniProt:Q6UX01","LMBR1L" -"UniProt:P31944","CASP14" -"UniProt:Q9Y365","STARD10" -"UniProt:Q99638","RAD9A" -"UniProt:Q3MIS6","ZNF528" -"UniProt:B7Z3H4","B7Z3H4" -"UniProt:Q12952","FOXL1" -"UniProt:P09429","HMGB1" -"UniProt:O55012","PICAL" -"UniProt:Q96JP0","FEM1C" -"UniProt:Q9HCJ1","ANKH" -"UniProt:Q06323","PSME1" -"UniProt:P62320","SMD3" -"UniProt:Q9NR33","POLE4" -"UniProt:Q9ULH1","ASAP1" -"UniProt:P62891","RPL39" -"UniProt:Q9P2N4","ADAMTS9" -"UniProt:Q92959","SLCO2A1" -"UniProt:Q93034","CUL5" -"UniProt:O60383","GDF9" -"UniProt:P0CF97","FAM200B" -"UniProt:Q96DZ9","CMTM5" -"UniProt:Q9HCQ7","NPVF" -"UniProt:Q9Y2R2","PTPN22" -"UniProt:P00326","ADH1C" -"UniProt:Q6NY19","KANK3" -"UniProt:Q7L5N1","CSN6" -"UniProt:P13164","IFITM1" -"UniProt:Q7LYY4","Q7LYY4" -"UniProt:O75346","ZNF253" -"UniProt:Q9UQQ2","SH2B3" -"UniProt:P19338","NUCL" -"UniProt:Q15054","POLD3" -"UniProt:P39748","FEN1" -"UniProt:Q8N4B1","FAM109A" -"UniProt:Q86X40","LRRC28" -"UniProt:O15117","FYB1" -"UniProt:Q08AL9","Q08AL9" -"UniProt:Q60823","Akt2" -"UniProt:Q969E3","UCN3" -"UniProt:O60814","HIST1H2BK" -"UniProt:Q53H96","P5CR3" -"UniProt:I6W9F2","I6W9F2" -"UniProt:P55201","BRPF1" -"UniProt:Q9HAW8","UGT1A10" -"UniProt:Q6UWE0","LRSAM1" -"UniProt:P04798","CYP1A1" -"UniProt:Q9Y3X0","CCDC9" -"UniProt:Q14123","PDE1C" -"UniProt:Q8N165","PDIK1L" -"UniProt:Q9NVA2","SEPT11" -"UniProt:Q7RTT5","SSX7" -"UniProt:P78417","GSTO1" -"UniProt:P08048","ZFY" -"UniProt:Q9P2E7","PCD10" -"UniProt:Q96RS0","TGS1" -"UniProt:Q8N6L0","KASH5" -"UniProt:Q96IW2","SHD" -"UniProt:Q6ICG6","K0930" -"UniProt:O95967","EFEMP2" -"UniProt:Q01850","CDR2" -"UniProt:P25189","MPZ" -"UniProt:P05106","ITGB3" -"UniProt:Q8N1N5","CRPAK" -"UniProt:P01737","T-cell" -"UniProt:P07333","CSF1R" -"UniProt:Q01668","CACNA1D" -"UniProt:Q6UWN0","LYPD4" -"UniProt:Q5U4P2","ASPHD1" -"UniProt:P32322","PYCR1" -"UniProt:P58215","LOXL3" -"UniProt:Q6W5P4","NPSR1" -"UniProt:Q9BRR0","ZKSC3" -"UniProt:Q6WCQ1","MPRIP" -"UniProt:P29218","IMPA1" -"UniProt:P05155","SERPING1" -"UniProt:Q96AP4","ZUFSP" -"UniProt:O00750","P3C2B" -"UniProt:Q13286","CLN3" -"UniProt:O94993","SOX30" -"UniProt:F1MSG6","RPGF2" -"UniProt:Q13418","ILK" -"UniProt:Q5DX21","IGSF11" -"UniProt:P27469","G0S2" -"UniProt:Q9H160","ING2" -"UniProt:Q6N069","NAA16" -"UniProt:Q9Y3Q3","TMED3" -"UniProt:P13591","NCAM1" -"UniProt:P04808","RLN1" -"UniProt:P05023","ATP1A1" -"UniProt:Q9H0W7","THAP2" -"UniProt:Q6UWR7","ENPP6" -"UniProt:Q9HCU8","POLD4" -"UniProt:Q8IZ26","ZNF34" -"UniProt:P60331","KRTAP10-1" -"UniProt:Q9UPR0","PLCL2" -"UniProt:Q6PIY2","Q6PIY2" -"UniProt:Q9H6J7","C11orf49" -"UniProt:Q86X52","CHSY1" -"UniProt:P07228","ITB1" -"UniProt:Q95365","HLA-B" -"UniProt:Q8TCZ2","C99L2" -"UniProt:Q96A56","TP53INP1" -"UniProt:Q9Z111","GA45G" -"UniProt:A6NGG8","C2orf71" -"UniProt:Q9UBX5","FBLN5" -"UniProt:A8MV23","SERPINE3" -"UniProt:Q6PF05","TT23L" -"UniProt:Q6UXH0","ANGPTL8" -"UniProt:Q8N2I2","ZNF619" -"UniProt:O43316","PAX4" -"UniProt:Q16555","DPYSL2" -"UniProt:Q8NDV7","TNR6A" -"UniProt:Q14527","HLTF" -"UniProt:Q8TEY5","CREB3L4" -"UniProt:Q9C0C7","AMRA1" -"UniProt:P83876","TXNL4A" -"UniProt:Q76LX8","ADAMTS13" -"UniProt:O95084","PRSS23" -"UniProt:O43298","ZBT43" -"UniProt:Q00888","PSG4" -"UniProt:Q7Z419","R144B" -"UniProt:Q63HQ2","EGFLAM" -"UniProt:P29317","EPHA2" -"UniProt:P07213","TOM70" -"UniProt:Q9H0N5","PHS2" -"UniProt:Q8WUY1","THEM6" -"UniProt:P54868","HMGCS2" -"UniProt:O95400","CD2BP2" -"UniProt:P28908","TNFRSF8" -"UniProt:Q8IVG9","HUNIN" -"UniProt:Q01970","PLCB3" -"UniProt:Q7L2E3","DHX30" -"UniProt:P53674","CRYBB1" -"UniProt:Q9UHF1","EGFL7" -"UniProt:O88507","CNTFR" -"UniProt:Q08406","CNTFR" -"UniProt:Q9NZQ7","CD274" -"UniProt:P54646","AAPK2" -"UniProt:P35908","KRT2" -"UniProt:P21854","CD72" -"UniProt:O43613","HCRTR1" -"UniProt:Q8WXD5","GEMIN6" -"UniProt:O94844","RHOBTB1" -"UniProt:P03081","ST" -"UniProt:Q9P2D8","UNC79" -"UniProt:Q9NXW2","DNAJB12" -"UniProt:Q9Y496","KIF3A" -"UniProt:Q9UBH6","XPR1" -"UniProt:Q3YBR2","TBRG1" -"UniProt:Q9Y6W6","DUS10" -"UniProt:Q96JK4","HHIPL1" -"UniProt:P46783","RPS10" -"UniProt:Q96CP7","TLCD1" -"UniProt:P35503","UGT1A3" -"UniProt:P61457","PCBD1" -"UniProt:Q04756","HGFAC" -"UniProt:Q8TCG1","CIP2A" -"UniProt:Q8TF65","GIPC2" -"UniProt:Q5FVE4","ACSBG2" -"UniProt:Q14952","KIR2DS3" -"UniProt:O75094","SLIT3" -"UniProt:Q9NYB5","SLCO1C1" -"UniProt:Q7Z401","MYCPP" -"UniProt:P35398","RORA" -"UniProt:O60828","PQBP1" -"UniProt:Q9Y2J4","AMOTL2" -"UniProt:Q96D31","ORAI1" -"UniProt:Q96G04","EF2KT" -"UniProt:Q8TAZ6","CMTM2" -"UniProt:P35125","USP6" -"UniProt:O00479","HMGN4" -"UniProt:Q53TQ3","INO80D" -"UniProt:P19105","MYL12A" -"UniProt:Q8NEE6","FBXL13" -"UniProt:P78367","NKX3-2" -"UniProt:Q6RFH5","WDR74" -"UniProt:Q9BZF2","OSBPL7" -"UniProt:Q5T752","LCE1D" -"UniProt:Q6IN84","MRM1" -"UniProt:Q99542","MMP19" -"UniProt:Q5VTY9","HHAT" -"UniProt:A0A0C4DGF1","A0A0C4DGF1" -"UniProt:P08047","SP1" -"UniProt:Q8NAA4","ATG16L2" -"UniProt:Q6ZMT4","KDM7A" -"UniProt:P53778","MK12" -"UniProt:Q8NBI2","CYAC3" -"UniProt:P69332","US28" -"UniProt:Q05127","VP35" -"UniProt:Q96J94","PIWIL1" -"UniProt:Q96QU8","XPO6" -"UniProt:P43631","KIR2DS2" -"UniProt:P62952","BLCAP" -"UniProt:P28332","ADH6" -"UniProt:O60512","B4GALT3" -"UniProt:Q9UPZ6","THSD7A" -"UniProt:P16591","FER" -"UniProt:Q53XL8","Q53XL8" -"UniProt:Q9BZD7","PRRG3" -"UniProt:P11207","V" -"UniProt:Q5XG87","PAPD7" -"UniProt:Q52LD8","RFTN2" -"UniProt:O95741","CPNE6" -"UniProt:Q96FL8","SLC47A1" -"UniProt:Q12968","NFATC3" -"UniProt:Q96DX5","ASB9" -"UniProt:O77622","CCT6" -"UniProt:Q9C093","SPEF2" -"UniProt:Q16445","GABRA6" -"UniProt:Q9Y586","MAB21L2" -"UniProt:Q02223","TNFRSF17" -"UniProt:Q12908","SLC10A2" -"UniProt:Q8WUA7","TBC1D22A" -"UniProt:Q92882","OSTF1" -"UniProt:Q9UPP5","KIAA1107" -"UniProt:Q8NBP5","MFSD9" -"UniProt:Q9P0L2","MARK1" -"UniProt:O76070","SYUG" -"UniProt:Q9UKV0","HDAC9" -"UniProt:Q6NZI2","CAVIN1" -"UniProt:P70211","Dcc" -"UniProt:Q96S53","TESK2" -"UniProt:Q969X6","UTP4" -"UniProt:O94810","RGS11" -"UniProt:Q9BU40","CHRDL1" -"UniProt:Q63HQ0","AP1AR" -"UniProt:Q6SA08","TSSK4" -"UniProt:O43432","EIF4G3" -"UniProt:P05121","SERPINE1" -"UniProt:O43610","SPY3" -"UniProt:P41145","OPRK1" -"UniProt:Q15846","CLUL1" -"UniProt:Q9UL63","MKLN1" -"UniProt:Q9H841","NIPAL2" -"UniProt:Q9BVS5","TRMT61B" -"UniProt:P46587","SSA2" -"UniProt:Q14213","EBI3" -"UniProt:O95859","TSPAN12" -"UniProt:Q6NX49","ZNF544" -"UniProt:Q9UJY5","GGA1" -"UniProt:Q99767","APBA2" -"UniProt:Q96LM6","TEX37" -"UniProt:Q6P161","MRPL54" -"UniProt:I0DF37","I0DF37" -"UniProt:P56851","EP3B" -"UniProt:P30486","HLA-B" -"UniProt:Q5T160","RARS2" -"UniProt:Q9UNY4","TTF2" -"UniProt:Q96IP4","FA46A" -"UniProt:Q9NWW7","C2orf42" -"UniProt:Q9BRQ4","C11orf70" -"UniProt:Q96R09","OR5B2" -"UniProt:P56373","P2RX3" -"UniProt:Q9BS40","LXN" -"UniProt:Q8IYF3","TEX11" -"UniProt:Q5VX52","SPATA1" -"UniProt:Q30KQ3","Beta-defensin" -"UniProt:O76021","RL1D1" -"UniProt:A0A061IJ01","A0A061IJ01" -"UniProt:Q8IUI8","CRLF3" -"UniProt:Q9H2P0","ADNP" -"UniProt:Q6ZR85","C17orf107" -"UniProt:Q15006","EMC2" -"UniProt:Q9NPB0","SAYSD1" -"UniProt:Q9UD57","NKX1-2" -"UniProt:Q9Y6K1","DNMT3A" -"UniProt:Q5SZJ8","BEND6" -"UniProt:Q14774","HLX" -"UniProt:P46778","RPL21" -"UniProt:Q9Y6A9","SPCS1" -"UniProt:Q9BQQ3","GORASP1" -"UniProt:Q8TB36","GDAP1" -"UniProt:P11055","MYH3" -"UniProt:Q15699","ALX1" -"UniProt:O00237","RNF103" -"UniProt:Q9Y5R6","DMRT1" -"UniProt:Q99708","RBBP8" -"UniProt:P09769","FGR" -"UniProt:P45378","TNNT3" -"UniProt:P54764","EPHA4" -"UniProt:Q9Y3Q4","HCN4" -"UniProt:P54687","BCAT1" -"UniProt:Q5PSV4","BRM1L" -"UniProt:Q9H3D4","TP63" -"UniProt:Q86X10","RALGAPB" -"UniProt:C6KE32","C6KE32" -"UniProt:Q9HCM9","TRIM39" -"UniProt:Q60838","DVL2" -"UniProt:Q15466","NR0B2" -"UniProt:P00367","GLUD1" -"UniProt:Q9UDY4","DNJB4" -"UniProt:Q92609","TBC1D5" -"UniProt:P35712","SOX6" -"UniProt:Q9UQ13","SHOC2" -"UniProt:Q07065","CKAP4" -"UniProt:P37263","YC16" -"UniProt:O75030","MITF" -"UniProt:O88382","MAGI2" -"UniProt:P51679","CCR4" -"UniProt:A8MUP2","MET12" -"UniProt:D6RCP7","USP17L19" -"UniProt:Q8WXF7","ATL1" -"UniProt:Q8WXG1","RSAD2" -"UniProt:Q15506","SP17" -"UniProt:O43186","CRX" -"UniProt:Q8N1F8","STK11IP" -"UniProt:Q9UNM6","PSMD13" -"UniProt:Q9HBF4","ZFYVE1" -"UniProt:Q96S21","RAB40C" -"UniProt:O60232","SSA27" -"UniProt:Q9HBA0","TRPV4" -"UniProt:P19256","CD58" -"UniProt:Q8WU58","FAM222B" -"UniProt:Q9NWQ4","GPATCH2L" -"UniProt:Q8N3F0","MTURN" -"UniProt:Q8NBI5","SLC43A3" -"UniProt:Q04917","YWHAH" -"UniProt:Q8WVQ1","CANT1" -"UniProt:Q8IW35","CEP97" -"UniProt:P19086","GNAZ" -"UniProt:P29373","RABP2" -"UniProt:Q15942","ZYX" -"UniProt:Q03591","CFHR1" -"UniProt:P10696","ALPPL2" -"UniProt:P22892","AP1G1" -"UniProt:A6NML5","TMEM212" -"UniProt:Q8N2G4","LYPD1" -"UniProt:P01241","GH1" -"UniProt:P06744","GPI" -"UniProt:Q14012","CAMK1" -"UniProt:Q9HC38","GLOD4" -"UniProt:Q8NCH0","CHST14" -"UniProt:P63092","GNAS" -"UniProt:Q99PZ6","OSPG" -"UniProt:A0PG75","PLSCR5" -"UniProt:Q5SY16","NOL9" -"UniProt:Q8TE85","GRHL3" -"UniProt:Q8TDB6","DTX3L" -"UniProt:P59037","CU084" -"UniProt:Q8TDE3","RNASE8" -"UniProt:E9PAV3","NACA" -"UniProt:Q92819","HAS2" -"UniProt:Q96G30","MRAP2" -"UniProt:Q62667","MVP" -"UniProt:X6R4H8","X6R4H8" -"UniProt:Q9P2E5","CHPF2" -"UniProt:Q03157","APLP1" -"UniProt:Q9NRG7","SDR39U1" -"UniProt:Q14587","ZNF268" -"UniProt:Q96C74","ROPN1L" -"UniProt:Q9Y662","HS3ST3B1" -"UniProt:P42771","CDKN2A" -"UniProt:Q9UHG0","DCDC2" -"UniProt:A0A0C4DGV1","A0A0C4DGV1" -"UniProt:Q9Y2Y9","KLF13" -"UniProt:P04818","TYSY" -"UniProt:Q10589","BST2" -"UniProt:Q6NUT3","MFSD12" -"UniProt:P32302","CXCR5" -"UniProt:Q8IXL7","MSRB3" -"UniProt:Q53HL2","CDCA8" -"UniProt:Q7L1H2","Q7L1H2" -"UniProt:P48788","TNNI2" -"UniProt:Q8NCN5","PDPR" -"UniProt:Q5VY43","PEAR1" -"UniProt:P30260","CDC27" -"UniProt:P54368","OAZ1" -"UniProt:P42696","RBM34" -"UniProt:P49591","SARS" -"UniProt:Q9UMW8","USP18" -"UniProt:Q9BQ13","KCD14" -"UniProt:P36406","TRI23" -"UniProt:Q5H9T9","FSCB" -"UniProt:Q8TAM2","TTC8" -"UniProt:Q9BVH7","ST6GALNAC5" -"UniProt:Q14165","MLEC" -"UniProt:P33241","LSP1" -"UniProt:P07951","TPM2" -"UniProt:Q9UBF1","MAGC2" -"UniProt:Q96KR4","LMLN" -"UniProt:Q8N9U0","TC2N" -"UniProt:Q9HBL0","TNS1" -"UniProt:O43827","ANGL7" -"UniProt:Q96RK1","CITED4" -"UniProt:Q17RY6","LY6K" -"UniProt:Q03135","CAV1" -"UniProt:Q96EG3","ZN837" -"UniProt:O75807","PPP1R15A" -"UniProt:Q9BW19","KIFC1" -"UniProt:P18074","ERCC2" -"UniProt:Q96M32","AK7" -"UniProt:P48634","PRRC2A" -"UniProt:Q9H999","PANK3" -"UniProt:Q96FX2","DPH3" -"UniProt:O00253","AGRP" -"UniProt:Q8TGM2","YL347" -"UniProt:Q9H6F0","Q9H6F0" -"UniProt:O14894","TM4SF5" -"UniProt:Q96RE7","NACC1" -"UniProt:P14138","EDN3" -"UniProt:P01189","POMC" -"UniProt:Q99538","LGMN" -"UniProt:Q9BZ76","CNTNAP3" -"UniProt:P25491","MAS5" -"UniProt:Q9UKY0","PRND" -"UniProt:Q15075","EEA1" -"UniProt:Q8N4S7","PAQR4" -"UniProt:Q07021","C1QBP" -"UniProt:P0DML3","CSH2" -"UniProt:Q14739","LBR" -"UniProt:P0DPB6","POLR1D" -"UniProt:Q9HBT6","CDH20" -"UniProt:Q8NGX9","OR6P1" -"UniProt:Q96MU8","KREMEN1" -"UniProt:Q16769","QPCT" -"UniProt:Q5BKX6","SLC45A4" -"UniProt:O43303","CCP110" -"UniProt:Q72497","Q72497" -"UniProt:P22234","PAICS" -"UniProt:Q96FI0","Q96FI0" -"UniProt:Q93099","HGD" -"UniProt:P12753","RAD50" -"UniProt:P09923","PPBI" -"UniProt:Q8NBZ7","UXS1" -"UniProt:Q8IWV8","UBR2" -"UniProt:Q9UGM6","WARS2" -"UniProt:Q8WVB6","CHTF18" -"UniProt:P22570","FDXR" -"UniProt:Q30134","HLA-DRB1" -"UniProt:P32245","MC4R" -"UniProt:Q9UKB3","DNAJC12" -"UniProt:P09619","PDGFRB" -"UniProt:Q9C0B1","FTO" -"UniProt:Q14397","GCKR" -"UniProt:Q8NA42","ZNF383" -"UniProt:Q8WV44","TRIM41" -"UniProt:P55916","UCP3" -"UniProt:O14558","HSPB6" -"UniProt:Q16874","Q16874" -"UniProt:Q6UXL0","IL20RB" -"UniProt:Q9NTG7","SIR3" -"UniProt:P62899","RPL31" -"UniProt:A8MWY0","KIAA1324L" -"UniProt:A6NH57","ARL5C" -"UniProt:Q9HC21","SLC25A19" -"UniProt:P01037","CYTN" -"UniProt:P02686","MBP" -"UniProt:V9HWF5","V9HWF5" -"UniProt:P62136","PP1A" -"UniProt:Q00839","HNRNPU" -"UniProt:Q9P2W7","B3GAT1" -"UniProt:Q9P260","KIAA1468" -"UniProt:Q86X51","CX067" -"UniProt:P26441","CNTF" -"UniProt:Q86XJ1","GAS2L3" -"UniProt:P20851","C4BPB" -"UniProt:Q9UKL2","OR52A1" -"UniProt:Q9P2H5","USP35" -"UniProt:Q9NY35","CLDND1" -"UniProt:Q8IY26","PLPP6" -"UniProt:P19957","PI3" -"UniProt:P21754","ZP3" -"UniProt:O43426","SYNJ1" -"UniProt:Q8WXT5","FOXD4L4" -"UniProt:Q52MB2","CC184" -"UniProt:Q5EP37","Q5EP37" -"UniProt:Q92784","DPF3" -"UniProt:Q8IZU0","FAM9B" -"UniProt:A1L4H1","SSC5D" -"UniProt:Q2NKJ9","Q2NKJ9" -"UniProt:P48230","TM4SF4" -"UniProt:P07686","HEXB" -"UniProt:Q02218","OGDH" -"UniProt:Q92845","KIFAP3" -"UniProt:O75459","PAGE1" -"UniProt:P28222","5HT1B" -"UniProt:O15327","INPP4B" -"UniProt:O75631","UPK3A" -"UniProt:P01700","IGLV1-47" -"UniProt:A9UF07","A9UF07" -"UniProt:A2NJV5","IGKVA18" -"UniProt:Q4KMG9","TMEM52B" -"UniProt:Q01814","ATP2B2" -"UniProt:Q9Z101","PAR6A" -"UniProt:Q9BT88","SYT11" -"UniProt:Q9BYD2","MRPL9" -"UniProt:Q6P4E1","CASC4" -"UniProt:Q8N5P1","ZC3H8" -"UniProt:Q8IYE1","CCD13" -"UniProt:Q9H0K1","SIK2" -"UniProt:Q96JC4","ZN479" -"UniProt:Q7L590","MCM10" -"UniProt:Q9UIV1","CNOT7" -"UniProt:Q8N6S5","ARL6IP6" -"UniProt:Q0D2K3","RIPP1" -"UniProt:P35670","ATP7B" -"UniProt:P23443","KS6B1" -"UniProt:Q6ZPD9","D19L3" -"UniProt:Q7Z794","KRT77" -"UniProt:P01772","IGHV3-33" -"UniProt:Q8TC99","FNDC8" -"UniProt:P23083","IGHV1-2" -"UniProt:Q93045","STMN2" -"UniProt:Q17RL8","Q17RL8" -"UniProt:O14556","GAPDHS" -"UniProt:Q96H55","MYO19" -"UniProt:Q9NVQ4","FAIM1" -"UniProt:Q9QYP6","AZI2" -"UniProt:Q96QC0","PP1RA" -"UniProt:Q96B26","EXOSC8" -"UniProt:Q6ZSB9","ZBT49" -"UniProt:Q6WQI6","HEPN1" -"UniProt:Q03137","Epha4" -"UniProt:P0CW24","PNM6A" -"UniProt:Q15761","NPY5R" -"UniProt:P05109","S10A8" -"UniProt:C9J1Q0","C9J1Q0" -"UniProt:Q8HWS3","RFX6" -"UniProt:P62280","RS11" -"UniProt:Q5TD94","RSPH4A" -"UniProt:Q495Y8","SPDE2" -"UniProt:Q9UDR5","AASS" -"UniProt:Q06543","GPN3" -"UniProt:O75052","NOS1AP" -"UniProt:Q9NZI2","KCNIP1" -"UniProt:Q00534","CDK6" -"UniProt:Q9NZU0","FLRT3" -"UniProt:Q86UB2","BIVM" -"UniProt:P0C5Y4","KRTAP1-4" -"UniProt:Q9NTN3","SLC35D1" -"UniProt:Q16875","PFKFB3" -"UniProt:Q9Y5X5","NPFFR2" -"UniProt:P01594","IGKV1-33" -"UniProt:Q8NA77","TEX19" -"UniProt:Q96S82","UBL7" -"UniProt:O00767","SCD" -"UniProt:P0C7M3","SFTA3" -"UniProt:Q9NZJ9","NUDT4" -"UniProt:Q13772","NCOA4" -"UniProt:Q8IXF9","AQP12A" -"UniProt:Q92626","PXDN" -"UniProt:O15530","PDPK1" -"UniProt:O60258","FGF17" -"UniProt:Q17RR3","PNLIPRP3" -"UniProt:P14406","CX7A2" -"UniProt:A6NHY2","ANKDD1B" -"UniProt:Q9HA72","CALHM2" -"UniProt:Q8TE49","OTUD7A" -"UniProt:Q8N695","SLC5A8" -"UniProt:Q9Y6T4","Q9Y6T4" -"UniProt:Q86XI8","ZSWM9" -"UniProt:Q9Y6X6","MYO16" -"UniProt:Q969E1","LEAP2" -"UniProt:Q5T681","CJ062" -"UniProt:O75157","TSC22D2" -"UniProt:P11142","HSPA8" -"UniProt:Q08E86","Q08E86" -"UniProt:P40136","cya" -"UniProt:Q8WYL5","SSH1" -"UniProt:O60238","BNIP3L" -"UniProt:Q6NXR0","IRGC" -"UniProt:Q8IY85","EFCAB13" -"UniProt:O43583","DENR" -"UniProt:Q96HA1","POM121" -"UniProt:Q6NZY4","ZCCHC8" -"UniProt:Q02083","NAAA" -"UniProt:P18084","ITGB5" -"UniProt:A4D1T9","PRSS37" -"UniProt:Q92844","TANK" -"UniProt:Q13304","GPR17" -"UniProt:P82663","MRPS25" -"UniProt:P43220","GLP1R" -"UniProt:Q16558","KCNMB1" -"UniProt:Q9H9H4","VPS37B" -"UniProt:Q9UK96","FBXO10" -"UniProt:Q8TC44","POC1B" -"UniProt:P05556","ITGB1" -"UniProt:Q15326","ZMYND11" -"UniProt:Q9Y530","OARD1" -"UniProt:P39682","PRP39" -"UniProt:P61586","RHOA" -"UniProt:Q9H7L9","SDS3" -"UniProt:Q96BD8","SKA1" -"UniProt:Q8NDY4","MDS2" -"UniProt:P27870","Vav1" -"UniProt:C9J442","C22orf46" -"UniProt:Q9UL12","SARDH" -"UniProt:P38606","ATP6V1A" -"UniProt:Q91ZM2","Sh2b1" -"UniProt:O75015","FCGR3B" -"UniProt:P29274","ADORA2A" -"UniProt:P60033","CD81" -"UniProt:Q9UJW8","ZNF180" -"UniProt:Q9NPJ3","ACOT13" -"UniProt:Q96S59","RANB9" -"UniProt:Q30KQ8","DEFB112" -"UniProt:P36888","FLT3" -"UniProt:Q5VZY2","PLPP4" -"UniProt:Q13813","SPTAN1" -"UniProt:Q9R002","IFI2" -"UniProt:P00749","PLAU" -"UniProt:Q9BYE3","LCE3D" -"UniProt:P21964","COMT" -"UniProt:P14416","DRD2" -"UniProt:Q8N6M5","ALLC" -"UniProt:Q96LB8","PGLYRP4" -"UniProt:O75596","CLEC3A" -"UniProt:P78364","PHC1" -"UniProt:Q9Y330","ZBT12" -"UniProt:Q7L7X3","TAOK1" -"UniProt:O60870","KIN" -"UniProt:Q5R2U3","Q5R2U3" -"UniProt:Q86VL8","SLC47A2" -"UniProt:Q16568","CARTPT" -"UniProt:P43490","NAMPT" -"UniProt:Q92793","CREBBP" -"UniProt:Q9NYQ7","CELSR3" -"UniProt:A6NI28","ARHGAP42" -"UniProt:P42681","TXK" -"UniProt:Q9BT40","INPP5K" -"UniProt:Q16819","MEP1A" -"UniProt:P62995","TRA2B" -"UniProt:Q9BYR0","KRA47" -"UniProt:Q9NZV1","CRIM1" -"UniProt:Q16236","NFE2L2" -"UniProt:P08172","CHRM2" -"UniProt:O43361","ZNF749" -"UniProt:Q96S66","CLCC1" -"UniProt:Q70EL4","USP43" -"UniProt:Q9H9E3","COG4" -"UniProt:P47869","GABRA2" -"UniProt:Q9NPJ8","NXT2" -"UniProt:Q86U28","ISCA2" -"UniProt:Q04760","GLO1" -"UniProt:Q5SSJ5","HP1BP3" -"UniProt:Q8N726","ARF" -"UniProt:P78334","GABRE" -"UniProt:Q9H693","C16orf95" -"UniProt:Q3B7T1","EDRF1" -"UniProt:P82673","MRPS35" -"UniProt:P05981","HPN" -"UniProt:Q6ZP80","TMEM182" -"UniProt:P01033","TIMP1" -"UniProt:Q9UQQ1","NAALADL1" -"UniProt:P0DN76","U2AF1" -"UniProt:Q8TA86","RP9" -"UniProt:Q9P255","ZNF492" -"UniProt:Q16514","TAF12" -"UniProt:Q9BSJ2","GCP2" -"UniProt:P15391","CD19" -"UniProt:Q8N987","NECA1" -"UniProt:Q9NYV7","TAS2R16" -"UniProt:Q8IYQ9","Q8IYQ9" -"UniProt:Q9H2I8","LRMDA" -"UniProt:Q8NGA6","OR10H5" -"UniProt:Q5R372","RABGAP1L" -"UniProt:Q9HC73","CRLF2" -"UniProt:P31645","SLC6A4" -"UniProt:Q9BXK5","B2L13" -"UniProt:P11586","MTHFD1" -"UniProt:P13807","GYS1" -"UniProt:P70288","Hdac2" -"UniProt:Q969H9","DIRC1" -"UniProt:Q9NUE0","ZDHHC18" -"UniProt:Q8N8P3","Q8N8P3" -"UniProt:P01009","SERPINA1" -"UniProt:A0A0S2Z4U3","A0A0S2Z4U3" -"UniProt:Q15583","TGIF1" -"UniProt:O15018","PDZD2" -"UniProt:O15534","PER1" -"UniProt:Q9Y6P5","SESN1" -"UniProt:Q9P0G3","KLK14" -"UniProt:Q8NDX6","ZN740" -"UniProt:Q8TAK5","GABP2" -"UniProt:Q8IYN0","ZNF100" -"UniProt:P24593","IGFBP5" -"UniProt:Q9BWS9","CHID1" -"UniProt:Q15542","TAF5" -"UniProt:Q6PEC3","YIF1B" -"UniProt:Q92820","GGH" -"UniProt:P04049","RAF1" -"UniProt:P10085","Myod1" -"UniProt:Q9NX18","SDHAF2" -"UniProt:Q58WW2","DCAF6" -"UniProt:O60602","TLR5" -"UniProt:O95159","ZFPL1" -"UniProt:Q6ZN79","ZNF705A" -"UniProt:P50238","CRIP1" -"UniProt:Q08144","TLG2" -"UniProt:Q149M9","NWD1" -"UniProt:O35716","Socs1" -"UniProt:Q8N2X6","EXAS1" -"UniProt:Q13621","SLC12A1" -"UniProt:P47989","XDH" -"UniProt:P41212","ETV6" -"UniProt:Q13515","BFSP2" -"UniProt:Q04743","EMX2" -"UniProt:P29144","TPP2" -"UniProt:P48544","KCNJ5" -"UniProt:P25929","NPY1R" -"UniProt:Q5JU85","IQSEC2" -"UniProt:Q14746","COG2" -"UniProt:Q9NPE2","NGRN" -"UniProt:O60869","EDF1" -"UniProt:Q9H2W6","RM46" -"UniProt:Q8NGK0","OR51G2" -"UniProt:Q13324","CRHR2" -"UniProt:P23141","CES1" -"UniProt:O60244","MED14" -"UniProt:O75144","ICOSL" -"UniProt:E7EPP7","E7EPP7" -"UniProt:P06312","IGKV4-1" -"UniProt:Q9P0M9","MRPL27" -"UniProt:P08F94","PKHD1" -"UniProt:Q9NYU2","UGGT1" -"UniProt:Q5T442","GJC2" -"UniProt:P01178","OXT" -"UniProt:P05413","FABP3" -"UniProt:Q8WTX9","ZDHC1" -"UniProt:L0R6Q1","SLC35A4" -"UniProt:Q99835","SMO" -"UniProt:Q16820","MEP1B" -"UniProt:Q92187","ST8SIA4" -"UniProt:P55083","MFAP4" -"UniProt:Q8IVJ8","C3orf35" -"UniProt:Q5VUY2","AADACL4" -"UniProt:Q8WW35","TCTEX1D2" -"UniProt:O15498","YKT6" -"UniProt:Q99575","POP1" -"UniProt:P38319","TYDP1" -"UniProt:Q99707","MTR" -"UniProt:Q17R99","Q17R99" -"UniProt:P23798","Pcgf2" -"UniProt:Q7LDG7","RASGRP2" -"UniProt:Q8WWH4","ASZ1" -"UniProt:Q8TDS4","HCAR2" -"UniProt:P36543","ATP6V1E1" -"UniProt:Q9UBK8","MTRR" -"UniProt:Q9ULB4","CDH9" -"UniProt:Q9ULT8","HECTD1" -"UniProt:P0DML2","CSH1" -"UniProt:P18827","SDC1" -"UniProt:Q68CQ1","MROH7" -"UniProt:O14994","SYN3" -"UniProt:P34969","HTR7" -"UniProt:P49221","TGM4" -"UniProt:Q96D09","GASP2" -"UniProt:Q8NFL0","B3GNT7" -"UniProt:Q7Z4R8","C6orf120" -"UniProt:Q86VW2","ARHGEF25" -"UniProt:P35638","DDIT3" -"UniProt:P01100","FOS" -"UniProt:P51610","HCFC1" -"UniProt:P63272","SUPT4H1" -"UniProt:Q15661","TPSAB1" -"UniProt:Q9P244","LRFN1" -"UniProt:Q04885","Opacity" -"UniProt:A0A0C4DG91","A0A0C4DG91" -"UniProt:Q13114","TRAF3" -"UniProt:O15511","ARPC5" -"UniProt:Q494V2","CFAP100" -"UniProt:Q86YW0","PLCZ1" -"UniProt:Q3ZCQ3","FAM174B" -"UniProt:Q01892","SPIB" -"UniProt:Q9NQX5","NPDC1" -"UniProt:Q9H2U2","PPA2" -"UniProt:Q96LL3","C16orf92" -"UniProt:Q96G21","IMP4" -"UniProt:Q8N812","C12orf76" -"UniProt:Q9Y620","RAD54B" -"UniProt:P08294","SODE" -"UniProt:O00566","MPHOSPH10" -"UniProt:Q08828","ADCY1" -"UniProt:Q460M5","LRFN2" -"UniProt:Q99801","NKX31" -"UniProt:Q9P2E9","RRBP1" -"UniProt:O14977","AZIN1" -"UniProt:Q14206","RCAN2" -"UniProt:Q0P5N6","ARL16" -"UniProt:P03120","VE2" -"UniProt:Q96IV0","NGLY1" -"UniProt:Q6P582","MZT2A" -"UniProt:Q5D1E7","ZC12A" -"UniProt:P57772","EEFSEC" -"UniProt:A0AVT1","UBA6" -"UniProt:Q9BY07","SLC4A5" -"UniProt:G3I183","G3I183" -"UniProt:Q8TCS8","PNPT1" -"UniProt:P27658","CO8A1" -"UniProt:Q8TDX9","PKD1L1" -"UniProt:P00772","CELA1" -"UniProt:Q9Y5L3","ENTPD2" -"UniProt:Q8N8N0","RNF152" -"UniProt:P02778","CXCL10" -"UniProt:Q05513","KPCZ" -"UniProt:Q7Z6J8","UBE3D" -"UniProt:O43603","GALR2" -"UniProt:Q8NGL9","OR4C16" -"UniProt:Q5SNT2","TMEM201" -"UniProt:Q658Y4","FAM91A1" -"UniProt:Q14692","BMS1" -"UniProt:Q9NQW5","PRDM7" -"UniProt:P78310","CXADR" -"UniProt:Q9NPA3","MID1IP1" -"UniProt:Q9BS16","CENPK" -"UniProt:P0C7H8","KRTAP2-3" -"UniProt:O75832","PSMD10" -"UniProt:P20963","CD247" -"UniProt:Q15743","GPR68" -"UniProt:Q9C030","TRIM6" -"UniProt:P53617","NRD1" -"UniProt:P14868","DARS" -"UniProt:Q53HV7","SMUG1" -"UniProt:Q8NH06","OR1P1" -"UniProt:Q9BWU1","CDK19" -"UniProt:Q9Y6F9","WNT6" -"UniProt:Q8NGS5","OR13C4" -"UniProt:Q9BXY0","MAK16" -"UniProt:Q8NGR9","OR1N2" -"UniProt:P62333","PSMC6" -"UniProt:P16260","SLC25A16" -"UniProt:Q99574","SERPINI1" -"UniProt:P62315","SMD1" -"UniProt:P10608","ADRB2" -"UniProt:A1L170","C1orf226" -"UniProt:Q96RP3","UCN2" -"UniProt:Q8NH94","OR1L1" -"UniProt:Q9JJ40","NHRF3" -"UniProt:O14756","HSD17B6" -"UniProt:Q8NG41","NPB" -"UniProt:P04279","SEMG1" -"UniProt:Q9P241","ATP10D" -"UniProt:P21673","SAT1" -"UniProt:Q86TH3","Q86TH3" -"UniProt:Q99622","C12orf57" -"UniProt:Q5VYP0","SPATA31A3" -"UniProt:Q8NH40","OR6S1" -"UniProt:Q8TF72","SHROOM3" -"UniProt:A0A0C4DFN3","A0A0C4DFN3" -"UniProt:Q66PJ3","ARL6IP4" -"UniProt:O95237","LRAT" -"UniProt:O95248","SBF1" -"UniProt:P01570","IFN14" -"UniProt:P27467","Wnt3a" -"UniProt:P04004","VTNC" -"UniProt:Q0JRZ9","FCHO2" -"UniProt:Q8N128","FAM177A1" -"UniProt:O15063","KIAA0355" -"UniProt:Q2NL82","TSR1" -"UniProt:Q86UL3","GPAT4" -"UniProt:Q6UXB3","LYPD2" -"UniProt:Q8N5R6","CCDC33" -"UniProt:Q9BRL5","Q9BRL5" -"UniProt:P70587","LRRC7" -"UniProt:Q9UK22","FBXO2" -"UniProt:Q8IW93","ARHGEF19" -"UniProt:Q76L83","ASXL2" -"UniProt:Q8IWU5","SULF2" -"UniProt:P47710","CASA1" -"UniProt:Q92889","ERCC4" -"UniProt:Q92615","LARP4B" -"UniProt:Q6ZMI3","GLDN" -"UniProt:O00198","HRK" -"UniProt:Q9NRW7","VPS45" -"UniProt:Q2L4Q9","PRSS53" -"UniProt:Q8N4S9","MARVELD2" -"UniProt:P06734","FCER2" -"UniProt:Q96FF9","CDCA5" -"UniProt:Q6IQ21","ZNF770" -"UniProt:Q5H9M0","MUM1L1" -"UniProt:Q7DB77","TIR" -"UniProt:Q96GG9","DCNL1" -"UniProt:Q9Y333","LSM2" -"UniProt:P03206","BZLF1" -"UniProt:P32456","GBP2" -"UniProt:P23921","RRM1" -"UniProt:Q7L3B6","CDC37L1" -"UniProt:Q06340","ESC2" -"UniProt:Q9H2X8","IFI27L2" -"UniProt:P19550","env" -"UniProt:Q96R72","OR4K3" -"UniProt:Q96CB2","Q96CB2" -"UniProt:Q9UGP5","DPOLL" -"UniProt:P30301","MIP" -"UniProt:Q8TBC4","UBA3" -"UniProt:Q8NH63","OR51H1" -"UniProt:Q6PI25","CNIH2" -"UniProt:B1ANS9","WDR64" -"UniProt:Q01638","ILRL1" -"UniProt:Q86UP2","KTN1" -"UniProt:Q96N66","MBOAT7" -"UniProt:Q8N3T1","GALNT15" -"UniProt:P00760","TRY1" -"UniProt:O60282","KIF5C" -"UniProt:P62308","SNRPG" -"UniProt:Q9BU27","Q9BU27" -"UniProt:O95168","NDUFB4" -"UniProt:Q9BTW9","TBCD" -"UniProt:Q8NGJ9","OR51T1" -"UniProt:Q14494","NFE2L1" -"UniProt:P20595","Gucy1b3" -"UniProt:Q08830","FGL1" -"UniProt:O14599","BPY2C" -"UniProt:Q9WV48","Shank1" -"UniProt:Q93097","WNT2B" -"UniProt:Q96R48","OR2A5" -"UniProt:Q9UHJ6","SHPK" -"UniProt:Q8N6W0","CELF5" -"UniProt:O00482","NR5A2" -"UniProt:Q9BYT8","NLN" -"UniProt:Q6IN36","WIPF1" -"UniProt:Q8IYR6","MSANTD3-TMEFF1" -"UniProt:Q5JSP0","FGD3" -"UniProt:Q8R4T5","GRASP" -"UniProt:Q9UDY6","TRIM10" -"UniProt:Q9BW62","KATL1" -"UniProt:O75610","LEFTY1" -"UniProt:Q96PU5","NEDD4L" -"UniProt:P55344","LIM2" -"UniProt:Q8NH10","OR8U1" -"UniProt:P36507","MAP2K2" -"UniProt:Q9BQQ7","RTP3" -"UniProt:P43307","SSRA" -"UniProt:Q8IZL2","MAML2" -"UniProt:O95983","MBD3" -"UniProt:O15144","ARPC2" -"UniProt:Q9UPT9","USP22" -"UniProt:Q70EK8","USP53" -"UniProt:Q8IUL8","CILP2" -"UniProt:Q9UQR1","ZNF148" -"UniProt:Q9Y2B2","PIGL" -"UniProt:Q5VXH4","PRAMEF6" -"UniProt:P34897","GLYM" -"UniProt:O75475","PSIP1" -"UniProt:P23025","XPA" -"UniProt:Q9NYS0","NKIRAS1" -"UniProt:P08631","HCK" -"UniProt:Q96II8","LRCH3" -"UniProt:Q8NDC4","MORN4" -"UniProt:O00451","GFRA2" -"UniProt:Q9NRH3","TUBG2" -"UniProt:P53365","ARFIP2" -"UniProt:Q9UKT5","FBXO4" -"UniProt:Q9H944","MED20" -"UniProt:Q9Y3M9","ZNF337" -"UniProt:P13640","MT1G" -"UniProt:Q9Y6M7","SLC4A7" -"UniProt:Q04201","CUE4" -"UniProt:P09958","FURIN" -"UniProt:P38263","GID4" -"UniProt:Q6PKX4","DOK6" -"UniProt:P55735","SEC13" -"UniProt:P40092","SPI1" -"UniProt:Q96KS0","EGLN2" -"UniProt:P36601","RAD51" -"UniProt:Q6PG37","ZNF790" -"UniProt:Q96DB2","HDA11" -"UniProt:Q62132","PTPRR" -"UniProt:Q16572","SLC18A3" -"UniProt:Q6P1M3","LLGL2" -"UniProt:Q6B0I6","KDM4D" -"UniProt:Q86VR2","F134C" -"UniProt:Q08999","RBL2" -"UniProt:Q9NY33","DPP3" -"UniProt:Q9H853","TUBA4B" -"UniProt:P35318","ADM" -"UniProt:P36057","SRPB" -"UniProt:Q04883","opaD" -"UniProt:O76075","DFFB" -"UniProt:Q9UID3","VPS51" -"UniProt:Q8IZ03","Q8IZ03" -"UniProt:Q01831","XPC" -"UniProt:Q6NZ36","FAAP20" -"UniProt:Q8WW18","CQ050" -"UniProt:Q86TE4","LUZP2" -"UniProt:O75387","SLC43A1" -"UniProt:P56545","CTBP2" -"UniProt:Q8NFW8","CMAS" -"UniProt:O60423","ATP8B3" -"UniProt:Q9BRP1","PDCD2L" -"UniProt:O15438","ABCC3" -"UniProt:Q7L266","ASRGL1" -"UniProt:Q6UXB8","PI16" -"UniProt:O12161","MINT-5231871" -"UniProt:Q96DN0","ERP27" -"UniProt:Q9Y4Z2","NEUROG3" -"UniProt:Q6UVJ0","SASS6" -"UniProt:Q6ZMU5","TRI72" -"UniProt:Q8IXQ9","ETFBKMT" -"UniProt:P49716","CEBPD" -"UniProt:Q96EY5","MVB12A" -"UniProt:Q9H4G1","CST9L" -"UniProt:P61006","RAB8A" -"UniProt:Q9BTC8","MTA3" -"UniProt:Q15544","TAF11" -"UniProt:O75448","MED24" -"UniProt:Q8WU10","PYROXD1" -"UniProt:Q8N4W6","DJC22" -"UniProt:Q9UJ41","RABX5" -"UniProt:O43741","AAKB2" -"UniProt:P10147","CCL3" -"UniProt:Q9BTL3","RAM" -"UniProt:Q9NVU7","SDAD1" -"UniProt:Q14197","MRPL58" -"UniProt:P48454","PPP3CC" -"UniProt:Q8IZC7","ZNF101" -"UniProt:O00762","UBE2C" -"UniProt:O15344","MID1" -"UniProt:P06464","VE7" -"UniProt:Q9Y2X0","MED16" -"UniProt:Q9Y4E5","ZNF451" -"UniProt:Q5SQP8","Q5SQP8" -"UniProt:Q05084","ICA1" -"UniProt:Q99797","MIPEP" -"UniProt:Q9NRA0","SPHK2" -"UniProt:O43423","AN32C" -"UniProt:P05496","AT5G1" -"UniProt:Q6IBW4","NCAPH2" -"UniProt:P60371","KR106" -"UniProt:Q8N8A6","DDX51" -"UniProt:Q9Y253","POLH" -"UniProt:Q6PIS1","SLC23A3" -"UniProt:A1KXE4","FAM168B" -"UniProt:Q9UKG4","SLC13A4" -"UniProt:Q96RU8","TRIB1" -"UniProt:Q9NT62","ATG3" -"UniProt:Q9Y4C0","NRXN3" -"UniProt:Q01085","TIAR" -"UniProt:Q569H4","LARGN" -"UniProt:O00110","OVOL3" -"UniProt:Q9UPQ9","TNRC6B" -"UniProt:Q13895","BYSL" -"UniProt:Q9UKU9","ANGPTL2" -"UniProt:Q96MF7","NSMCE2" -"UniProt:O43736","ITM2A" -"UniProt:Q8WWX9","SELM" -"UniProt:Q658N2","WSCD1" -"UniProt:Q8IU54","IFNL1" -"UniProt:O75586","MED6" -"UniProt:P62807","HIST1H2BC" -"UniProt:Q9HCK5","AGO4" -"UniProt:Q5VTH9","WDR78" -"UniProt:A9QM74","KPNA7" -"UniProt:Q66K79","CPZ" -"UniProt:P48061","CXCL12" -"UniProt:A0A0A0MQS1","A0A0A0MQS1" -"UniProt:A6NP11","ZNF716" -"UniProt:Q9C0K0","BCL11B" -"UniProt:O60635","TSPAN1" -"UniProt:Q8NHK3","KIR2DL5B" -"UniProt:Q96SK3","ZN607" -"UniProt:Q92871","PMM1" -"UniProt:Q6NSM0","Q6NSM0" -"UniProt:P61371","ISL1" -"UniProt:Q5JTW2","CEP78" -"UniProt:Q6P2C8","MED27" -"UniProt:Q9UBI1","COMMD3" -"UniProt:Q9H9B4","SFXN1" -"UniProt:Q07283","TCHH" -"UniProt:Q14667","KIAA0100" -"UniProt:Q8IZ81","ELMOD2" -"UniProt:Q6ZXV5","TMTC3" -"UniProt:Q15334","L2GL1" -"UniProt:A0AV96","RBM47" -"UniProt:P24394","IL4R" -"UniProt:Q96MG7","NSMCE3" -"UniProt:Q9UJX0","OSGI1" -"UniProt:P30566","ADSL" -"UniProt:Q8TEH3","DENND1A" -"UniProt:Q71U36","TUBA1A" -"UniProt:P16619","CCL3L1" -"UniProt:Q96GF1","RNF185" -"UniProt:P06315","IGKV5-2" -"UniProt:Q5TCS8","AK9" -"UniProt:Q9Y478","PRKAB1" -"UniProt:P17081","RHOQ" -"UniProt:Q9C035","TRIM5" -"UniProt:P08263","GSTA1" -"UniProt:O43543","XRCC2" -"UniProt:Q9JKL7","SREK1" -"UniProt:Q9NYK5","MRPL39" -"UniProt:O95391","SLU7" -"UniProt:C0H5X0","C0H5X0" -"UniProt:Q6TGC4","PADI6" -"UniProt:O75063","XYLK" -"UniProt:O00587","MFNG" -"UniProt:Q8IUC8","GALNT13" -"UniProt:Q03920","MTQ2" -"UniProt:O35274","NEB2" -"UniProt:H0YDU7","H0YDU7" -"UniProt:Q14588","ZNF234" -"UniProt:Q5VT52","RPRD2" -"UniProt:Q8IV63","VRK3" -"UniProt:A2RUS2","DENND3" -"UniProt:Q5SRR4","LY6G5C" -"UniProt:Q92466","DDB2" -"UniProt:Q6UXD7","MFSD7" -"UniProt:Q15149","PLEC" -"UniProt:Q6ZSZ5","ARHGEF18" -"UniProt:Q6PIM4","Q6PIM4" -"UniProt:Q12996","CSTF3" -"UniProt:Q13435","SF3B2" -"UniProt:Q7Z7G1","CLNK" -"UniProt:Q96RN1","SLC26A8" -"UniProt:O95343","SIX3" -"UniProt:Q02040","AKAP17A" -"UniProt:Q02846","GUCY2D" -"UniProt:Q8TBF2","FAM213B" -"UniProt:P11166","SLC2A1" -"UniProt:P49641","MAN2A2" -"UniProt:O00178","GTPBP1" -"UniProt:Q9H7Y0","CXorf36" -"UniProt:Q9UKZ9","PCOLCE2" -"UniProt:P08247","SYP" -"UniProt:Q96GP6","SCARF2" -"UniProt:Q86XT2","VPS37D" -"UniProt:Q14512","FGFBP1" -"UniProt:O94979","SC31A" -"UniProt:Q7Z7M0","MEGF8" -"UniProt:Q6PJF5","RHBDF2" -"UniProt:Q6ZVL6","KIAA1549L" -"UniProt:Q00975","CACNA1B" -"UniProt:Q9NPD3","EXOS4" -"UniProt:Q96PN7","TRERF1" -"UniProt:Q02978","SLC25A11" -"UniProt:P17038","ZNF43" -"UniProt:Q9BX67","JAM3" -"UniProt:P57058","HUNK" -"UniProt:Q13084","MRPL28" -"UniProt:Q96JK9","MAML3" -"UniProt:Q15543","TAF13" -"UniProt:Q12206","WTM2" -"UniProt:Q8TBZ9","CG062" -"UniProt:O15466","ST8SIA5" -"UniProt:Q9BYK8","HELZ2" -"UniProt:O95886","DLGAP3" -"UniProt:Q9Y450","HBS1L" -"UniProt:P11912","CD79A" -"UniProt:Q2TBC4","PRICKLE4" -"UniProt:Q96J77","TPD55" -"UniProt:Q8NEW7","TMIE" -"UniProt:Q6ISU1","PTCRA" -"UniProt:O43175","PHGDH" -"UniProt:P62266","RPS23" -"UniProt:O75342","ALOX12B" -"UniProt:Q5NV82","IGLV5-45" -"UniProt:Q8WZ60","KLHL6" -"UniProt:P54317","PNLIPRP2" -"UniProt:O60906","SMPD2" -"UniProt:Q9BWV7","TTLL2" -"UniProt:Q9UK73","FEM1B" -"UniProt:O00206","TLR4" -"UniProt:Q9HBX8","LGR6" -"UniProt:B0FTY2","B0FTY2" -"UniProt:Q86UD5","SLC9B2" -"UniProt:P35219","CA8" -"UniProt:O76027","ANXA9" -"UniProt:Q969R8","ITFG2" -"UniProt:Q12772","SREBF2" -"UniProt:Q96GC1","Q96GC1" -"UniProt:Q9ESU6","BRD4" -"UniProt:P25090","FPR2" -"UniProt:Q9GZQ6","NPFFR1" -"UniProt:Q9Y6J6","KCNE2" -"UniProt:P57789","KCNK10" -"UniProt:P20933","AGA" -"UniProt:O75911","DHRS3" -"UniProt:Q6PII3","CCDC174" -"UniProt:Q9Y2R0","COA3" -"UniProt:P68135","ACTS" -"UniProt:P14151","SELL" -"UniProt:P17031","ZNF26" -"UniProt:O43304","SEC14L5" -"UniProt:Q16774","GUK1" -"UniProt:Q9UL36","ZNF236" -"UniProt:P30052","sd" -"UniProt:Q6ZNC8","MBOAT1" -"UniProt:P19429","TNNI3" -"UniProt:Q9BW11","MXD3" -"UniProt:P48356","Lepr" -"UniProt:Q8N0U4","FAM185A" -"UniProt:P63218","GNG5" -"UniProt:Q49AG3","ZBED5" -"UniProt:Q9H063","MAF1" -"UniProt:Q6P4F7","ARHGAP11A" -"UniProt:O95789","ZMYM6" -"UniProt:Q96A47","ISL2" -"UniProt:O15084","ANKRD28" -"UniProt:Q68CP9","ARID2" -"UniProt:Q12056","ISU2" -"UniProt:O43513","MED7" -"UniProt:P84996","GNAS" -"UniProt:P49810","PSEN2" -"UniProt:Q8NGY5","OR6N1" -"UniProt:Q5T197","DCST1" -"UniProt:Q9UII4","HERC5" -"UniProt:Q5W064","LIPJ" -"UniProt:Q9BXU8","FHL17" -"UniProt:Q15311","RBP1" -"UniProt:Q96RM1","SPRR2F" -"UniProt:Q8IX01","SUGP2" -"UniProt:P78369","CLDN10" -"UniProt:Q96LD1","SGCZ" -"UniProt:P53969","SAM50" -"UniProt:O43680","TCF21" -"UniProt:K7EM05","K7EM05" -"UniProt:P14270","PDE4D" -"UniProt:Q9UK11","ZNF223" -"UniProt:Q8WUF5","PPP1R13L" -"UniProt:Q8TEY7","USP33" -"UniProt:O14798","TR10C" -"UniProt:P61925","PKIA" -"UniProt:Q5JWF2","GNAS" -"UniProt:O14646","CHD1" -"UniProt:Q53SZ7","PRR30" -"UniProt:A0A0A0MRY9","A0A0A0MRY9" -"UniProt:Q8IZL9","CDK20" -"UniProt:Q99941","ATF6B" -"UniProt:O15417","TNRC18" -"UniProt:O95467","GNAS" -"UniProt:Q13129","RLF" -"UniProt:Q7Z3V4","UBE3B" -"UniProt:O60716","CTNND1" -"UniProt:Q8TDB8","SLC2A14" -"UniProt:Q6DKJ4","NXN" -"UniProt:Q14678","KANK1" -"UniProt:I3L4J3","I3L4J3" -"UniProt:O95670","ATP6V1G2" -"UniProt:Q14687","GSE1" -"UniProt:P15382","KCNE1" -"UniProt:Q01082","SPTB2" -"UniProt:Q96IZ2","ADTRP" -"UniProt:Q01362","MS4A2" -"UniProt:Q6UWM9","UGT2A3" -"UniProt:Q92629","SGCD" -"UniProt:Q06643","LTB" -"UniProt:O15320","CTAGE5" -"UniProt:P04156","PRNP" -"UniProt:O95780","ZNF682" -"UniProt:Q17R89","ARHGAP44" -"UniProt:Q5VXD3","SAMD13" -"UniProt:Q9BUK6","MSTO1" -"UniProt:O75339","CILP" -"UniProt:Q86VE9","SERINC5" -"UniProt:Q9QYY0","Gab1" -"UniProt:O43272","PRODH" -"UniProt:Q14CW7","Q14CW7" -"UniProt:Q7Z6E9","RBBP6" -"UniProt:Q9BV68","RNF126" -"UniProt:O60469","DSCAM" -"UniProt:O75373","ZNF737" -"UniProt:P09564","CD7" -"UniProt:Q13241","KLRD1" -"UniProt:A0A0C4DGF2","A0A0C4DGF2" -"UniProt:P04732","MT1E" -"UniProt:Q9NR71","ASAH2" -"UniProt:P30475","HLA-B" -"UniProt:Q9USV1","SFR1" -"UniProt:P49768","PSEN1" -"UniProt:P26378","ELAVL4" -"UniProt:Q9Y580","RBM7" -"UniProt:Q9UBW7","ZMYM2" -"UniProt:Q9UI46","DNAI1" -"UniProt:Q6ZNJ1","NBEAL2" -"UniProt:Q9UGT4","SUSD2" -"UniProt:Q86TD4","SRL" -"UniProt:Q63HK5","TSH3" -"UniProt:Q7Z3Z4","PIWIL4" -"UniProt:P17480","UBTF" -"UniProt:Q8WXH4","ASB11" -"UniProt:Q6ZTW0","TPGS1" -"UniProt:Q9P2Q2","FRMD4A" -"UniProt:Q5XXA6","ANO1" -"UniProt:A4D1L5","A4D1L5" -"UniProt:Q3B8N2","LGALS9B" -"UniProt:Q13606","OR5I1" -"UniProt:P62262","1433E" -"UniProt:Q9Y623","MYH4" -"UniProt:P35180","TOM20" -"UniProt:Q5SXM2","SNAPC4" -"UniProt:Q9H808","TLE6" -"UniProt:Q7Z6B0","CCDC91" -"UniProt:Q9Y5A9","YTHD2" -"UniProt:P08922","ROS1" -"UniProt:Q14974","KPNB1" -"UniProt:Q93033","CD101" -"UniProt:Q8N972","ZNF709" -"UniProt:Q8N8Q1","CYB561D1" -"UniProt:Q92613","JADE3" -"UniProt:P22366","MYD88" -"UniProt:P54709","ATP1B3" -"UniProt:Q5SWA1","PR15B" -"UniProt:Q9HAR2","AGRL3" -"UniProt:Q7L5Y6","DET1" -"UniProt:Q7Z4I7","LIMS2" -"UniProt:Q96M60","FAM227B" -"UniProt:P35442","THBS2" -"UniProt:Q6UW68","TMEM205" -"UniProt:Q96RF1","Q96RF1" -"UniProt:Q14957","NMDE3" -"UniProt:Q8NE79","BVES" -"UniProt:J3KNI1","J3KNI1" -"UniProt:Q13255","GRM1" -"UniProt:Q6VAB6","KSR2" -"UniProt:P49759","CLK1" -"UniProt:O94992","HEXIM1" -"UniProt:Q8NEP7","KLHDC9" -"UniProt:Q16222","UAP1" -"UniProt:P07830","ACT1" -"UniProt:P22090","RPS4Y1" -"UniProt:P02810","PRH2" -"UniProt:Q96JB1","DNAH8" -"UniProt:P47756","CAPZB" -"UniProt:Q14749","GNMT" -"UniProt:P0DPB3","SCHI1" -"UniProt:Q6ZS82","RGS9BP" -"UniProt:P57682","KLF3" -"UniProt:P50458","LHX2" -"UniProt:Q99437","ATP6V0B" -"UniProt:Q969G9","NKD1" -"UniProt:Q9NSD5","SLC6A13" -"UniProt:Q9BZ72","PITPNM2" -"UniProt:P19237","TNNI1" -"UniProt:Q00341","VIGLN" -"UniProt:Q8TF17","SH3TC2" -"UniProt:Q14674","ESPL1" -"UniProt:Q9GZR2","REXO4" -"UniProt:Q2HRC7","VIL6" -"UniProt:P09874","PARP1" -"UniProt:P83369","LSM11" -"UniProt:P0C869","PLA2G4B" -"UniProt:Q9UJU3","ZNF112" -"UniProt:Q9NRZ5","AGPAT4" -"UniProt:Q9BW91","NUDT9" -"UniProt:P61081","UBE2M" -"UniProt:Q9UMF0","ICAM5" -"UniProt:P53609","PGGT1B" -"UniProt:Q8N292","GAPT" -"UniProt:Q99853","FOXB1" -"UniProt:P0C0L5","C4B_2;C4B" -"UniProt:Q9UG56","PISD" -"UniProt:P37023","ACVRL1" -"UniProt:Q53QV2","LBH" -"UniProt:Q96T58","MINT" -"UniProt:Q8NF64","ZMIZ2" -"UniProt:Q8WUD6","CHPT1" -"UniProt:Q53H76","PLA1A" -"UniProt:Q01813","PFKP" -"UniProt:Q96PD7","DGAT2" -"UniProt:P15863","PAX1" -"UniProt:Q9NX09","DDIT4" -"UniProt:Q9BXP5","SRRT" -"UniProt:P08861","CELA3B" -"UniProt:O75386","TULP3" -"UniProt:Q9HB40","SCPEP1" -"UniProt:O15523","DDX3Y" -"UniProt:Q9H479","FN3K" -"UniProt:A1Z1Q3","MACROD2" -"UniProt:Q8IWA5","SLC44A2" -"UniProt:Q9BRY0","SLC39A3" -"UniProt:Q9BQI9","NRIP2" -"UniProt:P49721","PSB2" -"UniProt:Q9UKJ5","CHIC2" -"UniProt:P0C0L4","C4A;C4B" -"UniProt:Q9NPB8","GPCPD1" -"UniProt:P24347","MMP11" -"UniProt:Q99584","S100A13" -"UniProt:Q96BP2","CHCHD1" -"UniProt:Q8TAS1","UHMK1" -"UniProt:Q99720","SIGMAR1" -"UniProt:Q5NV65","IGLV2-18" -"UniProt:Q7L5A8","FA2H" -"UniProt:Q08AN1","ZNF616" -"UniProt:Q8N957","ANKFN1" -"UniProt:Q6PIF2","SYCE2" -"UniProt:Q8N5U1","MS4A15" -"UniProt:Q15465","SHH" -"UniProt:P27105","STOM" -"UniProt:Q6YN16","HSDL2" -"UniProt:P52306","RAP1GDS1" -"UniProt:O60269","GRIN2" -"UniProt:Q11201","ST3GAL1" -"UniProt:O95573","ACSL3" -"UniProt:Q96IL0","APOPT1" -"UniProt:Q9UI47","CTNNA3" -"UniProt:Q6ZS81","WDFY4" -"UniProt:Q8NDG6","TDRD9" -"UniProt:Q9Y5L0","TNPO3" -"UniProt:Q8IY21","DDX60" -"UniProt:Q9P299","COPZ2" -"UniProt:P53804","TTC3" -"UniProt:Q86XP1","DGKH" -"UniProt:Q8WVM0","TFB1M" -"UniProt:P55082","MFAP3" -"UniProt:Q6E213","AWAT2" -"UniProt:Q9NUV7","SPTLC3" -"UniProt:P10747","CD28" -"UniProt:P61956","SUMO2" -"UniProt:Q8NEZ3","WDR19" -"UniProt:Q6P1N0","CC2D1A" -"UniProt:Q9NS69","TOMM22" -"UniProt:Q5FYB0","ARSJ" -"UniProt:P49146","NPY2R" -"UniProt:P78424","POU6F2" -"UniProt:Q969F8","KISS1R" -"UniProt:O14681","EI24" -"UniProt:Q9BRA0","NAA38" -"UniProt:Q9H255","OR51E2" -"UniProt:P42772","CDKN2B" -"UniProt:P58166","INHBE" -"UniProt:Q8TBG4","ETNPPL" -"UniProt:Q9BQK8","LPIN3" -"UniProt:Q9Y6X1","SERP1" -"UniProt:Q8NCW6","GALNT11" -"UniProt:P04054","PLA2G1B" -"UniProt:Q9NW08","POLR3B" -"UniProt:Q9H972","C14orf93" -"UniProt:Q9BX68","HINT2" -"UniProt:Q6NSJ5","LRRC8E" -"UniProt:Q15036","SNX17" -"UniProt:Q8TAQ9","SUN3" -"UniProt:Q9DBG9","TX1B3" -"UniProt:O75916","RGS9" -"UniProt:Q9NPH0","ACP6" -"UniProt:P97484","LIRB3" -"UniProt:Q13068","GAGE1" -"UniProt:P97953","VEGFC" -"UniProt:Q9BYW2","SETD2" -"UniProt:Q8N7N1","FAM86B1" -"UniProt:P20020","ATP2B1" -"UniProt:Q9H0U6","MRPL18" -"UniProt:Q8NC96","NECAP1" -"UniProt:Q9UJX6","ANAPC2" -"UniProt:Q9UI10","EIF2B4" -"UniProt:O14917","PCD17" -"UniProt:Q9BQ89","F110A" -"UniProt:Q9NSY0","NRBP2" -"UniProt:Q9P2W1","PSMC3IP" -"UniProt:P24588","AKAP5" -"UniProt:Q9HBY0","NOX3" -"UniProt:Q6ZNB7","AGMO" -"UniProt:O00526","UPK2" -"UniProt:P20718","GZMH" -"UniProt:Q64693","OBF1" -"UniProt:Q92667","AKAP1" -"UniProt:P41208","CETN2" -"UniProt:Q86SZ2","TRAPPC6B" -"UniProt:Q8IVH8","M4K3" -"UniProt:Q66K41","Z385C" -"UniProt:Q96NC0","ZMAT2" -"UniProt:Q9Y3S1","WNK2" -"UniProt:Q13155","AIMP2" -"UniProt:O95996","APC2" -"UniProt:Q14232","EIF2B1" -"UniProt:O94956","SLCO2B1" -"UniProt:Q9BT09","CNPY3" -"UniProt:Q96GW9","MARS2" -"UniProt:Q96E39","RBMXL1" -"UniProt:Q3LI77","KR134" -"UniProt:A8MTY7","KRTAP9-7" -"UniProt:Q11206","ST3GAL4" -"UniProt:Q9Y5U5","TNFRSF18" -"UniProt:Q96NS1","YPEL4" -"UniProt:Q9ULT6","ZNRF3" -"UniProt:Q8WWA1","TMEM40" -"UniProt:Q9Y676","MRPS18B" -"UniProt:Q9Y466","NR2E1" -"UniProt:Q04724","TLE1" -"UniProt:P49770","EIF2B2" -"UniProt:Q8NCW0","KREMEN2" -"UniProt:Q96PX8","SLITRK1" -"UniProt:Q96P16","RPRD1A" -"UniProt:Q5XKR4","OTP" -"UniProt:Q9BYT3","STK33" -"UniProt:Q709C8","VPS13C" -"UniProt:Q9BSU1","CP070" -"UniProt:A6NFH5","FABP12" -"UniProt:O88572","LRP6" -"UniProt:Q9H4L7","SMARCAD1" -"UniProt:P09234","RU1C" -"UniProt:P49795","RGS19" -"UniProt:Q6UX06","OLFM4" -"UniProt:Q86UD7","TBC1D26" -"UniProt:Q13007","IL24" -"UniProt:Q14002","CEACAM7" -"UniProt:Q8N2M8","CLASRP" -"UniProt:Q96FJ0","STAMBPL1" -"UniProt:Q6P5S2","LEG1H" -"UniProt:Q9NYA1","SPHK1" -"UniProt:Q6NTF7","APOBEC3H" -"UniProt:P13861","KAP2" -"UniProt:Q12986","NFX1" -"UniProt:P28370","SMARCA1" -"UniProt:Q8IUC4","RHPN2" -"UniProt:Q96PM5","RCHY1" -"UniProt:Q7Z6I6","ARHGAP30" -"UniProt:O95497","VNN1" -"UniProt:Q8N668","COMMD1" -"UniProt:Q93086","P2RX5" -"UniProt:P30495","HLA-B" -"UniProt:Q12431","EMC6" -"UniProt:P78536","ADAM17" -"UniProt:D0VY79","D0VY79" -"UniProt:P0C0U1","PB1" -"UniProt:Q15788","NCOA1" -"UniProt:Q8IVW1","ARL17A" -"UniProt:Q15121","PEA15" -"UniProt:Q2M3M2","SLC5A9" -"UniProt:Q12934","BFSP1" -"UniProt:O14561","ACPM" -"UniProt:O75886","STAM2" -"UniProt:Q96QT4","TRPM7" -"UniProt:P52824","DGKQ" -"UniProt:O75360","PROP1" -"UniProt:Q6PI77","BHLH9" -"UniProt:P10853","Hist1h2bf" -"UniProt:Q92540","SMG7" -"UniProt:Q96KN4","FAM84A" -"UniProt:P26038","MSN" -"UniProt:Q99436","PSB7" -"UniProt:Q9WTX6","Cul1" -"UniProt:Q5TGY3","AHDC1" -"UniProt:Q13144","EIF2B5" -"UniProt:Q9BSW7","SYT17" -"UniProt:A8MYP8","ODF3B" -"UniProt:Q13103","SPP2" -"UniProt:Q9NZM3","ITSN2" -"UniProt:Q5T0L3","SPT46" -"UniProt:Q6PKC3","TXD11" -"UniProt:Q96CW1","AP2M1" -"UniProt:Q09328","MGAT5" -"UniProt:Q96M86","DNHD1" -"UniProt:A2RU14","TM218" -"UniProt:Q16773","KAT1" -"UniProt:Q9UL40","ZNF346" -"UniProt:P13798","APEH" -"UniProt:Q969G2","LHX4" -"UniProt:Q9H2X3","CLEC4M" -"UniProt:Q6STE5","SMARCD3" -"UniProt:P37173","TGFBR2" -"UniProt:P08397","HMBS" -"UniProt:Q96D15","RCN3" -"UniProt:Q96KD3","FAM71F1" -"UniProt:P17612","PRKACA" -"UniProt:Q3SY52","ZIK1" -"UniProt:Q9NR50","EIF2B3" -"UniProt:Q92560","BAP1" -"UniProt:O00425","IGF2BP3" -"UniProt:A8MX76","CAPN14" -"UniProt:O96014","WNT11" -"UniProt:O95274","LYPD3" -"UniProt:Q9HCP6","HHATL" -"UniProt:Q01167","FOXK2" -"UniProt:Q75NE6","MIR17HG" -"UniProt:Q9UQV4","LAMP3" -"UniProt:Q9ULB1","NRXN1" -"UniProt:Q8N3Z3","GTPBP8" -"UniProt:P31321","KAP1" -"UniProt:Q96AJ9","VTI1A" -"UniProt:Q4ZH49","Q4ZH49" -"UniProt:Q7Z4H3","HDDC2" -"UniProt:P12369","KAP3" -"UniProt:P09803","CADH1" -"UniProt:O95155","UBE4B" -"UniProt:Q99676","ZNF184" -"UniProt:P26433","SL9A3" -"UniProt:Q5T124","UBXN11" -"UniProt:P31323","KAP3" -"UniProt:P02808","STATH" -"UniProt:Q5BJE1","CCDC178" -"UniProt:B7U540","KCNJ18" -"UniProt:Q8IYM2","SLFN12" -"UniProt:Q7Z3T8","ZFYVE16" -"UniProt:Q8IVT2","MISP" -"UniProt:Q9BR76","COR1B" -"UniProt:Q5H9K5","ZMAT1" -"UniProt:B7ZAP0","RABGAP1L" -"UniProt:Q5VU97","CACHD1" -"UniProt:Q5SZD1","C6orf141" -"UniProt:B2RCZ4","B2RCZ4" -"UniProt:Q8N1W2","ZNF710" -"UniProt:Q32M78","ZN699" -"UniProt:Q5VVP1","SPATA31A6" -"UniProt:Q0VDE8","ADIG" -"UniProt:Q8WY07","SLC7A3" -"UniProt:Q15172","2A5A" -"UniProt:Q6DN14","MCTP1" -"UniProt:O75398","DEAF1" -"UniProt:P68371","TBB4B" -"UniProt:Q8N130","SLC34A3" -"UniProt:P0CG48","UBC" -"UniProt:Q9Y6Q9","NCOA3" -"UniProt:Q16520","BATF" -"UniProt:Q96NT3","GUCD1" -"UniProt:Q86U76","Q86U76" -"UniProt:Q9C010","PKIB" -"UniProt:Q9BXI6","TBC1D10A" -"UniProt:Q8IX18","DHX40" -"UniProt:Q4W4Y0","C14orf28" -"UniProt:P29965","CD40LG" -"UniProt:Q9NVN3","RIC8B" -"UniProt:Q96IZ7","RSRC1" -"UniProt:O43586","PSTPIP1" -"UniProt:Q99685","MGLL" -"UniProt:Q13884","SNTB1" -"UniProt:A4D1P6","WDR91" -"UniProt:P51665","PSMD7" -"UniProt:Q9H3R1","NDST4" -"UniProt:Q9HCE6","ARHGEF10L" -"UniProt:Q64ET8","FRG2" -"UniProt:Q96LZ7","RMD2" -"UniProt:Q7Z699","SPRED1" -"UniProt:Q12841","FSTL1" -"UniProt:Q96LP2","FA81B" -"UniProt:Q658P3","STEAP3" -"UniProt:O60293","ZFC3H1" -"UniProt:P52631","STAT3" -"UniProt:Q02505","MUC3A" -"UniProt:P62253","UBE2G1" -"UniProt:Q86YV0","RASAL3" -"UniProt:Q8N2R0","OSR2" -"UniProt:A0A024R5S0","A0A024R5S0" -"UniProt:P02790","HPX" -"UniProt:Q96B21","TMEM45B" -"UniProt:Q96RU7","TRIB3" -"UniProt:Q8N1G0","ZNF687" -"UniProt:Q5TA81","LCE2C" -"UniProt:P09668","CTSH" -"UniProt:Q96G61","NUDT11" -"UniProt:Q9NUS5","AP5S1" -"UniProt:Q8WXX7","AUTS2" -"UniProt:P40306","PSB10" -"UniProt:O95622","ADCY5" -"UniProt:Q9C004","SPRY4" -"UniProt:P22893","TTP" -"UniProt:Q8ND83","SLAIN1" -"UniProt:P08833","IGFBP1" -"UniProt:Q9H252","KCNH6" -"UniProt:P25705","ATP5A1" -"UniProt:Q5JUX0","SPIN3" -"UniProt:P0C8F1","PATE4" -"UniProt:Q5U5X0","LYRM7" -"UniProt:Q5T751","LCE1C" -"UniProt:O94782","USP1" -"UniProt:Q14331","FRG1" -"UniProt:Q8BIF2","RFOX3" -"UniProt:Q9NQ11","ATP13A2" -"UniProt:Q9H5K3","POMK" -"UniProt:P01701","IGLV1-51" -"UniProt:Q9NR23","GDF3" -"UniProt:Q9QZS3","NUMB" -"UniProt:Q86VZ5","SGMS1" -"UniProt:O75970","MPDZ" -"UniProt:Q9Y4F1","FARP1" -"UniProt:P14075","ENV" -"UniProt:Q96NJ5","KLHL32" -"UniProt:O14569","C56D2" -"UniProt:O15488","GYG2" -"UniProt:Q7Z2V1","C16orf82" -"UniProt:Q9UBX2","LOC107987487;LOC107987484;LOC107987485;LOC107987491;LOC107987490;LOC107987488;LOC107987489;LOC107987486;DUX4" -"UniProt:P01892","HLA-A" -"UniProt:Q16363","LAMA4" -"UniProt:O75177","SS18L1" -"UniProt:Q9UHL9","GT2D1" -"UniProt:P27540","ARNT" -"UniProt:Q9NUX5","POT1" -"UniProt:Q7L099","RUFY3" -"UniProt:Q00536","CDK16" -"UniProt:F1M775","F1M775" -"UniProt:Q9NX63","CHCHD3" -"UniProt:Q92575","UBXN4" -"UniProt:Q6ZMN8","CCNI2" -"UniProt:Q8NHV5","C16orf52" -"UniProt:P04439","HLA-A" -"UniProt:Q96NT0","CCDC115" -"UniProt:Q04978","YMF3" -"UniProt:P61221","ABCE1" -"UniProt:Q8IWC1","MAP7D3" -"UniProt:P31938","MP2K1" -"UniProt:Q9H082","RAB33B" -"UniProt:D3DWK9","D3DWK9" -"UniProt:Q9NZC4","EHF" -"UniProt:Q3MIN7","RGL3" -"UniProt:Q9GZZ7","GFRA4" -"UniProt:Q5JUK2","SOHLH1" -"UniProt:Q8WXA8","HTR3C" -"UniProt:Q8TC29","ENKUR" -"UniProt:P20591","MX1" -"UniProt:Q969Q6","P2R3C" -"UniProt:Q5VIY5","ZNF468" -"UniProt:Q12211","PUS1" -"UniProt:P20039","HLA-DRB1" -"UniProt:Q86WU2","LDHD" -"UniProt:Q9Y5Z6","B3GALT1" -"UniProt:Q8TDI8","TMC1" -"UniProt:Q15084","PDIA6" -"UniProt:Q9UPW6","SATB2" -"UniProt:Q7Z553","MDGA2" -"UniProt:P23352","ANOS1" -"UniProt:P49815","TSC2" -"UniProt:Q9NQ87","HEYL" -"UniProt:P10606","COX5B" -"UniProt:P27986","PIK3R1" -"UniProt:Q8N635","MEIOB" -"UniProt:Q9Y2U2","KCNK7" -"UniProt:O00168","FXYD1" -"UniProt:O60936","NOL3" -"UniProt:P18859","ATP5J" -"UniProt:Q5NV87","IGLV11-55" -"UniProt:Q8NG50","RDM1" -"UniProt:Q03001","DST" -"UniProt:Q92574","TSC1" -"UniProt:Q96BR6","ZNF669" -"UniProt:Q8WVV9","HNRLL" -"UniProt:Q9BWF3","RBM4" -"UniProt:Q9HAY2","MAGEF1" -"UniProt:A5PLN9","TRAPPC13" -"UniProt:Q8NEF9","SRFBP1" -"UniProt:P70191","TRAF5" -"UniProt:Q8IWB6","TEX14" -"UniProt:P40455","YIP2" -"UniProt:A1L4L9","A1L4L9" -"UniProt:Q96F86","EDC3" -"UniProt:P63165","SUMO1" -"UniProt:Q15800","MSMO1" -"UniProt:Q8N653","LZTR1" -"UniProt:Q9NUY8","TBC1D23" -"UniProt:Q9Y2Y1","RPC10" -"UniProt:Q7L014","DDX46" -"UniProt:O95834","EML2" -"UniProt:P19878","NCF2" -"UniProt:Q15131","CDK10" -"UniProt:Q9H2D1","SLC25A32" -"UniProt:P06132","UROD" -"UniProt:O75592","MYCB2" -"UniProt:Q13485","SMAD4" -"UniProt:Q9Y223","GNE" -"UniProt:Q8WZ04","LRTOMT" -"UniProt:Q9NQ90","ANO2" -"UniProt:Q9H4A9","DPEP2" -"UniProt:P01210","PENK" -"UniProt:Q9HB96","FANCE" -"UniProt:Q96LC9","BMF" -"UniProt:Q5T9C9","PIP5KL1" -"UniProt:P22830","FECH" -"UniProt:O75190","DNAJB6" -"UniProt:Q9UHF3","NAT8B" -"UniProt:P52565","ARHGDIA" -"UniProt:Q8TB22","SPATA20" -"UniProt:Q9H091","ZMYND15" -"UniProt:P48730","CSNK1D" -"UniProt:P48059","LIMS1" -"UniProt:A6NFK2","GRXCR2" -"UniProt:Q8N543","OGFOD1" -"UniProt:P08173","CHRM4" -"UniProt:Q548N1","Q548N1" -"UniProt:A6ND01","IZUMO1R" -"UniProt:Q96N67","DOCK7" -"UniProt:Q6V702","C4orf22" -"UniProt:Q9HBE5","IL21R" -"UniProt:O14610","GNGT2" -"UniProt:Q13635","PTCH1" -"UniProt:Q8NG04","SLC26A10" -"UniProt:P20382","PMCH" -"UniProt:Q96PQ7","KLHL5" -"UniProt:P55822","SH3BGR" -"UniProt:Q9P2M4","TBC1D14" -"UniProt:Q5T7P2","LCE1A" -"UniProt:O75496","GMNN" -"UniProt:Q86TC9","MYPN" -"UniProt:Q9UJS0","SLC25A13" -"UniProt:Q9ESN9","MAPK8IP3" -"UniProt:Q04721","NOTCH2" -"UniProt:Q92750","TAF4B" -"UniProt:P01817","IGHV2-5" -"UniProt:Q9BVU3","Q9BVU3" -"UniProt:Q9BXB7","SPATA16" -"UniProt:O76071","CIAO1" -"UniProt:Q9H221","ABCG8" -"UniProt:P01876","IGHA1" -"UniProt:Q3ZCQ8","TIMM50" -"UniProt:Q04844","CHRNE" -"UniProt:Q8N2N9","ANKRD36B" -"UniProt:Q9HBG6","IFT122" -"UniProt:Q6UWN8","SPINK6" -"UniProt:Q9Y271","CYSLTR1" -"UniProt:P47887","OR1E2" -"UniProt:O95661","DIRA3" -"UniProt:Q9GZK4","OR2H1" -"UniProt:P06493","CDK1" -"UniProt:P18465","HLA-B" -"UniProt:Q8NGC9","OR11H4" -"UniProt:Q86V48","LUZP1" -"UniProt:Q8IUW1","Q8IUW1" -"UniProt:A1L0T0","ILVBL" -"UniProt:P09681","GIP" -"UniProt:P16930","FAH" -"UniProt:Q96JA4","M4A14" -"UniProt:P30460","HLA-B" -"UniProt:A6NFC9","OR2W5" -"UniProt:P13288","KR2" -"UniProt:O94876","TMCC1" -"UniProt:P42766","RL35" -"UniProt:P00746","CFD" -"UniProt:Q9NSY2","STARD5" -"UniProt:Q8NGN5","OR10G8" -"UniProt:Q04307","RPC10" -"UniProt:Q8NFU3","TSTD1" -"UniProt:Q5T700","LRAD1" -"UniProt:Q9Y5J6","TIMM10B" -"UniProt:P29994","ITPR1" -"UniProt:Q15025","TNIP1" -"UniProt:O43809","CPSF5" -"UniProt:Q49MI3","CERKL" -"UniProt:Q9HB75","PIDD1" -"UniProt:D3DTT2","D3DTT2" -"UniProt:Q8NGX1","OR2T34" -"UniProt:Q8NGA5","OR10H4" -"UniProt:P40507","AIR1" -"UniProt:Q92598","HS105" -"UniProt:Q8NGE7","OR9K2" -"UniProt:Q14194","DPYL1" -"UniProt:Q7L1S5","CHST9" -"UniProt:P31947","1433S" -"UniProt:P78413","IRX4" -"UniProt:Q6ZR03","YU004" -"UniProt:Q9UBP5","HEY2" -"UniProt:Q8N7X4","MAGB6" -"UniProt:A6NKK0","OR5H1" -"UniProt:Q8IVP5","FUNDC1" -"UniProt:Q9ULS5","TMCC3" -"UniProt:A4D1E1","ZNF804B" -"UniProt:Q9H4F1","ST6GALNAC4" -"UniProt:Q13946","PDE7A" -"UniProt:Q9P1P4","TAAR3" -"UniProt:Q9UK10","ZNF225" -"UniProt:Q9BU79","TM243" -"UniProt:Q92806","KCNJ9" -"UniProt:Q92670","ZNF75CP" -"UniProt:Q6IF99","OR10K2" -"UniProt:Q6P1R4","DUS1L" -"UniProt:Q8TF39","ZNF483" -"UniProt:O95628","CNOT4" -"UniProt:P12520","VPR" -"UniProt:Q1KLZ0","Q1KLZ0" -"UniProt:O95371","OR2C1" -"UniProt:Q14392","LRRC32" -"UniProt:P32927","CSF2RB" -"UniProt:Q9Y2F5","ICE1" -"UniProt:Q9BRX9","WDR83" -"UniProt:Q8NGF3","OR51D1" -"UniProt:Q8N999","C12orf29" -"UniProt:Q5SVZ6","ZMYM1" -"UniProt:O00291","HIP1" -"UniProt:Q3LIE5","ADPRM" -"UniProt:P12956","XRCC6" -"UniProt:Q7Z2F6","ZN720" -"UniProt:Q6UXN8","CLEC9A" -"UniProt:P59025","RTP1" -"UniProt:Q15648","MED1" -"UniProt:P35918","Kdr" -"UniProt:O75783","RHBL1" -"UniProt:Q8NGK9","OR5D16" -"UniProt:Q8NHP1","AKR7L" -"UniProt:P23396","RS3" -"UniProt:Q9Y2X7","GIT1" -"UniProt:H0Y5X4","H0Y5X4" -"UniProt:Q494R4","CC153" -"UniProt:Q9UGF5","OR14J1" -"UniProt:Q04206","TF65" -"UniProt:A8MTJ3","GNAT3" -"UniProt:O43889","CREB3" -"UniProt:Q9P2H0","CE126" -"UniProt:Q8NGJ2","OR52H1" -"UniProt:Q8NH87","OR9G1" -"UniProt:P58400","NRXN1" -"UniProt:Q8NGY7","OR10J6P" -"UniProt:Q5M7Z0","RNFT1" -"UniProt:Q8NDQ6","ZNF540" -"UniProt:Q9UKB1","FBW1B" -"UniProt:Q96AG4","LRC59" -"UniProt:J3QQT5","J3QQT5" -"UniProt:P16401","H15" -"UniProt:Q8NH08","OR10AC1" -"UniProt:Q00872","MYBPC1" -"UniProt:Q14137","BOP1" -"UniProt:Q8NGW1","OR6B3" -"UniProt:Q12746","PGA3" -"UniProt:Q92973","TNPO1" -"UniProt:P54278","LOC107984056;PMS2" -"UniProt:Q9BVL2","NUP58" -"UniProt:Q12901","ZNF155" -"UniProt:P20936","RASA1" -"UniProt:Q8NH51","OR8K3" -"UniProt:Q86VP3","PACS2" -"UniProt:O14545","TRAD1" -"UniProt:P14784","IL2RB" -"UniProt:Q9NP66","HM20A" -"UniProt:P54577","YARS" -"UniProt:Q7Z4F1","LRP10" -"UniProt:P28906","CD34" -"UniProt:Q9NV72","ZNF701" -"UniProt:Q6IEZ7","OR2T5" -"UniProt:Q9NY59","SMPD3" -"UniProt:Q07108","CD69" -"UniProt:Q9NX47","MARH5" -"UniProt:Q07887","LDB18" -"UniProt:Q86XQ3","CATSPER3" -"UniProt:Q96R84","OR1F2P" -"UniProt:Q6AHZ1","ZNF518A" -"UniProt:Q8NGC8","OR11H7" -"UniProt:Q9Y3D6","FIS1" -"UniProt:P16233","PNLIP" -"UniProt:Q02078","MEF2A" -"UniProt:P54750","PDE1A" -"UniProt:P11226","MBL2" -"UniProt:O15079","SNPH" -"UniProt:Q8NH48","OR5B3" -"UniProt:P17483","HOXB4" -"UniProt:Q8IZT9","FAM9C" -"UniProt:Q7Z2Y5","NRK" -"UniProt:Q8NGQ3","OR1S2" -"UniProt:Q7Z406","MYH14" -"UniProt:Q8WVM8","SCFD1" -"UniProt:P54803","GALC" -"UniProt:H9KV84","H9KV84" -"UniProt:Q8NFW1","COL22A1" -"UniProt:A8MXD5","GRXCR1" -"UniProt:P06576","ATPB" -"UniProt:Q5HYI8","RABL3" -"UniProt:P31277","HOXD11" -"UniProt:O14684","PTGES" -"UniProt:Q9Y592","CEP83" -"UniProt:Q15744","CEBPE" -"UniProt:P25335","ALLC" -"UniProt:Q5VIR6","VPS53" -"UniProt:Q12118","SGT2" -"UniProt:Q9H6U6","BCAS3" -"UniProt:Q14451","GRB7" -"UniProt:Q05932","FPGS" -"UniProt:Q9H0C2","ADT4" -"UniProt:Q701N2","KRTAP5-5" -"UniProt:P43166","CA7" -"UniProt:Q8TAT2","FGFBP3" -"UniProt:Q9UHI7","SLC23A1" -"UniProt:P50151","GBG10" -"UniProt:P10316","HLA-A" -"UniProt:P07900","HS90A" -"UniProt:Q8NDZ0","BEND2" -"UniProt:Q96PU8","QKI" -"UniProt:Q96P47","AGAP3" -"UniProt:P36084","MUD2" -"UniProt:Q8N944","AMER3" -"UniProt:Q9BZE0","GLIS2" -"UniProt:Q9H669","Q9H669" -"UniProt:O60888","CUTA" -"UniProt:P22674","CCNO" -"UniProt:Q6XR72","SLC30A10" -"UniProt:Q16881","TRXR1" -"UniProt:Q9Y274","ST3GAL6" -"UniProt:P41134","ID1" -"UniProt:Q61214","DYR1A" -"UniProt:O94766","B3GAT3" -"UniProt:P53597","SUCLG1" -"UniProt:P61647","ST8SIA6" -"UniProt:P51692","STAT5B" -"UniProt:Q9UBC3","DNMT3B" -"UniProt:Q69ZI1","SH3R1" -"UniProt:P09067","HXB5" -"UniProt:Q9GZS9","CHST5" -"UniProt:Q86TJ2","TADA2B" -"UniProt:P29597","TYK2" -"UniProt:A6NJZ3","OR6C65" -"UniProt:Q9NST1","PNPLA3" -"UniProt:P54851","EMP2" -"UniProt:Q9C0D5","TANC1" -"UniProt:Q8NEF3","CCDC112" -"UniProt:Q9BYR2","KRA45" -"UniProt:Q9BQ48","MRPL34" -"UniProt:A8K979","ERI2" -"UniProt:P46095","GPR6" -"UniProt:O94818","NOL4" -"UniProt:Q9NUP9","LIN7C" -"UniProt:P55899","FCGRT" -"UniProt:Q9QY36","NAA10" -"UniProt:Q9Z0H7","Bcl10" -"UniProt:P08185","SERPINA6" -"UniProt:Q9BRR9","ARHGAP9" -"UniProt:H0Y695","H0Y695" -"UniProt:Q96RT8","GCP5" -"UniProt:P54252","ATXN3" -"UniProt:G8BFS5","G8BFS5" -"UniProt:O95154","ARK73" -"UniProt:O60741","HCN1" -"UniProt:Q9UIK5","TEFF2" -"UniProt:Q8TAF7","ZNF461" -"UniProt:O00330","PDHX" -"UniProt:Q9H8K7","CJ088" -"UniProt:Q8N7Y1","KIAS3" -"UniProt:Q86TL0","ATG4D" -"UniProt:G8BE22","G8BE22" -"UniProt:Q03160","GRB7" -"UniProt:Q8TEA1","NSUN6" -"UniProt:Q8TEW8","PARD3B" -"UniProt:Q96FK6","WDR89" -"UniProt:P08493","MGP" -"UniProt:Q9UHD1","CHORDC1" -"UniProt:Q9Y4G2","PLEKHM1" -"UniProt:O75907","DGAT1" -"UniProt:Q6ISS4","LAIR2" -"UniProt:A6NHR9","SMCHD1" -"UniProt:Q6UWU2","GLB1L" -"UniProt:Q9BXU3","TX13A" -"UniProt:P0DI83","RAB34" -"UniProt:Q8WY64","MYLIP" -"UniProt:O70239","AXIN1" -"UniProt:P60411","KR109" -"UniProt:Q6ZMS4","ZNF852" -"UniProt:P11137","MAP2" -"UniProt:Q9NRA8","4ET" -"UniProt:Q02747","GUC2A" -"UniProt:Q12815","TROAP" -"UniProt:P81605","DCD" -"UniProt:Q9Y2U5","M3K2" -"UniProt:Q96NU1","SAMD11" -"UniProt:Q1LZN1","Q1LZN1" -"UniProt:P18621","RL17" -"UniProt:Q8NFM7","IL17RD" -"UniProt:P0CB33","ZNF735" -"UniProt:Q9HCX3","ZNF304" -"UniProt:Q9Y5X4","NR2E3" -"UniProt:Q96PZ7","CSMD1" -"UniProt:Q8TAT6","NPLOC4" -"UniProt:Q77M19","Q77M19" -"UniProt:P23368","ME2" -"UniProt:Q12789","TF3C1" -"UniProt:P38919","EIF4A3" -"UniProt:O54921","EXOC2" -"UniProt:P62753","RS6" -"UniProt:P23644","TOM40" -"UniProt:Q9H1B5","XYLT2" -"UniProt:Q9NS75","CLTR2" -"UniProt:Q12851","M4K2" -"UniProt:Q3KRG0","Q3KRG0" -"UniProt:Q92843","B2CL2" -"UniProt:P17987","TCPA" -"UniProt:Q6P3X8","PGBD2" -"UniProt:Q6P1M9","ARMCX5" -"UniProt:Q9H467","CUED2" -"UniProt:O88509","Dnmt3b" -"UniProt:Q9JJG6","TMM47" -"UniProt:Q12778","FOXO1" -"UniProt:P52815","MRPL12" -"UniProt:P70444","BID" -"UniProt:Q96BI1","SLC22A18" -"UniProt:P49802","RGS7" -"UniProt:I4AY87","I4AY87" -"UniProt:Q13029","PRDM2" -"UniProt:Q8N0V5","GCNT2" -"UniProt:Q9UN19","DAPP1" -"UniProt:P05165","PCCA" -"UniProt:Q14978","NOLC1" -"UniProt:O95816","BAG2" -"UniProt:Q969G5","CAVN3" -"UniProt:P46531","NOTCH1" -"UniProt:P05166","PCCB" -"UniProt:Q61337","BAD" -"UniProt:Q9NTI2","ATP8A2" -"UniProt:P40014","SPC25" -"UniProt:Q68D85","NCR3LG1" -"UniProt:Q9UJF2","NGAP" -"UniProt:Q5MJ09","SPXN3" -"UniProt:P10071","GLI3" -"UniProt:Q8N428","GALNT16" -"UniProt:P37837","TALDO1" -"UniProt:Q5JSH3","WDR44" -"UniProt:Q6ZN57","ZFP2" -"UniProt:Q5QJU3","ACER2" -"UniProt:Q7Z333","SETX" -"UniProt:P32249","GPR183" -"UniProt:Q8NGN1","OR6T1" -"UniProt:Q6ZMP0","THSD4" -"UniProt:Q6UXR4","SERPINA13P" -"UniProt:Q9Y3D9","RT23" -"UniProt:Q8N7C4","TMEM217" -"UniProt:P31424","GRM5" -"UniProt:Q3B820","FAM161A" -"UniProt:P41410","RAD54" -"UniProt:Q96Q80","DERL3" -"UniProt:P56589","PEX3" -"UniProt:P08107","HSP71" -"UniProt:P46734","MP2K3" -"UniProt:P55273","CDKN2D" -"UniProt:P48728","AMT" -"UniProt:O60268","KIAA0513" -"UniProt:Q9ULV5","HSF4" -"UniProt:Q9Y5A6","ZSC21" -"UniProt:P87108","TIM10" -"UniProt:P05880","env" -"UniProt:Q13156","RPA4" -"UniProt:Q9P0K8","FOXJ2" -"UniProt:Q91ZE9","BMF" -"UniProt:P28749","RBL1" -"UniProt:Q8WWU5","TCP11" -"UniProt:Q9BXM7","PINK1" -"UniProt:Q93052","LPP" -"UniProt:P50150","GNG4" -"UniProt:J3KPQ4","J3KPQ4" -"UniProt:Q8NG77","OR2T12" -"UniProt:P61278","SST" -"UniProt:Q9H974","QTRT2" -"UniProt:P55316","FOXG1" -"UniProt:Q8IYL2","TRMT44" -"UniProt:Q8NFU4","FDSCP" -"UniProt:Q9C000","NLRP1" -"UniProt:P49334","TOM22" -"UniProt:B2RUZ4","SMIM1" -"UniProt:Q07440","B2LA1" -"UniProt:Q9Y2P5","S27A5" -"UniProt:P35658","NUP214" -"UniProt:P23378","GLDC" -"UniProt:Q8N402","YV020" -"UniProt:Q9Y5R5","DMRT2" -"UniProt:Q9BXH1","BBC3" -"UniProt:A6NGY1","FRG2C" -"UniProt:P47013","DS1P1" -"UniProt:O00399","DCTN6" -"UniProt:P23434","GCSH" -"UniProt:Q60644","NR1H2" -"UniProt:Q9Y371","SH3GLB1" -"UniProt:Q9UI17","DMGDH" -"UniProt:Q8NGD5","OR4K14" -"UniProt:Q5T7Y6","Q5T7Y6" -"UniProt:P28301","LYOX" -"UniProt:Q08E77","Q08E77" -"UniProt:O75794","CDC123" -"UniProt:Q8IV45","UN5CL" -"UniProt:Q14693","LPIN1" -"UniProt:Q9NQI0","DDX4" -"UniProt:A8MPY1","GABRR3" -"UniProt:Q8NAC3","IL17RC" -"UniProt:Q8TD91","MAGEC3" -"UniProt:P0C0P6","NPS" -"UniProt:P51946","CCNH" -"UniProt:O43709","BUD23" -"UniProt:P42285","SK2L2" -"UniProt:O00522","KRIT1" -"UniProt:Q13724","MOGS" -"UniProt:Q8IX90","SKA3" -"UniProt:A0AVI2","FER1L5" -"UniProt:Q00537","CDK17" -"UniProt:Q8N531","FBXL6" -"UniProt:Q70YC4","ZNF365" -"UniProt:P60059","SC61G" -"UniProt:O75425","MOSPD3" -"UniProt:P08620","FGF4" -"UniProt:P23759","PAX7" -"UniProt:Q9NRD9","DUOX1" -"UniProt:A8K5H9","A8K5H9" -"UniProt:Q56NI9","ESCO2" -"UniProt:Q86T03","TM55B" -"UniProt:Q9NQR4","NIT2" -"UniProt:Q8VIG1","REST" -"UniProt:Q9NP59","SLC40A1" -"UniProt:Q96PL2","TECTB" -"UniProt:P04579","env" -"UniProt:Q9NVH0","EXD2" -"UniProt:A6NCW0","USP17L3" -"OMIM:103050","ADENYLOSUCCINASE DEFICIENCY; ADSLD" -"OMIM:602089","HEMANGIOMA, CAPILLARY INFANTILE" -"OMIM:127350","DYSCHONDROSTEOSIS AND NEPHRITIS" -"DOID:4249","Gerstmann-Straussler-Scheinker syndrome" -"DOID:0110341","osteogenesis imperfecta type 2" -"OMIM:102699","ADENO-ASSOCIATED VIRUS INTEGRATION SITE 1; AAVS1" -"OMIM:602092","DEAFNESS, AUTOSOMAL RECESSIVE 18A; DFNB18A" -"OMIM:602093","CONE DYSTROPHY 3; COD3" -"OMIM:103200","ADIPOSIS DOLOROSA" -"OMIM:127400","DYSCHROMATOSIS SYMMETRICA HEREDITARIA; DSH" -"DOID:0050784","primary progressive multiple sclerosis" -"OMIM:602096","ALZHEIMER DISEASE 5" -"OMIM:602097","USHER SYNDROME, TYPE IE; USH1E" -"DOID:0110339","osteogenesis imperfecta type 3" -"DOID:0110346","osteogenesis imperfecta type 10" -"OMIM:602099","AMYOTROPHIC LATERAL SCLEROSIS 5, JUVENILE; ALS5" -"OMIM:602107","NEUROPATHY, HEREDITARY THERMOSENSITIVE" -"DOID:0110962","brachydactyly-preaxial hallux varus syndrome" -"DOID:1107","esophageal carcinoma" -"DOID:0110335","osteogenesis imperfecta with opalescent teeth, blue sclerae and wormian bones but without fractures" -"OMIM:602111","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, MISSOURI TYPE" -"OMIM:102900","ADENOSINE TRIPHOSPHATE, ELEVATED, OF ERYTHROCYTES" -"DOID:0050651","atrioventricular septal defect" -"OMIM:602114","NEPHROPATHY, PROGRESSIVE TUBULOINTERSTITIAL, WITH CHOLESTATIC LIVER DISEASE" -"DOID:1697","ichthyosis" -"OMIM:602124","DYSTONIA 7, TORSION; DYT7" -"OMIM:127100","DWARFISM, LEVI TYPE" -"OMIM:602134","TREMOR, HEREDITARY ESSENTIAL, 2; ETM2" -"OMIM:127200","DWARFISM WITH STIFF JOINTS AND OCULAR ABNORMALITIES" -"OMIM:602152","RHYNS SYNDROME" -"DOID:0090118","congenital amegakaryocytic thrombocytopenia" -"OMIM:602196","PIERRE ROBIN SEQUENCE WITH PECTUS EXCAVATUM AND RIB AND SCAPULAR ANOMALIES" -"OMIM:127000","KENNY-CAFFEY SYNDROME, TYPE 2; KCS2" -"OMIM:602197","CEREBELLAR DEGENERATION-RELATED AUTOANTIGEN 3" -"DOID:0050147","otomycosis" -"OMIM:602199","MEDIUM CHAIN 3-KETOACYL-CoA THIOLASE DEFICIENCY" -"OMIM:602200","VENTRICULOMEGALY WITH DEFECTS OF THE RADIUS AND KIDNEY" -"DOID:0060571","Ritscher-Schinzel syndrome 1" -"OMIM:138990","GRANULOMATOUS DISEASE, CHRONIC, AUTOSOMAL DOMINANT TYPE" -"DOID:10518","beach ear" -"OMIM:602247","XANTHOMATOSIS, SUSCEPTIBILITY TO" -"DOID:778","delusional disorder" -"DOID:0111101","maturity-onset diabetes of the young type 5" -"OMIM:602248","MALIGNANT ATROPHIC PAPULOSIS" -"OMIM:602249","PROGEROID FACIAL APPEARANCE WITH HAND ANOMALIES" -"DOID:1114","esophagus sarcoma" -"DOID:10520","acute infection of pinna" -"OMIM:602252","MITOCHONDRIAL INTERMEMBRANE SPACE PROTEIN TIM12, YEAST, HOMOLOG OF" -"OMIM:602271","SPONDYLOMETAPHYSEAL DYSPLASIA, AXIAL; SMDAX" -"OMIM:602340","SENSORINEURAL HEARING LOSS, RETINAL PIGMENT EPITHELIUM LESIONS, DISCOLORED TEETH" -"OMIM:602342","PIERPONT SYNDROME; PRPTS" -"DOID:8672","viral exanthem" -"OMIM:613348","PANCREATIC CANCER, SUSCEPTIBILITY TO, 3" -"OMIM:605543","PARKINSON DISEASE 4, AUTOSOMAL DOMINANT; PARK4" -"OMIM:617272","GLAUCOMA 3, PRIMARY CONGENITAL, E; GLC3E" -"OMIM:104110","ALOPECIA, FAMILIAL FOCAL; ALPF" -"OMIM:617275","TOOTH AGENESIS, SELECTIVE, 9; STHAG9" -"DOID:4990","essential tremor" -"OMIM:103920","ALLERGIC BRONCHOPULMONARY ASPERGILLOSIS, FAMILIAL" -"OMIM:605544","FIBROMATOSIS, GINGIVAL, 2; GINGF2" -"OMIM:613353","MONONEUROPATHY OF THE MEDIAN NERVE, MILD; MNMN" -"OMIM:605549","CONE-ROD DYSTROPHY 8; CORD8" -"DOID:1474","aggressive periodontitis" -"OMIM:613355","CHROMOSOME 17q23.1-q23.2 DELETION SYNDROME" -"OMIM:617276","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 48; EIEE48" -"OMIM:613364","SPASTIC PARAPLEGIA 41, AUTOSOMAL DOMINANT; SPG41" -"OMIM:605552","ABDOMINAL OBESITY-METABOLIC SYNDROME 1; AOMS1" -"OMIM:617280","ATRIAL FIBRILLATION, FAMILIAL, 18; ATFB18" -"DOID:10423","acute pericementitis" -"OMIM:605572","ABDOMINAL OBESITY-METABOLIC SYNDROME QUANTITATIVE TRAIT LOCUS 2" -"OMIM:617281","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 49; EIEE49" -"OMIM:613370","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 10; MODY10" -"DOID:0060264","pontocerebellar hypoplasia" -"OMIM:617282","DYSTONIA, CHILDHOOD-ONSET, WITH OPTIC ATROPHY AND BASAL GANGLIA ABNORMALITIES; DYTOABG" -"OMIM:613371","SPINOCEREBELLAR ATAXIA 30; SCA30" -"OMIM:605582","CARDIOMYOPATHY, DILATED, 1K; CMD1K" -"OMIM:605583","DEAFNESS, AUTOSOMAL DOMINANT 25; DFNA25" -"OMIM:617284","DYSTONIA 28, CHILDHOOD-ONSET; DYT28" -"OMIM:613375","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 11; MODY11" -"OMIM:104000","ALOPECIA AREATA 1; AA1" -"OMIM:605588","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2B1; CMT2B1" -"OMIM:617290","EPILEPSY, EARLY-ONSET, VITAMIN B6-DEPENDENT; EPVB6D" -"OMIM:613376","NEURONOPATHY, DISTAL HEREDITARY MOTOR, TYPE IIC; HMN2C" -"DOID:13709","premature ejaculation" -"OMIM:605589","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2B2; CMT2B2" -"OMIM:617294","EPIDERMOLYSIS BULLOSA SIMPLEX, GENERALIZED, WITH SCARRING AND HAIR LOSS; EBSSH" -"OMIM:613382","BRACHYDACTYLY, TYPE E2; BDE2" -"OMIM:103900","HYPERALDOSTERONISM, FAMILIAL, TYPE I; HALD1" -"OMIM:613385","AUTOIMMUNE DISEASE, MULTISYSTEM, WITH FACIAL DYSMORPHISM; ADMFD" -"OMIM:617296","SPASTIC PARAPLEGIA, INTELLECTUAL DISABILITY, NYSTAGMUS, AND OBESITY; SINO" -"OMIM:605594","DEAFNESS, AUTOSOMAL DOMINANT 39, WITH DENTINOGENESIS IMPERFECTA 1" -"DOID:823","periapical periodontitis" -"OMIM:605598","DIABETES MELLITUS, INSULIN-DEPENDENT, 18; IDDM18" -"OMIM:613387","FATTY LIVER DISEASE, NONALCOHOLIC, SUSCEPTIBILITY TO, 2; NAFLD2" -"OMIM:617297","AMELOGENESIS IMPERFECTA, TYPE IJ; AI1J" -"DOID:0110145","Bartter disease type 4a" -"OMIM:617300","HYDROPS FETALIS, NONIMMUNE, AND/OR ATRIAL SEPTAL DEFECT, SUSCEPTIBILITY TO; HFASD" -"OMIM:613388","FANCONI RENOTUBULAR SYNDROME 2; FRTS2" -"OMIM:605606","PSORIASIS 7, SUSCEPTIBILITY TO; PSORS7" -"OMIM:605618","TETRALOGY OF FALLOT SYNDROME, AUTOSOMAL RECESSIVE" -"OMIM:617301","GLYCINE ENCEPHALOPATHY WITH NORMAL SERUM GLYCINE" -"OMIM:613390","FANCONI ANEMIA, COMPLEMENTATION GROUP O; FANCO" -"OMIM:605627","CEREBROOCULONASAL SYNDROME" -"DOID:7401","colonic L-cell glucagon-like peptide producing tumor" -"OMIM:613391","DEAFNESS, AUTOSOMAL RECESSIVE 84A; DFNB84A" -"DOID:8566","herpes simplex" -"DOID:7045","basaloid lung carcinoma" -"OMIM:617302","OPTIC ATROPHY 11; OPA11" -"OMIM:613392","DEAFNESS, AUTOSOMAL RECESSIVE 85; DFNB85" -"OMIM:605635","HYPERALDOSTERONISM, FAMILIAL, TYPE II; HALD2" -"OMIM:617303","MUCOPOLYSACCHARIDOSIS-PLUS SYNDROME; MPSPS" -"DOID:12859","choreatic disease" -"OMIM:613393","BIRBECK GRANULE DEFICIENCY" -"OMIM:605637","MYOPATHY, PROXIMAL, AND OPHTHALMOPLEGIA; MYPOP" -"OMIM:617304","RETINITIS PIGMENTOSA 77; RP77" -"OMIM:613398","WARSAW BREAKAGE SYNDROME; WABS" -"OMIM:605642","THYROID CARCINOMA, PAPILLARY, WITH PAPILLARY RENAL NEOPLASIA" -"OMIM:617306","COLOBOMA, OSTEOPETROSIS, MICROPHTHALMIA, MACROCEPHALY, ALBINISM, AND DEAFNESS; COMMAD" -"OMIM:617308","BILE ACID SYNTHESIS DEFECT, CONGENITAL, 6; CBAS6" -"OMIM:605670","LATE-ONSET RETINAL DEGENERATION; LORD" -"OMIM:613399","BREAST-OVARIAN CANCER, FAMILIAL, SUSCEPTIBILITY TO, 3; BROVCA3" -"OMIM:605672","CEREBELLAR ATAXIA AND HYPERGONADOTROPIC HYPOGONADISM" -"OMIM:613402","MICROCEPHALY, SEIZURES, AND DEVELOPMENTAL DELAY; MCSZ" -"OMIM:617315","ANTERIOR SEGMENT DYSGENESIS 6; ASGD6" -"DOID:14499","Fabry disease" -"OMIM:605676","CARDIOMYOPATHY, DILATED, WITH WOOLLY HAIR AND KERATODERMA; DCWHK" -"OMIM:617319","ANTERIOR SEGMENT DYSGENESIS 8; ASGD8" -"DOID:10054","skin amelanotic melanoma" -"OMIM:613404","ARTHROGRYPOSIS, RENAL DYSFUNCTION, AND CHOLESTASIS 2; ARCS2" -"OMIM:613406","WITTEVEEN-KOLK SYNDROME; WITKOS" -"OMIM:617320","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 12; ARCI12" -"OMIM:605711","MULTIPLE MITOCHONDRIAL DYSFUNCTIONS SYNDROME 1; MMDS1" -"OMIM:605714","CEREBRAL AMYLOID ANGIOPATHY, APP-RELATED" -"OMIM:613407","LEPROSY, SUSCEPTIBILITY TO, 6; LPRS6" -"OMIM:617321","YAO SYNDROME; YAOS" -"OMIM:617323","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 59; MRT59" -"OMIM:613410","AUTISM, SUSCEPTIBILITY TO, 16; AUTS16" -"OMIM:605724","FANCONI ANEMIA, COMPLEMENTATION GROUP D1; FANCD1" -"DOID:13366","Stiff-Person syndrome" -"OMIM:605726","SPINAL MUSCULAR ATROPHY, DISTAL, AUTOSOMAL RECESSIVE, 2; DSMA2" -"OMIM:613411","OGUCHI DISEASE 2" -"OMIM:617330","HYPOTONIA, ATAXIA, AND DELAYED DEVELOPMENT SYNDROME; HADDS" -"OMIM:613412","ESOPHAGITIS, EOSINOPHILIC, 2; EOE2" -"OMIM:617333","INTELLECTUAL DEVELOPMENTAL DISORDER WITH DYSMORPHIC FACIES AND PTOSIS; IDDDFP" -"OMIM:605727","OTOSCLEROSIS 2; OTSC2" -"OMIM:605728","CATARACT 25; CTRCT25" -"OMIM:617336","NEMALINE MYOPATHY 11, AUTOSOMAL RECESSIVE; NEM11" -"OMIM:613418","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 15; BMND15" -"DOID:1992","rectum malignant melanoma" -"OMIM:617337","ECTODERMAL DYSPLASIA 12, HYPOHIDROTIC/HAIR/TOOTH/NAIL TYPE; ECTD12" -"OMIM:605735","BLEEDING DISORDER, PLATELET-TYPE, 12; BDPLT12" -"OMIM:613424","CARDIOMYOPATHY, DILATED, 1R; CMD1R" -"OMIM:605738","MICROPHTHALMIA, ISOLATED, WITH COLOBOMA 2; MCOPCB2" -"OMIM:613426","CARDIOMYOPATHY, DILATED, 1S; CMD1S" -"OMIM:617339","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 51; EIEE51" -"DOID:13839","extrapyramidal and movement disease" -"OMIM:605746","ANISOMASTIA" -"OMIM:617341","CEREBRORETINAL MICROANGIOPATHY WITH CALCIFICATIONS AND CYSTS 2; CRMCC2" -"OMIM:613428","RETINITIS PIGMENTOSA 54; RP54" -"OMIM:605749","CATARACT 26, MULTIPLE TYPES; CTRCT26" -"OMIM:613435","AMYOTROPHIC LATERAL SCLEROSIS 12; ALS12" -"OMIM:617343","HYPERPARATHYROIDISM 4; HRPT4" -"OMIM:617347","HYPERLIPOPROTEINEMIA, TYPE III" -"OMIM:613436","AUTISM, SUSCEPTIBILITY TO, 17; AUTS17" -"OMIM:605750","EXUDATIVE VITREORETINOPATHY 3; EVR3" -"DOID:1713","benign shuddering attacks" -"DOID:11337","Lemierre's syndrome" -"OMIM:605751","SEIZURES, BENIGN FAMILIAL INFANTILE, 2; BFIS2" -"OMIM:613440","STATURE QUANTITATIVE TRAIT LOCUS 21; STQTL21" -"OMIM:617349","AORTIC ANEURYSM, FAMILIAL THORACIC 11, SUSCEPTIBILITY TO; AAT11" -"DOID:824","periodontitis" -"OMIM:613443","MENTAL RETARDATION, AUTOSOMAL DOMINANT 20; MRD20" -"OMIM:617350","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 52; EIEE52" -"OMIM:605756","OVARIAN DYSGENESIS, HYPERGONADOTROPIC, WITH SHORT STATURE AND RECURRENT METABOLIC ACIDOSIS" -"OMIM:605779","NAIL DISORDER, NONSYNDROMIC CONGENITAL, 7; NDNC7" -"OMIM:617352","MULCHANDANI-BHOJ-CONLIN SYNDROME; MBCS" -"OMIM:613444","CHROMOSOME 16p11.2 DELETION SYNDROME, 220-KB" -"DOID:0110117","autoimmune lymphoproliferative syndrome type 4" -"OMIM:617364","CONGENITAL HEART DEFECTS AND ECTODERMAL DYSPLASIA; CHDED" -"OMIM:605803","DERMATITIS, ATOPIC, 2; ATOD2" -"OMIM:613451","FRONTONASAL DYSPLASIA 2; FND2" -"OMIM:617360","CONGENITAL HEART DEFECTS, DYSMORPHIC FACIAL FEATURES, AND INTELLECTUAL DEVELOPMENTAL DISORDER; CHDFIDD" -"OMIM:104100","PALMOPLANTAR KERATODERMA AND CONGENITAL ALOPECIA 1; PPKCA1" -"OMIM:605804","DERMATITIS, ATOPIC, 3; ATOD3" -"UniProt:Q12527","ATG11" -"UniProt:O95475","SIX6" -"UniProt:Q9Y3D7","PAM16" -"UniProt:O00471","EXOC5" -"UniProt:O75096","LRP4" -"UniProt:Q02774","SHR3" -"UniProt:P53990","IST1" -"UniProt:A4D1E9","GTPBP10" -"UniProt:Q9UHB9","SRP68" -"UniProt:Q04323","UBXN1" -"UniProt:P60370","KR105" -"UniProt:Q96C32","Q96C32" -"UniProt:O43665","RGS10" -"UniProt:P16104","H2AFX" -"UniProt:P9WGV3","SAHH" -"UniProt:Q9BX82","ZNF471" -"UniProt:O96000","NDUFB10" -"UniProt:Q9Y606","PUS1" -"UniProt:Q14210","LY6D" -"UniProt:Q9NZR4","VSX1" -"UniProt:Q6Q788","APOA5" -"UniProt:Q01524","DEF6" -"UniProt:O75191","XYLB" -"UniProt:O95232","LC7L3" -"UniProt:Q8TBR7","FAM57A" -"UniProt:Q9BYH1","SEZ6L" -"UniProt:Q5TA77","LCE3B" -"UniProt:Q9NV96","CC50A" -"UniProt:Q86UT6","NLRX1" -"UniProt:Q8TD06","AGR3" -"UniProt:P29034","S10A2" -"UniProt:P39905","GDNF" -"UniProt:O75128","COBL" -"UniProt:Q3MIR4","CC50B" -"UniProt:Q53EQ6","TIGD5" -"UniProt:P38374","YSY6" -"UniProt:Q3UVX5","GRM5" -"UniProt:Q9UPI3","FLVCR2" -"UniProt:Q8WVT3","TRAPPC12" -"UniProt:Q9Y6G1","TM14A" -"UniProt:Q6UXA7","CF015" -"UniProt:Q0P631","Q0P631" -"UniProt:Q9NRM7","LATS2" -"UniProt:Q9NVX2","NLE1" -"UniProt:P01920","HLA-DQB1" -"UniProt:P13379","CD5" -"UniProt:Q02252","ALDH6A1" -"UniProt:Q8TB40","ABHD4" -"UniProt:P47871","GCGR" -"UniProt:Q9BYE0","HES7" -"UniProt:Q16706","MAN2A1" -"UniProt:Q6XZB0","LIPI" -"UniProt:P03973","SLPI" -"UniProt:O60331","PIP5K1C" -"UniProt:Q969S3","ZN622" -"UniProt:P54259","ATN1" -"UniProt:Q8IYB9","ZNF595" -"UniProt:Q53EL9","SEZ6" -"UniProt:O60503","ADCY9" -"UniProt:Q9NWF9","RNF216" -"UniProt:Q9NS67","GPR27" -"UniProt:O95925","EPPIN" -"UniProt:Q9Y548","YIPF1" -"UniProt:Q9NQC1","JADE2" -"UniProt:Q8TGQ7","YP159" -"UniProt:O15072","ATS3" -"UniProt:Q9NPC2","KCNK9" -"UniProt:Q9ULV3","CIZ1" -"UniProt:Q8IYJ0","PIANP" -"UniProt:P40501","AVT7" -"UniProt:Q12809","KCNH2" -"UniProt:P35583","Foxa2" -"UniProt:P51798","CLCN7" -"UniProt:Q9NRD0","FBXO8" -"UniProt:Q8IVF4","DNAH10" -"UniProt:Q15652","JHD2C" -"UniProt:Q96GY0","ZC2HC1A" -"UniProt:Q9UL41","PNMA3" -"UniProt:Q8TAD2","IL17D" -"UniProt:P41279","MAP3K8" -"UniProt:Q9NRR6","INPP5E" -"UniProt:Q3MII6","TBC1D25" -"UniProt:Q9HBU6","EKI1" -"UniProt:Q6P0N0","MIS18BP1" -"UniProt:Q9Y2R5","MRPS17" -"UniProt:P01909","HLA-DQA1" -"UniProt:Q9UHF0","TAC3" -"UniProt:P11279","LAMP1" -"UniProt:Q6QHK4","FIGLA" -"UniProt:P0C7M6","IQCF3" -"UniProt:Q400G9","AMZ1" -"UniProt:P59533","TAS2R38" -"UniProt:Q9Y463","DYRK1B" -"UniProt:Q86UK5","EVC2" -"UniProt:Q5VZ52","MORN5" -"UniProt:Q9P289","STK26" -"UniProt:Q9BVV7","TIM21" -"UniProt:P48378","RFX2" -"UniProt:Q96MX0","CKLF3" -"UniProt:Q9Y5Q3","MAFB" -"UniProt:P06197","PIS" -"UniProt:Q5HYK3","COQ5" -"UniProt:Q5JPT6","Q5JPT6" -"UniProt:P40425","PBX2" -"UniProt:P98073","TMPRSS15" -"UniProt:P29279","CTGF" -"UniProt:Q9NPC1","LTB4R2" -"UniProt:Q9Y421","FAM32A" -"UniProt:P16383","GCFC2" -"UniProt:Q03362","YD476" -"UniProt:P56715","RP1" -"UniProt:O75452","RDH16" -"UniProt:Q4G0G5","SC2B2" -"UniProt:Q9UGH3","SLC23A2" -"UniProt:A0A0C4DGN4","A0A0C4DGN4" -"UniProt:O95625","ZBTB11" -"UniProt:Q9HCJ3","RAVER2" -"UniProt:Q15691","MARE1" -"UniProt:Q9Y6G3","MRPL42" -"UniProt:P0DP58","LYNX1" -"UniProt:Q8WWY7","WFD12" -"UniProt:O60573","IF4E2" -"UniProt:Q6MX51","Q6MX51" -"UniProt:Q9WVI9","MAPK8IP1" -"UniProt:Q96GZ6","S41A3" -"UniProt:Q86SK9","SCD5" -"UniProt:Q9NS23","RASSF1" -"UniProt:O14828","SCAMP3" -"UniProt:Q9NVF7","FBX28" -"UniProt:Q7Z403","TMC6" -"UniProt:P48145","NPBW1" -"UniProt:Q99742","NPAS1" -"UniProt:O95639","CPSF4" -"UniProt:P10915","HAPLN1" -"UniProt:P14211","Calr" -"UniProt:Q1X8D7","LRRC36" -"UniProt:Q9BYQ2","KRA94" -"UniProt:P30968","GNRHR" -"UniProt:P05408","7B2" -"UniProt:Q9UBD6","RHCG" -"UniProt:Q6NX45","ZNF774" -"UniProt:P13761","HLA-DRB1" -"UniProt:P11177","PDHB" -"UniProt:O95721","SNAP29" -"UniProt:Q53GI3","ZNF394" -"UniProt:P9WMN3","GLMU" -"UniProt:Q16853","AOC3" -"UniProt:Q9H1Z8","AUGN" -"UniProt:Q6UXV4","APOOL" -"UniProt:Q9NV31","IMP3" -"UniProt:A4FU01","MTMR11" -"UniProt:Q10713","PMPCA" -"UniProt:P20810","CAST" -"UniProt:Q8IXX5","T183A" -"UniProt:Q8NBF1","GLIS1" -"UniProt:P98066","TSG6" -"UniProt:O15479","MAGB2" -"UniProt:Q8N131","PORIM" -"UniProt:P02655","APOC2" -"UniProt:Q00535","CDK5" -"UniProt:P30040","ERP29" -"UniProt:Q9NZG7","NINJ2" -"UniProt:O75431","MTX2" -"UniProt:P57679","EVC" -"UniProt:Q6UWI2","PARM1" -"UniProt:Q5TA82","LCE2D" -"UniProt:Q9NYW0","TAS2R10" -"UniProt:Q5GAN6","RNS10" -"UniProt:O15118","NPC1" -"UniProt:Q4VC31","CCDC58" -"UniProt:A6NK58","LIPT2" -"UniProt:J3KQ25","J3KQ25" -"UniProt:O60224","SSX4B" -"UniProt:Q6UWE3","COLL2" -"UniProt:Q9NR12","PDLIM7" -"UniProt:Q6GMR7","FAAH2" -"UniProt:P0CH99","ZNF705D" -"UniProt:P54843","MAF" -"UniProt:P53730","ALG12" -"UniProt:Q8WVF1","OSCP1" -"UniProt:Q14112","NID2" -"UniProt:Q0P641","C2orf80" -"UniProt:Q8NBU5","ATAD1" -"UniProt:O43506","ADAM20" -"UniProt:A0A087WTJ2","A0A087WTJ2" -"UniProt:A6NDP7","MYADML2" -"UniProt:P05067","APP" -"UniProt:Q9Y337","KLK5" -"UniProt:P03228","BARF1" -"UniProt:O00505","IMA4" -"UniProt:Q92729","PTPRU" -"UniProt:Q02817","MUC2" -"UniProt:O00308","WWP2" -"UniProt:Q9ULI4","KIF26A" -"UniProt:Q9URQ5","HTL1" -"UniProt:Q15063","POSTN" -"UniProt:A8K855","EFCAB7" -"UniProt:Q9HAW0","BRF2" -"UniProt:O95214","LERL1" -"UniProt:Q15417","CNN3" -"UniProt:Q96IW7","SC22A" -"UniProt:P35227","PCGF2" -"UniProt:Q9ULD0","OGDHL" -"UniProt:A8MUZ8","ZNF705G" -"UniProt:Q14651","PLS1" -"UniProt:Q14153","FAM53B" -"UniProt:Q6NXP6","NOXRED1" -"UniProt:Q6P1R3","MSANTD2" -"UniProt:Q9HCJ0","TNRC6C" -"UniProt:P28074","PSB5" -"UniProt:P38265","IML3" -"UniProt:Q6ZVU3","Q6ZVU3" -"UniProt:Q0VAL7","Q0VAL7" -"UniProt:Q9NUB1","ACS2L" -"UniProt:Q5SQI0","ATAT1" -"UniProt:Q5D1E8","ZC12A" -"UniProt:P28065","PSMB9" -"UniProt:Q9UI30","TRMT112" -"UniProt:Q9HA82","CERS4" -"UniProt:Q8NFP7","NUD10" -"UniProt:P00588","Diphtheria" -"UniProt:Q9HCN4","GPN1" -"UniProt:Q9Y296","TPPC4" -"UniProt:Q9H0I2","ENKD1" -"UniProt:P57773","GJA9" -"UniProt:H0YKB7","H0YKB7" -"UniProt:Q9Y2T6","GPR55" -"UniProt:Q6PJT7","ZC3H14" -"UniProt:Q2KHM9","KIAA0753" -"UniProt:O43286","B4GALT5" -"UniProt:Q8N100","ATOH7" -"UniProt:Q9GZZ9","UBA5" -"UniProt:Q96MC5","CP045" -"UniProt:P0CAP2","POLR2M" -"UniProt:Q96Q05","TRAPPC9" -"UniProt:O43776","NARS" -"UniProt:Q8WXS5","CACNG8" -"UniProt:Q96EY1","DNJA3" -"UniProt:P62745","RHOB" -"UniProt:Q460N3","PARP15" -"UniProt:P61247","RS3A" -"UniProt:Q9BT76","UPK3B" -"UniProt:Q8NGK1","OR51G1" -"UniProt:Q96G01","BICD1" -"UniProt:P19551","env" -"UniProt:P01275","GCG" -"UniProt:P54852","EMP3" -"UniProt:Q8IXH6","TP53INP2" -"UniProt:Q96QF0","RAB3I" -"UniProt:Q96LB3","IFT74" -"UniProt:Q6UXU6","TMEM92" -"UniProt:Q96JA3","PLEKHA8" -"UniProt:Q9NVE4","CCD87" -"UniProt:Q9H8X9","ZDHHC11" -"UniProt:Q8N423","LILRB2" -"UniProt:Q17RH5","Q17RH5" -"UniProt:Q8NFI3","ENGASE" -"UniProt:Q8NGE3","OR10P1" -"UniProt:P51813","BMX" -"UniProt:Q9P2X3","IMPACT" -"UniProt:Q3KPI0","CEACAM21" -"UniProt:Q9UKF6","CPSF3" -"UniProt:D6RBQ6","USP17L17" -"UniProt:Q15633","TARBP2" -"UniProt:Q96S16","JMJD8" -"UniProt:Q8NGI0","OR52N2" -"UniProt:Q8NE00","TMEM104" -"UniProt:P30041","PRDX6" -"UniProt:P29311","BMH1" -"UniProt:Q9NYB9","ABI2" -"UniProt:P00330","ADH1" -"UniProt:Q62884","Q62884" -"UniProt:P47890","OR1G1" -"UniProt:Q9ULJ3","ZBT21" -"UniProt:P38571","LIPA" -"UniProt:Q569K4","ZNF385B" -"UniProt:Q99816","TS101" -"UniProt:Q8N143","BCL6B" -"UniProt:Q8NEP3","DNAAF1" -"UniProt:Q86WR0","CCDC25" -"UniProt:Q96A98","PTH2" -"UniProt:Q9NW97","TMEM51" -"UniProt:Q6ZRF8","RNF207" -"UniProt:Q86V86","PIM3" -"UniProt:P25962","ADRB3" -"UniProt:P40222","TXLNA" -"UniProt:P50406","HTR6" -"UniProt:Q6P9E2","Q6P9E2" -"UniProt:A4QPB0","A4QPB0" -"UniProt:Q6UXK5","LRRN1" -"UniProt:Q3I5F7","ACOT6" -"UniProt:Q9H9A5","CNOT10" -"UniProt:O14603","PRY2" -"UniProt:Q96P63","SERPINB12" -"UniProt:Q6UXG8","BTNL9" -"UniProt:Q8NGZ0","OR2AJ1" -"UniProt:O43189","PHF1" -"UniProt:P49848","TAF6" -"UniProt:A6NDH6","OR5H15" -"UniProt:Q9H1H1","GTSF1L" -"UniProt:Q8NGS2","OR1J2" -"UniProt:P22736","NR4A1" -"UniProt:Q8IYA8","IHO1" -"UniProt:Q96SQ9","CYP2S1" -"UniProt:Q75N90","FBN3" -"UniProt:P49419","ALDH7A1" -"UniProt:Q5T0J7","TEX35" -"UniProt:Q8WYQ4","C22orf15" -"UniProt:P04000","OPN1LW" -"UniProt:Q969X5","ERGIC1" -"UniProt:Q8TF21","ANKRD24" -"UniProt:P51172","SCNN1D" -"UniProt:Q13753","LAMC2" -"UniProt:Q9NZ81","PRR13" -"UniProt:Q96DB9","FXYD5" -"UniProt:P25106","ACKR3" -"UniProt:Q96GD4","AURKB" -"UniProt:Q8TBF5","PIGX" -"UniProt:P48553","TPC10" -"UniProt:P15882","CHN1" -"UniProt:Q9Y6Q6","TNFRSF11A" -"UniProt:Q96RQ9","IL4I1" -"UniProt:Q9P2E2","KIF17" -"UniProt:Q8IZ40","RCOR2" -"UniProt:Q14990","ODFP1" -"UniProt:Q29974","HLA-DRB1" -"UniProt:Q96GE6","CALML4" -"UniProt:P14174","MIF" -"UniProt:O95674","CDS2" -"UniProt:P42658","DPP6" -"UniProt:Q969F0","FATE1" -"UniProt:Q8WV19","SFT2A" -"UniProt:Q9H175","CSRNP2" -"UniProt:B0I1T2","MYO1G" -"UniProt:Q8NBR0","TP53I13" -"UniProt:Q9H7Z3","NRDE2" -"UniProt:A8MUK1","USP17L5" -"UniProt:Q9UBV7","B4GALT7" -"UniProt:Q6PCT2","FBXL19" -"UniProt:O75038","PLCH2" -"UniProt:Q8IZY5","BLID" -"UniProt:Q9UH92","MLX" -"UniProt:O95793","STAU1" -"UniProt:P31941","APOBEC3A" -"UniProt:Q96HR8","NAF1" -"UniProt:Q9BPX7","C7orf25" -"UniProt:O75439","PMPCB" -"UniProt:P0C7M7","ACSM4" -"UniProt:Q9Y458","TBX22" -"UniProt:Q14627","IL13RA2" -"UniProt:Q13433","SLC39A6" -"UniProt:Q9NRJ4","TULP4" -"UniProt:P19823","ITIH2" -"UniProt:Q9NSA1","FGF21" -"UniProt:Q86VS8","HOOK3" -"UniProt:Q6N063","OGFOD2" -"UniProt:O95777","LSM8" -"UniProt:Q969J5","IL22RA2" -"UniProt:Q6MZP7","LIN54" -"UniProt:P11230","CHRNB1" -"UniProt:P61758","PFD3" -"UniProt:O60884","DNAJA2" -"UniProt:Q9UHL4","DPP7" -"UniProt:Q5RGS3","F74A1" -"UniProt:Q674X7","KAZN" -"UniProt:Q7Z4W1","DCXR" -"UniProt:Q8N6F8","WBS27" -"UniProt:O15374","SLC16A4" -"UniProt:Q96JM4","LRRIQ1" -"UniProt:Q08460","KCMA1" -"UniProt:Q9MY60","HLS-B60" -"UniProt:Q9H1P6","CT085" -"UniProt:Q9BWU0","NADAP" -"UniProt:Q5VV63","ATRNL1" -"UniProt:P18283","GPX2" -"UniProt:Q5VVW2","GARNL3" -"UniProt:Q96H20","SNF8" -"UniProt:P23229","ITGA6" -"UniProt:P20929","NEB" -"UniProt:Q32NC0","C18orf21" -"UniProt:Q9ULA0","DNPEP" -"UniProt:P52179","MYOM1" -"UniProt:Q7Z6J2","GRASP" -"UniProt:Q9NS87","KIF15" -"UniProt:Q9H0W9","C11ORF54" -"UniProt:P33991","MCM4" -"UniProt:Q9NR19","ACSS2" -"UniProt:Q15125","EBP" -"UniProt:A2RUH7","MYBPHL" -"UniProt:Q8TCY9","URGCP" -"UniProt:Q8IWW8","ADHFE1" -"UniProt:Q8IYB1","M21D2" -"UniProt:P00390","GSR" -"UniProt:P23771","GATA3" -"UniProt:Q9H4Z3","PCIF1" -"UniProt:P51690","ARSE" -"UniProt:Q16549","PCSK7" -"UniProt:Q02750","MAP2K1" -"UniProt:P09228","CST2" -"UniProt:O75717","WDHD1" -"UniProt:P01825","IGHV4-59" -"UniProt:Q96BS2","TESC" -"UniProt:Q92546","RGP1" -"UniProt:Q8N729","NPW" -"UniProt:P24666","ACP1" -"UniProt:Q7Z695","ADCK2" -"UniProt:Q6B0K9","HBM" -"UniProt:Q9BXL6","CARD14" -"UniProt:Q8NE86","MCU" -"UniProt:P16150","LEUK" -"UniProt:P04001","OPN1MW2;LOC107984055;OPN1MW;OPN1MW3" -"UniProt:P61163","ACTR1A" -"UniProt:Q9BY43","CHMP4A" -"UniProt:Q9NPB6","PAR6A" -"UniProt:A0A087X169","A0A087X169" -"UniProt:Q8NC24","RELL2" -"UniProt:Q96JH7","VCPIP1" -"UniProt:Q99732","LITAF" -"UniProt:P17473","ICP4" -"UniProt:Q5VTL8","PR38B" -"UniProt:P16144","ITGB4" -"UniProt:Q9Y230","RUVB2" -"UniProt:P48146","NPBW2" -"UniProt:Q9NW75","GPATCH2" -"UniProt:O15245","SLC22A1" -"UniProt:O15389","SIGL5" -"UniProt:P02008","HBAZ" -"UniProt:Q7M4L6","SHF" -"UniProt:P15104","GLUL" -"UniProt:P31249","HXD3" -"UniProt:Q7Z3B4","NUP54" -"UniProt:Q9NPA1","KCNMB3" -"UniProt:Q15375","EPHA7" -"UniProt:P09466","PAEP" -"UniProt:Q5BJF2","TMM97" -"UniProt:Q9BQ66","KR412" -"UniProt:Q92738","USP6NL" -"UniProt:Q6NT76","HMBX1" -"UniProt:Q9GZN7","ROGDI" -"UniProt:Q9H4P4","RNF41" -"UniProt:Q9H0H5","RACGAP1" -"UniProt:Q16787","LAMA3" -"UniProt:Q9UI43","MRM2" -"UniProt:P24386","CHM" -"UniProt:P17039","ZNF30" -"UniProt:P46682","AP3B" -"UniProt:Q7Z7L9","ZSCAN2" -"UniProt:Q96I51","RCC1L" -"UniProt:Q96M20","CNBD2" -"UniProt:Q9Y295","DRG1" -"UniProt:P97333","Nrp1" -"UniProt:Q9NPG4","PCDH12" -"UniProt:O35658","C1QBP" -"UniProt:Q9BR01","ST4A1" -"UniProt:Q8IW00","VSTM4" -"UniProt:P53985","SLC16A1" -"UniProt:Q15040","JOS1" -"UniProt:Q8WUH1","CHURC1" -"UniProt:Q12893","TMEM115" -"UniProt:Q8IYD9","LAS2" -"UniProt:Q8WYJ6","SEPT1" -"UniProt:Q8N0Z6","TTC5" -"UniProt:P0DN78","OPN1MW" -"UniProt:Q9H1C0","LPAR5" -"UniProt:E7EMZ9","E7EMZ9" -"UniProt:Q7Z4G1","COMMD6" -"UniProt:Q9UBQ6","EXTL2" -"UniProt:Q96R06","SPAG5" -"UniProt:Q8WVR3","CG043" -"UniProt:B2RA10","B2RA10" -"UniProt:Q969P0","IGSF8" -"UniProt:Q9BXU7","USP26" -"UniProt:Q9NRP2","CMC2" -"UniProt:Q9NS40","KCNH7" -"UniProt:Q01851","POU4F1" -"UniProt:Q13901","C1D" -"UniProt:Q15937","ZNF79" -"UniProt:Q6ZV56","C22ORF34" -"UniProt:Q5T4I8","C6orf52" -"UniProt:Q9BY76","ANGPTL4" -"UniProt:Q99500","S1PR3" -"UniProt:P41160","Lep" -"UniProt:Q96EB1","ELP4" -"UniProt:Q96E93","KLRG1" -"UniProt:Q9C002","C15orf48" -"UniProt:O00560","SDCBP" -"UniProt:P50226","SULT1A2" -"UniProt:P49335","POU3F4" -"UniProt:P59534","TAS2R39" -"UniProt:Q9H9S4","CAB39L" -"UniProt:Q8N393","ZN786" -"UniProt:P22735","TGM1" -"UniProt:P56377","AP1S2" -"UniProt:P78426","NKX6-1" -"UniProt:Q7Z479","Q7Z479" -"UniProt:Q8NHS9","SPT22" -"UniProt:Q13956","PDE6H" -"UniProt:P35250","RFC2" -"UniProt:Q9UBJ2","ABCD2" -"UniProt:Q8N103","TAGAP" -"UniProt:O94762","RECQL5" -"UniProt:Q29963","HLA-C" -"UniProt:O14836","TNFRSF13B" -"UniProt:Q5H9S7","DCAF17" -"UniProt:Q6ZUT1","CK057" -"UniProt:P36894","BMPR1A" -"UniProt:P54840","GYS2" -"UniProt:Q17R88","SORCS3" -"UniProt:O60220","TIMM8A" -"UniProt:Q8NA82","MARCH10" -"UniProt:Q9BRJ7","NUDT16L1" -"UniProt:Q6ZMQ8","AATK" -"UniProt:Q15813","TBCE" -"UniProt:Q8NE01","CNNM3" -"UniProt:P50052","AGTR2" -"UniProt:Q16720","ATP2B3" -"UniProt:Q9Y5Y2","NUBP2" -"UniProt:Q4KMZ8","NKAIN1" -"UniProt:Q9UHC6","CNTNAP2" -"UniProt:P08133","ANXA6" -"UniProt:Q96K31","C8orf76" -"UniProt:Q24JQ0","TMEM241" -"UniProt:P05187","PPB1" -"UniProt:P25515","VATL1" -"UniProt:P98172","EFNB1" -"UniProt:Q01105","SET" -"UniProt:P19013","K2C4" -"UniProt:Q6UWW0","LCN15" -"UniProt:Q86T23","CROL1" -"UniProt:Q96MM7","HS6ST2" -"UniProt:Q9UIU0","CACNA2D1" -"UniProt:Q9BYQ9","KRTAP4-8" -"UniProt:P82650","MRPS22" -"UniProt:Q9BVC5","C2orf49" -"UniProt:P98182","ZNF200" -"UniProt:Q8TAB7","CCD26" -"UniProt:P58304","VSX2" -"UniProt:B2R4U6","B2R4U6" -"UniProt:Q6ZU64","CFAP65" -"UniProt:Q6EMK4","VASN" -"UniProt:Q7Z417","NUFP2" -"UniProt:P31751","AKT2" -"UniProt:Q96DR7","ARHGEF26" -"UniProt:O60344","ECE2" -"UniProt:P59796","GPX6" -"UniProt:Q92692","NECTIN2" -"UniProt:Q9Y388","RBMX2" -"UniProt:Q08722","CD47" -"UniProt:P18583","SON" -"UniProt:Q9NQ32","C11orf16" -"UniProt:Q96D59","RNF183" -"UniProt:O60403","OR10H2" -"UniProt:Q96DC7","TMCO6" -"UniProt:Q08477","CYP4F3" -"UniProt:Q5T447","HECTD3" -"UniProt:Q8TE23","TAS1R2" -"UniProt:Q2VWA4","SKOR2" -"UniProt:P62991","UBIQ" -"UniProt:Q5T7P3","LCE1B" -"UniProt:Q8N0X2","SPAG16" -"UniProt:Q9NVS9","PNPO" -"UniProt:Q687X5","STEAP4" -"UniProt:Q7Z422","SZRD1" -"UniProt:Q03426","MVK" -"UniProt:Q8NFD5","ARID1B" -"UniProt:Q12792","TWF1" -"UniProt:P05186","ALPL" -"UniProt:P04201","MAS1" -"UniProt:Q16611","BAK" -"UniProt:Q9NRC6","SPTBN5" -"UniProt:Q9NRR5","UBQL4" -"UniProt:Q13596","SNX1" -"UniProt:P53007","SLC25A1" -"UniProt:D2IYK5","D2IYK5" -"UniProt:P10643","C7" -"UniProt:P35212","CXA4" -"UniProt:A1L4E9","A1L4E9" -"UniProt:Q14202","ZMYM3" -"UniProt:Q6YHK3","CD109" -"UniProt:Q9UHN1","POLG2" -"UniProt:Q9Y5Z0","BACE2" -"UniProt:P47133","EMC2" -"UniProt:Q9BQY9","DBNDD2" -"UniProt:Q9H825","METTL8" -"UniProt:Q92838","EDA" -"UniProt:Q5T9L3","WLS" -"UniProt:A6NDV4","TMEM8B" -"UniProt:P0C7T3","OR56A5" -"UniProt:P07942","LAMB1" -"UniProt:Q96MN9","ZNF488" -"UniProt:Q9BU64","CENPO" -"UniProt:O60341","KDM1A" -"UniProt:Q8IYM9","TRIM22" -"UniProt:Q8IUR5","TMTC1" -"UniProt:Q8IX04","UEVLD" -"UniProt:O14990","PPP1R2P9" -"UniProt:Q96K17","BT3L4" -"UniProt:Q6UW63","KDELC1" -"UniProt:P06340","HLA-DOA" -"UniProt:Q9BXJ7","AMN" -"UniProt:Q96QD8","S38A2" -"UniProt:P30622","CLIP1" -"UniProt:P09022","HXA1" -"UniProt:P15259","PGAM2" -"UniProt:Q8N4F4","SLC22A24" -"UniProt:P55040","GEM" -"UniProt:B6A8C7","TARM1" -"UniProt:G3V1X1","G3V1X1" -"UniProt:Q9BSA4","TTYH2" -"UniProt:O60739","EIF1B" -"UniProt:Q8WYR1","PIK3R5" -"UniProt:Q9Y3E2","BOLA1" -"UniProt:P09525","ANXA4" -"UniProt:Q7Z7A1","CNTRL" -"UniProt:P39518","LCF2" -"UniProt:Q969H6","POP5" -"UniProt:Q7Z7A3","CTU1" -"UniProt:Q6P0Q8","MAST2" -"UniProt:P54753","EPHB3" -"UniProt:Q02241","KIF23" -"UniProt:Q92833","JARID2" -"UniProt:O94864","SUPT7L" -"UniProt:Q8NCY6","MSD4" -"UniProt:Q12788","TBL3" -"UniProt:O43687","AKAP7" -"UniProt:Q14761","PTCA" -"UniProt:P16118","F261" -"UniProt:P03971","AMH" -"UniProt:Q06203","PPAT" -"UniProt:Q9UFB7","ZBTB47" -"UniProt:B2RTY4","MYO9A" -"UniProt:P31275","HOXC12" -"UniProt:Q5JVG2","ZNF484" -"UniProt:Q9UKJ0","PILRB" -"UniProt:P51398","DAP3" -"UniProt:Q58A45","PAN3" -"UniProt:Q02724","ULP1" -"UniProt:Q9UPT5","EXOC7" -"UniProt:Q9Y679","AUP1" -"UniProt:P09417","QDPR" -"UniProt:O60942","MCE1" -"UniProt:Q07627","KRA11" -"UniProt:Q9HBI0","PARVG" -"UniProt:Q96EX3","WDR34" -"UniProt:Q9Y5Q0","FADS3" -"UniProt:Q9UGJ1","TUBGCP4" -"UniProt:Q8N9K5","ZNF565" -"UniProt:Q9BRQ3","NUDT22" -"UniProt:P57059","SIK1B;SIK1" -"UniProt:P49771","FLT3LG" -"UniProt:Q96LZ2","MAGBA" -"UniProt:Q8N9H8","EXD3" -"UniProt:B2RAB7","B2RAB7" -"UniProt:P12814","ACTN1" -"UniProt:P16870","CPE" -"UniProt:Q96DE5","ANAPC16" -"UniProt:Q9P265","DIP2B" -"UniProt:P01258","CALCA" -"UniProt:P21980","TGM2" -"UniProt:Q582G4","ANM7" -"UniProt:Q8N5Z3","Q8N5Z3" -"UniProt:Q96NW4","ANKRD27" -"UniProt:Q9BQF6","SENP7" -"UniProt:A0FGR9","ESYT3" -"UniProt:Q9NZ71","RTEL1" -"UniProt:Q14201","BTG3" -"UniProt:P0C5Z0","H2AFB2" -"UniProt:Q13183","SLC13A2" -"UniProt:Q6UX07","DHRS13" -"UniProt:Q8TC92","ENOX1" -"UniProt:Q6ZMV7","LEKR1" -"UniProt:Q9UKY7","CDV3" -"UniProt:O60711","LPXN" -"UniProt:Q09160","HLA-A" -"UniProt:P24462","CYP3A7" -"UniProt:Q8TD20","SLC2A12" -"UniProt:Q9NZ32","ACTR10" -"UniProt:Q9HB19","PLEKHA2" -"UniProt:Q6ICM0","Q6ICM0" -"UniProt:O14633","LCE2B" -"UniProt:Q9P0M2","AKAP7" -"UniProt:B0B1U2","B0B1U2" -"UniProt:Q9BQ70","TCF25" -"UniProt:Q8TF50","ZN526" -"UniProt:P11678","EPX" -"UniProt:Q9BRB3","PIGQ" -"UniProt:Q969L4","LSM10" -"UniProt:O75494","SRS10" -"UniProt:Q86YD7","F90A1" -"UniProt:Q03393","PTS" -"UniProt:O60832","DKC1" -"UniProt:O15090","ZNF536" -"UniProt:P78325","ADAM8" -"UniProt:Q5T6S3","PHF19" -"UniProt:A0A0S2Z4Q4","A0A0S2Z4Q4" -"UniProt:Q53GL0","PLEKHO1" -"UniProt:P07316","CRYGB" -"UniProt:Q15345","LRRC41" -"UniProt:P07339","CTSD" -"UniProt:Q6IQ55","TTBK2" -"UniProt:Q5T1A1","DCST2" -"UniProt:P35558","PCK1" -"UniProt:P40933","IL15" -"UniProt:Q9NSC7","ST6GALNAC1" -"UniProt:A2RTX5","SYTC2" -"UniProt:P49789","FHIT" -"UniProt:Q6Y288","B3GLCT" -"UniProt:Q16849","PTPRN" -"UniProt:Q5TCY1","TTBK1" -"UniProt:Q9NWX5","ASB6" -"UniProt:P10686","Plcg1" -"UniProt:Q9Y255","PRELID1" -"UniProt:Q16671","AMHR2" -"UniProt:Q15269","PWP2" -"UniProt:Q9D666","SUN1" -"UniProt:Q6PGB6","NAA50" -"UniProt:O75521","ECI2" -"UniProt:Q92772","CDKL2" -"UniProt:P40429","RL13A" -"UniProt:Q9P000","COMD9" -"UniProt:A1L162","ERIC2" -"UniProt:Q9ULM3","YEATS2" -"UniProt:Q9H816","DCLRE1B" -"UniProt:P00915","CA1" -"UniProt:Q14159","SPIDR" -"UniProt:Q86X67","NUDT13" -"UniProt:P30305","MPIP2" -"UniProt:P48507","GCLM" -"UniProt:Q96K49","TMEM87B" -"UniProt:P10323","ACR" -"UniProt:Q9BWG6","SCNM1" -"UniProt:P48645","NMU" -"UniProt:O60664","PLIN3" -"UniProt:Q9NWS6","F118A" -"UniProt:Q96N19","GPR137" -"UniProt:Q86T65","DAAM2" -"UniProt:Q9H3R2","MUC13" -"UniProt:Q9BY44","EIF2A" -"UniProt:A2RU00","A2RU00" -"UniProt:Q14257","RCN2" -"UniProt:P03508","NS" -"UniProt:P30559","OXTR" -"UniProt:Q9BTK6","PAGR1" -"UniProt:P17035","ZNF28" -"UniProt:Q60631","Grb2" -"UniProt:Q9UGU5","HMGXB4" -"UniProt:Q6IPT4","CYB5RL" -"UniProt:D3JIB2","D3JIB2" -"UniProt:Q8WUX1","SLC38A5" -"UniProt:O95382","M3K6" -"UniProt:Q9UNG2","TNFSF18" -"UniProt:Q0VAA5","PLCXD2" -"UniProt:Q7Z4N2","TRPM1" -"UniProt:O00358","FOXE1" -"UniProt:Q8WZA9","IRGQ" -"UniProt:Q8N9E0","FAM133A" -"UniProt:Q14258","TRI25" -"UniProt:O75340","PDCD6" -"UniProt:P81534","DEFB103B" -"UniProt:Q13316","DMP1" -"UniProt:Q6UWV6","ENPP7" -"UniProt:O15540","FABP7" -"UniProt:A2APF7","A2APF7" -"UniProt:P03203","EBNA4" -"UniProt:P56750","CLDN17" -"UniProt:Q5THR3","EFCAB6" -"UniProt:P27037","ACVR2A" -"UniProt:Q9UPT8","ZC3H4" -"UniProt:Q6NT32","CES5A" -"UniProt:Q6ZTQ4","CDHR3" -"UniProt:Q9NVM4","PRMT7" -"UniProt:A6NDX5","ZNF840P" -"UniProt:P26450","Pik3r1" -"UniProt:Q6IAV4","Q6IAV4" -"UniProt:P10193","OBP" -"UniProt:Q16739","UGCG" -"UniProt:Q8N6I1","EID2" -"UniProt:O15056","SYNJ2" -"UniProt:Q96BN2","TADA1" -"UniProt:Q99567","NUP88" -"UniProt:A6NHJ4","ZNF860" -"UniProt:P41219","PERI" -"UniProt:Q8NHH1","TTLL11" -"UniProt:P59923","ZNF445" -"UniProt:A8K8P3","SFI1" -"UniProt:Q4FZC9","SYNE3" -"UniProt:O14732","IMPA2" -"UniProt:P54793","ARSF" -"UniProt:Q8N4T8","CBR4" -"UniProt:Q9NUV9","GIMAP4" -"UniProt:Q52LJ0","FAM98B" -"UniProt:Q9HD36","B2L10" -"UniProt:F1BA49","F1BA49" -"UniProt:Q00961","NMDE3" -"UniProt:O95922","TTLL1" -"UniProt:P15088","CPA3" -"UniProt:A6PVC2","TTLL8" -"UniProt:O15354","GPR37" -"UniProt:Q04727","TLE4" -"UniProt:P31421","GRM2" -"UniProt:O15399","GRIN2D" -"UniProt:Q99879","HIST1H2BM" -"UniProt:Q9ULZ9","MMP17" -"UniProt:P16422","EPCAM" -"UniProt:Q96BF3","TMIGD2" -"UniProt:O75603","GCM2" -"UniProt:P61328","FGF12" -"UniProt:Q5TEA6","SEL1L2" -"UniProt:Q9BXA9","SALL3" -"UniProt:Q00059","TFAM" -"UniProt:P46939","UTRN" -"UniProt:O75964","ATP5L" -"UniProt:O75146","HIP1R" -"UniProt:O75900","MMP23B" -"UniProt:P48444","ARCN1" -"UniProt:O76064","RNF8" -"UniProt:Q8N2C3","DEPDC4" -"UniProt:Q6ZN18","AEBP2" -"UniProt:Q92485","SMPDL3B" -"UniProt:Q86XP3","DDX42" -"UniProt:O60502","MGEA5" -"UniProt:Q5HYJ3","FAM76B" -"UniProt:P18505","GABRB1" -"UniProt:P12643","BMP2" -"UniProt:Q96PC2","IP6K3" -"UniProt:Q16576","RBBP7" -"UniProt:Q9BPY8","HOP" -"UniProt:Q9WTR2","M3K6" -"UniProt:O14786","NRP1" -"UniProt:O14843","FFAR3" -"UniProt:Q96EG1","ARSG" -"UniProt:Q92484","SMPDL3A" -"UniProt:Q00169","PITPNA" -"UniProt:Q8N0W5","IQCK" -"UniProt:Q6NSJ2","PHLDB3" -"UniProt:P02562","MYSS" -"UniProt:P0CF74","IGLC6" -"UniProt:Q9H891","Q9H891" -"UniProt:P11233","RALA" -"UniProt:P34932","HSPA4" -"OMIM:141750","ALPHA-THALASSEMIA/MENTAL RETARDATION SYNDROME, CHROMOSOME 16-RELATED" -"OMIM:136900","SORSBY FUNDUS DYSTROPHY; SFD" -"DOID:5716","hormone producing pituitary cancer" -"DOID:2433","epidermal appendage tumor" -"DOID:2438","dermis tumor" -"DOID:664","angiokeratoma of Fordyce" -"OMIM:141700","HEMOLYTIC POIKILOCYTIC ANEMIA DUE TO REDUCED ANKYRIN BINDING SITES" -"OMIM:110800","BLOOD GROUP, I SYSTEM; Ii" -"DOID:0050889","non-syndromic intellectual disability" -"DOID:0090088","hypogonadotropic hypogonadism 24 without anosmia" -"OMIM:111200","BLOOD GROUP--LUTHERAN SYSTEM; LU" -"DOID:3145","hyperlipoproteinemia type III" -"DOID:8006","skin meningioma" -"OMIM:141000","HEMANGIOMA-THROMBOCYTOPENIA SYNDROME" -"OMIM:136760","FRONTONASAL DYSPLASIA 1; FND1" -"DOID:10188","skin lipoma" -"OMIM:137130","GASTRIC SNEEZING" -"OMIM:110900","BLOOD GROUP--KELL SYSTEM; KEL" -"DOID:3818","photoallergic dermatitis" -"DOID:2411","granular cell tumor" -"DOID:0080192","relapsed/refractory diffuse large B-cell lymphoma" -"OMIM:136830","FUCOSIDASE REGULATOR" -"DOID:0050339","commensal bacterial infectious disease" -"DOID:9042","polyp of corpus uteri" -"OMIM:111000","BLOOD GROUP--KIDD SYSTEM; JK" -"DOID:2425","cutaneous ganglioneuroma" -"DOID:10534","stomach cancer" -"OMIM:141500","MIGRAINE, FAMILIAL HEMIPLEGIC, 1; FHM1" -"DOID:4683","cutaneous mucoepidermoid carcinoma" -"DOID:8969","tonsillar fossa cancer" -"DOID:2789","parasitic protozoa infectious disease" -"DOID:1171","hyperlipoproteinemia type V" -"OMIM:141749","FETAL HEMOGLOBIN QUANTITATIVE TRAIT LOCUS 1; HBFQTL1" -"DOID:0060679","catecholaminergic polymorphic ventricular tachycardia 5" -"DOID:997","uterine inversion" -"DOID:121","vaginal disease" -"OMIM:141350","HEMIFACIAL HYPERPLASIA WITH STRABISMUS" -"DOID:7518","inhibited female orgasm" -"DOID:14250","Down syndrome" -"OMIM:140850","HEMANGIOMAS, CAVERNOUS, OF FACE AND SUPRAUMBILICAL MIDLINE RAPHE" -"DOID:851","Bartholin's duct cyst" -"DOID:0110387","retinitis pigmentosa 9" -"DOID:3674","kidney rhabdoid cancer" -"DOID:471","skin hemangioma" -"OMIM:141300","HEMIFACIAL ATROPHY, PROGRESSIVE; HFA" -"DOID:1251","tuberculous epididymitis" -"OMIM:137100","IMMUNOGLOBULIN A DEFICIENCY 1; IGAD1" -"DOID:4073","pancreatic cystadenocarcinoma" -"DOID:0060074","ductal carcinoma in situ" -"OMIM:613032","GLIOMA SUSCEPTIBILITY 7; GLM7" -"OMIM:616969","DEAFNESS, AUTOSOMAL DOMINANT 66; DFNA66" -"DOID:4557","oral leukoedema" -"OMIM:616973","MENTAL RETARDATION, AUTOSOMAL DOMINANT 42; MRD42" -"DOID:0110392","retinitis pigmentosa 70" -"OMIM:613033","GLIOMA SUSCEPTIBILITY 8; GLM8" -"DOID:2782","rectosigmoid junction cancer" -"OMIM:613035","HEARING LOSS, NOISE-INDUCED, SUSCEPTIBILITY TO; NIHL" -"OMIM:616974","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 30; COXPD30" -"DOID:4331","burning mouth syndrome" -"DOID:0111047","platelet-type bleeding disorder 14" -"DOID:2855","hyperthyroxinemia" -"OMIM:613038","PITUITARY HORMONE DEFICIENCY, COMBINED, 1; CPHD1" -"OMIM:616975","NEURODEVELOPMENTAL DISORDER WITH OR WITHOUT ANOMALIES OF THE BRAIN, EYE, OR HEART; NEDBEH" -"OMIM:613055","ATRIAL FIBRILLATION, FAMILIAL, 8; ATFB8" -"OMIM:616977","MENTAL RETARDATION, AUTOSOMAL DOMINANT 43; MRD43" -"DOID:1091","tooth disease" -"DOID:0080000","muscular disease" -"OMIM:616981","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 37; EIEE37" -"OMIM:613058","BASAL CELL CARCINOMA, SUSCEPTIBILITY TO, 2; BCC2" -"DOID:688","embryonal cancer" -"DOID:0110359","retinitis pigmentosa 67" -"OMIM:613059","BASAL CELL CARCINOMA, SUSCEPTIBILITY TO, 3; BCC3" -"OMIM:617004","POLYCYSTIC LIVER DISEASE 2; PCLD2" -"OMIM:613060","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 10; EIG10" -"DOID:12711","black piedra" -"DOID:0080179","haemophilus meningitis" -"OMIM:617006","AUTOIMMUNE DISEASE, MULTISYSTEM, INFANTILE-ONSET, 2; ADMIO2" -"OMIM:613061","BASAL CELL CARCINOMA, SUSCEPTIBILITY TO, 4; BCC4" -"OMIM:617008","CEREBRAL PALSY, SPASTIC QUADRIPLEGIC, 3; CPSQ3" -"DOID:5704","sclerosing liposarcoma" -"OMIM:617011","MACROCEPHALY, DYSMORPHIC FACIES, AND PSYCHOMOTOR RETARDATION; MDFPMR" -"OMIM:166700","BUSCHKE-OLLENDORFF SYNDROME; BOS" -"DOID:9809","hypersensitivity vasculitis" -"OMIM:613062","BASAL CELL CARCINOMA, SUSCEPTIBILITY TO, 5; BCC5" -"OMIM:613063","BASAL CELL CARCINOMA, SUSCEPTIBILITY TO, 6; BCC6" -"OMIM:617013","HYPERMANGANESEMIA WITH DYSTONIA 2; HMNDYT2" -"OMIM:617014","NEUTROPENIA, SEVERE CONGENITAL, 7, AUTOSOMAL RECESSIVE; SCN7" -"OMIM:613064","DERMATITIS, ATOPIC, 7; ATOD7" -"DOID:10944","tongue disease" -"DOID:11809","bladder neck cancer" -"OMIM:613065","LEUKEMIA, ACUTE LYMPHOBLASTIC; ALL" -"OMIM:617017","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2T; CMT2T" -"DOID:0110416","retinitis pigmentosa 24" -"DOID:3108","ascaridiasis" -"OMIM:617018","SPINOCEREBELLAR ATAXIA 43; SCA43" -"DOID:1725","peritoneum cancer" -"DOID:6543","acne" -"OMIM:613067","LEUKEMIA, ACUTE LYMPHOBLASTIC, SUSCEPTIBILITY TO, 2; ALL2" -"OMIM:617020","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 38; EIEE38" -"OMIM:613068","NEURODEGENERATION DUE TO CEREBRAL FOLATE TRANSPORT DEFICIENCY" -"DOID:10223","dermatomyositis" -"DOID:12424","thyrocalcitonin secretion disease" -"DOID:4007","bladder carcinoma" -"OMIM:613070","LIVER FAILURE, INFANTILE, TRANSIENT; LFIT" -"OMIM:617021","HYDROPS, LACTIC ACIDOSIS, AND SIDEROBLASTIC ANEMIA; HLASA" -"OMIM:166780","OTOFACIOCERVICAL SYNDROME 1; OTFCS" -"OMIM:617022","LETHAL CONGENITAL CONTRACTURE SYNDROME 10; LCCS10" -"OMIM:613071","BRONCHIECTASIS WITH OR WITHOUT ELEVATED SWEAT CHLORIDE 3; BESC3" -"OMIM:617023","RETINITIS PIGMENTOSA 75; RP75" -"DOID:3665","diffuse cutaneous mastocytosis" -"OMIM:613073","METAPHYSEAL ANADYSPLASIA 2; MANDP2" -"OMIM:617024","NIGHT BLINDNESS, CONGENITAL STATIONARY, TYPE 1H; CSNB1H" -"OMIM:613074","DEAFNESS, AUTOSOMAL DOMINANT 50; DFNA50" -"DOID:7480","large cell carcinoma with rhabdoid phenotype" -"OMIM:613075","MACS SYNDROME" -"OMIM:617025","NEVUS COMEDONICUS; NC" -"DOID:12531","von Willebrand's disease" -"OMIM:617026","PONTOCEREBELLAR HYPOPLASIA, TYPE 2F; PCH2F" -"OMIM:613076","MYOPATHY, MITOCHONDRIAL PROGRESSIVE, WITH CONGENITAL CATARACT, HEARING LOSS, AND DEVELOPMENTAL DELAY" -"OMIM:108980","PR INTERVAL, VARIATION IN" -"OMIM:166760","OTITIS MEDIA, SUSCEPTIBILITY TO" -"OMIM:613077","PROGRESSIVE EXTERNAL OPHTHALMOPLEGIA WITH MITOCHONDRIAL DNA DELETIONS, AUTOSOMAL DOMINANT 5; PEOA5" -"OMIM:166750","OTODENTAL DYSPLASIA" -"OMIM:617027","HYPERALDOSTERONISM, FAMILIAL, TYPE IV; HALD4" -"OMIM:617028","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 54; MRT54" -"OMIM:613078","NIJMEGEN BREAKAGE SYNDROME-LIKE DISORDER; NBSLD" -"OMIM:617030","MYOPATHY, DISTAL, 5; MPD5" -"OMIM:613079","DEAFNESS, AUTOSOMAL RECESSIVE 77; DFNB77" -"DOID:9297","lip disease" -"OMIM:613080","46,XY SEX REVERSAL 5; SRXY5" -"OMIM:617035","PATENT DUCTUS ARTERIOSUS 2; PDA2" -"OMIM:166740","OSTEOSCLEROSIS WITH ICHTHYOSIS AND FRACTURES" -"DOID:7169","lung occult large cell carcinoma" -"OMIM:613085","GLAUCOMA 3, PRIMARY CONGENITAL, C; GLC3C" -"OMIM:617039","PATENT DUCTUS ARTERIOSUS 3; PDA3" -"DOID:0050747","lymphoplasmacytic lymphoma" -"OMIM:617041","DUANE RETRACTION SYNDROME 3 WITH OR WITHOUT DEAFNESS; DURS3" -"DOID:10854","salivary gland disease" -"OMIM:613086","GLAUCOMA 3, PRIMARY CONGENITAL, D; GLC3D" -"DOID:12474","capillariasis" -"DOID:338","cranial nerve neoplasm" -"OMIM:613087","ATRIAL SEPTAL DEFECT 6; ASD6" -"OMIM:617044","SHORT STATURE, DEVELOPMENTAL DELAY, AND CONGENITAL HEART DEFECTS; SDDHD" -"DOID:10907","microcephaly" -"DOID:0110349","osteogenesis imperfecta type 9" -"OMIM:617046","SPASTIC PARAPLEGIA 77, AUTOSOMAL RECESSIVE; SPG77" -"OMIM:109000","AURICULOOSTEODYSPLASIA" -"OMIM:613088","PELVIC ORGAN PROLAPSE, SUSCEPTIBILITY TO, 2" -"OMIM:166705","OSTEOPOIKILOSIS AND DACRYOCYSTITIS" -"OMIM:613089","CAPILLARY MALFORMATION OF THE LOWER LIP, LYMPHATIC MALFORMATION OF FACE AND NECK, ASYMMETRY OF FACE AND LIMBS, AND PARTIAL/GENERALIZED OVERGROWTH" -"OMIM:617047","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 26; CMH26" -"OMIM:617049","CHOLESTASIS, PROGRESSIVE FAMILIAL INTRAHEPATIC, 5; PFIC5" -"DOID:2856","euthyroid sick syndrome" -"OMIM:613090","BARTTER SYNDROME, TYPE 4B, NEONATAL, WITH SENSORINEURAL DEAFNESS; BARTS4B" -"DOID:8433","thyroid malformation" -"OMIM:613091","SHORT-RIB THORACIC DYSPLASIA 3 WITH OR WITHOUT POLYDACTYLY; SRTD3" -"OMIM:617050","HERMANSKY-PUDLAK SYNDROME 10; HPS10" -"DOID:0110400","retinitis pigmentosa 22" -"OMIM:166710","OSTEOPOROSIS" -"OMIM:166800","OTOSCLEROSIS 1; OTSC1" -"OMIM:617051","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 55; MRT55" -"DOID:13060","traumatic glaucoma" -"OMIM:613092","HYPERURICEMIC NEPHROPATHY, FAMILIAL JUVENILE, 2; HNFJ2" -"OMIM:617052","BONE MARROW FAILURE SYNDROME 3; BMFS3" -"OMIM:613093","CONE DYSTROPHY 4; COD4" -"DOID:0110375","retinitis pigmentosa 40" -"OMIM:617053","MIRAGE SYNDROME; MIRAGE" -"DOID:11821","bladder lymphoma" -"OMIM:613094","MICROPHTHALMIA, ISOLATED 4; MCOP4" -"DOID:12837","thyroid crisis" -"OMIM:108985","SVEINSSON CHORIORETINAL ATROPHY; SCRA" -"DOID:5427","urinary bladder villous adenoma" -"OMIM:613095","POLYCYSTIC KIDNEY DISEASE 2; PKD2" -"OMIM:617054","STRIATONIGRAL DEGENERATION, CHILDHOOD-ONSET; SNDC" -"DOID:4556","lung large cell carcinoma" -"DOID:706","mature B-cell neoplasm" -"DOID:0111029","hemochromatosis type 1" -"DOID:9883","Becker muscular dystrophy" -"OMIM:134600","FANCONI RENOTUBULAR SYNDROME 1; FRTS1" -"DOID:4500","hypokalemia" -"OMIM:139500","HAIRY EARS" -"DOID:0090081","hypogonadotropic hypogonadism 22 with or without anosmia" -"DOID:557","kidney disease" -"DOID:2848","melancholia" -"OMIM:139290","GUANYLATE KINASE 3; GUK3" -"OMIM:139393","GUILLAIN-BARRE SYNDROME, FAMILIAL; GBS" -"OMIM:139450","HAIR MORPHOLOGY 2; HRM2" -"DOID:0050952","spastic ataxia" -"OMIM:139300","AROMATASE EXCESS SYNDROME; AEXS" -"DOID:11328","schizophreniform disorder" -"OMIM:139650","HAIRY PALMS AND SOLES" -"DOID:0090082","hypogonadotropic hypogonadism 20 with or without anosmia" -"DOID:8757","gastric mucosal hypertrophy" -"OMIM:139750","HAND AND FOOT DEFORMITY WITH FLAT FACIES" -"DOID:11720","distal muscular dystrophy" -"OMIM:139900","HAND SKILL, RELATIVE; HSR" -"DOID:13001","carotid stenosis" -"DOID:120","female reproductive organ cancer" -"DOID:5629","adenosquamous colon carcinoma" -"OMIM:139800","HAND CLASPING PATTERN" -"OMIM:139400","HAIR WHORL" -"DOID:9975","cocaine dependence" -"DOID:1896","sigmoid neoplasm" -"OMIM:139630","HAIRY NOSE TIP" -"DOID:0090077","hypogonadotropic hypogonadism 4 with or without anosmia" -"DOID:1529","penile disease" -"DOID:234","colon adenocarcinoma" -"DOID:0090087","hypogonadotropic hypogonadism 14 with or without anosmia" -"DOID:14133","Masters-Allen syndrome" -"DOID:2378","relapsing-remitting multiple sclerosis" -"DOID:150","disease of mental health" -"DOID:0060684","autosomal dominant nocturnal frontal lobe epilepsy 3" -"OMIM:139600","HAIRY ELBOWS" -"DOID:1826","epilepsy" -"DOID:6727","colon small cell carcinoma" -"DOID:3525","middle cerebral artery infarction" -"DOID:2921","glomerulonephritis" -"DOID:0080183","medullary colon carcinoma" -"OMIM:134540","FACTOR IX AND FACTOR XI, COMBINED DEFICIENCY OF" -"DOID:12191","splenic flexure cancer" -"DOID:5519","colon squamous cell carcinoma" -"DOID:0050035","African tick-bite fever" -"DOID:0060315","oral hairy leukoplakia" -"DOID:7725","epilepsy with generalized tonic-clonic seizures" -"DOID:0050557","congenital muscular dystrophy" -"DOID:3250","pleomorphic rhabdomyosarcoma" -"DOID:0050260","dioctophymiasis" -"OMIM:613096","SPASTIC PARAPLEGIA 36, AUTOSOMAL DOMINANT; SPG36" -"DOID:10435","purulent acute otitis media" -"DOID:10516","malignant otitis externa" -"DOID:13348","laryngeal cartilage cancer" -"OMIM:613098","INCREASED ANALGESIA FROM KAPPA-OPIOID RECEPTOR AGONIST, FEMALE-SPECIFIC" -"DOID:10075","diphyllobothriasis" -"DOID:2048","autoimmune hepatitis" -"DOID:0050890","synucleinopathy" -"DOID:0110864","congenital stationary night blindness 1F" -"OMIM:613099","MELANOMA, CUTANEOUS MALIGNANT, SUSCEPTIBILITY TO, 5; CMM5" -"DOID:4955","central nervous system melanocytic neoplasm" -"DOID:0110007","achromatopsia 2" -"DOID:0110867","congenital stationary night blindness 1C" -"DOID:13767","clonorchiasis" -"DOID:10080","sparganosis" -"OMIM:613100","GLAUCOMA 1, OPEN ANGLE, O; GLC1O" -"DOID:1824","status epilepticus" -"DOID:0110866","congenital stationary night blindness 1H" -"OMIM:613101","HEMOPHAGOCYTIC LYMPHOHISTIOCYTOSIS, FAMILIAL, 5; FHL5" -"DOID:0060502","gastrointestinal allergy" -"DOID:1255","trichostrongyloidiasis" -"OMIM:613102","HYPOTRICHOSIS AND RECURRENT SKIN VESICLES" -"DOID:0110715","congenital stationary night blindness autosomal dominant 3" -"DOID:10154","small intestine cancer" -"DOID:1252","trichuriasis" -"DOID:0060380","orofaciodigital syndrome X" -"DOID:0110140","Bardet-Biedl syndrome 18" -"OMIM:613105","CHOROIDAL DYSTROPHY, CENTRAL AREOLAR 2; CACD2" -"DOID:0110752","type 1 diabetes mellitus 13" -"DOID:9790","toxocariasis" -"DOID:12403","tinea pedis" -"DOID:3660","wheat allergy" -"OMIM:613106","VERTIGO, BENIGN RECURRENT, 2; BRV2" -"DOID:9784","trichinosis" -"DOID:12707","myoclonic cerebellar dyssynergia" -"DOID:13774","Addison's disease" -"DOID:0060057","gluten allergy" -"OMIM:613107","NEUTROPENIA, SEVERE CONGENITAL, 2, AUTOSOMAL DOMINANT; SCN2" -"DOID:0110863","congenital stationary night blindness autosomal dominant 2" -"DOID:14203","childhood type dermatomyositis" -"DOID:591","phobic disorder" -"DOID:884","metagonimiasis" -"DOID:0050251","coenurosis" -"OMIM:613108","CANDIDIASIS, FAMILIAL, 4; CANDF4" -"DOID:0110138","Bardet-Biedl syndrome 16" -"DOID:2481","infantile epileptic encephalopathy" -"OMIM:613112","MACROTHROMBOCYTOPENIA, AUTOSOMAL DOMINANT, TUBB1-RELATED" -"DOID:0050261","thelaziasis" -"DOID:0110757","type 1 diabetes mellitus 20" -"OMIM:613115","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, TYPE IIB; HSAN2B" -"DOID:0110734","neurodegeneration with brain iron accumulation" -"DOID:4376","milk allergy" -"OMIM:613116","THROMBOPHILIA DUE TO HISTIDINE-RICH GLYCOPROTEIN DEFICIENCY; THPH11" -"DOID:594","panic disorder" -"DOID:0110870","congenital stationary night blindness 1A" -"OMIM:613118","ANTITHROMBIN III DEFICIENCY; AT3D" -"OMIM:613119","BRUGADA SYNDROME 6; BRGDA6" -"DOID:0110714","congenital stationary night blindness 1G" -"DOID:4716","malignant gastric germ cell tumor" -"DOID:0060513","fish allergy" -"OMIM:613120","BRUGADA SYNDROME 7; BRGDA7" -"DOID:1588","thrombocytopenia" -"DOID:0110871","congenital stationary night blindness 2A" -"OMIM:613122","CARDIOMYOPATHY, DILATED, 1CC; CMD1CC" -"DOID:5280","gastric leiomyosarcoma" -"DOID:3070","malignant glioma" -"DOID:1219","dicrocoeliasis" -"DOID:4379","nut allergy" -"OMIM:613123","BRUGADA SYNDROME 8; BRGDA8" -"DOID:0090003","agenesis of the corpus callosum with peripheral neuropathy" -"DOID:3612","retinitis" -"DOID:0110123","Bardet-Biedl syndrome 1" -"OMIM:613124","HYDROPS FETALIS, NONIMMUNE, WITH GRACILE BONES AND DYSMORPHIC FEATURES" -"DOID:0110862","congenital stationary night blindness autosomal dominant 1" -"DOID:0050253","mesocestoidiasis" -"OMIM:613135","PARKINSONISM-DYSTONIA, INFANTILE; PKDYS" -"DOID:10544","pylorus cancer" -"DOID:13768","opisthorchiasis" -"DOID:0110141","Bardet-Biedl syndrome 19" -"DOID:0060503","fruit allergy" -"DOID:7651","hypercalcemic type ovarian small cell carcinoma" -"OMIM:613144","CHOROIDAL DYSTROPHY, CENTRAL AREOLAR, 3; CACD3" -"DOID:0110131","Bardet-Biedl syndrome 9" -"OMIM:613145","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 14; SLEB14" -"DOID:1523","colon lymphoma" -"DOID:1496","echinococcosis" -"DOID:6102","herpetic gastritis" -"OMIM:613148","INFLAMMATORY BOWEL DISEASE 28, AUTOSOMAL RECESSIVE; IBD28" -"DOID:0110755","type 1 diabetes mellitus 18" -"DOID:2790","necatoriasis" -"OMIM:613150","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 2; MDDGA2" -"DOID:4377","egg allergy" -"OMIM:613151","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH MENTAL RETARDATION), TYPE B, 3; MDDGB3" -"DOID:14418","dracunculiasis" -"DOID:0110865","congenital stationary night blindness 1B" -"DOID:6483","rete testis adenoma" -"DOID:1129","pituitary apoplexy" -"OMIM:613152","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITHOUT MENTAL RETARDATION), TYPE B, 4; MDDGB4" -"DOID:3107","toxascariasis" -"OMIM:613153","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 5; MDDGA5" -"DOID:9700","bacterial conjunctivitis" -"DOID:7457","enterobiasis" -"OMIM:613154","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 6; MDDGA6" -"DOID:0110127","Bardet-Biedl syndrome 5" -"OMIM:613155","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH MENTAL RETARDATION), TYPE B, 1; MDDGB1" -"DOID:14247","chronic purulent otitis media" -"DOID:882","heterophyiasis" -"DOID:0050883","infantile cerebellar-retinal degeneration" -"DOID:10685","separation anxiety disorder" -"OMIM:613156","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH MENTAL RETARDATION), TYPE B, 2; MDDGB2" -"DOID:0110747","type 1 diabetes mellitus 8" -"DOID:9088","parapsoriasis" -"DOID:1218","echinostomiasis" -"OMIM:613157","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (LIMB-GIRDLE), TYPE C, 3; MDDGC3" -"DOID:10540","gastric lymphoma" -"DOID:0060495","shellfish allergy" -"OMIM:613158","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (LIMB-GIRDLE), TYPE C, 2; MDDGC2" -"DOID:888","fasciolopsiasis" -"OMIM:613159","NEPHRONOPHTHISIS-LIKE NEPHROPATHY 1; NPHPL1" -"DOID:0110756","type 1 diabetes mellitus 19" -"OMIM:613161","BETA-UREIDOPROPIONASE DEFICIENCY; UPB1D" -"DOID:0050256","angiostrongyliasis" -"DOID:0060681","autosomal dominant nocturnal frontal lobe epilepsy" -"OMIM:613162","SPASTIC PARAPLEGIA 45, AUTOSOMAL RECESSIVE; SPG45" -"DOID:1217","fascioloidiasis" -"OMIM:613163","GABA-TRANSAMINASE DEFICIENCY" -"OMIM:617055","COLD-INDUCED SWEATING SYNDROME 3; CISS3" -"OMIM:114550","HEPATOCELLULAR CARCINOMA" -"OMIM:617056","HYPERURICEMIC NEPHROPATHY, FAMILIAL JUVENILE, 4; HNFJ4" -"DOID:0060676","catecholaminergic polymorphic ventricular tachycardia 2" -"DOID:13407","hypercalcemic sarcoidosis" -"OMIM:617061","MENTAL RETARDATION, AUTOSOMAL DOMINANT 44; MRD44" -"DOID:12055","sarcoid meningitis" -"OMIM:617062","OKUR-CHUNG NEURODEVELOPMENTAL SYNDROME; OCNDS" -"DOID:2273","vulvovaginitis" -"DOID:0050588","muscular dystrophy-dystroglycanopathy" -"OMIM:617063","MEIER-GORLIN SYNDROME 7; MGORS7" -"OMIM:114480","BREAST CANCER" -"OMIM:114580","CANDIDIASIS, FAMILIAL, 1; CANDF1" -"DOID:0050254","acanthocephaliasis" -"OMIM:617065","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 40; EIEE40" -"DOID:0060012","recombinase activating gene 2 deficiency" -"OMIM:114300","ARTHROGRYPOSIS, DISTAL, TYPE 3; DA3" -"OMIM:617066","MUSCULAR DYSTROPHY, CONGENITAL, DAVIGNON-CHAUVEAU TYPE; MDCDC" -"OMIM:156190","MENTAL AND GROWTH RETARDATION WITH AMBLYOPIA" -"DOID:0050250","philophthalmiasis" -"OMIM:617068","PORTAL HYPERTENSION, NONCIRRHOTIC; NCPH" -"DOID:4362","cervical cancer" -"OMIM:114620","CRANIOFACIOFRONTODIGITAL SYNDROME" -"OMIM:617069","PROGRESSIVE EXTERNAL OPHTHALMOPLEGIA WITH MITOCHONDRIAL DNA DELETIONS, AUTOSOMAL RECESSIVE 3; PEOB3" -"DOID:519","aortitis" -"OMIM:114700","CARABELLI ANOMALY OF MAXILLARY MOLAR TEETH" -"OMIM:617070","PROGRESSIVE EXTERNAL OPHTHALMOPLEGIA WITH MITOCHONDRIAL DNA DELETIONS, AUTOSOMAL RECESSIVE 4; PEOB4" -"DOID:12841","ancylostomiasis" -"OMIM:617072","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2Y; LGMD2Y" -"OMIM:617073","TOOTH AGENESIS, SELECTIVE, 8; STHAG8" -"OMIM:156200","MENTAL RETARDATION, AUTOSOMAL DOMINANT 1; MRD1" -"DOID:0050634","alopecia universalis" -"DOID:8691","mycosis fungoides" -"OMIM:617075","NASOPHARYNGEAL CARCINOMA, SUSCEPTIBILITY TO, 3; NPCA3" -"DOID:931","monieziasis" -"DOID:1380","endometrial cancer" -"DOID:10955","strongyloidiasis" -"DOID:13404","uveoparotid fever" -"OMIM:617080","SEIZURES, BENIGN FAMILIAL INFANTILE, 5; BFIS5" -"DOID:885","fascioliasis" -"OMIM:617082","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Iaa; CDG1AA" -"OMIM:156220","MERALGIA PARAESTHETICA, FAMILIAL" -"OMIM:114600","CANINE TEETH, ABSENCE OF UPPER PERMANENT" -"DOID:727","premenstrual tension" -"DOID:5426","premature ovarian failure" -"OMIM:114450","CANCER, FAMILIAL, WITH IN VITRO RADIORESISTANCE" -"DOID:3426","vestibular disease" -"DOID:3530","chronic wasting disease" -"DOID:3021","acute kidney failure" -"DOID:13402","skin sarcoidosis" -"DOID:4333","parovarian cyst" -"DOID:0050132","inflammatory diarrhea" -"OMIM:617086","ENCEPHALOPATHY DUE TO DEFECTIVE MITOCHONDRIAL AND PEROXISOMAL FISSION 2; EMPF2" -"DOID:3572","intracranial sinus thrombosis" -"OMIM:115150","CARDIOFACIOCUTANEOUS SYNDROME 1; CFC1" -"OMIM:617087","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, AUTOSOMAL RECESSIVE, TYPE 2A2B; CMT2A2B" -"DOID:2377","multiple sclerosis" -"OMIM:617088","SHORT-RIB THORACIC DYSPLASIA 15 WITH POLYDACTYLY; SRTD15" -"DOID:10074","hymenolepiasis" -"OMIM:617090","MICROCEPHALY 17, PRIMARY, AUTOSOMAL RECESSIVE; MCPH17" -"DOID:0050777","Joubert syndrome" -"DOID:0111100","maturity-onset diabetes of the young type 2" -"OMIM:114500","COLORECTAL CANCER; CRC" -"OMIM:617091","CILIARY DYSKINESIA, PRIMARY, 34; CILD34" -"DOID:2074","intestinal perforation" -"DOID:585","nephrolithiasis" -"DOID:1395","schistosomiasis" -"OMIM:617092","CILIARY DYSKINESIA, PRIMARY, 35; CILD35" -"OMIM:617093","GROWTH RETARDATION, INTELLECTUAL DEVELOPMENTAL DISORDER, HYPOTONIA, AND HEPATOPATHY; GRIDHH" -"OMIM:617099","AUTOINFLAMMATION, PANNICULITIS, AND DERMATOSIS SYNDROME; AIPDS" -"DOID:1080","filariasis" -"DOID:12735","hernia of ovary and fallopian tube" -"OMIM:115000","CARDIAC ARRHYTHMIA" -"DOID:10699","paragonimiasis" -"OMIM:156240","MESOTHELIOMA, MALIGNANT; MESOM" -"OMIM:617100","FAMILIAL ADENOMATOUS POLYPOSIS 4; FAP4" -"OMIM:156230","MESOMELIC DWARFISM OF HYPOPLASTIC TIBIA AND RADIUS TYPE" -"OMIM:617101","INTELLECTUAL DEVELOPMENTAL DISORDER WITH PERSISTENCE OF FETAL HEMOGLOBIN" -"DOID:1962","fallopian tube disease" -"OMIM:617102","SHORT-RIB THORACIC DYSPLASIA 16 WITH OR WITHOUT POLYDACTYLY; SRTD16" -"OMIM:114900","CARCINOID TUMORS, INTESTINAL" -"DOID:161","keratosis" -"OMIM:617105","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 41; EIEE41" -"OMIM:617106","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 42; EIEE42" -"OMIM:617107","THAUVIN-ROBINET-FAIVRE SYNDROME; TROFAS" -"DOID:1003","pelvic inflammatory disease" -"DOID:456","ascariasis" -"OMIM:617108","SESSILE SERRATED POLYPOSIS CANCER SYNDROME; SSPCS" -"DOID:13403","cerebral sarcoidosis" -"DOID:11840","coronary artery vasospasm" -"OMIM:617111","MACULAR DYSTROPHY, PATTERNED, 3; MDPT3" -"OMIM:156000","MENIERE DISEASE" -"OMIM:115080","CARDIAC CONDUCTION DEFECT" -"OMIM:617113","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 43; EIEE43" -"DOID:0050596","taeniasis" -"OMIM:156232","MESOMELIC DYSPLASIA, KANTAPUTRA TYPE; MMDK" -"OMIM:617114","MYOPATHY, MYOFIBRILLAR, 7; MFM7" -"DOID:1284","prolapse of female genital organ" -"DOID:429","gynatresia" -"DOID:7033","anisakiasis" -"OMIM:617115","PEELING SKIN SYNDROME 5; PSS5" -"DOID:784","chronic kidney disease" -"OMIM:114650","CAR FACTOR DEFICIENCY" -"DOID:3983","oesophagostomiasis" -"OMIM:617116","EPILEPSY, FAMILIAL FOCAL, WITH VARIABLE FOCI 2; FFEVF2" -"OMIM:156250","METACHONDROMATOSIS; METCDS" -"DOID:0050259","baylisascariasis" -"OMIM:617118","EPILEPSY, FAMILIAL FOCAL, WITH VARIABLE FOCI 3; FFEVF3" -"DOID:3007","breast ductal carcinoma" -"OMIM:300613","MYOPIA 13, X-LINKED; MYP13" -"OMIM:603416","RIBOSOMAL PROTEIN L21 PSEUDOGENE 1; RPL21P1" -"OMIM:603438","RADIOULNAR SYNOSTOSIS WITH MICROCEPHALY, SHORT STATURE, SCOLIOSIS, AND MENTAL RETARDATION" -"OMIM:300614","DEAFNESS, X-LINKED 5; DFNX5" -"OMIM:603439","EXPANSILE BONE LESIONS" -"OMIM:300615","BRUNNER SYNDROME; BRNRS" -"DOID:0050292","primary systemic mycosis" -"DOID:0050291","parasitic Ichthyosporea infectious disease" -"OMIM:603446","OROACRAL SYNDROME, VERLOES-KOULISCHER TYPE" -"OMIM:300619","CATARACT, ATAXIA, SHORT STATURE, AND MENTAL RETARDATION" -"DOID:289","endometriosis" -"OMIM:300622","TN POLYAGGLUTINATION SYNDROME; TNPS" -"OMIM:603457","BOSMA ARHINIA MICROPHTHALMIA SYNDROME; BAMS" -"DOID:5157","benign pleural mesothelioma" -"DOID:599","specific phobia" -"OMIM:300623","FRAGILE X TREMOR/ATAXIA SYNDROME; FXTAS" -"OMIM:603463","HYPOSPADIAS, HYPERTELORISM, UPPER LID COLOBOMA, AND MIXED-TYPE HEARING LOSS" -"OMIM:300624","FRAGILE X SYNDROME; FXS" -"DOID:365","bladder disease" -"OMIM:603467","FANCONI ANEMIA, COMPLEMENTATION GROUP F; FANCF" -"OMIM:300633","HYPOSPADIAS 1, X-LINKED; HYSP1" -"OMIM:603471","CITRULLINEMIA, TYPE II, ADULT-ONSET; CTLN2" -"DOID:0050332","enlarged vestibular aqueduct" -"OMIM:603472","NEURONAL INTRANUCLEAR INCLUSION DISEASE" -"OMIM:300635","LYMPHOPROLIFERATIVE SYNDROME, X-LINKED, 2; XLP2" -"OMIM:300636","IMMUNODEFICIENCY 33; IMD33" -"OMIM:603511","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 1E; LGMD1E" -"OMIM:300640","INVASIVE PNEUMOCOCCAL DISEASE, RECURRENT ISOLATED, 2; IPD2" -"OMIM:603513","CEREBRAL PALSY, SPASTIC QUADRIPLEGIC, 1; CPSQ1" -"OMIM:603516","SPINOCEREBELLAR ATAXIA 10; SCA10" -"OMIM:300643","ROLANDIC EPILEPSY, MENTAL RETARDATION, AND SPEECH DYSPRAXIA, X-LINKED; RESDX" -"OMIM:603523","CHYLOTHORAX, CONGENITAL" -"DOID:9562","primary ciliary dyskinesia" -"DOID:13078","eumycotic mycetoma" -"OMIM:300645","IMMUNODEFICIENCY 34; IMD34" -"OMIM:300650","ALBINISM, OCULAR, WITH LATE-ONSET SENSORINEURAL DEAFNESS; OASD" -"OMIM:603529","DYSERYTHROPOIESIS, CONGENITAL, WITH ULTRASTRUCTURALLY NORMAL ERYTHROBLAST HETEROCHROMATIN" -"OMIM:300652","ANGIOMA SERPIGINOSUM, X-LINKED" -"OMIM:603530","LIGHT FIXATION SEIZURE SYNDROME" -"DOID:2473","opportunistic mycosis" -"OMIM:603543","LIMB-MAMMARY SYNDROME; LMS" -"OMIM:300653","PHOSPHOGLYCERATE KINASE 1 DEFICIENCY" -"OMIM:603546","SPONDYLOEPIMETAPHYSEAL DYSPLASIA WITH JOINT LAXITY, TYPE 2; SEMDJL2" -"OMIM:300659","MENTAL RETARDATION, X-LINKED 93; MRX93" -"OMIM:300660","LEUKOENCEPHALOPATHY WITH METAPHYSEAL CHONDRODYSPLASIA; LKMCD" -"OMIM:603552","HEMOPHAGOCYTIC LYMPHOHISTIOCYTOSIS, FAMILIAL, 4; FHL4" -"OMIM:603553","HEMOPHAGOCYTIC LYMPHOHISTIOCYTOSIS, FAMILIAL, 2; FHL2" -"OMIM:300661","PHOSPHORIBOSYLPYROPHOSPHATE SYNTHETASE SUPERACTIVITY" -"OMIM:603554","OMENN SYNDROME" -"OMIM:300672","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 2; EIEE2" -"OMIM:300673","ENCEPHALOPATHY, NEONATAL SEVERE, DUE TO MECP2 MUTATIONS" -"OMIM:603563","SPASTIC PARAPLEGIA 8, AUTOSOMAL DOMINANT; SPG8" -"OMIM:300676","MENTAL RETARDATION, X-LINKED, SYNDROMIC 14; MRXS14" -"OMIM:603569","TRACHEOBRONCHIAL STENOSIS, CONGENITAL" -"OMIM:603572","MICROCEPHALY, FACIAL ABNORMALITIES, MICROMELIA, AND MENTAL RETARDATION" -"OMIM:300679","CHROMOSOME Xp21 DELETION SYNDROME" -"OMIM:300695","SCAPULOPERONEAL MYOPATHY, X-LINKED DOMINANT; SPM" -"OMIM:603585","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIf; CDG2F" -"DOID:0060549","Barber-Say syndrome" -"DOID:11054","urinary bladder cancer" -"OMIM:603587","FOLLICULAR ATROPHODERMA, PERIORAL PIGMENTED, WITH MILIA AND EPIDERMOID CYSTS" -"OMIM:300696","MYOPATHY, X-LINKED, WITH POSTURAL MUSCLE ATROPHY; XMPMA" -"OMIM:603588","PAROTITIS, JUVENILE RECURRENT" -"OMIM:300699","MENTAL RETARDATION, X-LINKED, SYNDROMIC, WU TYPE; MRXSW" -"OMIM:603589","FACIAL DYSMORPHISM, SELECTIVE TOOTH AGENESIS, AND CHOROID CALCIFICATION" -"OMIM:300700","ALBINISM-DEAFNESS SYNDROME; ADFN" -"DOID:0060877","ichthyosis bullosa of Siemens" -"OMIM:603592","XANTHINURIA, TYPE II; XAN2" -"OMIM:300703","SPINOCEREBELLAR ATAXIA, X-LINKED 5; SCAX5" -"DOID:8912","tinea nigra" -"DOID:2964","periarthritis" -"OMIM:300704","PROSTATE CANCER, HEREDITARY, X-LINKED 2; HPCX2" -"OMIM:603595","CRANIOSYNOSTOSIS WITH ECTOPIA LENTIS" -"OMIM:603596","POLYDACTYLY" -"OMIM:300705","CHROMOSOME Xp11.22 DUPLICATION SYNDROME" -"OMIM:603600","OSTEOMA OF CRANIAL VAULT, FAMILIAL" -"OMIM:300706","MENTAL RETARDATION, X-LINKED, SYNDROMIC, TURNER TYPE; MRXST" -"DOID:593","agoraphobia" -"DOID:0050589","inflammatory bowel disease" -"OMIM:300707","TOE SYNDACTYLY, TELECANTHUS, AND ANOGENITAL AND RENAL MALFORMATIONS; STAR" -"OMIM:603622","DEAFNESS, AUTOSOMAL DOMINANT 17; DFNA17" -"DOID:999","hypereosinophilic syndrome" -"OMIM:300709","MENTAL RETARDATION, X-LINKED, SYNDROMIC 9; MRXS9" -"OMIM:603629","DEAFNESS, AUTOSOMAL RECESSIVE 21; DFNB21" -"OMIM:300710","ALOPECIA, ANDROGENETIC, 2; AGA2" -"OMIM:603641","NEUROENDOCRINE CARCINOMA OF SALIVARY GLANDS, SENSORINEURAL HEARING LOSS, AND ENAMEL HYPOPLASIA" -"DOID:0060597","atypical chronic myeloid leukemia" -"OMIM:603642","ATRIAL SEPTAL DEFECT, SECUNDUM, WITH VARIOUS CARDIAC AND NONCARDIAC DEFECTS" -"OMIM:300711","PYLORIC STENOSIS, INFANTILE HYPERTROPHIC, 4; IHPS4" -"OMIM:603643","SITUS INVERSUS TOTALIS WITH CYSTIC DYSPLASIA OF KIDNEYS AND PANCREAS" -"OMIM:300712","CRANIOFACIOSKELETAL SYNDROME" -"OMIM:168710","PAROTID PROLINE-RICH SALIVARY PROTEIN Pc" -"OMIM:193220","VITREORETINOCHOROIDOPATHY; VRCP" -"OMIM:617119","BARDET-BIEDL SYNDROME 20; BBS20" -"OMIM:613164","PARKINSON DISEASE 16; PARK16" -"OMIM:603649","CONE-ROD DYSTROPHY 7; CORD7" -"OMIM:193230","VITREORETINAL DEGENERATION, SNOWFLAKE TYPE; SVD" -"OMIM:613172","CARDIOMYOPATHY, DILATED, 1DD; CMD1DD" -"OMIM:617120","JOUBERT SYNDROME 27; JBTS27" -"DOID:14793","hypohidrotic ectodermal dysplasia" -"OMIM:603656","EXOSTOSIS, DUPUYTREN SUBUNGUAL" -"OMIM:603663","MENTAL HEALTH WELLNESS 1" -"OMIM:613174","CHROMOSOME 5p13 DUPLICATION SYNDROME" -"OMIM:617121","JOUBERT SYNDROME 28; JBTS28" -"OMIM:168830","PASSOVOY FACTOR DEFECT" -"OMIM:193235","VITREORETINOPATHY, NEOVASCULAR INFLAMMATORY; VRNI" -"OMIM:193240","VOCAL CORD PARALYSIS AND PTOSIS" -"DOID:2861","congenital nonspherocytic hemolytic anemia" -"OMIM:613177","CUTIS LAXA, AUTOSOMAL RECESSIVE, TYPE IC; ARCL1C" -"OMIM:603664","MENTAL HEALTH WELLNESS 2" -"OMIM:617123","RETINITIS PIGMENTOSA 76; RP76" -"OMIM:603669","ECCRINE SYRINGOFIBROADENOMATOSIS WITH EYELID ABNORMALITIES" -"OMIM:193250","VOLVULUS OF MIDGUT" -"OMIM:613179","PURINE NUCLEOSIDE PHOSPHORYLASE DEFICIENCY" -"OMIM:617125","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 56; MRT56" -"OMIM:603670","BLUE NEVI, FAMILIAL MULTIPLE" -"OMIM:617126","ALAZAMI-YUAN SYNDROME; ALYUS" -"OMIM:613180","CORTICAL DYSPLASIA, COMPLEX, WITH OTHER BRAIN MALFORMATIONS 8; CDCBM8" -"OMIM:193300","VON HIPPEL-LINDAU SYNDROME; VHL" -"OMIM:193400","VON WILLEBRAND DISEASE, TYPE 1; VWD1" -"OMIM:603671","ACROMELIC FRONTONASAL DYSOSTOSIS; AFND" -"OMIM:613192","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 13; MRT13" -"DOID:0060613","X-linked cleft palate with or without ankyloglossia" -"OMIM:617127","OROFACIODIGITAL SYNDROME XV; OFD15" -"OMIM:617132","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 44; EIEE44" -"OMIM:613193","CILIARY DYSKINESIA, PRIMARY, 13; CILD13" -"OMIM:193450","VULVOVAGINITIS, ALLERGIC SEMINAL" -"DOID:4919","renal pelvis carcinoma" -"DOID:13628","favism" -"OMIM:174600","POLYDACTYLY, PREAXIAL III" -"OMIM:603678","DEAFNESS, AUTOSOMAL RECESSIVE 14; DFNB14" -"OMIM:603688","PROSTATE CANCER/BRAIN CANCER SUSCEPTIBILITY" -"OMIM:193500","WAARDENBURG SYNDROME, TYPE 1; WS1" -"OMIM:613194","RETINITIS PIGMENTOSA 50; RP50" -"OMIM:168860","PATELLA APLASIA-HYPOPLASIA; PTLAH" -"OMIM:174770","ACTINIC PRURIGO" -"OMIM:617133","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 24; SCAR24" -"DOID:3265","chronic granulomatous disease" -"OMIM:603689","HEREDITARY MYOPATHY WITH EARLY RESPIRATORY FAILURE; HMERF" -"OMIM:174750","POLYKARYOCYTOSIS INDUCER; FUSE" -"OMIM:193510","WAARDENBURG SYNDROME, TYPE 2A; WS2A" -"DOID:6179","ovarian small cell carcinoma" -"OMIM:613195","WEILL-MARCHESANI-LIKE SYNDROME" -"OMIM:617137","FRONTOMETAPHYSEAL DYSPLASIA 2; FMD2" -"OMIM:617140","ZTTK SYNDROME; ZTTKS" -"OMIM:193520","WATSON SYNDROME; WTSN" -"OMIM:603694","DIABETES MELLITUS, NONINSULIN-DEPENDENT, 3" -"OMIM:613204","MUSCULAR DYSTROPHY, CONGENITAL, DUE TO INTEGRIN ALPHA-7 DEFICIENCY" -"OMIM:193530","WEYERS ACROFACIAL DYSOSTOSIS; WAD" -"OMIM:613205","MUSCULAR DYSTROPHY, CONGENITAL, LMNA-RELATED" -"OMIM:603720","DEAFNESS, AUTOSOMAL RECESSIVE 16; DFNB16" -"OMIM:168800","PAROTIDOMEGALY, HEREDITARY BILATERAL" -"OMIM:617141","ANIRIDIA 2; AN2" -"OMIM:193670","WHIM SYNDROME; WHIMS" -"OMIM:174700","POLYDACTYLY, PREAXIAL IV" -"OMIM:613206","SPASTIC PARAPLEGIA 44, AUTOSOMAL RECESSIVE; SPG44" -"OMIM:174310","POLYDACTYLY, POSTAXIAL, WITH PROGRESSIVE MYOPIA" -"OMIM:617142","ANIRIDIA 3; AN3" -"OMIM:603736","OHDO SYNDROME, SBBYS VARIANT; SBBYSS" -"OMIM:613207","ASTHMA-RELATED TRAITS, SUSCEPTIBILITY TO, 8; ASRT8" -"OMIM:617143","MYASTHENIC SYNDROME, CONGENITAL, 20, PRESYNAPTIC; CMS20" -"OMIM:193700","ARTHROGRYPOSIS, DISTAL, TYPE 2A; DA2A" -"OMIM:603737","OVARIAN GERM CELL CANCER" -"OMIM:617145","NEURODEGENERATION WITH ATAXIA, DYSTONIA, AND GAZE PALSY, CHILDHOOD-ONSET; NADGP" -"OMIM:193900","WHITE SPONGE NEVUS 1; WSN1" -"OMIM:603740","ACRODYSPLASIA WITH OSSIFICATION ABNORMALITIES, SHORT STATURE, AND FIBULAR HYPOPLASIA" -"DOID:0110033","autosomal recessive Alport syndrome" -"DOID:262","kidney hemangiopericytoma" -"OMIM:613211","AMELOGENESIS IMPERFECTA, HYPOMATURATION TYPE, IIA3; AI2A3" -"OMIM:617146","ARTHROGRYPOSIS, DISTAL, WITH IMPAIRED PROPRIOCEPTION AND TOUCH; DAIPT" -"OMIM:613215","CHROMOSOME 17p13.3, CENTROMERIC, DUPLICATION SYNDROME" -"OMIM:603744","PAPILLARY THYROID MICROCARCINOMA" -"OMIM:194000","WIDOW'S PEAK" -"OMIM:603776","HYPERCHOLESTEROLEMIA, AUTOSOMAL DOMINANT, 3; HCHOLA3" -"OMIM:617153","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 45; EIEE45" -"OMIM:613216","NIGHT BLINDNESS, CONGENITAL STATIONARY, TYPE 1C; CSNB1C" -"OMIM:194050","WILLIAMS-BEUREN SYNDROME; WBS" -"OMIM:194070","WILMS TUMOR 1; WT1" -"OMIM:617156","MITOCHONDRIAL DNA DEPLETION SYNDROME 15 (HEPATOCEREBRAL TYPE); MTDPS15" -"OMIM:174050","POLYCYSTIC LIVER DISEASE 1; PCLD1" -"OMIM:613217","DIARRHEA 5, WITH TUFTING ENTEROPATHY, CONGENITAL; DIAR5" -"OMIM:174400","POLYDACTYLY, PREAXIAL I" -"OMIM:603783","INTELLIGENCE QUANTITATIVE TRAIT LOCUS 1" -"OMIM:603786","STARGARDT DISEASE 4; STGD4" -"OMIM:617157","SHORT STATURE, BRACHYDACTYLY, INTELLECTUAL DEVELOPMENTAL DISABILITY, AND SEIZURES; SBIDDS" -"OMIM:194071","WILMS TUMOR 2; WT2" -"DOID:3262","phagocyte bactericidal dysfunction" -"OMIM:613219","FASTING PLASMA GLUCOSE LEVEL QUANTITATIVE TRAIT LOCUS 2; FGQTL2" -"DOID:4692","endophthalmitis" -"OMIM:603794","HYDROA VACCINIFORME, FAMILIAL" -"OMIM:613223","LEPROSY, SUSCEPTIBILITY TO, 5; LPRS5" -"OMIM:617158","MYOPATHY, DISTAL, WITH RIMMED VACUOLES; DMRV" -"OMIM:194072","WILMS TUMOR, ANIRIDIA, GENITOURINARY ANOMALIES, AND MENTAL RETARDATION SYNDROME; WAGR" -"DOID:1925","Coffin-Siris syndrome" -"DOID:2154","nephroblastoma" -"OMIM:613224","NOONAN SYNDROME 6; NS6" -"OMIM:603802","MICROCEPHALY WITH SIMPLIFIED GYRAL PATTERN" -"OMIM:617159","SIFRIM-HITZ-WEISS SYNDROME; SIHIWES" -"OMIM:162820","NEUTROPHIL MIGRATION; NM" -"OMIM:194080","DENYS-DRASH SYNDROME; DDS" -"OMIM:603806","URINARY TRACT INFECTIONS, RECURRENT, SUSCEPTIBILITY TO" -"OMIM:617162","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 46; EIEE46" -"OMIM:194090","WILMS TUMOR 3; WT3" -"OMIM:613225","FACTOR XIII, A SUBUNIT, DEFICIENCY OF" -"OMIM:194190","WOLF-HIRSCHHORN SYNDROME; WHS" -"OMIM:617164","SHORT STATURE, RHIZOMELIC, WITH MICROCEPHALY, MICROGNATHIA, AND DEVELOPMENTAL DELAY; SRMMD" -"OMIM:603813","HYPERCHOLESTEROLEMIA, AUTOSOMAL RECESSIVE; ARH" -"DOID:0110967","brachydactyly type A4" -"OMIM:613227","CEREBELLAR ATAXIA, MENTAL RETARDATION, AND DYSEQUILIBRIUM SYNDROME 3; CAMRQ3" -"OMIM:603828","BRITTLE BONE DISORDER" -"OMIM:194200","WOLFF-PARKINSON-WHITE SYNDROME" -"OMIM:613229","TRICHOTILLOMANIA; TTM" -"OMIM:162900","NEVUS, EPIDERMAL" -"OMIM:617166","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 47; EIEE47" -"OMIM:194300","WOOLLY HAIR, AUTOSOMAL DOMINANT; ADWH" -"OMIM:613233","FASTING PLASMA GLUCOSE LEVEL QUANTITATIVE TRAIT LOCUS 3; FGQTL3" -"OMIM:603829","VENTRICULAR FIBRILLATION, PAROXYSMAL FAMILIAL, 1; VF1" -"OMIM:617168","AORTIC ANEURYSM, FAMILIAL THORACIC 10; AAT10" -"OMIM:613235","FACTOR XIII, B SUBUNIT, DEFICIENCY OF" -"OMIM:194320","WORONETS TRAIT" -"OMIM:617169","SOTOS SYNDROME 3; SOTOS3" -"OMIM:603830","LONG QT SYNDROME 3; LQT3" -"OMIM:163000","CAPILLARY MALFORMATIONS, CONGENITAL; CMC" -"DOID:0110214","cleft soft palate" -"OMIM:603855","CYSTIC FIBROSIS, MODIFIER OF, 1; CFM1" -"DOID:3675","childhood kidney neoplasm" -"OMIM:617171","DYSKINESIA, SEIZURES, AND INTELLECTUAL DEVELOPMENTAL DISORDER; DYSEIDD" -"OMIM:194350","WT LIMB-BLOOD SYNDROME" -"OMIM:613237","FOCAL SEGMENTAL GLOMERULOSCLEROSIS 5; FSGS5" -"OMIM:603860","MEDULLARY CYSTIC KIDNEY DISEASE 2; MCKD2" -"OMIM:617173","INTELLECTUAL DEVELOPMENTAL DISORDER WITH CARDIAC ARRHYTHMIA; IDDCA" -"OMIM:194370","X-RAY SENSITIVITY; XRS" -"OMIM:613238","SPONDYLOARTHROPATHY, SUSCEPTIBILITY TO, 3; SPDA3" -"OMIM:603896","LEUKOENCEPHALOPATHY WITH VANISHING WHITE MATTER; VWM" -"OMIM:613239","THYROTOXIC PERIODIC PARALYSIS, SUSCEPTIBILITY TO, 2; TTPP2" -"OMIM:617174","EHLERS-DANLOS SYNDROME, PERIODONTAL TYPE, 2; EDSPD2" -"DOID:10931","dependent personality disorder" -"OMIM:194380","DEHYDRATED HEREDITARY STOMATOCYTOSIS 1 WITH OR WITHOUT PSEUDOHYPERKALEMIA AND/OR PERINATAL EDEMA; DHS1" -"OMIM:603902","BETA-THALASSEMIA, DOMINANT INCLUSION BODY TYPE" -"OMIM:613241","PSEUDOPILI ANNULATI" -"OMIM:194400","XERODERMA PIGMENTOSUM, AUTOSOMAL DOMINANT, MILD" -"OMIM:617175","RETINAL DYSTROPHY WITH OR WITHOUT EXTRAOCULAR ANOMALIES; RDEOA" -"OMIM:194470","ZINC, ELEVATED PLASMA" -"OMIM:617180","CHITAYAT SYNDROME; CHYTS" -"OMIM:613243","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 13; CMH13" -"OMIM:603903","SICKLE CELL ANEMIA" -"OMIM:603909","AUTOIMMUNE LYMPHOPROLIFERATIVE SYNDROME, TYPE IIA; ALPS2A" -"OMIM:162830","NEUTROPHILIA, HEREDITARY" -"OMIM:617182","LANGUAGE DELAY AND ATTENTION DEFICIT-HYPERACTIVITY DISORDER/COGNITIVE IMPAIRMENT WITH OR WITHOUT CARDIAC ARRHYTHMIA; LADCI" -"OMIM:200100","ABETALIPOPROTEINEMIA; ABL" -"OMIM:613244","COLORECTAL CANCER, HEREDITARY NONPOLYPOSIS, TYPE 8; HNPCC8" -"OMIM:174200","POLYDACTYLY, POSTAXIAL, TYPE A1; PAPA1" -"OMIM:617183","HAREL-YOON SYNDROME; HAYOS" -"OMIM:613251","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 14; CMH14" -"OMIM:603918","HYPERTENSION, ESSENTIAL, SUSCEPTIBILITY TO, 1" -"OMIM:200110","ABLEPHARON-MACROSTOMIA SYNDROME; AMS" -"OMIM:174300","OROFACIODIGITAL SYNDROME V; OFD5" -"OMIM:613252","CARDIOMYOPATHY, DILATED, 1EE; CMD1EE" -"OMIM:603932","INTERVERTEBRAL DISC DISEASE; IDD" -"OMIM:617184","MITOCHONDRIAL DNA DEPLETION SYNDROME 12A (CARDIOMYOPATHIC TYPE), AUTOSOMAL DOMINANT; MTDPS12A" -"OMIM:163050","NEVUS ANEMICUS" -"OMIM:200130","ABSENT EYEBROWS AND EYELASHES WITH MENTAL RETARDATION" -"OMIM:617186","ENCEPHALOPATHY, PROGRESSIVE, EARLY-ONSET, WITH BRAIN EDEMA AND/OR LEUKOENCEPHALOPATHY; PEBEL" -"OMIM:200150","CHOREOACANTHOCYTOSIS; CHAC" -"OMIM:603933","MICROVASCULAR COMPLICATIONS OF DIABETES, SUSCEPTIBILITY TO, 1; MVCD1" -"DOID:0050591","tooth agenesis" -"OMIM:613254","TUBEROUS SCLEROSIS 2; TSC2" -"OMIM:613255","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 15; CMH15" -"OMIM:200170","ACANTHOSIS NIGRICANS WITH MUSCLE CRAMPS AND ACRAL ENLARGEMENT" -"OMIM:617187","SPERMATOGENIC FAILURE 16; SPGF16" -"DOID:2129","atypical teratoid rhabdoid tumor" -"OMIM:174500","POLYDACTYLY, PREAXIAL II; PPD2" -"OMIM:603935","PSORIASIS 4, SUSCEPTIBILITY TO; PSORS4" -"OMIM:244400","CILIARY DYSKINESIA, PRIMARY, 1; CILD1" -"OMIM:244450","KAUFMAN OCULOCEREBROFACIAL SYNDROME; KOS" -"OMIM:140000","HAND-FOOT-GENITAL SYNDROME; HFG" -"DOID:0090125","COL4A1-related familial vascular leukoencephalopathy" -"OMIM:244460","KENNY-CAFFEY SYNDROME, TYPE 1; KCS1" -"OMIM:244510","KERATOCONUS AND CONGENITAL HIP DYSPLASIA" -"DOID:5583","lung giant cell carcinoma" -"OMIM:244600","KERATOCONUS POSTICUS CIRCUMSCRIPTUS; KPC" -"OMIM:140300","HASHIMOTO THYROIDITIS" -"OMIM:244850","PALMOPLANTAR KERATODERMA, NORRBOTTEN RECESSIVE TYPE; PPKNR" -"OMIM:245000","PAPILLON-LEFEVRE SYNDROME; PALS" -"OMIM:245010","HAIM-MUNK SYNDROME; HMS" -"OMIM:245050","SUCCINYL-CoA:3-OXOACID-CoA TRANSFERASE DEFICIENCY; SCOTD" -"OMIM:245100","RICHARDS-RUNDLE SYNDROME; RRNS" -"DOID:2786","cerebellar disease" -"DOID:1443","cerebral degeneration" -"DOID:2982","perinephritis" -"DOID:891","progressive myoclonus epilepsy" -"OMIM:245130","KETOADIPICACIDURIA" -"OMIM:245150","KEUTEL SYNDROME; KTLS" -"OMIM:140450","HEART-HAND SYNDROME, SPANISH TYPE" -"DOID:10846","angiodysplasia of intestine" -"OMIM:245160","KNIEST-LIKE DYSPLASIA WITH PURSED LIPS AND ECTOPIA LENTIS" -"DOID:6658","pulmonary large cell neuroendocrine carcinoma" -"OMIM:245180","KIFAFA SEIZURE DISORDER" -"DOID:1607","hypoglycemic coma" -"OMIM:245190","KNIEST-LIKE DYSPLASIA, LETHAL" -"DOID:2580","rhizomelic chondrodysplasia punctata" -"DOID:0110958","Gaucher's disease type II" -"OMIM:245200","KRABBE DISEASE" -"OMIM:140350","HAWKINSINURIA" -"DOID:9719","proliferative vitreoretinopathy" -"OMIM:245300","KURU, SUSCEPTIBILITY TO" -"DOID:0050850","diabetic encephalopathy" -"OMIM:245340","ERYTHROCYTE LACTATE TRANSPORTER DEFECT" -"OMIM:140500","HEART, MALFORMATION OF" -"OMIM:245348","PYRUVATE DEHYDROGENASE E2 DEFICIENCY; PDHDD" -"DOID:9463","otitis externa" -"DOID:8437","intestinal obstruction" -"OMIM:245349","PYRUVATE DEHYDROGENASE E3-BINDING PROTEIN DEFICIENCY; PDHXD" -"DOID:10602","steatorrhea" -"DOID:2148","tuberculous oophoritis" -"OMIM:245400","MITOCHONDRIAL DNA DEPLETION SYNDROME 9 (ENCEPHALOMYOPATHIC TYPE WITH METHYLMALONIC ACIDURIA); MTDPS9" -"OMIM:245450","LACTIC ACIDURIA DUE TO D-LACTIC ACID" -"DOID:0060689","atrichia with papular lesions" -"OMIM:245480","SPECIFIC GRANULE DEFICIENCY 1; SGD1" -"DOID:7475","diverticulitis" -"DOID:13025","retinopathy of prematurity" -"DOID:0090130","cortical dysplasia-focal epilepsy syndrome" -"DOID:2034","encephalomalacia" -"OMIM:245550","LAMBERT SYNDROME" -"DOID:1969","cerebral palsy" -"DOID:4422","malignant adenofibroma" -"OMIM:245552","LAMBOTTE SYNDROME" -"DOID:4662","thalamic disease" -"OMIM:245570","EPILEPSY, FOCAL, WITH SPEECH DISORDER AND WITH OR WITHOUT MENTAL RETARDATION; FESD" -"DOID:8607","herpetic whitlow" -"OMIM:245590","GROWTH HORMONE INSENSITIVITY WITH IMMUNODEFICIENCY" -"DOID:1931","hypothalamic disease" -"OMIM:245600","MULTIPLE JOINT DISLOCATIONS, SHORT STATURE, AND CRANIOFACIAL DYSMORPHISM WITH OR WITHOUT CONGENITAL HEART DEFECTS; JDSCD" -"OMIM:245650","LARSEN-LIKE SYNDROME, LETHAL TYPE" -"DOID:2384","Wernicke encephalopathy" -"DOID:11223","small intestine diverticulitis" -"DOID:3119","gastrointestinal system cancer" -"OMIM:245660","LARYNGOONYCHOCUTANEOUS SYNDROME; LOCS" -"DOID:0050211","swine influenza" -"DOID:5949","angiokeratoma circumscriptum" -"DOID:0060263","porencephaly" -"OMIM:245800","LAURENCE-MOON SYNDROME; LNMS" -"OMIM:245900","LECITHIN:CHOLESTEROL ACYLTRANSFERASE DEFICIENCY" -"OMIM:246000","LEG, ABSENCE DEFORMITY OF, WITH CONGENITAL CATARACT" -"OMIM:180100","RETINITIS PIGMENTOSA 1; RP1" -"DOID:2479","central nervous system origin vertigo" -"OMIM:246200","DONOHUE SYNDROME" -"DOID:10486","intestinal atresia" -"DOID:1974","adenosarcoma" -"OMIM:140400","PROGRESSIVE FAMILIAL HEART BLOCK, TYPE II; PFHB2" -"OMIM:246300","LEPROSY, SUSCEPTIBILITY TO, 3; LPRS3" -"DOID:0060675","catecholaminergic polymorphic ventricular tachycardia 1" -"DOID:9428","intracranial hypertension" -"OMIM:246400","LETTERER-SIWE DISEASE" -"OMIM:146850","IMMUNE SUPPRESSION; IS" -"OMIM:613265","WAARDENBURG SYNDROME, TYPE 4B; WS4B" -"DOID:6827","pancreatic solid pseudopapillary carcinoma" -"DOID:0110537","autosomal recessive nonsyndromic deafness 93" -"DOID:0110521","autosomal recessive nonsyndromic deafness 70" -"OMIM:613266","WAARDENBURG SYNDROME, TYPE 4C; WS4C" -"OMIM:613267","CORNEAL DYSTROPHY, FUCHS ENDOTHELIAL, 3; FECD3" -"DOID:0110499","autosomal recessive nonsyndromic deafness 40" -"OMIM:613268","CORNEAL DYSTROPHY, FUCHS ENDOTHELIAL, 4; FECD4" -"DOID:0110500","autosomal recessive nonsyndromic deafness 42" -"OMIM:613269","CORNEAL DYSTROPHY, FUCHS ENDOTHELIAL, 5; FECD5" -"DOID:0110501","autosomal recessive nonsyndromic deafness 44" -"OMIM:613270","CORNEAL DYSTROPHY, FUCHS ENDOTHELIAL, 6; FECD6" -"DOID:0110495","autosomal recessive nonsyndromic deafness 37" -"OMIM:613271","CORNEAL DYSTROPHY, FUCHS ENDOTHELIAL, 7; FECD7" -"OMIM:146820","IMMUNE RESPONSE TO SYNTHETIC POLYPEPTIDE--IRGAT; IGAT" -"DOID:0111111","maturity-onset diabetes of the young type 14" -"OMIM:613280","HYPERMANGANESEMIA WITH DYSTONIA 1; HMNDYT1" -"DOID:4164","cerebral neuroblastoma" -"OMIM:613282","FATTY LIVER DISEASE, NONALCOHOLIC, SUSCEPTIBILITY TO, 1; NAFLD1" -"OMIM:613284","HEMATOCRIT/HEMOGLOBIN QUANTITATIVE TRAIT LOCUS 3; HCHGQ3" -"OMIM:613285","DEAFNESS, AUTOSOMAL RECESSIVE 25; DFNB25" -"OMIM:107750","ARBITRARY RESTRICTION POLYMORPHISM 1" -"OMIM:613286","CARDIOMYOPATHY, DILATED, 1FF; CMD1FF" -"OMIM:147060","HYPER-IgE RECURRENT INFECTION SYNDROME, AUTOSOMAL DOMINANT" -"DOID:6823","pancreatoblastoma" -"OMIM:613287","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2N; CMT2N" -"OMIM:146840","IMMUNODEFICIENCY WITH DEFECTIVE LEUKOCYTE AND LYMPHOCYTE FUNCTION AND WITH RESPONSE TO HISTAMINE-1 ANTAGONIST" -"OMIM:613290","HEARING LOSS, CISPLATIN-INDUCED, SUSCEPTIBILITY TO; CIHL" -"OMIM:107800","ARCUS CORNEAE" -"OMIM:146800","ICHTHYOSIS BULLOSA OF SIEMENS; IBS" -"DOID:3089","granulomatous orchitis" -"OMIM:613291","BILE ACID MALABSORPTION, PRIMARY; PBAM" -"DOID:3222","causalgia" -"OMIM:146810","IMMUNE RESPONSE TO SYNTHETIC POLYPEPTIDE--IRPHEGAL; IPHEG" -"OMIM:613307","DEAFNESS, AUTOSOMAL RECESSIVE 79; DFNB79" -"DOID:0110523","autosomal recessive nonsyndromic deafness 74" -"OMIM:613308","DIAMOND-BLACKFAN ANEMIA 9; DBA9" -"OMIM:107920","AROMATIC ALPHA-KETO ACID REDUCTASE" -"OMIM:613309","DIAMOND-BLACKFAN ANEMIA 10; DBA10" -"OMIM:147050","IgE RESPONSIVENESS, ATOPIC; IGER" -"DOID:0110534","autosomal recessive nonsyndromic deafness 89" -"OMIM:613310","EXUDATIVE VITREORETINOPATHY 5; EVR5" -"OMIM:613312","HYPOPHOSPHATEMIC RICKETS, AUTOSOMAL RECESSIVE, 2; ARHR2" -"DOID:0110511","autosomal recessive nonsyndromic deafness 59" -"DOID:11996","spermatic cord torsion" -"OMIM:146950","IMMUNE RESPONSE TO SYNTHETIC POLYPEPTIDE--IRHGAL; IHG" -"OMIM:613313","HEMOCHROMATOSIS, TYPE 2B; HFE2B" -"OMIM:146960","IMMUNE RESPONSE TO SYNTHETIC POLYPEPTIDE--IRTGAL; ITG" -"DOID:11994","atrophy of testis" -"OMIM:613318","MIYOSHI MUSCULAR DYSTROPHY 2; MMD2" -"DOID:13160","scrotum melanoma" -"OMIM:613319","MIYOSHI MUSCULAR DYSTROPHY 3; MMD3" -"DOID:2132","brain sarcoma" -"DOID:5104","testicular infarct" -"DOID:0110506","autosomal recessive nonsyndromic deafness 49" -"OMIM:107850","ARM FOLDING PREFERENCE" -"DOID:0110012","advanced sleep phase syndrome 2" -"OMIM:613320","SPONDYLOMETAPHYSEAL DYSPLASIA, MEGARBANE-DAGHER-MELKI TYPE; SMDMDM" -"DOID:1025","tuberculoid leprosy" -"OMIM:146830","IMMUNE DEFICIENCY, FAMILIAL VARIABLE" -"OMIM:613325","RHABDOID TUMOR PREDISPOSITION SYNDROME 2; RTPS2" -"OMIM:107650","APNEA, OBSTRUCTIVE SLEEP" -"DOID:720","normocytic anemia" -"DOID:0110519","autosomal recessive nonsyndromic deafness 68" -"OMIM:613327","LIPODYSTROPHY, CONGENITAL GENERALIZED, TYPE 4; CGL4" -"DOID:0110485","autosomal recessive nonsyndromic deafness 27" -"OMIM:613328","ROIFMAN-CHITAYAT SYNDROME" -"DOID:0080006","bone development disease" -"DOID:0080008","ischemic bone disease" -"OMIM:613329","PLASMINOGEN ACTIVATOR INHIBITOR-1 DEFICIENCY" -"DOID:0111108","maturity-onset diabetes of the young type 10" -"OMIM:146990","IMMUNOGLOBULIN HEAVY CHAIN DIVERSITY REGION 2; IGHDY2" -"DOID:0110517","autosomal recessive nonsyndromic deafness 66" -"OMIM:613330","SPONDYLO-MEGAEPIPHYSEAL-METAPHYSEAL DYSPLASIA; SMMD" -"DOID:10970","spastic quadriplegia" -"OMIM:107640","APNEA, CENTRAL SLEEP" -"OMIM:118610","CHONDROCALCINOSIS DUE TO APATITE CRYSTAL DEPOSITION" -"OMIM:613339","EPILEPSY, HOT WATER, 1; HWE1" -"OMIM:147080","IMMUNE RESPONSE TO SYNTHETIC POLYPEPTIDE--IRGLPHE 1; IGLP1" -"OMIM:613340","EPILEPSY, HOT WATER, 2; HWE2" -"DOID:0050382","glandular tularemia" -"OMIM:107600","APLASIA CUTIS CONGENITA, NONSYNDROMIC; ACC" -"OMIM:613341","LEBER CONGENITAL AMAUROSIS 14; LCA14" -"OMIM:613342","MSELENI JOINT DISEASE" -"DOID:2518","orchitis" -"OMIM:118600","CHONDROCALCINOSIS 2; CCAL2" -"OMIM:107900","ARMS, MALFORMATION OF" -"DOID:4074","pancreatic adenocarcinoma" -"OMIM:613343","HANDIGODU JOINT DISEASE" -"OMIM:107700","APPENDICITIS, PRONENESS TO" -"DOID:893","Wilson disease" -"OMIM:613345","HYPOKALEMIC PERIODIC PARALYSIS, TYPE 2; HOKPP2" -"DOID:11213","acute contagious conjunctivitis" -"DOID:4492","avian influenza" -"OMIM:147061","IMMUNOGLOBULIN E CONCENTRATION, SERUM; IGES" -"OMIM:613347","PANCREATIC CANCER, SUSCEPTIBILITY TO, 2" -"OMIM:617188","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 57; MRT57" -"OMIM:167800","PANCREATITIS, HEREDITARY; PCTT" -"OMIM:617190","SHASHI-PENA SYNDROME; SHAPNS" -"DOID:1795","tumor of exocrine pancreas" -"OMIM:617193","ENCEPHALOPATHY, PROGRESSIVE, EARLY-ONSET, WITH BRAIN ATROPHY AND THIN CORPUS CALLOSUM; PEBAT" -"DOID:10609","rickets" -"OMIM:617194","LETHAL CONGENITAL CONTRACTURE SYNDROME 11; LCCS11" -"DOID:0111110","maturity-onset diabetes of the young type 13" -"DOID:0060903","thrombosis" -"DOID:10649","acute inferolateral myocardial infarction" -"OMIM:617201","PERIVENTRICULAR NODULAR HETEROTOPIA 7; PVNH7" -"DOID:0090053","episodic kinesigenic dyskinesia 1" -"OMIM:617205","HETEROTAXY, VISCERAL, 8, AUTOSOMAL; HTX8" -"OMIM:167959","HUMAN PAPILLOMAVIRUS TYPE 18 INTEGRATION SITE 1; HPV18I1" -"OMIM:617207","ENCEPHALOPATHY, PROGRESSIVE, WITH AMYOTROPHY AND OPTIC ATROPHY; PEAMO" -"OMIM:617213","SEDOHEPTULOKINASE DEFICIENCY; SHPKD" -"OMIM:617214","SPERMATOGENIC FAILURE 17; SPGF17" -"OMIM:617217","AMELOGENESIS IMPERFECTA, HYPOMATURATION TYPE, IIA6; AI2A6" -"DOID:0090015","Cenani-Lenz syndactyly syndrome" -"OMIM:617219","CHROMOSOME 19q13.11 DELETION SYNDROME, PROXIMAL" -"DOID:7632","Cowper gland carcinoma" -"OMIM:617222","SUDDEN CARDIAC FAILURE, INFANTILE; SCFI" -"DOID:1967","leiomyosarcoma" -"DOID:0110098","atopic dermatitis 2" -"OMIM:617223","SUDDEN CARDIAC FAILURE, ALCOHOL-INDUCED; SCFAI" -"DOID:3355","fibrosarcoma" -"OMIM:617225","SPASTIC PARAPLEGIA 78, AUTOSOMAL RECESSIVE; SPG78" -"OMIM:167750","PANCREAS, ANNULAR" -"DOID:1964","fallopian tube cancer" -"DOID:403","mouth disease" -"OMIM:617228","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 31; COXPD31" -"DOID:12678","hypercalcemia" -"DOID:962","neurofibroma" -"OMIM:617232","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2Z; LGMD2Z" -"OMIM:617234","PREIMPLANTATION EMBRYONIC LETHALITY 2; PREMBL2" -"DOID:1796","pancreas sarcoma" -"OMIM:617235","MYOCLONUS, INTRACTABLE, NEONATAL; NEIMY" -"DOID:5026","sclerosing hepatic carcinoma" -"OMIM:617236","CONE-ROD DYSTROPHY AND HEARING LOSS; CRDHL" -"OMIM:617237","IMMUNODEFICIENCY 49; IMD49" -"DOID:0080011","bone resorption disease" -"OMIM:181430","SCAPULOPERONEAL MYOPATHY, MYH7-RELATED; SPMM" -"OMIM:617238","MYOPIA 25, AUTOSOMAL DOMINANT; MYP25" -"DOID:10366","epididymis cancer" -"OMIM:617239","MYASTHENIC SYNDROME, CONGENITAL, 21, PRESYNAPTIC; CMS21" -"DOID:6721","Littre gland carcinoma" -"OMIM:167850","PANCYTOPENIA AND OCCLUSIVE VASCULAR DISEASE" -"OMIM:167950","PAPILLOMATOSIS, FLORID, OF NIPPLE" -"OMIM:617241","LUNG DISEASE, IMMUNODEFICIENCY, AND CHROMOSOME BREAKAGE SYNDROME; LICS" -"OMIM:617243","FANCONI ANEMIA, COMPLEMENTATION GROUP V; FANCV" -"OMIM:617244","FANCONI ANEMIA, COMPLEMENTATION GROUP R; FANCR" -"OMIM:617247","FANCONI ANEMIA, COMPLEMENTATION GROUP U; FANCU" -"OMIM:167755","PANCREAS, DORSAL, AGENESIS OF" -"OMIM:617248","3-METHYLGLUTACONIC ACIDURIA, TYPE VIII; MGCA8" -"DOID:4676","uremia" -"OMIM:617251","UNCOMBABLE HAIR SYNDROME 2; UHS2" -"DOID:13369","tinea manuum" -"OMIM:167870","PANIC DISORDER 1; PAND1" -"OMIM:617252","UNCOMBABLE HAIR SYNDROME 3; UHS3" -"DOID:11917","tinea cruris" -"OMIM:617253","SECKEL SYNDROME 10; SCKL10" -"DOID:12179","tinea corporis" -"OMIM:617255","LISSENCEPHALY 8; LIS8" -"OMIM:167900","PAPILLOMATOSIS, CONFLUENT AND RETICULATED; CARP" -"OMIM:617258","MYOPATHY, MYOFIBRILLAR, 8; MFM8" -"DOID:3192","neurilemmoma" -"OMIM:617260","GLOBAL DEVELOPMENTAL DELAY, ABSENT OR HYPOPLASTIC CORPUS CALLOSUM, AND DYSMORPHIC FACIES; GDACCF" -"OMIM:617268","NEURODEVELOPMENTAL DISORDER WITH HYPOTONIA, SEIZURES, AND ABSENT LANGUAGE; NDHSAL" -"DOID:12282","femoral vein thrombophlebitis" -"DOID:0060072","benign neoplasm" -"DOID:7206","melanomatosis" -"DOID:0050096","tinea barbae" -"DOID:2444","hyperpituitarism" -"OMIM:617270","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 58; MRT58" -"DOID:3437","laryngitis" -"OMIM:173560","PLATELET MEMBRANE FLUIDITY; PMF" -"DOID:3382","liposarcoma" -"DOID:3401","inappropriate ADH syndrome" -"OMIM:617271","NEPHRONOPHTHISIS 20; NPHP20" -"OMIM:602066","CONVULSIONS, FAMILIAL INFANTILE, WITH PAROXYSMAL CHOREOATHETOSIS; ICCA" -"OMIM:127300","LERI-WEILL DYSCHONDROSTEOSIS; LWD" -"DOID:5040","malignant granular cell esophageal tumor" -"DOID:2609","adenomyoma" -"OMIM:602068","LEISHMANIASIS, TEGUMENTARY, SUSCEPTIBILITY TO" -"OMIM:172700","PICK DISEASE OF BRAIN" -"OMIM:602071","BROAD TERMINAL PHALANGES, FAMILIAL" -"OMIM:172850","PIEBALD TRAIT WITH NEUROLOGIC DEFECTS" -"DOID:11719","oculopharyngeal muscular dystrophy" -"OMIM:602078","FIBROSIS OF EXTRAOCULAR MUSCLES, CONGENITAL, 2; CFEOM2" -"OMIM:172800","PIEBALD TRAIT; PBT" -"OMIM:602079","TRIMETHYLAMINURIA; TMAU" -"OMIM:602080","PAGET DISEASE OF BONE 2, EARLY-ONSET; PDB2" -"OMIM:102800","ADENOSINE TRIPHOSPHATASE DEFICIENCY, ANEMIA DUE TO" -"DOID:1108","esophagus melanoma" -"OMIM:127550","DYSKERATOSIS CONGENITA, AUTOSOMAL DOMINANT 1; DKCA1" -"OMIM:602081","SPEECH-LANGUAGE DISORDER 1; SPCH1" -"OMIM:102730","ADENOSINE DEAMINASE, ELEVATED, HEMOLYTIC ANEMIA DUE TO" -"OMIM:602082","CORNEAL DYSTROPHY, THIEL-BEHNKE TYPE; CDTB" -"DOID:0110344","osteogenesis imperfecta type 5" -"OMIM:602083","USHER SYNDROME, TYPE IF; USH1F" -"OMIM:102700","SEVERE COMBINED IMMUNODEFICIENCY, AUTOSOMAL RECESSIVE, T CELL-NEGATIVE, B CELL-NEGATIVE, NK CELL-NEGATIVE, DUE TO ADENOSINE DEAMINASE DEFICIENCY" -"DOID:6950","combat disorder" -"OMIM:602085","POLYDACTYLY, POSTAXIAL, TYPE A2; PAPA2" -"OMIM:103100","ADIE PUPIL" -"OMIM:602086","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 3; ARVD3" -"OMIM:127500","DYSCHROMATOSIS UNIVERSALIS HEREDITARIA 1; DUH1" -"DOID:4418","cutaneous fibrous histiocytoma" -"OMIM:126950","DWARFISM WITH TALL VERTEBRAE" -"OMIM:602087","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 4; ARVD4" -"DOID:4723","intracranial hypotension" -"OMIM:602088","NEPHRONOPHTHISIS 2; NPHP2" -"OMIM:129400","RAPP-HODGKIN SYNDROME; RHS" -"OMIM:211770","CAHMR SYNDROME" -"OMIM:239100","HYPEROSTOSIS CORTICALIS GENERALISATA" -"DOID:3904","bronchus carcinoma" -"OMIM:239199","HYPERPARATHYROIDISM, NEONATAL SELF-LIMITED PRIMARY, WITH HYPERCALCIURIA" -"OMIM:211800","CALCIFICATION OF JOINTS AND ARTERIES; CALJA" -"DOID:5759","sebaceous gland neoplasm" -"OMIM:211890","CAMPOMELIA, CUMMING TYPE" -"OMIM:239200","HYPERPARATHYROIDISM, NEONATAL SEVERE; NSHPT" -"DOID:4282","pigmented basal cell carcinoma" -"OMIM:129100","EARS, ABILITY TO MOVE" -"OMIM:211900","TUMORAL CALCINOSIS, HYPERPHOSPHATEMIC, FAMILIAL; HFTC" -"OMIM:239300","HYPERPHOSPHATASIA WITH MENTAL RETARDATION SYNDROME 1; HPMRS1" -"OMIM:211910","CAMPTODACTYLY SYNDROME, GUADALAJARA, TYPE I; GCS1" -"OMIM:239350","HYPERPHOSPHATEMIA, POLYURIA, AND SEIZURES" -"DOID:2495","senile angioma" -"DOID:2339","Crouzon syndrome" -"DOID:10131","psychologic vaginismus" -"OMIM:239500","HYPERPROLINEMIA, TYPE I; HYRPRO1" -"OMIM:211920","CAMPTODACTYLY SYNDROME, GUADALAJARA, TYPE II" -"OMIM:239510","HYPERPROLINEMIA, TYPE II; HYRPRO2" -"DOID:4014","sarcomatoid transitional cell carcinoma" -"OMIM:211930","CAMPTODACTYLY WITH FIBROUS TISSUE HYPERPLASIA AND SKELETAL DYSPLASIA" -"OMIM:239710","ACROFRONTOFACIONASAL DYSOSTOSIS 2" -"DOID:4304","signet ring basal cell carcinoma" -"OMIM:211960","CAMPTODACTYLY WITH MUSCULAR HYPOPLASIA, SKELETAL DYSPLASIA, AND ABNORMAL PALMAR CREASES" -"OMIM:128800","EAR WITHOUT HELIX" -"OMIM:211965","CAMPTODACTYLY-ICHTHYOSIS SYNDROME" -"OMIM:239711","HYPERTELORISM AND TETRALOGY OF FALLOT" -"OMIM:128980","EARLOBES, THICKENED, WITH CONDUCTIVE DEAFNESS FROM INCUDOSTAPEDIAL ABNORMALITIES" -"OMIM:239800","HYPERTELORISM, MICROTIA, FACIAL CLEFTING SYNDROME" -"OMIM:211980","LUNG CANCER" -"DOID:2355","anemia" -"DOID:3907","lung squamous cell carcinoma" -"OMIM:239840","HYPERTRICHOSIS, CONGENITAL ANTERIOR CERVICAL, WITH PERIPHERAL SENSORY AND MOTOR NEUROPATHY" -"OMIM:211990","CAMPTOMELIC SYNDROME, LONG-LIMB TYPE" -"OMIM:128900","EARLOBE ATTACHMENT, ATTACHED VS UNATTACHED" -"DOID:4829","adenosquamous cell lung carcinoma" -"OMIM:212050","CANDIDIASIS, FAMILIAL, 2; CANDF2" -"DOID:0111070","congenital bile acid synthesis defect 3" -"OMIM:239850","CANTU SYNDROME" -"OMIM:212060","CARBIMAZOLE SENSITIVITY" -"OMIM:239900","HYPERTROPHIC NEUROPATHY AND CATARACT" -"OMIM:129200","BASAN SYNDROME" -"OMIM:212065","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ia; CDG1A" -"OMIM:128950","EARLOBE CREASE" -"OMIM:240000","HYPERURICEMIA, INFANTILE, WITH ABNORMAL BEHAVIOR AND NORMAL HYPOXANTHINE GUANINE PHOSPHORIBOSYLTRANSFERASE" -"DOID:4286","sebaceous basal cell carcinoma" -"OMIM:240150","HYPERVITAMINOSIS A, SUSCEPTIBILITY TO" -"OMIM:212066","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIa; CDG2A" -"DOID:4299","infiltrative basal cell carcinoma" -"OMIM:212067","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE I/IIx" -"OMIM:240200","HYPOADRENOCORTICISM, FAMILIAL" -"OMIM:240300","AUTOIMMUNE POLYENDOCRINE SYNDROME, TYPE I, WITH OR WITHOUT REVERSIBLE METAPHYSEAL DYSPLASIA; APS1" -"OMIM:212070","CARBOXYPEPTIDASE N DEFICIENCY" -"OMIM:612637","FEBRILE SEIZURES, FAMILIAL, 10; FEB10" -"OMIM:208910","ATAXIA-TELANGIECTASIA WITH GENERALIZED SKIN PIGMENTATION AND EARLY DEATH" -"OMIM:602555","MICROCEPHALY, MACROTIA, AND MENTAL RETARDATION" -"OMIM:208920","ATAXIA, EARLY-ONSET, WITH OCULOMOTOR APRAXIA AND HYPOALBUMINEMIA; EAOH" -"OMIM:612639","INFLAMMATORY BOWEL DISEASE 26; IBD26" -"OMIM:602556","FACIAL DYSMORPHISM, CLEFT PALATE, HEARING LOSS, AND CAMPTODACTYLY" -"OMIM:612642","DEAFNESS, AUTOSOMAL DOMINANT 59; DFNA59" -"OMIM:115900","CATARACT 42; CTRCT42" -"OMIM:602557","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, SHOHAT TYPE" -"OMIM:209010","ATHEROSCLEROSIS, PREMATURE, WITH DEAFNESS, NEPHROPATHY, DIABETES MELLITUS, PHOTOMYOCLONUS, AND DEGENERATIVE NEUROLOGIC DISEASE" -"OMIM:209050","ATHROMBIA, ESSENTIAL" -"OMIM:602558","CRANIOMICROMELIC SYNDROME" -"OMIM:612643","DEAFNESS, AUTOSOMAL DOMINANT 3B; DFNA3B" -"OMIM:209100","ATONIC-ASTATIC SYNDROME OF FOERSTER" -"OMIM:602561","BRACHYDACTYLY, INTRAVENTRICULAR SEPTAL DEFECT, AND DEAFNESS" -"OMIM:612644","DEAFNESS, AUTOSOMAL DOMINANT 2B; DFNA2B" -"OMIM:116300","CATARACT 30, MULTIPLE TYPES; CTRCT30" -"DOID:260","hepatic flexure cancer" -"OMIM:602562","MANDIBULOFACIAL DYSOSTOSIS WITH MACROBLEPHARON AND MACROSTOMIA" -"OMIM:209300","ATRANSFERRINEMIA" -"OMIM:612645","DEAFNESS, AUTOSOMAL RECESSIVE 1B; DFNB1B" -"DOID:11843","coronary artery anomaly" -"OMIM:602564","EMPHYSEMA, CONGENITAL, WITH DEAFNESS, PENOSCROTAL WEB, AND MENTAL RETARDATION" -"OMIM:209500","ATRICHIA WITH PAPULAR LESIONS; APL" -"OMIM:612649","CILIARY DYSKINESIA, PRIMARY, 11; CILD11" -"OMIM:602579","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ib; CDG1B" -"OMIM:612650","CILIARY DYSKINESIA, PRIMARY, 12; CILD12" -"OMIM:209600","ATRIOVENTRICULAR DISSOCIATION" -"OMIM:209700","ATROPHODERMA VERMICULATA; AVA" -"OMIM:602588","BRANCHIOOTIC SYNDROME 1; BOS1" -"OMIM:612651","ENDOCRINE-CEREBROOSTEODYSPLASIA; ECO" -"DOID:0060043","sexual disorder" -"OMIM:602594","RETINITIS PIGMENTOSA 22; RP22" -"OMIM:209770","AURAL ATRESIA, MULTIPLE CONGENITAL ANOMALIES, AND MENTAL RETARDATION" -"OMIM:612653","SPHEROCYTOSIS, TYPE 4; SPH4" -"DOID:1245","vulva cancer" -"DOID:10140","dry eye syndrome" -"DOID:10588","adrenoleukodystrophy" -"OMIM:602596","PANCREATIC LYMPHOMA, FAMILIAL" -"OMIM:209800","AUSTRALIA ANTIGEN" -"OMIM:612656","EPISODIC ATAXIA, TYPE 6; EA6" -"OMIM:115650","CATARACT 32, MULTIPLE TYPES; CTRCT32" -"OMIM:209850","AUTISM" -"OMIM:602611","SPONDYLOEPIPHYSEAL DYSPLASIA WITH CORONAL CRANIOSYNOSTOSIS, CATARACTS, CLEFT PALATE, AND MENTAL RETARDATION" -"OMIM:115700","CATARACT 4, MULTIPLE TYPES; CTRCT4" -"OMIM:612657","CONE-ROD DYSTROPHY 12; CORD12" -"OMIM:612671","URIC ACID CONCENTRATION, SERUM, QUANTITATIVE TRAIT LOCUS 4; UAQTL4" -"OMIM:209880","CENTRAL HYPOVENTILATION SYNDROME, CONGENITAL; CCHS" -"OMIM:602612","CAMPTODACTYLY, MYOPIA, AND FIBROSIS OF THE MEDIAL RECTUS MUSCLE OF EYE" -"DOID:0111107","maturity-onset diabetes of the young type 9" -"OMIM:209885","BARBER-SAY SYNDROME; BBRSAY" -"OMIM:612674","POLYNEUROPATHY, HEARING LOSS, ATAXIA, RETINITIS PIGMENTOSA, AND CATARACT; PHARC" -"OMIM:602613","SKELETAL DYSPLASIA AND PROGRESSIVE CENTRAL NERVOUS SYSTEM DEGENERATION, LETHAL" -"OMIM:176920","PROTEUS SYNDROME" -"OMIM:209900","BARDET-BIEDL SYNDROME 1; BBS1" -"DOID:11823","hepatorenal syndrome" -"OMIM:602629","DYSTONIA 6, TORSION; DYT6" -"OMIM:612690","SPHEROCYTOSIS, TYPE 5; SPH5" -"OMIM:602639","TOOTH AGENESIS, SELECTIVE, 2; STHAG2" -"OMIM:209920","BARE LYMPHOCYTE SYNDROME, TYPE II" -"OMIM:612691","POLYMICROGYRIA, BILATERAL TEMPOROOCCIPITAL; BTOP" -"OMIM:612692","AGAMMAGLOBULINEMIA 6, AUTOSOMAL RECESSIVE; AGM6" -"OMIM:209950","IMMUNODEFICIENCY 27A; IMD27A" -"OMIM:602668","MYOTONIC DYSTROPHY 2; DM2" -"OMIM:602685","MENTAL RETARDATION, SEVERE, WITH SPASTICITY AND PIGMENTARY TAPETORETINAL DEGENERATION" -"OMIM:612702","HYPOGONADOTROPIC HYPOGONADISM 6 WITH OR WITHOUT ANOSMIA; HH6" -"OMIM:209970","BEEMER LETHAL MALFORMATION SYNDROME" -"OMIM:115645","CATARACT, ABERRANT ORAL FRENULA, AND GROWTH RETARDATION" -"DOID:349","systemic mastocytosis" -"OMIM:210000","BEHR SYNDROME; BEHRS" -"OMIM:612703","MICROCEPHALY 7, PRIMARY, AUTOSOMAL RECESSIVE; MCPH7" -"OMIM:602722","RENAL TUBULAR ACIDOSIS, DISTAL, AUTOSOMAL RECESSIVE; RTADR" -"OMIM:602723","PSORIASIS 2; PSORS2" -"OMIM:210050","BERRY ANEURYSM, CIRRHOSIS, PULMONARY EMPHYSEMA, AND CEREBRAL CALCIFICATION" -"OMIM:612712","LEBER CONGENITAL AMAUROSIS 13; LCA13" -"OMIM:115800","CATARACT 29; CTRCT29" -"OMIM:602759","PROSTATE CANCER, HEREDITARY, 8" -"OMIM:210100","BETA-AMINOISOBUTYRIC ACIDURIA; BAIBA" -"OMIM:612713","KAHRIZI SYNDROME; KHRZ" -"OMIM:210200","3-METHYLCROTONYL-CoA CARBOXYLASE 1 DEFICIENCY; MCC1D" -"OMIM:602771","RIGID SPINE MUSCULAR DYSTROPHY 1; RSMD1" -"OMIM:612714","EXOCRINE PANCREATIC INSUFFICIENCY, DYSERYTHROPOIETIC ANEMIA, AND CALVARIAL HYPEROSTOSIS" -"OMIM:612715","DYSCHROMATOSIS UNIVERSALIS HEREDITARIA 2; DUH2" -"OMIM:210210","3-METHYLCROTONYL-CoA CARBOXYLASE 2 DEFICIENCY; MCC2D" -"OMIM:602772","RETINITIS PIGMENTOSA 25; RP25" -"DOID:1933","Rubinstein-Taybi syndrome" -"DOID:0060271","pontocerebellar hypoplasia type 2E" -"OMIM:210250","SITOSTEROLEMIA" -"OMIM:612716","DYSTONIA, DOPA-RESPONSIVE, DUE TO SEPIAPTERIN REDUCTASE DEFICIENCY" -"OMIM:602782","HISTIOCYTOSIS-LYMPHADENOPATHY PLUS SYNDROME" -"OMIM:210350","BIEMOND SYNDROME II" -"OMIM:602849","MUENKE SYNDROME; MNKES" -"OMIM:612717","MYOPIA 15, AUTOSOMAL DOMINANT; MYP15" -"OMIM:210370","BIETTI CRYSTALLINE CORNEORETINAL DYSTROPHY; BCD" -"OMIM:602875","ACROMESOMELIC DYSPLASIA, MAROTEAUX TYPE; AMDM" -"OMIM:612718","CEREBRAL CREATINE DEFICIENCY SYNDROME 3; CCDS3" -"DOID:0111099","maturity-onset diabetes of the young type 1" -"OMIM:210400","BIFID NOSE, AUTOSOMAL RECESSIVE" -"OMIM:602966","OROFACIAL CLEFT 2; OFC2" -"OMIM:612726","HARDIKAR SYNDROME" -"OMIM:116200","CATARACT 1, MULTIPLE TYPES; CTRCT1" -"OMIM:602994","LEUKOREGULIN" -"OMIM:210500","BILIARY ATRESIA, EXTRAHEPATIC; EHBA" -"OMIM:612727","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 13; BMND13" -"OMIM:612728","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 14; BMND14" -"OMIM:603003","BILE DUCT CYSTS" -"OMIM:210550","BILIARY MALFORMATION WITH RENAL TUBULAR INSUFFICIENCY" -"OMIM:210600","SECKEL SYNDROME 1; SCKL1" -"OMIM:603010","DEAFNESS, AUTOSOMAL RECESSIVE 17; DFNB17" -"OMIM:612729","LEAN BODY MASS QUANTITATIVE TRAIT LOCUS 1; LBMQTL1" -"OMIM:612731","FACIOCARDIOMELIC SYNDROME" -"OMIM:210700","MICROCEPHALIC PRIMORDIAL DWARFISM, MONTREAL TYPE" -"OMIM:603013","SCHIZOPHRENIA 6; SCZD6" -"DOID:0050561","Lennox-Gastaut syndrome" -"OMIM:115665","CATARACT 8, MULTIPLE TYPES; CTRCT8" -"OMIM:612736","CEREBRAL CREATINE DEFICIENCY SYNDROME 2; CCDS2" -"OMIM:115660","CATARACT 7; CTRCT7" -"OMIM:603034","MYASTHENIC SYNDROME, CONGENITAL, 5; CMS5" -"OMIM:210710","MICROCEPHALIC OSTEODYSPLASTIC PRIMORDIAL DWARFISM, TYPE I; MOPD1" -"OMIM:612737","STATURE QUANTITATIVE TRAIT LOCUS 17; STQTL17" -"OMIM:210720","MICROCEPHALIC OSTEODYSPLASTIC PRIMORDIAL DWARFISM, TYPE II; MOPD2" -"OMIM:603040","TUMOR SUPPRESSOR GENE ON CHROMOSOME 11" -"DOID:1699","congenital ichthyosiform erythroderma" -"OMIM:210730","MICROCEPHALIC OSTEODYSPLASTIC PRIMORDIAL DWARFISM, TYPE III" -"OMIM:603041","MITOCHONDRIAL DNA DEPLETION SYNDROME 1 (MNGIE TYPE); MTDPS1" -"OMIM:612740","PORPHYRIA, ACUTE HEPATIC" -"OMIM:116100","CATARACT 20, MULTIPLE TYPES; CTRCT20" -"OMIM:603047","ASTIGMATISM" -"OMIM:612759","SYNESTHESIA" -"OMIM:210740","BANGSTAD SYNDROME" -"OMIM:210745","BLEPHAROPHIMOSIS WITH PTOSIS, SYNDACTYLY, AND SHORT STATURE" -"OMIM:603075","MACULAR DEGENERATION, AGE-RELATED, 1; ARMD1" -"OMIM:612775","CONE-ROD DYSTROPHY 9; CORD9" -"OMIM:176900","PROTEOLYTIC CAPACITY OF PLASMA" -"OMIM:148000","KAPOSI SARCOMA, SUSCEPTIBILITY TO" -"OMIM:616617","HEIMLER SYNDROME 2; HMLR2" -"OMIM:235700","HEMOLYTIC ANEMIA, NONSPHEROCYTIC, DUE TO HEXOKINASE DEFICIENCY" -"OMIM:616622","IMMUNODEFICIENCY 42; IMD42" -"OMIM:235730","MOWAT-WILSON SYNDROME; MOWS" -"DOID:5641","diffuse pulmonary fibrosis" -"OMIM:616625","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2W; CMT2W" -"OMIM:235740","HIRSCHSPRUNG DISEASE WITH POLYDACTYLY, RENAL AGENESIS, AND DEAFNESS" -"OMIM:235750","HIRSCHSPRUNG DISEASE WITH ULNAR POLYDACTYLY, POLYSYNDACTYLY OF BIG TOES, AND VENTRICULAR SEPTAL DEFECT" -"OMIM:616629","SENIOR-LOKEN SYNDROME 9; SLSN9" -"OMIM:235760","HIRSCHSPRUNG DISEASE WITH HYPOPLASTIC NAILS AND DYSMORPHIC FACIAL FEATURES" -"OMIM:616631","POROKERATOSIS 9, MULTIPLE TYPES; POROK9" -"OMIM:148050","KBG SYNDROME; KBGS" -"DOID:11665","Patau syndrome" -"OMIM:616632","SEIZURES, CORTICAL BLINDNESS, AND MICROCEPHALY SYNDROME; SCBMS" -"OMIM:235800","HISTIDINEMIA" -"OMIM:616636","IMMUNODEFICIENCY 44; IMD44" -"OMIM:235830","HISTIDINURIA DUE TO A RENAL TUBULAR DEFECT" -"DOID:9538","multiple myeloma" -"DOID:13185","esophageal diverticulosis" -"DOID:11801","protein-energy malnutrition" -"OMIM:235900","HISTIOCYTOSIS, FAMILIAL LIPOCHROME" -"OMIM:616638","SMITH-KINGSMORE SYNDROME; SKS" -"OMIM:616640","EPILEPSY, PROGRESSIVE MYOCLONIC, 10; EPM10" -"OMIM:236000","LYMPHOMA, HODGKIN, CLASSIC; CHL" -"OMIM:236100","HOLOPROSENCEPHALY 1; HPE1" -"OMIM:616645","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 34; EIEE34" -"OMIM:271320","SPINOCEREBELLAR DEGENERATION WITH MACULAR CORNEAL DYSTROPHY, CONGENITAL CATARACTS, AND MYOPIA" -"DOID:4545","mesenchymal chondrosarcoma" -"OMIM:236110","HOLZGREVE SYNDROME" -"DOID:0110381","retinitis pigmentosa 14" -"DOID:715","T-cell leukemia" -"OMIM:616647","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 35; EIEE35" -"OMIM:616648","OPTIC ATROPHY 8; OPA8" -"OMIM:236130","HOMOCARNOSINOSIS" -"DOID:2452","thrombophilia" -"DOID:10939","antisocial personality disorder" -"OMIM:616649","SPHEROCYTOSIS, TYPE 2; SPH2" -"OMIM:236200","HOMOCYSTINURIA DUE TO CYSTATHIONINE BETA-SYNTHASE DEFICIENCY" -"OMIM:236250","HOMOCYSTINURIA DUE TO DEFICIENCY OF N(5,10)-METHYLENETETRAHYDROFOLATE REDUCTASE ACTIVITY" -"OMIM:616651","ROIFMAN SYNDROME; RFMN" -"OMIM:236270","HOMOCYSTINURIA-MEGALOBLASTIC ANEMIA, cblE COMPLEMENTATION TYPE; HMAE" -"DOID:5246","hilar cholangiocellular carcinoma" -"OMIM:616652","YUAN-HAREL-LUPSKI SYNDROME; YUHAL" -"OMIM:236300","HOOFT DISEASE" -"DOID:12123","postinflammatory pulmonary fibrosis" -"OMIM:616654","JOUBERT SYNDROME 24; JBTS24" -"OMIM:236400","HUMERORADIAL SYNOSTOSIS" -"OMIM:616657","SPASTIC TETRAPLEGIA, THIN CORPUS CALLOSUM, AND PROGRESSIVE MICROCEPHALY; SPATCCM" -"OMIM:236410","HUMERORADIAL SYNOSTOSIS WITH CRANIOFACIAL ANOMALIES" -"DOID:14227","azoospermia" -"OMIM:616668","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2X; CMT2X" -"OMIM:236450","HUTTERITE CEREBROOSTEONEPHRODYSPLASIA SYNDROME" -"OMIM:616669","IMMUNODEFICIENCY 45; IMD45" -"DOID:5642","localized pulmonary fibrosis" -"OMIM:616672","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 27; COXPD27" -"OMIM:236500","MULTINUCLEATED NEURONS, ANHYDRAMNIOS, RENAL DYSPLASIA, CEREBELLAR HYPOPLASIA, AND HYDRANENCEPHALY; MARCH" -"OMIM:236600","HYDROCEPHALUS, NONSYNDROMIC, AUTOSOMAL RECESSIVE 1; HYC1" -"OMIM:616680","SPASTIC PARAPLEGIA 75, AUTOSOMAL RECESSIVE; SPG75" -"OMIM:236635","HYDROCEPHALUS DUE TO CONGENITAL STENOSIS OF AQUEDUCT OF SYLVIUS" -"OMIM:616681","MICROCEPHALY 16, PRIMARY, AUTOSOMAL RECESSIVE; MCPH16" -"DOID:9060","pityriasis versicolor" -"OMIM:616682","SEIZURES, SCOLIOSIS, AND MACROCEPHALY SYNDROME; SSMS" -"OMIM:236640","HYDROCEPHALUS WITH ASSOCIATED MALFORMATIONS" -"DOID:1943","telogen effluvium" -"DOID:14784","olivopontocerebellar atrophy" -"OMIM:236660","HYDROCEPHALUS, TALL STATURE, JOINT LAXITY, AND KYPHOSCOLIOSIS" -"DOID:7577","pancreatic foamy gland adenocarcinoma" -"OMIM:616683","LEUKODYSTROPHY, HYPOMYELINATING, 12; HLD12" -"OMIM:236670","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 1; MDDGA1" -"OMIM:616684","CHARCOT-MARIE-TOOTH DISEASE, TYPE 4K; CMT4K" -"DOID:4468","clear cell adenocarcinoma" -"OMIM:236680","HYDROLETHALUS SYNDROME 1; HLS1" -"OMIM:616685","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 14; EIG14" -"DOID:3534","Lafora disease" -"DOID:657","adenoma" -"OMIM:616687","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2Y; CMT2Y" -"OMIM:236690","HYDROCEPHALUS, NORMAL-PRESSURE" -"OMIM:616688","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2Z; CMT2Z" -"OMIM:236700","MCKUSICK-KAUFMAN SYNDROME; MKKS" -"OMIM:616689","DEHYDRATED HEREDITARY STOMATOCYTOSIS 2; DHS2" -"OMIM:236730","UROFACIAL SYNDROME 1; UFS1" -"OMIM:616697","DEAFNESS, AUTOSOMAL DOMINANT 69; DFNA69" -"OMIM:236750","HYDROPS FETALIS, NONIMMUNE; NIHF" -"OMIM:616705","DEAFNESS, AUTOSOMAL RECESSIVE 97; DFNB97" -"OMIM:236792","L-2-HYDROXYGLUTARIC ACIDURIA; L2HGA" -"DOID:0050744","anaplastic large cell lymphoma" -"OMIM:236795","3-HYDROXYISOBUTYRIC ACIDURIA" -"OMIM:616707","DEAFNESS, AUTOSOMAL DOMINANT 68; DFNA68" -"DOID:13413","hepatic encephalopathy" -"OMIM:236800","HYDROXYKYNURENINURIA" -"OMIM:616708","DESANTO-SHINAWI SYNDROME; DESSH" -"OMIM:236900","HYDROXYLYSINURIA" -"OMIM:616710","PARKINSON DISEASE 22, AUTOSOMAL DOMINANT; PARK22" -"DOID:14018","alcoholic liver cirrhosis" -"OMIM:616716","RHIZOMELIC CHONDRODYSPLASIA PUNCTATA, TYPE 5; RCDP5" -"OMIM:237000","HYDROXYPROLINEMIA" -"OMIM:148100","KELOID FORMATION" -"OMIM:616719","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 21; SCAR21" -"OMIM:237100","HYMEN, IMPERFORATE" -"DOID:0060374","orofaciodigital syndrome IV" -"DOID:0090105","autosomal recessive hypercholesterolemia" -"DOID:0060375","orofaciodigital syndrome V" -"DOID:0060382","orofaciodigital syndrome IX" -"DOID:0050943","spastic ataxia 4" -"DOID:4413","cervix melanoma" -"DOID:13450","coccidioidomycosis" -"DOID:0060269","pontocerebellar hypoplasia type 2C" -"DOID:0060381","orofaciodigital syndrome XI" -"DOID:9155","mucocutaneous leishmaniasis" -"DOID:0060316","orofaciodigital syndrome I" -"DOID:0060373","orofaciodigital syndrome III" -"DOID:0080005","bone remodeling disease" -"DOID:10627","primary optic atrophy" -"DOID:0060265","pontocerebellar hypoplasia type 1A" -"DOID:0110105","atopic dermatitis 9" -"DOID:0060166","bipolar ll disorder" -"DOID:0050772","spastic ataxia 1" -"DOID:9854","lingual-facial-buccal dyskinesia" -"DOID:845","cyclothymic disorder" -"DOID:0060378","orofaciodigital syndrome VIII" -"DOID:5731","chronic salpingitis" -"DOID:0060377","orofaciodigital syndrome VII" -"DOID:66","muscle tissue disease" -"DOID:0110976","brachydactyly type E2" -"DOID:0050338","primary bacterial infectious disease" -"DOID:12087","deep corneal vascularisation" -"DOID:14121","blue toe syndrome" -"DOID:8688","tonsillar pillar cancer" -"DOID:0050945","spastic ataxia 7" -"DOID:8937","Waldeyer's ring cancer" -"DOID:8556","vallecula cancer" -"DOID:0110753","type 1 diabetes mellitus 15" -"DOID:2614","serous surface papilloma" -"DOID:0080010","bone structure disease" -"DOID:8858","tonsil cancer" -"DOID:10972","salpingo-oophoritis" -"DOID:0110380","retinitis pigmentosa 62" -"OMIM:616720","MYASTHENIC SYNDROME, CONGENITAL, 19; CMS19" -"DOID:14669","acrodysostosis" -"OMIM:603956","CERVICAL CANCER" -"DOID:0060201","amyotrophic lateral sclerosis type 10" -"OMIM:612776","HYPOGLOSSIA WITH SITUS INVERSUS" -"OMIM:616721","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIn; CDG2N" -"OMIM:603964","DEAFNESS, AUTOSOMAL DOMINANT 16; DFNA16" -"DOID:0060355","amyotrophic lateral sclerosis type 22" -"OMIM:612777","HYPOTONIA, SEIZURES, AND PRECOCIOUS PUBERTY" -"OMIM:616722","RETINAL DYSTROPHY AND IRIS COLOBOMA WITH OR WITHOUT CONGENITAL CATARACT; RDICC" -"DOID:0110409","retinitis pigmentosa 46" -"OMIM:603965","FOCAL SEGMENTAL GLOMERULOSCLEROSIS 2; FSGS2" -"OMIM:612780","SEIZURES, SENSORINEURAL DEAFNESS, ATAXIA, MENTAL RETARDATION, AND ELECTROLYTE IMBALANCE; SESAMES" -"OMIM:108600","SPASTIC ATAXIA 1, AUTOSOMAL DOMINANT; SPAX1" -"DOID:0060207","amyotrophic lateral sclerosis type 16" -"OMIM:612781","ISOLATED GROWTH HORMONE DEFICIENCY, TYPE IB; IGHD1B" -"OMIM:604004","MEGALENCEPHALIC LEUKOENCEPHALOPATHY WITH SUBCORTICAL CYSTS 1; MLC1" -"OMIM:616723","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, FADEN-ALKURAYA TYPE; SEMDFA" -"OMIM:164180","OCULOCEREBROCUTANEOUS SYNDROME" -"OMIM:108721","ATELOSTEOGENESIS, TYPE III; AO3" -"OMIM:133200","ERYTHROKERATODERMIA VARIABILIS ET PROGRESSIVA 1; EKVP1" -"DOID:0060208","amyotrophic lateral sclerosis type 17" -"OMIM:616724","TOOTH AGENESIS, SELECTIVE, 7; STHAG7" -"OMIM:612782","IMMUNODEFICIENCY 9; IMD9" -"OMIM:604060","DEAFNESS, AUTOSOMAL RECESSIVE 20; DFNB20" -"OMIM:100800","ACHONDROPLASIA; ACH" -"OMIM:604091","HYPOALPHALIPOPROTEINEMIA, PRIMARY" -"OMIM:612783","IMMUNODEFICIENCY 10; IMD10" -"OMIM:108650","SPASTIC ATAXIA 7, AUTOSOMAL DOMINANT; SPAX7" -"OMIM:616726","CILIARY DYSKINESIA, PRIMARY, 33; CILD33" -"OMIM:164170","NYSTAGMUS, VOLUNTARY" -"OMIM:616728","CLEFT PALATE, PSYCHOMOTOR RETARDATION, AND DISTINCTIVE FACIAL FEATURES; CPRF" -"OMIM:604093","KERATOSIS PILARIS ATROPHICANS; KPA" -"OMIM:612785","MEGARBANE-JALKH SYNDROME" -"OMIM:133260","ESTERASE B; ESB" -"OMIM:612789","DEAFNESS, AUTOSOMAL RECESSIVE 71; DFNB71" -"OMIM:604116","CONE-ROD DYSTROPHY 3; CORD3" -"OMIM:616730","NEPHROTIC SYNDROME, TYPE 11; NPHS11" -"OMIM:108340","ARYL HYDROCARBON HYDROXYLASE INDUCIBILITY" -"OMIM:612794","ATRIAL SEPTAL DEFECT 5; ASD5" -"OMIM:604117","VOHWINKEL SYNDROME, VARIANT FORM" -"OMIM:616732","OPTIC ATROPHY 10 WITH OR WITHOUT ATAXIA, MENTAL RETARDATION, AND SEIZURES; OPA10" -"DOID:3755","antithrombin III deficiency" -"OMIM:133240","ESOPHAGEAL RING, LOWER" -"OMIM:604121","CEREBELLAR ATAXIA, DEAFNESS, AND NARCOLEPSY, AUTOSOMAL DOMINANT; ADCADN" -"OMIM:616733","COENZYME Q10 DEFICIENCY, PRIMARY, 8; COQ10D8" -"OMIM:612795","POLYUNSATURATED FATTY ACIDS PLASMA LEVEL QUANTITATIVE TRAIT LOCUS 1; PUFAQTL1" -"DOID:9392","tracheitis" -"DOID:14095","boutonneuse fever" -"DOID:4546","pediatric mesenchymal chondrosarcoma" -"DOID:0110067","juvenile amyotrophic lateral sclerosis with dementia" -"OMIM:604129","EPIDERMOLYSIS BULLOSA PRURIGINOSA" -"OMIM:616734","SKIN CREASES, CONGENITAL SYMMETRIC CIRCUMFERENTIAL, 2; CSCSC2" -"OMIM:612796","INFLAMMATORY BOWEL DISEASE 27; IBD27" -"DOID:0060196","amyotrophic lateral sclerosis type 4" -"OMIM:616736","TREMOR, HEREDITARY ESSENTIAL, 5; ETM5" -"OMIM:612797","HIGH DENSITY LIPOPROTEIN CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 12; HDLCQ12" -"OMIM:133270","ESTERASE C; ESC" -"OMIM:108320","ARTICHOKE, MODIFICATION OF TASTE BY" -"OMIM:101000","NEUROFIBROMATOSIS, TYPE II; NF2" -"DOID:0110367","retinitis pigmentosa 38" -"OMIM:604131","ALPHA-THALASSEMIA" -"OMIM:604145","CARDIOMYOPATHY, DILATED, 1G; CMD1G" -"OMIM:612798","QUESTION MARK EARS, ISOLATED; QME" -"OMIM:616737","TAKENOUCHI-KOSAKI SYNDROME; TKS" -"OMIM:164200","OCULODENTODIGITAL DYSPLASIA; ODDD" -"DOID:0110369","retinitis pigmentosa 47" -"OMIM:616738","RADIOULNAR SYNOSTOSIS WITH AMEGAKARYOCYTIC THROMBOCYTOPENIA 2; RUSAT2" -"OMIM:604154","ALZHEIMER DISEASE WITHOUT NEUROFIBRILLARY TANGLES" -"OMIM:133100","ERYTHROCYTOSIS, FAMILIAL, 1; ECYT1" -"OMIM:612813","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, AGGRECAN TYPE; SEMDAG" -"OMIM:616739","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 51; MRT51" -"OMIM:604168","CONGENITAL CATARACTS, FACIAL DYSMORPHISM, AND NEUROPATHY; CCFDN" -"OMIM:612838","BRUGADA SYNDROME 5; BRGDA5" -"DOID:8747","subacute myeloid leukemia" -"OMIM:604169","LEFT VENTRICULAR NONCOMPACTION 1; LVNC1" -"OMIM:100700","ACHARD SYNDROME" -"OMIM:616740","IMMUNODEFICIENCY 46; IMD46" -"DOID:0110405","retinitis pigmentosa 36" -"DOID:235","colonic benign neoplasm" -"DOID:3113","papillary carcinoma" -"DOID:783","end stage renal failure" -"OMIM:604172","CARONTE" -"OMIM:616744","AUTOINFLAMMATORY SYNDROME, FAMILIAL, BEHCET-LIKE; AISBL" -"OMIM:108725","ATHEROSCLEROSIS SUSCEPTIBILITY; ATHS" -"OMIM:612841","HYPOTRICHOSIS 5; HYPT5" -"OMIM:612843","KERATOSIS FOLLICULARIS SPINULOSA DECALVANS, AUTOSOMAL DOMINANT; KFSD" -"OMIM:616749","HETEROTAXY, VISCERAL, 7, AUTOSOMAL; HTX7" -"OMIM:604173","POIKILODERMA WITH NEUTROPENIA; PN" -"OMIM:100820","ACHOO SYNDROME" -"OMIM:616754","BOMBAY PHENOTYPE" -"OMIM:101120","ACROCEPHALOPOLYSYNDACTYLY TYPE III" -"OMIM:612847","BRACHYOLMIA TYPE 4 WITH MILD EPIPHYSEAL AND METAPHYSEAL CHANGES; BCYM4" -"OMIM:604183","CHOLESTEATOMA, CONGENITAL" -"OMIM:164230","OBSESSIVE-COMPULSIVE DISORDER; OCD" -"OMIM:604185","FACIAL PARESIS, HEREDITARY CONGENITAL, 2; HCFP2" -"OMIM:612851","NARCOLEPSY 5, SUSCEPTIBILITY TO; NRCLP5" -"DOID:224","transient cerebral ischemia" -"DOID:0110383","retinitis pigmentosa 7" -"OMIM:616756","SPASTIC PARAPLEGIA AND PSYCHOMOTOR RETARDATION WITH OR WITHOUT SEIZURES; SPPRS" -"DOID:10611","protein-losing enteropathy" -"OMIM:108390","ASPARAGUS, SPECIFIC SMELL HYPERSENSITIVITY" -"OMIM:616760","WOOLLY HAIR, AUTOSOMAL RECESSIVE 3; ARWH3" -"OMIM:100675","ACETAMINOPHEN METABOLISM" -"DOID:1984","rectal neoplasm" -"DOID:10605","short bowel syndrome" -"OMIM:133239","ESOPHAGEAL CANCER" -"OMIM:616763","LEUKODYSTROPHY AND ACQUIRED MICROCEPHALY WITH OR WITHOUT DYSTONIA; LDAMD" -"OMIM:612853","RESTLESS LEGS SYNDROME, SUSCEPTIBILITY TO, 7; RLS7" -"OMIM:604201","HEPATIC FIBROSIS, SEVERE, SUSCEPTIBILITY TO, DUE TO SCHISTOSOMA MANSONI INFECTION" -"OMIM:604211","HIRSCHSPRUNG DISEASE WITH HEART DEFECTS, LARYNGEAL ANOMALIES, AND PREAXIAL POLYDACTYLY" -"OMIM:616777","SECKEL SYNDROME 9; SCKL9" -"OMIM:612858","OROFACIAL CLEFT 12; OFC12" -"OMIM:108700","ATAXIA WITH FASCICULATIONS" -"DOID:0060118","thoracic disease" -"OMIM:164280","FEINGOLD SYNDROME 1; FGLDS1" -"OMIM:604213","CHUDLEY-MCCULLOUGH SYNDROME; CMCS" -"OMIM:616779","CEREBRAL ARTERIOPATHY, AUTOSOMAL DOMINANT, WITH SUBCORTICAL INFARCTS AND LEUKOENCEPHALOPATHY, TYPE 2; CADASIL2" -"OMIM:164185","OCULAR CICATRICIAL PEMPHIGOID; OCP" -"OMIM:612862","PULMONARY HYPERTENSION, CHRONIC THROMBOEMBOLIC, WITHOUT DEEP VEIN THROMBOSIS, SUSCEPTIBILITY TO" -"OMIM:604218","ENCEPHALOPATHY, FAMILIAL, WITH NEUROSERPIN INCLUSION BODIES; FENIB" -"OMIM:612863","CHROMOSOME 6q24-q25 DELETION SYNDROME" -"OMIM:616780","OOCYTE MATURATION DEFECT 2; OOMD2" -"DOID:0060313","tracheomalacia" -"OMIM:604219","CATARACT 9, MULTIPLE TYPES; CTRCT9" -"OMIM:616781","JOUBERT SYNDROME 25; JBTS25" -"OMIM:612867","CORNEAL DYSTROPHY, SUBEPITHELIAL MUCINOUS; SMCD" -"OMIM:108720","ATELOSTEOGENESIS, TYPE I; AO1" -"DOID:5119","ovarian cyst" -"OMIM:612868","CORNEAL DYSTROPHY, POSTERIOR AMORPHOUS; PACD" -"OMIM:616784","JOUBERT SYNDROME 26; JBTS26" -"DOID:11263","chlamydia" -"OMIM:604229","ANTERIOR SEGMENT DYSGENESIS 5; ASGD5" -"OMIM:164210","HEMIFACIAL MICROSOMIA; HFM" -"DOID:0110869","congenital stationary night blindness 1E" -"OMIM:616788","OROFACIAL CLEFT 15; OFC15" -"OMIM:604232","LEBER CONGENITAL AMAUROSIS 3; LCA3" -"OMIM:612874","ERYTHROCYTE AMP DEAMINASE DEFICIENCY" -"OMIM:612875","GONADOTROPIN-RELEASING HORMONE RECEPTOR 2; GNRHR2" -"OMIM:616789","MENTAL RETARDATION AND DISTINCTIVE FACIAL FEATURES WITH OR WITHOUT CARDIAC DEFECTS; MRFACD" -"DOID:13608","biliary atresia" -"DOID:1495","cystic echinococcosis" -"OMIM:108760","ATRESIA OF EXTERNAL AUDITORY CANAL AND CONDUCTIVE DEAFNESS" -"OMIM:133180","ERYTHROLEUKEMIA, FAMILIAL" -"DOID:12177","common variable immunodeficiency" -"OMIM:164220","SCHILBACH-ROTT SYNDROME" -"OMIM:616792","NEUROBLASTOMA, SUSCEPTIBILITY TO, 7; NBLST7" -"OMIM:604250","HEMOCHROMATOSIS, TYPE 3; HFE3" -"DOID:8590","acute vascular insufficiency of intestine" -"OMIM:612876","SPINOCEREBELLAR ATAXIA 9; SCA9" -"OMIM:164190","OCULAR DOMINANCE" -"OMIM:133300","ESTERASE ES-2, REGULATOR FOR" -"DOID:0060205","amyotrophic lateral sclerosis type 14" -"OMIM:616794","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 28; COXPD28" -"OMIM:604254","DYSLEXIA, SUSCEPTIBILITY TO, 3; DYX3" -"OMIM:612877","CARDIOMYOPATHY, DILATED, 1BB; CMD1BB" -"OMIM:108420","SPERMATOGENIC FAILURE 2; SPGF2" -"DOID:2744","pyelitis" -"OMIM:612881","CHROMOSOME 5q14.3 DELETION SYNDROME, DISTAL" -"OMIM:604257","CAMERA-MARUGO-COHEN SYNDROME" -"OMIM:133190","SPINOCEREBELLAR ATAXIA 34; SCA34" -"OMIM:616795","SPINOCEREBELLAR ATAXIA 42; SCA42" -"DOID:0060848","early infantile epileptic encephalopathy 9" -"OMIM:604271","GROWTH HORMONE INSENSITIVITY, PARTIAL; GHIP" -"OMIM:612882","MENARCHE, AGE AT, QUANTITATIVE TRAIT LOCUS 2; MENAQ2" -"OMIM:108450","ASYMMETRIC SHORT STATURE SYNDROME" -"OMIM:616801","HYPOTONIA, INFANTILE, WITH PSYCHOMOTOR RETARDATION AND CHARACTERISTIC FACIES 2; IHPRF2" -"OMIM:616803","LAMB-SHAFFER SYNDROME; LAMSHF" -"DOID:14224","tracheal calcification" -"OMIM:612883","MENARCHE, AGE AT, QUANTITATIVE TRAIT LOCUS 3; MENAQ3" -"DOID:2595","glottis cancer" -"DOID:2977","primary hyperoxaluria" -"OMIM:164150","NYSTAGMUS, HEREDITARY VERTICAL" -"OMIM:604273","MITOCHONDRIAL COMPLEX V (ATP SYNTHASE) DEFICIENCY, NUCLEAR TYPE 1; MC5DN1" -"OMIM:604278","RENAL TUBULAR ACIDOSIS, PROXIMAL, WITH OCULAR ABNORMALITIES AND MENTAL RETARDATION" -"OMIM:616806","WILMS TUMOR 6; WT6" -"OMIM:108300","STICKLER SYNDROME, TYPE I; STL1" -"OMIM:100600","ACANTHOSIS NIGRICANS" -"OMIM:108500","EPISODIC ATAXIA, TYPE 2; EA2" -"OMIM:612884","MENOPAUSE, NATURAL, AGE AT, QUANTITATIVE TRAIT LOCUS 2; MENOQ2" -"OMIM:133020","ERYTHERMALGIA, PRIMARY" -"DOID:3227","tracheal stenosis" -"OMIM:616809","HYPERPHOSPHATASIA WITH MENTAL RETARDATION SYNDROME 6; HPMRS6" -"OMIM:604286","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2E; LGMD2E" -"OMIM:612885","PREMATURE OVARIAN FAILURE 10; POF10" -"DOID:3118","hepatobiliary disease" -"OMIM:274265","THYMIC-RENAL-ANAL-LUNG DYSPLASIA" -"DOID:13117","paronychia" -"OMIM:274270","DIHYDROPYRIMIDINE DEHYDROGENASE DEFICIENCY" -"DOID:11256","typhus" -"DOID:0110653","long QT syndrome 12" -"DOID:0110759","type 1 diabetes mellitus 22" -"OMIM:274300","THYROID HORMONE RESISTANCE, GENERALIZED, AUTOSOMAL RECESSIVE; GRTH" -"OMIM:176690","PROGEROID SHORT STATURE WITH PIGMENTED NEVI" -"OMIM:274400","THYROID DYSHORMONOGENESIS 1; TDH1" -"DOID:2123","tularemia" -"OMIM:274500","THYROID DYSHORMONOGENESIS 2A; TDH2A" -"DOID:0110651","long QT syndrome 10" -"DOID:0090027","split hand-foot malformation 2" -"OMIM:176670","HUTCHINSON-GILFORD PROGERIA SYNDROME; HGPS" -"DOID:9667","placental abruption" -"DOID:0060757","sclerosteosis 2" -"DOID:0110654","long QT syndrome 13" -"DOID:231","motor neuron disease" -"OMIM:274600","PENDRED SYNDROME; PDS" -"DOID:7551","gonorrhea" -"OMIM:274700","THYROID DYSHORMONOGENESIS 3; TDH3" -"DOID:0080176","meningococcal meningitis" -"OMIM:274800","THYROID DYSHORMONOGENESIS 4; TDH4" -"DOID:11382","corneal neovascularization" -"DOID:0050697","chorioamnionitis" -"OMIM:274900","THYROID DYSHORMONOGENESIS 5; TDH5" -"DOID:754","bladder tuberculosis" -"OMIM:275000","GRAVES DISEASE, SUSCEPTIBILITY TO, 1; GRD1" -"DOID:2842","Jervell-Lange Nielsen syndrome" -"DOID:1022","pinta disease" -"OMIM:275100","HYPOTHYROIDISM, CONGENITAL, NONGOITROUS, 4; CHNG4" -"DOID:11338","tetanus" -"DOID:7061","precursor B lymphoblastic lymphoma/leukemia" -"OMIM:275120","THYROTROPIN-RELEASING HORMONE DEFICIENCY" -"DOID:0110648","long QT syndrome 6" -"DOID:14271","acute cholangitis" -"DOID:9043","uterine cervix leukoplakia" -"OMIM:275190","TIGLIC ACIDEMIA" -"DOID:13431","bejel" -"OMIM:275200","HYPOTHYROIDISM, CONGENITAL, NONGOITROUS, 1; CHNG1" -"DOID:0110650","long QT syndrome 9" -"OMIM:275210","RESTRICTIVE DERMOPATHY, LETHAL" -"DOID:5052","melioidosis" -"DOID:2348","arteriosclerotic cardiovascular disease" -"DOID:6758","chest wall lymphoma" -"DOID:10458","legionellosis" -"OMIM:275220","TIBIAL HEMIMELIA" -"DOID:0090024","split hand-foot malformation 1 with sensorineural hearing loss" -"DOID:2755","Mycobacterium avium complex disease" -"OMIM:275230","TIBIA, ABSENCE OF, WITH CONGENITAL DEAFNESS" -"DOID:0110646","long QT syndrome 3" -"DOID:11102","bartonellosis" -"DOID:9681","cervical incompetence" -"OMIM:275240","TINEA IMBRICATA, SUSCEPTIBILITY TO" -"DOID:0110741","type 1 diabetes mellitus 2" -"DOID:2059","vulvar disease" -"OMIM:275250","TONGUE, PIGMENTED FUNGIFORM PAPILLAE OF" -"DOID:13778","chancroid" -"OMIM:275300","TRACHEOBRONCHOMEGALY" -"DOID:11055","pasteurellosis" -"DOID:0110652","long QT syndrome 11" -"OMIM:275350","TRANSCOBALAMIN II DEFICIENCY" -"DOID:2251","hypertrophic elongation of cervix" -"DOID:0090023","split hand-foot malformation 4" -"DOID:0110647","long QT syndrome 5" -"OMIM:275355","SQUAMOUS CELL CARCINOMA, HEAD AND NECK; HNSCC" -"DOID:0060859","salmonellosis" -"DOID:0050116","tinea imbricata" -"DOID:0110750","type 1 diabetes mellitus 11" -"DOID:0090022","split hand-foot malformation 5" -"OMIM:275370","TRICARBOXYLIC ACID CYCLE, DEFECT OF" -"DOID:11100","Q fever" -"OMIM:275400","OLIVER-MCFARLANE SYNDROME; OMCS" -"DOID:0090025","split hand-foot malformation 3" -"DOID:8455","pyridoxine deficiency anemia" -"DOID:13034","relapsing fever" -"OMIM:275450","TRICHOODONTOONYCHIAL DYSPLASIA WITH BONE DEFICIENCY" -"DOID:0090026","split hand-foot malformation 6" -"DOID:7427","anthrax disease" -"OMIM:275595","TRIGONOBRACHYCEPHALY, BULBOUS BIFID NOSE, MICROGNATHIA, AND ABNORMALITIES OF THE HANDS AND FEET" -"DOID:0110644","long QT syndrome 1" -"DOID:2297","leptospirosis" -"OMIM:275630","CHANARIN-DORFMAN SYNDROME; CDS" -"DOID:96","staphyloenterotoxemia" -"OMIM:275900","SPASTIC PARAPLEGIA 20, AUTOSOMAL RECESSIVE; SPG20" -"OMIM:276100","TRYPTOPHANURIA WITH DWARFISM" -"DOID:3482","plague" -"DOID:0060756","sclerosteosis 1" -"OMIM:276200","T-SUBSTANCE ANOMALY" -"DOID:3456","cervix erosion" -"DOID:8644","gastroduodenitis" -"OMIM:276300","MISMATCH REPAIR CANCER SYNDROME; MMRCS" -"DOID:0090021","split hand-foot malformation 1" -"OMIM:276400","TWINNING, DIZYGOTIC" -"DOID:0060892","late onset Parkinson disease" -"DOID:10242","ehrlichiosis" -"OMIM:276410","TWINNING, MONOZYGOTIC" -"DOID:2364","post-thrombotic syndrome" -"OMIM:276600","TYROSINEMIA, TYPE II; TYRSN2" -"DOID:0110971","brachydactyly type D" -"DOID:12384","dysentery" -"DOID:9923","developmental coordination disorder" -"OMIM:276700","TYROSINEMIA, TYPE I; TYRSN1" -"DOID:9113","granuloma inguinale" -"DOID:10371","yaws" -"OMIM:276710","TYROSINEMIA, TYPE III; TYRSN3" -"DOID:0060325","cervical polyp" -"DOID:3042","allergic contact dermatitis" -"DOID:1564","fungal infectious disease" -"DOID:3507","dermatofibrosarcoma protuberans" -"DOID:0060749","familial temporal lobe epilepsy 6" -"DOID:11476","osteoporosis" -"OMIM:153480","BANNAYAN-RILEY-RUVALCABA SYNDROME; BRRS" -"OMIM:153400","LYMPHEDEMA-DISTICHIASIS SYNDROME" -"DOID:0050749","peripheral T-cell lymphoma" -"OMIM:153600","MACROGLOBULINEMIA, WALDENSTROM, SUSCEPTIBILITY TO, 1; WM1" -"OMIM:176270","PRADER-WILLI SYNDROME; PWS" -"DOID:9351","diabetes mellitus" -"OMIM:153290","LYMPHOCYTE CYTOSOL POLYPEPTIDE, 49-KD" -"OMIM:153670","BERNARD-SOULIER SYNDROME, TYPE A2, AUTOSOMAL DOMINANT; BSSA2" -"DOID:0050562","West syndrome" -"DOID:11968","postmenopausal atrophic vaginitis" -"OMIM:153280","LYMPHOCYTE CYTOSOL POLYPEPTIDE, 40-KD" -"DOID:8805","intermediate coronary syndrome" -"DOID:0060752","familial temporal lobe epilepsy 5" -"DOID:4397","granulomatous dermatitis" -"OMIM:153800","MACULAR DEGENERATION, AGE-RELATED, 2; ARMD2" -"OMIM:153300","YELLOW NAIL SYNDROME" -"OMIM:153630","MACROGLOSSIA" -"DOID:0111169","subcortical band heterotopia" -"OMIM:153650","EPSTEIN SYNDROME; EPSTNS" -"OMIM:153640","FECHTNER SYNDROME; FTNS" -"DOID:1398","parasitic infectious disease" -"DOID:0060754","familial temporal lobe epilepsy 8" -"DOID:10690","mastitis" -"DOID:10923","sickle cell anemia" -"DOID:10938","paranoid personality disorder" -"DOID:0060750","familial temporal lobe epilepsy 3" -"OMIM:153470","MACROCEPHALY, BENIGN FAMILIAL" -"DOID:6376","hypersplenism" -"DOID:12365","malaria" -"DOID:0110857","posterior polymorphous corneal dystrophy 3" -"OMIM:153700","MACULAR DYSTROPHY, VITELLIFORM, 2; VMD2" -"DOID:0050862","pyometritis" -"DOID:10556","supine hypotensive syndrome" -"DOID:0110855","posterior polymorphous corneal dystrophy 1" -"DOID:288","endometriosis of uterus" -"DOID:0060751","familial temporal lobe epilepsy 7" -"DOID:9821","choroideremia" -"DOID:2253","cervix disease" -"DOID:11723","Duchenne Muscular Dystrophy" -"DOID:1785","pituitary cancer" -"DOID:1005","endometrial disease" -"DOID:4054","prostate sarcoma" -"DOID:13736","uterine inflammatory disease" -"OMIM:153550","CHROMOSOME 5q DELETION SYNDROME" -"DOID:12297","Vogt-Koyanagi-Harada disease" -"DOID:104","bacterial infectious disease" -"DOID:13812","adhesions of uterus" -"OMIM:179900","RETINAL APLASIA" -"DOID:12223","specific bursitis often of occupational origin" -"DOID:11190","pseudomembranous conjunctivitis" -"OMIM:616811","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 29; COXPD29" -"OMIM:612886","MENOPAUSE, NATURAL, AGE AT, QUANTITATIVE TRAIT LOCUS 4; MENOQ4" -"DOID:5733","salpingitis" -"OMIM:616812","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2X; LGMD2X" -"OMIM:612892","STATURE QUANTITATIVE TRAIT LOCUS 18; STQTL18" -"OMIM:612893","STATURE QUANTITATIVE TRAIT LOCUS 19; STQTL19" -"DOID:3672","rhabdoid cancer" -"DOID:11752","acute endophthalmitis" -"OMIM:616814","PREIMPLANTATION EMBRYONIC LETHALITY 1; PREMBL1" -"OMIM:612894","STATURE QUANTITATIVE TRAIT LOCUS 20; STQTL20" -"OMIM:616816","HYPOTONIA, INFANTILE, WITH PSYCHOMOTOR RETARDATION; IHPMR" -"OMIM:616817","MICROCEPHALY, SHORT STATURE, AND IMPAIRED GLUCOSE METABOLISM 2; MSSGM2" -"OMIM:612899","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 8; EIG8" -"OMIM:616818","IgA NEPHROPATHY, SUSCEPTIBILITY TO, 3; IGAN3" -"OMIM:612900","CEREBRAL PALSY, SPASTIC QUADRIPLEGIC, 2; CPSQ2" -"OMIM:612908","KERATOSIS PALMOPLANTARIS STRIATA II; PPKS2" -"OMIM:616819","CORPUS CALLOSUM, AGENESIS OF, WITH FACIAL ANOMALIES AND CEREBELLAR ATAXIA; CCAFCA" -"OMIM:616827","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2W; LGMD2W" -"OMIM:612913","OROFACIODIGITAL SYNDROME XI; OFD11" -"OMIM:612916","ZECHI-CEIDE SYNDROME" -"OMIM:616828","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIo; CDG2O" -"OMIM:612917","GIACHETI SYNDROME" -"OMIM:616829","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIp; CDG2P" -"OMIM:612918","CONGENITAL LIPOMATOUS OVERGROWTH, VASCULAR MALFORMATIONS, AND EPIDERMAL NEVI" -"OMIM:616831","LUSCAN-LUMISH SYNDROME; LLS" -"DOID:684","hepatocellular carcinoma" -"OMIM:616833","PAGET DISEASE OF BONE 6; PDB6" -"DOID:4051","alveolar rhabdomyosarcoma" -"OMIM:612921","THREE M SYNDROME 2; 3M2" -"OMIM:616834","MICROCEPHALY, CONGENITAL CATARACT, AND PSORIASIFORM DERMATITIS; MCCPD" -"OMIM:612922","HEMOLYTIC UREMIC SYNDROME, ATYPICAL, SUSCEPTIBILITY TO, 2; AHUS2" -"OMIM:612923","HEMOLYTIC UREMIC SYNDROME, ATYPICAL, SUSCEPTIBILITY TO, 3; AHUS3" -"OMIM:616835","MEIER-GORLIN SYNDROME 6; MGORS6" -"OMIM:612924","HEMOLYTIC UREMIC SYNDROME, ATYPICAL, SUSCEPTIBILITY TO, 4; AHUS4" -"OMIM:616839","EXERCISE INTOLERANCE, RIBOFLAVIN-RESPONSIVE; RREI" -"DOID:0110013","advanced sleep phase syndrome 3" -"DOID:11219","conjunctival folliculosis" -"OMIM:612925","HEMOLYTIC UREMIC SYNDROME, ATYPICAL, SUSCEPTIBILITY TO, 5; AHUS5" -"OMIM:616840","PARKINSON DISEASE 23, AUTOSOMAL RECESSIVE EARLY-ONSET; PARK23" -"DOID:12603","acute leukemia" -"OMIM:616843","LYMPHEDEMA, HEREDITARY, III; LMPH3" -"OMIM:612926","HEMOLYTIC UREMIC SYNDROME, ATYPICAL, SUSCEPTIBILITY TO, 6; AHUS6" -"DOID:4223","pyoderma" -"OMIM:616849","BRACHYDACTYLY, TYPE A1, D; BDA1D" -"OMIM:612929","MYCOBACTERIUM TUBERCULOSIS, SUSCEPTIBILITY TO, 3" -"OMIM:616851","CATARACT 45; CTRCT45" -"OMIM:612932","GLYCOGEN STORAGE DISEASE XIII; GSD13" -"OMIM:616852","MYOPATHY, SCAPULOHUMEROPERONEAL; SHPM" -"OMIM:612933","GLYCOGEN STORAGE DISEASE XI; GSD11" -"OMIM:616854","EVEN-PLUS SYNDROME; EVPLS" -"OMIM:612936","SPASTIC PARAPLEGIA 50, AUTOSOMAL RECESSIVE; SPG50" -"DOID:10182","diabetic peripheral angiopathy" -"DOID:10991","basal ganglia cerebrovascular disease" -"OMIM:612937","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Io; CDG1O" -"OMIM:616858","COWDEN SYNDROME 7; CWS7" -"DOID:10368","epididymis adenocarcinoma" -"OMIM:612938","GROWTH RETARDATION, DEVELOPMENTAL DELAY, AND FACIAL DYSMORPHISM; GDFD" -"OMIM:616859","SPASTICITY, CHILDHOOD-ONSET, WITH HYPERGLYCINEMIA; SPAHGC" -"OMIM:612940","CUTIS LAXA, AUTOSOMAL RECESSIVE, TYPE IIB; ARCL2B" -"OMIM:616860","ANEMIA, SIDEROBLASTIC, 3, PYRIDOXINE-REFRACTORY; SIDBA3" -"DOID:9282","ocular hypertension" -"OMIM:612943","RETINITIS PIGMENTOSA 42; RP42" -"OMIM:616863","CHROMOSOME 16p13.2 DELETION SYNDROME" -"OMIM:612946","HADZISELIMOVIC SYNDROME" -"OMIM:616866","SPINAL MUSCULAR ATROPHY WITH CONGENITAL BONE FRACTURES 1; SMABF1" -"DOID:0050135","subcutaneous mycosis" -"OMIM:612947","MICROCEPHALY, GROWTH RETARDATION, CATARACT, HEARING LOSS, AND UNUSUAL APPEARANCE" -"OMIM:616867","SPINAL MUSCULAR ATROPHY WITH CONGENITAL BONE FRACTURES 2; SMABF2" -"OMIM:616868","DIARRHEA 8, SECRETORY SODIUM, CONGENITAL; DIAR8" -"OMIM:612948","STARGARDT MACULAR DEGENERATION, ABSENT OR HYPOPLASTIC CORPUS CALLOSUM, MENTAL RETARDATION, AND DYSMORPHIC FEATURES" -"OMIM:616871","MYELOPROLIFERATIVE/LYMPHOPROLIFERATIVE NEOPLASMS, FAMILIAL (MULTIPLE TYPES), SUSCEPTIBILITY TO; MPLPF" -"OMIM:612949","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 39; EIEE39" -"OMIM:616873","IMMUNODEFICIENCY, COMMON VARIABLE, 13; CVID13" -"OMIM:612950","PSORIASIS 12, SUSCEPTIBILITY TO; PSORS12" -"OMIM:612951","LEUKOENCEPHALOPATHY, CYSTIC, WITHOUT MEGALENCEPHALY" -"OMIM:616875","CEREBELLAR ATROPHY, VISUAL IMPAIRMENT, AND PSYCHOMOTOR RETARDATION; CAVIPMR" -"DOID:0111069","congenital bile acid synthesis defect 2" -"OMIM:616878","METABOLIC ENCEPHALOMYOPATHIC CRISES, RECURRENT, WITH RHABDOMYOLYSIS, CARDIAC ARRHYTHMIAS, AND NEURODEGENERATION; MECRCN" -"OMIM:612952","AICARDI-GOUTIERES SYNDROME 5; AGS5" -"DOID:14243","chronic perichondritis of pinna" -"OMIM:612953","PARKINSON DISEASE 14, AUTOSOMAL RECESSIVE; PARK14" -"OMIM:616881","LEUKODYSTROPHY, HYPOMYELINATING, 13; HLD13" -"OMIM:612954","MYOPATHY, MYOFIBRILLAR, 6; MFM6" -"OMIM:616882","ADVANCED SLEEP PHASE SYNDROME, FAMILIAL, 3; FASPS3" -"DOID:50","thyroid gland disease" -"OMIM:612955","LONG QT SYNDROME 12; LQT12" -"OMIM:616887","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 52; MRT52" -"DOID:0050566","X-linked nonsyndromic deafness" -"OMIM:612956","VENTRICULAR FIBRILLATION, PAROXYSMAL FAMILIAL, 2; VF2" -"OMIM:616890","SPLIT-FOOT MALFORMATION WITH MESOAXIAL POLYDACTYLY; SFMMP" -"DOID:114","heart disease" -"OMIM:116920","LEUKOCYTE ADHESION DEFICIENCY, TYPE I; LAD" -"OMIM:116870","CELIAC ARTERY STENOSIS FROM COMPRESSION BY MEDIAN ARCUATE LIGAMENT OF DIAPHRAGM" -"DOID:4109","tick infestation" -"OMIM:117600","CEREBRAL SARCOMA" -"DOID:397","restrictive cardiomyopathy" -"DOID:3165","skin benign neoplasm" -"DOID:4977","lymphedema" -"DOID:12969","central nervous system leukemia" -"OMIM:117100","CENTRALOPATHIC EPILEPSY" -"DOID:10747","lymphoid leukemia" -"OMIM:116950","TEMPERATURE-SENSITIVE AF8 COMPLEMENT; AF8T" -"OMIM:117360","SPINOCEREBELLAR ATAXIA 29; SCA29" -"DOID:4289","micronodular basal cell carcinoma" -"OMIM:117550","SOTOS SYNDROME 1; SOTOS1" -"DOID:1037","lymphoblastic leukemia" -"DOID:0050748","marginal zone B-cell lymphoma" -"DOID:14004","thoracic aortic aneurysm" -"DOID:2568","cervicitis" -"OMIM:117300","CEREBRAL AMYLOID ANGIOPATHY, ITM2B-RELATED, 2" -"DOID:0050266","tungiasis" -"OMIM:117000","CENTRAL CORE DISEASE OF MUSCLE; CCD" -"DOID:3459","breast carcinoma" -"DOID:0060046","aphasia" -"OMIM:117210","SPINOCEREBELLAR ATAXIA 31; SCA31" -"OMIM:117650","CEREBROCOSTOMANDIBULAR SYNDROME; CCMS" -"DOID:11758","iron deficiency anemia" -"DOID:14681","Silver-Russell syndrome" -"DOID:11079","leech infestation" -"DOID:2170","vaginitis" -"DOID:1040","chronic lymphocytic leukemia" -"DOID:11080","myiasis" -"DOID:0050700","cardiomyopathy" -"DOID:4547","adult mesenchymal chondrosarcoma" -"OMIM:612957","VITAMIN B6 PLASMA LEVEL QUANTITATIVE TRAIT LOCUS 1; B6QTL1" -"OMIM:616892","NEPHROTIC SYNDROME, TYPE 12; NPHS12" -"DOID:367","olfactory nerve disease" -"OMIM:616893","NEPHROTIC SYNDROME, TYPE 13; NPHS13" -"DOID:0110970","brachydactyly type C" -"OMIM:180000","RETINAL ARTERIES, TORTUOSITY OF; RATOR" -"OMIM:612961","MULTIPLE SYNOSTOSES SYNDROME 3; SYNS3" -"OMIM:118450","ALAGILLE SYNDROME 1; ALGS1" -"DOID:10584","retinitis pigmentosa" -"OMIM:612964","PREMATURE OVARIAN FAILURE 7; POF7" -"OMIM:616894","ROBINOW SYNDROME, AUTOSOMAL DOMINANT 3; DRS3" -"OMIM:616896","MITOCHONDRIAL DNA DEPLETION SYNDROME 14 (CARDIOENCEPHALOMYOPATHIC TYPE); MTDPS14" -"OMIM:612965","46,XY SEX REVERSAL 3; SRXY3" -"OMIM:612967","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 15; BMIQ15" -"DOID:0050524","maturity-onset diabetes of the young" -"OMIM:616897","OSTEOCHONDRODYSPLASIA, COMPLEX LETHAL, SYMOENS-BARNES-GISTELINCK TYPE; OCLSBG" -"OMIM:616898","CHROMOSOME 15q14 DELETION SYNDROME" -"DOID:3512","neurofibrosarcoma" -"DOID:11457","brain compression" -"OMIM:612968","CATARACT 34, MULTIPLE TYPES; CTRCT34" -"OMIM:612970","NEUROBLASTOMA BREAKPOINT FAMILY, MEMBER 17, PSEUDOGENE; NBPF17P" -"OMIM:616900","HYPOTONIA, INFANTILE, WITH PSYCHOMOTOR RETARDATION AND CHARACTERISTIC FACIES 3; IHPRF3" -"DOID:1485","cystic fibrosis" -"OMIM:125630","VIBRATORY URTICARIA; VBU" -"OMIM:612975","SHORT SLEEPER" -"OMIM:616901","DEVELOPMENTAL DELAY WITH SHORT STATURE, DYSMORPHIC FEATURES, AND SPARSE HAIR; DEDSSH" -"OMIM:616902","CHROMOSOME 11p13 DELETION SYNDROME, DISTAL" -"OMIM:612976","AGE-RELATED HEARING IMPAIRMENT 2; ARHI2" -"OMIM:616903","THIOPURINES, POOR METABOLISM OF, 2; THPM2" -"OMIM:612989","OPTIC ATROPHY 7 WITH OR WITHOUT AUDITORY NEUROPATHY; OPA7" -"OMIM:118400","CHERUBISM" -"OMIM:612997","SPERMATOGENIC FAILURE 7; SPGF7" -"DOID:6053","pediatric germ cell cancer" -"OMIM:616907","SPASTIC PARAPLEGIA 76, AUTOSOMAL RECESSIVE; SPG76" -"OMIM:612998","EMERY-DREIFUSS MUSCULAR DYSTROPHY 4, AUTOSOMAL DOMINANT; EDMD4" -"DOID:5718","adrenal neuroblastoma" -"OMIM:616910","IMMUNODEFICIENCY-CENTROMERIC INSTABILITY-FACIAL ANOMALIES SYNDROME 3; ICF3" -"DOID:2669","Pacinian tumor" -"OMIM:612999","EMERY-DREIFUSS MUSCULAR DYSTROPHY 5, AUTOSOMAL DOMINANT; EDMD5" -"OMIM:616911","IMMUNODEFICIENCY-CENTROMERIC INSTABILITY-FACIAL ANOMALIES SYNDROME 4; ICF4" -"DOID:0060699","familial hypocalciuric hypercalcemia" -"OMIM:616913","BLEEDING DISORDER, PLATELET-TYPE, 20; BDPLT20" -"OMIM:125595","DERMATOPATHIA PIGMENTOSA RETICULARIS; DPR" -"OMIM:613000","PALMOPLANTAR KERATODERMA, NONEPIDERMOLYTIC, FOCAL 1; FNEPPK1" -"OMIM:616914","MARFAN LIPODYSTROPHY SYNDROME; MFLS" -"OMIM:613001","ENCEPHALOCRANIOCUTANEOUS LIPOMATOSIS; ECCL" -"DOID:3847","papillary craniopharyngioma" -"OMIM:125635","DERMOGRAPHISM, FAMILIAL" -"OMIM:613002","HERPES SIMPLEX ENCEPHALITIS, SUSCEPTIBILITY TO, 2" -"OMIM:616917","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 53; MRT53" -"OMIM:118430","CHLORPROPAMIDE-ALCOHOL FLUSHING; CPAF" -"OMIM:613003","ATTENTION DEFICIT-HYPERACTIVITY DISORDER, SUSCEPTIBILITY TO, 7" -"OMIM:616920","HEART AND BRAIN MALFORMATION SYNDROME; HBMS" -"OMIM:125580","DERMATOGLYPHICS--FINGER RIDGE COUNT" -"OMIM:616921","DYSKINESIA, LIMB AND OROFACIAL, INFANTILE-ONSET; IOLOD" -"OMIM:613005","SANTOS SYNDROME" -"OMIM:616922","STRIATAL DEGENERATION, AUTOSOMAL DOMINANT 2; ADSD2" -"OMIM:613006","DIABETES MELLITUS, INSULIN-DEPENDENT, 24; IDDM24" -"OMIM:125600","DERMATOSIS PAPULOSA NIGRA" -"OMIM:613007","BILIARY CIRRHOSIS, PRIMARY, 2; PBC2" -"OMIM:616924","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2CC; CMT2CC" -"DOID:8541","Sezary's disease" -"OMIM:613008","BILIARY CIRRHOSIS, PRIMARY, 3; PBC3" -"OMIM:616937","THROMBOCYTOPENIA 6; THC6" -"OMIM:613011","LYMPHOPROLIFERATIVE SYNDROME 1; LPFS1" -"OMIM:616938","COFFIN-SIRIS SYNDROME 5; CSS5" -"OMIM:125590","DERMATOGLYPHICS--FINGERPRINT PATTERN" -"OMIM:616939","CHOREA, CHILDHOOD-ONSET, WITH PSYCHOMOTOR RETARDATION; COCPMR" -"OMIM:613013","NEUROBLASTOMA, SUSCEPTIBILITY TO, 2; NBLST2" -"OMIM:613014","NEUROBLASTOMA, SUSCEPTIBILITY TO, 3; NBLST3" -"OMIM:616941","AGAMMAGLOBULINEMIA 8, AUTOSOMAL DOMINANT; AGM8" -"OMIM:118420","CHIARI MALFORMATION TYPE I" -"OMIM:616943","TRICHOTHIODYSTROPHY 6, NONPHOTOSENSITIVE; TTD6" -"OMIM:613015","NEUROBLASTOMA, SUSCEPTIBILITY TO, 4; NBLST4" -"OMIM:125700","DIABETES INSIPIDUS, NEUROHYPOPHYSEAL" -"OMIM:616944","MENTAL RETARDATION, AUTOSOMAL DOMINANT 41; MRD41" -"DOID:7148","rheumatoid arthritis" -"OMIM:613016","NEUROBLASTOMA, SUSCEPTIBILITY TO, 5; NBLST5" -"OMIM:616946","PREMATURE OVARIAN FAILURE 11; POF11" -"OMIM:613017","NEUROBLASTOMA, SUSCEPTIBILITY TO, 6; NBLST6" -"DOID:3491","Turner syndrome" -"DOID:14791","Leber congenital amaurosis" -"DOID:5149","epithelioid neurofibroma" -"OMIM:613021","BRONCHIECTASIS WITH OR WITHOUT ELEVATED SWEAT CHLORIDE 2; BESC2" -"OMIM:616947","PREMATURE OVARIAN FAILURE 12; POF12" -"OMIM:118330","CHEILITIS GLANDULARIS" -"OMIM:616948","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 22; SCAR22" -"DOID:0110973","Mononen-Karnes-Senac syndrome" -"OMIM:613024","FOLLICULAR LYMPHOMA, SUSCEPTIBILITY TO, 1; FL1" -"OMIM:613025","SCHIZOPHRENIA 13; SCZD13" -"OMIM:616949","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 23; SCAR23" -"DOID:8466","retinal degeneration" -"OMIM:616950","SPERMATOGENIC FAILURE 15; SPGF15" -"OMIM:613026","CHROMOSOME 19q13.11 DELETION SYNDROME, DISTAL" -"OMIM:125640","DERMOODONTODYSPLASIA" -"DOID:10319","mixed mineral dust pneumoconiosis" -"OMIM:613027","GLYCOGEN STORAGE DISEASE IXc; GSD9C" -"OMIM:616954","YOU-HOOVER-FONG SYNDROME; YHFS" -"OMIM:616958","DEAFNESS, AUTOSOMAL RECESSIVE 105; DFNB105" -"OMIM:613028","GLIOMA SUSCEPTIBILITY 2; GLM2" -"DOID:0110761","type 1 diabetes mellitus 24" -"OMIM:616959","RETINITIS PIGMENTOSA AND ERYTHROCYTIC MICROCYTOSIS; RPEM" -"OMIM:613029","GLIOMA SUSCEPTIBILITY 3; GLM3" -"OMIM:118350","CHEMODECTOMA, INTRAABDOMINAL, WITH CUTANEOUS ANGIOLIPOMAS" -"OMIM:613030","GLIOMA SUSCEPTIBILITY 5; GLM5" -"OMIM:616963","HYPERCALCEMIA, INFANTILE, 2; HCINF2" -"OMIM:613031","GLIOMA SUSCEPTIBILITY 6; GLM6" -"OMIM:616968","DEAFNESS, AUTOSOMAL DOMINANT 70; DFNA70" -"OMIM:242600","IMINOGLYCINURIA" -"DOID:520","aortic disease" -"OMIM:242670","CILIARY DYSKINESIA WITH DEFECTIVE RADIAL SPOKES" -"OMIM:242680","CILIARY DYSKINESIA WITH EXCESSIVELY LONG CILIA" -"OMIM:154370","MAMMASTATIN" -"OMIM:154780","MARSHALL SYNDROME; MRSHS" -"OMIM:242700","IMMUNE DEFECT DUE TO ABSENCE OF THYMUS" -"OMIM:242840","VICI SYNDROME; VICIS" -"OMIM:242850","IMMUNE DEFICIENCY DISEASE" -"DOID:6804","colon Kaposi sarcoma" -"DOID:12253","testicular lymphoma" -"OMIM:242860","IMMUNODEFICIENCY-CENTROMERIC INSTABILITY-FACIAL ANOMALIES SYNDROME 1; ICF1" -"OMIM:242870","IMMUNODEFICIENCY, PARTIAL COMBINED, WITH ABSENCE OF HLA DETERMINANTS AND BETA-2-MICROGLOBULIN FROM LYMPHOCYTES" -"DOID:0050746","mantle cell lymphoma" -"OMIM:154700","MARFAN SYNDROME; MFS" -"OMIM:154276","MALIGNANT HYPERTHERMIA, SUSCEPTIBILITY TO, 3" -"OMIM:242880","IMMUNOERYTHROMYELOID HYPOPLASIA" -"DOID:0060685","autosomal dominant nocturnal frontal lobe epilepsy 4" -"OMIM:242890","IMMUNOGLOBULIN D LEVEL IN PLASMA, LOW" -"OMIM:154275","MALIGNANT HYPERTHERMIA, SUSCEPTIBILITY TO, 2" -"OMIM:154600","MARCUS GUNN PHENOMENON" -"OMIM:242900","SCHIMKE IMMUNOOSSEOUS DYSPLASIA; SIOD" -"DOID:9346","Taylor's syndrome" -"DOID:576","proteinuria" -"OMIM:243000","INDIFFERENCE TO PAIN, CONGENITAL, AUTOSOMAL RECESSIVE; CIP" -"OMIM:243050","INDOLYLACROYL GLYCINURIA WITH MENTAL RETARDATION" -"OMIM:243060","SPERMATOGENIC FAILURE 5; SPGF5" -"OMIM:243080","INOSINE PHOSPHORYLASE DEFICIENCY, IMMUNE DEFECT DUE TO" -"OMIM:154400","ACROFACIAL DYSOSTOSIS 1, NAGER TYPE; AFD1" -"OMIM:243100","INTERNAL CAROTID ARTERIES, HYPOPLASIA OF" -"DOID:9146","visceral leishmaniasis" -"OMIM:243110","IMMUNODEFICIENCY WITH DEFECTIVE T-CELL RESPONSE TO INTERLEUKIN 1" -"OMIM:243150","GASTROINTESTINAL DEFECTS AND IMMUNODEFICIENCY SYNDROME; GIDID" -"DOID:512","epididymal neoplasm" -"DOID:0080162","lupus nephritis" -"OMIM:243180","VISCERAL NEUROPATHY, FAMILIAL, AUTOSOMAL RECESSIVE" -"OMIM:154500","TREACHER COLLINS SYNDROME 1; TCS1" -"DOID:5557","testicular germ cell cancer" -"OMIM:243185","INTESTINAL PSEUDOOBSTRUCTION WITH PATENT DUCTUS ARTERIOSUS AND NATAL TEETH" -"DOID:0060308","autosomal recessive non-syndromic intellectual disability" -"OMIM:243200","INTRACRANIAL HYPERTENSION, IDIOPATHIC" -"DOID:6050","esophageal disease" -"DOID:14064","acute poststreptococcal glomerulonephritis" -"OMIM:243300","CHOLESTASIS, BENIGN RECURRENT INTRAHEPATIC, 1; BRIC1" -"DOID:1909","melanoma" -"DOID:1800","neuroendocrine carcinoma" -"OMIM:243310","BARAITSER-WINTER SYNDROME 1; BRWS1" -"DOID:3798","pleural empyema" -"OMIM:243320","INTRINSIC FACTOR AND R BINDER, COMBINED CONGENITAL DEFICIENCY OF" -"OMIM:243400","ACETYLATION, SLOW" -"DOID:9958","hemometra" -"DOID:12205","dengue disease" -"OMIM:243440","ISOTRETINOIN EMBRYOPATHY-LIKE SYNDROME" -"DOID:0111087","Fanconi anemia complementation group C" -"DOID:0050679","blue cone monochromacy" -"DOID:7528","acute endometritis" -"DOID:6132","bronchitis" -"DOID:0060037","developmental disorder of mental health" -"OMIM:243450","ISOVALERIC ACID, INABILITY TO SMELL" -"DOID:961","neurofibroma of the esophagus" -"OMIM:243500","ISOVALERIC ACIDEMIA; IVA" -"DOID:4337","tinea capitis" -"DOID:4561","granulomatous endometritis" -"DOID:4784","immune-complex glomerulonephritis" -"DOID:8725","vascular dementia" -"OMIM:243600","JEJUNAL ATRESIA" -"OMIM:154300","MALOCCLUSION DUE TO PROTUBERANT UPPER FRONT TEETH" -"OMIM:243605","STROMME SYNDROME; STROMS" -"DOID:5821","methotrexate-associated lymphoproliferation" -"DOID:10976","membranous glomerulonephritis" -"OMIM:243700","HYPER-IgE RECURRENT INFECTION SYNDROME, AUTOSOMAL RECESSIVE" -"DOID:998","eosinophilia-myalgia syndrome" -"DOID:4062","testis sarcoma" -"DOID:9074","systemic lupus erythematosus" -"DOID:4560","non specific chronic endometritis" -"DOID:1578","pulmonary systemic sclerosis" -"OMIM:154750","MARFANOID HYPERMOBILITY SYNDROME" -"OMIM:243800","JOHANSON-BLIZZARD SYNDROME; JBS" -"OMIM:243910","ARIMA SYNDROME" -"DOID:12286","testicular leukemia" -"DOID:4737","somatoform disorder" -"OMIM:244100","JUMPING FRENCHMEN OF MAINE" -"DOID:14256","adult-onset Still's disease" -"OMIM:154570","MANNOSE 6-PHOSPHATE RECEPTOR RECOGNITION DEFECT, LEBANESE TYPE" -"DOID:12276","malignant tumor of undescended testis" -"DOID:0050773","paraganglioma" -"OMIM:244200","HYPOGONADOTROPIC HYPOGONADISM 3 WITH OR WITHOUT ANOSMIA; HH3" -"OMIM:244300","KAPUR-TORIELLO SYNDROME" -"DOID:438","autoimmune disease of the nervous system" -"OMIM:137040","GALLBLADDER, AGENESIS OF" -"OMIM:141405","HEMIFACIAL SPASM, FAMILIAL" -"OMIM:141200","HEMATURIA, BENIGN FAMILIAL; BFH" -"OMIM:137000","FUTCHER LINE" -"OMIM:140700","HEINZ BODY ANEMIAS" -"DOID:5705","spindle cell liposarcoma" -"DOID:2410","skin granular cell tumor" -"OMIM:110700","BLOOD GROUP, DUFFY SYSTEM; FY" -"DOID:4916","pituitary carcinoma" -"DOID:3280","mixed type thymoma" -"DOID:8857","lupus erythematosus" -"OMIM:136880","FUNDUS ALBIPUNCTATUS" -"OMIM:176450","CURRARINO SYNDROME" -"DOID:10567","late yaws" -"DOID:3178","skin papilloma" -"OMIM:110720","BLOOD GROUP--En" -"OMIM:137050","GAMMA-A-GLOBULIN, DEFECT IN ASSEMBLY OF" -"OMIM:142309","HEMOGLOBIN--VARIANTS FOR WHICH THE CHAIN CARRYING THE MUTATION IS UNKNOWN OR UNCERTAIN" -"OMIM:111150","BLOOD GROUP--LUTHERAN INHIBITOR; INLU" -"OMIM:140600","OSTEOARTHRITIS SUSCEPTIBILITY 2; OS2" -"DOID:1575","rheumatic disease" -"DOID:12351","alcoholic hepatitis" -"OMIM:141400","HEMIFACIAL MICROSOMIA WITH RADIAL DEFECTS" -"DOID:9808","Goodpasture syndrome" -"OMIM:111130","BLOOD GROUP--LKE; LKE" -"OMIM:136800","CORNEAL DYSTROPHY, FUCHS ENDOTHELIAL, 1; FECD1" -"OMIM:140900","HEMANGIOMAS OF SMALL INTESTINE" -"DOID:172","clear cell acanthoma" -"OMIM:616263","NEUROLOGIC, ENDOCRINE, AND PANCREATIC DISEASE, MULTISYSTEM, INFANTILE-ONSET; IMNEPD" -"OMIM:612267","SKIN/HAIR/EYE PIGMENTATION, VARIATION IN, 10; SHEP10" -"OMIM:612269","EPILEPSY, CHILDHOOD ABSENCE, SUSCEPTIBILITY TO, 5; ECA5" -"OMIM:616265","PEELING SKIN SYNDROME 3; PSS3" -"OMIM:616266","CONGENITAL CONTRACTURES OF THE LIMBS AND FACE, HYPOTONIA, AND DEVELOPMENTAL DELAY; CLIFAHDD" -"OMIM:612271","SKIN/HAIR/EYE PIGMENTATION, VARIATION IN, 11; SHEP11" -"OMIM:115195","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 2; CMH2" -"OMIM:616267","ATAXIA-OCULOMOTOR APRAXIA 4; AOA4" -"OMIM:612274","CILIARY DYSKINESIA, PRIMARY, 8; CILD8" -"DOID:0060783","ectrodactyly, ectodermal dysplasia, and cleft lip-palate syndrome 3" -"OMIM:612278","INFLAMMATORY BOWEL DISEASE (CROHN DISEASE) 19; IBD19" -"OMIM:616268","MENTAL RETARDATION, AUTOSOMAL DOMINANT 32; MRD32" -"OMIM:616269","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 48; MRT48" -"OMIM:612279","GENERALIZED EPILEPSY WITH FEBRILE SEIZURES PLUS, TYPE 6; GEFSP6" -"OMIM:612281","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 6; ARCI6" -"OMIM:616270","AMELOGENESIS IMPERFECTA, TYPE IF; AI1F" -"OMIM:616271","3-METHYLGLUTACONIC ACIDURIA WITH CATARACTS, NEUROLOGIC INVOLVEMENT, AND NEUTROPENIA; MEGCANN" -"OMIM:612284","MECKEL SYNDROME, TYPE 6; MKS6" -"DOID:0110011","advanced sleep phase syndrome 1" -"DOID:1936","atherosclerosis" -"OMIM:612285","JOUBERT SYNDROME 9; JBTS9" -"OMIM:616276","COENZYME Q10 DEFICIENCY, PRIMARY, 7; COQ10D7" -"OMIM:612286","NEPHROLITHIASIS/OSTEOPOROSIS, HYPOPHOSPHATEMIC, 1; NPHLOP1" -"OMIM:616277","MITOCHONDRIAL SHORT-CHAIN ENOYL-CoA HYDRATASE 1 DEFICIENCY; ECHS1D" -"OMIM:142690","ACNE INVERSA, FAMILIAL, 1; ACNINV1" -"DOID:539","ophthalmoplegia" -"DOID:0110902","inflammatory bowel disease 27" -"OMIM:142625","HIRSUTISM, SKELETAL DYSPLASIA, AND MENTAL RETARDATION" -"DOID:409","liver disease" -"DOID:0050598","extrapulmonary tuberculosis" -"DOID:1073","renal hypertension" -"DOID:0060570","cardiac tuberculosis" -"DOID:0110903","inflammatory bowel disease 4" -"DOID:0110891","inflammatory bowel disease 3" -"DOID:0110884","inflammatory bowel disease 23" -"DOID:216","dental caries" -"DOID:8778","Crohn's disease" -"DOID:11077","brucellosis" -"DOID:0110894","inflammatory bowel disease 11" -"DOID:11199","hypoparathyroidism" -"OMIM:142700","DEVELOPMENTAL DYSPLASIA OF THE HIP 1; DDH1" -"DOID:0110888","inflammatory bowel disease 18" -"OMIM:142680","PERIODIC FEVER, FAMILIAL, AUTOSOMAL DOMINANT" -"DOID:9724","purulent endophthalmitis" -"DOID:9970","obesity" -"DOID:0060491","SPOAN syndrome" -"OMIM:142660","HEXOSAMINIDASE C; HEXC" -"DOID:0110905","inflammatory bowel disease 22" -"DOID:0110896","inflammatory bowel disease 16" -"DOID:0110883","inflammatory bowel disease 17" -"DOID:0050831","familial encephalopathy with neuroserpin inclusion bodies" -"DOID:2957","pulmonary tuberculosis" -"DOID:0070019","autosomal recessive dyskeratosis congenita 3" -"DOID:13593","eclampsia" -"DOID:0110907","inflammatory bowel disease 6" -"OMIM:142630","HISTIOCYTOSIS, PROGRESSIVE MUCINOUS" -"OMIM:142669","BEUKES HIP DYSPLASIA; BHD" -"DOID:0110887","inflammatory bowel disease 12" -"DOID:0110898","inflammatory bowel disease 20" -"OMIM:142623","HIRSCHSPRUNG DISEASE, SUSCEPTIBILITY TO, 1; HSCR1" -"DOID:0110890","inflammatory bowel disease 19" -"DOID:14089","root caries" -"DOID:0110892","inflammatory bowel disease 1" -"DOID:0110886","inflammatory bowel disease 9" -"DOID:0110908","inflammatory bowel disease 24" -"DOID:11736","odontoclasia" -"DOID:9277","primary cerebellar degeneration" -"OMIM:170650","PERIODONTITIS, AGGRESSIVE, 1" -"OMIM:616278","BILE ACID SYNTHESIS DEFECT, CONGENITAL, 5; CBAS5" -"OMIM:612287","NEPHROLITHIASIS/OSTEOPOROSIS, HYPOPHOSPHATEMIC, 2; NPHLOP2" -"OMIM:186750","TALONAVICULAR COALITION" -"OMIM:130050","EHLERS-DANLOS SYNDROME, TYPE IV, AUTOSOMAL DOMINANT" -"OMIM:612288","INFLAMMATORY BOWEL DISEASE 20; IBD20" -"OMIM:616279","CATARACT 43; CTRCT43" -"OMIM:186850","TARSAL COALITION" -"OMIM:616280","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2U; CMT2U" -"OMIM:186890","TEAR PROTEIN, ANODAL" -"DOID:2877","larynx sarcoma" -"OMIM:130060","EHLERS-DANLOS SYNDROME, TYPE VII, AUTOSOMAL DOMINANT" -"DOID:2143","ovarian malignant mesothelioma" -"OMIM:612289","PROGEROID SYNDROME, CONGENITAL, PETTY TYPE" -"OMIM:130020","EHLERS-DANLOS SYNDROME, HYPERMOBILITY TYPE" -"OMIM:612290","MICROTIA, HEARING IMPAIRMENT, AND CLEFT PALATE" -"OMIM:186950","T-CELL SUBGROUPS, NON-HLA-LINKED" -"OMIM:178610","PULMONARY NODULAR LYMPHOID HYPERPLASIA, FAMILIAL" -"OMIM:616281","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 49; MRT49" -"DOID:6190","rectum Kaposi's sarcoma" -"DOID:3508","stricture or kinking of ureter" -"OMIM:187000","TEETH, ODD SHAPES OF" -"OMIM:612291","JOUBERT SYNDROME 8; JBTS8" -"DOID:11705","impaired renal function disease" -"OMIM:616282","SPASTIC PARAPLEGIA 73, AUTOSOMAL DOMINANT; SPG73" -"DOID:1521","cecum cancer" -"OMIM:616286","LETHAL CONGENITAL CONTRACTURE SYNDROME 7; LCCS7" -"OMIM:187030","T-COMPLEX LOCUS TCP10B; TCP10B" -"OMIM:612292","BIRK-BAREL MENTAL RETARDATION DYSMORPHISM SYNDROME" -"OMIM:187050","TEETH PRESENT AT BIRTH" -"OMIM:616287","LETHAL CONGENITAL CONTRACTURE SYNDROME 8; LCCS8" -"OMIM:612293","POROKERATOSIS 5, DISSEMINATED SUPERFICIAL ACTINIC TYPE; POROK5" -"DOID:14766","renal agenesis" -"DOID:6554","ovarian clear cell malignant adenofibroma" -"OMIM:616289","OPTIC ATROPHY 9; OPA9" -"OMIM:187100","TEETH, SUPERNUMERARY" -"OMIM:612300","HEMOLYTIC ANEMIA, CD59-MEDIATED, WITH OR WITHOUT IMMUNE-MEDIATED POLYNEUROPATHY; HACD59" -"OMIM:612301","OSTEOPETROSIS, AUTOSOMAL RECESSIVE 7; OPTB7" -"DOID:0111031","hemochromatosis type 5" -"OMIM:187260","TELANGIECTASIA, HEREDITARY BENIGN" -"OMIM:616291","LICHTENSTEIN-KNORR SYNDROME; LIKNS" -"OMIM:187290","TEMPERATURE SENSITIVITY COMPLEMENTATION, CELL CYCLE SPECIFIC, H142; H142T" -"OMIM:612304","THROMBOPHILIA DUE TO PROTEIN C DEFICIENCY, AUTOSOMAL RECESSIVE; THPH4" -"DOID:6687","Achenbach syndrome" -"OMIM:616294","COLE-CARPENTER SYNDROME 2; CLCRP2" -"DOID:0050804","glioblastoma proneural subtype" -"OMIM:187300","TELANGIECTASIA, HEREDITARY HEMORRHAGIC, OF RENDU, OSLER, AND WEBER; HHT" -"DOID:580","acute urate nephropathy" -"OMIM:612306","THYROID-STIMULATING HORMONE LEVEL QUANTITATIVE TRAIT LOCUS 1; TSHQTL1" -"OMIM:616295","PEELING SKIN WITH LEUKONYCHIA, ACRAL PUNCTATE KERATOSES, CHEILITIS, AND KNUCKLE PADS; PLACK" -"OMIM:129850","EDINBURGH MALFORMATION SYNDROME" -"OMIM:187310","TEMPERATURE SENSITIVITY COMPLEMENTATION, CELL CYCLE SPECIFIC, K12" -"DOID:873","anaerobic pneumonia" -"OMIM:616298","SINGLETON-MERTEN SYNDROME 2; SGMRT2" -"OMIM:612310","PREMATURE OVARIAN FAILURE 6; POF6" -"OMIM:612311","ATTENTION DEFICIT-HYPERACTIVITY DISORDER, SUSCEPTIBILITY TO, 5" -"OMIM:187320","TEMPERATURE SENSITIVITY COMPLEMENTATION, CELL CYCLE SPECIFIC, ts13; TS13" -"OMIM:616299","LIPOYLTRANSFERASE 1 DEFICIENCY; LIPT1D" -"DOID:10126","keratoconus" -"OMIM:157640","PROGRESSIVE EXTERNAL OPHTHALMOPLEGIA WITH MITOCHONDRIAL DNA DELETIONS, AUTOSOMAL DOMINANT 1; PEOA1" -"DOID:2973","kidney cortex necrosis" -"OMIM:616300","SHORT-RIB THORACIC DYSPLASIA 13 WITH OR WITHOUT POLYDACTYLY; SRTD13" -"OMIM:187330","TEMPERATURE SENSITIVITY COMPLEMENTATION, CELL CYCLE SPECIFIC, ts546; TS546" -"OMIM:129840","EDEMA, FAMILIAL IDIOPATHIC, PREPUBERTAL" -"OMIM:612312","ATTENTION DEFICIT-HYPERACTIVITY DISORDER, SUSCEPTIBILITY TO, 6" -"OMIM:612313","GLASS SYNDROME; GLASS" -"OMIM:187340","TEMPERATURE-SENSITIVE LETHAL MUTATION" -"OMIM:616304","MYASTHENIC SYNDROME, CONGENITAL, 17; CMS17" -"OMIM:157300","MIGRAINE WITH OR WITHOUT AURA, SUSCEPTIBILITY TO, 1" -"DOID:0050868","hepatocellular adenoma" -"OMIM:187350","TELECANTHUS" -"OMIM:616307","SENIOR-LOKEN SYNDROME 8; SLSN8" -"OMIM:612318","PSEUDOFOLLICULITIS BARBAE" -"OMIM:157700","MITRAL VALVE PROLAPSE 1; MVP1" -"OMIM:187360","TEMPORAL ARTERITIS" -"OMIM:616311","MENTAL RETARDATION, AUTOSOMAL DOMINANT 33; MRD33" -"OMIM:612319","SPASTIC PARAPLEGIA 35, AUTOSOMAL RECESSIVE; SPG35" -"OMIM:616313","MYASTHENIC SYNDROME, CONGENITAL, 2A, SLOW-CHANNEL; CMS2A" -"OMIM:612335","SPASTIC PARAPLEGIA 38, AUTOSOMAL DOMINANT; SPG38" -"OMIM:187370","ARTHROGRYPOSIS, DISTAL, TYPE 10; DA10" -"DOID:0060204","amyotrophic lateral sclerosis type 13" -"OMIM:187390","TENDONS, EXTENSOR, OF FINGERS, ANOMALOUS INSERTION OF" -"OMIM:616314","MYASTHENIC SYNDROME, CONGENITAL, 2C, ASSOCIATED WITH ACETYLCHOLINE RECEPTOR DEFICIENCY; CMS2C" -"OMIM:612336","THROMBOPHILIA DUE TO PROTEIN S DEFICIENCY, AUTOSOMAL DOMINANT; THPH5" -"OMIM:187400","TESTICULAR TORSION" -"OMIM:616321","MYASTHENIC SYNDROME, CONGENITAL, 3A, SLOW-CHANNEL; CMS3A" -"DOID:636","central pontine myelinolysis" -"OMIM:612337","MENTAL RETARDATION, AUTOSOMAL DOMINANT 22; MRD22" -"OMIM:612343","MUSICAL APTITUDE QUANTITATIVE TRAIT LOCUS" -"OMIM:616322","MYASTHENIC SYNDROME, CONGENITAL, 3B, FAST-CHANNEL; CMS3B" -"OMIM:187500","TETRALOGY OF FALLOT; TOF" -"DOID:3153","lipomatosis" -"DOID:0050572","cone-rod dystrophy" -"OMIM:616323","MYASTHENIC SYNDROME, CONGENITAL, 3C, ASSOCIATED WITH ACETYLCHOLINE RECEPTOR DEFICIENCY; CMS3C" -"OMIM:187501","TETRALOGY OF FALLOT AND GLAUCOMA" -"DOID:10310","viral meningitis" -"OMIM:612345","CHROMOSOME 2q31.2 DELETION SYNDROME" -"OMIM:187510","TETRAMELIC MONODACTYLY" -"OMIM:616324","MYASTHENIC SYNDROME, CONGENITAL, 4B, FAST-CHANNEL; CMS4B" -"DOID:14043","neonatal myasthenia gravis" -"OMIM:612347","JERVELL AND LANGE-NIELSEN SYNDROME 2; JLNS2" -"OMIM:187550","THALASSEMIA, BETA+, SILENT ALLELE" -"OMIM:616325","MYASTHENIC SYNDROME, CONGENITAL, 9, ASSOCIATED WITH ACETYLCHOLINE RECEPTOR DEFICIENCY; CMS9" -"OMIM:612348","THROMBOPHILIA, FAMILIAL, DUE TO DECREASED RELEASE OF TISSUE PLASMINOGEN ACTIVATOR; THPH9" -"DOID:3575","cavernous sinus thrombosis" -"DOID:0050855","renal fibrosis" -"OMIM:616326","MYASTHENIC SYNDROME, CONGENITAL, 11, ASSOCIATED WITH ACETYLCHOLINE RECEPTOR DEFICIENCY; CMS11" -"OMIM:612350","SPONDYLOCHEIRODYSPLASIA, EHLERS-DANLOS SYNDROME-LIKE" -"OMIM:187600","THANATOPHORIC DYSPLASIA, TYPE I; TD1" -"DOID:11963","esophagitis" -"DOID:1731","histoplasmosis" -"OMIM:187601","THANATOPHORIC DYSPLASIA, TYPE II; TD2" -"OMIM:612353","POROKERATOSIS 6, MULTIPLE TYPES; POROK6" -"OMIM:129900","ECTRODACTYLY, ECTODERMAL DYSPLASIA, AND CLEFT LIP/PALATE SYNDROME 1; EEC1" -"OMIM:616329","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 13; MODY13" -"OMIM:612354","INFLAMMATORY BOWEL DISEASE 21; IBD21" -"OMIM:616330","MYASTHENIC SYNDROME, CONGENITAL, 18; CMS18" -"OMIM:187650","THEOPHYLLINE BIOTRANSFORMATION" -"OMIM:187750","THORACIC DYSOSTOSIS, ISOLATED" -"OMIM:616331","ROBINOW SYNDROME, AUTOSOMAL DOMINANT 2; DRS2" -"DOID:0050805","glioblastoma mesenchymal subtype" -"OMIM:129905","EGASYN" -"OMIM:612356","HEPARIN COFACTOR II DEFICIENCY" -"OMIM:187760","THORACOLARYNGOPELVIC DYSPLASIA; TLPD" -"OMIM:616335","MICROCEPHALY AND CHORIORETINOPATHY, AUTOSOMAL RECESSIVE, 3; MCCRP3" -"OMIM:612357","MAJOR AFFECTIVE DISORDER 8; MAFD8" -"OMIM:612359","COWDEN SYNDROME 2; CWS2" -"DOID:0050928","ovarian melanoma" -"OMIM:187770","THORACOPELVIC DYSOSTOSIS" -"OMIM:616339","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 29; EIEE29" -"OMIM:187800","BLEEDING DISORDER, PLATELET-TYPE, 16; BDPLT16" -"OMIM:612361","SCHIZOPHRENIA 14" -"OMIM:616340","DEAFNESS, AUTOSOMAL DOMINANT 67; DFNA67" -"DOID:1508","candidiasis" -"OMIM:157600","MIRROR MOVEMENTS 1; MRMV1" -"DOID:2145","malignant ovarian cyst" -"OMIM:187900","BLEEDING DISORDER, PLATELET-TYPE, 17; BDPLT17" -"OMIM:616341","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 30; EIEE30" -"OMIM:612362","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 12; BMIQ12" -"DOID:9617","orthostatic proteinuria" -"OMIM:130000","EHLERS-DANLOS SYNDROME, CLASSIC TYPE" -"OMIM:612363","ALANINE AMINOTRANSFERASE, PLASMA LEVEL OF, QUANTITATIVE TRAIT LOCUS 1" -"OMIM:616342","LISSENCEPHALY 7 WITH CEREBELLAR HYPOPLASIA; LIS7" -"OMIM:187940","THROMBOCYTE B; THB" -"DOID:2981","kidney papillary necrosis" -"OMIM:187950","THROMBOCYTHEMIA 1; THCYT1" -"OMIM:612364","ALANINE AMINOTRANSFERASE, PLASMA LEVEL OF, QUANTITATIVE TRAIT LOCUS 2" -"DOID:3002","ovary neuroendocrine neoplasm" -"DOID:9455","lipid storage disease" -"OMIM:616345","IMMUNODEFICIENCY 39; IMD39" -"OMIM:157400","MILIA, MULTIPLE ERUPTIVE" -"OMIM:616346","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 31; EIEE31" -"OMIM:188000","THROMBOCYTOPENIA 2; THC2" -"OMIM:612365","GAMMA GLUTAMYLTRANSFERASE, PLASMA LEVEL OF, QUANTITATIVE TRAIT LOCUS 1" -"OMIM:178650","PULMONIC STENOSIS, ATRIAL SEPTAL DEFECT, AND UNIQUE ELECTROCARDIOGRAPHIC ABNORMALITIES" -"DOID:0050806","glioblastoma neural subtype" -"OMIM:616351","MENTAL RETARDATION, AUTOSOMAL DOMINANT 34; MRD34" -"OMIM:612366","GAMMA GLUTAMYLTRANSFERASE, PLASMA LEVEL OF, QUANTITATIVE TRAIT LOCUS 2" -"OMIM:188020","THROMBOCYTOPENIA, CYCLIC" -"OMIM:122100","CORNEAL DYSTROPHY, MEESMANN; MECD" -"DOID:670","amphetamine abuse" -"OMIM:122400","EPITHELIAL RECURRENT EROSION DYSTROPHY; ERED" -"DOID:5692","cellular myxoid liposarcoma" -"DOID:9621","non-congenital cyst of kidney" -"DOID:3852","Peutz-Jeghers syndrome" -"DOID:14435","chronic tubotympanic suppurative otitis media" -"OMIM:122455","CORONARY ARTERY DISSECTION, SPONTANEOUS" -"DOID:3068","glioblastoma multiforme" -"DOID:10487","Hirschsprung's disease" -"DOID:0050143","asymptomatic dengue" -"DOID:0110619","primary ciliary dyskinesia 33" -"OMIM:122460","HUMAN CORONAVIRUS SENSITIVITY; HCVS" -"DOID:9252","amino acid metabolic disorder" -"DOID:4471","chromophobe renal cell carcinoma" -"OMIM:122440","CORNEODERMATOOSSEOUS SYNDROME" -"DOID:8502","bullous skin disease" -"OMIM:122200","CORNEAL DYSTROPHY, LATTICE TYPE I; LCD1" -"DOID:3181","oligodendroglioma" -"DOID:10590","mild pre-eclampsia" -"DOID:0080148","T-cell childhood lymphoblastic lymphoma" -"DOID:7575","pancreatic intraductal papillary-mucinous neoplasm" -"OMIM:122430","CORNEAL HYPESTHESIA WITH RETINAL ABNORMALITIES, SENSORINEURAL DEAFNESS, UNUSUAL FACIES, PERSISTENT DUCTUS ARTERIOSUS, AND MENTAL RETARDATION" -"DOID:13819","lymphogranuloma venereum" -"DOID:0111133","focal segmental glomerulosclerosis 8" -"DOID:0050751","T-cell large granular lymphocyte leukemia" -"DOID:2122","pneumonic tularemia" -"DOID:0111129","focal segmental glomerulosclerosis 2" -"OMIM:252320","MOTOR NEUROPATHY, PERIPHERAL, WITH DYSAUTONOMIA" -"DOID:0110390","retinitis pigmentosa 1" -"OMIM:122450","CORNEAL HYPESTHESIA, FAMILIAL" -"DOID:12972","intrapelvic lymph node leukemic reticuloendotheliosis" -"DOID:421","hair disease" -"DOID:3095","germ cell and embryonal cancer" -"DOID:9169","Wiskott-Aldrich syndrome" -"OMIM:310900","OCCIPITAL HAIR, WHITE LOCK OF" -"OMIM:262500","LARON SYNDROME" -"OMIM:604401","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 6; ARVD6" -"OMIM:262600","PITUITARY HORMONE DEFICIENCY, COMBINED, 2; CPHD2" -"OMIM:310980","OMPHALOCELE, X-LINKED" -"DOID:0060056","hypersensitivity reaction disease" -"OMIM:604403","GENERALIZED EPILEPSY WITH FEBRILE SEIZURES PLUS, TYPE 2; GEFSP2" -"OMIM:262650","KOWARSKI SYNDROME" -"OMIM:311000","OPHTHALMOPLEGIA, EXTERNAL, AND MYOPIA; OPEM" -"DOID:0080087","nonsyndromic congenital nail disorder 9" -"OMIM:604416","PYOGENIC STERILE ARTHRITIS, PYODERMA GANGRENOSUM, AND ACNE" -"OMIM:311050","OPTIC ATROPHY 2; OPA2" -"OMIM:262700","PITUITARY HORMONE DEFICIENCY, COMBINED, 4; CPHD4" -"OMIM:604431","POLYNEUROPATHY, LETHAL NEONATAL, AXONAL SENSORIMOTOR, AUTOSOMAL RECESSIVE" -"DOID:7305","astroblastoma" -"OMIM:604432","SPINOCEREBELLAR ATAXIA 11; SCA11" -"OMIM:262710","PITUITARY DWARFISM WITH LARGE SELLA TURCICA" -"OMIM:311070","CHARCOT-MARIE-TOOTH DISEASE, X-LINKED RECESSIVE, 5; CMTX5" -"DOID:4852","pleomorphic xanthoastrocytoma" -"OMIM:311100","OPTIC ATROPHY--SPASTIC PARAPLEGIA SYNDROME" -"OMIM:604451","BASAL CELL CARCINOMA, INFUNDIBULOCYSTIC" -"OMIM:262800","PLASMA CLOT RETRACTION FACTOR, DEFICIENCY OF" -"OMIM:311200","OROFACIODIGITAL SYNDROME I; OFD1" -"OMIM:262850","ALPHA-2-PLASMIN INHIBITOR DEFICIENCY" -"DOID:0080084","nonsyndromic congenital nail disorder 6" -"OMIM:604454","WELANDER DISTAL MYOPATHY; WDM" -"OMIM:604474","HUMAN HERPESVIRUS TYPE 6, INTEGRATED" -"OMIM:262875","PLATELET PROSTACYCLIN RECEPTOR DEFECT" -"OMIM:311250","ORNITHINE TRANSCARBAMYLASE DEFICIENCY, HYPERAMMONEMIA DUE TO" -"OMIM:262890","SCOTT SYNDROME; SCTS" -"OMIM:311300","OTOPALATODIGITAL SYNDROME, TYPE I; OPD1" -"OMIM:604484","NEUROPATHY, HEREDITARY MOTOR AND SENSORY, OKINAWA TYPE; HMSNO" -"DOID:0050631","Allan-Herndon-Dudley syndrome" -"DOID:2222","factor X deficiency" -"OMIM:137580","GILLES DE LA TOURETTE SYNDROME; GTS" -"DOID:0111058","platelet-type bleeding disorder 12" -"OMIM:604498","AMEGAKARYOCYTIC THROMBOCYTOPENIA, CONGENITAL; CAMT" -"OMIM:262900","PLEOCONIAL MYOPATHY WITH SALT CRAVING" -"OMIM:311350","OUABAIN RESISTANCE; OUBR" -"DOID:0080082","nonsyndromic congenital nail disorder 4" -"OMIM:604499","HYPERLIPIDEMIA, COMBINED, 2" -"OMIM:311360","PREMATURE OVARIAN FAILURE 1; POF1" -"DOID:6726","fibrillary astrocytoma" -"OMIM:263000","INTERSTITIAL PNEUMONITIS, DESQUAMATIVE, FAMILIAL; DIP" -"DOID:7378","pituitary hypoplasia" -"OMIM:263100","POLYCYSTIC KIDNEY, CATARACT, AND CONGENITAL BLINDNESS" -"OMIM:604519","INFLAMMATORY BOWEL DISEASE 3; IBD3" -"DOID:12259","hemophilia B" -"OMIM:137575","GIGANTIFORM CEMENTOMA, FAMILIAL" -"OMIM:311400","PAINE SYNDROME" -"DOID:1681","heart septal defect" -"OMIM:263200","POLYCYSTIC KIDNEY DISEASE 4 WITH OR WITHOUT HEPATIC DISEASE; PKD4" -"OMIM:311450","PALLISTER W SYNDROME" -"DOID:0111046","platelet-type bleeding disorder 10" -"DOID:0111048","platelet-type bleeding disorder 19" -"DOID:712","refractory hematologic cancer" -"OMIM:604536","ECTODERMAL DYSPLASIA/SKIN FRAGILITY SYNDROME" -"DOID:4845","pilomyxoid astrocytoma" -"DOID:2236","congenital afibrinogenemia" -"OMIM:604537","LEBER CONGENITAL AMAUROSIS 5; LCA5" -"DOID:7008","protoplasmic astrocytoma" -"OMIM:263210","GILLESSEN-KAESBACH-NISHIMURA SYNDROME; GIKANIS" -"DOID:0111045","platelet-type bleeding disorder 9" -"OMIM:311510","WAISMAN SYNDROME; WSMN" -"DOID:2120","focal dermal hypoplasia" -"OMIM:604547","VAN DER WOUDE SYNDROME 1, MODIFIER OF" -"OMIM:311895","PIERRE ROBIN SEQUENCE WITH FACIAL AND DIGITAL ANOMALIES" -"DOID:0080085","nonsyndromic congenital nail disorder 7" -"DOID:2215","factor VII deficiency" -"OMIM:263300","POLYCYTHEMIA VERA; PV" -"OMIM:604559","PROGRESSIVE FAMILIAL HEART BLOCK, TYPE IB; PFHB1B" -"OMIM:263400","ERYTHROCYTOSIS, FAMILIAL, 2; ECYT2" -"OMIM:311900","TARP SYNDROME; TARPS" -"DOID:0060691","platelet-type bleeding disorder 16" -"DOID:0110968","brachydactyly type A6" -"DOID:0111044","gray platelet syndrome" -"OMIM:604563","CHARCOT-MARIE-TOOTH DISEASE, TYPE 4B2; CMT4B2" -"OMIM:312000","PANHYPOPITUITARISM, X-LINKED; PHPX" -"OMIM:263450","POLYDACTYLY, POSTAXIAL, TYPE A5; PAPA5" -"OMIM:263520","SHORT-RIB THORACIC DYSPLASIA 6 WITH OR WITHOUT POLYDACTYLY; SRTD6" -"OMIM:604571","BARE LYMPHOCYTE SYNDROME, TYPE I" -"DOID:3756","protein C deficiency" -"DOID:2216","factor V deficiency" -"OMIM:312060","PROPERDIN DEFICIENCY, X-LINKED; CFPD" -"OMIM:263540","POLYDACTYLY, POSTAXIAL, WITH DENTAL AND VERTEBRAL ANOMALIES" -"DOID:0080080","nonsyndromic congenital nail disorder 2" -"OMIM:312080","PELIZAEUS-MERZBACHER DISEASE; PMD" -"OMIM:604595","CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 1" -"OMIM:263550","POLYMYOCLONUS, INFANTILE" -"OMIM:312150","MULTIPLE PTERYGIUM SYNDROME, X-LINKED" -"OMIM:604625","TOOTH AGENESIS, SELECTIVE, 3; STHAG3" -"DOID:11184","acute conjunctivitis" -"OMIM:263570","POLYGLUCOSAN BODY NEUROPATHY, ADULT FORM; APBN" -"OMIM:312170","PYRUVATE DEHYDROGENASE E1-ALPHA DEFICIENCY; PDHAD" -"OMIM:604690","GROWTH AND DEVELOPMENTAL RETARDATION, OCULAR PTOSIS, CARDIAC DEFECT, AND ANAL ATRESIA" -"DOID:9091","REM sleep behavior disorder" -"OMIM:263600","POLYSACCHARIDE, STORAGE OF UNUSUAL" -"OMIM:604715","ORTHOSTATIC INTOLERANCE" -"OMIM:312190","RADIAL APLASIA, X-LINKED" -"OMIM:137500","GIANT NEUTROPHIL LEUKOCYTES" -"OMIM:312200","RADIAL LOOP, PLAIN, ON RIGHT INDEX FINGER" -"OMIM:604717","DEAFNESS, AUTOSOMAL DOMINANT 20; DFNA20" -"DOID:2211","factor XIII deficiency" -"OMIM:263610","POLYHYDRAMNIOS, CHRONIC IDIOPATHIC" -"DOID:1700","X-linked ichthyosis" -"DOID:0080086","nonsyndromic congenital nail disorder 8" -"OMIM:263630","POLYSYNDACTYLY WITH CARDIAC MALFORMATION" -"DOID:3079","juvenile astrocytoma" -"OMIM:604757","CRANIOSYNOSTOSIS 2; CRS2" -"OMIM:137400","GEOGRAPHIC AND FISSURED TONGUE" -"OMIM:312210","RADIATION SENSITIVITY OF NATURAL KILLER ACTIVITY" -"DOID:2475","chronic conjunctivitis" -"OMIM:604765","CARDIOMYOPATHY, DILATED, 1I; CMD1I" -"OMIM:263650","POPLITEAL PTERYGIUM SYNDROME, LETHAL TYPE" -"OMIM:312300","ANDROGEN INSENSITIVITY, PARTIAL; PAIS" -"OMIM:604771","POLYCYSTIC BONE DISEASE" -"OMIM:312500","RETICULOENDOTHELIOSIS, X-LINKED" -"OMIM:263700","PORPHYRIA, CONGENITAL ERYTHROPOIETIC" -"OMIM:137440","GERSTMANN-STRAUSSLER DISEASE; GSD" -"DOID:14261","fragile X syndrome" -"OMIM:263750","POSTAXIAL ACROFACIAL DYSOSTOSIS; POADS" -"DOID:2219","Glanzmann's thrombasthenia" -"OMIM:604772","VENTRICULAR TACHYCARDIA, CATECHOLAMINERGIC POLYMORPHIC, 1, WITH OR WITHOUT ATRIAL DYSFUNCTION AND/OR DILATED CARDIOMYOPATHY; CPVT1" -"OMIM:312550","RETINAL DYSPLASIA, PRIMARY; PRD" -"OMIM:263800","GITELMAN SYNDROME; GTLMNS" -"DOID:0060844","Norrie disease" -"OMIM:312600","RETINITIS PIGMENTOSA 2; RP2" -"OMIM:604777","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 5; ARCI5" -"DOID:0111053","platelet-type bleeding disorder 15" -"DOID:630","genetic disease" -"OMIM:312612","RETINITIS PIGMENTOSA 6; RP6" -"OMIM:604801","MUSCULAR DYSTROPHY, CONGENITAL, 1B; MDC1B" -"OMIM:264010","PRADER-WILLI HABITUS, OSTEOPENIA, AND CAMPTODACTYLY" -"DOID:0111050","Quebec platelet disorder" -"OMIM:264050","PRENATAL BOWING" -"OMIM:312700","RETINOSCHISIS 1, X-LINKED, JUVENILE; RS1" -"OMIM:604802","HUNTINGTON DISEASE-LIKE 3; HDL3" -"DOID:0080088","nonsyndromic congenital nail disorder 10" -"OMIM:137550","MELANOCYTIC NEVUS SYNDROME, CONGENITAL; CMNS" -"DOID:4367","apparent mineralocorticoid excess syndrome" -"OMIM:604804","MICROCEPHALY 3, PRIMARY, AUTOSOMAL RECESSIVE; MCPH3" -"OMIM:312750","RETT SYNDROME; RTT" -"OMIM:264060","PREPAPILLARY VASCULAR LOOPS" -"DOID:4960","bone marrow cancer" -"OMIM:264070","HYPERPHENYLALANINEMIA, BH4-DEFICIENT, D; HPABH4D" -"DOID:4856","gliofibroma" -"OMIM:604805","SPASTIC PARAPLEGIA 12, AUTOSOMAL DOMINANT; SPG12" -"DOID:3078","grade III astrocytoma" -"DOID:9709","rosacea conjunctivitis" -"OMIM:312780","RUSSELL-SILVER SYNDROME, X-LINKED" -"DOID:8683","myeloid sarcoma" -"OMIM:264080","PROGESTERONE RESISTANCE" -"OMIM:604809","PANBRONCHIOLITIS, DIFFUSE" -"OMIM:312830","SCARF SYNDROME" -"DOID:14711","FG syndrome" -"DOID:0111055","platelet-type bleeding disorder 20" -"DOID:3076","adult astrocytic tumour" -"OMIM:264090","PROGEROID SYNDROME, NEONATAL" -"OMIM:312840","SCHIMKE X-LINKED MENTAL RETARDATION SYNDROME" -"DOID:0111051","platelet-type bleeding disorder 18" -"OMIM:137560","GIANT PLATELET SYNDROME WITH THROMBOCYTOPENIA" -"OMIM:604827","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 7; EIG7" -"OMIM:312863","COMBINED IMMUNODEFICIENCY, X-LINKED; CIDX" -"OMIM:604830","MANDIBULOFACIAL DYSOSTOSIS SYNDROME, BAURU TYPE" -"OMIM:264110","PROLACTIN DEFICIENCY, ISOLATED" -"DOID:0111052","Scott syndrome" -"OMIM:312870","SIMPSON-GOLABI-BEHMEL SYNDROME, TYPE 1; SGBS1" -"OMIM:264120","PROLACTIN DEFICIENCY WITH OBESITY AND ENLARGED TESTES" -"OMIM:604841","STICKLER SYNDROME, TYPE II; STL2" -"DOID:1023","borderline leprosy" -"OMIM:616353","DYSKERATOSIS CONGENITA, AUTOSOMAL RECESSIVE 6; DKCB6" -"OMIM:612367","ALKALINE PHOSPHATASE, PLASMA LEVEL OF, QUANTITATIVE TRAIT LOCUS 2" -"OMIM:612368","ALKALINE PHOSPHATASE, PLASMA LEVEL OF, QUANTITATIVE TRAIT LOCUS 3" -"OMIM:616354","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 20; SCAR20" -"OMIM:612369","ALKALINE PHOSPHATASE, PLASMA LEVEL OF, QUANTITATIVE TRAIT LOCUS 4" -"OMIM:616355","MENTAL RETARDATION, AUTOSOMAL DOMINANT 35; MRD35" -"OMIM:612370","HYPOGONADOTROPIC HYPOGONADISM 5 WITH OR WITHOUT ANOSMIA; HH5" -"OMIM:616357","DEAFNESS, AUTOSOMAL DOMINANT 40; DFNA40" -"OMIM:130650","BECKWITH-WIEDEMANN SYNDROME; BWS" -"DOID:8233","inflammatory liposarcoma" -"OMIM:612371","MAJOR AFFECTIVE DISORDER 7; MAFD7" -"OMIM:616361","PARKINSON DISEASE 21; PARK21" -"OMIM:612372","MAJOR AFFECTIVE DISORDER 9; MAFD9" -"OMIM:616362","MENTAL RETARDATION, AUTOSOMAL DOMINANT 36; MRD36" -"DOID:3279","spindle cell thymoma" -"OMIM:616364","WHITE-SUTTON SYNDROME; WHSUS" -"DOID:10024","migraine with aura" -"OMIM:612376","ACUTE PROMYELOCYTIC LEUKEMIA; APL" -"DOID:0110032","autosomal dominant Alport syndrome" -"OMIM:612378","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 13; SLEB13" -"OMIM:616366","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 32; EIEE32" -"OMIM:612379","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Iq; CDG1Q" -"DOID:5297","rectum leiomyosarcoma" -"OMIM:616367","MANDIBULOFACIAL DYSOSTOSIS WITH ALOPECIA; MFDA" -"DOID:1068","juvenile glaucoma" -"OMIM:616368","CHOPS SYNDROME; CHOPS" -"OMIM:612380","INFLAMMATORY BOWEL DISEASE 22; IBD22" -"OMIM:616370","MULTIPLE MITOCHONDRIAL DYSFUNCTIONS SYNDROME 4; MMDS4" -"OMIM:612381","INFLAMMATORY BOWEL DISEASE 23; IBD23" -"OMIM:612387","SARCOIDOSIS, SUSCEPTIBILITY TO, 2; SS2" -"OMIM:616371","PULMONARY FIBROSIS AND/OR BONE MARROW FAILURE, TELOMERE-RELATED, 4; PFBMFT4" -"OMIM:612388","SARCOIDOSIS, SUSCEPTIBILITY TO, 3; SS3" -"OMIM:616373","PULMONARY FIBROSIS AND/OR BONE MARROW FAILURE, TELOMERE-RELATED, 3; PFBMFT3" -"OMIM:612389","PONTOCEREBELLAR HYPOPLASIA, TYPE 2B; PCH2B" -"DOID:13550","angle-closure glaucoma" -"OMIM:616389","NIGHT BLINDNESS, CONGENITAL STATIONARY, TYPE 1G; CSNB1G" -"OMIM:616390","TRICHOTHIODYSTROPHY 2, PHOTOSENSITIVE; TTD2" -"OMIM:612390","PONTOCEREBELLAR HYPOPLASIA, TYPE 2C; PCH2C" -"OMIM:616392","SKINT1-LIKE PSEUDOGENE; SKINTL" -"DOID:4053","rectum rhabdomyosarcoma" -"OMIM:612394","BONE FRAGILITY WITH CONTRACTURES, ARTERIAL RUPTURE, AND DEAFNESS" -"OMIM:616393","MENTAL RETARDATION, AUTOSOMAL DOMINANT 38; MRD38" -"DOID:8454","ariboflavinosis" -"OMIM:612396","ALLANTOICASE; ALLC" -"OMIM:616394","RETINITIS PIGMENTOSA 71; RP71" -"OMIM:612400","OSTEOARTHRITIS SUSCEPTIBILITY 5; OS5" -"OMIM:130700","EMPHYSEMA, HEREDITARY PULMONARY" -"OMIM:616395","TRICHOTHIODYSTROPHY 3, PHOTOSENSITIVE; TTD3" -"OMIM:612401","OSTEOARTHRITIS SUSCEPTIBILITY 6; OS6" -"OMIM:612406","DYSTONIA 17, TORSION, AUTOSOMAL RECESSIVE; DYT17" -"OMIM:616398","DYSTONIA 26, MYOCLONIC; DYT26" -"OMIM:612410","PSORIASIS 10, SUSCEPTIBILITY TO; PSORS10" -"OMIM:616399","BRUGADA SYNDROME 9; BRGDA9" -"OMIM:131100","MULTIPLE ENDOCRINE NEOPLASIA, TYPE I; MEN1" -"DOID:10159","osteonecrosis" -"OMIM:612416","FACTOR XI DEFICIENCY" -"OMIM:616400","PALMOPLANTAR KERATODERMA, NONEPIDERMOLYTIC, FOCAL 2; FNEPPK2" -"DOID:3168","squamous cell neoplasm" -"DOID:1657","ventricular septal defect" -"OMIM:612417","NARCOLEPSY 4, SUSCEPTIBILITY TO; NRCLP4" -"OMIM:616402","MICROCEPHALY 14, PRIMARY, AUTOSOMAL RECESSIVE; MCPH14" -"OMIM:616407","BROWN SYNDROME; BRWNS" -"OMIM:612421","ALOPECIA, ANDROGENETIC, 3; AGA3" -"OMIM:130950","ENCEPHALOPATHY, RECURRENT, OF CHILDHOOD" -"OMIM:616409","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 33; EIEE33" -"OMIM:130900","AMELOGENESIS IMPERFECTA, TYPE IIIA; AI3A" -"OMIM:612422","CARDIOMYOPATHY, FAMILIAL RESTRICTIVE, 3; RCM3" -"DOID:206","hereditary multiple exostoses" -"OMIM:612423","PREKALLIKREIN DEFICIENCY" -"DOID:0060782","EEC syndrome" -"OMIM:616410","SPINOCEREBELLAR ATAXIA 41; SCA41" -"DOID:3821","posterior cerebral artery infarction" -"OMIM:616411","DYSTONIA 27; DYT27" -"OMIM:612431","DEAFNESS, AUTOSOMAL DOMINANT 27; DFNA27" -"OMIM:612433","DEAFNESS, AUTOSOMAL RECESSIVE 45; DFNB45" -"OMIM:616413","BASAL GANGLIA CALCIFICATION, IDIOPATHIC, 6; IBGC6" -"OMIM:616414","AUTOIMMUNE INTERSTITIAL LUNG, JOINT, AND KIDNEY DISEASE; AILJK" -"OMIM:612437","EPILEPSY, PROGRESSIVE MYOCLONIC, 1B; EPM1B" -"DOID:6406","double outlet right ventricle" -"OMIM:612438","LEUKODYSTROPHY, HYPOMYELINATING, 6; HLD6" -"OMIM:616415","FAMILIAL ADENOMATOUS POLYPOSIS 3; FAP3" -"OMIM:130720","LATERAL MENINGOCELE SYNDROME; LMNS" -"OMIM:131200","ENDOMETRIOSIS, SUSCEPTIBILITY TO, 1" -"OMIM:616418","HYPOMAGNESEMIA, SEIZURES, AND MENTAL RETARDATION; HOMGSMR" -"OMIM:612444","CILIARY DYSKINESIA, PRIMARY, 9; CILD9" -"DOID:8619","recurrent hypersomnia" -"OMIM:616420","LEUKODYSTROPHY, HYPOMYELINATING, 10; HLD10" -"OMIM:612445","SCOLIOSIS, ARACHNODACTYLY, AND BLINDNESS" -"OMIM:612446","COMPLEMENT COMPONENT 6 DEFICIENCY; C6D" -"OMIM:616421","MYOCLONIC-ATONIC EPILEPSY; MAE" -"OMIM:130710","EMPHYSEMA, CONGENITAL LOBAR; CLE" -"OMIM:612447","SKELETAL DEFECTS, GENITAL HYPOPLASIA, AND MENTAL RETARDATION" -"OMIM:616425","46,XY SEX REVERSAL 10; SRXY10" -"DOID:4988","alcoholic pancreatitis" -"OMIM:612448","AGE-RELATED HEARING IMPAIRMENT 1; ARHI1" -"OMIM:616428","MICROPHTHALMIA, ISOLATED, WITH COLOBOMA 10; MCOPCB10" -"OMIM:616430","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 25; COXPD25" -"DOID:2913","acute pancreatitis" -"OMIM:612459","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 13; BMIQ13" -"OMIM:112010","BLOOD GROUP--WALDNER TYPE; WD" -"OMIM:603098","DEAFNESS, AUTOSOMAL RECESSIVE 13; DFNB13" -"OMIM:603116","CDAGS SYNDROME" -"OMIM:112050","BLOOD GROUP--WRIGHT ANTIGEN; WR" -"DOID:8457","pellagra" -"OMIM:603117","SPASTIC PARAPLEGIA, OPTIC ATROPHY, MICROCEPHALY, AND XY SEX REVERSAL" -"DOID:2303","stereotypic movement disorder" -"OMIM:603119","APRAXIA OF EYELID OPENING" -"OMIM:111600","BLOOD GROUP, LANGEREIS SYSTEM; LAN" -"OMIM:603133","DISLOCATED ELBOWS, BOWED TIBIAS, SCOLIOSIS, DEAFNESS, CATARACT, MICROCEPHALY, AND MENTAL RETARDATION" -"OMIM:603147","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ic; CDG1C" -"OMIM:603165","DERMATITIS, ATOPIC" -"DOID:6457","Cowden disease" -"DOID:12117","pulmonary alveolar microlithiasis" -"OMIM:603174","HOMOCYSTEINEMIA" -"OMIM:111500","BLOOD GROUP--PRIVATE SYSTEMS" -"OMIM:603175","SCHIZOPHRENIA 5; SCZD5" -"OMIM:603176","SCHIZOPHRENIA 7; SCZD7" -"OMIM:603188","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 8; BMIQ8" -"OMIM:603194","MECKEL SYNDROME, TYPE 2; MKS2" -"DOID:0060317","lung abscess" -"OMIM:111750","BLOOD GROUP--SCIANNA SYSTEM; SC" -"DOID:1271","capillary disease" -"OMIM:603204","EPILEPSY, NOCTURNAL FRONTAL LOBE, 2; ENFL2" -"DOID:4374","silo filler's disease" -"OMIM:603206","SCHIZOPHRENIA 8; SCZD8" -"OMIM:149500","KYRLE DISEASE" -"OMIM:111800","BLOOD GROUP--STOLTZFUS SYSTEM; Sf" -"DOID:0050218","polycystic echinococcosis" -"OMIM:603209","CYTIDINE MONOPHOSPHO-N-ACETYLNEURAMINIC ACID HYDROXYLASE, PSEUDOGENE; CMAHP" -"OMIM:603218","HUNTINGTON DISEASE-LIKE 1; HDL1" -"OMIM:603221","MYOPIA 3, AUTOSOMAL DOMINANT; MYP3" -"OMIM:150170","LACTIC ACIDOSIS, CHRONIC ADULT FORM" -"OMIM:603233","PSEUDOHYPOPARATHYROIDISM, TYPE IB; PHP1B" -"DOID:10337","glaucomatous atrophy of optic disc" -"OMIM:603266","DIABETES MELLITUS, INSULIN-DEPENDENT, 17; IDDM17" -"DOID:1512","chronic gonorrhea of cervix" -"OMIM:603278","FOCAL SEGMENTAL GLOMERULOSCLEROSIS 1; FSGS1" -"DOID:13994","cleidocranial dysplasia" -"OMIM:149700","LACRIMAL DUCT DEFECT; LCDD" -"OMIM:111620","RADIN BLOOD GROUP ANTIGEN; RD" -"OMIM:603282","ZINC FINGER PROTEIN 204; ZNF204" -"DOID:1792","pancreas lymphoma" -"DOID:1342","congenital hypoplastic anemia" -"OMIM:603284","CEREBRAL CAVERNOUS MALFORMATIONS 2; CCM2" -"DOID:2544","extratemporal epilepsy" -"OMIM:603285","CEREBRAL CAVERNOUS MALFORMATIONS 3; CCM3" -"DOID:5112","swayback" -"DOID:12120","pulmonary alveolar proteinosis" -"OMIM:603323","MUSCULAR DYSTROPHY, CONGENITAL, WITH CEREBELLAR ATROPHY" -"DOID:3677","pulmonary plasma cell granuloma" -"OMIM:182220","SISTER CHROMATID EXCHANGE, FREQUENCY OF" -"OMIM:603342","SCHIZOPHRENIA 2; SCZD2" -"OMIM:603358","GRACILE SYNDROME" -"DOID:3158","hand dermatosis" -"OMIM:112000","BLOOD GROUP--Ul SYSTEM; UL" -"OMIM:182230","SEPTOOPTIC DYSPLASIA" -"OMIM:149730","LACRIMOAURICULODENTODIGITAL SYNDROME; LADD" -"OMIM:171720","ALKALINE PHOSPHATASE, PLASMA LEVEL OF, QUANTITATIVE TRAIT LOCUS 1" -"OMIM:603373","HYPERTHYROIDISM, FAMILIAL GESTATIONAL" -"OMIM:603376","LONG CHAIN FATTY ACIDS, DEFECT IN TRANSPORT OF" -"DOID:9165","neurotic excoriation" -"OMIM:603383","GLAUCOMA 1, OPEN ANGLE, F; GLC1F" -"DOID:2810","middle lobe syndrome" -"OMIM:603386","THYROID CARCINOMA, NONMEDULLARY, WITH OR WITHOUT CELL OXYPHILIA" -"OMIM:149600","LABIA MINORA, INCOMPLETE ADHESION OF" -"DOID:1882","atrial heart septal defect" -"OMIM:603387","MEGALENCEPHALY-POLYMICROGYRIA-POLYDACTYLY-HYDROCEPHALUS SYNDROME 1; MPPH1" -"DOID:1584","acute chest syndrome" -"OMIM:603388","GRAVES DISEASE, SUSCEPTIBILITY TO, 2" -"OMIM:603389","OSEBOLD SKELETAL DYSPLASIA/OSTEOLYSIS SYNDROME" -"DOID:11049","meconium aspiration syndrome" -"DOID:4501","orofaciodigital syndrome" -"DOID:1701","steroid inherited metabolic disorder" -"DOID:2734","keratosis follicularis" -"OMIM:603393","OSTEOSCLEROTIC CHONDRODYSPLASIA, LETHAL, WITH INTRACELLULAR INCLUSIONS" -"OMIM:111690","BLOOD GROUP--RHESUS SYSTEM E POLYPEPTIDE; RHE" -"DOID:3309","neurodermatitis" -"DOID:2942","bronchiolitis" -"OMIM:603394","MICROCEPHALY, SEVERE, WITH SKELETAL ANOMALIES INCLUDING POSTERIOR RIB-GAP DEFECTS" -"DOID:424","pulmonary immaturity" -"OMIM:603396","TONOKI SYNDROME" -"OMIM:150230","TRICHORHINOPHALANGEAL SYNDROME, TYPE II; TRPS2" -"DOID:4399","acneiform dermatitis" -"DOID:5713","mediastinum liposarcoma" -"OMIM:612460","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 14; BMIQ14" -"OMIM:612462","PSEUDOHYPOPARATHYROIDISM, TYPE IC; PHP1C" -"DOID:5820","composite lymphoma" -"DOID:2513","basal cell carcinoma" -"OMIM:612463","PSEUDOPSEUDOHYPOPARATHYROIDISM; PPHP" -"OMIM:178651","PULMONIC STENOSIS AND DEAFNESS" -"OMIM:612469","WILMS TUMOR, ANIRIDIA, GENITOURINARY ANOMALIES, MENTAL RETARDATION, AND OBESITY SYNDROME; WAGRO" -"DOID:11076","Brucella suis brucellosis" -"OMIM:612474","CHROMOSOME 1q21.1 DELETION SYNDROME, 1.35-MB" -"DOID:0050641","Rh deficiency syndrome" -"OMIM:612475","CHROMOSOME 1q21.1 DUPLICATION SYNDROME" -"OMIM:138340","GLUTATHIONE TRANSFERASE ACTIVITY TOWARD TRANS-STILBENE OXIDE" -"OMIM:612513","CHROMOSOME 2p16.1-p15 DELETION SYNDROME" -"DOID:11747","uterine adnexa cancer" -"DOID:0111071","congenital bile acid synthesis defect 1" -"OMIM:612514","SPECIFIC LANGUAGE IMPAIRMENT 4; SLI4" -"DOID:699","mitochondrial myopathy" -"OMIM:612518","CILIARY DYSKINESIA, PRIMARY, 10; CILD10" -"OMIM:612520","DIABETES MELLITUS, INSULIN-DEPENDENT, 20; IDDM20" -"OMIM:612521","DIABETES MELLITUS, INSULIN-DEPENDENT, 21; IDDM21" -"DOID:4438","central nervous system germinoma" -"OMIM:612522","DIABETES MELLITUS, INSULIN-DEPENDENT, 22; IDDM22" -"DOID:3197","schwannoma of twelfth cranial nerve" -"OMIM:612525","PYLORIC STENOSIS, INFANTILE HYPERTROPHIC, 5; IHPS5" -"OMIM:612526","LIPODYSTROPHY, CONGENITAL GENERALIZED, TYPE 3; CGL3" -"OMIM:138110","GLUCOSE-6-PHOSPHATE DEHYDROGENASE-LIKE; G6PDL" -"OMIM:612527","DIAMOND-BLACKFAN ANEMIA 4; DBA4" -"OMIM:612528","DIAMOND-BLACKFAN ANEMIA 5; DBA5" -"DOID:0060292","X-linked chondrodysplasia punctata" -"DOID:4880","kidney clear cell sarcoma" -"OMIM:612529","AMELOGENESIS IMPERFECTA, HYPOMATURATION TYPE, IIA2; AI2A2" -"OMIM:612530","CHROMOSOME 1q41-q42 DELETION SYNDROME" -"OMIM:178300","PTOSIS, HEREDITARY CONGENITAL 1; PTOS1" -"OMIM:138500","HYPERGLYCINURIA" -"OMIM:612539","SPASTIC PARAPLEGIA 42, AUTOSOMAL DOMINANT; SPG42" -"DOID:5699","kidney liposarcoma" -"DOID:5693","adult liposarcoma" -"OMIM:612540","MYOPATHY, CONGENITAL, COMPTON-NORTH; MYPCN" -"OMIM:612541","NEUTROPENIA, SEVERE CONGENITAL, 4, AUTOSOMAL RECESSIVE; SCN4" -"OMIM:138000","GLOMUVENOUS MALFORMATIONS; GVM" -"OMIM:612542","VITAMIN B12 PLASMA LEVEL QUANTITATIVE TRAIT LOCUS 1; B12QTL1" -"OMIM:612551","FOCAL SEGMENTAL GLOMERULOSCLEROSIS 4, SUSCEPTIBILITY TO; FSGS4" -"DOID:9212","pityriasis rubra pilaris" -"DOID:3196","cellular schwannoma" -"OMIM:612554","MYOPIA 16, AUTOSOMAL DOMINANT; MYP16" -"OMIM:138060","GLUCOCORTICOID RECEPTOR-LIKE 1; GRLL1" -"OMIM:612555","BREAST-OVARIAN CANCER, FAMILIAL, SUSCEPTIBILITY TO, 2; BROVCA2" -"OMIM:612556","ADIPONECTIN, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS 1; ADIPQTL1" -"OMIM:138277","GLUTAMIC ACID DECARBOXYLASE, BRAIN, MEMBRANE FORM" -"DOID:0111066","congenital bile acid synthesis defect 5" -"OMIM:612557","LEUKEMIA, CHRONIC LYMPHOCYTIC, SUSCEPTIBILITY TO, 3" -"OMIM:612558","LEUKEMIA, CHRONIC LYMPHOCYTIC, SUSCEPTIBILITY TO, 4" -"OMIM:612559","LEUKEMIA, CHRONIC LYMPHOCYTIC, SUSCEPTIBILITY TO, 5" -"OMIM:137950","GLOMERULOPATHY WITH FIBRONECTIN DEPOSITS 1; GFND1" -"DOID:11316","histoplasmosis retinitis" -"OMIM:169000","PATELLA, FAMILIAL RECURRENT DISLOCATION OF" -"OMIM:612560","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 12; BMND12" -"OMIM:612561","DIAMOND-BLACKFAN ANEMIA 6; DBA6" -"DOID:0050434","Andersen-Tawil syndrome" -"OMIM:612562","DIAMOND-BLACKFAN ANEMIA 7; DBA7" -"OMIM:138070","GLUCOGLYCINURIA" -"OMIM:612563","DIAMOND-BLACKFAN ANEMIA 8; DBA8" -"DOID:10327","anthracosis" -"OMIM:612566","INFLAMMATORY BOWEL DISEASE 24; IBD24" -"DOID:12157","aseptic meningitis" -"OMIM:612567","INFLAMMATORY BOWEL DISEASE 25, AUTOSOMAL RECESSIVE; IBD25" -"DOID:0050177","monogenic disease" -"DOID:11717","neonatal diabetes mellitus" -"OMIM:612571","LUNG CANCER SUSCEPTIBILITY 3; LNCR3" -"DOID:8741","seborrheic dermatitis" -"DOID:399","tuberculosis" -"OMIM:616433","IMMUNODEFICIENCY 40; IMD40" -"OMIM:188025","THROMBOCYTOPENIA, PARIS-TROUSSEAU TYPE; TCPT" -"OMIM:616435","FANCONI ANEMIA, COMPLEMENTATION GROUP T; FANCT" -"OMIM:188030","THROMBOCYTOPENIC PURPURA, AUTOIMMUNE; AITP" -"OMIM:616436","EPILEPSY, FAMILIAL TEMPORAL LOBE, 7; ETL7" -"OMIM:188050","THROMBOPHILIA DUE TO THROMBIN DEFECT; THPH1" -"DOID:0060703","Muenke Syndrome" -"OMIM:126390","DNA, LOW-REPETITIVE SEQUENCES OF" -"OMIM:188055","THROMBOPHILIA DUE TO ACTIVATED PROTEIN C RESISTANCE; THPH2" -"OMIM:126850","DUODENAL ULCER, HYPERPEPSINOGENEMIC I" -"OMIM:616437","FRONTOTEMPORAL DEMENTIA AND/OR AMYOTROPHIC LATERAL SCLEROSIS 3; FTDALS3" -"DOID:2030","anxiety disorder" -"DOID:1579","respiratory system disease" -"OMIM:616439","FRONTOTEMPORAL DEMENTIA AND/OR AMYOTROPHIC LATERAL SCLEROSIS 4; FTDALS4" -"OMIM:188100","THUMB DEFORMITY" -"OMIM:188150","THUMB DEFORMITY AND ALOPECIA" -"OMIM:616445","CANDIDIASIS, FAMILIAL, 9; CANDF9" -"DOID:9884","muscular dystrophy" -"OMIM:126410","DNA, SATELLITE, ALPHA TYPE" -"OMIM:188201","THUMBS, STIFF, WITH BRACHYDACTYLY TYPE A1 AND DEVELOPMENTAL DELAY" -"OMIM:616449","BASEL-VANAGAITE-SMIRIN-YOSEF SYNDROME; BVSYS" -"DOID:0060438","Cole-Carpenter syndrome" -"OMIM:125050","DEAFNESS WITH ANHIDROTIC ECTODERMAL DYSPLASIA" -"OMIM:188400","DIGEORGE SYNDROME; DGS" -"OMIM:125310","CEREBRAL ARTERIOPATHY, AUTOSOMAL DOMINANT, WITH SUBCORTICAL INFARCTS AND LEUKOENCEPHALOPATHY, TYPE 1; CADASIL1" -"OMIM:616451","SPASTIC PARAPLEGIA 74, AUTOSOMAL RECESSIVE; SPG74" -"OMIM:616452","B-CELL EXPANSION WITH NFKB AND T-CELL ANERGY; BENTA" -"OMIM:188455","THYROGLOSSAL DUCT CYST, FAMILIAL" -"OMIM:188470","THYROID CANCER, NONMEDULLARY, 2; NMTC2" -"OMIM:616455","ZIMMERMANN-LABAND SYNDROME 2; ZLS2" -"OMIM:188550","THYROID CANCER, NONMEDULLARY, 1; NMTC1" -"DOID:10040","malignant eyelid melanoma" -"OMIM:616457","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 50; EIEE50" -"OMIM:188560","THYROID HORMONE PLASMA MEMBRANE TRANSPORT DEFECT" -"OMIM:616459","AL-RAQAD SYNDROME; ARS" -"OMIM:125260","DEFECTIVE INTERFERING PARTICLE INDUCTION, CONTROL OF" -"OMIM:616460","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 50; MRT50" -"OMIM:188570","THYROID HORMONE RESISTANCE, GENERALIZED, AUTOSOMAL DOMINANT; GRTH" -"OMIM:126840","DUODENAL ULCER DUE TO ANTRAL G-CELL HYPERFUNCTION" -"OMIM:616461","EPILEPSY, FAMILIAL TEMPORAL LOBE, 8; ETL8" -"OMIM:188580","THYROTOXIC PERIODIC PARALYSIS, SUSCEPTIBILITY TO, 1; TTPP1" -"OMIM:188700","BLOUNT DISEASE, INFANTILE" -"OMIM:616462","ACROFACIAL DYSOSTOSIS, CINCINNATI TYPE; AFDCIN" -"OMIM:125250","OPTIC ATROPHY WITH OR WITHOUT DEAFNESS, OPHTHALMOPLEGIA, MYOPATHY, ATAXIA, AND NEUROPATHY" -"OMIM:188740","TIBIA, HYPOPLASIA OR APLASIA OF, WITH POLYDACTYLY; THYP" -"OMIM:616468","EXUDATIVE VITREORETINOPATHY 6; EVR6" -"OMIM:188800","TIBIAL TORSION, BILATERAL MEDIAL" -"OMIM:616469","RETINITIS PIGMENTOSA 72; RP72" -"OMIM:188850","TL ANTIGEN" -"OMIM:616470","ULLRICH CONGENITAL MUSCULAR DYSTROPHY 2; UCMD2" -"OMIM:126700","BASAL LAMINAR DRUSEN" -"OMIM:126900","DUPUYTREN CONTRACTURE" -"OMIM:616471","BETHLEM MYOPATHY 2; BTHLM2" -"OMIM:188890","TOBACCO ADDICTION, SUSCEPTIBILITY TO" -"OMIM:616479","PROGRESSIVE EXTERNAL OPHTHALMOPLEGIA WITH MITOCHONDRIAL DNA DELETIONS, AUTOSOMAL RECESSIVE 2; PEOB2" -"DOID:4236","carcinosarcoma" -"DOID:0090085","hypogonadotropic hypogonadism 9 with or without anosmia" -"OMIM:126320","DISTICHIASIS WITH CONGENITAL ANOMALIES OF THE HEART AND PERIPHERAL VASCULATURE" -"OMIM:189000","TOE, FIFTH, NUMBER OF PHALANGES IN" -"OMIM:616481","CILIARY DYSKINESIA, PRIMARY, 32; CILD32" -"OMIM:189100","TOE, MISSHAPEN" -"OMIM:126800","DUANE RETRACTION SYNDROME 1; DURS1" -"OMIM:189150","TOE, ROTATED FIFTH" -"OMIM:616482","ACHONDROPLASIA, SEVERE, WITH DEVELOPMENTAL DELAY AND ACANTHOSIS NIGRICANS; SADDAN" -"OMIM:125230","DEAFNESS-CRANIOFACIAL SYNDROME" -"OMIM:616483","INFANTILE LIVER FAILURE SYNDROME 2; ILFS2" -"OMIM:189200","TOES, RELATIVE LENGTH OF FIRST AND SECOND" -"OMIM:616486","MICROCEPHALY 15, PRIMARY, AUTOSOMAL RECESSIVE; MCPH15" -"OMIM:189230","TOES, SPACE BETWEEN FIRST AND SECOND" -"DOID:0090083","hypogonadotropic hypogonadism 2 with or without anosmia" -"OMIM:616487","EPIDERMOLYSIS BULLOSA SIMPLEX WITH NAIL DYSTROPHY; EBSND" -"OMIM:189300","TONGUE CURLING, FOLDING, OR ROLLING" -"OMIM:126550","DOUGHNUT LESIONS OF SKULL, FAMILIAL" -"OMIM:616488","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, TYPE VIII; HSAN8" -"OMIM:189490","MALPOSITION OF TEETH WITH OR WITHOUT HYPODONTIA/OLIGODONTIA" -"OMIM:189500","WITKOP SYNDROME" -"OMIM:616489","GROWTH RESTRICTION, SEVERE, WITH DISTINCTIVE FACIES; GRDF" -"OMIM:189600","TORTICOLLIS" -"OMIM:616490","JOUBERT SYNDROME 23; JBTS23" -"OMIM:125320","DEMENTIA/PARKINSONISM WITH NON-ALZHEIMER AMYLOID PLAQUES" -"DOID:4061","testis rhabdomyosarcoma" -"OMIM:189700","TORUS PALATINUS AND TORUS MANDIBULARIS" -"OMIM:616491","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2V; CMT2V" -"DOID:0050742","nicotine dependence" -"OMIM:126370","DNA, SATELLITE, III; HS3; D1Z1" -"OMIM:616494","LEUKODYSTROPHY, HYPOMYELINATING, 11; HLD11" -"OMIM:189800","PREECLAMPSIA/ECLAMPSIA 1; PEE1" -"OMIM:189960","TRACHEOESOPHAGEAL FISTULA WITH OR WITHOUT ESOPHAGEAL ATRESIA" -"OMIM:616500","CARDIOENCEPHALOMYOPATHY, FATAL INFANTILE, DUE TO CYTOCHROME c OXIDASE DEFICIENCY 3; CEMCOX3" -"OMIM:125280","DENS EVAGINATUS" -"OMIM:616501","CARDIOENCEPHALOMYOPATHY, FATAL INFANTILE, DUE TO CYTOCHROME c OXIDASE DEFICIENCY 4; CEMCOX4" -"OMIM:189961","TRACHEOPATHIA OSTEOPLASTICA" -"OMIM:125300","DENS IN DENTE AND PALATAL INVAGINATIONS" -"OMIM:616502","CONE-ROD DYSTROPHY 21; CORD21" -"DOID:1002","endometritis" -"OMIM:190100","GENIOSPASM 1; GSM1" -"OMIM:190200","TREMOR OF INTENTION, ATAXIA, AND LIPOFUSCINOSIS" -"OMIM:616503","LETHAL CONGENITAL CONTRACTURE SYNDROME 9; LCCS9" -"DOID:1883","hepatitis C" -"OMIM:126600","DOYNE HONEYCOMB RETINAL DYSTROPHY; DHRD" -"OMIM:616505","NEUROPATHY, HEREDITARY MOTOR AND SENSORY, TYPE VIB; HMSN6B" -"OMIM:126500","DOUBLE NAIL FOR FIFTH TOE" -"OMIM:190300","TREMOR, HEREDITARY ESSENTIAL, 1; ETM1" -"DOID:0060061","cutaneous T cell lymphoma" -"OMIM:616507","OSTEOGENESIS IMPERFECTA, TYPE XVII; OI17" -"OMIM:190310","TREMOR, NYSTAGMUS, AND DUODENAL ULCER" -"DOID:0060370","autosomal recessive early-onset Parkinson disease 7" -"DOID:10132","psychosexual disorder" -"DOID:11162","respiratory failure" -"DOID:0050465","Muir-Torre syndrome" -"DOID:0060862","mal de Meleda" -"DOID:0050156","idiopathic pulmonary fibrosis" -"DOID:8533","hypopharynx cancer" -"DOID:5137","pericardium leiomyoma" -"DOID:3204","neurilemmomatosis" -"DOID:0050847","sleep apnea" -"DOID:2223","platelet storage pool deficiency" -"DOID:10629","microphthalmia" -"DOID:0110412","retinitis pigmentosa 23" -"DOID:11396","pulmonary edema" -"DOID:543","dystonia" -"OMIM:612572","RETINITIS PIGMENTOSA 46; RP46" -"OMIM:616509","CATARACT 44; CTRCT44" -"OMIM:604287","CARNEY TRIAD" -"DOID:4110","parasitic ectoparasitic infectious disease" -"OMIM:612573","MEAN PLATELET VOLUME QUANTITATIVE TRAIT LOCUS 1; MPVQTL1" -"DOID:9279","hyperhomocysteinemia" -"OMIM:604288","CARDIOMYOPATHY, DILATED, 1H; CMD1H" -"OMIM:616511","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 14; MODY14" -"DOID:14323","Marfan syndrome" -"OMIM:604290","ACERULOPLASMINEMIA" -"OMIM:612574","MEAN PLATELET VOLUME QUANTITATIVE TRAIT LOCUS 2; MPVQTL2" -"OMIM:616515","DEAFNESS, AUTOSOMAL RECESSIVE 104; DFNB104" -"DOID:0050466","Loeys-Dietz syndrome" -"DOID:10600","chronic tic disorder" -"OMIM:616516","EMERY-DREIFUSS MUSCULAR DYSTROPHY 3, AUTOSOMAL RECESSIVE; EDMD3" -"OMIM:612575","MEAN PLATELET VOLUME QUANTITATIVE TRAIT LOCUS 3; MPVQTL3" -"OMIM:604291","ASCARIS LUMBRICOIDES INFECTION, SUSCEPTIBILITY TO" -"DOID:9296","cleft lip" -"DOID:3664","mast cell neoplasm" -"OMIM:612576","CHROMOSOME 17p13.3, TELOMERIC, DUPLICATION SYNDROME" -"OMIM:616517","ACHROMATOPSIA 7; ACHM7" -"OMIM:604292","ECTRODACTYLY, ECTODERMAL DYSPLASIA, AND CLEFT LIP/PALATE SYNDROME 3; EEC3" -"OMIM:106900","ANONYCHIA-ECTRODACTYLY" -"DOID:13636","Fanconi anemia" -"DOID:420","hypertrichosis" -"OMIM:616521","MENTAL RETARDATION, AUTOSOMAL DOMINANT 39; MRD39" -"OMIM:604302","RHEUMATOID ARTHRITIS, SYSTEMIC JUVENILE" -"DOID:14449","mixed gonadal dysgenesis" -"OMIM:612577","AMYOTROPHIC LATERAL SCLEROSIS 11; ALS11" -"OMIM:612578","STATURE QUANTITATIVE TRAIT LOCUS 15; STQTL15" -"OMIM:604307","CATARACT 2, MULTIPLE TYPES; CTRCT2" -"OMIM:616531","POLYMICROGYRIA, PERISYLVIAN, WITH CEREBELLAR HYPOPLASIA AND ARTHROGRYPOSIS; PMGYCHA" -"OMIM:132450","EPIPHYSEAL DYSPLASIA, MULTIPLE, WITH MYOPIA AND CONDUCTIVE DEAFNESS; EDMMD" -"OMIM:612579","STATURE QUANTITATIVE TRAIT LOCUS 16; STQTL16" -"OMIM:604308","MASS SYNDROME" -"OMIM:616532","HERPES SIMPLEX ENCEPHALITIS, SUSCEPTIBILITY TO, 7" -"OMIM:616534","THYROID CANCER, NONMEDULLARY, 4; NMTC4" -"OMIM:612580","MENTAL RETARDATION, AUTOSOMAL DOMINANT 3; MRD3" -"OMIM:604314","BLEPHAROPHIMOSIS WITH FACIAL AND GENITAL ANOMALIES AND MENTAL RETARDATION" -"OMIM:106500","ANNULAR ERYTHEMA" -"OMIM:612581","MENTAL RETARDATION, AUTOSOMAL DOMINANT 4; MRD4" -"DOID:13405","cardiac sarcoidosis" -"OMIM:604315","ANEMIA, CONGENITAL HYPOPLASTIC, WITH MULTIPLE CONGENITAL ANOMALIES/MENTAL RETARDATION SYNDROME" -"OMIM:616535","THYROID CANCER, NONMEDULLARY, 5; NMTC5" -"OMIM:604316","PSORIASIS 5, SUSCEPTIBILITY TO; PSORS5" -"OMIM:616538","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 9; MDDGA9" -"OMIM:612582","CHROMOSOME 6pter-p24 DELETION SYNDROME" -"OMIM:106700","TOTAL ANOMALOUS PULMONARY VENOUS RETURN 1; TAPVR1" -"DOID:2741","bilirubin metabolic disorder" -"OMIM:612586","ANEURYSM, INTRACRANIAL BERRY, 9; ANIB9" -"OMIM:616539","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 26; COXPD26" -"OMIM:604317","MICROCEPHALY 2, PRIMARY, AUTOSOMAL RECESSIVE, WITH OR WITHOUT CORTICAL MALFORMATIONS; MCPH2" -"DOID:0060320","inguinal hernia" -"OMIM:125900","DIASTEMA, DENTAL MEDIAL" -"OMIM:616540","EPILEPSY, PROGRESSIVE MYOCLONIC, 9; EPM9" -"OMIM:612587","ANEURYSM, INTRACRANIAL BERRY, 10; ANIB10" -"OMIM:132800","MULTIPLE SELF-HEALING SQUAMOUS EPITHELIOMA, SUSCEPTIBILITY TO; MSSE" -"DOID:12930","dilated cardiomyopathy" -"OMIM:604320","SPINAL MUSCULAR ATROPHY, DISTAL, AUTOSOMAL RECESSIVE, 1; DSMA1" -"OMIM:604321","MICROCEPHALY 4, PRIMARY, AUTOSOMAL RECESSIVE; MCPH4" -"OMIM:612589","COLORECTAL CANCER, SUSCEPTIBILITY TO, 8; CRCS8" -"OMIM:616541","SHORT STATURE, MICROCEPHALY, AND ENDOCRINE DYSFUNCTION; SSMED" -"OMIM:125850","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 1; MODY1" -"OMIM:604324","ACNE, ADULT" -"OMIM:612590","COLORECTAL CANCER, SUSCEPTIBILITY TO, 9; CRCS9" -"OMIM:616544","RETINITIS PIGMENTOSA 73; RP73" -"DOID:11119","Gilles de la Tourette syndrome" -"OMIM:132850","EPSTEIN-BARR VIRUS INSERTION SITE 1; EBVS1" -"OMIM:106750","ANONYCHIA WITH FLEXURAL PIGMENTATION" -"OMIM:616546","SHORT-RIB THORACIC DYSPLASIA 14 WITH POLYDACTYLY; SRTD14" -"OMIM:612591","COLORECTAL CANCER, SUSCEPTIBILITY TO, 10; CRCS10" -"OMIM:125890","DIARRHEA, GLUCOSE-STIMULATED SECRETORY, WITH COMMON VARIABLE IMMUNODEFICIENCY" -"OMIM:604326","SPINOCEREBELLAR ATAXIA 12; SCA12" -"OMIM:125851","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 2; MODY2" -"OMIM:612592","COLORECTAL CANCER, SUSCEPTIBILITY TO, 11; CRCS11" -"OMIM:616549","KLIPPEL-FEIL SYNDROME 4, AUTOSOMAL RECESSIVE, WITH NEMALINE MYOPATHY AND FACIAL DYSMORPHISM; KFS4" -"DOID:1247","blood coagulation disease" -"OMIM:132990","ERYTHEMA NODOSUM, FAMILIAL" -"DOID:5621","histiocytic and dendritic cell cancer" -"OMIM:604329","HYPERTENSION, ESSENTIAL, SUSCEPTIBILITY TO, 2" -"OMIM:612593","LUNG CANCER SUSCEPTIBILITY 4; LNCR4" -"DOID:6364","migraine" -"OMIM:604335","REFLEX SYMPATHETIC DYSTROPHY" -"OMIM:616553","DYSKERATOSIS CONGENITA, AUTOSOMAL DOMINANT 6; DKCA6" -"OMIM:604348","ADVANCED SLEEP PHASE SYNDROME, FAMILIAL, 1; FASPS1" -"OMIM:616559","NOONAN SYNDROME 9; NS9" -"OMIM:133000","ERYTHEMA PALMARE HEREDITARIUM" -"OMIM:612594","MULTIPLE SCLEROSIS, SUSCEPTIBILITY TO, 2; MS2" -"OMIM:604352","FEBRILE SEIZURES, FAMILIAL, 4; FEB4" -"OMIM:616562","RETINITIS PIGMENTOSA 74; RP74" -"OMIM:612595","MULTIPLE SCLEROSIS, SUSCEPTIBILITY TO, 3; MS3" -"OMIM:162500","NEUROPATHY, HEREDITARY, WITH LIABILITY TO PRESSURE PALSIES; HNPP" -"OMIM:612596","MULTIPLE SCLEROSIS, SUSCEPTIBILITY TO, 4; MS4" -"OMIM:604356","DUANE RETRACTION SYNDROME 2; DURS2" -"OMIM:616564","NOONAN SYNDROME 10; NS10" -"OMIM:132600","PILOMATRIXOMA" -"DOID:3627","aortic aneurysm" -"OMIM:604360","SPASTIC PARAPLEGIA 11, AUTOSOMAL RECESSIVE; SPG11" -"OMIM:612599","PSORIASIS 11, SUSCEPTIBILITY TO; PSORS11" -"DOID:0080001","bone disease" -"DOID:2859","hemoglobin C disease" -"OMIM:616566","SPONDYLOCOSTAL DYSOSTOSIS 6, AUTOSOMAL RECESSIVE; SCDO6" -"OMIM:616568","GLIOMA SUSCEPTIBILITY 9; GLM9" -"OMIM:612621","MENTAL RETARDATION, AUTOSOMAL DOMINANT 5; MRD5" -"OMIM:604363","MYOCLONIC EPILEPSY, CONGENITAL DEAFNESS, MACULAR DYSTROPHY, AND PSYCHIATRIC DISORDERS" -"OMIM:125852","DIABETES MELLITUS, INSULIN-DEPENDENT, 2" -"OMIM:616570","CEREBROOCULOFACIOSKELETAL SYNDROME 3; COFS3" -"OMIM:604364","EPILEPSY, FAMILIAL FOCAL, WITH VARIABLE FOCI 1; FFEVF1" -"OMIM:612622","DIABETES MELLITUS, INSULIN-DEPENDENT, 23; IDDM23" -"OMIM:132500","EPISTAXIS, HEREDITARY" -"OMIM:162600","NEUROPATHY, WITH PARAPROTEIN IN SERUM, CEREBROSPINAL FLUID AND URINE" -"DOID:162","cancer" -"OMIM:612623","MICROVASCULAR COMPLICATIONS OF DIABETES, SUSCEPTIBILITY TO, 2; MVCD2" -"OMIM:616576","IMMUNODEFICIENCY, COMMON VARIABLE, 12; CVID12" -"OMIM:604367","LIPODYSTROPHY, FAMILIAL PARTIAL, TYPE 3; FPLD3" -"OMIM:106600","TOOTH AGENESIS, SELECTIVE, 1; STHAG1" -"OMIM:616577","EPILEPSY, HEARING LOSS, AND MENTAL RETARDATION SYNDROME; EHLMRS" -"OMIM:612624","MICROVASCULAR COMPLICATIONS OF DIABETES, SUSCEPTIBILITY TO, 3; MVCD3" -"OMIM:604369","SALLA DISEASE; SD" -"OMIM:616579","MENTAL RETARDATION, AUTOSOMAL DOMINANT 40; MRD40" -"OMIM:604370","BREAST-OVARIAN CANCER, FAMILIAL, SUSCEPTIBILITY TO, 1; BROVCA1" -"OMIM:612626","CHROMOSOME 15q26-qter DELETION SYNDROME" -"OMIM:106995","ANONYCHIA-ONYCHODYSTROPHY WITH HYPOPLASIA OR ABSENCE OF DISTAL PHALANGES" -"DOID:3951","acute myocarditis" -"OMIM:604377","CARDIOENCEPHALOMYOPATHY, FATAL INFANTILE, DUE TO CYTOCHROME c OXIDASE DEFICIENCY 1; CEMCOX1" -"OMIM:612627","SEIZURES, BENIGN FAMILIAL INFANTILE, 4; BFIS4" -"OMIM:616580","AU-KLINE SYNDROME; AUKS" -"OMIM:125853","DIABETES MELLITUS, NONINSULIN-DEPENDENT; NIDDM" -"OMIM:162400","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, TYPE IA; HSAN1A" -"OMIM:604379","HYPOTRICHOSIS 7; HYPT7" -"DOID:0050941","spastic ataxia 2" -"OMIM:612628","MICROVASCULAR COMPLICATIONS OF DIABETES, SUSCEPTIBILITY TO, 4; MVCD4" -"OMIM:616583","SPONDYLOEPIPHYSEAL DYSPLASIA, STANESCU TYPE; SEDSTN" -"OMIM:604380","ULNAR RAY DYSGENESIS WITH POSTAXIAL POLYDACTYLY AND RENAL CYSTIC DYSPLASIA" -"OMIM:612629","ADIPONECTIN, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS 4; ADIPQTL4" -"OMIM:616586","SPASTIC PARAPLEGIA 9B, AUTOSOMAL RECESSIVE; SPG9B" -"OMIM:162700","NEUTROPENIA, CHRONIC FAMILIAL" -"OMIM:612630","HAIR MORPHOLOGY 1; HRM1" -"OMIM:132900","AORTIC ANEURYSM, FAMILIAL THORACIC 4; AAT4" -"DOID:0050944","spastic ataxia 5" -"OMIM:132400","EPIPHYSEAL DYSPLASIA, MULTIPLE, 1; EDM1" -"OMIM:604381","PATENT DUCTUS ARTERIOSUS AND BICUSPID AORTIC VALVE WITH HAND ANOMALIES" -"OMIM:616589","ADAMS-OLIVER SYNDROME 6; AOS6" -"OMIM:616592","KOSAKI OVERGROWTH SYNDROME; KOGS" -"OMIM:612631","ADENYLATE KINASE DEFICIENCY, HEMOLYTIC ANEMIA DUE TO" -"OMIM:604382","LISSENCEPHALY, FAMILIAL, WITH CLEFT PALATE AND CEREBELLAR HYPOPLASIA" -"OMIM:612632","USHER SYNDROME, TYPE IH; USH1H" -"OMIM:616602","CRANIOSYNOSTOSIS 6; CRS6" -"OMIM:604387","NEPHRONOPHTHISIS 3; NPHP3" -"OMIM:162800","CYCLIC NEUTROPENIA" -"OMIM:125800","DIABETES INSIPIDUS, NEPHROGENIC, AUTOSOMAL" -"OMIM:616603","CUTIS LAXA, AUTOSOMAL DOMINANT 3; ADCL3" -"OMIM:612633","MICROVASCULAR COMPLICATIONS OF DIABETES, SUSCEPTIBILITY TO, 5; MVCD5" -"OMIM:604391","ATAXIA-TELANGIECTASIA-LIKE DISORDER 1; ATLD1" -"OMIM:106990","ANONYCHIA-ONYCHODYSTROPHY WITH BRACHYDACTYLY TYPE B AND ECTRODACTYLY" -"OMIM:107000","NAIL DISORDER, NONSYNDROMIC CONGENITAL, 6; NDNC6" -"OMIM:604393","LEBER CONGENITAL AMAUROSIS 4; LCA4" -"OMIM:132700","CYLINDROMATOSIS, FAMILIAL" -"OMIM:176860","THROMBOPHILIA DUE TO PROTEIN C DEFICIENCY, AUTOSOMAL DOMINANT; THPH3" -"OMIM:612634","MICROVASCULAR COMPLICATIONS OF DIABETES, SUSCEPTIBILITY TO, 6; MVCD6" -"DOID:3883","Lynch syndrome" -"OMIM:616604","CHROMOSOME 14q32 DUPLICATION SYNDROME, 700-KB" -"OMIM:616606","RING CHROMOSOME 14 SYNDROME" -"OMIM:612635","MICROVASCULAR COMPLICATIONS OF DIABETES, SUSCEPTIBILITY TO, 7; MVCD7" -"OMIM:604400","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 5; ARVD5" -"OMIM:129490","ECTODERMAL DYSPLASIA 10A, HYPOHIDROTIC/HAIR/NAIL TYPE, AUTOSOMAL DOMINANT; ECTD10A" -"DOID:10915","Wernicke-Korsakoff syndrome" -"OMIM:237300","CARBAMOYL PHOSPHATE SYNTHETASE I DEFICIENCY, HYPERAMMONEMIA DUE TO" -"OMIM:210750","SKIN/HAIR/EYE PIGMENTATION, VARIATION IN, 6; SHEP6" -"OMIM:237310","N-ACETYLGLUTAMATE SYNTHASE DEFICIENCY; NAGSD" -"OMIM:210900","BLOOM SYNDROME; BLM" -"OMIM:211000","BLUE DIAPER SYNDROME" -"OMIM:237400","HYPER-BETA-ALANINEMIA" -"OMIM:211120","BONE DYSPLASIA, LETHAL, HOLMGREN TYPE" -"OMIM:237450","HYPERBILIRUBINEMIA, ROTOR TYPE; HBLRR" -"OMIM:211180","BOWEN-CONRADI SYNDROME; BWCNS" -"OMIM:237500","DUBIN-JOHNSON SYNDROME; DJS" -"OMIM:211200","BOWEN SYNDROME OF MULTIPLE MALFORMATIONS" -"DOID:3611","acute retinal necrosis syndrome" -"OMIM:237550","HYPERBILIRUBINEMIA, CONJUGATED, TYPE III" -"OMIM:237800","HYPERBILIRUBINEMIA, SHUNT, PRIMARY; PSHB" -"OMIM:211350","KYPHOMELIC DYSPLASIA" -"OMIM:237900","HYPERBILIRUBINEMIA, TRANSIENT FAMILIAL NEONATAL; HBLRTFN" -"OMIM:211355","BOWING OF LONG BONES, ASYMMETRIC AND SYMMETRIC" -"DOID:0060672","Grn-related frontotemporal lobar degeneration with Tdp43 inclusions" -"OMIM:238320","LEYDIG CELL HYPOPLASIA, TYPE I" -"OMIM:211369","BRACHYDACTYLY, TYPE A2, WITH MICROCEPHALY" -"OMIM:129000","EARRING HOLES, NATURAL" -"DOID:0050783","secondary progressive multiple sclerosis" -"OMIM:211370","BRACHYMETAPODY-ANODONTIA-HYPOTRICHOSIS-ALBINOIDISM" -"OMIM:238340","HYPERLEUCINE-ISOLEUCINEMIA" -"OMIM:238350","HYPERLEXIA" -"OMIM:211380","BRACHIOSKELETOGENITAL SYNDROME" -"DOID:0050753","cerebellar ataxia" -"DOID:9622","kidney hypertrophy" -"OMIM:238600","HYPERLIPOPROTEINEMIA, TYPE I" -"OMIM:211390","SABINAS BRITTLE HAIR SYNDROME" -"OMIM:238700","HYPERLYSINEMIA, TYPE I" -"OMIM:211400","BRONCHIECTASIS WITH OR WITHOUT ELEVATED SWEAT CHLORIDE 1; BESC1" -"DOID:14272","pericholangitis" -"OMIM:238710","HYPERLYSINEMIA DUE TO DEFECT IN LYSINE TRANSPORT INTO MITOCHONDRIA" -"OMIM:129150","ECHO VIRUS 11 SENSITIVITY; E11S" -"OMIM:211450","BRONCHOMALACIA" -"DOID:2352","hemochromatosis" -"OMIM:211480","BUERGER DISEASE" -"OMIM:238750","HYPERLYSINURIA WITH HYPERAMMONEMIA" -"OMIM:238800","HYPERMETABOLISM DUE TO DEFECT IN MITOCHONDRIA" -"OMIM:211500","FAZIO-LONDE DISEASE" -"OMIM:211530","BROWN-VIALETTO-VAN LAERE SYNDROME 1; BVVLS1" -"OMIM:238950","HYPEROPIA, HIGH" -"DOID:916","liver neoplasm" -"OMIM:211600","CHOLESTASIS, PROGRESSIVE FAMILIAL INTRAHEPATIC, 1; PFIC1" -"DOID:7181","benign dermal neurilemmoma" -"OMIM:238970","HYPERORNITHINEMIA-HYPERAMMONEMIA-HOMOCITRULLINURIA SYNDROME" -"OMIM:211750","C SYNDROME" -"OMIM:239000","PAGET DISEASE OF BONE 5, JUVENILE-ONSET; PDB5" -"DOID:9651","systolic heart failure" -"OMIM:611588","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (LIMB-GIRDLE), TYPE C, 4; MDDGC4" -"OMIM:278200","WOOLLY HAIR, HYPOTRICHOSIS, EVERTED LOWER LIP, AND OUTSTANDING EARS" -"OMIM:177300","PSEUDOARTHROGRYPOSIS" -"DOID:5385","mixed cell adenoma" -"OMIM:611590","RENAL TUBULAR ACIDOSIS, DISTAL, WITH HEMOLYTIC ANEMIA" -"OMIM:278250","WRINKLY SKIN SYNDROME; WSS" -"OMIM:180870","RUVALCABA SYNDROME" -"DOID:12361","Graves' disease" -"DOID:3144","cutis laxa" -"OMIM:611597","CATARACT 12, MULTIPLE TYPES; CTRCT12" -"OMIM:177600","PSEUDOCHOLINESTERASE, INCREASE IN PLASMA LEVEL OF" -"OMIM:278300","XANTHINURIA, TYPE I; XAN1" -"DOID:1793","pancreatic cancer" -"OMIM:278700","XERODERMA PIGMENTOSUM, COMPLEMENTATION GROUP A; XPA" -"OMIM:611598","CELIAC DISEASE, SUSCEPTIBILITY TO, 6; CELIAC6" -"DOID:9097","erythematosquamous dermatosis" -"DOID:3052","Balkan nephropathy" -"OMIM:611603","LISSENCEPHALY 3; LIS3" -"OMIM:278720","XERODERMA PIGMENTOSUM, COMPLEMENTATION GROUP C; XPC" -"DOID:0110840","Usher syndrome type 2D" -"OMIM:611615","CARDIOMYOPATHY, DILATED, 1X; CMD1X" -"OMIM:278730","XERODERMA PIGMENTOSUM, COMPLEMENTATION GROUP D; XPD" -"OMIM:278740","XERODERMA PIGMENTOSUM, COMPLEMENTATION GROUP E" -"OMIM:611630","EPILEPSY, FAMILIAL TEMPORAL LOBE, 3; ETL3" -"DOID:3142","leg dermatosis" -"OMIM:611631","EPILEPSY, FAMILIAL TEMPORAL LOBE, 4; ETL4" -"OMIM:278750","XERODERMA PIGMENTOSUM, VARIANT TYPE; XPV" -"OMIM:611634","FEBRILE SEIZURES, FAMILIAL, 9; FEB9" -"OMIM:278760","XERODERMA PIGMENTOSUM, COMPLEMENTATION GROUP F; XPF" -"OMIM:611637","PRIMARY LATERAL SCLEROSIS, ADULT, 1; PLSA1" -"OMIM:278780","XERODERMA PIGMENTOSUM, COMPLEMENTATION GROUP G; XPG" -"OMIM:278800","DE SANCTIS-CACCHIONE SYNDROME" -"OMIM:611638","MICROPHTHALMIA, ISOLATED, WITH COLOBOMA 5; MCOPCB5" -"DOID:986","alopecia areata" -"DOID:14096","infertility due to extratesticular cause" -"OMIM:278850","46,XX SEX REVERSAL 2; SRXX2" -"OMIM:611644","HIRSCHSPRUNG DISEASE, SUSCEPTIBILITY TO, 9; HSCR9" -"DOID:3134","facial dermatosis" -"OMIM:278900","XYLOSIDASE DEFICIENCY" -"OMIM:611650","PERIPAPILLARY ATROPHY, BETA TYPE; PPAB" -"DOID:14330","Parkinson's disease" -"DOID:0110410","retinitis pigmentosa 69" -"OMIM:611664","SKIN/HAIR/EYE PIGMENTATION, VARIATION IN, 7; SHEP7" -"OMIM:279000","YOUNG SYNDROME" -"DOID:8574","lichen disease" -"OMIM:280000","COLOBOMA, CONGENITAL HEART DISEASE, ICHTHYOSIFORM DERMATOSIS, MENTAL RETARDATION, AND EAR ANOMALIES SYNDROME; CHIME" -"OMIM:611694","DYSTONIA WITH CEREBELLAR ATROPHY; DYTCA" -"OMIM:300000","OPITZ GBBB SYNDROME, TYPE I; GBBB1" -"OMIM:611702","SPONDYLOMETAPHYSEAL DYSPLASIA, EAST AFRICAN TYPE" -"DOID:0050185","erythema multiforme" -"OMIM:611705","SALIH MYOPATHY; SALMY" -"OMIM:300001","ICHTHYOSIS, X-LINKED, WITHOUT STEROID SULFATASE DEFICIENCY" -"DOID:3156","incontinentia pigmenti achromians" -"OMIM:611706","MIGRAINE WITH OR WITHOUT AURA, SUSCEPTIBILITY TO, 12; MGR12" -"OMIM:300004","CORPUS CALLOSUM, AGENESIS OF, WITH ABNORMAL GENITALIA" -"DOID:3892","insulinoma" -"OMIM:611717","SPONDYLOEPIPHYSEAL DYSPLASIA-BRACHYDACTYLY AND DISTINCTIVE SPEECH" -"OMIM:300009","DENT DISEASE 1" -"OMIM:300018","46,XY SEX REVERSAL 2; SRXY2" -"OMIM:611718","HYPOMAGNESEMIA 4, RENAL; HOMG4" -"OMIM:611719","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 5; COXPD5" -"OMIM:300029","RETINITIS PIGMENTOSA 3; RP3" -"DOID:6354","CLL/SLL" -"OMIM:611721","COMBINED SAPOSIN DEFICIENCY" -"OMIM:300030","DEAFNESS, X-LINKED 3; DFNX3" -"DOID:589","congenital hemolytic anemia" -"OMIM:300042","ALOPECIA, CONGENITAL; ALPC" -"OMIM:611722","KRABBE DISEASE, ATYPICAL, DUE TO SAPOSIN A DEFICIENCY" -"OMIM:300046","MENTAL RETARDATION, X-LINKED 23; MRX23" -"OMIM:611724","SKIN/HAIR/EYE PIGMENTATION, VARIATION IN, 8; SHEP8" -"DOID:11712","lipoatrophic diabetes" -"OMIM:300047","MENTAL RETARDATION, X-LINKED 20; MRX20" -"OMIM:611726","EPILEPSY, PROGRESSIVE MYOCLONIC, 3, WITH OR WITHOUT INTRACELLULAR INCLUSIONS; EPM3" -"DOID:0050830","peripheral artery disease" -"OMIM:300048","INTESTINAL PSEUDOOBSTRUCTION, NEURONAL, CHRONIC IDIOPATHIC, X-LINKED" -"OMIM:611733","DAUWERSE-PETERS SYNDROME" -"DOID:11181","serous glue ear" -"OMIM:611738","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 7; BMND7" -"OMIM:300049","PERIVENTRICULAR NODULAR HETEROTOPIA 1; PVNH1" -"DOID:4483","rhinitis" -"OMIM:611739","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 8; BMND8" -"OMIM:300054","BODY LENGTH, MOUSE, HUMAN HOMOLOG" -"DOID:5401","water-clear cell adenoma" -"DOID:8692","myeloid leukemia" -"OMIM:300055","MENTAL RETARDATION, X-LINKED, SYNDROMIC 13; MRXS13" -"OMIM:611742","SKIN/HAIR/EYE PIGMENTATION, VARIATION IN, 9; SHEP9" -"DOID:8549","chronic ulcer of skin" -"OMIM:115310","PARAGANGLIOMAS 4; PGL4" -"DOID:0110331","Leber congenital amaurosis 3" -"DOID:62","aortic valve disease" -"OMIM:251290","PSEUDO-TORCH SYNDROME 1; PTORCH1" -"DOID:0050829","pericardium disease" -"OMIM:615895","POLYGLUCOSAN BODY MYOPATHY 1 WITH OR WITHOUT IMMUNODEFICIENCY; PGBM1" -"DOID:0110583","autosomal dominant nonsyndromic deafness 59" -"OMIM:251300","GALLOWAY-MOWAT SYNDROME; GAMOS" -"OMIM:615896","HYPOTRICHOSIS 13; HYPT13" -"OMIM:615897","IMMUNODEFICIENCY 24; IMD24" -"OMIM:169150","MACULAR DYSTROPHY, PATTERNED, 1; MDPT1" -"OMIM:251400","MICROCOLON" -"OMIM:251450","DESBUQUOIS DYSPLASIA 1; DBQD1" -"OMIM:615905","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 25; EIEE25" -"OMIM:168885","PAROXYSMAL TONIC UPGAZE, BENIGN CHILDHOOD, WITH ATAXIA" -"OMIM:115300","HYPERCAROTENEMIA AND VITAMIN A DEFICIENCY, AUTOSOMAL DOMINANT" -"OMIM:615907","LYMPHEDEMA, HEREDITARY, ID; LMPH1D" -"DOID:13189","gout" -"OMIM:251505","MICROPHTHALMIA, ISOLATED, WITH COLOBOMA 4; MCOPCB4" -"OMIM:169200","PECHET FACTOR DEFICIENCY" -"DOID:0110577","autosomal dominant nonsyndromic deafness 51" -"OMIM:615909","DIAMOND-BLACKFAN ANEMIA 13; DBA13" -"OMIM:251600","MICROPHTHALMIA, ISOLATED 1; MCOP1" -"OMIM:615911","FRONTOTEMPORAL DEMENTIA AND/OR AMYOTROPHIC LATERAL SCLEROSIS 2; FTDALS2" -"OMIM:251700","MICROPHTHALMIA WITH HYPEROPIA, RETINAL DEGENERATION, MACROPHAKIA, AND DENTAL ANOMALIES" -"OMIM:251750","MICROSPHEROPHAKIA AND/OR MEGALOCORNEA, WITH ECTOPIA LENTIS AND WITH OR WITHOUT SECONDARY GLAUCOMA; MSPKA" -"OMIM:615916","CARDIOMYOPATHY, DILATED, 1NN; CMD1NN" -"OMIM:251800","MICROTIA WITH MEATAL ATRESIA AND CONDUCTIVE DEAFNESS" -"OMIM:615917","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 20; COXPD20" -"OMIM:251850","DIARRHEA 2, WITH MICROVILLUS ATROPHY; DIAR2" -"OMIM:115250","COLLAGENOMA, FAMILIAL CUTANEOUS" -"DOID:61","mitral valve disease" -"OMIM:615918","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 21; COXPD21" -"OMIM:615919","ATAXIA-TELANGIECTASIA-LIKE DISORDER 2; ATLD2" -"OMIM:251880","MITOCHONDRIAL DNA DEPLETION SYNDROME 3 (HEPATOCEREBRAL TYPE); MTDPS3" -"DOID:0110078","Leber congenital amaurosis 1" -"OMIM:615922","RETINITIS PIGMENTOSA 70; RP70" -"OMIM:251900","MITOCHONDRIAL MYOPATHY" -"DOID:0050826","tricuspid valve disease" -"OMIM:615923","EPIPHYSEAL CHONDRODYSPLASIA, MIURA TYPE; ECDM" -"OMIM:251945","MITOCHONDRIAL MYOPATHY WITH A DEFECT IN MITOCHONDRIAL-PROTEIN TRANSPORT" -"OMIM:615924","ENCEPHALOPATHY, PROGRESSIVE, WITH OR WITHOUT LIPODYSTROPHY; PELD" -"OMIM:251950","MITOCHONDRIAL MYOPATHY WITH LACTIC ACIDOSIS; MMLA" -"OMIM:615925","GROWTH HORMONE DEFICIENCY, ISOLATED PARTIAL; GHDP" -"OMIM:252010","MITOCHONDRIAL COMPLEX I DEFICIENCY" -"OMIM:169170","PATTERSON PSEUDOLEPRECHAUNISM SYNDROME" -"OMIM:252011","MITOCHONDRIAL COMPLEX II DEFICIENCY" -"OMIM:615926","WEBB-DATTANI SYNDROME; WEDAS" -"OMIM:615934","STING-ASSOCIATED VASCULOPATHY, INFANTILE-ONSET; SAVI" -"OMIM:252100","MOHR SYNDROME" -"DOID:4409","folliculitis" -"DOID:10456","tonsillitis" -"OMIM:252150","MOLYBDENUM COFACTOR DEFICIENCY, COMPLEMENTATION GROUP A; MOCODA" -"OMIM:615935","PANCREATIC AGENESIS 2; PAGEN2" -"DOID:450","myotonic disease" -"OMIM:252160","MOLYBDENUM COFACTOR DEFICIENCY, COMPLEMENTATION GROUP B; MOCODB" -"OMIM:615937","MEGALENCEPHALY-POLYMICROGYRIA-POLYDACTYLY-HYDROCEPHALUS SYNDROME 2; MPPH2" -"OMIM:169400","PELGER-HUET ANOMALY; PHA" -"DOID:0110330","Leber congenital amaurosis 13" -"DOID:8929","atrophic gastritis" -"OMIM:615938","MEGALENCEPHALY-POLYMICROGYRIA-POLYDACTYLY-HYDROCEPHALUS SYNDROME 3; MPPH3" -"OMIM:252250","MONOCYTE CHEMOTACTIC DISORDER" -"DOID:0110588","autosomal dominant nonsyndromic deafness 67" -"OMIM:115400","CARPAL DISPLACEMENT" -"OMIM:252270","MONOSOMY 7 OF BONE MARROW" -"OMIM:615942","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 44; MRT44" -"DOID:614","lymphopenia" -"OMIM:169300","PECTUS EXCAVATUM" -"DOID:11195","acute laryngopharyngitis" -"OMIM:252300","MORQUIO SYNDROME C" -"OMIM:615945","SPINOCEREBELLAR ATAXIA 37; SCA37" -"DOID:0110572","autosomal dominant nonsyndromic deafness 49" -"DOID:0050827","rheumatic heart disease" -"DOID:0110581","autosomal dominant nonsyndromic deafness 56" -"DOID:4481","allergic rhinitis" -"DOID:0050145","adenoiditis" -"DOID:0110561","autosomal dominant nonsyndromic deafness 31" -"DOID:10825","essential hypertension" -"OMIM:115470","CAT EYE SYNDROME; CES" -"OMIM:252350","MOYAMOYA DISEASE 1; MYMY1" -"DOID:0110546","autosomal dominant nonsyndromic deafness 15" -"OMIM:615947","HYPERLIPOPROTEINEMIA, TYPE ID" -"DOID:0110587","autosomal dominant nonsyndromic deafness 66" -"OMIM:615948","OROFACIODIGITAL SYNDROME XIV; OFD14" -"OMIM:252500","MUCOLIPIDOSIS II ALPHA/BETA" -"OMIM:615952","AUTOIMMUNE DISEASE, MULTISYSTEM, INFANTILE-ONSET, 1; ADMIO1" -"OMIM:252600","MUCOLIPIDOSIS III ALPHA/BETA" -"OMIM:615953","KALLIKREIN, DECREASED URINARY ACTIVITY OF" -"OMIM:252605","MUCOLIPIDOSIS III GAMMA" -"DOID:11400","pyelonephritis" -"OMIM:252650","MUCOLIPIDOSIS IV; ML4" -"OMIM:615954","ACTH-INDEPENDENT MACRONODULAR ADRENAL HYPERPLASIA 2; AIMAH2" -"OMIM:252700","MUCOPOLYSACCHARIDOSES, UNCLASSIFIED TYPES" -"OMIM:615957","SPINOCEREBELLAR ATAXIA 38; SCA38" -"OMIM:169100","CHAR SYNDROME; CHAR" -"DOID:12558","chronic progressive external ophthalmoplegia" -"OMIM:252900","MUCOPOLYSACCHARIDOSIS, TYPE IIIA; MPS3A" -"OMIM:615959","MYOPATHY, CENTRONUCLEAR, 5; CNM5" -"OMIM:168900","PATELLA, CHONDROMALACIA OF" -"OMIM:252920","MUCOPOLYSACCHARIDOSIS, TYPE IIIB; MPS3B" -"OMIM:615960","PORETTI-BOLTSHAUSER SYNDROME; PTBHS" -"OMIM:615961","ACID-LABILE SUBUNIT DEFICIENCY; ACLSD" -"OMIM:252930","MUCOPOLYSACCHARIDOSIS, TYPE IIIC; MPS3C" -"DOID:0110575","autosomal dominant nonsyndromic deafness 5" -"OMIM:615962","GLUCOCORTICOID RESISTANCE, GENERALIZED; GCCR" -"DOID:0110590","autosomal dominant nonsyndromic deafness 69" -"DOID:11429","endometriosis of pelvic peritoneum" -"DOID:10325","silicosis" -"OMIM:252940","MUCOPOLYSACCHARIDOSIS, TYPE IIID; MPS3D" -"OMIM:615963","VESICOURETERAL REFLUX 8; VUR8" -"OMIM:253000","MUCOPOLYSACCHARIDOSIS, TYPE IVA; MPS4A" -"OMIM:253010","MUCOPOLYSACCHARIDOSIS, TYPE IVB; MPS4B" -"OMIM:615966","IMMUNODEFICIENCY 26 WITH OR WITHOUT NEUROLOGIC ABNORMALITIES; IMD26" -"DOID:0110079","Leber congenital amaurosis 8" -"OMIM:615969","ALPHA-FETOPROTEIN DEFICIENCY; AFPD" -"OMIM:253200","MUCOPOLYSACCHARIDOSIS TYPE VI; MPS6" -"DOID:3965","Merkel cell carcinoma" -"DOID:3737","verrucous carcinoma" -"DOID:0060548","luminal breast carcinoma" -"OMIM:125540","DERMAL RIDGES, PATTERNLESS" -"DOID:14332","postencephalitic Parkinson disease" -"DOID:13603","obstructive jaundice" -"DOID:4680","breast metaplastic carcinoma" -"OMIM:125550","DERMAL RIDGES-OFF-THE-END; ROES" -"OMIM:125570","DERMATOGLYPHICS--ARCH ON ANY DIGIT" -"DOID:10936","schizoid personality disorder" -"OMIM:125530","DERMAL RIDGES, NELSON SYNDROME" -"DOID:4291","fibroepithelial basal cell carcinoma" -"DOID:5760","sebaceous breast carcinoma" -"DOID:5658","lipid-rich carcinoma" -"DOID:5050","Ehrlich tumor carcinoma" -"DOID:8029","sporadic breast cancer" -"DOID:6652","diffuse idiopathic skeletal hyperostosis" -"DOID:2316","brain ischemia" -"DOID:5675","cribriform carcinoma" -"DOID:0080170","normophosphatemic familial tumoral calcinosis" -"DOID:0001816","angiosarcoma" -"DOID:605","flying phobia" -"DOID:0111063","hyperphosphatemic familial tumoral calcinosis" -"DOID:4473","sarcomatoid renal cell carcinoma" -"DOID:6776","breast myoepithelial carcinoma" -"DOID:5522","basaloid squamous cell carcinoma" -"DOID:297","pleomorphic adenoma carcinoma" -"DOID:8849","sublingual gland cancer" -"DOID:11285","tick paralysis" -"DOID:4465","papillary renal cell carcinoma" -"DOID:4464","collecting duct carcinoma" -"DOID:9415","allergic asthma" -"DOID:6741","bilateral breast cancer" -"DOID:4015","spindle cell carcinoma" -"DOID:4467","renal clear cell carcinoma" -"DOID:3458","breast adenocarcinoma" -"DOID:4463","multilocular clear cell renal cell carcinoma" -"DOID:0050904","salivary gland carcinoma" -"DOID:0080147","lymphoblastic lymphoma" -"DOID:5063","basosquamous carcinoma" -"DOID:5082","liver cirrhosis" -"DOID:13035","louse-borne relapsing fever" -"DOID:9036","parotid gland cancer" -"DOID:9173","submandibular gland cancer" -"DOID:4830","adenosquamous carcinoma" -"DOID:4877","breast adenoid cystic carcinoma" -"DOID:5524","adenoid squamous cell carcinoma" -"DOID:4385","papillary squamous carcinoma" -"DOID:4454","childhood kidney cell carcinoma" -"DOID:600","animal phobia" -"DOID:0050938","breast lobular carcinoma" -"DOID:4226","endometrial stromal sarcoma" -"DOID:0050801","androgenic alopecia" -"DOID:0050636","familial visceral amyloidosis" -"DOID:4734","calciphylaxis" -"DOID:4472","mucinous tubular and spindle renal cell carcinoma" -"DOID:7843","female breast carcinoma" -"OMIM:611755","LEBER CONGENITAL AMAUROSIS 10; LCA10" -"OMIM:615970","ALPHA-FETOPROTEIN, HEREDITARY PERSISTENCE OF; HPAFP" -"OMIM:615972","NANOPHTHALMOS 4; NNO4" -"DOID:507","adjustment disorder" -"OMIM:611762","FAMILIAL COLD AUTOINFLAMMATORY SYNDROME 2; FCAS2" -"OMIM:173395","PLATELET ADENYLATE CYCLASE ACTIVITY" -"OMIM:615973","CONE-ROD DYSTROPHY 20; CORD20" -"OMIM:611771","LIPOPROTEIN GLOMERULOPATHY; LPG" -"OMIM:182980","SPINAL MUSCULAR ATROPHY, LATE-ONSET, FINKEL TYPE; SMAFK" -"OMIM:611773","ANGIOPATHY, HEREDITARY, WITH NEPHROPATHY, ANEURYSMS, AND MUSCLE CRAMPS; HANAC" -"OMIM:615974","DEAFNESS, AUTOSOMAL RECESSIVE 102; DFNB102" -"OMIM:611775","KAWASAKI DISEASE" -"OMIM:615978","IMMUNODEFICIENCY 27B; IMD27B" -"OMIM:182990","SPINAL INTRADURAL ARACHNOID CYSTS" -"OMIM:611777","BRUGADA SYNDROME 2; BRGDA2" -"OMIM:615979","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 45; MRT45" -"OMIM:176807","PROSTATE CANCER" -"OMIM:611783","ERYTHROCYTOSIS, FAMILIAL, 4; ECYT4" -"OMIM:615980","LIPODYSTROPHY, FAMILIAL PARTIAL, TYPE 6; FPLD6" -"OMIM:176780","PELVIC ORGAN PROLAPSE, SUSCEPTIBILITY TO" -"OMIM:611788","AORTIC ANEURYSM, FAMILIAL THORACIC 6; AAT6" -"OMIM:615981","BARDET-BIEDL SYNDROME 2; BBS2" -"OMIM:615982","BARDET-BIEDL SYNDROME 4; BBS4" -"OMIM:611804","ELLIPTOCYTOSIS 1; EL1" -"OMIM:176770","PROLINE-NEGATIVE AUXOTROPH OF HAMSTER, COMPLEMENTATION OF; PROA" -"OMIM:176800","PRONATION-SUPINATION OF THE FOREARM, IMPAIRMENT OF" -"OMIM:615983","BARDET-BIEDL SYNDROME 5; BBS5" -"OMIM:611808","TREMOR, HEREDITARY ESSENTIAL, AND IDIOPATHIC NORMAL PRESSURE HYDROCEPHALUS; ETINPH" -"OMIM:176700","PROGNATHISM, MANDIBULAR" -"OMIM:611809","BESTROPHINOPATHY, AUTOSOMAL RECESSIVE; ARB" -"OMIM:615984","BARDET-BIEDL SYNDROME 7; BBS7" -"OMIM:615985","BARDET-BIEDL SYNDROME 8; BBS8" -"OMIM:611812","46,XX SEX REVERSAL WITH DYSGENESIS OF KIDNEYS, ADRENALS, AND LUNGS; SERKAL" -"OMIM:611816","TEMPLE-BARAITSER SYNDROME; TMBTS" -"OMIM:615986","BARDET-BIEDL SYNDROME 9; BBS9" -"OMIM:615987","BARDET-BIEDL SYNDROME 10; BBS10" -"OMIM:611818","LONG QT SYNDROME 9; LQT9" -"OMIM:611819","LONG QT SYNDROME 10; LQT10" -"OMIM:615988","BARDET-BIEDL SYNDROME 11; BBS11" -"DOID:10935","dissociative disorder" -"OMIM:611820","LONG QT SYNDROME 11; LQT11" -"OMIM:173400","PLATELET AGGREGATION, SPONTANEOUS" -"OMIM:615989","BARDET-BIEDL SYNDROME 12; BBS12" -"OMIM:615990","BARDET-BIEDL SYNDROME 13; BBS13" -"OMIM:611862","WHITE BLOOD CELL COUNT QUANTITATIVE TRAIT LOCUS 1; WBCQ1" -"DOID:11847","coronary thrombosis" -"OMIM:611863","MICROTIA WITH NASOLACRIMAL DUCT IMPERFORATION AND EYE COLOBOMA" -"OMIM:615991","BARDET-BIEDL SYNDROME 14; BBS14" -"OMIM:611867","CHROMOSOME 22q11.2 DELETION SYNDROME, DISTAL" -"OMIM:615992","BARDET-BIEDL SYNDROME 15; BBS15" -"OMIM:615993","BARDET-BIEDL SYNDROME 16; BBS16" -"OMIM:611868","PROSTATE CANCER, HEREDITARY, 12; HPC12" -"DOID:0060646","congenital chylothorax" -"OMIM:611875","BRUGADA SYNDROME 3; BRGDA3" -"OMIM:615994","BARDET-BIEDL SYNDROME 17; BBS17" -"OMIM:615995","BARDET-BIEDL SYNDROME 18; BBS18" -"OMIM:611876","BRUGADA SYNDROME 4; BRGDA4" -"OMIM:611878","CARDIOMYOPATHY, DILATED, 1Y; CMD1Y" -"OMIM:615996","BARDET-BIEDL SYNDROME 19; BBS19" -"OMIM:611879","CARDIOMYOPATHY, DILATED, 1Z; CMD1Z" -"DOID:7326","cranial pseudosarcomatous fasciitis" -"OMIM:615999","HYPERTHYROXINEMIA, FAMILIAL DYSALBUMINEMIC; FDAH" -"DOID:9973","substance dependence" -"OMIM:611880","CARDIOMYOPATHY, DILATED, 2A; CMD2A" -"OMIM:616000","ANALBUMINEMIA; ANALBA" -"OMIM:611881","GLYCOGEN STORAGE DISEASE XII; GSD12" -"OMIM:616001","BREASTS AND/OR NIPPLES, APLASIA OR HYPOPLASIA OF, 2; BNAH2" -"OMIM:611884","CILIARY DYSKINESIA, PRIMARY, 7; CILD7" -"OMIM:616002","FOCAL SEGMENTAL GLOMERULOSCLEROSIS 7; FSGS7" -"OMIM:611886","MESOMELIC DYSPLASIA, CAMERA TYPE" -"OMIM:616004","DYSFIBRINOGENEMIA, CONGENITAL" -"DOID:0060006","artemis deficiency" -"OMIM:611890","LETHAL ARTHROGRYPOSIS WITH ANTERIOR HORN CELL DISEASE; LAAHD" -"OMIM:616005","IMMUNODEFICIENCY 36; IMD36" -"OMIM:611891","AORTIC ANEURYSM, FAMILIAL ABDOMINAL, 3; AAA3" -"OMIM:616006","HENNEKAM LYMPHANGIECTASIA-LYMPHEDEMA SYNDROME 2; HKLLS2" -"OMIM:611892","ANEURYSM, INTRACRANIAL BERRY, 6; ANIB6" -"OMIM:616007","CATARACTS, GROWTH HORMONE DEFICIENCY, SENSORY NEUROPATHY, SENSORINEURAL HEARING LOSS, AND SKELETAL DYSPLASIA; CAGSSS" -"OMIM:611895","AMYOTROPHIC LATERAL SCLEROSIS 9; ALS9" -"OMIM:616022","NEUTROPENIA, SEVERE CONGENITAL, 6, AUTOSOMAL RECESSIVE; SCN6" -"OMIM:616025","HYPERPHOSPHATASIA WITH MENTAL RETARDATION SYNDROME 5; HPMRS5" -"OMIM:611897","NANOPHTHALMOS 3; NNO3" -"OMIM:616026","FANCONI RENOTUBULAR SYNDROME 4 WITH MATURITY-ONSET DIABETES OF THE YOUNG; FRTS4" -"OMIM:611907","EPISODIC ATAXIA, TYPE 7; EA7" -"OMIM:611913","CHROMOSOME 16p11.2 DELETION SYNDROME, 593-KB" -"OMIM:616028","ADAMS-OLIVER SYNDROME 5; AOS5" -"OMIM:611920","C-REACTIVE PROTEIN, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS 1; CRPQTL1" -"OMIM:616029","ECTODERMAL DYSPLASIA/SHORT STATURE SYNDROME; ECTDS" -"DOID:1852","intrahepatic cholestasis" -"DOID:10211","cholelithiasis" -"OMIM:106240","ANISOCORIA" -"DOID:811","lipodystrophy" -"DOID:9810","polyarteritis nodosa" -"DOID:0110406","retinitis pigmentosa 30" -"DOID:4624","Ollier disease" -"DOID:0110414","retinitis pigmentosa 3" -"DOID:0070024","autosomal recessive dyskeratosis congenita 6" -"DOID:0070023","autosomal dominant dyskeratosis congenita 6" -"DOID:3825","Shwartzman phenomenon" -"DOID:0110373","retinitis pigmentosa 61" -"OMIM:106260","ANKYLOBLEPHARON-ECTODERMAL DEFECTS-CLEFT LIP/PALATE" -"DOID:0110371","retinitis pigmentosa 56" -"DOID:3574","lateral sinus thrombosis" -"DOID:0110360","retinitis pigmentosa 39" -"OMIM:106230","ANIRIDIA, MICROCORNEA, AND SPONTANEOUSLY REABSORBED CATARACT" -"DOID:0070014","autosomal dominant dyskeratosis congenita 1" -"OMIM:176250","POSTERIOR COLUMN ATAXIA" -"OMIM:106250","ANKYLOBLEPHARON FILIFORME ADNATUM AND CLEFT PALATE; AFA" -"DOID:0110363","retinitis pigmentosa 71" -"OMIM:106280","ANKYLOGLOSSIA" -"DOID:0110365","retinitis pigmentosa 28" -"OMIM:106100","ANGIOEDEMA, HEREDITARY, TYPE I; HAE1" -"DOID:11563","retinal vasculitis" -"DOID:0070020","autosomal dominant dyskeratosis congenita 4" -"DOID:2490","congenital nervous system abnormality" -"OMIM:172870","PIGMENTED PARAVENOUS CHORIORETINAL ATROPHY; PPCRA" -"OMIM:172880","PIERRE ROBIN SYNDROME AND OLIGODACTYLY" -"DOID:10932","obsessive-compulsive personality disorder" -"DOID:3049","Churg-Strauss syndrome" -"OMIM:106210","ANIRIDIA 1; AN1" -"DOID:0110408","retinitis pigmentosa 11" -"DOID:0050781","Ogden syndrome" -"OMIM:179840","RETICULAR DYSTROPHY OF RETINAL PIGMENT EPITHELIUM" -"DOID:0070021","autosomal recessive dyskeratosis congenita 4" -"DOID:14737","craniofrontonasal syndrome" -"OMIM:179850","DOWLING-DEGOS DISEASE 1; DDD1" -"DOID:12449","aplastic anemia" -"OMIM:106190","ANHIDROSIS, ISOLATED, WITH NORMAL SWEAT GLANDS; ANHD" -"DOID:0110358","retinitis pigmentosa 12" -"DOID:2555","granulomatous angiitis" -"OMIM:106220","ANIRIDIA AND ABSENT PATELLA" -"DOID:0050739","autosomal genetic disease" -"DOID:5375","hair follicle neoplasm" -"DOID:7962","tamoxifen-related endometrial lesion" -"DOID:0110389","retinitis pigmentosa 73" -"OMIM:106070","ANGIOMA, HEREDITARY NEUROCUTANEOUS" -"OMIM:133600","EXOSTOSES OF HEEL" -"OMIM:611926","IMMUNODEFICIENCY, OVARIAN DYSGENESIS, AND PULMONARY FIBROSIS" -"OMIM:133700","EXOSTOSES, MULTIPLE, TYPE I" -"DOID:1577","limited scleroderma" -"OMIM:611928","PROSTATE CANCER, HEREDITARY, 13; HPC13" -"DOID:0060272","pontocerebellar hypoplasia type 3" -"OMIM:112310","BOOMERANG DYSPLASIA" -"OMIM:144190","HYPERKERATOSIS-HYPERPIGMENTATION SYNDROME" -"OMIM:611929","CAMPTODACTYLY SYNDROME, GUADALAJARA, TYPE III" -"DOID:850","lung disease" -"OMIM:133540","COCKAYNE SYNDROME B; CSB" -"OMIM:611934","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 5; EIG5" -"DOID:57","aortic valve insufficiency" -"OMIM:112370","BRACHMANN-DE LANGE-LIKE FACIAL CHANGES WITH MICROCEPHALY, METATARSUS ADDUCTUS, AND DEVELOPMENTAL DELAY" -"OMIM:611936","CHROMOSOME 3q29 DUPLICATION SYNDROME" -"DOID:11868","chronic erythremia" -"OMIM:611938","VENTRICULAR TACHYCARDIA, CATECHOLAMINERGIC POLYMORPHIC, 2; CPVT2" -"DOID:0060293","autosomal dominant chondrodysplasia punctata" -"DOID:1036","chronic leukemia" -"OMIM:611942","EPILEPSY, CHILDHOOD ABSENCE, SUSCEPTIBILITY TO, 6; ECA6" -"DOID:7757","childhood leukemia" -"OMIM:611943","RIDDLE SYNDROME" -"OMIM:611944","LYMPHEDEMA, HEREDITARY, IB; LMPH1B" -"OMIM:611945","SPASTIC PARAPLEGIA 37, AUTOSOMAL DOMINANT; SPG37" -"OMIM:112100","YT BLOOD GROUP ANTIGEN" -"OMIM:611953","MACULAR DEGENERATION, AGE-RELATED, 11; ARMD11" -"DOID:3770","pulmonary fibrosis" -"OMIM:611955","PROSTATE CANCER, HEREDITARY, 11; HPC11" -"OMIM:112200","BLUE RUBBER BLEB NEVUS" -"OMIM:611958","PROSTATE CANCER, HEREDITARY, 14; HPC14" -"OMIM:611959","PROSTATE CANCER, HEREDITARY, 15; HPC15" -"OMIM:133690","EXOSTOSES WITH ANETODERMIA AND BRACHYDACTYLY, TYPE E" -"DOID:5822","gray zone lymphoma" -"OMIM:112240","COLE-CARPENTER SYNDROME 1; CLCRP1" -"DOID:2773","contact dermatitis" -"OMIM:611960","ASTHMA-RELATED TRAITS, SUSCEPTIBILITY TO, 7; ASRT7" -"DOID:10763","hypertension" -"OMIM:611961","STEVENSON-CAREY SYNDROME" -"DOID:6000","congestive heart failure" -"OMIM:611962","HUNTER-MACDONALD SYNDROME" -"OMIM:612001","CHROMOSOME 15q13.3 DELETION SYNDROME" -"DOID:9254","mast-cell leukemia" -"OMIM:112270","BONE PAIN, PERIODIC" -"OMIM:612004","THROMBOCYTOPENIA 4; THC4" -"OMIM:612005","CELIAC DISEASE, SUSCEPTIBILITY TO, 7; CELIAC7" -"OMIM:133750","EXTRASYSTOLES, MULTIFORM VENTRICULAR, WITH SHORT STATURE, HYPERPIGMENTATION AND MICROCEPHALY" -"OMIM:612006","CELIAC DISEASE, SUSCEPTIBILITY TO, 8; CELIAC8" -"DOID:1312","focal segmental glomerulosclerosis" -"OMIM:612007","CELIAC DISEASE, SUSCEPTIBILITY TO, 9; CELIAC9" -"OMIM:144250","HYPERLIPIDEMIA, FAMILIAL COMBINED; FCHL" -"DOID:12965","subleukemic leukemia" -"OMIM:612008","CELIAC DISEASE, SUSCEPTIBILITY TO, 10; CELIAC10" -"DOID:3687","MELAS syndrome" -"OMIM:144300","HYPERLIPOPROTEINEMIA, TYPE II, AND DEAFNESS" -"OMIM:612009","CELIAC DISEASE, SUSCEPTIBILITY TO, 11; CELIAC11" -"OMIM:112250","DIAPHYSEAL MEDULLARY STENOSIS WITH MALIGNANT FIBROUS HISTIOCYTOMA; DMSMFH" -"DOID:8761","megakaryocytic leukemia" -"OMIM:612010","CELIAC DISEASE, SUSCEPTIBILITY TO, 12; CELIAC12" -"OMIM:612011","CELIAC DISEASE, SUSCEPTIBILITY TO, 13; CELIAC13" -"OMIM:144700","RENAL CELL CARCINOMA, NONPAPILLARY; RCC" -"OMIM:133500","EXCHONDROSIS OF PINNA, POSTERIOR" -"OMIM:133705","EXTERNAL AUDITORY CANAL, BILATERAL ATRESIA OF, WITH CONGENITAL VERTICAL TALUS" -"OMIM:612015","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE In; CDG1N" -"OMIM:612016","COENZYME Q10 DEFICIENCY, PRIMARY, 4; COQ10D4" -"OMIM:144750","ENDOSTEAL HYPEROSTOSIS, AUTOSOMAL DOMINANT" -"OMIM:612017","PYLORIC STENOSIS, INFANTILE HYPERTROPHIC, 3; IHPS3" -"OMIM:144600","HYPERLIPOPROTEINEMIA, TYPE IV" -"OMIM:133701","EXOSTOSES, MULTIPLE, TYPE II" -"OMIM:612018","CATARACT 47; CTRCT47" -"OMIM:112300","BOOK SYNDROME" -"OMIM:612020","SPASTIC PARAPLEGIA 39, AUTOSOMAL RECESSIVE; SPG39" -"OMIM:612030","CORONARY HEART DISEASE, SUSCEPTIBILITY TO, 9; CHDS9" -"DOID:299","adenocarcinoma" -"DOID:1234","gender identity disorder" -"OMIM:612042","RECOMBINATION RATE QUANTITATIVE TRAIT LOCUS 1; RRQTL1" -"OMIM:144200","PALMOPLANTAR KERATODERMA, EPIDERMOLYTIC; EPPK" -"DOID:13732","panophthalmitis" -"OMIM:612052","SMOKING AS A QUANTITATIVE TRAIT LOCUS 3; SQTL3" -"OMIM:112350","WEISMANN-NETTER SYNDROME; WNS" -"OMIM:144650","HYPERLIPOPROTEINEMIA, TYPE V" -"OMIM:612067","DYSTONIA 16; DYT16" -"OMIM:612069","AMYOTROPHIC LATERAL SCLEROSIS 10 WITH OR WITHOUT FRONTOTEMPORAL DEMENTIA; ALS10" -"DOID:0110906","inflammatory bowel disease 21" -"OMIM:616030","HYPOGONADOTROPIC HYPOGONADISM 22 WITH OR WITHOUT ANOSMIA; HH22" -"OMIM:202200","GLUCOCORTICOID DEFICIENCY 1; GCCD1" -"OMIM:312910","SPASTIC PARAPARESIS AND DEAFNESS" -"OMIM:312920","SPASTIC PARAPLEGIA 2, X-LINKED; SPG2" -"OMIM:616032","FOCAL SEGMENTAL GLOMERULOSCLEROSIS 8; FSGS8" -"OMIM:202300","ADRENOCORTICAL CARCINOMA, HEREDITARY; ADCC" -"OMIM:616033","MICROCEPHALY, SHORT STATURE, AND IMPAIRED GLUCOSE METABOLISM 1; MSSGM1" -"OMIM:313000","SPATIAL VISUALIZATION, APTITUDE FOR" -"OMIM:202355","ADRENOCORTICAL UNRESPONSIVENESS TO ACTH WITH POSTRECEPTOR DEFECT" -"DOID:11202","primary hyperparathyroidism" -"OMIM:313200","SPINAL AND BULBAR MUSCULAR ATROPHY, X-LINKED 1; SMAX1" -"OMIM:202370","PEROXISOME BIOGENESIS DISORDER 2B; PBD2B" -"OMIM:616034","2,4-DIENOYL-CoA REDUCTASE DEFICIENCY; DECRD" -"DOID:0110900","inflammatory bowel disease 2" -"OMIM:616037","CILIARY DYSKINESIA, PRIMARY, 30; CILD30" -"OMIM:202400","AFIBRINOGENEMIA, CONGENITAL" -"OMIM:313350","SPLIT-HAND/FOOT MALFORMATION 2; SHFM2" -"DOID:2458","papillary conjunctivitis" -"OMIM:616038","NEU-LAXOVA SYNDROME 2; NLS2" -"OMIM:313400","SPONDYLOEPIPHYSEAL DYSPLASIA TARDA, X-LINKED; SEDT" -"OMIM:202550","AGANGLIONOSIS, TOTAL INTESTINAL" -"DOID:0110882","inflammatory bowel disease 7" -"OMIM:202600","AGENESIS OF CEREBRAL WHITE MATTER" -"OMIM:313420","SPONDYLOMETAPHYSEAL DYSPLASIA, X-LINKED" -"DOID:6128","gliomatosis cerebri" -"DOID:0110895","inflammatory bowel disease 14" -"OMIM:616039","CHARCOT-MARIE-TOOTH DISEASE, RECESSIVE INTERMEDIATE D; CMTRID" -"DOID:0110897","inflammatory bowel disease 15" -"OMIM:313480","TaqI POLYMORPHISM; TAQ1" -"OMIM:616040","MYASTHENIC SYNDROME, CONGENITAL, 7, PRESYNAPTIC; CMS7" -"OMIM:202650","AGNATHIA-OTOCEPHALY COMPLEX; AGOTC" -"OMIM:202660","PAGOD SYNDROME" -"OMIM:313490","TAURODONTISM, MICRODONTIA, AND DENS INVAGINATUS" -"DOID:3205","melanotic neurilemmoma" -"OMIM:616042","DEAFNESS, AUTOSOMAL RECESSIVE 103; DFNB103" -"OMIM:202700","NEUTROPENIA, SEVERE CONGENITAL, 1, AUTOSOMAL DOMINANT; SCN1" -"OMIM:313500","TOOTH AGENESIS, SELECTIVE, X-LINKED, 1; STHAGX1" -"OMIM:616044","DEAFNESS, AUTOSOMAL DOMINANT 65; DFNA65" -"OMIM:202900","ALANINURIA WITH MICROCEPHALY, DWARFISM, ENAMEL HYPOPLASIA, AND DIABETES MELLITUS" -"DOID:0110904","inflammatory bowel disease 8" -"OMIM:616045","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 22; COXPD22" -"OMIM:313850","THORACOABDOMINAL SYNDROME; THAS" -"OMIM:616050","AUTOINFLAMMATION WITH INFANTILE ENTEROCOLITIS; AIFEC" -"OMIM:313900","THROMBOCYTOPENIA 1; THC1" -"OMIM:203000","FRONTONASAL DYSPLASIA WITH ALAR CLEFTS" -"OMIM:314000","THROMBOCYTOPENIA WITH ELEVATED SERUM IgA AND RENAL DISEASE" -"OMIM:616051","MICROCEPHALY 13, PRIMARY, AUTOSOMAL RECESSIVE; MCPH13" -"OMIM:203100","ALBINISM, OCULOCUTANEOUS, TYPE IA; OCA1A" -"DOID:0110885","inflammatory bowel disease 10" -"DOID:0110889","inflammatory bowel disease 5" -"OMIM:314050","THROMBOCYTOPENIA WITH BETA-THALASSEMIA, X-LINKED; XLTT" -"OMIM:203200","ALBINISM, OCULOCUTANEOUS, TYPE II; OCA2" -"OMIM:616052","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (LIMB-GIRDLE), TYPE C, 7; MDDGC7" -"DOID:0110901","inflammatory bowel disease 26" -"DOID:0060496","respiratory allergy" -"OMIM:203290","ALBINISM, OCULOCUTANEOUS, TYPE III; OCA3" -"OMIM:314100","THUMBS, CONGENITAL CLASPED" -"OMIM:616053","SPINOCEREBELLAR ATAXIA 40; SCA40" -"DOID:0060062","familial juvenile hyperuricemic nephropathy" -"OMIM:616055","EPISODIC ATAXIA, TYPE 8; EA8" -"OMIM:314240","TOOTH SIZE" -"DOID:3201","sympathetic neurilemmoma" -"OMIM:203300","HERMANSKY-PUDLAK SYNDROME 1; HPS1" -"OMIM:616056","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 26; EIEE26" -"OMIM:203330","PSEUDOHYPOPARATHYROIDISM, TYPE II; PHP2" -"OMIM:314250","DYSTONIA 3, TORSION, X-LINKED; DYT3" -"DOID:0110899","inflammatory bowel disease 28" -"OMIM:203340","ALBINISM-MICROCEPHALY-DIGITAL ANOMALIES SYNDROME" -"OMIM:314300","TORTICOLLIS, KELOIDS, CRYPTORCHIDISM, AND RENAL DYSPLASIA; TKCR" -"OMIM:616059","MIRROR MOVEMENTS 3; MRMV3" -"DOID:1587","thrombocytopenia due to platelet alloimmunization" -"OMIM:616060","BLOOD GROUP, DOMBROCK SYSTEM; DO" -"OMIM:314320","TRIGONOCEPHALY WITH SHORT STATURE AND DEVELOPMENTAL DELAY" -"OMIM:203400","CORTICOSTERONE METHYLOXIDASE TYPE I DEFICIENCY" -"OMIM:616063","POROKERATOSIS 8, DISSEMINATED SUPERFICIAL ACTINIC TYPE; POROK8" -"OMIM:314360","ULNAR HYPOPLASIA WITH LOBSTER-CLAW DEFORMITY OF FEET" -"DOID:2173","eyelid neoplasm" -"OMIM:203450","ALEXANDER DISEASE; ALXDRD" -"OMIM:314380","UNIQUE GREEN PHENOMENON" -"OMIM:203500","ALKAPTONURIA; AKU" -"OMIM:616067","46,XY SEX REVERSAL 9; SRXY9" -"OMIM:203550","ALOPECIA-CONTRACTURES-DWARFISM MENTAL RETARDATION SYNDROME" -"OMIM:616069","INFLAMMATORY SKIN AND BOWEL DISEASE, NEONATAL, 2; NISBD2" -"OMIM:314390","VACTERL ASSOCIATION, X-LINKED, WITH OR WITHOUT HYDROCEPHALUS; VACTERLX" -"DOID:10652","Alzheimer Disease" -"DOID:3203","macrocystic neurilemmoma" -"OMIM:203600","ALOPECIA-EPILEPSY-OLIGOPHRENIA SYNDROME OF MOYNAHAN" -"OMIM:314400","CARDIAC VALVULAR DYSPLASIA, X-LINKED; CVD1" -"OMIM:616078","MENTAL RETARDATION, AUTOSOMAL DOMINANT 29; MRD29" -"OMIM:314500","VAN DEN BOSCH SYNDROME" -"OMIM:616079","RETINAL DYSTROPHY WITH INNER RETINAL DYSFUNCTION AND GANGLION CELL ABNORMALITIES; RDGCA" -"OMIM:203650","ALOPECIA-MENTAL RETARDATION SYNDROME 1; APMR1" -"DOID:0050136","systemic mycosis" -"OMIM:203655","ALOPECIA UNIVERSALIS CONGENITA; ALUNC" -"OMIM:314550","VESICOURETERAL REFLUX, X-LINKED; VURX" -"DOID:0060728","NGLY1-deficiency" -"DOID:11983","Prader-Willi syndrome" -"OMIM:616080","MICROCEPHALY 12, PRIMARY, AUTOSOMAL RECESSIVE; MCPH12" -"DOID:3206","plexiform schwannoma" -"OMIM:203700","MITOCHONDRIAL DNA DEPLETION SYNDROME 4A (ALPERS TYPE); MTDPS4A" -"OMIM:314560","VON WILLEBRAND DISEASE, X-LINKED FORM" -"DOID:0080160","Cytomegalovirus retinitis" -"DOID:0060532","latex allergy" -"OMIM:616081","PONTOCEREBELLAR HYPOPLASIA, TYPE 1C; PCH1C" -"OMIM:616083","MENTAL RETARDATION, AUTOSOMAL DOMINANT 30; MRD30" -"OMIM:314570","WIDOW'S PEAK SYNDROME" -"OMIM:203740","ALPHA-KETOGLUTARATE DEHYDROGENASE DEFICIENCY" -"DOID:10573","Osteomalacia" -"OMIM:616084","SIDEROBLASTIC ANEMIA WITH B-CELL IMMUNODEFICIENCY, PERIODIC FEVERS, AND DEVELOPMENTAL DELAY; SIFD" -"OMIM:314580","WIEACKER-WOLFF SYNDROME; WRWF" -"DOID:4302","cystic basal cell carcinoma" -"OMIM:203750","ALPHA-METHYLACETOACETIC ACIDURIA" -"OMIM:314600","WILDERVANCK SYNDROME" -"OMIM:616087","DIABETES MELLITUS, NONINSULIN-DEPENDENT, 5; NIDDM5" -"OMIM:203760","ALPHA-2-DEFICIENT COLLAGEN DISEASE" -"DOID:5784","esophageal neuroendocrine tumor" -"OMIM:314700","BLOOD GROUP, XG SYSTEM; XG" -"OMIM:203780","ALPORT SYNDROME, AUTOSOMAL RECESSIVE" -"OMIM:616089","BLOOD GROUP, GERBICH SYSTEM; GE" -"OMIM:314705","XG REGULATOR; XGR" -"OMIM:203800","ALSTROM SYNDROME; ALMS" -"OMIM:616093","BLOOD GROUP, ABO SYSTEM" -"OMIM:180050","RETINAL DETACHMENT" -"OMIM:204000","LEBER CONGENITAL AMAUROSIS 1; LCA1" -"OMIM:616094","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (LIMB-GIRDLE), TYPE C, 12; MDDGC12" -"OMIM:314800","XH ANTIGEN" -"DOID:3071","gliosarcoma" -"OMIM:314900","XM SYSTEM" -"OMIM:616095","MONOCARBOXYLATE TRANSPORTER 1 DEFICIENCY; MCT1D" -"OMIM:180080","RETINAL VENOUS BEADING" -"DOID:3074","giant cell glioblastoma" -"OMIM:204100","LEBER CONGENITAL AMAUROSIS 2; LCA2" -"DOID:3523","brain stem infarction" -"OMIM:204110","AMAUROSIS CONGENITA, CONE-ROD TYPE, WITH CONGENITAL HYPERTRICHOSIS" -"OMIM:616098","IMMUNODEFICIENCY 37; IMD37" -"DOID:0050741","Alcohol Dependence" -"OMIM:400004","RETINITIS PIGMENTOSA, Y-LINKED; RPY" -"DOID:5327","retinal detachment" -"OMIM:616099","PALMOPLANTAR KERATODERMA AND WOOLLY HAIR; PPKWH" -"OMIM:400021","LYMPHOMA, HODGKIN, Y-LINKED PSEUDOAUTOSOMAL" -"OMIM:204200","CEROID LIPOFUSCINOSIS, NEURONAL, 3; CLN3" -"OMIM:400042","SPERMATOGENIC FAILURE, Y-LINKED, 1; SPGFY1" -"OMIM:204300","CEROID LIPOFUSCINOSIS, NEURONAL, 4A, AUTOSOMAL RECESSIVE; CLN4A" -"OMIM:616100","AUTOIMMUNE LYMPHOPROLIFERATIVE SYNDROME, TYPE V; ALPS5" -"OMIM:300847","AUTISM, SUSCEPTIBILITY TO, X-LINKED 5; AUTSX5" -"OMIM:256450","HYPERINSULINEMIC HYPOGLYCEMIA, FAMILIAL, 1; HHF1" -"DOID:0110555","autosomal dominant nonsyndromic deafness 25" -"DOID:13476","supraglottis cancer" -"DOID:620","blood protein disease" -"OMIM:256500","NETHERTON SYNDROME; NETH" -"OMIM:300848","MENTAL RETARDATION, X-LINKED 89; MRX89" -"OMIM:300849","MENTAL RETARDATION, X-LINKED 41; MRX41" -"OMIM:256520","NEU-LAXOVA SYNDROME 1; NLS1" -"OMIM:300850","MENTAL RETARDATION, X-LINKED 90; MRX90" -"OMIM:256540","GALACTOSIALIDOSIS; GSL" -"OMIM:256550","NEURAMINIDASE DEFICIENCY" -"OMIM:300851","MENTAL RETARDATION, X-LINKED 92; MRX92" -"DOID:0110579","autosomal dominant nonsyndromic deafness 53" -"DOID:0110569","autosomal dominant nonsyndromic deafness 44" -"DOID:0110545","autosomal dominant nonsyndromic deafness 13" -"OMIM:256600","NEURODEGENERATION WITH BRAIN IRON ACCUMULATION 2A; NBIA2A" -"OMIM:300852","MENTAL RETARDATION, X-LINKED 88; MRX88" -"DOID:0080182","mixed fibrolamellar hepatocellular carcinoma" -"OMIM:256690","NEUROFACIODIGITORENAL SYNDROME" -"OMIM:300853","IMMUNODEFICIENCY, X-LINKED, WITH MAGNESIUM DEFECT, EPSTEIN-BARR VIRUS INFECTION, AND NEOPLASIA; XMEN" -"OMIM:256700","NEUROBLASTOMA, SUSCEPTIBILITY TO" -"OMIM:300854","RENAL CELL CARCINOMA, Xp11-ASSOCIATED; RCCX1" -"OMIM:300855","OGDEN SYNDROME; OGDNS" -"OMIM:256710","ELEJALDE DISEASE" -"OMIM:169710","PEPSINOGEN 3, GROUP I; PGA3" -"OMIM:300856","HYPOSPADIAS 4, X-LINKED, SUSCEPTIBILITY TO; HYSP4" -"DOID:0110559","autosomal dominant nonsyndromic deafness 2B" -"DOID:0110541","autosomal dominant nonsyndromic deafness 1" -"DOID:4905","pancreatic carcinoma" -"DOID:7005","gemistocytic astrocytoma" -"OMIM:256720","NEUROLOGIC DISEASE, INFANTILE MULTISYSTEM, WITH OSSEOUS FRAGILITY" -"OMIM:256730","CEROID LIPOFUSCINOSIS, NEURONAL, 1; CLN1" -"DOID:0110580","autosomal dominant nonsyndromic deafness 54" -"DOID:12129","bulimia nervosa" -"OMIM:300857","AMYOTROPHIC LATERAL SCLEROSIS 15 WITH OR WITHOUT FRONTOTEMPORAL DEMENTIA; ALS15" -"OMIM:300858","MENTAL RETARDATION, X-LINKED, SYNDROMIC 17; MRXS17" -"OMIM:256731","CEROID LIPOFUSCINOSIS, NEURONAL, 5; CLN5" -"OMIM:300860","MENTAL RETARDATION, X-LINKED, SYNDROMIC, NASCIMENTO TYPE; MRXSN" -"OMIM:256800","INSENSITIVITY TO PAIN, CONGENITAL, WITH ANHIDROSIS; CIPA" -"OMIM:170400","HYPOKALEMIC PERIODIC PARALYSIS, TYPE 1; HOKPP1" -"OMIM:256810","MITOCHONDRIAL DNA DEPLETION SYNDROME 6 (HEPATOCEREBRAL TYPE); MTDPS6" -"OMIM:300861","MENTAL RETARDATION, X-LINKED, SYNDROMIC, CHUDLEY-SCHWARTZ TYPE; MRXSCS" -"DOID:12128","pica disease" -"DOID:14545","seminal vesicle adenocarcinoma" -"OMIM:256840","NEUROPATHY, HEREDITARY SENSORY, WITH SPASTIC PARAPLEGIA, AUTOSOMAL RECESSIVE" -"DOID:1799","islet cell tumor" -"OMIM:300863","CHONDRODYSPLASIA WITH PLATYSPONDYLY, DISTINCTIVE BRACHYDACTYLY, HYDROCEPHALY, AND MICROPHTHALMIA" -"OMIM:170100","PROLIDASE DEFICIENCY" -"DOID:13382","megaloblastic anemia" -"DOID:0110585","autosomal dominant nonsyndromic deafness 64" -"OMIM:256850","GIANT AXONAL NEUROPATHY 1, AUTOSOMAL RECESSIVE; GAN1" -"OMIM:300864","CEREBRAL-CEREBELLAR-COLOBOMA SYNDROME, X-LINKED" -"DOID:12450","pancytopenia" -"DOID:11615","penile cancer" -"OMIM:256855","NEUROPATHY, HEREDITARY MOTOR AND SENSORY, WITH EXCESSIVE MYELIN FOLDING COMPLEX, AUTOSOMAL RECESSIVE" -"OMIM:300867","KABUKI SYNDROME 2; KABUK2" -"OMIM:300868","MULTIPLE CONGENITAL ANOMALIES-HYPOTONIA-SEIZURES SYNDROME 2; MCAHS2" -"OMIM:256860","NEUROPATHY, HEREDITARY SENSORY, ATYPICAL" -"DOID:11507","rumination disorder" -"DOID:0110565","autosomal dominant nonsyndromic deafness 3B" -"OMIM:256870","NEUROPATHY, PAINFUL" -"OMIM:300869","CHROMOSOME Xq27.3-q28 DUPLICATION SYNDROME" -"DOID:0110584","autosomal dominant nonsyndromic deafness 6" -"DOID:559","acute pyelonephritis" -"OMIM:257000","NEUROVISCERAL STORAGE DISEASE WITH CURVILINEAR BODIES" -"OMIM:300870","ANEURYSM, INTRACRANIAL BERRY, 5; ANIB5" -"DOID:5433","urinary tract papillary transitional cell benign neoplasm" -"DOID:0110567","autosomal dominant nonsyndromic deafness 41" -"DOID:0110554","autosomal dominant nonsyndromic deafness 24" -"OMIM:300872","AUTISM, SUSCEPTIBILITY TO, X-LINKED 6; AUTSX6" -"OMIM:257100","NEUTROPENIA, LETHAL CONGENITAL, WITH EOSINOPHILIA" -"DOID:0110562","autosomal dominant nonsyndromic deafness 33" -"OMIM:170390","ANDERSEN CARDIODYSRHYTHMIC PERIODIC PARALYSIS" -"OMIM:257150","NEUTROPHIL ACTIN DYSFUNCTION; NAD" -"DOID:518","scrotum neoplasm" -"OMIM:300881","BARATELA-SCOTT SYNDROME" -"OMIM:170600","NORMOKALEMIC PERIODIC PARALYSIS" -"OMIM:300882","CORNELIA DE LANGE SYNDROME 5; CDLS5" -"OMIM:257200","NIEMANN-PICK DISEASE, TYPE A" -"OMIM:170500","HYPERKALEMIC PERIODIC PARALYSIS; HYPP" -"OMIM:257220","NIEMANN-PICK DISEASE, TYPE C1; NPC1" -"DOID:0110578","autosomal dominant nonsyndromic deafness 52" -"OMIM:300884","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 36; EIEE36" -"DOID:1460","atheroembolism of kidney" -"DOID:11981","morbid obesity" -"OMIM:257270","NIGHT BLINDNESS, CONGENITAL STATIONARY, TYPE 1B; CSNB1B" -"OMIM:300886","MENTAL RETARDATION, X-LINKED, SYNDROMIC 32; MRXS32" -"DOID:0060277","pontocerebellar hypoplasia type 8" -"DOID:14118","familial lipoprotein lipase deficiency" -"OMIM:177170","PSEUDOACHONDROPLASIA; PSACH" -"DOID:0110568","autosomal dominant nonsyndromic deafness 43" -"OMIM:257300","MOSAIC VARIEGATED ANEUPLOIDY SYNDROME 1; MVA1" -"OMIM:300887","LINEAR SKIN DEFECTS WITH MULTIPLE CONGENITAL ANOMALIES 2; LSDMCA2" -"DOID:0110142","Bartter disease type 1" -"OMIM:177200","LIDDLE SYNDROME; LIDLS" -"OMIM:257320","LISSENCEPHALY 2; LIS2" -"OMIM:300888","HYPOTHYROIDISM, CENTRAL, AND TESTICULAR ENLARGEMENT; CHTE" -"DOID:3856","male reproductive organ cancer" -"DOID:0110963","Ballard syndrome" -"OMIM:257350","NUCHAL BLEB, FAMILIAL" -"OMIM:300894","NEURODEGENERATION WITH BRAIN IRON ACCUMULATION 5; NBIA5" -"DOID:0110544","autosomal dominant nonsyndromic deafness 12" -"OMIM:257400","NYSTAGMUS, CONGENITAL, AUTOSOMAL RECESSIVE" -"OMIM:300895","OHDO SYNDROME, X-LINKED; OHDOX" -"OMIM:179620","RAPH BLOOD GROUP SYSTEM" -"DOID:1076","chronic pyelonephritis" -"OMIM:257500","OBESITY-HYPOVENTILATION SYNDROME" -"DOID:3246","embryonal rhabdomyosarcoma" -"OMIM:300896","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIm; CDG2M" -"OMIM:257550","OCULAR MOTOR APRAXIA" -"OMIM:300905","CHARCOT-MARIE-TOOTH DISEASE, X-LINKED DOMINANT, 6; CMTX6" -"OMIM:257600","OCULAR MYOPATHY WITH CURARE SENSITIVITY" -"OMIM:179650","RED CELL PERMEABILITY DEFECT" -"OMIM:300908","ANEMIA, NONSPHEROCYTIC HEMOLYTIC, DUE TO G6PD DEFICIENCY" -"DOID:11132","prostatic hypertrophy" -"DOID:5639","rete testis neoplasm" -"OMIM:257790","OCULOCEREBRAL HYPOPIGMENTATION SYNDROME OF PREUS" -"OMIM:300909","ANGIOEDEMA INDUCED BY ACE INHIBITORS, SUSCEPTIBILITY TO; AEACEI" -"DOID:0110550","autosomal dominant nonsyndromic deafness 20" -"OMIM:257800","OCULOCEREBRAL SYNDROME WITH HYPOPIGMENTATION" -"OMIM:300910","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 18; BMND18" -"DOID:0110552","autosomal dominant nonsyndromic deafness 22" -"DOID:0110560","autosomal dominant nonsyndromic deafness 30" -"OMIM:257850","OCULODENTODIGITAL DYSPLASIA, AUTOSOMAL RECESSIVE" -"OMIM:300911","PARKINSONISM WITH SPASTICITY, X-LINKED; XPDS" -"DOID:0110566","autosomal dominant nonsyndromic deafness 40" -"OMIM:257910","OCULOPALATOCEREBRAL SYNDROME" -"OMIM:300912","MENTAL RETARDATION, X-LINKED 98; MRX98" -"OMIM:612073","MITOCHONDRIAL DNA DEPLETION SYNDROME 5 (ENCEPHALOMYOPATHIC WITH OR WITHOUT METHYLMALONIC ACIDURIA); MTDPS5" -"OMIM:616106","PSORIASIS 15, PUSTULAR, SUSCEPTIBILITY TO; PSORS15" -"OMIM:158350","COWDEN SYNDROME 1; CWS1" -"OMIM:612075","MITOCHONDRIAL DNA DEPLETION SYNDROME 8A (ENCEPHALOMYOPATHIC TYPE WITH RENAL TUBULOPATHY); MTDPS8A" -"DOID:3319","lymphangioleiomyomatosis" -"OMIM:616108","RETINAL DYSTROPHY, JUVENILE CATARACTS, AND SHORT STATURE SYNDROME; RDJCSS" -"DOID:1703","Richter's syndrome" -"OMIM:612076","HYPOURICEMIA, RENAL, 2; RHUC2" -"OMIM:616111","MITOCHONDRIAL COMPLEX III DEFICIENCY, NUCLEAR TYPE 9; MC3DN9" -"OMIM:612079","ALOPECIA, NEUROLOGIC DEFECTS, AND ENDOCRINOPATHY SYNDROME; ANES" -"OMIM:616113","POLYENDOCRINE-POLYNEUROPATHY SYNDROME; PEPNS" -"DOID:3341","osteitis fibrosa" -"OMIM:612083","MUSCLE STRENGTH QUANTITATIVE TRAIT LOCUS 1" -"OMIM:616115","FAMILIAL COLD AUTOINFLAMMATORY SYNDROME 4; FCAS4" -"DOID:0050785","progressive relapsing multiple sclerosis" -"OMIM:616116","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 46; MRT46" -"OMIM:612089","HYPOPHOSPHATEMIC RICKETS AND HYPERPARATHYROIDISM" -"OMIM:158400","MUSCLE CRAMPS, FAMILIAL" -"OMIM:616117","CARDIAC CONDUCTION DISEASE WITH OR WITHOUT DILATED CARDIOMYOPATHY; CCDD" -"DOID:12241","beta thalassemia" -"OMIM:612095","RETINITIS PIGMENTOSA 41; RP41" -"OMIM:616118","MACULAR DEGENERATION, EARLY-ONSET; EOMD" -"OMIM:612096","OTOSCLEROSIS 8; OTSC8" -"OMIM:612097","DEAFNESS, UNILATERAL, WITH DELAYED ENDOLYMPHATIC HYDROPS" -"OMIM:616121","GTPase, VERY LARGE INTERFERON-INDUCIBLE, PSEUDOGENE 1; GVINP1" -"OMIM:612098","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 11; CMH11" -"OMIM:616126","IMMUNODEFICIENCY 38 WITH BASAL GANGLIA CALCIFICATION; IMD38" -"DOID:1949","cholecystitis" -"OMIM:612099","TRICHOEPITHELIOMA, MULTIPLE FAMILIAL, 2" -"OMIM:616127","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 17; SCAR17" -"OMIM:612100","AUTISM, SUSCEPTIBILITY TO, 15; AUTS15" -"OMIM:616138","PERRAULT SYNDROME 5; PRLTS5" -"OMIM:612108","FASTING PLASMA GLUCOSE LEVEL QUANTITATIVE TRAIT LOCUS 1; FGQTL1" -"OMIM:616139","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 27; EIEE27" -"OMIM:616140","LEUKODYSTROPHY, HYPOMYELINATING, 9; HLD9" -"OMIM:612109","OCULOAURICULAR SYNDROME; OCACS" -"OMIM:181450","ULNAR-MAMMARY SYNDROME; UMS" -"DOID:0111030","hemochromatosis type 3" -"OMIM:616145","CATEL-MANZKE SYNDROME; CATMANS" -"OMIM:612110","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 9; BMND9" -"OMIM:181440","SCHEUERMANN DISEASE" -"OMIM:612113","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 10; BMND10" -"OMIM:616151","MACULAR DYSTROPHY, VITELLIFORM, 4; VMD4" -"DOID:1039","prolymphocytic leukemia" -"DOID:0080074","neural tube defect" -"OMIM:612114","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 11; BMND11" -"OMIM:616152","MACULAR DYSTROPHY, VITELLIFORM, 5; VMD5" -"OMIM:158580","NEURONOPATHY, DISTAL HEREDITARY MOTOR, TYPE VIIA; HMN7A" -"OMIM:612119","TREHALASE DEFICIENCY" -"OMIM:616154","PEROXISOMAL FATTY ACYL-CoA REDUCTASE 1 DISORDER; PFCRD" -"OMIM:612124","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 12; CMH12" -"OMIM:616155","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2S; CMT2S" -"OMIM:612126","GLUT1 DEFICIENCY SYNDROME 2; GLUT1DS2" -"OMIM:616158","MENTAL RETARDATION, AUTOSOMAL DOMINANT 31; MRD31" -"OMIM:616165","NEMALINE MYOPATHY 10; NEM10" -"OMIM:612132","ECTODERMAL DYSPLASIA, ANHIDROTIC, WITH T-CELL IMMUNODEFICIENCY, AUTOSOMAL DOMINANT" -"DOID:0060008","janus kinase-3 deficiency" -"DOID:14269","suppurative cholangitis" -"OMIM:616166","AORTIC ANEURYSM, FAMILIAL THORACIC 9; AAT9" -"DOID:14270","ascending cholangitis" -"OMIM:612138","EPIDERMOLYSIS BULLOSA SIMPLEX WITH PYLORIC ATRESIA; EBSPA" -"OMIM:158590","NEURONOPATHY, DISTAL HEREDITARY MOTOR, TYPE IIA; HMN2A" -"OMIM:158320","MUIR-TORRE SYNDROME; MRTES" -"OMIM:612158","CARDIOMYOPATHY, DILATED, 1AA, WITH OR WITHOUT LEFT VENTRICULAR NONCOMPACTION; CMD1AA" -"OMIM:616170","MACULAR DYSTROPHY WITH CENTRAL CONE INVOLVEMENT; CCMD" -"OMIM:616171","MICROCEPHALY AND CHORIORETINOPATHY, AUTOSOMAL RECESSIVE, 2; MCCRP2" -"OMIM:612160","HISTIOCYTOMA, ANGIOMATOID FIBROUS" -"OMIM:616172","GENERALIZED EPILEPSY WITH FEBRILE SEIZURES PLUS, TYPE 9; GEFSP9" -"OMIM:612161","ANEURYSM, INTRACRANIAL BERRY, 7; ANIB7" -"OMIM:612162","ANEURYSM, INTRACRANIAL BERRY, 8; ANIB8" -"DOID:4660","indolent systemic mastocytosis" -"OMIM:616176","BLEEDING DISORDER, PLATELET-TYPE, 19; BDPLT19" -"OMIM:616182","CHRONIC MOUNTAIN SICKNESS, SUSCEPTIBILITY TO" -"OMIM:612164","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 4; EIEE4" -"OMIM:158330","MULLERIAN APLASIA AND HYPERANDROGENISM" -"DOID:12145","detrusor sphincter dyssynergia" -"OMIM:616185","OVARIAN DYSGENESIS 4; ODG4" -"OMIM:130100","ELASTOSIS PERFORANS SERPIGINOSA; EPS" -"OMIM:612165","RETINITIS PIGMENTOSA 29; RP29" -"OMIM:616187","EPILEPSY, PROGRESSIVE MYOCLONIC 7; EPM7" -"OMIM:612198","DIASTASIS RECTI AND WEAKNESS OF THE LINEA ALBA" -"OMIM:616188","RETINAL DYSTROPHY AND OBESITY; RDOB" -"OMIM:612199","CEREBRORETINAL MICROANGIOPATHY WITH CALCIFICATIONS AND CYSTS 1; CRMCC1" -"OMIM:612201","ATRIAL FIBRILLATION, FAMILIAL, 6; ATFB6" -"DOID:10190","liver lipoma" -"OMIM:616192","ATAXIA, COMBINED CEREBELLAR AND PERIPHERAL, WITH HEARING LOSS AND DIABETES MELLITUS; ACPHD" -"OMIM:158600","SPINAL MUSCULAR ATROPHY, LOWER EXTREMITY-PREDOMINANT, 1, AUTOSOMAL DOMINANT; SMALED1" -"OMIM:612219","EWING SARCOMA; ES" -"OMIM:130080","EHLERS-DANLOS SYNDROME, PERIODONTAL TYPE, 1; EDSPD1" -"OMIM:158345","MULTIPLE EXOSTOSES WITH SPASTIC TETRAPARESIS" -"DOID:9439","chronic cholangitis" -"OMIM:130070","EHLERS-DANLOS SYNDROME WITH SHORT STATURE AND LIMB ANOMALIES; EDSSLA" -"OMIM:616193","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 47; MRT47" -"OMIM:616198","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 23; COXPD23" -"OMIM:612221","STATURE QUANTITATIVE TRAIT LOCUS 10; STQTL10" -"DOID:10461","dentin caries" -"OMIM:158500","MUSCULAR ATROPHY, ATAXIA, RETINITIS PIGMENTOSA, AND DIABETES MELLITUS" -"OMIM:158310","MUCOEPITHELIAL DYSPLASIA, HEREDITARY" -"OMIM:616199","POLYGLUCOSAN BODY MYOPATHY 2; PGBM2" -"OMIM:612223","STATURE QUANTITATIVE TRAIT LOCUS 11; STQTL11" -"OMIM:130090","EHLERS-DANLOS SYNDROME, AUTOSOMAL DOMINANT, TYPE UNSPECIFIED" -"OMIM:616200","RUIJS-AALFS SYNDROME; RJALS" -"OMIM:612224","STATURE QUANTITATIVE TRAIT LOCUS 12; STQTL12" -"DOID:615","leukopenia" -"OMIM:616201","CHRONIC ATRIAL AND INTESTINAL DYSRHYTHMIA; CAID" -"OMIM:612225","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 9; MODY9" -"OMIM:155900","MELKERSSON-ROSENTHAL SYNDROME" -"OMIM:155755","MELANOMA-ASTROCYTOMA SYNDROME" -"DOID:9978","acute female pelvic peritonitis" -"DOID:10719","toxic diffuse goiter" -"OMIM:155770","MELANOMA TUMOR ANTIGEN GP90" -"OMIM:155601","MELANOMA, CUTANEOUS MALIGNANT, SUSCEPTIBILITY TO, 2; CMM2" -"OMIM:185120","STRATTON-PARKER SYNDROME" -"OMIM:182960","NEURONOPATHY, DISTAL HEREDITARY MOTOR, TYPE I; HMN1" -"DOID:0110034","X-linked Alport syndrome" -"DOID:6482","lung acinar adenocarcinoma" -"OMIM:155950","MELORHEOSTOSIS, ISOLATED" -"DOID:8920","leukoplakia of vagina" -"OMIM:155500","MEGALODACTYLY" -"DOID:7267","lung clear cell carcinoma" -"DOID:13911","achromatopsia" -"DOID:0050795","cone dystrophy" -"DOID:5403","microcystic adenoma" -"DOID:1240","leukemia" -"DOID:5158","pleural cancer" -"DOID:5390","clear cell adenoma" -"OMIM:155720","MELANOMA, UVEAL" -"DOID:4926","bronchiolo-alveolar adenocarcinoma" -"OMIM:155980","MEMBRANOUS CRANIAL OSSIFICATION, DELAYED" -"DOID:10974","oophoritis" -"DOID:7168","lung occult adenocarcinoma" -"DOID:5804","discrete subaortic stenosis" -"DOID:9207","periodic limb movement disorder" -"DOID:5398","lipoadenoma" -"DOID:203","exostosis" -"OMIM:155700","MELANOMA, MALIGNANT FAMILIAL INTRAOCULAR" -"DOID:3069","astrocytoma" -"OMIM:155600","MELANOMA, CUTANEOUS MALIGNANT, SUSCEPTIBILITY TO, 1; CMM1" -"DOID:9470","bacterial meningitis" -"DOID:0060161","Kennedy's disease" -"OMIM:191540","URATE OXIDASE, PSEUDOGENE; UOX" -"OMIM:132090","EPILEPSY, BENIGN OCCIPITAL; BOE" -"DOID:7147","ankylosing spondylitis" -"OMIM:191550","URETER, BIFID OR DOUBLE" -"OMIM:132000","EPIDERMOLYSIS BULLOSA WITH CONGENITAL LOCALIZED ABSENCE OF SKIN AND DEFORMITY OF NAILS" -"OMIM:191600","URETER, CANCER OF" -"OMIM:114290","CAMPOMELIC DYSPLASIA" -"OMIM:191650","URETEROCELE" -"DOID:11516","hypertensive heart disease" -"OMIM:132100","PHOTOPAROXYSMAL RESPONSE 1; PPR1" -"OMIM:191700","UROLITHIASIS, URIC ACID, AUTOSOMAL DOMINANT" -"OMIM:191800","URINARY BLADDER, ATONY OF" -"OMIM:191830","RENAL HYPODYSPLASIA/APLASIA 1; RHDA1" -"DOID:8337","appendicitis" -"DOID:12785","diabetic polyneuropathy" -"OMIM:191850","URTICARIA, AQUAGENIC" -"OMIM:191900","MUCKLE-WELLS SYNDROME; MWS" -"OMIM:191950","URTICARIA, FAMILIAL LOCALIZED HEAT" -"OMIM:114200","CAMPTODACTYLY 1; CAMPD1" -"OMIM:192000","UTERINE ANOMALIES" -"OMIM:182255","SKELETAL DYSPLASIA WITH DELAYED EPIPHYSEAL AND CARPAL BONE OSSIFICATION" -"OMIM:192050","UTERUS BICORNIS BICOLLIS WITH PARTIAL VAGINAL SEPTUM AND UNILATERAL HEMATOCOLPOS WITH IPSILATERAL RENAL AGENESIS" -"OMIM:192100","UVULA, BIFID" -"DOID:9768","heart aneurysm" -"OMIM:192200","VARICOSE VEINS" -"OMIM:192300","VASCULAR HELIX OF UMBILICAL CORD" -"DOID:0111065","autosomal recessive distal spinal muscular atrophy 2" -"OMIM:192310","VASCULITIS, LYMPHOCYTIC, NODULAR" -"OMIM:192315","VASCULOPATHY, RETINAL, WITH CEREBRAL LEUKODYSTROPHY; RVCL" -"OMIM:192350","VATER/VACTERL ASSOCIATION" -"OMIM:131960","EPIDERMOLYSIS BULLOSA SIMPLEX WITH MOTTLED PIGMENTATION; EBSMP" -"OMIM:192400","VEINS, PATTERN OF, ON ANTERIOR THORAX" -"DOID:9778","irritable bowel syndrome" -"OMIM:192430","VELOCARDIOFACIAL SYNDROME" -"OMIM:192445","VENTRICULAR EXTRASYSTOLES WITH SYNCOPE, PERODACTYLY, AND ROBIN SEQUENCE" -"OMIM:192500","LONG QT SYNDROME 1; LQT1" -"DOID:0050825","endocardium disease" -"OMIM:192600","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 1; CMH1" -"OMIM:192605","VENTRICULAR TACHYCARDIA, FAMILIAL" -"OMIM:192700","VENULAR INSUFFICIENCY, SYSTEMIC" -"OMIM:192800","VERTEBRAL FUSION, POSTERIOR LUMBOSACRAL, WITH BLEPHAROPTOSIS" -"DOID:0080178","mucositis" -"DOID:0060160","survival motor neuron spinal muscular atrophy" -"OMIM:192900","VERTEBRAL HYPOPLASIA WITH LUMBAR KYPHOSIS" -"OMIM:192950","VERTICAL TALUS, CONGENITAL; CVT" -"DOID:14654","prostatitis" -"OMIM:193000","VESICOURETERAL REFLUX 1; VUR1" -"OMIM:193003","NYSTAGMUS 4, CONGENITAL, AUTOSOMAL DOMINANT; NYS4" -"OMIM:131950","EPIDERMOLYSIS BULLOSA SIMPLEX, OGNA TYPE; EBSOG" -"DOID:3410","carotid artery thrombosis" -"OMIM:193005","VESTIBULOCOCHLEAR DYSFUNCTION, PROGRESSIVE" -"OMIM:193007","VERTIGO, BENIGN RECURRENT; BRV" -"DOID:12783","migraine without aura" -"OMIM:193070","VIRUS RD114 RNA COMPLEMENTARITY" -"OMIM:132300","EPILEPSY, READING" -"DOID:9065","leishmaniasis" -"OMIM:193090","TRANSCOBALAMIN I DEFICIENCY" -"OMIM:193100","HYPOPHOSPHATEMIC RICKETS, AUTOSOMAL DOMINANT; ADHR" -"DOID:10247","pleurisy" -"OMIM:193200","VITILIGO-ASSOCIATED MULTIPLE AUTOIMMUNE DISEASE SUSCEPTIBILITY 6; VAMAS6" -"OMIM:612226","STATURE QUANTITATIVE TRAIT LOCUS 13; STQTL13" -"OMIM:616202","CEREBELLOFACIODENTAL SYNDROME; CFDS" -"OMIM:612227","DIABETES MELLITUS, KETOSIS-PRONE; KPD" -"OMIM:616204","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 18; SCAR18" -"OMIM:616208","AMYOTROPHIC LATERAL SCLEROSIS 22 WITH OR WITHOUT FRONTOTEMPORAL DEMENTIA; ALS22" -"OMIM:612228","STATURE QUANTITATIVE TRAIT LOCUS 14; STQTL14" -"OMIM:616209","MYOPATHY, ISOLATED MITOCHONDRIAL, AUTOSOMAL DOMINANT; IMMD" -"OMIM:612229","COLORECTAL CANCER, SUSCEPTIBILITY TO, 3; CRCS3" -"OMIM:115210","CARDIOMYOPATHY, FAMILIAL RESTRICTIVE, 1; RCM1" -"DOID:401","multidrug-resistant tuberculosis" -"OMIM:612230","COLORECTAL CANCER, SUSCEPTIBILITY TO, 5; CRCS5" -"OMIM:616211","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 28; EIEE28" -"OMIM:612231","COLORECTAL CANCER, SUSCEPTIBILITY TO, 6; CRCS6" -"OMIM:616212","LISSENCEPHALY 6 WITH MICROCEPHALY; LIS6" -"OMIM:115200","CARDIOMYOPATHY, DILATED, 1A; CMD1A" -"OMIM:616214","HYPERPROINSULINEMIA" -"OMIM:115197","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 4; CMH4" -"OMIM:612232","COLORECTAL CANCER, SUSCEPTIBILITY TO, 7; CRCS7" -"OMIM:616216","THROMBOCYTOPENIA 5; THC5" -"OMIM:612233","LEUKODYSTROPHY, HYPOMYELINATING, 4; HLD4" -"DOID:13724","scurvy" -"OMIM:616217","NEPHRONOPHTHISIS 19; NPHP19" -"DOID:11203","Angelucci's syndrome" -"OMIM:612237","CHONDROSARCOMA, EXTRASKELETAL MYXOID" -"DOID:552","pneumonia" -"OMIM:612238","SCOLIOSIS, ISOLATED, SUSCEPTIBILITY TO, 4; IS4" -"OMIM:616219","FIBROSIS OF EXTRAOCULAR MUSCLES, CONGENITAL, 5; CFEOM5" -"DOID:4303","sarcomatoid basal cell carcinoma" -"OMIM:616220","FOCAL SEGMENTAL GLOMERULOSCLEROSIS 9; FSGS9" -"OMIM:612239","SCOLIOSIS, ISOLATED, SUSCEPTIBILITY TO, 5; IS5" -"DOID:3517","conventional fibrosarcoma" -"OMIM:616221","AMELOGENESIS IMPERFECTA, TYPE IH; AI1H" -"OMIM:612240","ATRIAL FIBRILLATION, FAMILIAL, 7; ATFB7" -"DOID:4300","superficial basal cell carcinoma" -"OMIM:612241","INFLAMMATORY BOWEL DISEASE 12; IBD12" -"OMIM:616222","TEMPLE SYNDROME" -"DOID:9452","fatty liver disease" -"OMIM:612242","CHROMOSOME 10q22.3-q23.2 DELETION SYNDROME" -"OMIM:616224","MYASTHENIC SYNDROME, CONGENITAL, 22; CMS22" -"OMIM:616227","MYASTHENIC SYNDROME, CONGENITAL, 15; CMS15" -"OMIM:612244","INFLAMMATORY BOWEL DISEASE 13; IBD13" -"OMIM:612245","INFLAMMATORY BOWEL DISEASE 14; IBD14" -"OMIM:616228","MYASTHENIC SYNDROME, CONGENITAL, 14; CMS14" -"DOID:13121","deficiency anemia" -"DOID:4914","esophagus adenocarcinoma" -"OMIM:616229","OSTEOGENESIS IMPERFECTA, TYPE XVI; OI16" -"OMIM:115196","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 3; CMH3" -"OMIM:612247","CROUZON SYNDROME WITH ACANTHOSIS NIGRICANS; CAN" -"DOID:1074","kidney failure" -"OMIM:612251","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 10; SLEB10" -"OMIM:616230","EPILEPSY, PROGRESSIVE MYOCLONIC, 8; EPM8" -"OMIM:612253","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 11; SLEB11" -"OMIM:616231","MYOPATHY, VACUOLAR, WITH CASQ1 AGGREGATES; VMCQA" -"OMIM:616239","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 24; COXPD24" -"OMIM:612254","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 12; SLEB12" -"DOID:8677","perinatal necrotizing enterocolitis" -"OMIM:616247","LONG QT SYNDROME 14; LQT14" -"OMIM:612255","INFLAMMATORY BOWEL DISEASE 15; IBD15" -"DOID:4448","macular degeneration" -"OMIM:616248","LETHAL CONGENITAL CONTRACTURE SYNDROME 6; LCCS6" -"OMIM:612259","INFLAMMATORY BOWEL DISEASE 16; IBD16" -"DOID:10286","prostate carcinoma" -"OMIM:616249","LONG QT SYNDROME 15; LQT15" -"OMIM:612260","MYD88 DEFICIENCY; MYD88D" -"DOID:1415","gyrate atrophy" -"OMIM:612261","INFLAMMATORY BOWEL DISEASE 17; IBD17" -"OMIM:616255","SHORT STATURE WITH NONSPECIFIC SKELETAL ABNORMALITIES; SNSK" -"OMIM:612262","INFLAMMATORY BOWEL DISEASE 18; IBD18" -"OMIM:616258","MECKEL SYNDROME 12; MKS12" -"DOID:11245","transient neonatal neutropenia" -"OMIM:616260","TENORIO SYNDROME; TNORS" -"OMIM:612263","MELANOMA, CUTANEOUS MALIGNANT, SUSCEPTIBILITY TO, 7; CMM7" -"OMIM:610760","CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 2" -"DOID:0110080","Leber congenital amaurosis 12" -"OMIM:610761","HIGH DENSITY LIPOPROTEIN CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 5" -"OMIM:615553","ARTHROGRYPOSIS, MENTAL RETARDATION, AND SEIZURES; AMRS" -"OMIM:269720","SEIZURES, BENIGN FAMILIAL NEONATAL, AUTOSOMAL RECESSIVE" -"DOID:9858","deep keratitis" -"OMIM:615554","MULTIPLE FIBROADENOMAS OF THE BREAST; MFAB" -"OMIM:610762","HIGH DENSITY LIPOPROTEIN CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 6; HDLCQ6" -"OMIM:269800","SENILE PLAQUE FORMATION" -"OMIM:615555","HYPERPROLACTINEMIA; HPRL" -"OMIM:269840","IMMUNODEFICIENCY 48; IMD48" -"DOID:0060343","glucocorticoid-induced osteoporosis" -"OMIM:610768","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Im; CDG1M" -"OMIM:610773","MITOCHONDRIAL PHOSPHATE CARRIER DEFICIENCY" -"OMIM:615557","MELIOIDOSIS, SUSCEPTIBILITY TO" -"OMIM:269860","SHORT-RIB THORACIC DYSPLASIA 12; SRTD12" -"DOID:2871","endometrial carcinoma" -"DOID:9270","Alkaptonuria" -"DOID:4163","ganglioneuroblastoma" -"DOID:417","hypersensitivity reaction type II disease" -"OMIM:615558","HYPOBETALIPOPROTEINEMIA, FAMILIAL, 1; FHBL1" -"OMIM:269870","SHORT STATURE-OBESITY SYNDROME; SSOS" -"OMIM:610797","EPIPHYSEAL DYSPLASIA, BAUMANN TYPE" -"OMIM:615559","AUTOIMMUNE LYMPHOPROLIFERATIVE SYNDROME, TYPE III; ALPS3" -"OMIM:269880","SHORT SYNDROME" -"OMIM:610798","IMMUNODEFICIENCY DUE TO DEFECT IN MAPBP-INTERACTING PROTEIN" -"DOID:0110217","Leber congenital amaurosis 17" -"OMIM:615560","OTOFACIOCERVICAL SYNDROME 2; OTFCS2" -"OMIM:610799","INVASIVE PNEUMOCOCCAL DISEASE, RECURRENT ISOLATED, 1; IPD1" -"OMIM:269920","INFANTILE SIALIC ACID STORAGE DISEASE; ISSD" -"OMIM:134000","FACIAL HYPERTRICHOSIS" -"DOID:0050073","invasive aspergillosis" -"OMIM:133800","EYEBROW, WHORL IN" -"OMIM:610805","CONGENITAL ANOMALIES OF KIDNEY AND URINARY TRACT 1, SUSCEPTIBILITY TO; CAKUT1" -"OMIM:269921","SIALURIA" -"OMIM:615561","COMPLEMENT FACTOR B DEFICIENCY; CFBD" -"DOID:5435","variant Creutzfeldt-Jakob disease" -"OMIM:270100","HETEROTAXY, VISCERAL, 5, AUTOSOMAL; HTX5" -"DOID:0110189","Leber congenital amaurosis 15" -"OMIM:610828","HOLOPROSENCEPHALY 7; HPE7" -"DOID:0080158","herpes simplex virus keratitis" -"OMIM:615565","RETINITIS PIGMENTOSA 67; RP67" -"OMIM:610829","HOLOPROSENCEPHALY 9; HPE9" -"DOID:13042","persistent fetal circulation syndrome" -"DOID:0110118","Leber congenital amaurosis 16" -"OMIM:134300","FACIAL SPASM" -"OMIM:270150","SJOGREN SYNDROME" -"DOID:0050597","intestinal schistosomiasis" -"OMIM:615573","NEPHROTIC SYNDROME, TYPE 9; NPHS9" -"OMIM:610830","POLYOSTEOLYSIS-HYPEROSTOSIS SYNDROME" -"OMIM:615574","ASPARAGINE SYNTHETASE DEFICIENCY; ASNSD" -"OMIM:270200","SJOGREN-LARSSON SYNDROME; SLS" -"DOID:8463","corneal ulcer" -"DOID:0110005","Leber congenital amaurosis 9" -"DOID:9460","uterine corpus cancer" -"OMIM:270220","SJOGREN-LARSSON-LIKE ICHTHYOSIS WITHOUT CNS OR EYE INVOLVEMENT" -"OMIM:615575","NEURONOPATHY, DISTAL HEREDITARY MOTOR, TYPE IID; HMN2D" -"OMIM:610832","FANCONI ANEMIA, COMPLEMENTATION GROUP N; FANCN" -"DOID:0050433","fatal familial insomnia" -"OMIM:270300","PEELING SKIN SYNDROME 1; PSS1" -"OMIM:615577","IMMUNODEFICIENCY, COMMON VARIABLE, 10; CVID10" -"OMIM:610836","AUTISM, SUSCEPTIBILITY TO, 11; AUTS11" -"DOID:3528","anterior cerebral artery infarction" -"DOID:9352","type 2 diabetes mellitus" -"OMIM:270350","ANOSMIA FOR BUTYL MERCAPTAN" -"DOID:0110216","Leber congenital amaurosis 11" -"DOID:0110188","Leber congenital amaurosis 14" -"DOID:2217","Bernard-Soulier syndrome" -"OMIM:610838","AUTISM, SUSCEPTIBILITY TO, 12; AUTS12" -"OMIM:615578","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 18; COXPD18" -"OMIM:615582","LOEYS-DIETZ SYNDROME 5; LDS5" -"OMIM:270400","SMITH-LEMLI-OPITZ SYNDROME; SLOS" -"OMIM:610839","OSTEOARTHRITIS SUSCEPTIBILITY 4; OS4" -"DOID:0110332","Leber congenital amaurosis 4" -"OMIM:615583","VERHEIJ SYNDROME; VRJS" -"OMIM:270420","DIARRHEA 3, SECRETORY SODIUM, CONGENITAL, WITH OR WITHOUT OTHER CONGENITAL ANOMALIES; DIAR3" -"OMIM:610840","MITRAL VALVE PROLAPSE 3; MVP3" -"DOID:0110975","brachydactyly type B2" -"OMIM:610842","PSEUDOXANTHOMA ELASTICUM-LIKE DISORDER WITH MULTIPLE COAGULATION FACTOR DEFICIENCY" -"OMIM:134200","FACIAL PALSY, FAMILIAL RECURRENT PERIPHERAL" -"OMIM:615589","OTOSCLEROSIS 10; OTSC10" -"OMIM:134520","FACTORS VIII, IX AND XI, COMBINED DEFICIENCY OF" -"DOID:0110329","Leber congenital amaurosis 6" -"OMIM:270425","SODIUM-POTASSIUM-ATPase ACTIVITY OF RED CELL" -"OMIM:270450","INSULIN-LIKE GROWTH FACTOR I, RESISTANCE TO" -"OMIM:615590","ALZHEIMER DISEASE 18; AD18" -"OMIM:610852","CILIARY DYSKINESIA, PRIMARY, 6; CILD6" -"OMIM:109600","BEETURIA" -"DOID:4664","filamentary keratitis" -"OMIM:270460","SONODA SYNDROME" -"OMIM:610871","SAKODA COMPLEX" -"OMIM:615591","MACULAR DEGENERATION, AGE-RELATED, 15; ARMD15" -"OMIM:270500","ATAXIA, SPASTIC, CHILDHOOD-ONSET, AUTOSOMAL RECESSIVE, WITH OPTIC ATROPHY AND MENTAL RETARDATION" -"OMIM:615592","IMMUNODEFICIENCY 15; IMD15" -"OMIM:610873","MENARCHE, AGE AT, QUANTITATIVE TRAIT LOCUS 1; MENAQ1" -"DOID:0110215","Leber congenital amaurosis 5" -"OMIM:615593","IMMUNODEFICIENCY 16; IMD16" -"OMIM:610878","VESICOURETERAL REFLUX 2; VUR2" -"DOID:13626","photokeratitis" -"DOID:11871","macular keratitis" -"DOID:7615","sarcomatosis" -"OMIM:270550","SPASTIC ATAXIA, CHARLEVOIX-SAGUENAY TYPE; SACS" -"OMIM:270600","SPASTIC DIPLEGIA AND MENTAL RETARDATION" -"OMIM:610883","POTOCKI-LUPSKI SYNDROME; PTLS" -"OMIM:615595","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 19; COXPD19" -"OMIM:270685","SPASTIC PARAPLEGIA 17, AUTOSOMAL DOMINANT; SPG17" -"OMIM:610896","BRANCHIOOTORENAL SYNDROME 2; BOR2" -"OMIM:615596","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Iw; CDG1W" -"OMIM:270700","SPASTIC PARAPLEGIA 15, AUTOSOMAL RECESSIVE; SPG15" -"OMIM:615597","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ix; CDG1X" -"OMIM:610898","SUPRANUCLEAR PALSY, PROGRESSIVE, 3; PSNP3" -"OMIM:610906","ASTHMA-RELATED TRAITS, SUSCEPTIBILITY TO, 4" -"DOID:0110291","Leber congenital amaurosis 10" -"OMIM:270750","SPASTIC PARAPLEGIA 23; SPG23" -"OMIM:615598","PALMOPLANTAR KERATODERMA, NAGASHIMA TYPE; PPKN" -"OMIM:109660","BETA-AMINO ACIDS, RENAL TRANSPORT OF; AABT" -"OMIM:615599","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 40; MRT40" -"OMIM:610908","AUTISM, SUSCEPTIBILITY TO, 13; AUTS13" -"OMIM:270800","SPASTIC PARAPLEGIA 5A, AUTOSOMAL RECESSIVE; SPG5A" -"OMIM:134400","FACTOR V EXCESS WITH SPONTANEOUS THROMBOSIS" -"OMIM:610910","PULMONARY ALVEOLAR PROTEINOSIS, ACQUIRED" -"OMIM:270805","SPASTIC PARAPLEGIA WITH MYOCLONIC EPILEPSY" -"OMIM:615602","MEMORY QUANTITATIVE TRAIT LOCUS; MEMRYQTL" -"OMIM:109543","LEUKEMIA, CHRONIC LYMPHOCYTIC, SUSCEPTIBILITY TO, 2" -"DOID:0110016","Leber congenital amaurosis 2" -"OMIM:270850","SPASTIC PARESIS, GLAUCOMA, AND MENTAL RETARDATION" -"OMIM:610913","SURFACTANT METABOLISM DYSFUNCTION, PULMONARY, 2; SMDP2" -"DOID:10754","otitis media" -"OMIM:615604","L-FERRITIN DEFICIENCY; LFTD" -"OMIM:610915","OSTEOGENESIS IMPERFECTA, TYPE VIII; OI8" -"OMIM:615605","FANCONI RENOTUBULAR SYNDROME 3; FRTS3" -"OMIM:134430","FACTOR VII AND FACTOR VIII, COMBINED DEFICIENCY OF" -"OMIM:270900","SPASTIC PSEUDOSCLEROSIS" -"OMIM:610921","SURFACTANT METABOLISM DYSFUNCTION, PULMONARY, 3; SMDP3" -"DOID:9697","gonococcal keratitis" -"OMIM:270950","SPASTIC QUADRIPLEGIA, RETINITIS PIGMENTOSA, AND MENTAL RETARDATION" -"OMIM:109650","BEHCET SYNDROME" -"OMIM:615607","IMMUNODEFICIENCY 17; IMD17" -"DOID:0110333","Leber congenital amaurosis 7" -"OMIM:615612","DEVELOPMENTAL DYSPLASIA OF THE HIP 2; DDH2" -"OMIM:610926","TOOTH AGENESIS, SELECTIVE, 5; STHAG5" -"OMIM:270960","SPERMATOGENIC FAILURE 4; SPGF4" -"OMIM:270970","SPHEROCYTOSIS, TYPE 3; SPH3" -"OMIM:615615","IMMUNODEFICIENCY 18; IMD18" -"OMIM:134500","FACTOR VIII DEFICIENCY" -"OMIM:133780","EXUDATIVE VITREORETINOPATHY 1; EVR1" -"DOID:13777","epidermodysplasia verruciformis" -"OMIM:610927","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 9; SLEB9" -"OMIM:610938","CORONARY HEART DISEASE, SUSCEPTIBILITY TO, 7; CHDS7" -"OMIM:615616","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 13; ARVD13" -"DOID:2722","acrodermatitis" -"OMIM:271109","SPINAL MUSCULAR ATROPHY WITH MENTAL RETARDATION" -"OMIM:615617","IMMUNODEFICIENCY 19; IMD19" -"OMIM:271110","SPINAL MUSCULAR ATROPHY WITH MICROCEPHALY AND MENTAL SUBNORMALITY" -"OMIM:610947","CORONARY ARTERY DISEASE, AUTOSOMAL DOMINANT 2; ADCAD2" -"DOID:5727","uterine ligament cancer" -"OMIM:134510","FACTOR VIII AND FACTOR IX, COMBINED DEFICIENCY OF; F8F9D" -"OMIM:610948","HYPERTENSION, ESSENTIAL, SUSCEPTIBILITY TO, 7" -"OMIM:615619","CHOLANGIOCARCINOMA, SUSCEPTIBILITY TO" -"OMIM:271150","SPINAL MUSCULAR ATROPHY, TYPE IV; SMA4" -"OMIM:254800","MYOCLONIC EPILEPSY OF UNVERRICHT AND LUNDBORG" -"OMIM:600994","DEAFNESS, AUTOSOMAL DOMINANT 5; DFNA5" -"DOID:12375","bronchopneumonia" -"OMIM:254900","EPILEPSY, PROGRESSIVE MYOCLONIC, 4, WITH OR WITHOUT RENAL FAILURE; EPM4" -"OMIM:600995","NEPHROTIC SYNDROME, TYPE 2; NPHS2" -"DOID:874","bacterial pneumonia" -"OMIM:600996","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 2; ARVD2" -"OMIM:254940","CAREY-FINEMAN-ZITER SYNDROME; CFZS" -"OMIM:601001","EPIDERMOLYSIS BULLOSA SIMPLEX, AUTOSOMAL RECESSIVE 1; EBSB1" -"OMIM:300220","syndromic X-linked intellectual disability type 10" -"OMIM:254950","MYOPATHY, GRANULOVACUOLAR LOBULAR, WITH ELECTRICAL MYOTONIA" -"OMIM:254960","MYOPATHY DUE TO MALATE-ASPARTATE SHUTTLE DEFECT" -"OMIM:601003","BRODY MYOPATHY" -"OMIM:601004","PORTAL VEIN, CAVERNOUS TRANSFORMATION OF" -"OMIM:255100","LIPID STORAGE MYOPATHY DUE TO FLAVIN ADENINE DINUCLEOTIDE SYNTHETASE DEFICIENCY; LSMFLAD" -"OMIM:150270","LARYNGEAL ADDUCTOR PARALYSIS; LAP" -"OMIM:150260","LARYNGEAL ABDUCTOR PARALYSIS" -"DOID:2797","idiopathic interstitial pneumonia" -"OMIM:255110","CARNITINE PALMITOYLTRANSFERASE II DEFICIENCY, MYOPATHIC, STRESS-INDUCED" -"OMIM:601005","TIMOTHY SYNDROME; TS" -"OMIM:255120","CARNITINE PALMITOYLTRANSFERASE I DEFICIENCY" -"OMIM:601016","MIDLINE MALFORMATIONS, MULTIPLE, WITH LIMB ABNORMALITIES AND HYPOPITUITARISM" -"OMIM:150590","LEG ULCERS, FAMILIAL, OF JUVENILE ONSET" -"OMIM:255125","MYOPATHY WITH LACTIC ACIDOSIS, HEREDITARY; HML" -"OMIM:601027","TIBIA, ABSENCE OR HYPOPLASIA OF, WITH POLYDACTYLY, RETROCEREBELLAR ARACHNOID CYST, AND OTHER ANOMALIES" -"DOID:0050828","artery disease" -"OMIM:601039","ICHTHYOSIS-MENTAL RETARDATION SYNDROME WITH LARGE KERATOHYALIN GRANULES IN THE SKIN" -"OMIM:255140","MYOPATHY WITH GIANT ABNORMAL MITOCHONDRIA" -"DOID:2494","angiodysplasia" -"OMIM:150500","LATTICE DEGENERATION OF RETINA LEADING TO RETINAL DETACHMENT" -"OMIM:108800","ATRIAL SEPTAL DEFECT 1; ASD1" -"OMIM:601042","DYSTONIA 9; DYT9" -"OMIM:255160","MYOPATHY, MYOSIN STORAGE, AUTOSOMAL RECESSIVE; MSMB" -"OMIM:601067","USHER SYNDROME, TYPE ID; USH1D" -"OMIM:255200","MYOPATHY, CENTRONUCLEAR, 2; CNM2" -"OMIM:150550","LAZY LEUKOCYTE SYNDROME" -"OMIM:601068","EPILEPSY, FAMILIAL ADULT MYOCLONIC, 1; FAME1" -"DOID:0060372","autosomal recessive early-onset Parkinson disease 15" -"OMIM:255300","MYOPATHY, CONGENITAL" -"DOID:0110415","retinitis pigmentosa 2" -"OMIM:108770","ATRIAL STANDSTILL 1; ATRST1" -"OMIM:255310","MYOPATHY, CONGENITAL, WITH FIBER-TYPE DISPROPORTION; CFTD" -"DOID:14319","pleuropneumonia" -"DOID:0060369","autosomal recessive early-onset Parkinson disease 6" -"OMIM:150250","LARSEN SYNDROME; LRS" -"DOID:4772","mesoblastic nephroma" -"OMIM:601071","DEAFNESS, AUTOSOMAL RECESSIVE 9; DFNB9" -"DOID:2409","rhinosporidiosis" -"OMIM:255320","MINICORE MYOPATHY WITH EXTERNAL OPHTHALMOPLEGIA" -"OMIM:601072","DEAFNESS, AUTOSOMAL RECESSIVE 8; DFNB8" -"DOID:551","toxic pneumonitis" -"OMIM:182290","SMITH-MAGENIS SYNDROME; SMS" -"OMIM:255500","MYOPIA 18, AUTOSOMAL RECESSIVE; MYP18" -"OMIM:601075","APLASIA CUTIS CONGENITA, HIGH MYOPIA, AND CONE-ROD DYSFUNCTION" -"DOID:0050454","periventricular nodular heterotopia" -"OMIM:601076","MULLERIAN DUCT APLASIA, UNILATERAL RENAL AGENESIS, AND CERVICOTHORACIC SOMITE ANOMALIES; MURCS" -"OMIM:150280","LARYNGOMALACIA" -"OMIM:255600","MYOSCLEROSIS, AUTOSOMAL RECESSIVE" -"OMIM:255700","MYOTONIA CONGENITA, AUTOSOMAL RECESSIVE" -"OMIM:601083","CD4/CD8 T-CELL RATIO" -"DOID:0110397","retinitis pigmentosa 27" -"OMIM:255710","MYOTONIA WITH SKELETAL ABNORMALITIES AND MENTAL RETARDATION" -"OMIM:601086","LATERALITY DEFECTS, AUTOSOMAL DOMINANT" -"DOID:272","hepatic vascular disease" -"DOID:0110384","retinitis pigmentosa 25" -"DOID:0060898","early-onset Parkinson disease 20" -"OMIM:255800","SCHWARTZ-JAMPEL SYNDROME, TYPE 1; SJS1" -"OMIM:601088","AYME-GRIPP SYNDROME; AYGRP" -"OMIM:173700","POIKILODERMA, HEREDITARY SCLEROSING" -"OMIM:108950","ATRIAL TACHYARRHYTHMIA WITH SHORT PR INTERVAL" -"OMIM:601095","HARROD SYNDROME" -"OMIM:255900","MYXEDEMA" -"DOID:13453","gonococcal bursitis" -"OMIM:255960","MYXOMA, INTRACARDIAC" -"OMIM:601096","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, MICROMELIC" -"DOID:0060285","parietal foramina" -"OMIM:255980","NASODIGITOACOUSTIC SYNDROME" -"DOID:12857","Achilles bursitis" -"OMIM:601098","CHARCOT-MARIE-TOOTH DISEASE, DEMYELINATING, TYPE 1C; CMT1C" -"DOID:866","vein disease" -"OMIM:255990","NATHALIE SYNDROME" -"OMIM:601101","TELANGIECTASIA, HEREDITARY HEMORRHAGIC, TYPE 3; HHT3" -"DOID:0110352","retinitis pigmentosa 59" -"OMIM:601104","SUPRANUCLEAR PALSY, PROGRESSIVE, 1; PSNP1" -"OMIM:255995","NATIVE AMERICAN MYOPATHY; NAM" -"DOID:5870","eosinophilic pneumonia" -"OMIM:150600","LEGG-CALVE-PERTHES DISEASE; LCPD" -"OMIM:256000","LEIGH SYNDROME; LS" -"OMIM:601110","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Id; CDG1D" -"DOID:9383","iridocyclitis" -"DOID:0110404","retinitis pigmentosa 17" -"OMIM:601127","FALLOT COMPLEX WITH SEVERE MENTAL AND GROWTH RETARDATION" -"OMIM:182400","SOMATOMEDIN, EMBRYONIC" -"OMIM:256020","NAIL-PATELLA-LIKE RENAL DISEASE" -"OMIM:601136","TRANSSUPPRESSOR OF EXPRESSION 2" -"DOID:14447","gonadal dysgenesis" -"OMIM:256030","NEMALINE MYOPATHY 2; NEM2" -"OMIM:182410","SNEDDON SYNDROME" -"OMIM:601138","GUANYLATE CYCLASE 2E, PSEUDOGENE; GUCY2EP" -"OMIM:256040","AUTOINFLAMMATION, LIPODYSTROPHY, AND DERMATOSIS SYNDROME; ALDD" -"OMIM:256050","ATELOSTEOGENESIS, TYPE II; AO2" -"OMIM:150360","LARYNGEAL WEB, FAMILIAL" -"OMIM:601144","BRUGADA SYNDROME 1; BRGDA1" -"OMIM:108900","ATRIAL SEPTAL DEFECT 7 WITH OR WITHOUT ATRIOVENTRICULAR CONDUCTION DEFECTS; ASD7" -"OMIM:256100","NEPHRONOPHTHISIS 1; NPHP1" -"OMIM:601152","NEUROPATHY, HEREDITARY MOTOR AND SENSORY, TYPE VIA; HMSN6A" -"OMIM:256120","NEPHROPATHY, DEAFNESS, AND HYPERPARATHYROIDISM" -"OMIM:601154","CARDIOMYOPATHY, DILATED, 1E; CMD1E" -"OMIM:150300","LARYNX, CONGENITAL PARTIAL ATRESIA OF" -"DOID:0110420","dominant pericentral pigmentary retinopathy" -"OMIM:150400","TOOTH AGENESIS, SELECTIVE, 4; STHAG4" -"OMIM:601160","LISSENCEPHALY TYPE III AND BONE DYSPLASIA" -"OMIM:256150","NEPHROSIALIDOSIS" -"OMIM:601161","TRISOMY 18-LIKE SYNDROME" -"OMIM:256200","NEPHROSIS WITH DEAFNESS AND URINARY TRACT AND DIGITAL MALFORMATIONS" -"OMIM:601162","SPASTIC PARAPLEGIA 9A, AUTOSOMAL DOMINANT; SPG9A" -"OMIM:256300","NEPHROTIC SYNDROME, TYPE 1; NPHS1" -"DOID:0060896","autosomal recessive early-onset Parksinson disease 23" -"DOID:0110372","retinitis pigmentosa 4" -"OMIM:256370","NEPHROTIC SYNDROME, TYPE 4; NPHS4" -"OMIM:601163","DIAPHRAGMATIC DEFECTS, LIMB DEFICIENCIES, AND OSSIFICATION DEFECTS OF SKULL" -"OMIM:177735","PSEUDOHYPOALDOSTERONISM, TYPE I, AUTOSOMAL DOMINANT; PHA1A" -"DOID:4406","spongiotic dermatitis" -"DOID:5378","hemoglobin D disease" -"OMIM:178550","PULMONARY HEMOSIDEROSIS" -"OMIM:177800","PSEUDOPAPILLEDEMA" -"DOID:1580","diffuse scleroderma" -"OMIM:178600","PULMONARY HYPERTENSION, PRIMARY, 1; PPH1" -"OMIM:177850","PSEUDOXANTHOMA ELASTICUM, FORME FRUSTE" -"OMIM:177820","PSEUDO-VON WILLEBRAND DISEASE; VWDP" -"DOID:6004","aleukemic leukemia" -"DOID:4552","large cell carcinoma" -"OMIM:178000","PTERYGIUM OF CONJUNCTIVA AND CORNEA" -"OMIM:177900","PSORIASIS 1, SUSCEPTIBILITY TO; PSORS1" -"DOID:229","female reproductive system disease" -"DOID:14735","hereditary angioedema" -"OMIM:177700","GLAUCOMA 1, OPEN ANGLE, P; GLC1P" -"OMIM:177650","EXFOLIATION SYNDROME; XFS" -"DOID:169","neuroendocrine tumor" -"DOID:1064","cystinosis" -"DOID:11239","appendix cancer" -"OMIM:177980","PTERYGIA, MENTAL RETARDATION, AND DISTINCTIVE CRANIOFACIAL FEATURES" -"DOID:4798","aggressive systemic mastocytosis" -"DOID:3663","cutaneous mastocytosis" -"OMIM:177750","PSEUDOMONILETHRIX" -"DOID:13026","lobomycosis" -"DOID:11446","sciatic neuropathy" -"OMIM:177990","PTERYGIUM COLLI, ISOLATED" -"DOID:0050661","vitelliform macular dystrophy" -"DOID:0050662","bestrophinopathy" -"DOID:0060863","patterned macular dystrophy" -"DOID:3264","subacute leukemia" -"DOID:0060856","right atrial isomerism" -"DOID:0060281","photosensitive epilepsy" -"OMIM:128200","EPISODIC KINESIGENIC DYSKINESIA 1; EKD1" -"OMIM:610951","CEROID LIPOFUSCINOSIS, NEURONAL, 7; CLN7" -"OMIM:127820","DYSPLASIA EPIPHYSEALIS HEMIMELICA WITH CHONDROMAS AND OSTEOCHONDROMAS" -"OMIM:200300","ACETOPHENETIDIN SENSITIVITY" -"OMIM:615625","SPASTIC PARAPLEGIA 72, AUTOSOMAL RECESSIVE; SPG72" -"OMIM:200400","ACHALASIA, FAMILIAL ESOPHAGEAL" -"OMIM:615629","DEAFNESS, AUTOSOMAL DOMINANT 56; DFNA56" -"OMIM:610954","PITT-HOPKINS SYNDROME; PTHS" -"DOID:0080016","spina bifida" -"OMIM:615630","SHORT-RIB THORACIC DYSPLASIA 10 WITH OR WITHOUT POLYDACTYLY; SRTD10" -"DOID:3328","temporal lobe epilepsy" -"OMIM:128300","EAR EXOSTOSES" -"OMIM:610965","XFE PROGEROID SYNDROME; XFEPS" -"OMIM:200450","ACHALASIA-MICROCEPHALY SYNDROME" -"OMIM:615631","ANEMIA, CONGENITAL DYSERYTHROPOIETIC, TYPE Ib; CDAN1B" -"OMIM:610967","OSTEOGENESIS IMPERFECTA, TYPE V; OI5" -"OMIM:200500","ACHEIROPODY; ACHP" -"OMIM:200600","ACHONDROGENESIS, TYPE IA; ACG1A" -"DOID:74","hematopoietic system disease" -"OMIM:615632","NEUROPATHY, HEREDITARY SENSORY, TYPE IF; HSN1F" -"OMIM:128500","EAR FOLDING" -"OMIM:610968","OSTEOGENESIS IMPERFECTA, TYPE XI; OI11" -"OMIM:127750","DEMENTIA, LEWY BODY; DLB" -"OMIM:615633","SHORT-RIB THORACIC DYSPLASIA 11 WITH OR WITHOUT POLYDACTYLY; SRTD11" -"OMIM:200610","ACHONDROGENESIS, TYPE II; ACG2" -"DOID:0060870","isolated growth hormone deficiency" -"OMIM:610978","CHOREOATHETOSIS AND CONGENITAL HYPOTHYROIDISM WITH OR WITHOUT PULMONARY DYSFUNCTION; CAHTP" -"DOID:9111","cutaneous leishmaniasis" -"OMIM:610984","COMPLEMENT FACTOR I DEFICIENCY; CFID" -"OMIM:615636","JOUBERT SYNDROME 21; JBTS21" -"OMIM:200700","CHONDRODYSPLASIA, GREBE TYPE" -"OMIM:200900","SHORT-LIMB SKELETAL DYSPLASIA WITH SEVERE COMBINED IMMUNODEFICIENCY" -"OMIM:615637","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 41; MRT41" -"OMIM:610988","LEPROSY, SUSCEPTIBILITY TO, 4; LPRS4" -"OMIM:127700","DYSLEXIA, SUSCEPTIBILITY TO, 1; DYX1" -"DOID:9477","pulmonary embolism" -"OMIM:200950","ACID PHOSPHATASE DEFICIENCY" -"OMIM:615643","NEURODEGENERATION WITH BRAIN IRON ACCUMULATION 6; NBIA6" -"OMIM:610992","PHOSPHOSERINE AMINOTRANSFERASE DEFICIENCY; PSATD" -"OMIM:615649","DEAFNESS, AUTOSOMAL DOMINANT 54; DFNA54" -"OMIM:610997","PROSTATE CANCER, HEREDITARY, 9" -"OMIM:200970","ACKERMAN SYNDROME" -"OMIM:611003","SMOKING AS A QUANTITATIVE TRAIT LOCUS 1; SQTL1" -"OMIM:615651","LEUKOENCEPHALOPATHY WITH ATAXIA; LKPAT" -"OMIM:200980","ACRORENAL-MANDIBULAR SYNDROME" -"OMIM:615654","DEAFNESS, AUTOSOMAL DOMINANT 58; DFNA58" -"OMIM:611004","SMOKING AS A QUANTITATIVE TRAIT LOCUS 2; SQTL2" -"OMIM:200990","ACROCALLOSAL SYNDROME; ACLS" -"DOID:0080150","adrenocorticotropic hormone deficiency" -"OMIM:200995","ACROCEPHALOPOLYDACTYLOUS DYSPLASIA" -"OMIM:128100","DYSTONIA 1, TORSION, AUTOSOMAL DOMINANT; DYT1" -"OMIM:611010","FIBROMATOSIS, GINGIVAL, 4; GINGF4" -"DOID:0060326","myelomeningocele" -"OMIM:128230","DYSTONIA, DOPA-RESPONSIVE; DRD" -"OMIM:615656","CHROMOSOME 15q11.2 DELETION SYNDROME" -"OMIM:611014","HYPERTENSION, ESSENTIAL, SUSCEPTIBILITY TO, 8; HYT8" -"OMIM:615658","SPASTIC PARAPLEGIA 57, AUTOSOMAL RECESSIVE; SPG57" -"OMIM:201000","CARPENTER SYNDROME 1; CRPT1" -"DOID:9476","Sheehan syndrome" -"OMIM:201020","ACROCEPHALOPOLYSYNDACTYLY TYPE IV" -"DOID:1682","congenital heart disease" -"OMIM:615663","WARBURG MICRO SYNDROME 4; WARBM4" -"OMIM:611015","AUTISM, SUSCEPTIBILITY TO, 9; AUTS9" -"OMIM:611016","AUTISM, SUSCEPTIBILITY TO, 10; AUTS10" -"OMIM:201050","ACROCRANIOFACIAL DYSOSTOSIS" -"OMIM:615665","JOUBERT SYNDROME 22; JBTS22" -"DOID:0050701","electroclinical syndrome" -"OMIM:128000","DYSTELEPHALANGY" -"OMIM:611022","DEAFNESS, AUTOSOMAL RECESSIVE 24; DFNB24" -"DOID:0050486","exanthem" -"OMIM:615668","CHROMOSOME 5q12 DELETION SYNDROME" -"OMIM:201100","ACRODERMATITIS ENTEROPATHICA, ZINC-DEFICIENCY TYPE; AEZ" -"OMIM:611031","EPISODIC KINESIGENIC DYSKINESIA 2; EKD2" -"OMIM:201170","ACROFACIAL DYSOSTOSIS SYNDROME OF RODRIGUEZ" -"OMIM:615670","SCHWANNOMATOSIS 2; SWNTS2" -"OMIM:615673","MYOPATHY WITH EXTRAPYRAMIDAL SIGNS; MPXPS" -"OMIM:611038","MICROPHTHALMIA, ISOLATED 3; MCOP3" -"OMIM:201180","ACROFRONTOFACIONASAL DYSOSTOSIS 1" -"OMIM:615674","DOWLING-DEGOS DISEASE 3; DDD3" -"OMIM:201200","ACROGERIA, GOTTRON TYPE" -"OMIM:611040","MICROPHTHALMIA, ISOLATED 5; MCOP5" -"DOID:2214","inherited blood coagulation disease" -"OMIM:201250","ACROMESOMELIC DYSPLASIA, HUNTER-THOMPSON TYPE; AMDH" -"OMIM:611046","MYCOBACTERIUM TUBERCULOSIS, SUSCEPTIBILITY TO, 2" -"OMIM:615681","SPASTIC PARAPLEGIA 62, AUTOSOMAL RECESSIVE; SPG62" -"DOID:11713","diabetic angiopathy" -"DOID:1407","anterior uveitis" -"OMIM:615683","SPASTIC PARAPLEGIA 64, AUTOSOMAL RECESSIVE; SPG64" -"DOID:1227","neutropenia" -"OMIM:201300","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, TYPE IIA; HSAN2A" -"OMIM:611064","ASTHMA-RELATED TRAITS, SUSCEPTIBILITY TO, 5" -"OMIM:128400","EAR FLARE" -"OMIM:611067","SPINAL MUSCULAR ATROPHY, DISTAL, AUTOSOMAL RECESSIVE, 4; DSMA4" -"OMIM:201310","ACRORENAL SYNDROME, AUTOSOMAL RECESSIVE" -"OMIM:615685","SPASTIC PARAPLEGIA 61, AUTOSOMAL RECESSIVE; SPG61" -"DOID:1827","idiopathic generalized epilepsy" -"OMIM:615686","SPASTIC PARAPLEGIA 63, AUTOSOMAL RECESSIVE; SPG63" -"OMIM:611073","ALZHEIMER DISEASE 12" -"OMIM:201400","ACTH DEFICIENCY, ISOLATED; IAD" -"OMIM:615688","POLYARTERITIS NODOSA, CHILDHOOD-ONSET; PAN" -"OMIM:611081","INFLAMMATORY BOWEL DISEASE (CROHN DISEASE) 10; IBD10" -"OMIM:201450","ACYL-CoA DEHYDROGENASE, MEDIUM-CHAIN, DEFICIENCY OF; ACADMD" -"DOID:5113","nutritional deficiency disease" -"OMIM:201470","ACYL-CoA DEHYDROGENASE, SHORT-CHAIN, DEFICIENCY OF; ACADSD" -"OMIM:611087","POLYHYDRAMNIOS, MEGALENCEPHALY, AND SYMPTOMATIC EPILEPSY; PMSE" -"OMIM:615696","DOWLING-DEGOS DISEASE 4; DDD4" -"DOID:8632","Kaposi's sarcoma" -"OMIM:611090","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 12; MRT12" -"DOID:8991","cervix uteri carcinoma in situ" -"OMIM:201475","ACYL-CoA DEHYDROGENASE, VERY LONG-CHAIN, DEFICIENCY OF; ACADVLD" -"DOID:0110269","cataract 3 multiple types" -"OMIM:128235","DYSTONIA 12; DYT12" -"OMIM:615697","EPILEPSY, FAMILIAL TEMPORAL LOBE, 6; ETL6" -"OMIM:611091","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 5; MRT5" -"OMIM:615703","MORBID OBESITY AND SPERMATOGENIC FAILURE; MOSPGF" -"OMIM:201550","ADDUCTED THUMBS SYNDROME" -"DOID:2893","cervix carcinoma" -"OMIM:611092","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 6; MRT6" -"OMIM:201710","LIPOID CONGENITAL ADRENAL HYPERPLASIA; LCAH" -"OMIM:615704","POIKILODERMA, HEREDITARY FIBROSING, WITH TENDON CONTRACTURES, MYOPATHY, AND PULMONARY FIBROSIS; POIKTMP" -"OMIM:201750","ANTLEY-BIXLER SYNDROME WITH GENITAL ANOMALIES AND DISORDERED STEROIDOGENESIS; ABS1" -"DOID:0050929","mucosal melanoma" -"OMIM:615705","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 15; SCAR15" -"OMIM:128290","EAR ANTITRAGUS, TAG AT BASE OF" -"OMIM:611093","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 7; MRT7" -"OMIM:611095","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 9; MRT9" -"OMIM:201810","ADRENAL HYPERPLASIA, CONGENITAL, DUE TO 3-BETA-HYDROXYSTEROID DEHYDROGENASE 2 DEFICIENCY" -"OMIM:615706","AURICULOCONDYLAR SYNDROME 3; ARCND3" -"OMIM:201910","ADRENAL HYPERPLASIA, CONGENITAL, DUE TO 21-HYDROXYLASE DEFICIENCY" -"OMIM:611096","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 10; MRT10" -"OMIM:615707","IMMUNODEFICIENCY 20; IMD20" -"DOID:0060047","writing disorder" -"OMIM:127600","DYSKERATOSIS, HEREDITARY BENIGN INTRAEPITHELIAL; HBID" -"OMIM:202010","ADRENAL HYPERPLASIA, CONGENITAL, DUE TO STEROID 11-BETA-HYDROXYLASE DEFICIENCY" -"OMIM:615709","SACRAL AGENESIS WITH VERTEBRAL ANOMALIES; SAVA" -"OMIM:611097","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 11; MRT11" -"OMIM:615710","MITCHELL-RILEY SYNDROME; MTCHRS" -"OMIM:202110","ADRENAL HYPERPLASIA, CONGENITAL, DUE TO 17-ALPHA-HYDROXYLASE DEFICIENCY" -"OMIM:611100","PROSTATE CANCER, HEREDITARY, 10; HPC10" -"OMIM:202150","ADRENAL HYPOPLASIA, CONGENITAL, WITH ABSENT PITUITARY LUTEINIZING HORMONE" -"OMIM:615711","ALZHEIMER DISEASE 19; AD19" -"OMIM:611102","DEAFNESS-INFERTILITY SYNDROME; DIS" -"OMIM:128101","DYSTONIA 4, TORSION, AUTOSOMAL DOMINANT; DYT4" -"OMIM:127800","DYSPLASIA EPIPHYSEALIS HEMIMELICA" -"OMIM:202155","ADRENAL HYPOPLASIA, CYTOMEGALIC TYPE" -"OMIM:611105","LEUKOENCEPHALOPATHY WITH BRAINSTEM AND SPINAL CORD INVOLVEMENT AND LACTATE ELEVATION; LBSL" -"DOID:4525","mediastinum angiosarcoma" -"OMIM:615715","BONE MARROW FAILURE SYNDROME 2; BMFS2" -"OMIM:185050","STORAGE POOL PLATELET DISEASE" -"OMIM:217800","MACULAR DYSTROPHY, CORNEAL; MCD" -"OMIM:217980","CORPUS CALLOSUM, AGENESIS OF, WITH FACIAL ANOMALIES AND ROBIN SEQUENCE" -"OMIM:104290","ALTERNATING HEMIPLEGIA OF CHILDHOOD 1; AHC1" -"OMIM:101600","PFEIFFER SYNDROME" -"OMIM:129830","ECTRODACTYLY-CLEFT PALATE SYNDROME" -"OMIM:217990","CORPUS CALLOSUM, AGENESIS OF" -"OMIM:101200","APERT SYNDROME" -"DOID:4490","malignant peritoneal solitary fibrous tumor" -"OMIM:218000","AGENESIS OF THE CORPUS CALLOSUM WITH PERIPHERAL NEUROPATHY; ACCPN" -"OMIM:184850","STIFF-PERSON SYNDROME; SPS" -"OMIM:218010","CORTICAL BLINDNESS, RETARDATION, AND POSTAXIAL POLYDACTYLY" -"OMIM:184500","STEATOCYSTOMA MULTIPLEX" -"OMIM:218030","APPARENT MINERALOCORTICOID EXCESS; AME" -"OMIM:101850","PALMOPLANTAR KERATODERMA, PUNCTATE TYPE III; PPKP3" -"OMIM:104300","ALZHEIMER DISEASE; AD" -"OMIM:101400","SAETHRE-CHOTZEN SYNDROME; SCS" -"OMIM:129810","ECTRODACTYLY AND ECTODERMAL DYSPLASIA WITHOUT CLEFT LIP/PALATE" -"OMIM:129510","ECTODERMAL DYSPLASIA, TRICHOODONTOONYCHIAL TYPE" -"OMIM:218040","COSTELLO SYNDROME; CSTLO" -"OMIM:218050","CRAMPS, FAMILIAL ADOLESCENT" -"OMIM:129500","CLOUSTON SYNDROME" -"OMIM:104200","ALPORT SYNDROME, AUTOSOMAL DOMINANT" -"OMIM:218090","CRANE-HEISE SYNDROME" -"OMIM:101805","ACROFACIAL DYSOSTOSIS, CATANIA TYPE" -"OMIM:218100","CRANIAL NERVES, CONGENITAL PARESIS OF" -"OMIM:218200","CRANIAL NERVES, RECURRENT PARESIS OF" -"OMIM:184900","STIFF SKIN SYNDROME; SSKS" -"OMIM:184510","STEATOCYSTOMA MULTIPLEX WITH NATAL TEETH" -"OMIM:218300","CRANIODIAPHYSEAL DYSPLASIA; CDD" -"DOID:10631","partial optic atrophy" -"OMIM:218330","CRANIOECTODERMAL DYSPLASIA 1; CED1" -"OMIM:218340","TEMTAMY SYNDROME; TEMTYS" -"DOID:0110119","autoimmune lymphoproliferative syndrome type 3" -"OMIM:218350","CRANIOFACIAL DYSSYNOSTOSIS WITH SHORT STATURE" -"DOID:12571","phacogenic glaucoma" -"OMIM:218400","CRANIOMETAPHYSEAL DYSPLASIA, AUTOSOMAL RECESSIVE; CMDR" -"OMIM:129600","ECTOPIA LENTIS 1, ISOLATED, AUTOSOMAL DOMINANT; ECTOL1" -"OMIM:185000","OVERHYDRATED HEREDITARY STOMATOCYTOSIS; OHST" -"OMIM:218450","CRANIOSTENOSIS, SAGITTAL, WITH CONGENITAL HEART DISEASE, MENTAL DEFICIENCY, AND MANDIBULAR ANKYLOSIS" -"OMIM:110250","BLOOD GROUP--ABO SUPPRESSOR" -"OMIM:218530","CRANIOSYNOSTOSIS WITH ANOMALIES OF THE CRANIAL BASE AND DIGITS" -"OMIM:101800","ACRODYSOSTOSIS 1 WITH OR WITHOUT HORMONE RESISTANCE; ACRDYS1" -"OMIM:129750","ECTOPIA PUPILLAE" -"OMIM:218550","CRANIOSYNOSTOSIS WITH FIBULAR APLASIA" -"OMIM:184460","STAPES ANKYLOSIS WITH BROAD THUMB AND TOES" -"OMIM:110100","BLEPHAROPHIMOSIS, PTOSIS, AND EPICANTHUS INVERSUS; BPES" -"OMIM:218600","BALLER-GEROLD SYNDROME; BGS" -"OMIM:184705","STEINFELD SYNDROME" -"OMIM:218649","CRANIOSYNOSTOSIS-MENTAL RETARDATION SYNDROME OF LIN AND GETTIG" -"OMIM:101900","ACROKERATOSIS VERRUCIFORMIS; AKV" -"OMIM:185020","CRYOHYDROCYTOSIS; CHC" -"OMIM:218650","CRANIOSYNOSTOSIS-MENTAL RETARDATION-CLEFTING SYNDROME" -"OMIM:110150","BLEPHAROPTOSIS, MYOPIA, AND ECTOPIA LENTIS" -"DOID:0080081","nonsyndromic congenital nail disorder 3" -"OMIM:184700","POLYCYSTIC OVARY SYNDROME 1; PCOS1" -"OMIM:129550","ECTODERMAL DYSPLASIA WITH ADRENAL CYST" -"OMIM:129540","ECTODERMAL DYSPLASIA SYNDROME WITH DISTINCTIVE FACIAL APPEARANCE AND PREAXIAL POLYDACTYLY OF FEET" -"OMIM:218670","CRANIOTELENCEPHALIC DYSPLASIA" -"OMIM:110310","BLOOD GROUP--ABH ANTIGEN, TYPE 2" -"OMIM:218700","HYPOTHYROIDISM, CONGENITAL, NONGOITROUS, 2; CHNG2" -"DOID:11555","Fuchs' endothelial dystrophy" -"OMIM:218800","CRIGLER-NAJJAR SYNDROME, TYPE I" -"DOID:0080083","nonsyndromic congenital nail disorder 5" -"DOID:13129","severe pre-eclampsia" -"DOID:174","acanthoma" -"DOID:447","renal tubular transport disease" -"OMIM:218900","CROME SYNDROME" -"OMIM:219000","FRASER SYNDROME 1; FRASRS1" -"OMIM:184800","STERNUM, PREMATURE OBLITERATION OF SUTURES OF" -"OMIM:219050","CRYPTORCHIDISM, UNILATERAL OR BILATERAL" -"OMIM:185069","STORM SYNDROME" -"OMIM:104130","ALOPECIA, PSYCHOMOTOR EPILEPSY, PYORRHEA, AND MENTAL SUBNORMALITY" -"OMIM:219070","CURVED NAIL OF FOURTH TOE" -"OMIM:184840","OTOSPONDYLOMEGAEPIPHYSEAL DYSPLASIA, AUTOSOMAL DOMINANT; OSMEDA" -"OMIM:110050","BLEPHARONASOFACIAL MALFORMATION SYNDROME" -"OMIM:219080","ACTH-INDEPENDENT MACRONODULAR ADRENAL HYPERPLASIA; AIMAH1" -"OMIM:185070","STORMORKEN SYNDROME; STRMK" -"DOID:11379","gnathomiasis" -"OMIM:219090","PITUITARY ADENOMA 4, ACTH-SECRETING; PITA4" -"DOID:11748","round ligament malignant neoplasm" -"OMIM:219095","CUTANEOUS PHOTOSENSITIVITY AND COLITIS, LETHAL" -"OMIM:184450","STUTTERING, FAMILIAL PERSISTENT, 1; STUT1" -"OMIM:219100","CUTIS LAXA, AUTOSOMAL RECESSIVE, TYPE IA; ARCL1A" -"OMIM:102000","ACROLEUKOPATHY, SYMMETRIC" -"OMIM:101840","ACROKERATODERMA, HEREDITARY PAPULOTRANSLUCENT" -"OMIM:219150","CUTIS LAXA, AUTOSOMAL RECESSIVE, TYPE IIIA; ARCL3A" -"OMIM:219200","CUTIS LAXA, AUTOSOMAL RECESSIVE, TYPE IIA; ARCL2A" -"DOID:1788","peritoneal mesothelioma" -"OMIM:184400","SPRENGEL DEFORMITY" -"OMIM:219250","CUTIS MARMORATA TELANGIECTATICA CONGENITA; CMTC" -"OMIM:137270","GASTROCUTANEOUS SYNDROME" -"DOID:0110563","autosomal dominant nonsyndromic deafness 36" -"OMIM:611107","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 4; MRT4" -"OMIM:615716","HYPERPHOSPHATASIA WITH MENTAL RETARDATION SYNDROME 4; HPMRS4" -"OMIM:611109","CINNAMON ODOR, PLEASANTNESS OF" -"OMIM:615721","RENAL HYPODYSPLASIA/APLASIA 2; RHDA2" -"OMIM:611126","MITOCHONDRIAL COMPLEX I DEFICIENCY DUE TO ACAD9 DEFICIENCY" -"OMIM:615722","BOSCH-BOONSTRA-SCHAAF OPTIC ATROPHY SYNDROME; BBSOAS" -"OMIM:137220","GASTRIC JUICE PEPTIDES" -"DOID:0110553","autosomal dominant nonsyndromic deafness 23" -"OMIM:615723","PREMATURE OVARIAN FAILURE 8; POF8" -"OMIM:611131","RETINITIS PIGMENTOSA 37; RP37" -"DOID:0110570","autosomal dominant nonsyndromic deafness 47" -"DOID:0110591","autosomal dominant nonsyndromic deafness 7" -"OMIM:615724","PREMATURE OVARIAN FAILURE 9; POF9" -"OMIM:611134","MECKEL SYNDROME, TYPE 4; MKS4" -"OMIM:615725","RETINITIS PIGMENTOSA 68; RP68" -"DOID:0110548","autosomal dominant nonsyndromic deafness 17" -"OMIM:611136","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 13; EIG13" -"DOID:14324","Plasmodium malariae malaria" -"OMIM:611139","CORONARY HEART DISEASE, SUSCEPTIBILITY TO, 8; CHDS8" -"OMIM:615726","PACHYONYCHIA CONGENITA 3; PC3" -"DOID:12919","Plasmodium ovale malaria" -"OMIM:611147","PAROXYSMAL NONKINESIGENIC DYSKINESIA 2; PNKD2" -"DOID:14325","mixed malaria" -"OMIM:615728","PACHYONYCHIA CONGENITA 4; PC4" -"DOID:0110589","autosomal dominant nonsyndromic deafness 68" -"DOID:4035","lymphocytic gastritis" -"OMIM:611152","ALZHEIMER DISEASE 13; AD13" -"OMIM:615731","NEMALINE MYOPATHY 9; NEM9" -"DOID:0110613","primary ciliary dyskinesia 16" -"DOID:0110586","autosomal dominant nonsyndromic deafness 65" -"OMIM:611154","ALZHEIMER DISEASE 14; AD14" -"OMIM:615735","PALMOPLANTAR KERATODERMA, NONEPIDERMOLYTIC, FOCAL OR DIFFUSE; PPKNEFD" -"DOID:0110593","autosomal dominant nonsyndromic deafness 9" -"OMIM:611155","ALZHEIMER DISEASE 15; AD15" -"OMIM:615744","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 19; EIEE19" -"OMIM:615745","ATRIAL STANDSTILL 2; ATRST2" -"OMIM:611162","MALARIA, SUSCEPTIBILITY TO" -"DOID:0110549","autosomal dominant nonsyndromic deafness 18" -"OMIM:611174","HAMAMY SYNDROME; HMMS" -"OMIM:615749","ECULIZUMAB, POOR RESPONSE TO" -"OMIM:615750","MOYAMOYA DISEASE 6 WITH ACHALASIA; MYMY6" -"DOID:0110551","autosomal dominant nonsyndromic deafness 21" -"DOID:14069","cerebral malaria" -"OMIM:611182","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIh; CDG2H" -"OMIM:615751","CARBONIC ANHYDRASE VA DEFICIENCY, HYPERAMMONEMIA DUE TO; CA5AD" -"OMIM:611185","RESTLESS LEGS SYNDROME, SUSCEPTIBILITY TO, 6; RLS6" -"DOID:0110547","autosomal dominant nonsyndromic deafness 16" -"DOID:14175","von Hippel-Lindau disease" -"OMIM:611209","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIg; CDG2G" -"OMIM:615752","POLYMICROGYRIA, BILATERAL PERISYLVIAN, AUTOSOMAL RECESSIVE; BPPR" -"OMIM:611222","MICROPHTHALMIA, SYNDROMIC 10; MCOPS10" -"OMIM:615758","IMMUNODEFICIENCY 22; IMD22" -"OMIM:137215","GASTRIC CANCER, HEREDITARY DIFFUSE; HDGC" -"DOID:0110558","autosomal dominant nonsyndromic deafness 2A" -"OMIM:137210","GASTRIC VOLVULUS, INTRATHORACIC" -"OMIM:615760","MICROCEPHALY, PROGRESSIVE, WITH SEIZURES AND CEREBRAL AND CEREBELLAR ATROPHY; MSCCA" -"OMIM:611225","SPASTIC PARAPLEGIA 18, AUTOSOMAL RECESSIVE; SPG18" -"DOID:0060690","autosomal dominant auditory neuropathy 1" -"OMIM:615761","MENTAL RETARDATION, AUTOSOMAL DOMINANT 23; MRD23" -"OMIM:611228","CHARCOT-MARIE-TOOTH DISEASE, TYPE 4J; CMT4J" -"DOID:1082","dirofilariasis" -"DOID:8892","pityriasis rosea" -"OMIM:611242","RESTLESS LEGS SYNDROME, SUSCEPTIBILITY TO, 5; RLS5" -"DOID:1837","diabetic ketoacidosis" -"OMIM:615763","CORTICAL DYSPLASIA, COMPLEX, WITH OTHER BRAIN MALFORMATIONS 5; CDCBM5" -"DOID:0110592","autosomal dominant nonsyndromic deafness 70" -"OMIM:615767","IMMUNODEFICIENCY, COMMON VARIABLE, 11; CVID11" -"OMIM:611247","MAJOR AFFECTIVE DISORDER 4; MAFD4" -"DOID:4033","bacterial gastritis" -"DOID:0110571","autosomal dominant nonsyndromic deafness 48" -"OMIM:615768","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 16; SCAR16" -"OMIM:611252","SPASTIC PARAPLEGIA 32, AUTOSOMAL RECESSIVE; SPG32" -"DOID:0110623","primary ciliary dyskinesia 15" -"OMIM:615770","ATRIAL FIBRILLATION, FAMILIAL, 15; ATFB15" -"DOID:0110574","autosomal dominant nonsyndromic deafness 4B" -"DOID:11431","endometriosis of rectovaginal septum and vagina" -"OMIM:611263","SHORT-RIB THORACIC DYSPLASIA 2 WITH OR WITHOUT POLYDACTYLY; SRTD2" -"OMIM:137200","NEUROMYOTONIA AND AXONAL NEUROPATHY, AUTOSOMAL RECESSIVE; NMAN" -"OMIM:611274","GLAUCOMA 1, OPEN ANGLE, N; GLC1N" -"OMIM:615771","CORTICAL DYSPLASIA, COMPLEX, WITH OTHER BRAIN MALFORMATIONS 6; CDCBM6" -"DOID:0110557","autosomal dominant nonsyndromic deafness 28" -"OMIM:615774","OOCYTE MATURATION DEFECT 1; OOMD1" -"OMIM:611276","GLAUCOMA 1, OPEN ANGLE, H; GLC1H" -"OMIM:611277","GENERALIZED EPILEPSY WITH FEBRILE SEIZURES PLUS, TYPE 3; GEFSP3" -"DOID:0110576","autosomal dominant nonsyndromic deafness 50" -"DOID:12978","Plasmodium vivax malaria" -"OMIM:615777","DESBUQUOIS DYSPLASIA 2; DBQD2" -"OMIM:615779","CONGENITAL HEART DEFECTS, MULTIPLE TYPES, 4; CHTD4" -"OMIM:611283","ISOBUTYRYL-CoA DEHYDROGENASE DEFICIENCY" -"DOID:0110564","autosomal dominant nonsyndromic deafness 3A" -"OMIM:137280","GASTRITIS, FAMILIAL GIANT HYPERTROPHIC" -"OMIM:615780","RETINITIS PIGMENTOSA 69; RP69" -"OMIM:611284","DYSTONIA, FOCAL, TASK-SPECIFIC; FTSD" -"OMIM:615785","WHITE SPONGE NEVUS 2; WSN2" -"DOID:0110556","autosomal dominant nonsyndromic deafness 27" -"OMIM:611291","SEVERE COMBINED IMMUNODEFICIENCY WITH MICROCEPHALY, GROWTH RETARDATION, AND SENSITIVITY TO IONIZING RADIATION" -"OMIM:137360","GENOCHONDROMATOSIS" -"OMIM:615789","SHORT STATURE WITH MICROCEPHALY AND DISTINCTIVE FACIES" -"OMIM:611302","SPASTIC ATAXIA 2, AUTOSOMAL RECESSIVE; SPAX2" -"OMIM:137245","LYMPHOMA, MUCOSA-ASSOCIATED LYMPHOID TYPE" -"DOID:1079","setariasis" -"DOID:0110582","autosomal dominant nonsyndromic deafness 58" -"DOID:5379","hemoglobin E disease" -"DOID:5662","pleomorphic carcinoma" -"OMIM:615802","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 42; MRT42" -"OMIM:611307","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2L; LGMD2L" -"OMIM:615803","PONTOCEREBELLAR HYPOPLASIA, TYPE 10; PCH10" -"DOID:0110543","autosomal dominant nonsyndromic deafness 11" -"OMIM:611308","PERSISTENT HYPERPLASTIC PRIMARY VITREOUS, AUTOSOMAL DOMINANT; PHPVAD" -"OMIM:611363","ATRIAL SEPTAL DEFECT 4; ASD4" -"OMIM:615807","SECKEL SYNDROME 8; SCKL8" -"DOID:12323","cough variant asthma" -"OMIM:137370","GENU VALGUM, ST. HELENA FAMILIAL" -"DOID:0110542","autosomal dominant nonsyndromic deafness 10" -"DOID:9362","status asthmaticus" -"OMIM:615809","PONTOCEREBELLAR HYPOPLASIA, TYPE 9; PCH9" -"OMIM:611364","MYOCLONIC EPILEPSY, JUVENILE, SUSCEPTIBILITY TO, 4; EJM4" -"OMIM:611369","LETHAL CONGENITAL CONTRACTURE SYNDROME 3; LCCS3" -"OMIM:615812","ABDOMINAL OBESITY-METABOLIC SYNDROME 3; AOMS3" -"OMIM:611376","MUNGAN SYNDROME; MGS" -"OMIM:615816","IMMUNODEFICIENCY 23; IMD23" -"OMIM:145750","HYPERTRIGLYCERIDEMIA, FAMILIAL" -"OMIM:225500","ELLIS-VAN CREVELD SYNDROME; EVC" -"OMIM:181510","SCHIZOPHRENIA 1; SCZD1" -"OMIM:225700","ENCEPHALOMALACIA, MULTILOCULAR" -"DOID:0110594","primary ciliary dyskinesia 1" -"DOID:0110616","primary ciliary dyskinesia 8" -"OMIM:225740","ENCEPHALOPATHY, AXONAL, WITH NECROTIZING MYOPATHY, CARDIOMYOPATHY, AND CATARACTS" -"DOID:1935","Bardet-Biedl syndrome" -"DOID:1459","hypothyroidism" -"OMIM:225750","AICARDI-GOUTIERES SYNDROME 1; AGS1" -"OMIM:146300","HYPOPHOSPHATASIA, ADULT" -"OMIM:146000","HYPOCHONDROPLASIA; HCH" -"DOID:0110628","primary ciliary dyskinesia 24" -"OMIM:225753","PONTOCEREBELLAR HYPOPLASIA, TYPE 4; PCH4" -"DOID:0050869","villous adenoma" -"OMIM:225755","ENCEPHALOPATHY WITH INTRACRANIAL CALCIFICATION, GROWTH HORMONE DEFICIENCY, MICROCEPHALY, AND RETINAL DEGENERATION" -"DOID:5153","atypical neurofibroma" -"OMIM:146200","HYPOPARATHYROIDISM, FAMILIAL ISOLATED; FIH" -"OMIM:225790","PROLIFERATIVE VASCULOPATHY AND HYDRANENCEPHALY-HYDROCEPHALY SYNDROME; PVHH" -"OMIM:226000","ENDOCARDIAL FIBROELASTOSIS; EFE" -"DOID:11664","nephrosclerosis" -"OMIM:226100","ENDOCARDIAL FIBROELASTOSIS AND COARCTATION OF ABDOMINAL AORTA" -"OMIM:226110","ENDOTHELIAL DYSTROPHY, CONGENITAL HEREDITARY, WITH NAIL HYPOPLASIA" -"OMIM:226150","ENTEROCOLITIS" -"OMIM:181600","SCLEROTYLOSIS" -"OMIM:604187","SPASTIC PARAPLEGIA 10, AUTOSOMAL DOMINANT; SPG10" -"OMIM:145981","HYPOCALCIURIC HYPERCALCEMIA, FAMILIAL, TYPE II; HHC2" -"OMIM:226200","ENTEROKINASE DEFICIENCY" -"OMIM:181700","SCLEROCORNEA, AUTOSOMAL DOMINANT" -"DOID:635","acquired immunodeficiency syndrome" -"OMIM:226300","COMPLEMENT HYPERACTIVATION, ANGIOPATHIC THROMBOSIS, AND PROTEIN-LOSING ENTEROPATHY; CHAPLE" -"OMIM:146160","HYPOMELIA WITH MULLERIAN DUCT ANOMALIES" -"OMIM:226350","EOSINOPHILIC FASCIITIS" -"OMIM:146110","HYPOGONADOTROPIC HYPOGONADISM 7 WITH OR WITHOUT ANOSMIA; HH7" -"OMIM:226400","EPIDERMODYSPLASIA VERRUCIFORMIS; EV" -"DOID:0110611","primary ciliary dyskinesia 27" -"DOID:0070017","autosomal recessive dyskeratosis congenita 2" -"DOID:0110620","primary ciliary dyskinesia 35" -"DOID:0060106","brain meningioma" -"OMIM:226440","EPIDERMOLYSIS BULLOSA, LATE-ONSET LOCALIZED JUNCTIONAL, WITH MENTAL RETARDATION" -"DOID:0110853","rhizomelic chondrodysplasia punctata type 3" -"DOID:648","kuru" -"OMIM:226500","EPIDERMOLYSIS BULLOSA DYSTROPHICA NEUROTROPHICA" -"DOID:11520","benign hypertensive renal disease" -"OMIM:145800","HYPERTROPHIA MUSCULORUM VERA" -"OMIM:226600","EPIDERMOLYSIS BULLOSA DYSTROPHICA, AUTOSOMAL RECESSIVE; RDEB" -"OMIM:226650","EPIDERMOLYSIS BULLOSA, JUNCTIONAL, NON-HERLITZ TYPE" -"DOID:0110608","primary ciliary dyskinesia 19" -"OMIM:146255","HYPOPARATHYROIDISM, SENSORINEURAL DEAFNESS, AND RENAL DISEASE; HDR" -"OMIM:226670","EPIDERMOLYSIS BULLOSA SIMPLEX WITH MUSCULAR DYSTROPHY; EBSMD" -"DOID:0090076","hypogonadotropic hypogonadism 18 with or without anosmia" -"OMIM:226700","EPIDERMOLYSIS BULLOSA, JUNCTIONAL, HERLITZ TYPE" -"DOID:0050947","hereditary hypophosphatemic rickets with hypercalciuria" -"OMIM:226730","EPIDERMOLYSIS BULLOSA JUNCTIONALIS WITH PYLORIC ATRESIA" -"OMIM:182970","SPINAL MUSCULAR ATROPHY, FACIOSCAPULOHUMERAL TYPE" -"OMIM:226735","EPIDERMOLYSIS BULLOSA WITH DIAPHRAGMATIC HERNIA" -"DOID:0110599","primary ciliary dyskinesia 3" -"OMIM:226750","KOHLSCHUTTER-TONZ SYNDROME; KTZS" -"OMIM:145701","HYPERTRICHOSIS UNIVERSALIS CONGENITA, AMBRAS TYPE; HTC1" -"DOID:7166","thyroiditis" -"OMIM:145700","HYPERTRICHOSIS LANUGINOSA CONGENITA" -"DOID:0110595","Stromme syndrome" -"OMIM:226800","EPILEPSY, PHOTOGENIC, WITH SPASTIC DIPLEGIA AND MENTAL RETARDATION" -"DOID:10575","calcium metabolism disease" -"OMIM:226810","EPILEPSY WITH BILATERAL OCCIPITAL CALCIFICATIONS" -"OMIM:146350","HYPOPHOSPHATEMIC BONE DISEASE; HBD" -"OMIM:226850","EPILEPSY-TELANGIECTASIA" -"OMIM:226900","EPIPHYSEAL DYSPLASIA, MULTIPLE, 4; EDM4" -"OMIM:226950","EPIPHYSEAL DYSPLASIA OF FEMORAL HEAD, MYOPIA, AND DEAFNESS" -"DOID:0110604","primary ciliary dyskinesia 18" -"OMIM:145980","HYPOCALCIURIC HYPERCALCEMIA, FAMILIAL, TYPE I; HHC1" -"DOID:0110618","primary ciliary dyskinesia 13" -"DOID:649","prion disease" -"OMIM:226960","EPIPHYSEAL DYSPLASIA, MICROCEPHALY, AND NYSTAGMUS" -"DOID:0110610","primary ciliary dyskinesia 34" -"OMIM:226980","EPIPHYSEAL DYSPLASIA, MULTIPLE, WITH EARLY-ONSET DIABETES MELLITUS" -"OMIM:145900","HYPERTROPHIC NEUROPATHY OF DEJERINE-SOTTAS" -"DOID:5434","scrapie" -"DOID:7997","thyrotoxicosis" -"OMIM:226985","EPITHELIAL SQUAMOUS DYSPLASIA, KERATINIZING DESQUAMATIVE, OF URINARY TRACT" -"DOID:9192","dyskinesia of esophagus" -"OMIM:226990","EPSTEIN-BARR VIRUS, SUSCEPTIBILITY TO CHRONIC INFECTION BY" -"DOID:12176","goiter" -"OMIM:227000","ERYTHEMA OF ACRAL REGIONS" -"OMIM:173200","PITYRIASIS RUBRA PILARIS; PRP" -"OMIM:145680","HYPERTHYROXINEMIA, DYSTRANSTHYRETINEMIC; DTTRH" -"OMIM:227010","ERMINE PHENOTYPE" -"OMIM:227050","TRANSIENT ERYTHROBLASTOPENIA OF CHILDHOOD; TEC" -"DOID:0110605","primary ciliary dyskinesia 7" -"OMIM:136590","FRAGILE SITE 20p11" -"DOID:0060599","Nance-Horan syndrome" -"OMIM:260570","PELGER-HUET-LIKE ANOMALY AND EPISODIC FEVER WITH ABDOMINAL PAIN" -"OMIM:173900","POLYCYSTIC KIDNEY DISEASE 1; PKD1" -"OMIM:260600","LEUKODYSTROPHY, HYPOMYELINATING, 3; HLD3" -"OMIM:136580","FRAGILE SITE, DISTAMYCIN A TYPE, RARE, FRA(16)(q22.1); FRA16B" -"OMIM:174000","MEDULLARY CYSTIC KIDNEY DISEASE 1; MCKD1" -"OMIM:260650","PELLAGRA-LIKE SYNDROME" -"OMIM:260660","COUSIN SYNDROME" -"OMIM:260800","PENTOSURIA; PNTSU" -"DOID:11787","chronic congestive splenomegaly" -"OMIM:260900","PERICARDIAL EFFUSION, CHRONIC" -"OMIM:260910","PERIFOLLICULITIS CAPITIS ABSCEDENS ET SUFFODIENS, FAMILIAL" -"OMIM:260920","HYPER-IgD SYNDROME; HIDS" -"DOID:12134","factor VIII deficiency" -"OMIM:136660","FRAGILE SITE 17p12" -"OMIM:260950","PERIODONTITIS, CHRONIC" -"OMIM:260970","PERIPHERAL NEUROPATHY, ATAXIA, FOCAL NECROTIZING ENCEPHALOPATHY, AND SPONGY DEGENERATION OF BRAIN" -"OMIM:261000","INTRINSIC FACTOR DEFICIENCY; IFD" -"OMIM:261100","MEGALOBLASTIC ANEMIA 1" -"OMIM:261400","PERONEUS TERTIUS MUSCLE, ABSENCE OF" -"DOID:11726","Emery-Dreifuss muscular dystrophy" -"OMIM:261500","EOSINOPHIL PEROXIDASE DEFICIENCY; EPXD" -"DOID:2007","degeneration of macula and posterior pole" -"DOID:1056","oculocerebrorenal syndrome" -"OMIM:261515","D-BIFUNCTIONAL PROTEIN DEFICIENCY" -"OMIM:604233","GENERALIZED EPILEPSY WITH FEBRILE SEIZURES PLUS, TYPE 1; GEFSP1" -"OMIM:261540","PETERS-PLUS SYNDROME" -"DOID:0060253","scapuloperoneal myopathy" -"DOID:1574","alcohol abuse" -"OMIM:136630","MENTAL RETARDATION, FRA12A TYPE" -"OMIM:261550","PERSISTENT MULLERIAN DUCT SYNDROME, TYPES I AND II; PMDS" -"DOID:12680","pseudobulbar palsy" -"OMIM:261560","PFEIFFER-PALM-TELLER SYNDROME" -"OMIM:136620","FRAGILE SITE 10q25; FRA10B" -"OMIM:261575","PHAVER SYNDROME" -"OMIM:261590","PHENFORMIN 4-HYDROXYLATION" -"OMIM:261600","PHENYLKETONURIA; PKU" -"DOID:9588","encephalitis" -"OMIM:261630","HYPERPHENYLALANINEMIA, BH4-DEFICIENT, C; HPABH4C" -"OMIM:136600","FRIEDREICH ATAXIA, SO-CALLED, WITH OPTIC ATROPHY AND SENSORINEURAL DEAFNESS" -"OMIM:261640","HYPERPHENYLALANINEMIA, BH4-DEFICIENT, A; HPABH4A" -"DOID:9637","stomatitis" -"OMIM:261650","PHOSPHOENOLPYRUVATE CARBOXYKINASE DEFICIENCY, MITOCHONDRIAL; PCKDM" -"DOID:0050685","small cell carcinoma" -"OMIM:261670","GLYCOGEN STORAGE DISEASE X; GSD10" -"OMIM:261680","PHOSPHOENOLPYRUVATE CARBOXYKINASE DEFICIENCY, CYTOSOLIC; PCKDC" -"DOID:0090131","complex cortical dysplasia with other brain malformations" -"OMIM:261740","GLYCOGEN STORAGE DISEASE OF HEART, LETHAL CONGENITAL" -"DOID:2043","hepatitis B" -"DOID:2272","vulvovaginal candidiasis" -"OMIM:261750","GLYCOGEN STORAGE DISEASE IXb; GSD9B" -"DOID:14796","Dubowitz syndrome" -"OMIM:261800","PIERRE ROBIN SYNDROME; PRBNS" -"OMIM:261900","PILI TORTI, EARLY-ONSET" -"OMIM:136680","FRASIER SYNDROME" -"DOID:4267","akinetic mutism" -"OMIM:261990","PILI TORTI AND DEVELOPMENTAL DELAY" -"DOID:3431","cerebritis" -"OMIM:262000","BJORNSTAD SYNDROME; BJS" -"DOID:5825","adult lymphoma" -"OMIM:136570","CHROMOSOME 16p12.1 DELETION SYNDROME, 520-KB" -"DOID:0060748","familial temporal lobe epilepsy 1" -"OMIM:262020","PILODENTAL DYSPLASIA WITH REFRACTIVE ERRORS" -"OMIM:262190","PINEAL HYPERPLASIA, INSULIN-RESISTANT DIABETES MELLITUS, AND SOMATIC ABNORMALITIES" -"OMIM:136640","FRAGILE SITE 9q32" -"OMIM:262300","ACHROMATOPSIA 3; ACHM3" -"DOID:3783","Coffin-Lowry syndrome" -"OMIM:262400","ISOLATED GROWTH HORMONE DEFICIENCY, TYPE IA; IGHD1A" -"OMIM:611377","BRACHYDACTYLY, TYPE B2; BDB2" -"OMIM:615817","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 43; MRT43" -"OMIM:308200","ICHTHYOSIS AND MALE HYPOGONADISM" -"OMIM:118980","CLAVICLE, PSEUDARTHROSIS OF, CONGENITAL" -"OMIM:615821","CARDIOMYOPATHY, DILATED, WITH WOOLLY HAIR, KERATODERMA, AND TOOTH AGENESIS; DCWHKTA" -"OMIM:611378","MACULAR DEGENERATION, AGE-RELATED, 9; ARMD9" -"OMIM:308205","IFAP SYNDROME WITH OR WITHOUT BRESHECK SYNDROME" -"OMIM:615824","MITOCHONDRIAL COMPLEX III DEFICIENCY, NUCLEAR TYPE 7; MC3DN7" -"OMIM:611381","KALA-AZAR, SUSCEPTIBILITY TO, 2; KAZA2" -"DOID:7223","breast giant fibroadenoma" -"OMIM:308220","IMMUNODEFICIENCY, X-LINKED, WITH DEFICIENCY OF 115,000 DALTON SURFACE GLYCOPROTEIN" -"OMIM:308230","IMMUNODEFICIENCY WITH HYPER-IgM, TYPE 1; HIGM1" -"DOID:14544","rete testis adenocarcinoma" -"OMIM:615828","MENTAL RETARDATION, AUTOSOMAL DOMINANT 24; MRD24" -"OMIM:119500","POPLITEAL PTERYGIUM SYNDROME; PPS" -"OMIM:611382","KALA-AZAR, SUSCEPTIBILITY TO, 3; KAZA3" -"OMIM:611383","USHER SYNDROME, TYPE IID; USH2D" -"OMIM:615829","XIA-GIBBS SYNDROME" -"OMIM:308240","LYMPHOPROLIFERATIVE SYNDROME, X-LINKED, 1; XLP1" -"OMIM:611384","PLASMODIUM FALCIPARUM FEVER EPISODES QUANTITATIVE TRAIT LOCUS 1" -"DOID:3186","adult oligodendroglioma" -"OMIM:615830","PIGMENTED NODULAR ADRENOCORTICAL DISEASE, PRIMARY, 4; PPNAD4" -"OMIM:308250","IMMUNOGLOBULIN M, LEVEL OF" -"OMIM:615833","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 21; EIEE21" -"DOID:4290","adamantinoid basal cell epithelioma" -"OMIM:611390","SPASTIC ATAXIA 3, AUTOSOMAL RECESSIVE; SPAX3" -"OMIM:175900","POROKERATOSIS 3, MULTIPLE TYPES; POROK3" -"OMIM:308280","IMPACTED TEETH, MULTIPLE" -"OMIM:136000","ADERMATOGLYPHIA; ADERM" -"OMIM:615834","MENTAL RETARDATION, AUTOSOMAL DOMINANT 26; MRD26" -"OMIM:308290","IMPRINTING GENE RELATED TO RETINOBLASTOMA" -"OMIM:611391","CATARACT 33, MULTIPLE TYPES; CTRCT33" -"DOID:0110609","primary ciliary dyskinesia 23" -"OMIM:611403","ASTHMA-RELATED TRAITS, SUSCEPTIBILITY TO, 6" -"OMIM:615835","CHROMOSOME 16 INVERSION, 0.45-MB" -"OMIM:118865","CHOROIDAL OSTEOMA, BILATERAL" -"OMIM:119300","VAN DER WOUDE SYNDROME 1; VWS1" -"OMIM:308300","INCONTINENTIA PIGMENTI; IP" -"OMIM:176090","PORPHYRIA CUTANEA TARDA, TYPE I" -"OMIM:135800","FIBULA, RECURRENT DISLOCATION OF HEAD OF" -"OMIM:611407","CARDIOMYOPATHY, DILATED, 1W; CMD1W" -"OMIM:615837","DEAFNESS, AUTOSOMAL RECESSIVE 101; DFNB101" -"OMIM:308350","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 1; EIEE1" -"OMIM:176000","PORPHYRIA, ACUTE INTERMITTENT; AIP" -"OMIM:611426","TENTED EYEBROWS" -"OMIM:308500","IRIS HYPOPLASIA WITH GLAUCOMA; IHG" -"OMIM:615838","MITOCHONDRIAL COMPLEX III DEFICIENCY, NUCLEAR TYPE 8; MC3DN8" -"OMIM:119540","CLEFT PALATE, ISOLATED; CPI" -"OMIM:176100","PORPHYRIA CUTANEA TARDA" -"DOID:9286","priapism" -"OMIM:611431","LEGIUS SYNDROME" -"OMIM:615841","SPERMATOGENIC FAILURE 13; SPGF13" -"OMIM:308600","JAUNDICE, FAMILIAL OBSTRUCTIVE, OF INFANCY" -"DOID:0050279","conidiobolomycosis" -"OMIM:611451","DEAFNESS, AUTOSOMAL RECESSIVE 63; DFNB63" -"OMIM:615842","SPERMATOGENIC FAILURE 14; SPGF14" -"OMIM:308700","HYPOGONADOTROPIC HYPOGONADISM 1 WITH OR WITHOUT ANOSMIA; HH1" -"OMIM:308750","KALLMANN SYNDROME WITH SPASTIC PARAPLEGIA" -"OMIM:611456","TREMOR, HEREDITARY ESSENTIAL, 3; ETM3" -"OMIM:615846","AICARDI-GOUTIERES SYNDROME 7; AGS7" -"OMIM:119530","OROFACIAL CLEFT 1; OFC1" -"OMIM:615848","MELANOMA, CUTANEOUS MALIGNANT, SUSCEPTIBILITY TO, 10; CMM10" -"OMIM:611465","GALLBLADDER DISEASE 4; GBD4" -"OMIM:308800","KERATOSIS FOLLICULARIS SPINULOSA DECALVANS, X-LINKED; KFSDX" -"OMIM:615849","CULLER-JONES SYNDROME; CJS" -"OMIM:308830","KERATOSIS FOLLICULARIS, DWARFISM, AND CEREBRAL ATROPHY" -"OMIM:611469","COLORECTAL CANCER, SUSCEPTIBILITY TO, 2; CRCS2" -"OMIM:611488","MACULAR DEGENERATION, AGE-RELATED, 10; ARMD10" -"OMIM:615851","PONTOCEREBELLAR HYPOPLASIA, TYPE 2E; PCH2E" -"OMIM:308850","LARYNGEAL ABDUCTOR PARALYSIS" -"OMIM:158900","FACIOSCAPULOHUMERAL MUSCULAR DYSTROPHY 1; FSHD1" -"OMIM:615859","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 23; EIEE23" -"OMIM:308905","LEBER OPTIC ATROPHY, SUSCEPTIBILITY TO" -"OMIM:611489","CORTICOSTEROID-BINDING GLOBULIN DEFICIENCY" -"DOID:4001","ovarian carcinoma" -"OMIM:611490","OSTEOPETROSIS, AUTOSOMAL RECESSIVE 4; OPTB4" -"OMIM:308940","LEIOMYOMATOSIS, DIFFUSE, WITH ALPORT SYNDROME; DL-ATS" -"DOID:4400","dermatosis papulosa nigra" -"DOID:1562","chromoblastomycosis" -"OMIM:615860","CONE-ROD DYSTROPHY 19; CORD19" -"OMIM:136100","FINGERS, RELATIVE LENGTH OF" -"OMIM:118900","CIRRHOSIS, FAMILIAL" -"OMIM:611493","ATRIAL FIBRILLATION, FAMILIAL, 4; ATFB4" -"OMIM:615861","NEPHROTIC SYNDROME, TYPE 10; NPHS10" -"OMIM:308950","LESCH-NYHAN PHENOTYPE WITH NORMAL HGPRT" -"OMIM:611494","ATRIAL FIBRILLATION, FAMILIAL, 5; ATFB5" -"OMIM:615862","NEPHRONOPHTHISIS 18; NPHP18" -"OMIM:308960","LEUKEMIA, ACUTE, ?X-LINKED" -"OMIM:615863","DIARRHEA 7; DIAR7" -"OMIM:611497","OSTEOPETROSIS, AUTOSOMAL RECESSIVE 6; OPTB6" -"OMIM:308990","PROTEINURIA, LOW MOLECULAR WEIGHT, WITH HYPERCALCIURIA AND NEPHROCALCINOSIS" -"OMIM:309000","LOWE OCULOCEREBRORENAL SYNDROME; OCRL" -"OMIM:615866","MENTAL RETARDATION, AUTOSOMAL DOMINANT 27; MRD27" -"OMIM:611498","NEPHRONOPHTHISIS 7; NPHP7" -"OMIM:158650","MUSCULAR ATROPHY, MALIGNANT NEUROGENIC" -"OMIM:158901","FACIOSCAPULOHUMERAL MUSCULAR DYSTROPHY 2; FSHD2" -"OMIM:611515","FEBRILE SEIZURES, FAMILIAL, 7; FEB7" -"OMIM:615871","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 24; EIEE24" -"OMIM:309050","LUTHERAN SUPPRESSOR, X-LINKED; XS" -"OMIM:611521","IMMUNODEFICIENCY 35; IMD35" -"OMIM:615872","CILIARY DYSKINESIA, PRIMARY, 29; CILD29" -"OMIM:309100","MACULAR DYSTROPHY, X-LINKED" -"OMIM:158810","BETHLEM MYOPATHY 1; BTHLM1" -"OMIM:119000","CLEFT CHIN" -"OMIM:309120","SPERMATOGENIC FAILURE, X-LINKED, 2; SPGFX2" -"OMIM:135950","FINGER LOCKING, RECURRENT, WITH INTRAUTERINE GROWTH RETARDATION AND PROPORTIONATE SHORT STATURE" -"OMIM:615873","HELSMOORTEL-VAN DER AA SYNDROME; HVDAS" -"DOID:12566","ulceration of vulva" -"OMIM:135750","LAURIN-SANDROW SYNDROME; LSS" -"OMIM:611522","INTRAOCULAR PRESSURE QUANTITATIVE TRAIT LOCUS; IOPQTL" -"OMIM:309200","MAJOR AFFECTIVE DISORDER 2; MAFD2" -"OMIM:615877","MICROPHTHALMIA/COLOBOMA AND SKELETAL DYSPLASIA SYNDROME; MCSKS" -"OMIM:611523","PONTOCEREBELLAR HYPOPLASIA, TYPE 6; PCH6" -"OMIM:615878","CHOLESTASIS, PROGRESSIVE FAMILIAL INTRAHEPATIC, 4; PFIC4" -"OMIM:309300","MEGALOCORNEA; MGC1" -"OMIM:611528","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 12; ARVD12" -"DOID:350","mastocytosis" -"OMIM:309350","MELNICK-NEEDLES SYNDROME; MNS" -"OMIM:118943","CHYMOSIN PSEUDOGENE; CYMP" -"DOID:3642","empty sella syndrome" -"OMIM:135900","COFFIN-SIRIS SYNDROME 1; CSS1" -"OMIM:611535","MAJOR AFFECTIVE DISORDER 5; MAFD5" -"OMIM:615879","TATTON-BROWN-RAHMAN SYNDROME; TBRS" -"OMIM:611536","MAJOR AFFECTIVE DISORDER 6; MAFD6" -"OMIM:309400","MENKES DISEASE" -"DOID:0050881","inclusion body myopathy with Paget disease of bone and frontotemporal dementia" -"OMIM:615881","PLASMA TRIGLYCERIDE LEVEL QUANTITATIVE TRAIT LOCUS; TGQTL" -"OMIM:615883","MYOPATHY, TUBULAR AGGREGATE, 2; TAM2" -"OMIM:611543","CAVITARY OPTIC DISC ANOMALIES; CODA" -"OMIM:309480","MENTAL RETARDATION AND PSORIASIS" -"OMIM:615885","HYPOTRICHOSIS 12; HYPT12" -"OMIM:309500","RENPENNING SYNDROME 1; RENS1" -"OMIM:611544","CATARACT 17, MULTIPLE TYPES; CTRCT17" -"OMIM:158800","MUSCULAR DYSTROPHY, BARNES TYPE" -"OMIM:119100","SPLIT-HAND/FOOT MALFORMATION WITH LONG BONE DEFICIENCY 1; SHFLD1" -"DOID:14557","primary pulmonary hypertension" -"OMIM:615887","AMELOGENESIS IMPERFECTA, HYPOMATURATION TYPE, IIA5; AI2A5" -"OMIM:309510","PARTINGTON X-LINKED MENTAL RETARDATION SYNDROME; PRTS" -"OMIM:611547","STATURE QUANTITATIVE TRAIT LOCUS 9; STQTL9" -"OMIM:309520","LUJAN-FRYNS SYNDROME" -"OMIM:611548","PREMATURE OVARIAN FAILURE 5; POF5" -"DOID:4555","ovarian large-cell neuroendocrine carcinoma" -"OMIM:615888","BLEEDING DISORDER, PLATELET-TYPE, 18; BDPLT18" -"OMIM:615889","LEUKOENCEPHALOPATHY, PROGRESSIVE, WITH OVARIAN FAILURE; LKENP" -"OMIM:309530","MENTAL RETARDATION, X-LINKED 1; MRX1" -"OMIM:611553","NOONAN SYNDROME 5; NS5" -"OMIM:118840","CHROMATE RESISTANCE; CHR" -"OMIM:611554","LEOPARD SYNDROME 2; LPRD2" -"OMIM:615892","OROFACIAL CLEFT 14; OFC14" -"OMIM:309541","METHYLMALONIC ACIDEMIA AND HOMOCYSTEINEMIA, cblX TYPE" -"DOID:5339","cyclic hematopoiesis" -"DOID:11820","bladder dome cancer" -"OMIM:180105","RETINITIS PIGMENTOSA 10; RP10" -"DOID:13134","hordeolum externum" -"OMIM:180104","RETINITIS PIGMENTOSA 9; RP9" -"OMIM:180200","RETINOBLASTOMA; RB1" -"DOID:2449","acromegaly" -"DOID:8503","impetigo herpetiformis" -"DOID:0090107","autosomal dominant hypocalcemia 1" -"OMIM:182260","SLIPPED FEMORAL CAPITAL EPIPHYSES" -"OMIM:118301","CHARCOT-MARIE-TOOTH DISEASE WITH PTOSIS AND PARKINSONISM" -"OMIM:182269","SMALL PROLINE-RICH PROTEIN 2C, PSEUDOGENE; SPRR2C" -"DOID:0050590","severe congenital neutropenia" -"DOID:8283","peritonitis" -"DOID:11759","hypochromic anemia" -"DOID:11817","urachus cancer" -"DOID:682","compartment syndrome" -"OMIM:277900","WILSON DISEASE" -"OMIM:611555","RENAL TUBULAR ACIDOSIS, DISTAL, WITH NEPHROCALCINOSIS, SHORT STATURE, MENTAL RETARDATION, AND DISTINCTIVE FACIES" -"OMIM:611556","GLYCOGEN STORAGE DISEASE 0, MUSCLE; GSD0B" -"OMIM:277950","WINCHESTER SYNDROME; WNCHRS" -"OMIM:277970","WISKOTT-ALDRICH SYNDROME" -"OMIM:611560","JOUBERT SYNDROME 7; JBTS7" -"OMIM:180750","ROBINOW-SORAUF SYNDROME" -"OMIM:611561","MECKEL SYNDROME, TYPE 5; MKS5" -"DOID:0110838","Usher syndrome type 2A" -"OMIM:277990","WOLFF MENTAL RETARDATION SYNDROME" -"DOID:10273","heart conduction disease" -"OMIM:180849","RUBINSTEIN-TAYBI SYNDROME 1; RSTS1" -"DOID:2615","papilloma" -"OMIM:611571","OTOSCLEROSIS 4; OTSC4" -"OMIM:278000","LYSOSOMAL ACID LIPASE DEFICIENCY" -"OMIM:611572","OTOSCLEROSIS 7; OTSC7" -"OMIM:278100","WOLMAN DISEASE WITH HYPOLIPOPROTEINEMIA AND ACANTHOCYTOSIS" -"OMIM:180800","ROUSSY-LEVY HEREDITARY AREFLEXIC DYSTASIA" -"DOID:2634","cystadenoma" -"OMIM:278150","HYPOTRICHOSIS 8; HYPT8" -"OMIM:611584","WAARDENBURG SYNDROME, TYPE 2E; WS2E" -"OMIM:180860","SILVER-RUSSELL SYNDROME; SRS" -"OMIM:177350","PSEUDOATROPHODERMA COLLI" -"OMIM:186100","SYNDACTYLY, TYPE III" -"DOID:13948","bladder neck obstruction" -"OMIM:269300","CRANIOMETADIAPHYSEAL DYSPLASIA; CRMDD" -"OMIM:185700","SYMPHALANGISM, DISTAL" -"OMIM:269400","ANTERIOR SEGMENT DYSGENESIS 7; ASGD7" -"OMIM:185750","SYMPHALANGISM WITH MULTIPLE ANOMALIES OF HANDS AND FEET" -"OMIM:109720","BILIARY CIRRHOSIS, PRIMARY, 1; PBC1" -"OMIM:269500","SCLEROSTEOSIS 1; SOST1" -"OMIM:185800","SYMPHALANGISM, PROXIMAL, 1A; SYM1A" -"DOID:0110917","hereditary spherocytosis type 2" -"OMIM:185900","CHROMOSOME 2q35 DUPLICATION SYNDROME" -"OMIM:269600","SEA-BLUE HISTIOCYTE DISEASE" -"OMIM:116850","CATATRICHY" -"OMIM:186200","SYNDACTYLY, TYPE IV; SDTY4" -"OMIM:269630","SECOND METATARSAL-METACARPAL SYNDROME" -"OMIM:186000","SYNPOLYDACTYLY 1; SPD1" -"DOID:5678","nerve fibre bundle defect" -"OMIM:269650","SECRETORY COMPONENT DEFICIENCY" -"OMIM:109800","BLADDER CANCER" -"OMIM:615269","HYPOGONADOTROPIC HYPOGONADISM 19 WITH OR WITHOUT ANOSMIA; HH19" -"OMIM:610140","HEART-HAND SYNDROME, SLOVENIAN TYPE" -"OMIM:610141","QT INTERVAL, VARIATION IN" -"OMIM:615270","HYPOGONADOTROPIC HYPOGONADISM 20 WITH OR WITHOUT ANOSMIA; HH20" -"DOID:4515","thyroid sarcoma" -"OMIM:610143","DEAFNESS, AUTOSOMAL RECESSIVE 62; DFNB62" -"OMIM:615271","HYPOGONADOTROPIC HYPOGONADISM 21 WITH OR WITHOUT ANOSMIA; HH21" -"OMIM:610149","MACULAR DEGENERATION, AGE-RELATED, 7; ARMD7" -"OMIM:615272","FANCONI ANEMIA, COMPLEMENTATION GROUP Q; FANCQ" -"DOID:205","hyperostosis" -"OMIM:610153","DEAFNESS, AUTOSOMAL RECESSIVE 49; DFNB49" -"OMIM:615273","CONGENITAL DISORDER OF DEGLYCOSYLATION; CDDG" -"OMIM:109120","AXENFELD-RIEGER ANOMALY WITH PARTIALLY ABSENT EYE MUSCLES, DISTINCTIVE FACE, HYDROCEPHALY, AND SKELETAL ABNORMALITIES" -"DOID:0110128","Bardet-Biedl syndrome 6" -"OMIM:610154","DEAFNESS, AUTOSOMAL RECESSIVE 44; DFNB44" -"OMIM:615274","CATARACT 15, MULTIPLE TYPES; CTRCT15" -"OMIM:610155","DIABETES MELLITUS, INSULIN-DEPENDENT, 19; IDDM19" -"OMIM:615277","CATARACT 19, MULTIPLE TYPES; CTRCT19" -"OMIM:610156","MENTAL RETARDATION, TRUNCAL OBESITY, RETINAL DYSTROPHY, AND MICROPENIS SYNDROME; MORMS" -"OMIM:615278","CARDIOFACIOCUTANEOUS SYNDROME 2; CFC2" -"OMIM:615279","CARDIOFACIOCUTANEOUS SYNDROME 3; CFC3" -"OMIM:610157","HEAT-SHOCK RNA 1" -"OMIM:610158","CORNEAL DYSTROPHY, FUCHS ENDOTHELIAL, 2; FECD2" -"DOID:12466","secondary hyperparathyroidism" -"OMIM:615280","CARDIOFACIOCUTANEOUS SYNDROME 4; CFC4" -"OMIM:615281","HYPOMYELINATION WITH BRAINSTEM AND SPINAL CORD INVOLVEMENT AND LEG SPASTICITY; HBSL" -"OMIM:610163","IMMUNODEFICIENCY 25; IMD25" -"DOID:8527","monocytic leukemia" -"OMIM:610168","LOEYS-DIETZ SYNDROME 2; LDS2" -"OMIM:615282","CORTICAL DYSPLASIA, COMPLEX, WITH OTHER BRAIN MALFORMATIONS 2; CDCBM2" -"DOID:12705","Friedreich ataxia" -"DOID:9446","cholangitis" -"OMIM:610170","KYPHOSCOLIOSIS 1; KYPSC1" -"OMIM:615284","CHARCOT-MARIE-TOOTH DISEASE, TYPE 4B3; CMT4B3" -"OMIM:615285","NEUTROPENIA, SEVERE CONGENITAL, 5, AUTOSOMAL RECESSIVE; SCN5" -"OMIM:610181","AICARDI-GOUTIERES SYNDROME 2; AGS2" -"DOID:5528","rectum squamous cell carcinoma" -"OMIM:610185","CEREBELLAR ATAXIA, MENTAL RETARDATION, AND DYSEQUILIBRIUM SYNDROME 2; CAMRQ2" -"OMIM:615286","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 36; MRT36" -"OMIM:610187","DIAPHRAGMATIC HERNIA 3; DIH3" -"OMIM:615287","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 13; MDDGA13" -"OMIM:615290","SPINAL MUSCULAR ATROPHY, LOWER EXTREMITY-PREDOMINANT, 2, AUTOSOMAL DOMINANT; SMALED2" -"OMIM:610188","JOUBERT SYNDROME 5; JBTS5" -"OMIM:610189","SENIOR-LOKEN SYNDROME 6; SLSN6" -"OMIM:615293","MYOFIBROMATOSIS, INFANTILE, 2; IMF2" -"OMIM:615294","CILIARY DYSKINESIA, PRIMARY, 21; CILD21" -"OMIM:610193","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 10; ARVD10" -"DOID:90","degenerative disc disease" -"OMIM:610198","3-METHYLGLUTACONIC ACIDURIA, TYPE V; MGCA5" -"OMIM:615297","ADAMS-OLIVER SYNDROME 4; AOS4" -"OMIM:615298","SYMPHALANGISM, PROXIMAL, 1B; SYM1B" -"OMIM:610199","DIABETES MELLITUS, NEONATAL, WITH CONGENITAL HYPOTHYROIDISM; NDH" -"OMIM:610202","CATARACT 21, MULTIPLE TYPES; CTRCT21" -"OMIM:615300","PERRAULT SYNDROME 4; PRLTS4" -"DOID:0060694","Cayman type cerebellar ataxia" -"DOID:0050134","cutaneous mycosis" -"OMIM:615311","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 17; BMND17" -"OMIM:610204","PONTOCEREBELLAR HYPOPLASIA, TYPE 5; PCH5" -"OMIM:615312","ALBINISM, OCULOCUTANEOUS, TYPE V; OCA5" -"OMIM:610205","ALAGILLE SYNDROME 2; ALGS2" -"OMIM:610208","MIGRAINE WITH OR WITHOUT AURA, SUSCEPTIBILITY TO, 10" -"DOID:0050133","superficial mycosis" -"OMIM:109100","AUTOIMMUNE DISEASE" -"OMIM:615314","CRANIOSYNOSTOSIS 3; CRS3" -"OMIM:615325","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2R; LGMD2R" -"OMIM:610209","MIGRAINE WITH OR WITHOUT AURA, SUSCEPTIBILITY TO, 11" -"OMIM:610212","DEAFNESS, AUTOSOMAL RECESSIVE 66; DFNB66" -"OMIM:615327","DOWLING-DEGOS DISEASE 2; DDD2" -"DOID:1996","rectum adenocarcinoma" -"OMIM:610213","ANEURYSM, INTRACRANIAL BERRY, 4; ANIB4" -"OMIM:615328","SHAHEEN SYNDROME; SHNS" -"OMIM:109130","AXIAL OSTEOMALACIA" -"OMIM:615330","MULTIPLE MITOCHONDRIAL DYSFUNCTIONS SYNDROME 3; MMDS3" -"OMIM:610217","NEURODEGENERATION WITH BRAIN IRON ACCUMULATION 2B; NBIA2B" -"OMIM:615338","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 16; EIEE16" -"DOID:217","enamel caries" -"OMIM:610220","DEAFNESS, AUTOSOMAL RECESSIVE 59; DFNB59" -"OMIM:615342","PULMONARY HYPERTENSION, PRIMARY, 2; PPH2" -"OMIM:610227","SEBORRHEA-LIKE DERMATITIS WITH PSORIASIFORM ELEMENTS" -"OMIM:109050","AUROCEPHALOSYNDACTYLY" -"OMIM:610234","SYNPOLYDACTYLY 3; SPD3" -"OMIM:615343","PULMONARY HYPERTENSION, PRIMARY, 3; PPH3" -"OMIM:610239","HIGH DENSITY LIPOPROTEIN CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 4" -"OMIM:615344","PULMONARY HYPERTENSION, PRIMARY, 4; PPH4" -"DOID:0111034","hemochromatosis type 2" -"OMIM:615346","PRECOCIOUS PUBERTY, CENTRAL, 2; CPPB2" -"DOID:12895","keratoconjunctivitis sicca" -"OMIM:610244","SPASTIC PARAPLEGIA 33, AUTOSOMAL DOMINANT; SPG33" -"DOID:0050459","hyperphosphatemia" -"OMIM:615348","NEMALINE MYOPATHY 8; NEM8" -"OMIM:176305","PREAXIAL DEFICIENCY, POSTAXIAL POLYDACTYLY, AND HYPOSPADIAS" -"OMIM:610245","SPINOCEREBELLAR ATAXIA 23; SCA23" -"DOID:13543","hyperparathyroidism" -"OMIM:610246","SPINOCEREBELLAR ATAXIA 28; SCA28" -"OMIM:615349","EHLERS-DANLOS SYNDROME, PROGEROID TYPE, 2; EDSP2" -"DOID:12119","hemosiderosis" -"DOID:9132","liver carcinoma in situ" -"DOID:9174","rectum carcinoma in situ" -"DOID:4527","ovarian angiosarcoma" -"DOID:8791","breast carcinoma in situ" -"DOID:8616","Peyronie's disease" -"DOID:8872","penis carcinoma in situ" -"DOID:2712","phimosis" -"DOID:6148","nasal cavity carcinoma in situ" -"DOID:676","juvenile rheumatoid arthritis" -"DOID:4943","adenocarcinoma in situ" -"DOID:8738","leukoplakia of penis" -"DOID:13033","balanitis" -"DOID:14291","LEOPARD syndrome" -"DOID:0050638","transthyretin amyloidosis" -"DOID:0050793","short QT syndrome" -"DOID:9024","intestine carcinoma in situ" -"DOID:9095","esophagus carcinoma in situ" -"DOID:0050610","oral cavity carcinoma in situ" -"DOID:0110969","brachydactyly type B1" -"DOID:3846","adamantinous craniopharyngioma" -"DOID:0090092","hypogonadotropic hypogonadism 3 with or without anosmia" -"DOID:8792","eye carcinoma in situ" -"DOID:0111049","platelet-type bleeding disorder 17" -"DOID:3306","mixed germ cell cancer" -"DOID:9011","larynx carcinoma in situ" -"DOID:0050613","bile duct carcinoma in situ" -"DOID:9108","uterus carcinoma in situ" -"DOID:8661","lip carcinoma in situ" -"DOID:0050711","aceruloplasminemia" -"DOID:4851","pilocytic astrocytoma" -"DOID:9087","anal carcinoma in situ" -"DOID:8634","prostate carcinoma in situ" -"DOID:3385","bacterial vaginosis" -"DOID:1766","factitious disorder" -"DOID:263","kidney cancer" -"OMIM:215510","CHROMOSOMAL INSTABILITY WITH TISSUE-SPECIFIC RADIOSENSITIVITY" -"OMIM:228930","FIBULAR APLASIA OR HYPOPLASIA, FEMORAL BOWING AND POLY-, SYN-, AND OLIGODACTYLY" -"OMIM:610247","ESOPHAGITIS, EOSINOPHILIC, 1; EOE1" -"OMIM:400043","DEAFNESS, Y-LINKED 1; DFNY1" -"OMIM:228940","FIBULOULNAR APLASIA OR HYPOPLASIA WITH RENAL ABNORMALITIES" -"OMIM:610248","DEAFNESS, AUTOSOMAL RECESSIVE 65; DFNB65" -"OMIM:400044","46,XY SEX REVERSAL 1; SRXY1" -"OMIM:215518","CILIARY DISCOORDINATION DUE TO RANDOM CILIARY ORIENTATION" -"OMIM:228960","HIGH MOLECULAR WEIGHT KININOGEN DEFICIENCY" -"DOID:4206","childhood brain stem neoplasm" -"OMIM:400045","46,XX SEX REVERSAL 1; SRXX1" -"DOID:4202","brain stem glioma" -"OMIM:215520","CILIARY DYSKINESIA WITH TRANSPOSITION OF CILIARY MICROTUBULES" -"OMIM:610250","SPASTIC PARAPLEGIA 31, AUTOSOMAL DOMINANT; SPG31" -"OMIM:610251","ALCOHOL SENSITIVITY, ACUTE" -"OMIM:415000","SPERMATOGENIC FAILURE, Y-LINKED, 2; SPGFY2" -"OMIM:228980","FLECK RETINA, FAMILIAL BENIGN; FRFB" -"OMIM:215550","CIRCUMVALLATE PLACENTA SYNDROME" -"OMIM:215600","CIRRHOSIS, FAMILIAL" -"OMIM:610253","KLEEFSTRA SYNDROME" -"DOID:3200","cerebellopontine angle tumor" -"OMIM:228990","FLECK RETINA OF KANDORI" -"OMIM:121300","COPROPORPHYRIA, HEREDITARY; HCP" -"OMIM:424500","GONADOBLASTOMA; GBY" -"OMIM:610256","ANTERIOR SEGMENT DYSGENESIS 2; ASGD2" -"OMIM:215700","CITRULLINEMIA, CLASSIC" -"OMIM:229045","FOCAL EPITHELIAL HYPERPLASIA, ORAL" -"OMIM:121350","CORACOCLAVICULAR JOINT, ANOMALOUS" -"OMIM:425500","HAIRY EARS, Y-LINKED" -"OMIM:121070","ARTHROGRYPOSIS, DISTAL, TYPE 2E" -"OMIM:215720","CITRULLINE TRANSPORT DEFECT" -"OMIM:610260","PYLORIC STENOSIS, INFANTILE HYPERTROPHIC, 2; IHPS2" -"DOID:0050025","human granulocytic anaplasmosis" -"OMIM:229050","FOLATE MALABSORPTION, HEREDITARY" -"OMIM:475000","GROWTH CONTROL, Y-CHROMOSOME INFLUENCED; GCY" -"OMIM:215800","CLEFT LARYNX, POSTERIOR" -"OMIM:489000","UBIQUITIN-ACTIVATING ENZYME, Y-LINKED" -"OMIM:229070","HYPOGONADOTROPIC HYPOGONADISM 24 WITHOUT ANOSMIA; HH24" -"DOID:0110385","retinitis pigmentosa 63" -"OMIM:610261","HYPERTENSION, ESSENTIAL, SUSCEPTIBILITY TO, 5" -"OMIM:229100","GLUTAMATE FORMIMINOTRANSFERASE DEFICIENCY" -"OMIM:215850","CLEFT-LIMB-HEART MALFORMATION SYNDROME" -"OMIM:500000","CARDIOMYOPATHY, INFANTILE HISTIOCYTOID" -"OMIM:610262","HYPERTENSION, ESSENTIAL, SUSCEPTIBILITY TO, 6" -"DOID:0050432","Asperger syndrome" -"OMIM:500001","LEBER OPTIC ATROPHY AND DYSTONIA" -"OMIM:610265","DEAFNESS, AUTOSOMAL RECESSIVE 67; DFNB67" -"OMIM:229120","FOUNTAIN SYNDROME" -"DOID:6432","pulmonary hypertension" -"OMIM:121210","FEBRILE SEIZURES, FAMILIAL, 1; FEB1" -"DOID:0050642","hypochromic microcytic anemia" -"OMIM:216100","CLEFT LIP/PALATE WITH ABNORMAL THUMBS AND MICROCEPHALY" -"OMIM:500002","MITOCHONDRIAL MYOPATHY WITH DIABETES" -"OMIM:216300","CLEFT PALATE, DEAFNESS, AND OLIGODONTIA" -"OMIM:229200","BRITTLE CORNEA SYNDROME 1; BCS1" -"OMIM:610269","BULIMIA NERVOSA, SUSCEPTIBILITY TO, 2; BULN2" -"DOID:4743","mixed testicular germ cell tumor" -"OMIM:229230","FRASER-LIKE SYNDROME" -"OMIM:500003","STRIATONIGRAL DEGENERATION, INFANTILE, MITOCHONDRIAL" -"OMIM:216330","CLEIDOCRANIAL DYSPLASIA, RECESSIVE FORM" -"OMIM:610279","PACHYGYRIA, FRONTOTEMPORAL" -"DOID:11385","expressive language disorder" -"DOID:0111064","autosomal recessive distal spinal muscular atrophy 1" -"OMIM:216340","YUNIS-VARON SYNDROME; YVS" -"OMIM:500004","RETINITIS PIGMENTOSA-DEAFNESS SYNDROME" -"OMIM:610282","RETINITIS PIGMENTOSA 35; RP35" -"OMIM:229250","FREESIA FLOWERS, INABILITY TO SMELL" -"DOID:0050899","brain stem medulloblastoma" -"DOID:10973","acute salpingitis" -"OMIM:610283","CONE-ROD DYSTROPHY 10; CORD10" -"DOID:11573","listeriosis" -"OMIM:229300","FRIEDREICH ATAXIA 1; FRDA" -"OMIM:216360","COACH SYNDROME" -"OMIM:500005","HYPOMAGNESEMIA, HYPERTENSION, AND HYPERCHOLESTEROLEMIA, MITOCHONDRIAL" -"OMIM:229310","FRIEDREICH ATAXIA AND CONGENITAL GLAUCOMA" -"OMIM:610293","GLYCOSYLPHOSPHATIDYLINOSITOL DEFICIENCY; GPID" -"OMIM:500006","CARDIOMYOPATHY, INFANTILE HYPERTROPHIC" -"OMIM:216400","COCKAYNE SYNDROME A; CSA" -"OMIM:500007","CYCLIC VOMITING SYNDROME; CVS" -"OMIM:229400","FRONTOFACIONASAL DYSPLASIA" -"OMIM:216550","COHEN SYNDROME; COH1" -"OMIM:121050","ARTHROGRYPOSIS, DISTAL, TYPE 9; DA9" -"OMIM:610294","INTELLIGENCE QUANTITATIVE TRAIT LOCUS 2" -"OMIM:216700","COLLAGENOSIS, FAMILIAL REACTIVE PERFORATING; RPC" -"OMIM:500008","DEAFNESS, NONSYNDROMIC SENSORINEURAL, MITOCHONDRIAL" -"OMIM:610295","INTELLIGENCE QUANTITATIVE TRAIT LOCUS 3" -"OMIM:121270","COPPER DEFICIENCY, FAMILIAL BENIGN" -"OMIM:229500","FRUCTOSE AND GALACTOSE INTOLERANCE" -"OMIM:500009","MITOCHONDRIAL MYOPATHY, INFANTILE, TRANSIENT; MMIT" -"OMIM:229600","FRUCTOSE INTOLERANCE, HEREDITARY" -"OMIM:216800","COLOBOMA OF MACULA AND SKELETAL ANOMALIES" -"OMIM:610297","PARKINSON DISEASE 13, AUTOSOMAL DOMINANT, SUSCEPTIBILITY TO; PARK13" -"DOID:3766","leukorrhea" -"DOID:5074","malignant ependymoma" -"OMIM:229650","FRUCTOSE UTILIZATION" -"OMIM:500010","ATAXIA AND POLYNEUROPATHY, ADULT-ONSET" -"OMIM:216820","COLOBOMA, OCULAR, AUTOSOMAL RECESSIVE" -"OMIM:121200","SEIZURES, BENIGN FAMILIAL NEONATAL, 1; BFNS1" -"OMIM:610313","COLD-INDUCED SWEATING SYNDROME 2; CISS2" -"OMIM:229700","FRUCTOSE-1,6-BISPHOSPHATASE DEFICIENCY; FBP1D" -"OMIM:216900","ACHROMATOPSIA 2; ACHM2" -"OMIM:610319","RHIZOMELIC DYSPLASIA, SCOLIOSIS, AND RETINITIS PIGMENTOSA" -"OMIM:500011","MYOPATHY, LACTIC ACIDOSIS, AND SIDEROBLASTIC ANEMIA 3; MLASA3" -"DOID:13564","aspergillosis" -"OMIM:610320","MYOPIA 14; MYP14" -"OMIM:502000","AGING" -"DOID:7634","suprasellar meningioma" -"DOID:5076","mixed glioma" -"OMIM:229800","FRUCTOSURIA, ESSENTIAL" -"OMIM:216920","COMBINED INFLAMMATORY AND IMMUNOLOGIC DEFECT" -"OMIM:216950","COMPLEMENT COMPONENT C1r/C1s DEFICIENCY" -"OMIM:229850","FRYNS SYNDROME; FRNS" -"OMIM:610321","PROSTATE CANCER, HEREDITARY, 7; HPC7" -"OMIM:502500","ALZHEIMER DISEASE, SUSCEPTIBILITY TO, MITOCHONDRIAL" -"OMIM:610329","AICARDI-GOUTIERES SYNDROME 3; AGS3" -"OMIM:217000","COMPLEMENT COMPONENT 2 DEFICIENCY; C2D" -"OMIM:515000","CHLORAMPHENICOL TOXICITY" -"DOID:11907","ecthyma" -"OMIM:230000","FUCOSIDOSIS" -"OMIM:217080","JALILI SYNDROME" -"OMIM:610333","AICARDI-GOUTIERES SYNDROME 4; AGS4" -"OMIM:230200","GALACTOKINASE DEFICIENCY" -"OMIM:520000","DIABETES AND DEAFNESS, MATERNALLY INHERITED; MIDD" -"OMIM:520100","DIARRHEA, CHRONIC, WITH VILLOUS ATROPHY" -"OMIM:610338","RIGHT PULMONARY ARTERY, ANOMALOUS ORIGIN OF, FAMILIAL" -"DOID:4441","dysgerminoma" -"OMIM:217085","CONGENITAL HEART DEFECTS, HAMARTOMAS OF TONGUE, AND POLYSYNDACTYLY; CHDTHP" -"OMIM:230300","GALACTORRHEA" -"OMIM:217090","PLASMINOGEN DEFICIENCY, TYPE I" -"OMIM:530000","KEARNS-SAYRE SYNDROME; KSS" -"OMIM:230350","GALACTOSE EPIMERASE DEFICIENCY" -"DOID:3324","mood disorder" -"OMIM:610353","EPILEPSY, NOCTURNAL FRONTAL LOBE, 4; ENFL4" -"OMIM:610356","RETINAL CONE DYSTROPHY 3B; RCD3B" -"OMIM:535000","LEBER OPTIC ATROPHY" -"OMIM:217095","CONOTRUNCAL HEART MALFORMATIONS; CTHM" -"OMIM:230400","GALACTOSEMIA" -"DOID:9908","internal hordeolum" -"DOID:3448","penis Paget's disease" -"OMIM:217100","CONSTRICTING BANDS, CONGENITAL" -"OMIM:230450","GAMMA-GLUTAMYLCYSTEINE SYNTHETASE DEFICIENCY, HEMOLYTIC ANEMIA DUE TO" -"OMIM:610357","SPASTIC PARAPLEGIA 30, AUTOSOMAL RECESSIVE; SPG30" -"OMIM:540000","MITOCHONDRIAL MYOPATHY, ENCEPHALOPATHY, LACTIC ACIDOSIS, AND STROKE-LIKE EPISODES; MELAS" -"OMIM:610359","RETINITIS PIGMENTOSA 33; RP33" -"OMIM:230500","GM1-GANGLIOSIDOSIS, TYPE I" -"OMIM:217150","CONTRACTURES, CONGENITAL, TORTICOLLIS, AND MALIGNANT HYPERTHERMIA" -"OMIM:121201","SEIZURES, BENIGN FAMILIAL NEONATAL, 2; BFNS2" -"OMIM:545000","MYOCLONIC EPILEPSY ASSOCIATED WITH RAGGED-RED FIBERS; MERRF" -"DOID:5518","penis squamous cell carcinoma" -"OMIM:217200","CONVULSIVE DISORDER, FAMILIAL, WITH PRENATAL OR EARLY ONSET" -"OMIM:610361","OROFACIAL CLEFT 9; OFC9" -"DOID:6501","brain stem angioblastoma" -"OMIM:550500","MYOGLOBINURIA, RECURRENT" -"OMIM:230600","GM1-GANGLIOSIDOSIS, TYPE II" -"DOID:0050288","penicilliosis" -"DOID:678","progressive supranuclear palsy" -"OMIM:551000","MITOCHONDRIAL MYOPATHY, LETHAL, INFANTILE; LIMM" -"OMIM:217300","CORNEA PLANA 2, AUTOSOMAL RECESSIVE; CNA2" -"OMIM:610370","DIARRHEA 4, MALABSORPTIVE, CONGENITAL; DIAR4" -"OMIM:230650","GM1-GANGLIOSIDOSIS, TYPE III" -"OMIM:217400","CORNEAL DYSTROPHY AND PERCEPTIVE DEAFNESS; CDPD" -"OMIM:551200","NEPHROPATHY, CHRONIC TUBULOINTERSTITIAL" -"OMIM:230740","GAPO SYNDROME" -"OMIM:121400","CORNEA PLANA 1, AUTOSOMAL DOMINANT; CNA1" -"OMIM:610374","DIABETES MELLITUS, TRANSIENT NEONATAL, 2" -"OMIM:230750","GASTROSCHISIS" -"OMIM:551500","NEUROPATHY, ATAXIA, AND RETINITIS PIGMENTOSA" -"OMIM:610377","MEVALONIC ACIDURIA; MEVA" -"DOID:12053","cryptococcosis" -"OMIM:121390","CORNEA GUTTATA WITH ANTERIOR POLAR CATARACTS" -"OMIM:217500","CORNEAL DYSTROPHY, BAND-SHAPED" -"OMIM:553000","ONCOCYTOMA" -"OMIM:217520","CORNEAL DEGENERATION, BAND-SHAPED SPHEROID" -"OMIM:230800","GAUCHER DISEASE, TYPE I" -"OMIM:610379","WEST NILE VIRUS, SUSCEPTIBILITY TO" -"OMIM:121450","CORNEAL DEGENERATION, RIBBONLIKE, WITH DEAFNESS" -"OMIM:217600","CENTRAL CLOUDY DYSTROPHY OF FRANCOIS; CCDF" -"OMIM:610381","CONE-ROD DYSTROPHY 11; CORD11" -"OMIM:556500","PARKINSON DISEASE, MITOCHONDRIAL" -"OMIM:121800","SCHNYDER CORNEAL DYSTROPHY; SCCD" -"OMIM:230900","GAUCHER DISEASE, TYPE II" -"OMIM:610382","PROSOPAGNOSIA, HEREDITARY" -"OMIM:231000","GAUCHER DISEASE, TYPE III" -"OMIM:217700","CORNEAL ENDOTHELIAL DYSTROPHY; CHED" -"OMIM:557000","PEARSON MARROW-PANCREAS SYNDROME" -"OMIM:151210","PLATYSPONDYLIC LETHAL SKELETAL DYSPLASIA, TORRANCE TYPE; PLSDT" -"DOID:11811","urinary bladder posterior wall cancer" -"OMIM:120040","COCHLEOSACCULAR DEGENERATION WITH PROGRESSIVE CATARACTS" -"OMIM:615350","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 14; MDDGA14" -"OMIM:615351","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH MENTAL RETARDATION), TYPE B, 14; MDDGB14" -"DOID:11814","urinary bladder anterior wall cancer" -"OMIM:119570","CLEFT SOFT PALATE" -"OMIM:615352","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (LIMB-GIRDLE), TYPE C, 14; MDDGC14" -"OMIM:119580","BLEPHAROCHEILODONTIC SYNDROME 1; BCDS1" -"DOID:11593","bladder lateral wall cancer" -"OMIM:615355","NOONAN SYNDROME 8; NS8" -"OMIM:151000","LENTIGINOSIS, CENTROFACIAL NEURODYSRAPHIC" -"OMIM:615356","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2S; LGMD2S" -"DOID:3827","congenital diaphragmatic hernia" -"OMIM:119915","CLUSTER HEADACHE, FAMILIAL" -"OMIM:615360","LEBER CONGENITAL AMAUROSIS 17; LCA17" -"OMIM:151380","LEUKEMIA, ACUTE MONOCYTIC" -"OMIM:615361","HYPOCALCEMIA, AUTOSOMAL DOMINANT 2; HYPOC2" -"DOID:3669","intermittent claudication" -"OMIM:151001","LENTIGINOSIS, INHERITED PATTERNED" -"OMIM:615362","CEROID LIPOFUSCINOSIS, NEURONAL, 13; CLN13" -"DOID:2885","benign prostate phyllodes tumor" -"DOID:5160","arteriosclerosis obliterans" -"DOID:10783","methemoglobinemia" -"DOID:13938","amenorrhea" -"OMIM:615363","ESTROGEN RESISTANCE; ESTRR" -"OMIM:119900","DIGITAL CLUBBING, ISOLATED CONGENITAL" -"DOID:0050480","epidemic typhus" -"OMIM:151200","CHROMOSOME 8q22.1 DUPLICATION SYNDROME" -"OMIM:615368","LETHAL CONGENITAL CONTRACTURE SYNDROME 5; LCCS5" -"OMIM:615369","EPILEPTIC ENCEPHALOPATHY, CHILDHOOD-ONSET; EEOC" -"OMIM:615371","PULMONARY HYPERTENSION, NEONATAL, SUSCEPTIBILITY TO; PHN" -"DOID:1742","drug psychosis" -"OMIM:615373","LEFT VENTRICULAR NONCOMPACTION 8; LVNC8" -"OMIM:615374","CONE-ROD DYSTROPHY 18; CORD18" -"OMIM:119550","SYNGNATHIA" -"DOID:93","language disorder" -"OMIM:615376","CHARCOT-MARIE-TOOTH DISEASE, RECESSIVE INTERMEDIATE C; CMTRIC" -"DOID:8456","choline deficiency disease" -"OMIM:615377","ATRIAL FIBRILLATION, FAMILIAL, 13; ATFB13" -"DOID:1100","ovarian disease" -"OMIM:615378","ATRIAL FIBRILLATION, FAMILIAL, 14; ATFB14" -"DOID:3109","idiopathic CD4-positive T-lymphocytopenia" -"DOID:2529","splenic disease" -"OMIM:151050","LENZ-MAJEWSKI HYPEROSTOTIC DWARFISM; LMHD" -"OMIM:615381","MANDIBULAR HYPOPLASIA, DEAFNESS, PROGEROID FEATURES, AND LIPODYSTROPHY SYNDROME; MDPL" -"DOID:5161","Monckeberg arteriosclerosis" -"DOID:11813","bladder trigone cancer" -"OMIM:615382","NEPHRONOPHTHISIS 16; NPHP16" -"OMIM:119650","CLEIDORHIZOMELIC SYNDROME" -"OMIM:615386","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 14; SCAR14" -"DOID:9409","diabetes insipidus" -"OMIM:615387","T-CELL RECEPTOR-ALPHA/BETA DEFICIENCY" -"OMIM:615390","VESICOURETERAL REFLUX 7; VUR7" -"OMIM:615395","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 16; COXPD16" -"OMIM:615396","LEFT VENTRICULAR NONCOMPACTION 10; LVNC10" -"DOID:11818","ureteric orifice cancer" -"OMIM:615397","MECKEL SYNDROME, TYPE 11; MKS11" -"OMIM:615398","MULTIPLE CONGENITAL ANOMALIES-HYPOTONIA-SEIZURES SYNDROME 3; MCAHS3" -"DOID:480","movement disease" -"OMIM:615399","PAROXYSMAL NOCTURNAL HEMOGLOBINURIA 2; PNH2" -"DOID:13097","intracranial arteriosclerosis" -"DOID:13742","neurofibroma of spinal cord" -"OMIM:615400","EPILEPSY, FAMILIAL ADULT MYOCLONIC, 5; FAME5" -"DOID:0060119","pharynx cancer" -"OMIM:119600","CLEIDOCRANIAL DYSPLASIA; CCD" -"OMIM:119800","CLUBFOOT, CONGENITAL, WITH OR WITHOUT DEFICIENCY OF LONG BONES AND/OR MIRROR-IMAGE POLYDACTYLY; CCF" -"OMIM:615401","IMMUNODEFICIENCY 8; IMD8" -"DOID:3132","porphyria cutanea tarda" -"DOID:5152","cellular neurofibroma" -"OMIM:615402","DYSCHROMATOSIS UNIVERSALIS HEREDITARIA 3; DUH3" -"OMIM:120000","COARCTATION OF AORTA" -"DOID:5162","arteriolosclerosis" -"OMIM:615411","CORTICAL DYSPLASIA, COMPLEX, WITH OTHER BRAIN MALFORMATIONS 3; CDCBM3" -"DOID:4706","infratentorial cancer" -"DOID:5151","plexiform neurofibroma" -"OMIM:615412","CORTICAL DYSPLASIA, COMPLEX, WITH OTHER BRAIN MALFORMATIONS 4; CDCBM4" -"DOID:11832","visual epilepsy" -"OMIM:615413","SPERMATOGENIC FAILURE 12; SPGF12" -"DOID:9300","neurofibroma of the heart" -"OMIM:151100","LEOPARD SYNDROME 1; LPRD1" -"OMIM:615414","MICROCEPHALY 11, PRIMARY, AUTOSOMAL RECESSIVE; MCPH11" -"DOID:11812","bladder sarcoma" -"OMIM:175510","POLYPS, MULTIPLE AND RECURRENT INFLAMMATORY FIBROID, GASTROINTESTINAL" -"OMIM:615415","RENAL-HEPATIC-PANCREATIC DYSPLASIA 2; RHPD2" -"DOID:0060519","beta-lactam allergy" -"DOID:5150","neurofibroma of gallbladder" -"DOID:8580","malignant histiocytosis" -"OMIM:615418","MITOCHONDRIAL DNA DEPLETION SYNDROME 12B (CARDIOMYOPATHIC TYPE), AUTOSOMAL RECESSIVE; MTDPS12B" -"DOID:4439","central nervous system germ cell tumor" -"DOID:11086","chorioretinal scar" -"DOID:10887","lepromatous leprosy" -"OMIM:219300","CUTIS VERTICIS GYRATA AND MENTAL RETARDATION; CVG/MR" -"DOID:11036","chronic rapidly progressive glomerulonephritis" -"DOID:11561","hypertensive retinopathy" -"OMIM:219400","CYANOSIS AND HEPATIC DISEASE" -"DOID:0050851","glomerulosclerosis" -"OMIM:219500","CYSTATHIONINURIA" -"DOID:0060178","familial hemiplegic migraine" -"OMIM:219550","CYSTEINE PEPTIDURIA" -"DOID:627","severe combined immunodeficiency" -"OMIM:219600","CYSTIC DISEASE OF LUNG" -"OMIM:219700","CYSTIC FIBROSIS; CF" -"OMIM:219721","CYSTIC FIBROSIS WITH HELICOBACTER PYLORI GASTRITIS, MEGALOBLASTIC ANEMIA, AND MENTAL RETARDATION" -"DOID:4797","SM-AHNMD" -"DOID:9378","glaucomatocyclitic crisis" -"OMIM:219730","VENTRICULOMEGALY WITH CYSTIC KIDNEY DISEASE; VMCKD" -"DOID:4778","proliferative glomerulonephritis" -"DOID:0050909","MALT lymphoma" -"OMIM:219750","CYSTINOSIS, ADULT NONNEPHROPATHIC" -"OMIM:219800","CYSTINOSIS, NEPHROPATHIC; CTNS" -"OMIM:219900","CYSTINOSIS, LATE-ONSET JUVENILE OR ADOLESCENT NEPHROPATHIC TYPE" -"OMIM:171480","PHOCOMELIA-ECTRODACTYLY, EAR MALFORMATION, DEAFNESS, AND SINUS ARRHYTHMIA" -"OMIM:220100","CYSTINURIA" -"OMIM:220110","MITOCHONDRIAL COMPLEX IV DEFICIENCY" -"OMIM:220111","LEIGH SYNDROME, FRENCH CANADIAN TYPE; LSFC" -"OMIM:110350","BLOOD GROUP--AHONEN; AN" -"OMIM:171660","PHOSPHATASE, ACID, OF TISSUES" -"OMIM:110450","BLOOD GROUP--COLTON; CO" -"OMIM:220120","D-GLYCERIC ACIDURIA" -"DOID:10443","hypopyon" -"DOID:4781","diffuse glomerulonephritis" -"OMIM:220150","HYPOURICEMIA, RENAL, 1; RHUC1" -"OMIM:220200","DANDY-WALKER SYNDROME; DWS" -"OMIM:110500","BLOOD GROUP--DIEGO SYSTEM; DI" -"OMIM:220210","RITSCHER-SCHINZEL SYNDROME 1; RTSC1" -"DOID:12510","retinal ischemia" -"DOID:10772","thrombotic thrombocytopenic purpura" -"DOID:1432","blindness" -"OMIM:220219","DANDY-WALKER MALFORMATION WITH MENTAL RETARDATION, MACROCEPHALY, MYOPIA, AND BRACHYTELEPHALANGY" -"DOID:14000","rubeosis iridis" -"DOID:8515","Cor pulmonale" -"OMIM:220220","DANDY-WALKER MALFORMATION WITH POSTAXIAL POLYDACTYLY" -"DOID:0110009","achromatopsia 7" -"DOID:7088","columnar cell variant papillary carcinoma" -"OMIM:220290","DEAFNESS, AUTOSOMAL RECESSIVE 1A; DFNB1A" -"OMIM:220300","DEAFNESS, CONGENITAL, AND FAMILIAL MYOCLONIC EPILEPSY" -"DOID:4777","exudative glomerulonephritis" -"DOID:4776","rapidly progressive glomerulonephritis" -"OMIM:220400","JERVELL AND LANGE-NIELSEN SYNDROME 1; JLNS1" -"DOID:0090059","enhanced S-cone syndrome" -"OMIM:220500","DEAFNESS, ONYCHODYSTROPHY, OSTEODYSTROPHY, MENTAL RETARDATION, AND SEIZURES SYNDROME; DOORS" -"OMIM:220600","SPLIT-HAND/FOOT MALFORMATION 1 WITH SENSORINEURAL HEARING LOSS, AUTOSOMAL RECESSIVE; SHFM1D" -"DOID:13138","acute proliferative glomerulonephritis" -"OMIM:220900","DEAFNESS, CONGENITAL, WITH TOTAL ALBINISM" -"OMIM:221200","DEAFNESS AND MYOPIA; DFNMYP" -"DOID:0050278","basidiobolomycosis" -"OMIM:221300","DEAFNESS, CONDUCTIVE, WITH MALFORMED EXTERNAL EAR" -"DOID:3767","vaginal discharge" -"DOID:13401","angioid streaks" -"OMIM:221320","DEAFNESS, CONDUCTIVE, WITH PTOSIS AND SKELETAL ANOMALIES" -"OMIM:182940","NEURAL TUBE DEFECTS, SUSCEPTIBILITY TO; NTD" -"DOID:2772","irritant dermatitis" -"DOID:7633","macular holes" -"OMIM:221350","DEAFNESS, CONGENITAL, WITH VITILIGO AND ACHALASIA" -"DOID:0050743","mature T-cell and NK-cell lymphoma" -"OMIM:221400","DEAFNESS, NERVE TYPE, WITH MESENTERIC DIVERTICULA OF SMALL BOWEL AND PROGRESSIVE SENSORY NEUROPATHY" -"DOID:4783","mesangial proliferative glomerulonephritis" -"OMIM:182920","MYOPATHY, SPHEROID BODY" -"OMIM:182950","SPINAL ARACHNOIDITIS" -"OMIM:221500","DEAFNESS, NEURAL, CONGENITAL MODERATE" -"DOID:2920","membranoproliferative glomerulonephritis" -"OMIM:221700","DEAFNESS, NEURAL, WITH ATYPICAL ATOPIC DERMATITIS" -"DOID:0060017","CD3epsilon deficiency" -"DOID:5660","lymphoepithelioma-like carcinoma" -"DOID:1339","Diamond-Blackfan anemia" -"OMIM:175850","POROKERATOSIS 2, PALMAR, PLANTAR, AND DISSEMINATED TYPE; POROK2" -"DOID:0050335","bradyopsia" -"DOID:9384","gonococcal iridocyclitis" -"OMIM:221740","DEAFNESS-OLIGODONTIA SYNDROME" -"OMIM:221745","DEAFNESS, SENSORINEURAL, AUTOSOMAL-MITOCHONDRIAL TYPE" -"DOID:9389","infectious anterior uveitis" -"DOID:8504","impetigo" -"OMIM:221750","PITUITARY HORMONE DEFICIENCY, COMBINED, 3; CPHD3" -"DOID:4779","focal embolic glomerulonephritis" -"OMIM:176410","PRECOCIOUS PUBERTY, MALE-LIMITED" -"OMIM:610419","DEAFNESS, AUTOSOMAL RECESSIVE 68; DFNB68" -"OMIM:615419","HYPOTONIA, INFANTILE, WITH PSYCHOMOTOR RETARDATION AND CHARACTERISTIC FACIES 1; IHPRF1" -"OMIM:615420","MYOPIA 22, AUTOSOMAL DOMINANT; MYP22" -"DOID:0060439","lysinuric protein intolerance" -"OMIM:610420","PREAURICULAR TAG, ISOLATED, AUTOSOMAL DOMINANT, 1" -"OMIM:176430","PREMATURE CHROMATID SEPARATION TRAIT; PCS" -"OMIM:615422","INCLUSION BODY MYOPATHY WITH EARLY-ONSET PAGET DISEASE WITH OR WITHOUT FRONTOTEMPORAL DEMENTIA 2; IBMPFD2" -"OMIM:610422","ALOPECIA-MENTAL RETARDATION SYNDROME 2; APMR2" -"OMIM:610424","HEPATITIS B VIRUS, SUSCEPTIBILITY TO" -"OMIM:615424","INCLUSION BODY MYOPATHY WITH EARLY-ONSET PAGET DISEASE WITH OR WITHOUT FRONTOTEMPORAL DEMENTIA 3; IBMPFD3" -"DOID:9263","homocystinuria" -"OMIM:615425","EPIDERMOLYSIS BULLOSA SIMPLEX, AUTOSOMAL RECESSIVE 2; EBSB2" -"OMIM:610425","CATARACT 23, MULTIPLE TYPES; CTRCT23" -"OMIM:615426","AMYOTROPHIC LATERAL SCLEROSIS 20; ALS20" -"OMIM:610427","CONE-ROD SYNAPTIC DISORDER, CONGENITAL NONPROGRESSIVE; CRSD" -"OMIM:610430","MACROGLOBULINEMIA, WALDENSTROM, SUSCEPTIBILITY TO, 2; WM2" -"OMIM:120330","PAPILLORENAL SYNDROME; PAPRS" -"OMIM:615429","DEAFNESS, AUTOSOMAL RECESSIVE 88; DFNB88" -"DOID:12581","olecranon bursitis" -"DOID:7356","rectum sarcomatoid carcinoma" -"OMIM:610438","RESTLESS LEGS SYNDROME, SUSCEPTIBILITY TO, 3; RLS3" -"OMIM:615431","MYOPIA 23, AUTOSOMAL RECESSIVE; MYP23" -"OMIM:126180","DISCRIMINATION, TWO-POINT, REDUCTION IN" -"OMIM:615432","SPECIFIC LANGUAGE IMPAIRMENT 5; SLI5" -"OMIM:610439","RESTLESS LEGS SYNDROME, SUSCEPTIBILITY TO, 4; RLS4" -"OMIM:615433","CHROMOSOME 3q13.31 DELETION SYNDROME" -"OMIM:610441","TESTICULAR MICROLITHIASIS" -"OMIM:610442","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, GENEVIEVE TYPE; SEMDG" -"OMIM:615434","RETINITIS PIGMENTOSA WITH OR WITHOUT SITUS INVERSUS" -"DOID:11729","Lyme disease" -"DOID:0060693","Brunner Syndrome" -"OMIM:615436","AORTIC ANEURYSM, FAMILIAL THORACIC 8; AAT8" -"OMIM:610443","KOOLEN-DE VRIES SYNDROME; KDVS" -"DOID:1995","rectum sarcoma" -"OMIM:615438","INFANTILE LIVER FAILURE SYNDROME 1; ILFS1" -"OMIM:610444","NIGHT BLINDNESS, CONGENITAL STATIONARY, AUTOSOMAL DOMINANT 3; CSNBAD3" -"OMIM:120080","COLCHICINE RESISTANCE" -"OMIM:126190","DISPROPORTIONATE SHORT STATURE WITH PTOSIS AND VALVULAR HEART LESIONS" -"OMIM:610445","NIGHT BLINDNESS, CONGENITAL STATIONARY, AUTOSOMAL DOMINANT 1; CSNBAD1" -"OMIM:176400","PRECOCIOUS PUBERTY, CENTRAL, 1; CPPB1" -"OMIM:615439","MACULAR DEGENERATION, AGE-RELATED, 13; ARMD13" -"DOID:0090106","Bh4-deficient hyperphenylalaninemia A" -"OMIM:615440","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 17; COXPD17" -"OMIM:610446","BURULI ULCER, SUSCEPTIBILITY TO" -"OMIM:610448","CHILBLAIN LUPUS 1; CHBL1" -"OMIM:615441","VENTRICULAR TACHYCARDIA, CATECHOLAMINERGIC POLYMORPHIC, 5, WITH OR WITHOUT MUSCLE WEAKNESS; CPVT5" -"OMIM:615444","CILIARY DYSKINESIA, PRIMARY, 22; CILD22" -"OMIM:610452","MUTAGEN SENSITIVITY" -"OMIM:126300","DISTICHIASIS" -"DOID:9275","tyrosinemia" -"DOID:0050144","Kartagener syndrome" -"OMIM:610455","TUMORAL CALCINOSIS, NORMOPHOSPHATEMIC, FAMILIAL; NFTC" -"DOID:9274","hyperlysinemia" -"OMIM:615451","CILIARY DYSKINESIA, PRIMARY, 23; CILD23" -"OMIM:615453","MITOCHONDRIAL COMPLEX III DEFICIENCY, NUCLEAR TYPE 6; MC3DN6" -"OMIM:610460","THIOPURINES, POOR METABOLISM OF, 1; THPM1" -"OMIM:120200","COLOBOMA, OCULAR, AUTOSOMAL DOMINANT" -"OMIM:615457","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 18; BMIQ18" -"OMIM:610474","CAMPTODACTYLY, TALL STATURE, AND HEARING LOSS SYNDROME; CATSHLS" -"OMIM:615458","MICROCORNEA, MYOPIC CHORIORETINAL ATROPHY, AND TELECANTHUS; MMCAT" -"OMIM:610475","PIGMENTED NODULAR ADRENOCORTICAL DISEASE, PRIMARY, 2; PPNAD2" -"DOID:0050710","3-Methylcrotonyl-CoA carboxylase deficiency" -"OMIM:120300","COLOBOMA OF MACULA" -"OMIM:615465","HARTSFIELD SYNDROME; HRTFDS" -"OMIM:610476","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 11; ARVD11" -"OMIM:615468","IMMUNODEFICIENCY 12; IMD12" -"OMIM:610478","RETINAL CONE DYSTROPHY 4; RCD4" -"DOID:345","uterine disease" -"OMIM:610483","AGAMMAGLOBULINEMIA, MICROCEPHALY, AND SEVERE DERMATITIS" -"OMIM:615471","MITOCHONDRIAL DNA DEPLETION SYNDROME 13 (ENCEPHALOMYOPATHIC TYPE); MTDPS13" -"OMIM:610489","PIGMENTED NODULAR ADRENOCORTICAL DISEASE, PRIMARY, 1; PPNAD1" -"DOID:14067","Plasmodium falciparum malaria" -"OMIM:615473","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 17; EIEE17" -"DOID:0050762","adenylosuccinase lyase deficiency" -"DOID:5199","ureteral obstruction" -"OMIM:610498","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 2; COXPD2" -"OMIM:120400","COLOBOMA OF MACULA WITH TYPE B BRACHYDACTYLY" -"OMIM:615474","PRIMARY ALDOSTERONISM, SEIZURES, AND NEUROLOGIC ABNORMALITIES; PASNA" -"OMIM:126050","DIGITOTALAR DYSMORPHISM" -"OMIM:610504","PRETERM PREMATURE RUPTURE OF THE MEMBRANES; PPROM" -"OMIM:615476","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 18; EIEE18" -"DOID:0050643","anonychia congenita" -"DOID:3454","brain infarction" -"OMIM:120100","FAMILIAL COLD AUTOINFLAMMATORY SYNDROME 1; FCAS1" -"OMIM:615481","CILIARY DYSKINESIA, PRIMARY, 24; CILD24" -"DOID:9268","glycine encephalopathy" -"OMIM:610505","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 3; COXPD3" -"OMIM:120430","COLOBOMA OF OPTIC NERVE" -"OMIM:610508","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 7; MODY7" -"OMIM:615482","CILIARY DYSKINESIA, PRIMARY, 25; CILD25" -"OMIM:126100","DIMPLES, FACIAL" -"DOID:9266","cystinuria" -"OMIM:610532","LEUKODYSTROPHY, HYPOMYELINATING, 5; HLD5" -"OMIM:615483","BASAL GANGLIA CALCIFICATION, IDIOPATHIC, 5; IBGC5" -"OMIM:126250","DISTAL OSTEOSCLEROSIS" -"OMIM:615485","BAINBRIDGE-ROPERS SYNDROME; BRPS" -"OMIM:610535","GLAUCOMA 1, OPEN ANGLE, M; GLC1M" -"DOID:0050659","biotin-responsive basal ganglia disease" -"OMIM:615486","INTERSTITIAL LUNG AND LIVER DISEASE; ILLD" -"OMIM:610536","MANDIBULOFACIAL DYSOSTOSIS, GUION-ALMEIDA TYPE; MFDGA" -"OMIM:610539","GAUCHER DISEASE, ATYPICAL, DUE TO SAPOSIN C DEFICIENCY" -"OMIM:126200","MULTIPLE SCLEROSIS, SUSCEPTIBILITY TO; MS" -"DOID:14365","systemic primary carnitine deficiency disease" -"OMIM:126070","DILUTION, PIGMENTARY" -"OMIM:120050","COXSACKIEVIRUS B3 SUSCEPTIBILITY; CXB3S" -"OMIM:615489","MACULAR DEGENERATION, AGE-RELATED, 14; ARMD14" -"OMIM:610542","MYASTHENIC SYNDROME, CONGENITAL, 12; CMS12" -"OMIM:615490","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2R; CMT2R" -"OMIM:120433","COLOBOMA, OCULAR, WITH OR WITHOUT HEARING IMPAIRMENT, CLEFT LIP/PALATE, AND/OR MENTAL RETARDATION; COB1" -"OMIM:615491","SPASTIC PARAPLEGIA 79, AUTOSOMAL RECESSIVE; SPG79" -"OMIM:610543","CHROMOSOME 16p13.3 DELETION SYNDROME, PROXIMAL" -"DOID:13368","tinea profunda" -"OMIM:615493","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 37; MRT37" -"OMIM:610549","DIABETES MELLITUS, INSULIN-RESISTANT, WITH ACANTHOSIS NIGRICANS" -"OMIM:300914","DEAFNESS, X-LINKED 6; DFNX6" -"OMIM:146600","ICHTHYOSIS HYSTRIX GRAVIOR" -"OMIM:300915","MICROPHTHALMIA, SYNDROMIC 13; MCOPS13" -"DOID:11242","plethora of newborn" -"OMIM:300918","PALMOPLANTAR KERATODERMA, MUTILATING, WITH PERIORIFICIAL KERATOTIC PLAQUES, X-LINKED" -"OMIM:146520","HYPOTRICHOSIS 2; HYPT2" -"DOID:5090","sternum cancer" -"OMIM:300919","MENTAL RETARDATION, X-LINKED 99; MRX99" -"OMIM:146580","HYPOXANTHINE GUANINE PHOSPHORIBOSYLTRANSFERASE SUPPRESSOR" -"OMIM:300923","MENTAL RETARDATION, X-LINKED 100; MRX100" -"DOID:5812","MHC class II deficiency" -"DOID:13731","malignant secondary hypertension" -"DOID:3369","Ewing sarcoma" -"OMIM:300928","MENTAL RETARDATION, X-LINKED 101; MRX101" -"OMIM:146550","HYPOTRICHOSIS 4; HYPT4" -"OMIM:146500","MULTIPLE SYSTEM ATROPHY 1, SUSCEPTIBILITY TO; MSA1" -"OMIM:300932","THYROXINE-BINDING GLOBULIN QUANTITATIVE TRAIT LOCUS; TBGQTL" -"OMIM:300934","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Iy; CDG1Y" -"OMIM:300942","CHROMOSOME Xq26.3 DUPLICATION SYNDROME" -"OMIM:300943","PITUITARY ADENOMA 2, GROWTH HORMONE-SECRETING; PITA2" -"DOID:12270","coloboma" -"OMIM:146750","ICHTHYOSIS, LAMELLAR, AUTOSOMAL DOMINANT" -"OMIM:300946","DIAMOND-BLACKFAN ANEMIA 14 WITH MANDIBULOFACIAL DYSOSTOSIS; DBA14" -"OMIM:300952","LINEAR SKIN DEFECTS WITH MULTIPLE CONGENITAL ANOMALIES 3; LSDMCA3" -"DOID:5810","adenosine deaminase deficiency" -"OMIM:300953","TRICHOTHIODYSTROPHY 5, NONPHOTOSENSITIVE; TTD5" -"OMIM:146590","ICHTHYOSIS HYSTRIX, CURTH-MACKLIN TYPE; IHCM" -"OMIM:300957","MENTAL RETARDATION, X-LINKED 12; MRX12" -"OMIM:300958","MENTAL RETARDATION, X-LINKED 102; MRX102" -"OMIM:300960","MEND SYNDROME; MEND" -"DOID:3347","osteosarcoma" -"OMIM:300963","RITSCHER-SCHINZEL SYNDROME 2; RTSC2" -"OMIM:300966","MENTAL RETARDATION, X-LINKED, SYNDROMIC 33; MRXS33" -"DOID:3919","pancreatic serous cystic neoplasm" -"DOID:4143","orbital cancer" -"OMIM:146390","CHROMOSOME 18p DELETION SYNDROME" -"OMIM:300967","MENTAL RETARDATION, X-LINKED, SYNDROMIC 34; MRXS34" -"OMIM:103230","ADRENOCORTICAL HYPOFUNCTION, CHRONIC PRIMARY CONGENITAL" -"DOID:2762","bone carcinoma" -"OMIM:300968","MENTAL RETARDATION, X-LINKED 99, SYNDROMIC, FEMALE-RESTRICTED; MRXS99F" -"DOID:1934","dysostosis" -"OMIM:300971","BARTTER SYNDROME, TYPE 5, ANTENATAL, TRANSIENT; BARTS5" -"DOID:8680","alcoholic gastritis" -"DOID:3303","notochordal cancer" -"OMIM:300972","IMMUNODEFICIENCY 47; IMD47" -"OMIM:300977","SCHOLTE SYNDROME; SHLTS" -"OMIM:300978","MENTAL RETARDATION, X-LINKED 61; MRX61" -"DOID:0060010","Omenn syndrome" -"OMIM:300979","Xq25 DUPLICATION SYNDROME" -"DOID:0090090","hypogonadotropic hypogonadism 19 with or without anosmia" -"DOID:4034","fungal gastritis" -"OMIM:300982","MENTAL RETARDATION, X-LINKED 103; MRX103" -"DOID:2327","viral gastritis" -"OMIM:300983","MENTAL RETARDATION, X-LINKED 104; MRX104" -"OMIM:300984","MENTAL RETARDATION, X-LINKED 105; MRX105" -"OMIM:300985","VAS DEFERENS, CONGENITAL BILATERAL APLASIA OF, X-LINKED; CBAVDX" -"DOID:0090089","hypogonadotropic hypogonadism 10 with or without anosmia" -"DOID:4030","eosinophilic gastritis" -"OMIM:300986","MENTAL RETARDATION, X-LINKED, SYNDROMIC, BAIN TYPE; MRXSB" -"DOID:0060584","Noonan syndrome 6" -"OMIM:146700","ICHTHYOSIS VULGARIS" -"OMIM:300987","MENTAL RETARDATION, X-LINKED, SYNDROMIC, BORCK TYPE; MRXSBRK" -"DOID:0060013","gamma chain deficiency" -"OMIM:146720","ICHTHYOSIS--CHEEK--EYEBROW SYNDROME" -"OMIM:146510","PALLISTER-HALL SYNDROME; PHS" -"DOID:0090074","hypogonadotropic hypogonadism 8 with or without anosmia" -"OMIM:300988","IMMUNODEFICIENCY 50; IMD50" -"DOID:10149","long bones of lower limb cancer" -"DOID:4038","granulomatous gastritis" -"OMIM:300989","MEESTER-LOEYS SYNDROME; MRLS" -"OMIM:300990","MIDFACE HYPOPLASIA, HEARING IMPAIRMENT, ELLIPTOCYTOSIS, AND NEPHROCALCINOSIS; MFHIEN" -"OMIM:146450","HYPOSPADIAS 3, AUTOSOMAL; HYSP3" -"OMIM:300991","CILIARY DYSKINESIA, PRIMARY, 36, X-LINKED; CILD36" -"OMIM:300997","MENTAL RETARDATION, X-LINKED 106; MRX106" -"OMIM:181800","SCOLIOSIS, ISOLATED, SUSCEPTIBILITY TO, 1; IS1" -"DOID:3225","tracheal disease" -"OMIM:181750","SCLERODERMA, FAMILIAL PROGRESSIVE" -"DOID:0090064","familial cold autoinflammatory syndrome 3" -"DOID:1586","rheumatic fever" -"DOID:0050576","Senior-Loken syndrome" -"DOID:0090063","familial cold autoinflammatory syndrome 2" -"DOID:0110008","achromatopsia 3" -"OMIM:182170","ANEMIA, SIDEROBLASTIC, 4; SIDBA4" -"DOID:4207","childhood infratentorial neoplasm" -"OMIM:182190","SINUS NODE DISEASE AND MYOPIA" -"DOID:10459","common cold" -"DOID:786","laryngeal disease" -"DOID:0050148","laryngotracheitis" -"DOID:0110102","atopic dermatitis 6" -"DOID:9398","epiglottitis" -"DOID:9561","nasopharyngeal disease" -"DOID:4752","multiple system atrophy" -"DOID:4535","hypotrichosis" -"DOID:8826","colon carcinoma in situ" -"OMIM:182000","KERATOSIS, SEBORRHEIC" -"DOID:0110959","Gaucher's disease type III" -"OMIM:182150","SIMOSA CRANIOFACIAL SYNDROME" -"DOID:0060310","uvulitis" -"DOID:0060311","adenoid hypertrophy" -"DOID:8252","chronic rhinitis" -"DOID:8596","scarlet fever" -"DOID:9138","stomach carcinoma in situ" -"OMIM:610551","HERPES SIMPLEX ENCEPHALITIS, SUSCEPTIBILITY TO, 1" -"DOID:2825","nose disease" -"DOID:9478","postpartum depression" -"DOID:0110398","retinitis pigmentosa 51" -"OMIM:615500","CILIARY DYSKINESIA, PRIMARY, 26; CILD26" -"DOID:10044","balloon cell malignant melanoma" -"DOID:9053","bladder carcinoma in situ" -"OMIM:615501","MOLYBDENUM COFACTOR DEFICIENCY, COMPLEMENTATION GROUP C; MOCODC" -"OMIM:610582","DIABETES MELLITUS, TRANSIENT NEONATAL, 3" -"DOID:0110391","retinitis pigmentosa 31" -"DOID:713","HCL-V" -"OMIM:610599","RETINITIS PIGMENTOSA 36; RP36" -"OMIM:175800","POROKERATOSIS 1, MULTIPLE TYPES; POROK1" -"OMIM:615502","MENTAL RETARDATION, AUTOSOMAL DOMINANT 21; MRD21" -"DOID:404","gastrointestinal tuberculosis" -"OMIM:610600","CORTICOSTERONE METHYLOXIDASE TYPE II DEFICIENCY" -"OMIM:615503","SHORT-RIB THORACIC DYSPLASIA 8 WITH OR WITHOUT POLYDACTYLY; SRTD8" -"DOID:6812","childhood pilocytic astrocytoma" -"DOID:3055","paratyphoid fever" -"OMIM:610612","LEBER CONGENITAL AMAUROSIS 12; LCA12" -"DOID:10457","Legionnaires' disease" -"OMIM:615504","CILIARY DYSKINESIA, PRIMARY, 27; CILD27" -"DOID:0110413","retinitis pigmentosa 6" -"OMIM:610618","ANGIOEDEMA, HEREDITARY, TYPE III; HAE3" -"DOID:3103","thoracic outlet syndrome" -"DOID:0111109","maturity-onset diabetes of the young type 11" -"OMIM:615505","CILIARY DYSKINESIA, PRIMARY, 28; CILD28" -"OMIM:610623","CATARACT 11, MULTIPLE TYPES; CTRCT11" -"OMIM:615506","TELANGIECTASIA, HEREDITARY HEMORRHAGIC, TYPE 5; HHT5" -"DOID:0110370","retinitis pigmentosa 55" -"DOID:12096","sodoku disease" -"DOID:11265","trachoma" -"OMIM:615508","ERYTHRODERMA, CONGENITAL, WITH PALMOPLANTAR KERATODERMA, HYPOTRICHOSIS, AND HYPER-IgE; EPKHE" -"OMIM:610628","HYPOGONADOTROPIC HYPOGONADISM 4 WITH OR WITHOUT ANOSMIA; HH4" -"OMIM:610629","DIAMOND-BLACKFAN ANEMIA 3; DBA3" -"OMIM:615510","ALACRIMA, ACHALASIA, AND MENTAL RETARDATION SYNDROME; AAMR" -"OMIM:615511","MYOPATHY DUE TO MYOADENYLATE DEAMINASE DEFICIENCY; MMDD" -"DOID:0090016","chromosome 5q deletion syndrome" -"OMIM:610644","PALMOPLANTAR HYPERKERATOSIS WITH SQUAMOUS CELL CARCINOMA OF SKIN AND 46,XX SEX REVERSAL" -"DOID:0110103","atopic dermatitis 7" -"DOID:371","extracranial neuroblastoma" -"DOID:1024","leprosy" -"OMIM:227260","FOCAL FACIAL DERMAL DYSPLASIA 3, SETLEIS TYPE; FFDD3" -"OMIM:615512","TRIOSEPHOSPHATE ISOMERASE DEFICIENCY; TPID" -"OMIM:610649","BONE SIZE QUANTITATIVE TRAIT LOCUS 3" -"DOID:13371","scrub typhus" -"DOID:0050614","bronchus carcinoma in situ" -"DOID:0050456","Buruli ulcer disease" -"DOID:0050794","multiple synostoses syndrome" -"DOID:0110356","retinitis pigmentosa 18" -"OMIM:610651","XERODERMA PIGMENTOSUM, COMPLEMENTATION GROUP B; XPB" -"DOID:9261","nasopharynx carcinoma" -"DOID:8800","lung carcinoma in situ" -"OMIM:615513","IMMUNODEFICIENCY 14; IMD14" -"DOID:0060643","primary sclerosing cholangitis" -"DOID:13444","glanders" -"OMIM:615515","AMYOTROPHIC LATERAL SCLEROSIS 19; ALS19" -"OMIM:610655","TELANGIECTASIA, HEREDITARY HEMORRHAGIC, TYPE 4; HHT4" -"DOID:4166","syphilis" -"OMIM:610676","AUTISM, SUSCEPTIBILITY TO, 7; AUTS7" -"DOID:5172","endometrium carcinoma in situ" -"OMIM:615516","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 38; MRT38" -"DOID:0110394","retinitis pigmentosa 44" -"OMIM:610678","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 4; COXPD4" -"OMIM:615517","HEMOCHROMATOSIS, TYPE 5; HFE5" -"DOID:0050611","pharynx carcinoma in situ" -"OMIM:615518","IMMUNODEFICIENCY 13; IMD13" -"OMIM:610680","HOLOPROSENCEPHALY, RECURRENT INFECTIONS, AND MONOCYTOSIS" -"DOID:13238","Haverhill fever" -"OMIM:615522","COLE DISEASE; COLED" -"OMIM:610682","OSTEOGENESIS IMPERFECTA, TYPE VII; OI7" -"OMIM:615523","CORNEAL DYSTROPHY, FUCHS ENDOTHELIAL, 8; FECD8" -"OMIM:610685","SPLIT-HAND/FOOT MALFORMATION WITH LONG BONE DEFICIENCY 2; SHFLD2" -"DOID:0060071","pre-malignant neoplasm" -"OMIM:610687","NEMALINE MYOPATHY 7; NEM7" -"OMIM:615524","MICROPHTHALMIA, SYNDROMIC 12; MCOPS12" -"DOID:11104","spotted fever" -"DOID:679","basal ganglia disease" -"OMIM:615527","CANDIDIASIS, FAMILIAL, 8; CANDF8" -"DOID:11976","botulism" -"OMIM:610688","JOUBERT SYNDROME 6; JBTS6" -"OMIM:610698","MACULAR DEGENERATION, AGE-RELATED, 4; ARMD4" -"OMIM:615528","PARKINSON DISEASE 19A, JUVENILE-ONSET; PARK19A" -"DOID:9835","refractive error" -"DOID:0050061","erysipeloid" -"OMIM:615529","CRANIOSYNOSTOSIS 5, SUSCEPTIBILITY TO; CRS5" -"OMIM:610706","DEAFNESS, CONGENITAL, WITH INNER EAR AGENESIS, MICROTIA, AND MICRODONTIA" -"OMIM:610707","PSORIASIS 8, SUSCEPTIBILITY TO; PSORS8" -"DOID:0050612","gall bladder carcinoma in situ" -"OMIM:615530","PARKINSON DISEASE 20, EARLY-ONSET; PARK20" -"DOID:11405","diphtheria" -"DOID:0110418","retinitis pigmentosa Y-linked" -"OMIM:610708","OPTIC ATROPHY 5; OPA5" -"OMIM:615537","RETICULATE ACROPIGMENTATION OF KITAMURA; RAK" -"DOID:1525","nodular nonsuppurative panniculitis" -"DOID:0110395","retinitis pigmentosa 72" -"OMIM:610713","BRACHYDACTYLY-SYNDACTYLY SYNDROME; BDSD" -"DOID:0050481","endemic typhus" -"OMIM:615538","CHROMOSOME 22q13 DUPLICATION SYNDROME" -"DOID:0110386","retinitis pigmentosa 42" -"OMIM:610717","NEUTRAL LIPID STORAGE DISEASE WITH MYOPATHY; NLSDM" -"DOID:7840","pancreatic non-functioning delta cell tumor" -"OMIM:615539","EHLERS-DANLOS SYNDROME, MUSCULOCONTRACTURAL TYPE, 2; EDSMC2" -"DOID:3978","extrinsic cardiomyopathy" -"DOID:10937","impulse control disorder" -"DOID:8802","trachea carcinoma in situ" -"OMIM:610725","NEPHROTIC SYNDROME, TYPE 3; NPHS3" -"OMIM:615540","DEAFNESS, AUTOSOMAL RECESSIVE 76; DFNB76" -"DOID:9234","kidney carcinoma in situ" -"OMIM:610733","NOONAN SYNDROME 4; NS4" -"OMIM:615541","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 39; MRT39" -"OMIM:615542","TESTICULAR ANOMALIES WITH OR WITHOUT CONGENITAL HEART DISEASE; TACHD" -"OMIM:610738","NEUTROPENIA, SEVERE CONGENITAL, 3, AUTOSOMAL RECESSIVE; SCN3" -"DOID:0110104","atopic dermatitis 8" -"OMIM:610743","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 8; SCAR8" -"OMIM:615544","PERIVENTRICULAR NODULAR HETEROTOPIA 6; PVNH6" -"OMIM:610744","IRIS PATTERN" -"DOID:0050803","glioblastoma classical subtype" -"DOID:0060911","karyomegalic interstitial nephritis" -"DOID:2088","outlet dysfunction constipation" -"OMIM:615545","LEUKEMIA, ACUTE LYMPHOBLASTIC, SUSCEPTIBILITY TO, 3; ALL3" -"DOID:0110101","atopic dermatitis 5" -"OMIM:615546","VAN MALDERGEM SYNDROME 2; VMLDS2" -"OMIM:610753","ALOPECIA AREATA 2; AA2" -"OMIM:615547","SCHAAF-YANG SYNDROME; SHFYNG" -"DOID:8687","skin carcinoma in situ" -"OMIM:610755","MULTIPLE ENDOCRINE NEOPLASIA, TYPE IV; MEN4" -"DOID:0110354","retinitis pigmentosa 19" -"OMIM:610756","CEREBROOCULOFACIOSKELETAL SYNDROME 2; COFS2" -"OMIM:615548","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, TYPE VII; HSAN7" -"DOID:5505","papillary ependymoma" -"DOID:0060041","autism spectrum disorder" -"OMIM:615550","DIAMOND-BLACKFAN ANEMIA 12; DBA12" -"OMIM:610758","CEREBROOCULOFACIOSKELETAL SYNDROME 4; COFS4" -"DOID:10908","hydrocephalus" -"DOID:11336","rhinoscleroma" -"OMIM:610759","CORNELIA DE LANGE SYNDROME 3; CDLS3" -"DOID:4012","papillary transitional carcinoma" -"OMIM:615551","EPISODIC PAIN SYNDROME, FAMILIAL, 2; FEPS2" -"DOID:0110602","primary ciliary dyskinesia 11" -"DOID:4211","posterior cranial fossa meningioma" -"DOID:4749","middle cranial fossa meningioma" -"OMIM:309545","MENTAL RETARDATION, X-LINKED, SYNDROMIC 12; MRXS12" -"OMIM:250100","METACHROMATIC LEUKODYSTROPHY; MLD" -"DOID:53","pituitary gland disease" -"DOID:8216","parapharyngeal meningioma" -"OMIM:250215","METAPHYSEAL ACROSCYPHODYSPLASIA" -"OMIM:309548","MENTAL RETARDATION, X-LINKED, ASSOCIATED WITH FRAGILE SITE FRAXE" -"DOID:0110622","primary ciliary dyskinesia 9" -"OMIM:309549","MENTAL RETARDATION, X-LINKED 9; MRX9" -"DOID:5749","pulmonary valve disease" -"OMIM:250220","SPONDYLOMETAPHYSEAL DYSPLASIA, SEDAGHATIAN TYPE; SMDS" -"OMIM:309555","MENTAL RETARDATION WITH OPTIC ATROPHY, DEAFNESS, AND SEIZURES" -"DOID:4591","lymphoplasmacyte-rich meningioma" -"OMIM:250230","METAPHYSEAL CHONDRODYSPLASIA, KAITILA TYPE" -"DOID:7614","meninges sarcoma" -"OMIM:250250","CARTILAGE-HAIR HYPOPLASIA; CHH" -"OMIM:309560","MENTAL RETARDATION WITH SPASTIC PARAPLEGIA AND PALMOPLANTAR HYPERKERATOSIS" -"OMIM:309580","MENTAL RETARDATION-HYPOTONIC FACIES SYNDROME, X-LINKED, 1; MRXHF1" -"OMIM:250300","METAPHYSEAL CHONDRODYSPLASIA, PENA TYPE" -"DOID:7482","petrous apex meningioma" -"OMIM:309583","MENTAL RETARDATION, X-LINKED, SYNDROMIC, SNYDER-ROBINSON TYPE; MRXSSR" -"OMIM:250400","METAPHYSEAL DYSPLASIA, SPAHR TYPE; MDST" -"DOID:2021","placenta cancer" -"OMIM:250410","RETINITIS PIGMENTOSA WITH OR WITHOUT SKELETAL ANOMALIES; RPSKA" -"OMIM:309585","WILSON-TURNER X-LINKED MENTAL RETARDATION SYNDROME; WTS" -"OMIM:147251","INCISORS, FUSED MANDIBULAR" -"DOID:1791","peritoneal carcinoma" -"DOID:4593","pediatric meningioma" -"OMIM:147250","SOLITARY MEDIAN MAXILLARY CENTRAL INCISOR; SMMCI" -"DOID:0060683","autosomal dominant nocturnal frontal lobe epilepsy 2" -"DOID:7211","fibrous meningioma" -"OMIM:250420","METAPHYSEAL DYSOSTOSIS, MENTAL RETARDATION, AND CONDUCTIVE DEAFNESS" -"DOID:0110621","primary ciliary dyskinesia 17" -"OMIM:113800","EPIDERMOLYTIC HYPERKERATOSIS; EHK" -"OMIM:309610","PRIETO X-LINKED MENTAL RETARDATION SYNDROME; PRS" -"OMIM:309620","MENTAL RETARDATION, SKELETAL DYSPLASIA, AND ABDUCENS PALSY; MRSD" -"OMIM:250450","METAPHYSEAL DYSPLASIA, ANETODERMA, AND OPTIC ATROPHY" -"DOID:5058","rhabdoid meningioma" -"OMIM:147421","INCLUSION BODY MYOSITIS" -"OMIM:182601","SPASTIC PARAPLEGIA 4, AUTOSOMAL DOMINANT; SPG4" -"OMIM:309630","METACARPAL 4-5 FUSION; MF4" -"OMIM:250460","METAPHYSEAL DYSPLASIA WITHOUT HYPOTRICHOSIS; MDWH" -"DOID:0110615","primary ciliary dyskinesia 25" -"OMIM:309640","MENTAL RETARDATION WITH SPASTIC PARAPLEGIA" -"OMIM:250500","METAPHYSEAL MODELING ABNORMALITY, SKIN LESIONS, AND SPASTIC PARAPLEGIA" -"DOID:4584","choroid plexus meningioma" -"DOID:8943","lattice corneal dystrophy" -"DOID:0110597","primary ciliary dyskinesia 22" -"OMIM:309800","MICROPHTHALMIA, SYNDROMIC 1; MCOPS1" -"OMIM:250620","3-HYDROXYISOBUTYRYL-CoA HYDROLASE DEFICIENCY; HIBCHD" -"OMIM:182610","SPASTIC PARAPLEGIA, EPILEPSY, AND MENTAL RETARDATION; SPEMR" -"OMIM:113750","ALBINISM, OCULOCUTANEOUS, TYPE VI; OCA6" -"OMIM:309801","LINEAR SKIN DEFECTS WITH MULTIPLE CONGENITAL ANOMALIES 1; LSDMCA1" -"DOID:6086","malignant leptomeningeal tumor" -"DOID:0110606","primary ciliary dyskinesia 6" -"OMIM:182690","SPASTIC PARAPLEGIA, SENSORINEURAL DEAFNESS, MENTAL RETARDATION, AND PROGRESSIVE NEPHROPATHY" -"DOID:0110601","primary ciliary dyskinesia 12" -"OMIM:250650","METHANE PRODUCTION" -"DOID:0090108","autosomal dominant hypocalcemia 2" -"OMIM:250700","METHEMOGLOBIN REDUCTASE DEFICIENCY" -"OMIM:309840","MODIFIER, X-LINKED, FOR NEUROFUNCTIONAL DEFECTS" -"DOID:8030","periocular meningioma" -"OMIM:309900","MUCOPOLYSACCHARIDOSIS, TYPE II; MPS2" -"OMIM:250790","METHEMOGLOBINEMIA TYPE IV" -"OMIM:147480","CHOLESTASIS, INTRAHEPATIC, OF PREGNANCY, 1; ICP1" -"DOID:0110612","primary ciliary dyskinesia 10" -"DOID:0060036","intrinsic cardiomyopathy" -"OMIM:250800","METHEMOGLOBINEMIA DUE TO DEFICIENCY OF METHEMOGLOBIN REDUCTASE" -"OMIM:309930","MUSCULAR DYSTROPHY, CARDIAC TYPE" -"OMIM:309950","MUSCULAR DYSTROPHY, HEMIZYGOUS LETHAL TYPE" -"OMIM:250850","METHIONINE ADENOSYLTRANSFERASE I/III DEFICIENCY" -"OMIM:147330","INCISORS, LOWER CENTRAL, ABSENCE OF" -"OMIM:310000","MUSCULAR DYSTROPHY, MABRY TYPE" -"OMIM:250900","METHIONINE MALABSORPTION SYNDROME" -"OMIM:179830","RENAL TUBULAR ACIDOSIS, PROXIMAL" -"OMIM:182800","SPASTIC PARAPLEGIA WITH ASSOCIATED EXTRAPYRAMIDAL SIGNS" -"DOID:4436","anterior cranial fossa meningioma" -"OMIM:310095","MUSCULAR DYSTROPHY, PROGRESSIVE PECTORODORSAL" -"OMIM:250940","HOMOCYSTINURIA-MEGALOBLASTIC ANEMIA, cblG COMPLEMENTATION TYPE; HMAG" -"DOID:6110","jugular foramen meningioma" -"DOID:10615","acute gonococcal cervicitis" -"OMIM:250950","3-METHYLGLUTACONIC ACIDURIA, TYPE I; MGCA1" -"OMIM:310200","MUSCULAR DYSTROPHY, DUCHENNE TYPE; DMD" -"DOID:4594","microcystic meningioma" -"OMIM:147350","INCISORS, ROTATION OF UPPER CENTRAL" -"OMIM:310300","EMERY-DREIFUSS MUSCULAR DYSTROPHY 1, X-LINKED; EDMD1" -"OMIM:250951","3-METHYLGLUTACONIC ACIDURIA, TYPE IV; MGCA4" -"DOID:0110614","primary ciliary dyskinesia 4" -"DOID:0110627","primary ciliary dyskinesia 26" -"OMIM:310350","MYELOLYMPHATIC INSUFFICIENCY" -"OMIM:251000","METHYLMALONIC ACIDURIA DUE TO METHYLMALONYL-CoA MUTASE DEFICIENCY" -"DOID:7210","psammomatous meningioma" -"OMIM:310370","MYOCLONIC EPILEPSY, PROGRESSIVE" -"OMIM:251100","METHYLMALONIC ACIDURIA, cblA TYPE" -"DOID:3001","female reproductive endometrioid cancer" -"OMIM:170990","PEROXIDASE, SALIVARY; SAPX" -"OMIM:310400","MYOPATHY, CENTRONUCLEAR, X-LINKED; CNMX" -"DOID:5823","pediatric lymphoma" -"OMIM:251110","METHYLMALONIC ACIDURIA, cblB TYPE" -"OMIM:310440","MYOPATHY, X-LINKED, WITH EXCESSIVE AUTOPHAGY; MEAX" -"OMIM:251120","METHYLMALONYL-CoA EPIMERASE DEFICIENCY" -"OMIM:113900","PROGRESSIVE FAMILIAL HEART BLOCK, TYPE IA; PFHB1A" -"DOID:0050765","neuroacanthocytosis" -"OMIM:147320","INSULIN RECEPTORS, FAMILIAL INCREASE IN" -"DOID:2975","cystic kidney disease" -"DOID:0110603","primary ciliary dyskinesia 32" -"OMIM:310460","MYOPIA 1, X-LINKED; MYP1" -"OMIM:251190","MICROCEPHALIC PRIMORDIAL DWARFISM, TORIELLO TYPE" -"DOID:12559","idiopathic juvenile osteoporosis" -"DOID:0110617","primary ciliary dyskinesia 5" -"OMIM:147400","INCISORS, SHOVEL-SHAPED" -"OMIM:182830","SPASTIC PARAPLEGIA, OPTIC ATROPHY, AND DEMENTIA" -"OMIM:310465","N SYNDROME; NSX" -"OMIM:251200","MICROCEPHALY 1, PRIMARY, AUTOSOMAL RECESSIVE; MCPH1" -"DOID:11870","Pick's disease" -"DOID:0090072","hypogonadotropic hypogonadism 12 with or without anosmia" -"DOID:0110600","primary ciliary dyskinesia 29" -"OMIM:182815","SPASTIC PARAPLEGIA WITH NEUROPATHY AND POIKILODERMA" -"OMIM:310468","NEPHROLITHIASIS, X-LINKED RECESSIVE, WITH RENAL FAILURE; XRN" -"OMIM:251220","MICROCEPHALY-CARDIOMYOPATHY" -"DOID:3772","intraventricular meningioma" -"DOID:0110626","primary ciliary dyskinesia 2" -"OMIM:147090","IMMUNE RESPONSE TO SYNTHETIC POLYPEPTIDE--IRGLPHE 2; IGLP2" -"OMIM:182875","SPEECH DEVELOPMENT, DELAYED, WITH FACIAL ASYMMETRY, STRABISMUS, AND TRANSVERSE EARLOBE CREASE" -"OMIM:310470","NEUROPATHY, HEREDITARY SENSORY, X-LINKED" -"OMIM:251230","MICROCEPHALY-MICROMELIA SYNDROME; MIMIS" -"OMIM:182820","SPASTIC PARAPLEGIA WITH PRECOCIOUS PUBERTY" -"OMIM:251240","MICROCEPHALY WITH CHEMOTACTIC DEFECT AND TRANSIENT HYPOGAMMAGLOBULINEMIA" -"DOID:0090104","Huntington disease-like 2" -"DOID:4588","secretory meningioma" -"OMIM:147260","IMMUNOGLOBULIN SWITCH SEQUENCES" -"OMIM:310490","COWCHOCK SYNDROME; COWCK" -"OMIM:310500","NIGHT BLINDNESS, CONGENITAL STATIONARY, TYPE 1A; CSNB1A" -"OMIM:251250","MICROCEPHALY WITH CERVICAL SPINE FUSION ANOMALIES" -"DOID:4586","familial meningioma" -"DOID:0110607","primary ciliary dyskinesia 28" -"OMIM:251255","JAWAD SYNDROME; JWDS" -"OMIM:310600","NORRIE DISEASE; ND" -"DOID:7213","transitional meningioma" -"OMIM:310650","NUCLEAR RIBONUCLEIC ACID; nRNA" -"DOID:4957","meninges hemangiopericytoma" -"OMIM:251260","NIJMEGEN BREAKAGE SYNDROME; NBS" -"DOID:0110625","primary ciliary dyskinesia 20" -"OMIM:147430","INDIFFERENCE TO PAIN, CONGENITAL, AUTOSOMAL DOMINANT" -"OMIM:147300","INCISORS, LONG UPPER CENTRAL" -"OMIM:310700","NYSTAGMUS 1, CONGENITAL, X-LINKED; NYS1" -"DOID:0050951","hereditary ataxia" -"OMIM:251270","MICROCEPHALY AND CHORIORETINOPATHY, AUTOSOMAL RECESSIVE, 1; MCCRP1" -"DOID:0110596","primary ciliary dyskinesia 21" -"DOID:0110598","primary ciliary dyskinesia 14" -"DOID:0110624","primary ciliary dyskinesia 30" -"OMIM:251280","MICROCEPHALY, SEIZURES, SPASTICITY, AND BRAIN CALCIFICATIONS; MISSBC" -"OMIM:310800","NYSTAGMUS, MYOCLONIC" -"OMIM:133900","HEMIFACIAL HYPERPLASIA" -"OMIM:615552","EPISODIC PAIN SYNDROME, FAMILIAL, 3; FEPS3" -"OMIM:269700","LIPODYSTROPHY, CONGENITAL GENERALIZED, TYPE 2; CGL2" -"DOID:13341","parasitic conjunctivitis" -"DOID:3193","peripheral nerve sheath neoplasm" -"DOID:1686","glaucoma" -"DOID:12971","hereditary spherocytosis" -"DOID:917","liver leiomyoma" -"DOID:769","neuroblastoma" -"DOID:11424","fallopian tube endometriosis" -"DOID:11126","acquired thrombocytopenia" -"DOID:0110997","Joubert syndrome 28" -"DOID:1319","brain cancer" -"DOID:3317","hepatic angiomyolipoma" -"DOID:83","cataract" -"OMIM:180210","RETINOPATHY, PERICENTRAL PIGMENTARY, DOMINANT" -"DOID:0110981","Joubert syndrome 10" -"DOID:890","mitochondrial encephalomyopathy" -"DOID:3950","adrenal carcinoma" -"DOID:5603","acute T cell leukemia" -"DOID:0050745","diffuse large B-cell lymphoma" -"DOID:14566","disease of cellular proliferation" -"DOID:4203","brain stem cancer" -"OMIM:180550","RING DERMOID OF CORNEA; RDC" -"DOID:4522","superior vena cava angiosarcoma" -"DOID:0111003","Joubert syndrome 8" -"DOID:10966","lipoid nephrosis" -"DOID:1066","residual stage of open angle glaucoma" -"OMIM:163100","NEVUS FLAMMEUS OF NAPE OF NECK" -"DOID:3875","thrombophlebitis" -"OMIM:164500","SPINOCEREBELLAR ATAXIA 7; SCA7" -"OMIM:164400","SPINOCEREBELLAR ATAXIA 1; SCA1" -"DOID:3116","kidney benign neoplasm" -"DOID:0050735","X-linked disease" -"DOID:11851","indeterminate leprosy" -"OMIM:164800","NAIL DISORDER, NONSYNDROMIC CONGENITAL, 5; NDNC5" -"DOID:0050623","bladder benign neoplasm" -"OMIM:163400","NIEVERGELT SYNDROME" -"DOID:2228","thrombocytosis" -"DOID:2697","renal adenoma" -"DOID:0090002","Tietz syndrome" -"DOID:0110099","atopic dermatitis 3" -"DOID:2280","hidradenitis suppurativa" -"DOID:4524","prostate angiosarcoma" -"DOID:2239","granulomatous hepatitis" -"DOID:0090124","neurogenic arthrogryposis multiplex congenita" -"OMIM:179700","RED CELL PHOSPHOLIPID DEFECT WITH HEMOLYSIS" -"OMIM:164700","OLIVOPONTOCEREBELLAR ATROPHY V; OPCA V" -"OMIM:164330","ODONTOMA-DYSPHAGIA SYNDROME" -"OMIM:163500","NIGHT BLINDNESS, CONGENITAL STATIONARY, AUTOSOMAL DOMINANT 2; CSNBAD2" -"DOID:0050921","pharynx squamous cell carcinoma" -"DOID:9076","discoid lupus erythematosus of eyelid" -"DOID:0090115","spinocerebellar ataxia type 1 with axonal neuropathy" -"DOID:11714","gestational diabetes" -"DOID:2226","myeloproliferative neoplasm" -"DOID:6959","rectal cloacogenic carcinoma" -"DOID:730","urethral benign neoplasm" -"DOID:0060695","hyperekplexia" -"OMIM:163700","NIPPLES, SUPERNUMERARY" -"OMIM:164750","OMPHALOCELE, AUTOSOMAL" -"DOID:0050155","sensory system disease" -"OMIM:163600","NIPPLES INVERTED" -"OMIM:173540","PLATELET GROUPS--Pl(E) SYSTEM" -"OMIM:164680","ONYCHOGRYPOSIS, PEDAL, WITH KERATOSIS PLANTARIS AND COARSE HAIR" -"DOID:674","cleft palate" -"OMIM:164745","OMODYSPLASIA 2; OMOD2" -"OMIM:163200","SCHIMMELPENNING-FEUERSTEIN-MIMS SYNDROME; SFM" -"OMIM:609452","MYOPATHY, MYOFIBRILLAR, 4; MFM4" -"OMIM:600802","SEVERE COMBINED IMMUNODEFICIENCY, AUTOSOMAL RECESSIVE, T CELL-NEGATIVE, B CELL-POSITIVE, NK CELL-NEGATIVE" -"OMIM:614920","PEROXISOME BIOGENESIS DISORDER 14B; PEX14B" -"OMIM:600803","GALLBLADDER DISEASE 1; GBD1" -"OMIM:609454","SUPRANUCLEAR PALSY, PROGRESSIVE, 2; PSNP2" -"OMIM:614921","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE It; CDG1T" -"OMIM:614922","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 11; COXPD11" -"OMIM:600807","ASTHMA, SUSCEPTIBILITY TO" -"OMIM:609456","MUSCULAR DYSTROPHY, CONGENITAL, MEROSIN-POSITIVE" -"DOID:1470","major depressive disorder" -"OMIM:600808","ENURESIS, NOCTURNAL, 2; ENUR2" -"OMIM:609460","GOLDBERG-SHPRINTZEN SYNDROME; GOSHS" -"OMIM:614923","BRANCHED-CHAIN KETO ACID DEHYDROGENASE KINASE DEFICIENCY; BCKDKD" -"DOID:0060429","chromosomal duplication syndrome" -"OMIM:600841","EUKARYOTIC TRANSLATION ELONGATION FACTOR 1 ALPHA-1-LIKE 14; EEF1A1L14" -"OMIM:609465","AL-GAZALI SYNDROME" -"OMIM:614924","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 12; COXPD12" -"OMIM:614926","PERRAULT SYNDROME 2; PRLTS2" -"OMIM:600850","SCHIZOPHRENIA 4; SCZD4" -"OMIM:609466","CLEFT PALATE, MIDFACIAL HYPOPLASIA, TRIANGULAR FACIES, AND SENSORINEURAL HEARING LOSS" -"DOID:12858","Huntington's Disease" -"OMIM:600851","MITOCHONDRIAL IMPORT-STIMULATING FACTOR" -"OMIM:609469","NEPHROPATHY, PROGRESSIVE, WITH DEAFNESS" -"OMIM:614927","ECTODERMAL DYSPLASIA 5, HAIR/NAIL TYPE; ECTD5" -"OMIM:609470","LEFT VENTRICULAR NONCOMPACTION 2; LVNC2" -"OMIM:614928","ECTODERMAL DYSPLASIA 6, HAIR/NAIL TYPE; ECTD6" -"OMIM:600852","RETINITIS PIGMENTOSA 17; RP17" -"OMIM:614929","ECTODERMAL DYSPLASIA 7, HAIR/NAIL TYPE; ECTD7" -"OMIM:600858","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 6; CMH6" -"OMIM:609500","MYOPATHY, AUTOPHAGIC VACUOLAR, INFANTILE-ONSET" -"DOID:1557","hypersensitivity reaction type III disease" -"OMIM:614931","ECTODERMAL DYSPLASIA 9, HAIR/NAIL TYPE; ECTD9" -"OMIM:600880","BUDD-CHIARI SYNDROME; BDCHS" -"OMIM:609508","STICKLER SYNDROME, TYPE I, NONSYNDROMIC OCULAR" -"DOID:13810","hypercholesterolemia" -"OMIM:600881","CATARACT 10, MULTIPLE TYPES; CTRCT10" -"OMIM:614932","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 13; COXPD13" -"OMIM:609515","IRIDOGONIODYSGENESIS AND SKELETAL ANOMALIES" -"OMIM:600882","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2B; CMT2B" -"OMIM:609524","MYOPATHY, MYOFIBRILLAR, 5; MFM5" -"OMIM:614934","DEAFNESS, AUTOSOMAL RECESSIVE 70; DFNB70" -"OMIM:614935","CILIARY DYSKINESIA, PRIMARY, 19; CILD19" -"OMIM:609528","CEREBRAL DYSGENESIS, NEUROPATHY, ICHTHYOSIS, AND PALMOPLANTAR KERATODERMA SYNDROME" -"DOID:14504","Niemann-Pick disease" -"OMIM:600883","DIABETES MELLITUS, INSULIN-DEPENDENT, 8; IDDM8" -"OMIM:609529","IMMUNOGLOBULIN A DEFICIENCY 2; IGAD2" -"OMIM:614936","PALMOPLANTAR KERATODERMA, PUNCTATE TYPE IB; PPKP1B" -"OMIM:600884","CARDIOMYOPATHY, DILATED, 1B; CMD1B" -"DOID:5588","lung papillary adenocarcinoma" -"OMIM:600886","HYPERFERRITINEMIA WITH OR WITHOUT CATARACT; HRFTC" -"OMIM:614937","MYOCLONUS, FAMILIAL CORTICAL; FCM" -"OMIM:609532","HEPATITIS C VIRUS, SUSCEPTIBILITY TO" -"OMIM:614940","ECTODERMAL DYSPLASIA 11A, HYPOHIDROTIC/HAIR/TOOTH TYPE, AUTOSOMAL DOMINANT; ECTD11A" -"OMIM:600901","FANCONI ANEMIA, COMPLEMENTATION GROUP E; FANCE" -"OMIM:609533","DEAFNESS, AUTOSOMAL RECESSIVE 23; DFNB23" -"OMIM:600903","WISKOTT-ALDRICH SYNDROME, AUTOSOMAL DOMINANT FORM" -"OMIM:609535","DRUG METABOLISM, POOR, CYP2C19-RELATED" -"OMIM:614941","ECTODERMAL DYSPLASIA 11B, HYPOHIDROTIC/HAIR/TOOTH TYPE, AUTOSOMAL RECESSIVE; ECTD11B" -"DOID:5577","gastrinoma" -"OMIM:614944","DEAFNESS, AUTOSOMAL RECESSIVE 84B; DFNB84B" -"OMIM:600906","ECTODERMAL DYSPLASIA WITH MENTAL RETARDATION AND SYNDACTYLY" -"OMIM:609536","COMPLEMENT COMPONENT 5 DEFICIENCY; C5D" -"OMIM:600907","ENAMEL HYPOPLASIA, CATARACTS, AND AQUEDUCTAL STENOSIS" -"OMIM:614945","DEAFNESS, AUTOSOMAL RECESSIVE 18B; DFNB18B" -"OMIM:609537","LIPOMYELOMENINGOCELE" -"OMIM:600908","KENNERKNECHT SYNDROME" -"OMIM:609541","SPASTIC PARAPLEGIA, OPTIC ATROPHY, AND NEUROPATHY; SPOAN" -"DOID:1085","Edwards syndrome" -"OMIM:614946","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 14; COXPD14" -"OMIM:609545","OMPHALOCELE, DIAPHRAGMATIC HERNIA, AND RADIAL RAY DEFECTS" -"OMIM:600919","CARDIAC ARRHYTHMIA, ANKYRIN-B-RELATED" -"OMIM:614947","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 15; COXPD15" -"OMIM:600920","VAN DEN ENDE-GUPTA SYNDROME; VDEGS" -"OMIM:609549","NANOPHTHALMOS 2; NNO2" -"OMIM:614954","CONGENITAL HEART DEFECTS, MULTIPLE TYPES, 3; CHTD3" -"OMIM:614959","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 14; EIEE14" -"OMIM:609558","PROSTATE CANCER, HEREDITARY, 6" -"OMIM:600931","PROTOCADHERIN 3" -"OMIM:614961","PONTOCEREBELLAR HYPOPLASIA, TYPE 8; PCH8" -"OMIM:609560","MITOCHONDRIAL DNA DEPLETION SYNDROME 2 (MYOPATHIC TYPE); MTDPS2" -"OMIM:600952","TRANSSEXUALITY" -"OMIM:600955","PROPROTEIN CONVERTASE 1/3 DEFICIENCY" -"OMIM:614962","LEPTIN DEFICIENCY OR DYSFUNCTION; LEPD" -"OMIM:609566","PARIETAL FORAMINA 3; PFM3" -"DOID:1932","Angelman syndrome" -"OMIM:609570","MIGRAINE WITH OR WITHOUT AURA, SUSCEPTIBILITY TO, 8" -"OMIM:600962","PALMOPLANTAR KERATODERMA, NONEPIDERMOLYTIC; NEPPK" -"OMIM:614963","LEPTIN RECEPTOR DEFICIENCY" -"DOID:0110573","autosomal dominant nonsyndromic deafness 4A" -"OMIM:609572","PHOTOPAROXYSMAL RESPONSE 2; PPR2" -"OMIM:600965","DEAFNESS, AUTOSOMAL DOMINANT 6; DFNA6" -"OMIM:614969","PONTOCEREBELLAR HYPOPLASIA, TYPE 7; PCH7" -"OMIM:609573","PHOTOPAROXYSMAL RESPONSE 3; PPR3" -"OMIM:600969","EPIPHYSEAL DYSPLASIA, MULTIPLE, 3; EDM3" -"OMIM:614970","JOUBERT SYNDROME 20; JBTS20" -"DOID:3896","hidradenoma" -"OMIM:614972","CHOLESTASIS, INTRAHEPATIC, OF PREGNANCY 3; ICP3" -"OMIM:609578","CARDIOMYOPATHY, FAMILIAL RESTRICTIVE, 2; RCM2" -"OMIM:600971","DEAFNESS, AUTOSOMAL RECESSIVE 6; DFNB6" -"OMIM:609579","SCAPHOCEPHALY, MAXILLARY RETRUSION, AND MENTAL RETARDATION" -"OMIM:614973","FOCAL FACIAL DERMAL DYSPLASIA 2, BRAUER-SETLEIS TYPE; FFDD2" -"OMIM:600972","ACHONDROGENESIS, TYPE IB; ACG1B" -"OMIM:600974","DEAFNESS, AUTOSOMAL RECESSIVE 7; DFNB7" -"OMIM:609583","JOUBERT SYNDROME 4; JBTS4" -"OMIM:614974","FOCAL FACIAL DERMAL DYSPLASIA 4; FFDD4" -"DOID:0050905","inflammatory myofibroblastic tumor" -"DOID:0050998","nonprogressive cerebellar atxia with mental retardation" -"OMIM:600975","GLAUCOMA 3, PRIMARY INFANTILE, B; GLC3B" -"OMIM:614976","CARPENTER SYNDROME 2; CRPT2" -"OMIM:609597","PARIETAL FORAMINA 2; PFM2" -"OMIM:600977","CONE-ROD DYSTROPHY 5; CORD5" -"OMIM:614979","SPLENOMEGALY, CYTOPENIA, AND VISION LOSS" -"OMIM:609612","FIBROSIS OF EXTRAOCULAR MUSCLES, CONGENITAL, WITH SYNERGISTIC DIVERGENCE" -"OMIM:614980","CONGENITAL HEART DEFECTS, MULTIPLE TYPES, 2; CHTD2" -"OMIM:600987","CLEFT PALATE, CARDIAC DEFECTS, AND MENTAL RETARDATION; CPCMR" -"OMIM:609616","SPONDYLOMEGAEPIPHYSEAL DYSPLASIA WITH UPPER LIMB MESOMELIA, PUNCTATE CALCIFICATIONS, AND DEAFNESS" -"OMIM:609620","SHORT QT SYNDROME 1; SQT1" -"OMIM:600989","INFUNDIBULOPELVIC DYSGENESIS" -"OMIM:614990","USHER SYNDROME, TYPE IK; USH1K" -"OMIM:609621","SHORT QT SYNDROME 2; SQT2" -"OMIM:600991","HYDROCEPHALUS, SPRENGEL ANOMALY, AND COSTOVERTEBRAL DYSPLASIA" -"OMIM:615005","EPILEPSY, NOCTURNAL FRONTAL LOBE, 5; ENFL5" -"OMIM:231005","GAUCHER DISEASE, TYPE IIIC" -"DOID:5592","breast papillary carcinoma" -"DOID:11353","bladder diverticulum" -"OMIM:102300","RESTLESS LEGS SYNDROME, SUSCEPTIBILITY TO, 1; RLS1" -"OMIM:231050","GELEOPHYSIC DYSPLASIA 1; GPHYSD1" -"OMIM:231060","GENITOPALATOCARDIAC SYNDROME" -"DOID:1555","urticaria" -"OMIM:231070","GERODERMA OSTEODYSPLASTICUM; GO" -"DOID:2065","syringoma" -"OMIM:231080","GERMAN SYNDROME" -"OMIM:231090","HYDATIDIFORM MOLE, RECURRENT, 1; HYDM1" -"DOID:173","eccrine sweat gland neoplasm" -"DOID:8986","narcolepsy" -"OMIM:231095","GHOSAL HEMATODIAPHYSEAL DYSPLASIA; GHDD" -"OMIM:102200","PITUITARY ADENOMA 1, MULTIPLE TYPES; PITA1" -"OMIM:231100","HEMOCHROMATOSIS, NEONATAL" -"OMIM:102150","ACROMEGALOID FACIAL APPEARANCE SYNDROME" -"OMIM:231200","BERNARD-SOULIER SYNDROME; BSS" -"OMIM:231300","GLAUCOMA 3, PRIMARY CONGENITAL, A; GLC3A" -"DOID:0110852","rhizomelic chondrodysplasia punctata type 2" -"DOID:10691","fat necrosis of breast" -"OMIM:231530","3-HYDROXYACYL-CoA DEHYDROGENASE DEFICIENCY" -"OMIM:184095","SPONDYLOEPIPHYSEAL DYSPLASIA, MAROTEAUX TYPE" -"OMIM:231550","ACHALASIA-ADDISONIANISM-ALACRIMA SYNDROME; AAAS" -"DOID:2661","myoepithelioma" -"OMIM:184000","SPONDYLOEPIPHYSEAL DYSPLASIA, MYOPIA, AND SENSORINEURAL DEAFNESS" -"OMIM:184100","SPONDYLOEPIPHYSEAL DYSPLASIA TARDA, AUTOSOMAL DOMINANT" -"DOID:11168","anogenital venereal wart" -"OMIM:231630","MONOSODIUM GLUTAMATE SENSITIVITY" -"OMIM:231670","GLUTARIC ACIDEMIA I; GA1" -"OMIM:231680","MULTIPLE ACYL-CoA DEHYDROGENASE DEFICIENCY; MADD" -"DOID:5876","apocrine sweat gland neoplasm" -"OMIM:231690","GLUTARIC ACIDURIA III; GA3" -"DOID:361","cervix endometriosis" -"OMIM:231900","GLUTATHIONE SYNTHETASE DEFICIENCY OF ERYTHROCYTES, HEMOLYTIC ANEMIA DUE TO; GSSDE" -"DOID:10112","sleeping sickness" -"OMIM:155100","MAY-HEGGLIN ANOMALY; MHA" -"OMIM:231950","GLUTATHIONURIA" -"DOID:6629","nipple carcinoma" -"OMIM:231970","GLUTEAL MUSCLES, ABSENCE OF" -"OMIM:232200","GLYCOGEN STORAGE DISEASE Ia; GSD1A" -"DOID:0060379","acrofacial dysostosis" -"OMIM:232220","GLYCOGEN STORAGE DISEASE Ib; GSD1B" -"DOID:1988","rectum lymphoma" -"OMIM:232240","GLYCOGEN STORAGE DISEASE Ic; GSD1C" -"DOID:12144","low compliance bladder" -"DOID:0050453","lissencephaly" -"OMIM:232300","GLYCOGEN STORAGE DISEASE II; GSD2" -"OMIM:232400","GLYCOGEN STORAGE DISEASE III; GSD3" -"OMIM:232500","GLYCOGEN STORAGE DISEASE IV; GSD4" -"DOID:13521","tetanus neonatorum" -"DOID:0050778","Meckel syndrome" -"OMIM:232600","GLYCOGEN STORAGE DISEASE V; GSD5" -"OMIM:232700","GLYCOGEN STORAGE DISEASE VI; GSD6" -"DOID:0050761","paramyloidosis" -"OMIM:232800","GLYCOGEN STORAGE DISEASE VII; GSD7" -"OMIM:232900","GLYCOPROTEIN STORAGE DISEASE" -"DOID:0050637","Finnish type amyloidosis" -"OMIM:155050","MAXILLONASAL DYSPLASIA, BINDER TYPE" -"OMIM:233100","RENAL GLUCOSURIA; GLYS" -"OMIM:154850","MASTICATORY MUSCLES, HYPERTROPHY OF" -"OMIM:233270","GOMBO SYNDROME" -"DOID:7578","breast scirrhous carcinoma" -"OMIM:233300","OVARIAN DYSGENESIS 1; ODG1" -"OMIM:154800","MAST CELL DISEASE" -"OMIM:233400","PERRAULT SYNDROME 1; PRLTS1" -"OMIM:233420","46,XY SEX REVERSAL 7; SRXY7" -"OMIM:233430","GONADAL DYSGENESIS, XY TYPE, WITH ASSOCIATED ANOMALIES" -"OMIM:155000","MAXILLOFACIAL DYSOSTOSIS" -"OMIM:102100","ACROMEGALOID CHANGES, CUTIS VERTICIS GYRATA, AND CORNEAL LEUKOMA" -"OMIM:233450","GOODPASTURE SYNDROME" -"DOID:0050578","occult macular dystrophy" -"OMIM:609622","SHORT QT SYNDROME 3; SQT3" -"OMIM:615006","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 15; EIEE15" -"OMIM:248350","MALOCCLUSION AND SHORT STATURE" -"DOID:11482","hemopericardium" -"OMIM:248360","MALONYL-CoA DECARBOXYLASE DEFICIENCY" -"OMIM:609625","CHROMOSOME 10q26 DELETION SYNDROME" -"OMIM:615007","BASAL GANGLIA CALCIFICATION, IDIOPATHIC, 4; IBGC4" -"DOID:4086","testicular germ cell tumor non-seminomatous" -"DOID:0060244","specific language impairment" -"OMIM:609628","MAJEED SYNDROME; MJDS" -"OMIM:248370","MANDIBULOACRAL DYSPLASIA WITH TYPE A LIPODYSTROPHY; MADA" -"OMIM:615008","NEPHROTIC SYNDROME, TYPE 7; NPHS7" -"DOID:0060135","apraxia" -"OMIM:161600","NAVICULAR BONE, ACCESSORY" -"OMIM:615009","SCHUURS-HOEIJMAKERS SYNDROME; SHMS" -"OMIM:609629","VISCERAL NEUROPATHY, FAMILIAL, AUTOSOMAL DOMINANT" -"OMIM:248390","TREACHER COLLINS SYNDROME 3; TCS3" -"OMIM:161400","NARCOLEPSY 1; NRCLP1" -"OMIM:609630","LEUKEMIA, CHRONIC LYMPHOCYTIC, SUSCEPTIBILITY TO, 1" -"OMIM:248400","MANDIBULOFACIAL DYSOSTOSIS WITH MENTAL DEFICIENCY" -"OMIM:615010","AICARDI-GOUTIERES SYNDROME 6; AGS6" -"DOID:4277","penis basal cell carcinoma" -"OMIM:161480","NASAL BONES, ABSENCE OF" -"DOID:0060869","late-onset retinal degenration" -"OMIM:161700","NECROTIZING ENCEPHALOMYELOPATHY, SUBACUTE, OF LEIGH, ADULT" -"OMIM:248450","MANITOBA OCULOTRICHOANAL SYNDROME; MOTA" -"OMIM:615011","PHOSPHOHYDROXYLYSINURIA; PHLU" -"DOID:3614","Kallmann syndrome" -"OMIM:609634","MIGRAINE, FAMILIAL HEMIPLEGIC, 3; FHM3" -"OMIM:615021","BLOOD GROUP, GLOBOSIDE SYSTEM; GLOB" -"DOID:4961","bone marrow disease" -"OMIM:248500","MANNOSIDOSIS, ALPHA B, LYSOSOMAL; MANSA" -"OMIM:615022","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 7; ARCI7" -"OMIM:609636","ALZHEIMER DISEASE 10" -"OMIM:248510","MANNOSIDOSIS, BETA A, LYSOSOMAL; MANSB" -"OMIM:248600","MAPLE SYRUP URINE DISEASE; MSUD" -"DOID:0050152","aspiration pneumonia" -"OMIM:161530","NASAL HYPERPIGMENTATION, FAMILIAL TRANSVERSE" -"OMIM:615023","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 9; ARCI9" -"OMIM:609637","HOLOPROSENCEPHALY 5; HPE5" -"OMIM:609638","EPIDERMOLYSIS BULLOSA, LETHAL ACANTHOLYTIC; EBLA" -"OMIM:615024","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 10; ARCI10" -"OMIM:248700","MARDEN-WALKER SYNDROME; MWKS" -"OMIM:609640","FRIAS SYNDROME" -"OMIM:615025","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2Q; CMT2Q" -"OMIM:248760","MARFANOID HABITUS WITH MICROCEPHALY AND GLOMERULONEPHRITIS" -"OMIM:609643","NGUYEN SYNDROME" -"OMIM:248770","MARFANOID MENTAL RETARDATION SYNDROME, AUTOSOMAL" -"OMIM:615026","RIBOFLAVIN DEFICIENCY; RBFVD" -"DOID:9119","acute myeloid leukemia" -"OMIM:609646","DEAFNESS, AUTOSOMAL RECESSIVE 42; DFNB42" -"OMIM:248800","MARINESCO-SJOGREN SYNDROME; MSS" -"OMIM:615028","EPIDERMOLYSIS BULLOSA, NONSPECIFIC, AUTOSOMAL RECESSIVE; EBNS" -"OMIM:161500","NASAL GROOVE, FAMILIAL TRANSVERSE" -"OMIM:248900","MAST SYNDROME" -"OMIM:615030","SPASTIC PARAPLEGIA 56, AUTOSOMAL RECESSIVE; SPG56" -"OMIM:609647","DEAFNESS, AUTOSOMAL RECESSIVE 46; DFNB46" -"DOID:12987","agranulocytosis" -"OMIM:248910","CUTANEOUS MASTOCYTOSIS, CONDUCTIVE HEARING LOSS AND MICROTIA" -"OMIM:615031","SPASTIC PARAPLEGIA 49, AUTOSOMAL RECESSIVE; SPG49" -"DOID:2451","protein S deficiency" -"OMIM:609649","TRICHILEMMAL CYST 1; TRICY1" -"OMIM:615032","AUTISM, SUSCEPTIBILITY TO, 18; AUTS18" -"OMIM:609654","SHORT STATURE AND FACIOAURICULOTHORACIC MALFORMATIONS" -"OMIM:248950","MCDONOUGH SYNDROME" -"OMIM:615033","SPASTIC PARAPLEGIA 54, AUTOSOMAL RECESSIVE; SPG54" -"OMIM:249000","MECKEL SYNDROME, TYPE 1; MKS1" -"OMIM:609655","TALO-PATELLO-SCAPHOID OSTEOLYSIS, SYNOVITIS, AND SHORT FOURTH METACARPALS" -"OMIM:609656","BONE SIZE QUANTITATIVE TRAIT LOCUS 1" -"OMIM:615034","DYSTONIA 24; DYT24" -"OMIM:249100","FAMILIAL MEDITERRANEAN FEVER; FMF" -"DOID:5295","intestinal disease" -"OMIM:615035","SPASTIC PARAPLEGIA 55, AUTOSOMAL RECESSIVE; SPG55" -"OMIM:609657","BONE SIZE QUANTITATIVE TRAIT LOCUS 2" -"OMIM:249230","MEGAEPIPHYSEAL DWARFISM" -"OMIM:249240","MEGALENCEPHALY WITH DYSMYELINATION" -"DOID:0050534","congenital stationary night blindness" -"OMIM:615040","EPISODIC PAIN SYNDROME, FAMILIAL, 1; FEPS1" -"OMIM:609670","MIGRAINE WITH AURA, SUSCEPTIBILITY TO, 9" -"OMIM:609698","THYROID HORMONE METABOLISM, ABNORMAL" -"OMIM:249270","THIAMINE-RESPONSIVE MEGALOBLASTIC ANEMIA SYNDROME; TRMA" -"OMIM:615041","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 10; MDDGA10" -"DOID:0050664","Bietti crystalline corneoretinal dystrophy" -"OMIM:615042","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Iu; CDG1U" -"OMIM:249300","MEGALOCORNEA" -"OMIM:609706","DEAFNESS, AUTOSOMAL RECESSIVE 53; DFNB53" -"OMIM:609727","SPASTIC PARAPLEGIA 29, AUTOSOMAL DOMINANT; SPG29" -"OMIM:249310","MEGALOCORNEA-MENTAL RETARDATION SYNDROME" -"OMIM:615043","SPASTIC PARAPLEGIA 43, AUTOSOMAL RECESSIVE; SPG43" -"OMIM:161800","NEMALINE MYOPATHY 3; NEM3" -"DOID:12161","peripheral retinal degeneration" -"OMIM:615048","SPINAL MUSCULAR ATROPHY, JOKELA TYPE; SMAJ" -"OMIM:609734","PROOPIOMELANOCORTIN DEFICIENCY" -"OMIM:249400","MELANOSIS, NEUROCUTANEOUS; NCMS" -"DOID:0090070","hypogonadotropic hypogonadism" -"OMIM:609741","CATARACT 22, MULTIPLE TYPES; CTRCT22" -"OMIM:615058","NIGHT BLINDNESS, CONGENITAL STATIONARY, TYPE 1F; CSNB1F" -"DOID:13250","diarrhea" -"OMIM:249420","FRANK-TER HAAR SYNDROME; FTHS" -"OMIM:249500","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 1; MRT1" -"OMIM:615059","HYPOTRICHOSIS 11; HYPT11" -"OMIM:161550","NASOPHARYNGEAL CARCINOMA, SUSCEPTIBILITY TO, 2; NPCA2" -"OMIM:609745","GLAUCOMA 1, OPEN ANGLE, I; GLC1I" -"OMIM:249599","MENTAL RETARDATION SYNDROME, BELGIAN TYPE" -"OMIM:609750","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 4; EIG4" -"OMIM:615065","ARTHROGRYPOSIS, DISTAL, TYPE 5D; DA5D" -"OMIM:615066","OSTEOGENESIS IMPERFECTA, TYPE XIV; OI14" -"OMIM:249600","MENTAL RETARDATION SYNDROME, MIETENS-WEBER TYPE" -"OMIM:609753","CELIAC DISEASE, SUSCEPTIBILITY TO, 4; CELIAC4" -"DOID:4543","retrograde amnesia" -"DOID:11971","synostosis" -"OMIM:615067","CILIARY DYSKINESIA, PRIMARY, 20; CILD20" -"OMIM:609754","CELIAC DISEASE, SUSCEPTIBILITY TO, 2; CELIAC2" -"OMIM:249620","OHDO SYNDROME" -"OMIM:249630","MENTAL RETARDATION, BUENOS AIRES TYPE" -"OMIM:615071","ALAZAMI SYNDROME; ALAZS" -"DOID:14115","toxic shock syndrome" -"OMIM:609755","CELIAC DISEASE, SUSCEPTIBILITY TO, 3; CELIAC3" -"DOID:14268","sclerosing cholangitis" -"OMIM:609757","WILLIAMS-BEUREN REGION DUPLICATION SYNDROME" -"OMIM:249650","MERCAPTOLACTATE-CYSTEINE DISULFIDURIA; MCDU" -"OMIM:615072","BRACHYDACTYLY, TYPE A1, C; BDA1C" -"OMIM:615073","DYSTONIA 25; DYT25" -"OMIM:609782","AORTIC ANEURYSM, FAMILIAL ABDOMINAL, 2; AAA2" -"OMIM:249660","MESANGIAL SCLEROSIS, DIFFUSE RENAL, WITH OCULAR ABNORMALITIES" -"DOID:8472","localized scleroderma" -"DOID:8465","retinoschisis" -"OMIM:615074","MENTAL RETARDATION, AUTOSOMAL DOMINANT 18; MRD18" -"OMIM:609790","ALZHEIMER DISEASE 11" -"OMIM:249670","MESOAXIAL HEXADACTYLY AND CARDIAC MALFORMATION" -"OMIM:609796","PEELING SKIN SYNDROME 2; PSS2" -"OMIM:615075","MENTAL RETARDATION, AUTOSOMAL DOMINANT 19; MRD19" -"OMIM:249700","LANGER MESOMELIC DYSPLASIA; LMD" -"DOID:9500","leukocyte disease" -"OMIM:161470","NASAL ALAR COLLAPSE, BILATERAL" -"OMIM:609800","GENERALIZED EPILEPSY WITH FEBRILE SEIZURES PLUS, TYPE 4; GEFSP4" -"OMIM:249710","MESOMELIC LIMB SHORTENING AND BOWING" -"OMIM:615080","ALZHEIMER DISEASE 17; AD17" -"OMIM:249900","METACHROMATIC LEUKODYSTROPHY DUE TO SAPOSIN B DEFICIENCY" -"OMIM:609808","HAMARTOMA, PRECALCANEAL CONGENITAL FIBROLIPOMATOUS" -"OMIM:615081","SPERMATOGENIC FAILURE 11; SPGF11" -"OMIM:142340","DIAPHRAGMATIC HERNIA, CONGENITAL" -"OMIM:142395","HEPATITIS B VACCINE, RESPONSE TO" -"DOID:1595","endogenous depression" -"OMIM:147560","INTERFERON ANTIVIRAL DEPRESSOR" -"OMIM:142400","HERNIA, HIATUS" -"DOID:2055","post-traumatic stress disorder" -"DOID:10612","allergic urticaria" -"DOID:0050398","Carrion's disease" -"DOID:5844","Myocardial Infarction" -"DOID:0060345","bacillary angiomatosis" -"OMIM:147630","ISLET CELL ADENOMATOSIS" -"OMIM:147540","INSECT STINGS, HYPERSENSITIVITY TO" -"DOID:2841","asthma" -"DOID:5309","epithelial-myoepithelial carcinoma" -"DOID:526","HIV infectious disease" -"OMIM:142335","FETAL HEMOGLOBIN QUANTITATIVE TRAIT LOCUS 5; HBFQTL5" -"DOID:0050340","opportunistic bacterial infectious disease" -"OMIM:100050","AARSKOG SYNDROME, AUTOSOMAL DOMINANT" -"OMIM:100070","AORTIC ANEURYSM, FAMILIAL ABDOMINAL, 1; AAA1" -"DOID:4325","Ebola hemmorhagic fever" -"DOID:2723","dermatitis" -"DOID:2218","blood platelet disease" -"OMIM:142500","HETEROCHROMIA IRIDIS" -"OMIM:147610","IRIS PIGMENT LAYER, CLEAVAGE OF" -"DOID:1498","cholera" -"OMIM:142350","HERNIA, DOUBLE INGUINAL" -"DOID:10608","celiac disease" -"DOID:0110492","autosomal recessive nonsyndromic deafness 33" -"DOID:1510","personality disorder" -"OMIM:147800","AASE-SMITH SYNDROME I" -"OMIM:142470","FETAL HEMOGLOBIN QUANTITATIVE TRAIT LOCUS 2; HBFQTL2" -"OMIM:100100","PRUNE BELLY SYNDROME; PBS" -"OMIM:147710","INTUSSUSCEPTION" -"DOID:13186","megaesophagus" -"DOID:3781","anovulation" -"OMIM:142330","HEPATIC ADENOMAS, FAMILIAL" -"DOID:0050629","Aicardi-Goutieres syndrome" -"DOID:3689","brachial plexus neuritis" -"OMIM:147791","JACOBSEN SYNDROME; JBS" -"DOID:4989","pancreatitis" -"OMIM:147530","INSENSITIVITY TO PAIN WITH HYPERPLASTIC MYELINOPATHY" -"DOID:11101","trench fever" -"OMIM:100200","ABDUCENS PALSY" -"DOID:11258","cat-scratch disease" -"OMIM:147750","IVIC SYNDROME" -"OMIM:147770","JOHNSON NEUROECTODERMAL SYNDROME" -"DOID:4675","uremic neuropathy" -"DOID:0110494","autosomal recessive nonsyndromic deafness 36" -"OMIM:213600","BASAL GANGLIA CALCIFICATION, IDIOPATHIC, 1; IBGC1" -"DOID:0110964","brachydactyly type A1" -"OMIM:600151","BARDET-BIEDL SYNDROME 3; BBS3" -"DOID:6548","angiomatous meningioma" -"OMIM:600155","HIRSCHSPRUNG DISEASE, SUSCEPTIBILITY TO, 2; HSCR2" -"OMIM:213700","CEREBROTENDINOUS XANTHOMATOSIS; CTX" -"OMIM:109900","BLEPHAROCHALASIS AND DOUBLE LIP" -"OMIM:600156","HIRSCHSPRUNG DISEASE, SUSCEPTIBILITY TO, 5; HSCR5" -"DOID:4281","metatypical basal cell carcinoma" -"OMIM:128600","EAR MALFORMATION" -"OMIM:110000","BLEPHAROCHALASIS, SUPERIOR" -"OMIM:213820","CEREBRAL MALFORMATION, SEIZURES, HYPERTRICHOSIS, AND OVERLAPPING FINGERS" -"OMIM:213900","CEREBRAL SCLEROSIS SIMILAR TO PELIZAEUS-MERZBACHER DISEASE" -"OMIM:600159","PTERYGIUM COLLI AND MENTAL RETARDATION WITH FACIAL AND DIGITAL ANOMALIES" -"DOID:1172","hyperlipoproteinemia type IV" -"OMIM:213950","CEREBROCORTICAL DEGENERATION OF INFANCY" -"OMIM:600165","NANOPHTHALMOS 1; NNO1" -"OMIM:128710","EAR PITS, POSTERIOR HELICAL" -"OMIM:600166","HYPERPARATHYROIDISM, PRIMARY, CAUSED BY WATER CLEAR CELL HYPERPLASIA" -"OMIM:213980","CRANIOFACIAL DYSMORPHISM, SKELETAL ANOMALIES, AND MENTAL RETARDATION SYNDROME; CFSMR" -"OMIM:214100","PEROXISOME BIOGENESIS DISORDER 1A (ZELLWEGER); PBD1A" -"OMIM:600171","GONADAL AGENESIS" -"DOID:841","extrinsic allergic alveolitis" -"OMIM:109820","BLADDER DIVERTICULUM" -"OMIM:600175","NEURONOPATHY, DISTAL HEREDITARY MOTOR, TYPE VIII; HMN8" -"OMIM:214110","PEROXISOME BIOGENESIS DISORDER 2A (ZELLWEGER); PBD2A" -"DOID:2382","kernicterus" -"OMIM:214150","CEREBROOCULOFACIOSKELETAL SYNDROME 1; COFS1" -"OMIM:600176","PACHYGYRIA WITH MENTAL RETARDATION, SEIZURES, AND ARACHNOID CYSTS" -"OMIM:214200","CEROID STORAGE DISEASE" -"OMIM:600193","WAARDENBURG SYNDROME, TYPE 2B; WS2B" -"OMIM:214290","CERVICAL VERTEBRAE, AGENESIS OF" -"OMIM:600195","VENOUS MALFORMATIONS, MULTIPLE CUTANEOUS AND MUCOSAL; VMCM" -"OMIM:214300","KLIPPEL-FEIL SYNDROME 2, AUTOSOMAL RECESSIVE; KFS2" -"OMIM:600202","DYSLEXIA, SUSCEPTIBILITY TO, 2; DYX2" -"DOID:10952","nephritis" -"OMIM:600204","EPIPHYSEAL DYSPLASIA, MULTIPLE, 2; EDM2" -"OMIM:214350","CHAND SYNDROME; CHANDS" -"DOID:0050942","spastic ataxia 3" -"OMIM:214370","NEUROPATHY, HEREDITARY MOTOR AND SENSORY, WITH DEAFNESS, MENTAL RETARDATION, AND ABSENT SENSORY LARGE MYELINATED FIBERS" -"OMIM:600208","MACROTHROMBOCYTOPENIA AND PROGRESSIVE SENSORINEURAL DEAFNESS" -"OMIM:600209","EXOSTOSES, MULTIPLE, TYPE III; EXT3" -"OMIM:214400","CHARCOT-MARIE-TOOTH DISEASE, TYPE 4A; CMT4A" -"OMIM:179800","RENAL TUBULAR ACIDOSIS, DISTAL, AUTOSOMAL DOMINANT" -"OMIM:600223","SPINOCEREBELLAR ATAXIA 4; SCA4" -"OMIM:214450","GRISCELLI SYNDROME, TYPE 1; GS1" -"OMIM:128700","PREAURICULAR FISTULAE, CONGENITAL" -"OMIM:214500","CHEDIAK-HIGASHI SYNDROME; CHS" -"OMIM:600224","SPINOCEREBELLAR ATAXIA 5; SCA5" -"OMIM:214700","DIARRHEA 1, SECRETORY CHLORIDE, CONGENITAL; DIAR1" -"OMIM:600231","PALMOPLANTAR KERATODERMA, BOTHNIAN TYPE; PPKB" -"OMIM:600251","FACIAL CLEFTING, OBLIQUE, 1; OBLFC1" -"OMIM:214800","CHARGE SYNDROME" -"DOID:3697","acute transudative otitis media" -"OMIM:600252","LOWRY-MACLEAN SYNDROME" -"OMIM:214900","CHOLESTASIS-LYMPHEDEMA SYNDROME" -"OMIM:600257","CHROMOSOME 8q12.1-q21.2 DELETION SYNDROME" -"OMIM:214950","BILE ACID SYNTHESIS DEFECT, CONGENITAL, 4; CBAS4" -"OMIM:214980","CHOLESTASIS WITH GALLSTONE, ATAXIA, AND VISUAL DISTURBANCE" -"OMIM:600263","HELICOBACTER PYLORI INFECTION, SUSCEPTIBILITY TO" -"DOID:7212","meningothelial meningioma" -"DOID:7426","cutaneous anthrax" -"OMIM:600268","OCULOECTODERMAL SYNDROME; OES" -"OMIM:215030","CHOLESTEROL PNEUMONIA" -"OMIM:600269","SHORT TARSUS WITH ABSENCE OF LOWER EYELASHES; STALE" -"OMIM:215045","CHONDRODYSPLASIA, BLOMSTRAND TYPE; BOCD" -"DOID:2275","pharyngitis" -"DOID:11506","suppurative otitis media" -"OMIM:215050","CHONDRODYSPLASIA CALCIFICANS METAPHYSEALIS" -"OMIM:600273","POLYCYSTIC KIDNEY DISEASE, INFANTILE SEVERE, WITH TUBEROUS SCLEROSIS; PKDTS" -"DOID:0050129","secretory diarrhea" -"OMIM:600274","FRONTOTEMPORAL DEMENTIA; FTD" -"OMIM:215100","RHIZOMELIC CHONDRODYSPLASIA PUNCTATA, TYPE 1; RCDP1" -"DOID:445","Bartter disease" -"OMIM:215105","CHONDRODYSPLASIA PUNCTATA SYNDROME" -"DOID:0110143","Bartter disease type 2" -"OMIM:600302","FRYNS MACROCEPHALY" -"DOID:7635","Gasserian ganglion meningioma" -"OMIM:600309","ATRIOVENTRICULAR SEPTAL DEFECT 3; AVSD3" -"OMIM:215140","GREENBERG DYSPLASIA; GRBGD" -"OMIM:215150","OTOSPONDYLOMEGAEPIPHYSEAL DYSPLASIA, AUTOSOMAL RECESSIVE; OSMEDB" -"OMIM:600316","DEAFNESS, AUTOSOMAL RECESSIVE 3; DFNB3" -"OMIM:600318","DIABETES MELLITUS, INSULIN-DEPENDENT, 3; IDDM3" -"OMIM:215250","CHONDROITIN-6-SULFATURIA, DEFECTIVE CELLULAR IMMUNITY, NEPHROTIC SYNDROME" -"OMIM:600319","DIABETES MELLITUS, INSULIN-DEPENDENT, 4; IDDM4" -"OMIM:215300","CHONDROSARCOMA" -"DOID:4210","clear cell meningioma" -"OMIM:215400","CHORDOMA, SUSCEPTIBILITY TO; CHDM" -"OMIM:600320","DIABETES MELLITUS, INSULIN-DEPENDENT, 5; IDDM5" -"OMIM:600321","DIABETES MELLITUS, INSULIN-DEPENDENT, 7; IDDM7" -"OMIM:215450","CHOREA, BENIGN FAMILIAL" -"OMIM:215470","BOUCHER-NEUHAUSER SYNDROME; BNHS" -"DOID:0050650","familial atrial fibrillation" -"OMIM:600325","AMINOPTERIN SYNDROME SINE AMINOPTERIN; ASSA" -"OMIM:215480","CHOROID PLEXUS CALCIFICATION AND MENTAL RETARDATION" -"OMIM:600329","OSTEOPETROSIS AND INFANTILE NEUROAXONAL DYSTROPHY" -"OMIM:215500","CHOROIDAL DYSTROPHY, CENTRAL AREOLAR, 1; CACD1" -"DOID:3234","central nervous system lymphoma" -"OMIM:600331","PARC SYNDROME" -"DOID:14502","cholesterol ester storage disease" -"OMIM:615082","C3HEX, ABILITY TO SMELL" -"OMIM:609812","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 8, WITH EXOCRINE DYSFUNCTION; MODY8" -"OMIM:609813","SPONDYLOCOSTAL DYSOSTOSIS 3, AUTOSOMAL RECESSIVE; SCDO3" -"OMIM:615083","COLORECTAL CANCER, SUSCEPTIBILITY TO, 12; CRCS12" -"OMIM:615084","MITOCHONDRIAL DNA DEPLETION SYNDROME 11; MTDPS11" -"OMIM:609814","COMPLEMENT FACTOR H DEFICIENCY; CFHD" -"DOID:303","substance-related disorder" -"OMIM:615085","OSTEOPETROSIS, AUTOSOMAL RECESSIVE 8; OPTB8" -"OMIM:609815","ZYGODACTYLY 1" -"DOID:3393","coronary artery disease" -"OMIM:609817","VASCULITIS, LYMPHOCYTIC, CUTANEOUS SMALL VESSEL" -"OMIM:615091","AUTISM, SUSCEPTIBILITY TO, 19; AUTS19" -"OMIM:615092","LEFT VENTRICULAR NONCOMPACTION 7; LVNC7" -"OMIM:609820","ERYTHROCYTOSIS, FAMILIAL, 3; ECYT3" -"OMIM:609821","BLEEDING DISORDER, PLATELET-TYPE, 8; BDPLT8" -"OMIM:615095","MICROCEPHALY 10, PRIMARY, AUTOSOMAL RECESSIVE; MCPH10" -"DOID:1081","mansonelliasis" -"OMIM:609822","STATURE QUANTITATIVE TRAIT LOCUS 7; STQTL7" -"OMIM:615102","TYSHCHENKO SYNDROME" -"DOID:119","vaginal cancer" -"OMIM:609823","DEAFNESS, AUTOSOMAL RECESSIVE 28; DFNB28" -"OMIM:615106","COWDEN SYNDROME 3; CWS3" -"OMIM:609876","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 6; BMND6" -"OMIM:615107","COWDEN SYNDROME 4; CWS4" -"DOID:0060650","dicarboxylic aminoaciduria" -"OMIM:609886","GLOMERULOCYSTIC KIDNEY DISEASE WITH HYPERURICEMIA AND ISOSTHENURIA" -"OMIM:615108","COWDEN SYNDROME 5; CWS5" -"DOID:0050544","hypermethioninemia" -"OMIM:609887","GLAUCOMA 1, OPEN ANGLE, G; GLC1G" -"OMIM:615109","COWDEN SYNDROME 6; CWS6" -"DOID:655","inherited metabolic disorder" -"OMIM:609888","LEPROSY, SUSCEPTIBILITY TO, 1; LPRS1" -"OMIM:615112","UROFACIAL SYNDROME 2; UFS2" -"DOID:3878","intestinal pseudo-obstruction" -"OMIM:609889","ALPHA/BETA T-CELL LYMPHOPENIA WITH GAMMA/DELTA T-CELL EXPANSION, SEVERE CYTOMEGALOVIRUS INFECTION, AND AUTOIMMUNITY" -"OMIM:615113","MICROPHTHALMIA, ISOLATED 8; MCOP8" -"OMIM:615119","CARDIOENCEPHALOMYOPATHY, FATAL INFANTILE, DUE TO CYTOCHROME c OXIDASE DEFICIENCY 2; CEMCOX2" -"OMIM:609893","HYPOTHYROIDISM, CONGENITAL, NONGOITROUS, 3; CHNG3" -"DOID:11678","onchocerciasis" -"DOID:12720","cerebral atherosclerosis" -"OMIM:609903","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 5; SLEB5" -"DOID:9281","phenylketonuria" -"OMIM:615120","MYASTHENIC SYNDROME, CONGENITAL, 8; CMS8" -"OMIM:615121","STOMATIN-LIKE PROTEIN-2, HYPERPHOSPHORYLATION OF" -"OMIM:609909","CARDIOMYOPATHY, DILATED, 1P; CMD1P" -"DOID:14755","argininosuccinic aciduria" -"DOID:10230","aortic atherosclerosis" -"OMIM:615122","LYMPHOPROLIFERATIVE SYNDROME 2; LPFS2" -"OMIM:609913","RETINITIS PIGMENTOSA 32; RP32" -"DOID:0050798","cerebral creatine deficiency syndrome" -"OMIM:609915","CARDIOMYOPATHY, DILATED, 1Q; CMD1Q" -"OMIM:615127","EPILEPSY, FAMILIAL ADULT MYOCLONIC, 4; FAME4" -"DOID:222","perichondritis of auricle" -"OMIM:609918","GALLBLADDER DISEASE 2; GBD2" -"OMIM:615134","MELANOMA, CUTANEOUS MALIGNANT, SUSCEPTIBILITY TO, 9; CMM9" -"OMIM:615135","MAPLE SYRUP URINE DISEASE, MILD VARIANT; MSUDMV" -"OMIM:609919","GALLBLADDER DISEASE 3; GBD3" -"DOID:0060350","adenine phosphoribosyltransferase deficiency" -"OMIM:609923","RETINITIS PIGMENTOSA 31; RP31" -"DOID:9267","urea cycle disorder" -"OMIM:615139","FACIAL DYSMORPHISM, IMMUNODEFICIENCY, LIVEDO, AND SHORT STATURE; FILS" -"OMIM:609924","AMINOACYLASE 1 DEFICIENCY; ACY1D" -"OMIM:615145","MICROPHTHALMIA, ISOLATED, WITH COLOBOMA 9; MCOPCB9" -"DOID:2347","generalized atherosclerosis" -"OMIM:609939","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 6; SLEB6" -"DOID:14497","Wolman disease" -"OMIM:615147","RETINAL DYSTROPHY, IRIS COLOBOMA, AND COMEDOGENIC ACNE SYNDROME; RDCCAS" -"OMIM:615155","STEEL SYNDROME; STLS" -"OMIM:609941","DEAFNESS, AUTOSOMAL RECESSIVE 51; DFNB51" -"DOID:9280","carbamoyl phosphate synthetase I deficiency disease" -"DOID:0110909","inflammatory bowel disease 25" -"DOID:13169","spermatic cord cancer" -"OMIM:615156","PROGRESSIVE EXTERNAL OPHTHALMOPLEGIA WITH MITOCHONDRIAL DNA DELETIONS, AUTOSOMAL DOMINANT 6; PEOA6" -"OMIM:609942","NOONAN SYNDROME 3; NS3" -"DOID:1884","viral hepatitis" -"OMIM:615157","MITOCHONDRIAL COMPLEX III DEFICIENCY, NUCLEAR TYPE 2; MC3DN2" -"OMIM:609943","HYPERTRICHOSIS, HYPERKERATOSIS, MENTAL RETARDATION, AND DISTINCTIVE FACIAL FEATURES" -"OMIM:609944","ECTODERMAL DYSPLASIA, SENSORINEURAL HEARING LOSS, AND DISTINCTIVE FACIAL FEATURES" -"DOID:13523","loiasis" -"OMIM:615158","MITOCHONDRIAL COMPLEX III DEFICIENCY, NUCLEAR TYPE 3; MC3DN3" -"OMIM:609945","BRACHYPHALANGY, POLYDACTYLY, AND TIBIAL APLASIA/HYPOPLASIA" -"DOID:0050573","2-hydroxyglutaric aciduria" -"OMIM:615159","MITOCHONDRIAL COMPLEX III DEFICIENCY, NUCLEAR TYPE 4; MC3DN4" -"OMIM:609946","DEAFNESS, AUTOSOMAL RECESSIVE 47; DFNB47" -"OMIM:615160","MITOCHONDRIAL COMPLEX III DEFICIENCY, NUCLEAR TYPE 5; MC3DN5" -"OMIM:609952","DEAFNESS, AUTOSOMAL RECESSIVE 55; DFNB55" -"DOID:14422","dipetalonemiasis" -"OMIM:615162","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 35; MRT35" -"OMIM:615163","CONE-ROD DYSTROPHY 17; CORD17" -"OMIM:609954","ASPERGER SYNDROME, SUSCEPTIBILITY TO, 4; ASPG4" -"DOID:0060159","organic acidemia" -"OMIM:609955","FIBROMATOSIS, GINGIVAL, 3; GINGF3" -"OMIM:615170","WAHAB SYNDROME" -"DOID:857","multiple carboxylase deficiency" -"DOID:1394","urinary schistosomiasis" -"OMIM:181460","SCHISTOSOMA MANSONI INFECTION, SUSCEPTIBILITY/RESISTANCE TO" -"OMIM:609958","ASTHMA-RELATED TRAITS, SUSCEPTIBILITY TO, 3" -"OMIM:615174","L-THREONINE DEHYDROGENASE, PSEUDOGENE; TDH" -"DOID:0110115","autoimmune lymphoproliferative syndrome type 2A" -"DOID:1612","breast cancer" -"OMIM:181500","SCHIZOPHRENIA; SCZD" -"DOID:0050721","serine deficiency" -"OMIM:615179","ALBINISM, OCULOCUTANEOUS, TYPE VII; OCA7" -"OMIM:609965","DEAFNESS, AUTOSOMAL DOMINANT 53; DFNA53" -"DOID:0090142","cystathioninuria" -"OMIM:615181","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 11; MDDGA11" -"OMIM:609968","HYPERINSULINEMIC HYPOGLYCEMIA, FAMILIAL, 5; HHF5" -"DOID:10125","acute hydrops keratoconus" -"DOID:0110396","retinitis pigmentosa 50" -"DOID:4247","coronary restenosis" -"DOID:11472","subglottis cancer" -"OMIM:264140","PRUNE BELLY SYNDROME WITH PULMONIC STENOSIS, MENTAL RETARDATION, AND DEAFNESS" -"OMIM:100300","ADAMS-OLIVER SYNDROME 1; AOS1" -"OMIM:147900","JOINT LAXITY, FAMILIAL" -"OMIM:264180","PSEUDODIASTROPHIC DYSPLASIA" -"DOID:4058","gallbladder sarcoma" -"OMIM:147920","KABUKI SYNDROME 1; KABUK1" -"DOID:0110355","retinitis pigmentosa 32" -"OMIM:264270","PSEUDOHERMAPHRODITISM, FEMALE, WITH SKELETAL ANOMALIES" -"OMIM:149400","HYPEREKPLEXIA, HEREDITARY 1; HKPX1" -"OMIM:264300","17-BETA HYDROXYSTEROID DEHYDROGENASE III DEFICIENCY" -"OMIM:147860","INTERFERON, BETA-3; IFNB3" -"DOID:9775","diastolic heart failure" -"OMIM:264350","PSEUDOHYPOALDOSTERONISM, TYPE I, AUTOSOMAL RECESSIVE; PHA1B" -"OMIM:149200","KNUCKLE PADS, LEUKONYCHIA, AND SENSORINEURAL DEAFNESS" -"OMIM:264420","FUNDUS DYSTROPHY, PSEUDOINFLAMMATORY, RECESSIVE FORM" -"OMIM:149300","NAIL DISORDER, NONSYNDROMIC CONGENITAL, 2; NDNC2" -"OMIM:107970","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 1; ARVD1" -"OMIM:264470","PEROXISOMAL ACYL-CoA OXIDASE DEFICIENCY" -"DOID:0110403","retinitis pigmentosa 13" -"OMIM:108120","ARTHROGRYPOSIS, DISTAL, TYPE 1A; DA1A" -"OMIM:147950","HYPOGONADOTROPIC HYPOGONADISM 2 WITH OR WITHOUT ANOSMIA; HH2" -"DOID:2600","laryngeal carcinoma" -"OMIM:148840","KLEINE-LEVIN HIBERNATION SYNDROME" -"OMIM:264475","PSEUDOPAPILLEDEMA, OCULAR HYPOTELORISM, BLEPHAROPHIMOSIS, AND HAND ANOMALIES" -"DOID:13100","intracranial vasospasm" -"OMIM:264480","PSEUDOTRISOMY 13 SYNDROME" -"DOID:0110362","retinitis pigmentosa 58" -"OMIM:144010","HYPERCHOLESTEROLEMIA, AUTOSOMAL DOMINANT, TYPE B" -"DOID:12358","patulous eustachian tube" -"OMIM:144020","HYPERCHOLESTEROLEMIA SUPPRESSOR" -"DOID:10113","trypanosomiasis" -"OMIM:264500","PSEUDOURIDINURIA AND MENTAL DEFECT" -"OMIM:614468","FAMILIAL COLD AUTOINFLAMMATORY SYNDROME 3; FCAS3" -"OMIM:108100","ARTHRITIS, SACROILIAC" -"OMIM:136540","FRAGILE SITE 10q23" -"DOID:3805","porokeratosis" -"OMIM:149000","KLIPPEL-TRENAUNAY-WEBER SYNDROME" -"OMIM:264600","PSEUDOVAGINAL PERINEOSCROTAL HYPOSPADIAS; PPSH" -"OMIM:264700","VITAMIN D HYDROXYLATION-DEFICIENT RICKETS, TYPE 1A; VDDR1A" -"OMIM:108000","ARTERIES, ANOMALIES OF" -"OMIM:144120","HYPERIMMUNOGLOBULIN G1(A1) SYNDROME" -"OMIM:264800","PSEUDOXANTHOMA ELASTICUM; PXE" -"DOID:12298","intrahepatic gall duct cancer" -"OMIM:265000","MULTIPLE PTERYGIUM SYNDROME, ESCOBAR VARIANT; EVMPS" -"DOID:8167","gallbladder melanoma" -"OMIM:265050","3MC SYNDROME 2; 3MC2" -"OMIM:143890","HYPERCHOLESTEROLEMIA, FAMILIAL" -"DOID:8135","gallbladder lymphoma" -"DOID:0110421","late-adult onset retinitis pigmentosa" -"DOID:12148","alveolar echinococcosis" -"OMIM:108200","ARTHROGRYPOSIS, DISTAL, TYPE 6; DA6" -"DOID:0060769","T-cell immunodeficiency, congenital alopecia, and nail dystrophy" -"OMIM:265100","PULMONARY ALVEOLAR MICROLITHIASIS" -"DOID:1921","Klinefelter's syndrome" -"DOID:12568","dyscalculia" -"OMIM:265120","SURFACTANT METABOLISM DYSFUNCTION, PULMONARY, 1; SMDP1" -"DOID:0110353","retinitis pigmentosa 20" -"OMIM:136550","MACULAR DYSTROPHY, RETINAL, 1, NORTH CAROLINA TYPE; MCDR1" -"DOID:2450","central retinal vein occlusion" -"OMIM:265140","PULMONARY ARTERIOVENOUS FISTULAS" -"OMIM:108145","ARTHROGRYPOSIS, DISTAL, TYPE 5; DA5" -"DOID:4948","gallbladder carcinoma" -"DOID:3908","non-small cell lung carcinoma" -"OMIM:147891","ISCHIOCOXOPODOPATELLAR SYNDROME; ICPPS" -"OMIM:265150","PULMONARY ATRESIA WITH INTACT VENTRICULAR SEPTUM" -"OMIM:265200","PULMONARY BULLAE CAUSING PNEUMOTHORAX" -"OMIM:265300","LYMPHANGIECTASIA, PULMONARY, CONGENITAL; CPL" -"OMIM:144050","HYPERHEPARINEMIA" -"DOID:12347","osteogenesis imperfecta" -"OMIM:147820","INTERNAL CAROTID ARTERY, SPONTANEOUS DISSECTION OF" -"OMIM:144150","HYPERKERATOSIS LENTICULARIS PERSTANS; HLP" -"DOID:0110401","retinitis pigmentosa 74" -"OMIM:265380","ALVEOLAR CAPILLARY DYSPLASIA WITH MISALIGNMENT OF PULMONARY VEINS; ACDMPV" -"OMIM:108050","ARTERITIS, FAMILIAL GRANULOMATOUS, WITH JUVENILE POLYARTHRITIS" -"OMIM:265400","PULMONARY HYPERTENSION, PRIMARY, AUTOSOMAL RECESSIVE" -"DOID:0110366","retinitis pigmentosa 33" -"OMIM:265430","LUNG AGENESIS" -"DOID:0090013","severe combined immunodeficiency, autosomal recessive, T cell-negative, B cell-negative, Nk cell-positive" -"DOID:1726","partial of retinal vein occlusion" -"DOID:12306","vitiligo" -"OMIM:265450","PULMONARY VENOOCCLUSIVE DISEASE 1, AUTOSOMAL DOMINANT; PVOD1" -"DOID:0110364","retinitis pigmentosa 54" -"OMIM:265500","PULMONIC STENOSIS" -"OMIM:120790","COMPLEMENT COMPONENT 4, PARTIAL DEFICIENCY OF" -"DOID:10927","gastrojejunal ulcer" -"DOID:2000","otosalpingitis" -"OMIM:148820","WAARDENBURG SYNDROME, TYPE 3; WS3" -"DOID:0110388","retinitis pigmentosa 10" -"OMIM:265600","PULMONIC STENOSIS AND CONGENITAL NEPHROSIS" -"OMIM:108010","ARTERIOVENOUS MALFORMATIONS OF THE BRAIN" -"OMIM:265800","PYCNODYSOSTOSIS" -"OMIM:149100","KNUCKLE PADS" -"OMIM:265850","PYGMY" -"DOID:3747","esophagus verrucous carcinoma" -"OMIM:265880","PYKNOACHONDROGENESIS" -"OMIM:144110","HYPERHIDROSIS PALMARIS ET PLANTARIS; HYPRPP" -"OMIM:265900","PYLE DISEASE; PYL" -"OMIM:144100","HYPERHIDROSIS, GUSTATORY; HYPRG" -"DOID:2998","testicular cancer" -"OMIM:265950","PYLORIC ATRESIA" -"DOID:749","active peptic ulcer disease" -"OMIM:266100","EPILEPSY, PYRIDOXINE-DEPENDENT; EPD" -"DOID:2224","essential thrombocythemia" -"OMIM:266120","URIDINE 5-PRIME MONOPHOSPHATE HYDROLASE DEFICIENCY, HEMOLYTIC ANEMIA DUE TO" -"DOID:0060181","ischemic colitis" -"DOID:752","peptic ulcer perforation" -"OMIM:266130","GLUTATHIONE SYNTHETASE DEFICIENCY; GSSD" -"DOID:10138","xerophthalmia" -"OMIM:120970","CONE-ROD DYSTROPHY 2; CORD2" -"DOID:0110399","retinitis pigmentosa 37" -"OMIM:266140","PYROPOIKILOCYTOSIS, HEREDITARY; HPP" -"OMIM:609975","HYPERINSULINEMIC HYPOGLYCEMIA, FAMILIAL, 4; HHF4" -"OMIM:302803","CHARCOT-MARIE-TOOTH PERONEAL MUSCULAR ATROPHY, X-LINKED, WITH APLASIA CUTIS CONGENITA" -"OMIM:609981","NATURAL KILLER CELL AND GLUCOCORTICOID DEFICIENCY WITH DNA REPAIR DEFECT; NKGCD" -"OMIM:174810","FAMILIAL EXPANSILE OSTEOLYSIS; FEO" -"OMIM:302900","CHARCOT-MARIE-TOOTH PERONEAL MUSCULAR ATROPHY AND FRIEDREICH ATAXIA, COMBINED" -"OMIM:302905","ABRUZZO-ERICKSON SYNDROME; ABERS" -"OMIM:609985","PANIC DISORDER 3" -"OMIM:302950","CHONDRODYSPLASIA PUNCTATA 1, X-LINKED RECESSIVE; CDPX1" -"OMIM:609989","METAPHYSEAL CHONDRODYSPLASIA WITH CONE-SHAPED EPIPHYSES, NORMAL HAIR, AND NORMAL HANDS" -"DOID:5531","ovarian squamous cell carcinoma" -"OMIM:175200","PEUTZ-JEGHERS SYNDROME; PJS" -"DOID:2146","ovary sarcoma" -"OMIM:302960","CHONDRODYSPLASIA PUNCTATA 2, X-LINKED DOMINANT; CDPX2" -"DOID:2153","ovarian Wilms' cancer" -"OMIM:609990","TRICHOSCYPHODYSPLASIA" -"OMIM:609993","OSTEOSCLEROSIS WITH ICHTHYOSIS AND PREMATURE OVARIAN FAILURE" -"DOID:0090062","familial cold autoinflammatory syndrome 1" -"DOID:9743","diabetic neuropathy" -"DOID:6898","ovary mixed epithelial carcinoma" -"OMIM:303100","CHOROIDEREMIA; CHM" -"OMIM:303110","CHOROIDEREMIA, DEAFNESS, AND MENTAL RETARDATION" -"OMIM:174800","MCCUNE-ALBRIGHT SYNDROME; MAS" -"OMIM:609994","MYOPIA 11, AUTOSOMAL DOMINANT; MYP11" -"OMIM:609995","MYOPIA 12, AUTOSOMAL DOMINANT; MYP12" -"DOID:1614","male breast cancer" -"OMIM:303350","MASA SYNDROME" -"OMIM:610001","ARTHROGRYPOSIS MULTIPLEX WITH DEAFNESS, INGUINAL HERNIAS, AND EARLY DEATH" -"OMIM:303400","CLEFT PALATE WITH OR WITHOUT ANKYLOGLOSSIA, X-LINKED; CPX" -"OMIM:175500","POLYPOSIS, SKIN PIGMENTATION, ALOPECIA, AND FINGERNAIL CHANGES" -"OMIM:610003","CEROID LIPOFUSCINOSIS, NEURONAL, 8, NORTHERN EPILEPSY VARIANT" -"OMIM:303600","COFFIN-LOWRY SYNDROME; CLS" -"OMIM:175100","FAMILIAL ADENOMATOUS POLYPOSIS 1; FAP1" -"DOID:5513","Pediculus humanus corporis infestation" -"OMIM:303650","COLONIC ATRESIA" -"OMIM:610006","2-METHYLBUTYRYL-CoA DEHYDROGENASE DEFICIENCY" -"DOID:2152","ovary epithelial cancer" -"DOID:13760","Pthirus pubis infestation" -"OMIM:610015","GLUTAMINE DEFICIENCY, CONGENITAL" -"OMIM:303700","BLUE CONE MONOCHROMACY; BCM" -"OMIM:610017","MULTIPLE SYNOSTOSES SYNDROME 2; SYNS2" -"OMIM:303800","COLORBLINDNESS, PARTIAL, DEUTAN SERIES; CBD" -"OMIM:610019","CATARACT 18; CTRCT18" -"OMIM:303900","COLORBLINDNESS, PARTIAL, PROTAN SERIES; CBP" -"OMIM:304020","CONE-ROD DYSTROPHY, X-LINKED, 1; CORDX1" -"OMIM:610021","HYPERINSULINEMIC HYPOGLYCEMIA, FAMILIAL, 7; HHF7" -"OMIM:610023","BRACHYDACTYLY, COLOBOMA, AND ANTERIOR SEGMENT DYSGENESIS" -"OMIM:304030","CONE DYSTROPHY, X-LINKED, WITH TAPETAL-LIKE SHEEN" -"DOID:0060893","juvenile-onset Parkinson disease" -"DOID:813","septic arthritis" -"OMIM:175020","POLYPOSIS, GASTRIC" -"OMIM:304050","AICARDI SYNDROME; AIC" -"OMIM:610024","RETINAL CONE DYSTROPHY 3A; RCD3A" -"OMIM:304100","CORPUS CALLOSUM, PARTIAL AGENESIS OF, X-LINKED" -"OMIM:610031","CORTICAL DYSPLASIA, COMPLEX, WITH OTHER BRAIN MALFORMATIONS 7; CDCBM7" -"OMIM:304110","CRANIOFRONTONASAL SYNDROME; CFNS" -"OMIM:610042","PITT-HOPKINS-LIKE SYNDROME 1; PTHSL1" -"OMIM:610048","CORNEAL DYSTROPHY, CONGENITAL STROMAL; CSCD" -"OMIM:304120","OTOPALATODIGITAL SYNDROME, TYPE II; OPD2" -"OMIM:304150","OCCIPITAL HORN SYNDROME; OHS" -"OMIM:610064","OPIOID DEPENDENCE, SUSCEPTIBILITY TO, 1" -"DOID:48","male reproductive system disease" -"OMIM:304200","CUTIS VERTICIS GYRATA, THYROID APLASIA, AND MENTAL RETARDATION" -"OMIM:610065","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 7; SLEB7" -"OMIM:304300","CYANIDE, INABILITY TO SMELL" -"OMIM:610066","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 8; SLEB8" -"OMIM:610069","POLYPOSIS SYNDROME, HEREDITARY MIXED, 2; HMPS2" -"OMIM:304340","PETTIGREW SYNDROME; PGS" -"DOID:987","alopecia" -"OMIM:610071","HYPERPARATHYROIDISM 3; HRPT3" -"OMIM:304350","DEAFNESS-HYPOGONADISM SYNDROME" -"DOID:9736","blue drum syndrome" -"DOID:2156","ovarian germ cell cancer" -"OMIM:610090","PYRIDOXAMINE 5-PRIME-PHOSPHATE OXIDASE DEFICIENCY; PNPOD" -"OMIM:304400","DEAFNESS, X-LINKED 2; DFNX2" -"OMIM:174900","JUVENILE POLYPOSIS SYNDROME; JPS" -"DOID:0111128","focal segmental glomerulosclerosis 1" -"OMIM:610092","MICROPHTHALMIA, ISOLATED, WITH COLOBOMA 3; MCOPCB3" -"OMIM:304500","DEAFNESS, X-LINKED 1; DFNX1" -"DOID:3696","acute sanguinous otitis media" -"OMIM:304700","MOHR-TRANEBJAERG SYNDROME; MTS" -"OMIM:610093","MICROPHTHALMIA, ISOLATED 2; MCOP2" -"OMIM:175505","POLYPOSIS OF GASTRIC FUNDUS WITHOUT POLYPOSIS COLI" -"OMIM:610099","MYOPATHY, DISTAL, 3; MPD3" -"DOID:0050934","ovarian clear cell carcinoma" -"OMIM:304730","DERMOIDS OF CORNEA; CND" -"DOID:3840","craniopharyngioma" -"OMIM:304790","IMMUNODYSREGULATION, POLYENDOCRINOPATHY, AND ENTEROPATHY, X-LINKED; IPEX" -"OMIM:610100","GIANT AXONAL NEUROPATHY 2, AUTOSOMAL DOMINANT; GAN2" -"OMIM:175400","POLYPOSIS, INTESTINAL, SCATTERED AND DISCRETE" -"DOID:0111105","maturity-onset diabetes of the young type 8" -"DOID:0060251","sclerosteosis" -"OMIM:610102","COMPLEMENT COMPONENT 7 DEFICIENCY; C7D" -"OMIM:304800","DIABETES INSIPIDUS, NEPHROGENIC, X-LINKED" -"DOID:0050933","ovarian serous carcinoma" -"OMIM:304900","DIABETES INSIPIDUS, NEUROHYPOPHYSEAL TYPE" -"DOID:13365","reading disorder" -"OMIM:175050","JUVENILE POLYPOSIS/HEREDITARY HEMORRHAGIC TELANGIECTASIA SYNDROME; JPHT" -"OMIM:610114","STATURE QUANTITATIVE TRAIT LOCUS 8; STQTL8" -"OMIM:304950","DYGGVE-MELCHIOR-CLAUSEN SYNDROME, X-LINKED" -"DOID:687","hepatoblastoma" -"DOID:2361","macrocytic anemia" -"DOID:3713","ovary adenocarcinoma" -"OMIM:610125","MICROPHTHALMIA, SYNDROMIC 5; MCOPS5" -"OMIM:305000","DYSKERATOSIS CONGENITA, X-LINKED; DKCX" -"OMIM:610127","CEROID LIPOFUSCINOSIS, NEURONAL, 10; CLN10" -"OMIM:175450","POLYPOSIS, INTESTINAL, WITH MULTIPLE EXOSTOSES" -"DOID:780","placenta disease" -"OMIM:305100","ECTODERMAL DYSPLASIA 1, HYPOHIDROTIC, X-LINKED; XHED" -"OMIM:610131","PROGRESSIVE EXTERNAL OPHTHALMOPLEGIA WITH MITOCHONDRIAL DNA DELETIONS, AUTOSOMAL DOMINANT 4; PEOA4" -"DOID:0080032","craniodiaphyseal dysplasia" -"DOID:5501","Pediculus humanus capitis infestation" -"OMIM:610136","DEVRIENDT SYNDROME" -"OMIM:305200","EHLERS-DANLOS SYNDROME, TYPE V" -"OMIM:615182","COMBINED D-2- AND L-2-HYDROXYGLUTARIC ACIDURIA; D2L2AD" -"OMIM:615184","CARDIOMYOPATHY, DILATED, 1II; CMD1II" -"DOID:0090102","autosomal dominant macrothrombocytopenia TUBB1-related" -"DOID:7827","adult extraosseous osteosarcoma" -"DOID:2234","focal epilepsy" -"OMIM:615185","CHARCOT-MARIE-TOOTH DISEASE, DOMINANT INTERMEDIATE F; CMTDIF" -"OMIM:615188","CATARACT 39, MULTIPLE TYPES; CTRCT39" -"OMIM:615190","DYSKERATOSIS CONGENITA, AUTOSOMAL RECESSIVE 5; DKCB5" -"DOID:4271","microsporidiosis" -"DOID:2776","adamantinoma" -"OMIM:615191","LISSENCEPHALY 5; LIS5" -"OMIM:615192","BIRTH WEIGHT QUANTITATIVE TRAIT LOCUS 4; BWQTL4" -"DOID:0060534","hepatoid adenocarcinoma" -"OMIM:615193","BLEEDING DISORDER, PLATELET-TYPE, 15; BDPLT15" -"DOID:2832","geotrichosis" -"OMIM:615197","RESTLESS LEGS SYNDROME, SUSCEPTIBILITY TO, 8; RLS8" -"DOID:4917","villous adenocarcinoma" -"OMIM:615198","OSTEOSCLEROTIC METAPHYSEAL DYSPLASIA; OSMD" -"OMIM:615206","IMMUNODEFICIENCY 11; IMD11A" -"DOID:2739","Gilbert syndrome" -"OMIM:615207","IL21R IMMUNODEFICIENCY" -"DOID:7851","pancreatic intraductal papillary-mucinous adenoma" -"OMIM:615214","AGAMMAGLOBULINEMIA 7, AUTOSOMAL RECESSIVE; AGM7" -"OMIM:615217","ATAXIA-OCULOMOTOR APRAXIA 3; AOA3" -"DOID:0110965","brachydactyly type A2" -"DOID:11339","pneumocystosis" -"OMIM:615219","HYDROCEPHALUS, NONSYNDROMIC, AUTOSOMAL RECESSIVE 2; HYC2" -"DOID:10648","acute inferoposterior infarction" -"DOID:7207","lung combined large cell neuroendocrine carcinoma" -"OMIM:615220","OSTEOGENESIS IMPERFECTA, TYPE XV; OI15" -"OMIM:615221","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 16; BMND16" -"DOID:0110957","Gaucher's disease type I" -"DOID:3030","mucinous adenocarcinoma" -"OMIM:615222","SMITH-MCCORT DYSPLASIA 2; SMC2" -"DOID:5453","pulmonary venoocclusive disease" -"DOID:10032","hyperlucent lung" -"OMIM:615224","ADVANCED SLEEP PHASE SYNDROME, FAMILIAL, 2; FASPS2" -"DOID:10030","interstitial emphysema" -"DOID:4024","scirrhous adenocarcinoma" -"OMIM:615225","PALMOPLANTAR CARCINOMA, MULTIPLE SELF-HEALING; MSPC" -"DOID:3774","chordoid glioma" -"OMIM:615226","POLYDACTYLY, POSTAXIAL, TYPE A6; PAPA6" -"DOID:1863","skull cancer" -"OMIM:615228","MITOCHONDRIAL COMPLEX V (ATP SYNTHASE) DEFICIENCY, NUCLEAR TYPE 4; MC5DN4" -"DOID:0060894","early-onset Parkinson disease" -"OMIM:615232","SCHIZOPHRENIA 18; SCZD18" -"DOID:9407","strictly posterior acute myocardial infarction" -"OMIM:615233","RETINITIS PIGMENTOSA 66; RP66" -"DOID:10266","subendocardial infarction acute myocardial infarction" -"DOID:0050304","aniseikonia" -"DOID:0050290","trichosporonosis" -"OMIM:615234","ANEMIA, HYPOCHROMIC MICROCYTIC, WITH IRON OVERLOAD 2; AHMIO2" -"OMIM:615235","CARDIOMYOPATHY, DILATED, 1JJ; CMD1JJ" -"DOID:3493","signet ring cell adenocarcinoma" -"DOID:4360","epithelioid cell melanoma" -"DOID:13036","tick-borne relapsing fever" -"OMIM:615236","WOODS SYNDROME" -"DOID:0050289","fusariosis" -"OMIM:615237","CONGENITAL SHORT BOWEL SYNDROME; CSBS" -"DOID:3111","cystadenocarcinoma" -"OMIM:615238","LIPODYSTROPHY, FAMILIAL PARTIAL, TYPE 5; FPLD5" -"OMIM:185100","STRABISMUS, SUSCEPTIBILITY TO" -"OMIM:615244","NEPHROTIC SYNDROME, TYPE 8; NPHS8" -"OMIM:615248","CARDIOMYOPATHY, DILATED, 1KK; CMD1KK" -"OMIM:615249","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 12; MDDGA12" -"DOID:13690","acute gonococcal cystitis" -"DOID:10651","acute anterolateral myocardial infarction" -"OMIM:615264","BLOOD GROUP, VEL SYSTEM; VEL" -"DOID:4929","tubular adenocarcinoma" -"OMIM:615266","HYPOGONADOTROPIC HYPOGONADISM 17 WITH OR WITHOUT ANOSMIA; HH17" -"DOID:3112","papillary adenocarcinoma" -"DOID:182","calcinosis" -"OMIM:615267","HYPOGONADOTROPIC HYPOGONADISM 18 WITH OR WITHOUT ANOSMIA; HH18" -"OMIM:615268","CEREBELLAR ATAXIA, MENTAL RETARDATION, AND DYSEQUILIBRIUM SYNDROME 4; CAMRQ4" -"DOID:2560","morphine dependence" -"OMIM:268025","RETINITIS PIGMENTOSA, LATE-ADULT ONSET" -"OMIM:268040","RETINOHEPATOENDOCRINOLOGIC SYNDROME" -"OMIM:268050","RETINOPATHY, PIGMENTARY, AND MENTAL RETARDATION" -"DOID:707","B-cell lymphoma" -"OMIM:268060","RETINOPATHY, PERICENTRAL PIGMENTARY, AUTOSOMAL RECESSIVE" -"DOID:0110996","Joubert syndrome 27" -"OMIM:268080","RETINOSCHISIS OF FOVEA" -"OMIM:116800","CATARACT 5, MULTIPLE TYPES; CTRCT5" -"OMIM:268100","ENHANCED S-CONE SYNDROME; ESCS" -"OMIM:116400","CATARACT 41; CTRCT41" -"DOID:118","pericardial effusion" -"OMIM:268130","REVESZ SYNDROME" -"OMIM:268150","RH-NULL, REGULATOR TYPE; RHN" -"OMIM:268200","MYOGLOBINURIA, ACUTE RECURRENT, AUTOSOMAL RECESSIVE" -"OMIM:268210","RHABDOMYOSARCOMA, EMBRYONAL, 1; RMSE1" -"DOID:711","refractory hairy cell leukemia" -"OMIM:268220","RHABDOMYOSARCOMA 2; RMS2" -"OMIM:116600","CATARACT 6, MULTIPLE TYPES; CTRCT6" -"OMIM:268240","RHEUMATIC FEVER-RELATED ANTIGEN" -"DOID:11111","hydronephrosis" -"DOID:8512","puerperal pulmonary embolism" -"OMIM:268250","RHIZOMELIC SYNDROME" -"DOID:8719","in situ carcinoma" -"OMIM:268300","ROBERTS SYNDROME; RBS" -"DOID:13725","beriberi" -"OMIM:109730","AORTIC VALVE DISEASE 1; AOVD1" -"DOID:0060361","punctate palmoplantar keratoderma" -"OMIM:268305","ROBIN SEQUENCE WITH CLEFT MANDIBLE AND LIMB ANOMALIES" -"OMIM:268310","ROBINOW SYNDROME, AUTOSOMAL RECESSIVE; RRS" -"OMIM:116700","CATARACT 13 WITH ADULT i PHENOTYPE; CTRCT13" -"DOID:7693","abdominal aortic aneurysm" -"OMIM:268315","ROD-CONE DYSTROPHY, SENSORINEURAL DEAFNESS, AND FANCONI-TYPE RENAL DYSFUNCTION" -"OMIM:268320","RODRIGUES BLINDNESS" -"DOID:8649","tongue cancer" -"DOID:680","tauopathy" -"OMIM:116860","CEREBRAL CAVERNOUS MALFORMATIONS; CCM" -"DOID:0110916","hereditary spherocytosis type 1" -"OMIM:268400","ROTHMUND-THOMSON SYNDROME; RTS" -"OMIM:268500","ROWLEY-ROSENBERG SYNDROME" -"DOID:0090065","familial cold autoinflammatory syndrome 4" -"OMIM:268650","RUDIGER SYNDROME" -"DOID:115","cardiac tamponade" -"OMIM:185300","STURGE-WEBER SYNDROME; SWS" -"OMIM:185460","SULFHEMOGLOBINEMIA, CONGENITAL" -"OMIM:268700","SACCHAROPINURIA" -"OMIM:268800","SANDHOFF DISEASE" -"OMIM:109670","BETA-ADRENERGIC STIMULATION, RESPONSE TO; BAS" -"OMIM:109740","BIFID NOSE, AUTOSOMAL DOMINANT" -"OMIM:185200","STRIAE DISTENSAE, FAMILIAL" -"OMIM:182270","KETONE COMPOUNDS, ABILITY TO SMELL" -"DOID:0110856","posterior polymorphous corneal dystrophy 2" -"OMIM:268850","RICHIERI-COSTA/GUION-ALMEIDA SYNDROME" -"DOID:0110920","hereditary spherocytosis type 5" -"OMIM:185480","SUPRABULBAR PARESIS, CONGENITAL" -"OMIM:268900","SARCOSINEMIA; SARCOS" -"OMIM:269000","SC PHOCOMELIA SYNDROME" -"OMIM:185500","SUPRAVALVULAR AORTIC STENOSIS; SVAS" -"OMIM:269150","SCHINZEL-GIEDION MIDFACE RETRACTION SYNDROME" -"OMIM:185540","SURFACE ANTIGEN, GLYCOPROTEIN 75" -"OMIM:269160","SCHIZENCEPHALY" -"OMIM:185600","SYMPHALANGISM OF TOES" -"DOID:4233","clear cell sarcoma" -"OMIM:269200","AUTOIMMUNE POLYENDOCRINE SYNDROME, TYPE II; APS2" -"OMIM:185610","SURFACE POLYPEPTIDES, ANONYMOUS" -"DOID:782","renal infectious disease" -"OMIM:269250","SCHNECKENBECKEN DYSPLASIA" -"OMIM:185650","SYMPHALANGISM, C. S. LEWIS TYPE" -"OMIM:614575","CEREBELLAR ATAXIA, NEUROPATHY, AND VESTIBULAR AREFLEXIA SYNDROME; CANVAS" -"DOID:14450","46 XX gonadal dysgenesis" -"OMIM:608796","MOYAMOYA DISEASE 3; MYMY3" -"OMIM:614576","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIl; CDG2L" -"OMIM:614582","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 9; COXPD9" -"OMIM:608799","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ie; CDG1E" -"OMIM:608800","SUDDEN INFANT DEATH WITH DYSGENESIS OF THE TESTES SYNDROME; SIDDT" -"OMIM:614583","BARAITSER-WINTER SYNDROME 2; BRWS2" -"OMIM:614588","DYSTONIA 21; DYT21" -"OMIM:608804","LEUKODYSTROPHY, HYPOMYELINATING, 2; HLD2" -"DOID:7474","malignant pleural mesothelioma" -"OMIM:608805","AVASCULAR NECROSIS OF FEMORAL HEAD, PRIMARY, 1; ANFH1" -"OMIM:614590","PODOCONIOSIS, SUSCEPTIBILITY TO; PDCOS" -"OMIM:614592","BENT BONE DYSPLASIA SYNDROME; BBDS" -"OMIM:608807","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2J; LGMD2J" -"DOID:3959","adrenal cortical adenocarcinoma" -"OMIM:608808","TRANSPOSITION OF THE GREAT ARTERIES, DEXTRO-LOOPED 1; DTGA1" -"OMIM:614594","PALMOPLANTAR KERATODERMA, MUTILATING, WITH PERIORIFICIAL KERATOTIC PLAQUES" -"DOID:13386","gastrointestinal anthrax" -"DOID:3044","food allergy" -"OMIM:614595","PREECLAMPSIA/ECLAMPSIA 5; PEE5" -"OMIM:608809","LEUKOENCEPHALOPATHY, ARTHRITIS, COLITIS, AND HYPOGAMMAGLOBULINEMA; LACH" -"DOID:14032","malignant parietal pleura tumor" -"OMIM:608810","MYOPATHY, MYOFIBRILLAR, 2; MFM2" -"OMIM:614602","TRICHOHEPATOENTERIC SYNDROME 2; THES2" -"OMIM:614607","COFFIN-SIRIS SYNDROME 2; CSS2" -"OMIM:608811","METAPHYSEAL UNDERMODELING, SPONDYLAR DYSPLASIA, AND OVERGROWTH" -"DOID:5546","femoral cancer" -"OMIM:614608","COFFIN-SIRIS SYNDROME 3; CSS3" -"OMIM:608812","COLORECTAL CANCER, SUSCEPTIBILITY TO, 1; CRCS1" -"OMIM:608814","LATERAL SEMICIRCULAR CANAL MALFORMATION, FAMILIAL, WITH EXTERNAL AND MIDDLE EAR ABNORMALITIES" -"OMIM:614609","COFFIN-SIRIS SYNDROME 4; CSS4" -"DOID:0090061","familial cold autoinflammatory syndrome" -"OMIM:614613","ACRODYSOSTOSIS 2 WITH OR WITHOUT HORMONE RESISTANCE; ACRDYS2" -"OMIM:608816","MYOCLONIC EPILEPSY, JUVENILE, SUSCEPTIBILITY TO, 3; EJM3" -"DOID:4513","gallbladder angiosarcoma" -"OMIM:614614","DEAFNESS, AUTOSOMAL DOMINANT 4B; DFNA4B" -"OMIM:608831","RESTLESS LEGS SYNDROME, SUSCEPTIBILITY TO, 2; RLS2" -"OMIM:614615","JOUBERT SYNDROME 17; JBTS17" -"OMIM:608836","CARNITINE PALMITOYLTRANSFERASE II DEFICIENCY, LETHAL NEONATAL" -"OMIM:614616","DIARRHEA 6; DIAR6" -"OMIM:608837","CARNEY COMPLEX VARIANT" -"OMIM:614617","DEAFNESS, AUTOSOMAL RECESSIVE 86; DFNB86" -"OMIM:608840","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH MENTAL RETARDATION), TYPE B, 6; MDDGB6" -"OMIM:608850","MACULAR DYSTROPHY, RETINAL, 3; MCDR3" -"OMIM:614618","HYPEREKPLEXIA 3; HKPX3" -"OMIM:608852","PULMONARY FUNCTION" -"OMIM:614619","HYPEREKPLEXIA 2; HKPX2" -"DOID:12465","secondary hyperparathyroidism of renal origin" -"OMIM:608864","OROFACIAL CLEFT 6, SUSCEPTIBILITY TO; OFC6" -"OMIM:614621","UV-SENSITIVE SYNDROME 2; UVSS2" -"OMIM:614622","KERATOCONUS 5; KTCN5" -"OMIM:608874","OROFACIAL CLEFT 5; OFC5" -"DOID:4969","Gerstmann syndrome" -"OMIM:600593","CRANIOSYNOSTOSIS, ADELAIDE TYPE; CRSA" -"DOID:0110528","autosomal recessive nonsyndromic deafness 83" -"OMIM:600598","SETTING-SUN PHENOMENON, FAMILIAL BENIGN" -"DOID:4491","persian gulf syndrome" -"OMIM:600624","CONE-ROD DYSTROPHY 1; CORD1" -"DOID:0110476","autosomal recessive nonsyndromic deafness 1B" -"DOID:574","peripheral nervous system disease" -"OMIM:600625","OROFACIAL CLEFT 11; OFC11" -"DOID:3666","cutaneous solitary mastocytoma" -"DOID:0110487","autosomal recessive nonsyndromic deafness 29" -"OMIM:600627","HYPERTRYPTOPHANEMIA; HYPTRP" -"DOID:11934","head and neck cancer" -"DOID:0110540","autosomal recessive nonsyndromic deafness 98" -"OMIM:600628","LOOSE ANAGEN HAIR SYNDROME" -"DOID:1673","pneumothorax" -"OMIM:600630","UV-SENSITIVE SYNDROME 1; UVSS1" -"DOID:0110937","autosomal dominant osteopetrosis 1" -"OMIM:600631","ENURESIS, NOCTURNAL, 1; ENUR1" -"DOID:0110526","autosomal recessive nonsyndromic deafness 79" -"DOID:0110470","autosomal recessive nonsyndromic deafness 15" -"OMIM:173600","PNEUMOTHORAX, PRIMARY SPONTANEOUS" -"OMIM:600634","PITUITARY ADENOMA, PROLACTIN-SECRETING" -"OMIM:173590","PLATELET SIGNAL PROCESSING DEFECT" -"DOID:4260","gait apraxia" -"OMIM:600638","FIBROSIS OF EXTRAOCULAR MUSCLES, CONGENITAL, 3A, WITH OR WITHOUT EXTRAOCULAR INVOLVEMENT; CFEOM3A" -"DOID:0110463","autosomal recessive nonsyndromic deafness 102" -"OMIM:600643","CAROLI DISEASE, ISOLATED" -"DOID:12697","locked-in syndrome" -"DOID:5848","apical myocardial infarction" -"DOID:0110979","Sugarman brachydactyly" -"DOID:0110524","autosomal recessive nonsyndromic deafness 76" -"DOID:14464","neuroleptic malignant syndrome" -"DOID:5847","posterior myocardial infarction" -"OMIM:600649","CARNITINE PALMITOYLTRANSFERASE II DEFICIENCY, INFANTILE" -"DOID:0060682","autosomal dominant nocturnal frontal lobe epilepsy 1" -"DOID:0110477","autosomal recessive nonsyndromic deafness 2" -"DOID:0110854","rhizomelic chondrodysplasia punctata type 5" -"OMIM:600651","FRAGILE SITE 11B; FRA11B" -"DOID:355","mast-cell sarcoma" -"OMIM:600652","DEAFNESS, AUTOSOMAL DOMINANT 4A; DFNA4A" -"DOID:0110507","autosomal recessive nonsyndromic deafness 5" -"OMIM:600666","POLYCYSTIC KIDNEY DISEASE 3; PKD3" -"DOID:1106","esophagus lymphoma" -"OMIM:600668","CHONDROCALCINOSIS 1; CCAL1" -"DOID:4440","seminoma" -"DOID:0110515","autosomal recessive nonsyndromic deafness 63" -"DOID:5855","anteroseptal myocardial infarction" -"OMIM:600669","EPILEPSY, IDIOPATHIC GENERALIZED; EIG" -"DOID:0110945","autosomal recessive osteopetrosis 6" -"DOID:5851","posterolateral myocardial infarction" -"DOID:9505","cannabis abuse" -"OMIM:600670","VARICELLA, SEVERE RECURRENT" -"DOID:0110489","autosomal recessive nonsyndromic deafness 30" -"DOID:9767","myocardial stunning" -"OMIM:600674","MICROTIA-ANOTIA" -"DOID:0110471","autosomal recessive nonsyndromic deafness 16" -"OMIM:600679","DERMOID CYSTS, FAMILIAL FRONTONASAL" -"OMIM:600705","SATOYOSHI SYNDROME" -"DOID:13576","twin-to-twin transfusion syndrome" -"DOID:9408","acute myocardial infarction" -"DOID:0110503","autosomal recessive nonsyndromic deafness 46" -"OMIM:600706","PROXIMAL MYOPATHY WITH FOCAL DEPLETION OF MITOCHONDRIA" -"OMIM:600721","D-2-HYDROXYGLUTARIC ACIDURIA 1; D2HGA1" -"OMIM:600736","VELOFACIOSKELETAL SYNDROME" -"DOID:0050440","familial partial lipodystrophy" -"DOID:5849","subendocardial myocardial infarction" -"OMIM:600740","HYPOCALCIURIC HYPERCALCEMIA, FAMILIAL, TYPE III; HHC3" -"DOID:0110474","autosomal recessive nonsyndromic deafness 18B" -"DOID:5845","anterolateral myocardial infarction" -"OMIM:600757","OROFACIAL CLEFT 3; OFC3" -"DOID:0110527","autosomal recessive nonsyndromic deafness 8" -"DOID:14026","folic acid deficiency anemia" -"OMIM:600771","DWARFISM, FAMILIAL, WITH MUSCLE SPASMS" -"DOID:7574","pancreatic intraductal papillary-colloid carcinoma" -"DOID:5853","lateral myocardial infarction" -"OMIM:600775","CRANIOSYNOSTOSIS 4; CRS4" -"OMIM:600776","FRYNS MICROPHTHALMIA SYNDROME" -"DOID:0110940","autosomal recessive osteopetrosis 8" -"DOID:5852","inferolateral myocardial infarct" -"OMIM:615946","MYOPIA 24, AUTOSOMAL DOMINANT; MYP24" -"OMIM:600785","VITAMIN D-DEPENDENT RICKETS, TYPE 2B, WITH NORMAL VITAMIN D RECEPTOR; VDDR2B" -"DOID:5854","silent myocardial infarction" -"DOID:0050083","Keshan disease" -"DOID:5843","posteroinferior myocardial infarction" -"OMIM:600790","CHORIORETINAL ATROPHY, PROGRESSIVE BIFOCAL" -"DOID:331","central nervous system disease" -"OMIM:600791","DEAFNESS, AUTOSOMAL RECESSIVE 4, WITH ENLARGED VESTIBULAR AQUEDUCT; DFNB4" -"DOID:0060158","acquired metabolic disease" -"DOID:0110480","autosomal recessive nonsyndromic deafness 22" -"OMIM:600792","DEAFNESS, AUTOSOMAL RECESSIVE 5; DFNB5" -"DOID:0110464","autosomal recessive nonsyndromic deafness 103" -"DOID:5846","septal myocardial infarction" -"DOID:0110473","autosomal recessive nonsyndromic deafness 18A" -"OMIM:600794","NEURONOPATHY, DISTAL HEREDITARY MOTOR, TYPE VA; HMN5A" -"DOID:9847","peripheral vertigo" -"OMIM:600795","FRONTOTEMPORAL DEMENTIA, CHROMOSOME 3-LINKED; FTD3" -"DOID:0110939","autosomal recessive osteopetrosis 5" -"OMIM:600801","ISOPROTERENOL-MEDIATED VASODILATATION" -"DOID:1089","tethered spinal cord syndrome" -"OMIM:608875","GENE EXPRESSION, VARIATION IN, QUANTITATIVE TRAIT LOCUS ON CHROMOSOME 14" -"OMIM:608878","GENE EXPRESSION, VARIATION IN, QUANTITATIVE TRAIT LOCUS ON CHROMOSOME 20" -"OMIM:118005","CERVICAL VERTEBRAL DYSPLASIA" -"DOID:2671","transitional cell carcinoma" -"OMIM:608885","STOMATIN-DEFICIENT CRYOHYDROCYTOSIS WITH NEUROLOGIC DEFECTS; SDCHCN" -"OMIM:118220","CHARCOT-MARIE-TOOTH DISEASE, DEMYELINATING, TYPE 1A; CMT1A" -"OMIM:152420","LITHIUM TRANSPORT" -"OMIM:608890","WAARDENBURG SYNDROME, TYPE 2D; WS2D" -"OMIM:152430","LONGEVITY 1" -"DOID:4724","brain edema" -"OMIM:608895","NEUROPATHY, HEREDITARY, WITH OR WITHOUT AGE-RELATED MACULAR DEGENERATION; HNARMD" -"DOID:12927","screw worm infectious disease" -"OMIM:608898","HEMOPHAGOCYTIC LYMPHOHISTIOCYTOSIS, FAMILIAL, 3; FHL3" -"DOID:184","bone cancer" -"OMIM:152900","LYMPHEDEMA AND CEREBRAL ARTERIOVENOUS ANOMALY" -"OMIM:608901","CORONARY HEART DISEASE, SUSCEPTIBILITY TO, 5" -"DOID:14172","rheumatic congestive heart failure" -"OMIM:608902","DRUG METABOLISM, POOR, CYP2D6-RELATED" -"OMIM:117900","CERVICAL RIB" -"DOID:4562","subacute bacterial endocarditis" -"DOID:0060334","transient neonatal diabetes mellitus" -"OMIM:608903","ATTENTION DEFICIT-HYPERACTIVITY DISORDER, SUSCEPTIBILITY TO, 1" -"DOID:1513","chronic cervicitis" -"OMIM:608904","ATTENTION DEFICIT-HYPERACTIVITY DISORDER, SUSCEPTIBILITY TO, 2" -"DOID:10616","acute cervicitis" -"DOID:0050639","primary cutaneous amyloidosis" -"OMIM:608905","ATTENTION DEFICIT-HYPERACTIVITY DISORDER, SUSCEPTIBILITY TO, 3" -"OMIM:608906","ATTENTION DEFICIT-HYPERACTIVITY DISORDER, SUSCEPTIBILITY TO, 4" -"OMIM:173800","POLAND SYNDROME" -"OMIM:152450","LOW DENSITY LIPOPROTEIN, VARIATION IN MOLECULAR WEIGHT OF" -"OMIM:608907","ALZHEIMER DISEASE 9, SUSCEPTIBILITY TO; AD9" -"OMIM:608908","MYOPIA 6; MYP6" -"OMIM:608911","CHOANAL ATRESIA, POSTERIOR; PCA" -"OMIM:608930","MYASTHENIC SYNDROME, CONGENITAL, 1B, FAST-CHANNEL; CMS1B" -"DOID:0090103","Huntington disease-like 1" -"DOID:3650","lactic acidosis" -"OMIM:608931","MYASTHENIC SYNDROME, CONGENITAL, 4C, ASSOCIATED WITH ACETYLCHOLINE RECEPTOR DEFICIENCY; CMS4C" -"OMIM:152600","LUNULAE OF FINGERNAILS" -"OMIM:608932","KERATOCONUS 2; KTCN2" -"OMIM:118210","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2A1; CMT2A1" -"OMIM:608935","LUNG CANCER SUSCEPTIBILITY 1; LNCR1" -"OMIM:152950","MICROCEPHALY WITH OR WITHOUT CHORIORETINOPATHY, LYMPHEDEMA, OR MENTAL RETARDATION; MCLMR" -"DOID:384","Wolff-Parkinson-White syndrome" -"OMIM:608940","SPONDYLOMETAPHYSEAL DYSPLASIA WITH CONE-ROD DYSTROPHY; SMDCRD" -"OMIM:118230","CHARCOT-MARIE-TOOTH DISEASE, GUADALAJARA NEURONAL TYPE" -"DOID:0060591","WHIM syndrome" -"OMIM:608957","CD8 DEFICIENCY, FAMILIAL" -"OMIM:152550","LUMBAR STENOSIS, FAMILIAL" -"OMIM:118100","KLIPPEL-FEIL SYNDROME 1, AUTOSOMAL DOMINANT; KFS1" -"OMIM:608970","MACULAR DYSTROPHY, PATTERNED, 2; MDPT2" -"DOID:0111104","maturity-onset diabetes of the young type 6" -"OMIM:152800","LYMPHANGIECTASIA, INTESTINAL" -"OMIM:608971","SEVERE COMBINED IMMUNODEFICIENCY, AUTOSOMAL RECESSIVE, T CELL-NEGATIVE, B CELL-POSITIVE, NK CELL-POSITIVE" -"OMIM:117800","APOCRINE GLAND SECRETION, VARIATION IN" -"OMIM:608978","MEACHAM SYNDROME" -"OMIM:152700","SYSTEMIC LUPUS ERYTHEMATOSUS; SLE" -"OMIM:117850","CERVICAL HYPERTRICHOSIS WITH UNDERLYING KYPHOSCOLIOSIS" -"OMIM:608980","BIFID NOSE WITH OR WITHOUT ANORECTAL AND RENAL ANOMALIES; BNAR" -"OMIM:118000","CERVICAL VERTEBRAL BRIDGE" -"OMIM:608982","STATURE QUANTITATIVE TRAIT LOCUS 5; STQTL5" -"OMIM:608984","ATAXIA, SENSORY, 1, AUTOSOMAL DOMINANT; SNAX1" -"DOID:6713","cerebrovascular disease" -"OMIM:153200","LYMPHEDEMA, HEREDITARY, II; LMPH2" -"OMIM:608988","ATRIAL FIBRILLATION, FAMILIAL, 2; ATFB2" -"OMIM:608995","DYSLEXIA, SUSCEPTIBILITY TO, 8; DYX8" -"DOID:2983","anuria" -"OMIM:608996","PREMATURE OVARIAN FAILURE 3; POF3" -"OMIM:153100","LYMPHEDEMA, HEREDITARY, IA; LMPH1A" -"DOID:5757","endocervicitis" -"OMIM:118300","CHARCOT-MARIE-TOOTH DISEASE AND DEAFNESS" -"OMIM:609006","DEAFNESS, AUTOSOMAL RECESSIVE 36, WITH OR WITHOUT VESTIBULAR INVOLVEMENT; DFNB36" -"OMIM:609008","MARFANOID HABITUS WITH SITUS INVERSUS" -"DOID:13722","neuroschistosomiasis" -"OMIM:609015","MITOCHONDRIAL TRIFUNCTIONAL PROTEIN DEFICIENCY; MTPD" -"DOID:0050738","Y-linked disease" -"OMIM:609016","LONG-CHAIN 3-HYDROXYACYL-CoA DEHYDROGENASE DEFICIENCY" -"OMIM:118200","CHARCOT-MARIE-TOOTH DISEASE, DEMYELINATING, TYPE 1B; CMT1B" -"DOID:4627","ideomotor apraxia" -"DOID:12926","hypodermyiasis" -"OMIM:609021","PERIPHERAL CONE DYSTROPHY" -"OMIM:609026","CATARACT 28; CTRCT28" -"DOID:0050859","hemorrhagic cystitis" -"DOID:1461","cholesterol embolism" -"OMIM:182200","SELLA TURCICA, BRIDGED" -"DOID:7051","esophageal basaloid squamous cell carcinoma" -"OMIM:614623","KERATOCONUS 6; KTCN6" -"OMIM:614628","KERATOCONUS 8; KTCN8" -"DOID:0050354","infant botulism" -"OMIM:614629","KERATOCONUS 7; KTCN7" -"DOID:3345","xanthomatosis" -"OMIM:614640","UV-SENSITIVE SYNDROME 3; UVSS3" -"DOID:3963","thyroid carcinoma" -"OMIM:614643","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 7; MDDGA7" -"DOID:14503","neuronal ceroid lipofuscinosis" -"OMIM:614644","MEAN PLATELET VOLUME QUANTITATIVE TRAIT LOCUS 4; MPVQTL4" -"DOID:1130","pituitary infarct" -"DOID:1927","sphingolipidosis" -"OMIM:614645","MEAN PLATELET VOLUME QUANTITATIVE TRAIT LOCUS 5; MPVQTL5" -"DOID:9305","splenic tuberculosis" -"OMIM:614646","MEAN PLATELET VOLUME QUANTITATIVE TRAIT LOCUS 6; MPVQTL6" -"DOID:0060473","Kabuki syndrome" -"OMIM:614650","COENZYME Q10 DEFICIENCY, PRIMARY, 6; COQ10D6" -"OMIM:614651","COENZYME Q10 DEFICIENCY, PRIMARY, 2; COQ10D2" -"OMIM:614652","COENZYME Q10 DEFICIENCY, PRIMARY, 3; COQ10D3" -"OMIM:614653","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, TYPE VI; HSAN6" -"OMIM:614654","COENZYME Q10 DEFICIENCY, PRIMARY, 5; COQ10D5" -"DOID:0060674","catecholaminergic polymorphic ventricular tachycardia" -"OMIM:614655","STUTTERING, FAMILIAL PERSISTENT, 3; STUT3" -"DOID:0050817","Stargardt disease" -"OMIM:614662","CORTISONE REDUCTASE DEFICIENCY 2; CORTRD2" -"DOID:0050051","Rickettsia parkeri spotted fever" -"OMIM:614665","MECONIUM ILEUS" -"DOID:0050041","Astrakhan spotted fever" -"OMIM:614668","STUTTERING, FAMILIAL PERSISTENT, 4; STUT4" -"OMIM:614669","AURICULOCONDYLAR SYNDROME 2; ARCND2" -"OMIM:614670","PERIPARTUM CARDIOMYOPATHY, SUSCEPTIBILITY TO" -"OMIM:176630","PRIMARY RELEASE DISORDER OF PLATELETS" -"DOID:0110966","brachydactyly type A3" -"OMIM:614671","CHROMOSOME 16p11.2 DUPLICATION SYNDROME" -"DOID:0050484","aneruptive fever" -"OMIM:614672","CARDIOMYOPATHY, DILATED, 2B; CMD2B" -"OMIM:614673","MICROCEPHALY 8, PRIMARY, AUTOSOMAL RECESSIVE; MCPH8" -"DOID:0050042","Indian tick typhus" -"OMIM:614674","PERIODIC FEVER, MENSTRUAL CYCLE-DEPENDENT" -"DOID:9503","Loeffler syndrome" -"OMIM:614675","BONE MARROW FAILURE SYNDROME 1; BMFS1" -"OMIM:614676","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 21; CMH21" -"DOID:3516","adult fibrosarcoma" -"OMIM:614678","PONTOCEREBELLAR HYPOPLASIA, TYPE 1B; PCH1B" -"DOID:14130","lateral cystocele" -"DOID:4903","granular cell carcinoma" -"OMIM:614679","CILIARY DYSKINESIA, PRIMARY, 17; CILD17" -"DOID:0050464","Farber lipogranulomatosis" -"OMIM:614680","INFLUENZA, SEVERE, SUSCEPTIBILITY TO" -"OMIM:614684","HYPERTELORISM AND OTHER FACIAL DYSMORPHISM, BRACHYDACTYLY, GENITAL ABNORMALITIES, MENTAL RETARDATION, AND RECURRENT INFLAMMATORY EPISODES" -"DOID:0050729","neutral lipid storage disease" -"DOID:0060167","seasonal affective disorder" -"OMIM:614687","ALAR CLEFT, ISOLATED" -"OMIM:614688","PONTINE TEGMENTAL CAP DYSPLASIA; PTCD" -"DOID:12196","superficial keratitis" -"OMIM:614689","SOLUBLE INTERLEUKIN-6 RECEPTOR, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS" -"DOID:10784","Queensland tick typhus" -"OMIM:614691","CATARACT 38; CTRCT38" -"OMIM:614692","MEMBRANOUS NEPHROPATHY, SUSCEPTIBILITY TO; MBNP" -"OMIM:614696","AMYOTROPHIC LATERAL SCLEROSIS 17; ALS17" -"OMIM:614699","IMMUNODEFICIENCY, COMMON VARIABLE, 7; CVID7" -"DOID:0050046","Far Eastern spotted fever" -"DOID:0111106","maturity-onset diabetes of the young type 7" -"OMIM:233500","GORLIN-CHAUDHRY-MOSS SYNDROME; GCMS" -"OMIM:257920","3MC SYNDROME 1; 3MC1" -"OMIM:305350","EPIDERMODYSPLASIA VERRUCIFORMIS, X-LINKED; EDVX; EDV2" -"OMIM:257960","OCULOTRICHODYSPLASIA; OTD" -"OMIM:233600","GRANULOCYTOPENIA WITH IMMUNOGLOBULIN ABNORMALITY" -"OMIM:305390","EXUDATIVE VITREORETINOPATHY 2, X-LINKED; EVR2" -"OMIM:233650","COMBINED CELLULAR AND HUMORAL IMMUNE DEFECTS WITH GRANULOMAS; CCHIDG" -"OMIM:305400","AARSKOG-SCOTT SYNDROME; AAS" -"OMIM:257970","OCULORENOCEREBELLAR SYNDROME" -"OMIM:169545","PELVIC LIPOMATOSIS WITH CROSSED RENAL ECTOPIA" -"OMIM:233670","GRANULOMATOUS DISEASE WITH DEFECT IN NEUTROPHIL CHEMOTAXIS" -"OMIM:305435","FETAL HEMOGLOBIN QUANTITATIVE TRAIT LOCUS 3; HBFQTL3" -"DOID:5773","oral submucous fibrosis" -"OMIM:257980","ODONTOONYCHODERMAL DYSPLASIA; OODD" -"OMIM:305450","OPITZ-KAVEGGIA SYNDROME; OKS" -"OMIM:258040","OEIS COMPLEX" -"OMIM:233690","GRANULOMATOUS DISEASE, CHRONIC, AUTOSOMAL RECESSIVE, CYTOCHROME b-NEGATIVE" -"DOID:8440","ileus" -"OMIM:305550","FINGERPRINT BODY MYOPATHY" -"OMIM:233700","GRANULOMATOUS DISEASE, CHRONIC, AUTOSOMAL RECESSIVE, CYTOCHROME b-POSITIVE, TYPE I; CDG1" -"OMIM:258100","OGUCHI DISEASE 1" -"DOID:2351","iron metabolism disease" -"OMIM:258150","SPERMATOGENIC FAILURE 1; SPGF1" -"OMIM:233710","GRANULOMATOUS DISEASE, CHRONIC, AUTOSOMAL RECESSIVE, CYTOCHROME b-POSITIVE, TYPE II; CDG2" -"OMIM:305600","FOCAL DERMAL HYPOPLASIA; FDH" -"OMIM:184255","SPONDYLOMETAPHYSEAL DYSPLASIA, CORNER FRACTURE TYPE" -"OMIM:305620","FRONTOMETAPHYSEAL DYSPLASIA 1; FMD1" -"OMIM:233800","GROUPED PIGMENTATION OF THE RETINA" -"DOID:724","female stress incontinence" -"OMIM:184260","SPONDYLOMETAPHYSEAL DYSPLASIA WITH DENTINOGENESIS IMPERFECTA" -"OMIM:258200","OLIVER SYNDROME" -"OMIM:258300","OLIVOPONTOCEREBELLAR ATROPHY II, AUTOSOMAL RECESSIVE" -"OMIM:305690","GENITOURINARY TRACT ANOMALIES" -"OMIM:184300","SPONDYLOSIS, CERVICAL" -"OMIM:233805","GROWTH FACTORS, COMBINED DEFECT OF" -"DOID:0050568","spondylocostal dysostosis" -"OMIM:305700","SPERMATOGENIC FAILURE, X-LINKED, 1; SPGFX1" -"OMIM:233810","GROWTH RETARDATION, SMALL AND PUFFY HANDS AND FEET, AND ECZEMA" -"OMIM:258315","OMODYSPLASIA 1; OMOD1" -"OMIM:233910","HYPERPHENYLALANINEMIA, BH4-DEFICIENT, B; HPABH4B" -"OMIM:258320","OMPHALOCELE-CLEFT PALATE SYNDROME, LETHAL" -"OMIM:305800","MEMBRANOPROLIFERATIVE GLOMERULONEPHRITIS, X-LINKED" -"OMIM:305920","GLUTAMYL RIBOSE-5-PHOSPHATE STORAGE DISEASE" -"OMIM:234000","FACTOR XII DEFICIENCY" -"OMIM:258360","ONYCHOTRICHODYSPLASIA AND NEUTROPENIA" -"OMIM:234030","HAIR DEFECT WITH PHOTOSENSITIVITY AND MENTAL RETARDATION" -"OMIM:306000","GLYCOGEN STORAGE DISEASE IXa1; GSD9A1" -"OMIM:258400","OPHTHALMOPLEGIA TOTALIS WITH PTOSIS AND MIOSIS" -"OMIM:306300","GRANULOMAS, CONGENITAL CEREBRAL" -"OMIM:258450","PROGRESSIVE EXTERNAL OPHTHALMOPLEGIA WITH MITOCHONDRIAL DNA DELETIONS, AUTOSOMAL RECESSIVE 1; PEOB1" -"OMIM:234050","TRICHOTHIODYSTROPHY 4, NONPHOTOSENSITIVE; TTD4" -"OMIM:306400","GRANULOMATOUS DISEASE, CHRONIC, X-LINKED; CDGX" -"OMIM:234100","HALLERMANN-STREIFF SYNDROME; HSS" -"OMIM:258470","OPHTHALMOPLEGIC NEUROMUSCULAR DISORDER WITH ABNORMAL MITOCHONDRIA" -"OMIM:306700","HEMOPHILIA A; HEMA" -"OMIM:234200","NEURODEGENERATION WITH BRAIN IRON ACCUMULATION 1; NBIA1" -"OMIM:258480","OPSISMODYSPLASIA; OPSMD" -"DOID:10780","primary polycythemia" -"OMIM:306800","HEMOPHILIA A WITH VASCULAR ABNORMALITY" -"OMIM:234250","HALL-RIGGS MENTAL RETARDATION SYNDROME" -"OMIM:258500","OPTIC ATROPHY 6; OPA6" -"OMIM:169550","PELVIS-SHOULDER DYSPLASIA" -"OMIM:306900","HEMOPHILIA B; HEMB" -"OMIM:258501","3-METHYLGLUTACONIC ACIDURIA, TYPE III; MGCA3" -"OMIM:234280","HALLUX VARUS AND PREAXIAL POLYSYNDACTYLY" -"OMIM:306930","HEMOPOIETIC PROLIFERATION" -"OMIM:258650","OPTIC ATROPHY, HEARING LOSS, AND PERIPHERAL NEUROPATHY, AUTOSOMAL RECESSIVE" -"OMIM:234300","HALO NEVI" -"OMIM:234350","HALOTHANE HEPATITIS" -"OMIM:258660","NONARTERITIC ANTERIOR ISCHEMIC OPTIC NEUROPATHY, SUSCEPTIBILITY TO" -"OMIM:306950","HERNIA, ANTERIOR DIAPHRAGMATIC" -"OMIM:306955","HETEROTAXY, VISCERAL, 1, X-LINKED; HTX1" -"OMIM:258700","OPTICOCOCHLEODENTATE DEGENERATION" -"OMIM:234500","HARTNUP DISORDER; HND" -"OMIM:306960","HHHH SYNDROME" -"OMIM:234580","HEIMLER SYNDROME 1; HMLR1" -"OMIM:169600","BENIGN CHRONIC PEMPHIGUS; BCPM" -"OMIM:258800","ORAL SENSIBILITY, DISTURBANCE OF" -"OMIM:306980","HIRSCHSPRUNG DISEASE WITH TYPE D BRACHYDACTYLY" -"OMIM:258840","ORAL AND DIGITAL ANOMALIES WITH ICHTHYOSIS" -"OMIM:234700","HEART BLOCK, CONGENITAL" -"OMIM:306990","HOLOPROSENCEPHALY WITH FETAL AKINESIA/HYPOKINESIA SEQUENCE" -"OMIM:258850","OROFACIODIGITAL SYNDROME III; OFD3" -"OMIM:234750","HEART, MALFORMATION OF" -"OMIM:169610","PEMPHIGUS VULGARIS, FAMILIAL" -"OMIM:306995","HOMOSEXUALITY 1; HMS1" -"OMIM:258860","OROFACIODIGITAL SYNDROME IV; OFD4" -"OMIM:234800","HEMANGIOMATOSIS, CUTANEOUS, WITH ASSOCIATED FEATURES" -"OMIM:258865","OROFACIODIGITAL SYNDROME IX; OFD9" -"OMIM:307000","HYDROCEPHALUS DUE TO CONGENITAL STENOSIS OF AQUEDUCT OF SYLVIUS; HSAS" -"OMIM:234810","PULMONARY VENOOCCLUSIVE DISEASE 2, AUTOSOMAL RECESSIVE; PVOD2" -"OMIM:258870","GYRATE ATROPHY OF CHOROID AND RETINA; GACR" -"OMIM:234820","HEMANGIOPERICYTOMA, MALIGNANT" -"OMIM:307010","HYDROCEPHALUS WITH CEREBELLAR AGENESIS" -"DOID:7941","Barrett's adenocarcinoma" -"DOID:2834","acquired polycythemia" -"OMIM:235000","HEMIHYPERPLASIA, ISOLATED; IH" -"OMIM:258900","OROTIC ACIDURIA" -"OMIM:307030","GLYCEROL KINASE DEFICIENCY; GKD" -"OMIM:235200","HEMOCHROMATOSIS, TYPE 1; HFE1" -"OMIM:259050","PRIMROSE SYNDROME; PRIMS" -"DOID:8431","physiological polycythemia" -"DOID:14042","bipolar I disorder" -"OMIM:307150","HYPERTRICHOSIS, CONGENITAL GENERALIZED; HTC2" -"OMIM:235255","MULLERIAN DERIVATIVES, PERSISTENCE OF, WITH LYMPHANGIECTASIA AND POSTAXIAL POLYDACTYLY" -"OMIM:259100","HYPERTROPHIC OSTEOARTHROPATHY, PRIMARY, AUTOSOMAL RECESSIVE, 1; PHOAR1" -"OMIM:307200","ISOLATED GROWTH HORMONE DEFICIENCY, TYPE III; IGHD3" -"OMIM:235370","HEMOLYTIC ANEMIA WITH THERMAL SENSITIVITY OF RED CELLS" -"DOID:9348","carotid artery dissection" -"OMIM:259200","BLOUNT DISEASE, ADOLESCENT" -"DOID:8927","learning disability" -"OMIM:307500","HYPOGONADISM, MALE, WITH MENTAL RETARDATION AND SKELETAL ANOMALIES" -"OMIM:235400","HEMOLYTIC UREMIC SYNDROME, ATYPICAL, SUSCEPTIBILITY TO, 1; AHUS1" -"OMIM:307700","HYPOPARATHYROIDISM, X-LINKED; HYPX" -"DOID:8997","polycythemia vera" -"OMIM:259250","OSTEODYSPLASIA, FAMILIAL, ANDERSON TYPE" -"OMIM:235500","HEMOSIDEROSIS, PULMONARY, WITH DEFICIENCY OF GAMMA-A GLOBULIN" -"OMIM:307800","HYPOPHOSPHATEMIC RICKETS, X-LINKED DOMINANT; XLHR" -"OMIM:259270","OSTEODYSPLASTY, PRECOCIOUS, OF DANKS, MAYNE, AND KOZLOWSKI" -"OMIM:307830","HYPOURICEMIA, FAMILIAL RENAL, DUE TO TUBULAR HYPERSECRETION" -"OMIM:259410","OSTEOGENESIS IMPERFECTA CONGENITA, MICROCEPHALY, AND CATARACTS" -"OMIM:235510","HENNEKAM LYMPHANGIECTASIA-LYMPHEDEMA SYNDROME 1; HKLLS1" -"DOID:8670","eating disorder" -"OMIM:259420","OSTEOGENESIS IMPERFECTA, TYPE III; OI3" -"OMIM:235550","HEPATIC VENOOCCLUSIVE DISEASE WITH IMMUNODEFICIENCY; VODI" -"OMIM:308050","CONGENITAL HEMIDYSPLASIA WITH ICHTHYOSIFORM ERYTHRODERMA AND LIMB DEFECTS" -"OMIM:169500","LEUKODYSTROPHY, DEMYELINATING, ADULT-ONSET, AUTOSOMAL DOMINANT; ADLD" -"OMIM:308100","ICHTHYOSIS, X-LINKED; XLI" -"OMIM:259440","OSTEOGENESIS IMPERFECTA, TYPE IX; OI9" -"OMIM:235555","BILE ACID SYNTHESIS DEFECT, CONGENITAL, 2; CBAS2" -"DOID:1519","cecum carcinoma" -"OMIM:609027","BLOOD GROUP, INDIAN SYSTEM; IN" -"OMIM:614700","IMMUNODEFICIENCY, COMMON VARIABLE, 8, WITH AUTOIMMUNITY; CVID8" -"OMIM:614701","CORNELIA DE LANGE SYNDROME 4; CDLS4" -"OMIM:609029","EMANUEL SYNDROME" -"OMIM:614702","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 10; COXPD10" -"OMIM:609033","POSTERIOR COLUMN ATAXIA WITH RETINITIS PIGMENTOSA; AXPC1" -"DOID:0110972","brachydactyly type E1" -"OMIM:609037","MENTAL RETARDATION WITH OPTIC ATROPHY, FACIAL DYSMORPHISM, MICROCEPHALY, AND SHORT STATURE" -"OMIM:614706","CEROID LIPOFUSCINOSIS, NEURONAL, 11; CLN11" -"OMIM:609039","NARCOLEPSY 3; NRCLP3" -"DOID:4697","perineurioma" -"OMIM:614707","BROWN-VIALETTO-VAN LAERE SYNDROME 2; BVVLS2" -"OMIM:614714","POROKERATOSIS 7, MULTIPLE TYPES; POROK7" -"OMIM:609040","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 9; ARVD9" -"OMIM:609041","SPASTIC PARAPLEGIA 27, AUTOSOMAL RECESSIVE; SPG27" -"OMIM:614723","ADENINE PHOSPHORIBOSYLTRANSFERASE DEFICIENCY; APRTD" -"DOID:0050771","phaeochromocytoma" -"OMIM:614727","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIk; CDG2K" -"OMIM:609047","SKELETAL DYSPLASIA, RHIZOMELIC, WITH RETINITIS PIGMENTOSA" -"OMIM:614728","SECKEL SYNDROME 6; SCKL6" -"OMIM:609048","MELANOMA, CUTANEOUS MALIGNANT, SUSCEPTIBILITY TO, 3; CMM3" -"DOID:0060228","intracranial berry aneurysm" -"OMIM:609049","PIERSON SYNDROME" -"OMIM:614731","PROSTATE CANCER, HEREDITARY, 2; HPC2" -"OMIM:614732","INTRAUTERINE GROWTH RETARDATION, METAPHYSEAL DYSPLASIA, ADRENAL HYPOPLASIA CONGENITA, AND GENITAL ANOMALIES" -"OMIM:609052","SPONDYLOMETAPHYSEAL DYSPLASIA, TYPE A4" -"OMIM:609053","FANCONI ANEMIA, COMPLEMENTATION GROUP I; FANCI" -"OMIM:614736","GLUCOCORTICOID DEFICIENCY 4 WITH OR WITHOUT MINERALOCORTICOID DEFICIENCY; GCCD4" -"DOID:3891","placental insufficiency" -"OMIM:609054","FANCONI ANEMIA, COMPLEMENTATION GROUP J; FANCJ" -"OMIM:614739","3-METHYLGLUTACONIC ACIDURIA WITH DEAFNESS, ENCEPHALOPATHY, AND LEIGH-LIKE SYNDROME; MEGDEL" -"OMIM:609055","CEROID LIPOFUSCINOSIS, NEURONAL, 9; CLN9" -"OMIM:614740","BASAL CELL CARCINOMA, SUSCEPTIBILITY TO, 7; BCC7" -"OMIM:614741","MITOCHONDRIAL PYRUVATE CARRIER DEFICIENCY; MPYCD" -"OMIM:609056","SALT AND PEPPER DEVELOPMENTAL REGRESSION SYNDROME; SPDRS" -"OMIM:614742","PULMONARY FIBROSIS AND/OR BONE MARROW FAILURE, TELOMERE-RELATED, 1; PFBMFT1" -"OMIM:609057","NEPHROPATHY WITH PRETIBIAL EPIDERMOLYSIS BULLOSA AND DEAFNESS" -"OMIM:614743","PULMONARY FIBROSIS AND/OR BONE MARROW FAILURE, TELOMERE-RELATED, 2; PFBMFT2" -"OMIM:609060","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 1; COXPD1" -"DOID:11060","placenta praevia" -"OMIM:609069","PANCREATIC AND CEREBELLAR AGENESIS; PACA" -"OMIM:614744","FACIAL PARESIS, HEREDITARY CONGENITAL, 3; HCFP3" -"DOID:12156","arachnoiditis" -"OMIM:614745","BLOOD GROUP, JOHN MILTON HAGEN SYSTEM; JMH" -"OMIM:609070","HEMOGLOBIN, HIGH ALTITUDE ADAPTATION; HALAH" -"DOID:6498","seborrheic keratosis" -"OMIM:609113","TELOMERE LENGTH, MEAN LEUKOCYTE; LTL" -"OMIM:614746","URIC ACID CONCENTRATION, SERUM, QUANTITATIVE TRAIT LOCUS 5; UAQTL5" -"OMIM:614747","URIC ACID CONCENTRATION, SERUM, QUANTITATIVE TRAIT LOCUS 6; UAQTL6" -"OMIM:609115","LIMB-GIRDLE MUSCULAR DYSTROPHY, TYPE 1G; LGMD1G" -"OMIM:614748","INTERSTITIAL LUNG DISEASE, NEPHROTIC SYNDROME, AND EPIDERMOLYSIS BULLOSA, CONGENITAL; ILNEB" -"OMIM:609116","RESPIRATORY RHYTHMICITY IN SLEEP" -"OMIM:614749","HYPERPHOSPHATASIA WITH MENTAL RETARDATION SYNDROME 2; HPMRS2" -"OMIM:609122","ANEURYSM, INTRACRANIAL BERRY, 3; ANIB3" -"OMIM:609128","ARTHROGRYPOSIS, DISTAL, TYPE 4; DA4" -"OMIM:614750","MYASTHENIC SYNDROME, CONGENITAL, 13; CMS13" -"OMIM:609129","AUDITORY NEUROPATHY, AUTOSOMAL DOMINANT, 1; AUNA1" -"OMIM:614751","NEURONOPATHY, DISTAL HEREDITARY MOTOR, TYPE VB; HMN5B" -"OMIM:614752","INTERLEUKIN 6, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS" -"OMIM:609135","APLASTIC ANEMIA" -"DOID:5425","ovarian hyperstimulation syndrome" -"OMIM:609136","PERIPHERAL DEMYELINATING NEUROPATHY, CENTRAL DYSMYELINATION, WAARDENBURG SYNDROME, AND HIRSCHSPRUNG DISEASE; PCWH" -"OMIM:614753","SOTOS SYNDROME 2; SOTOS2" -"OMIM:609140","CORNEAL DYSTROPHY, POSTERIOR POLYMORPHOUS, 2; PPCD2" -"OMIM:614756","CEREBELLAR ATAXIA, NONPROGRESSIVE, WITH MENTAL RETARDATION; CANPMR" -"OMIM:609141","CORNEAL DYSTROPHY, POSTERIOR POLYMORPHOUS, 3; PPCD3" -"OMIM:614779","HETEROTAXY, VISCERAL, 6, AUTOSOMAL; HTX6" -"OMIM:609148","MALARIA, MILD, SUSCEPTIBILITY TO" -"OMIM:614782","TREMOR, HEREDITARY ESSENTIAL, 4; ETM4" -"OMIM:609152","HYPERTHYROIDISM, NONAUTOIMMUNE" -"OMIM:614800","SHORT STATURE, OPTIC NERVE ATROPHY, AND PELGER-HUET ANOMALY; SOPH" -"OMIM:614807","MYOPATHY, CENTRONUCLEAR, 4; CNM4" -"OMIM:609153","PSEUDOHYPERKALEMIA, FAMILIAL, 2, DUE TO RED CELL LEAK; PSHK2" -"OMIM:609161","STRIATAL DEGENERATION, AUTOSOMAL DOMINANT 1; ADSD1" -"OMIM:614808","AMYOTROPHIC LATERAL SCLEROSIS 18; ALS18" -"OMIM:609162","CZECH DYSPLASIA" -"OMIM:614809","CFHR5 DEFICIENCY" -"OMIM:614810","MULTIPLE SCLEROSIS, SUSCEPTIBILITY TO, 5; MS5" -"OMIM:609164","UMBILICUS, FAMILIAL FLAT" -"OMIM:609165","ERYTHRODERMA, ICHTHYOSIFORM, CONGENITAL RETICULAR; CRIE" -"OMIM:614813","SHORT STATURE, ONYCHODYSPLASIA, FACIAL DYSMORPHISM, AND HYPOTRICHOSIS; SOFT" -"OMIM:300998","MENTAL RETARDATION, X-LINKED, SYNDROMIC, 35; MRXS35" -"DOID:10657","colonic lymphangioma" -"OMIM:301000","WISKOTT-ALDRICH SYNDROME; WAS" -"OMIM:120440","COLONIC VARICES WITHOUT PORTAL HYPERTENSION" -"OMIM:301040","ALPHA-THALASSEMIA/MENTAL RETARDATION SYNDROME, X-LINKED; ATRX" -"OMIM:120500","COMMISSURAL LIP PITS" -"DOID:0060753","familial temporal lobe epilepsy 4" -"OMIM:151590","LICHEN SCLEROSUS ET ATROPHICUS; LSA" -"OMIM:301050","ALPORT SYNDROME, X-LINKED; ATS" -"OMIM:301200","AMELOGENESIS IMPERFECTA, TYPE IE; AI1E" -"DOID:758","situs inversus" -"OMIM:301201","AMELOGENESIS IMPERFECTA, HYPOPLASTIC/HYPOMATURATION, X-LINKED 2" -"DOID:14239","gastrointestinal tularemia" -"OMIM:301220","PIGMENTARY DISORDER, RETICULATE, WITH SYSTEMIC MANIFESTATIONS, X-LINKED; PDR" -"OMIM:301310","ANEMIA, SIDEROBLASTIC, AND SPINOCEREBELLAR ATAXIA; ASAT" -"DOID:0050912","colon adenoma" -"OMIM:301410","NEURAL TUBE DEFECTS, X-LINKED" -"OMIM:151630","LIP, MEDIAN NODULE OF UPPER" -"OMIM:301500","FABRY DISEASE" -"OMIM:177100","PRURITUS, HEREDITARY LOCALIZED" -"OMIM:177050","PROTRUSIO ACETABULI" -"OMIM:301590","MICROPHTHALMIA, SYNDROMIC 4; MCOPS4" -"OMIM:151620","LICHEN PLANUS, FAMILIAL" -"OMIM:301700","ANOSMIA" -"OMIM:301790","SPINOCEREBELLAR ATAXIA, X-LINKED 3" -"OMIM:172500","PHOTOMYOCLONUS, DIABETES MELLITUS, DEAFNESS, NEPHROPATHY, AND CEREBRAL DYSFUNCTION" -"OMIM:301800","ANUS, IMPERFORATE" -"OMIM:151623","LI-FRAUMENI SYNDROME 1; LFS1" -"OMIM:301815","ARTHROGRYPOSIS, ECTODERMAL DYSPLASIA, CLEFT LIP/PALATE, AND DEVELOPMENTAL DELAY" -"OMIM:301830","SPINAL MUSCULAR ATROPHY, X-LINKED 2; SMAX2" -"DOID:0111057","platelet-type bleeding disorder 11" -"OMIM:301835","ARTS SYNDROME; ARTS" -"OMIM:120450","COMEDONES, FAMILIAL DYSKERATOTIC" -"OMIM:301840","SPINOCEREBELLAR ATAXIA, X-LINKED 4" -"OMIM:301845","BAZEX SYNDROME; BZX" -"OMIM:301850","TUBULIN, BETA" -"OMIM:301900","BORJESON-FORSSMAN-LEHMANN SYNDROME; BFLS" -"OMIM:301940","BRACHYDACTYLY, MONONEN TYPE" -"OMIM:301950","BRANCHIAL ARCH SYNDROME, X-LINKED" -"OMIM:302000","BULLOUS DYSTROPHY, HEREDITARY MACULAR TYPE" -"DOID:4118","colon neuroendocrine neoplasm" -"OMIM:302030","CALVARIAL HYPEROSTOSIS" -"DOID:11249","vitamin K deficiency hemorrhagic disease" -"OMIM:302045","CARDIOMYOPATHY, DILATED, 3B; CMD3B" -"OMIM:151640","LIP, HAMARTOMATOUS" -"DOID:0060668","anencephaly" -"OMIM:302060","BARTH SYNDROME; BTHS" -"OMIM:302200","CATARACT 40; CTRCT40" -"OMIM:302350","NANCE-HORAN SYNDROME; NHS" -"OMIM:107550","AORTIC ARCH INTERRUPTION, FACIAL PALSY, AND RETINAL COLOBOMA" -"OMIM:151610","LEVATOR-MEDIAL RECTUS SYNKINESIS" -"OMIM:302400","CENTRAL INCISORS, ABSENCE OF" -"OMIM:176620","PRIAPISM, FAMILIAL IDIOPATHIC" -"OMIM:176600","PRESENILE DEMENTIA, KRAEPELIN TYPE" -"OMIM:302500","SPINOCEREBELLAR ATAXIA, X-LINKED 1; SCAX1" -"DOID:0110989","Joubert syndrome 20" -"OMIM:151500","LEUKOCYTE NUCLEAR APPENDAGES, HEREDITARY PREVALENCE OF" -"DOID:3008","invasive ductal carcinoma" -"OMIM:302600","SPINOCEREBELLAR ATAXIA, X-LINKED 2" -"OMIM:107500","AORTIC ARCH ANOMALY WITH PECULIAR FACIES AND MENTAL RETARDATION" -"OMIM:176500","CEREBRAL AMYLOID ANGIOPATHY, ITM2B-RELATED, 1" -"OMIM:302700","CEREBRAL SCLEROSIS, DIFFUSE, SCHOLZ TYPE" -"OMIM:302800","CHARCOT-MARIE-TOOTH DISEASE, X-LINKED DOMINANT, 1; CMTX1" -"OMIM:151600","NAIL DISORDER, NONSYNDROMIC CONGENITAL, 3; NDNC3" -"OMIM:302801","CHARCOT-MARIE-TOOTH DISEASE, X-LINKED RECESSIVE, 2; CMTX2" -"OMIM:151400","LEUKEMIA, CHRONIC LYMPHOCYTIC; CLL" -"OMIM:120435","LYNCH SYNDROME I" -"OMIM:120502","BRANCHIOOTIC SYNDROME 2" -"OMIM:302802","CHARCOT-MARIE-TOOTH DISEASE, X-LINKED RECESSIVE, 3; CMTX3" -"DOID:0050966","spinocerebellar ataxia type 16" -"DOID:0050964","spinocerebellar ataxia type 14" -"OMIM:609166","BRANCHIOGENIC-DEAFNESS SYNDROME" -"OMIM:609179","MIGRAINE WITH AURA, SUSCEPTIBILITY TO, 7" -"OMIM:609180","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE If; CDG1F" -"DOID:0110751","type 1 diabetes mellitus 12" -"OMIM:178200","PTERYGIUM, ANTECUBITAL" -"DOID:3240","aspiration pneumonitis" -"OMIM:609192","LOEYS-DIETZ SYNDROME 1; LDS1" -"OMIM:609195","SPASTIC PARAPLEGIA 26, AUTOSOMAL RECESSIVE; SPG26" -"DOID:0050987","hypomyelinating leukoencephalopathy" -"OMIM:178110","ARTHROGRYPOSIS, DISTAL, TYPE 8; DA8" -"DOID:0110760","type 1 diabetes mellitus 23" -"OMIM:168100","PARALYSIS AGITANS, JUVENILE, OF HUNT" -"DOID:0110742","type 1 diabetes mellitus 3" -"OMIM:609197","GLUCOCORTICOID DEFICIENCY 3; GCCD3" -"DOID:0110746","type 1 diabetes mellitus 7" -"OMIM:168605","PERRY SYNDROME" -"OMIM:609200","MYOPATHY, MYOFIBRILLAR, 3; MFM3" -"DOID:0110744","type 1 diabetes mellitus 5" -"DOID:2768","transient tic disorder" -"OMIM:168400","PARASTREMMATIC DWARFISM" -"DOID:0050954","spinocerebellar ataxia type 1" -"OMIM:609218","FOVEAL HYPOPLASIA 2; FVH2" -"DOID:0050971","spinocerebellar ataxia type 20" -"OMIM:105550","FRONTOTEMPORAL DEMENTIA AND/OR AMYOTROPHIC LATERAL SCLEROSIS 1; FTDALS1" -"OMIM:609220","BRUCK SYNDROME 2; BRKS2" -"OMIM:105500","AMYOTROPHIC LATERAL SCLEROSIS-PARKINSONISM/DEMENTIA COMPLEX 1" -"DOID:0110754","type 1 diabetes mellitus 17" -"OMIM:609222","DANDY-WALKER MALFORMATION WITH OCCIPITAL CEPHALOCELE, AUTOSOMAL DOMINANT; ADDWOC" -"OMIM:168200","PARAMOLAR TUBERCLE OF BOLK" -"DOID:10824","malignant hypertension" -"OMIM:609223","SPONDYLOEPIPHYSEAL DYSPLASIA TARDA, AUTOSOMAL RECESSIVE, LEROY-SPRANGER TYPE" -"DOID:0050981","spinocerebellar ataxia type 34" -"DOID:4430","somatostatinoma" -"DOID:0050383","typhoidal tularemia" -"OMIM:105563","ANAL SPHINCTER DYSPLASIA; ASDP" -"OMIM:609227","GRISCELLI SYNDROME, TYPE 3; GS3" -"DOID:0050963","spinocerebellar ataxia type 13" -"OMIM:609241","SCHINDLER DISEASE, TYPE I" -"DOID:0050958","spinocerebellar ataxia type 7" -"OMIM:609242","KANZAKI DISEASE" -"DOID:2994","germ cell cancer" -"OMIM:609250","HYPOTRICHOSIS, PROGRESSIVE PATTERNED SCALP, WITH WIRY HAIR, ONYCHOLYSIS, AND CLEFT LIP/PALATE" -"DOID:1440","Machado-Joseph disease" -"DOID:0050982","spinocerebellar ataxia type 35" -"OMIM:609253","FEBRILE SEIZURES, FAMILIAL, 6; FEB6" -"OMIM:609254","SENIOR-LOKEN SYNDROME 5; SLSN5" -"DOID:0050965","spinocerebellar ataxia type 15" -"OMIM:168000","PARAGANGLIOMAS 1; PGL1" -"OMIM:609255","FEBRILE SEIZURES, FAMILIAL, 5; FEB5" -"OMIM:105650","DIAMOND-BLACKFAN ANEMIA 1; DBA1" -"DOID:0050956","spinocerebellar ataxia type 6" -"OMIM:168300","PARAMYOTONIA CONGENITA OF VON EULENBURG; PMC" -"OMIM:609256","MYOPIA 7; MYP7" -"DOID:0110758","type 1 diabetes mellitus 21" -"OMIM:609257","MYOPIA 8; MYP8" -"OMIM:609258","MYOPIA 9; MYP9" -"DOID:0110745","type 1 diabetes mellitus 6" -"OMIM:168550","PARIETAL FORAMINA WITH CLEIDOCRANIAL DYSPLASIA; PFMCCD" -"OMIM:168500","PARIETAL FORAMINA 1; PFM1" -"OMIM:609259","MYOPIA 10; MYP10" -"OMIM:609260","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, AUTOSOMAL DOMINANT, TYPE 2A2A; CMT2A2A" -"DOID:0110749","type 1 diabetes mellitus 10" -"DOID:0050985","spinocerebellar ataxia type 38" -"OMIM:168600","PARKINSON DISEASE, LATE-ONSET; PD" -"OMIM:609261","STUTTERING, FAMILIAL PERSISTENT, 2; STUT2" -"OMIM:609265","LI-FRAUMENI SYNDROME 2; LFS2" -"DOID:0050977","spinocerebellar ataxia type 28" -"DOID:11949","Creutzfeldt-Jakob disease" -"OMIM:609266","LI-FRAUMENI SYNDROME 3; LFS3" -"DOID:0110743","type 1 diabetes mellitus 4" -"DOID:0050780","Opitz-GBBB syndrome" -"OMIM:609270","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 7; SCAR7" -"OMIM:609271","KERATOCONUS 4; KTCN4" -"OMIM:105570","ANDROSTENONE, ABILITY TO SMELL" -"DOID:0050961","spinocerebellar ataxia type 11" -"OMIM:609273","NEMALINE MYOPATHY 6; NEM6" -"OMIM:105565","ANAL SPHINCTER MYOPATHY, INTERNAL" -"OMIM:609283","PROGRESSIVE EXTERNAL OPHTHALMOPLEGIA WITH MITOCHONDRIAL DNA DELETIONS, AUTOSOMAL DOMINANT 2; PEOA2" -"OMIM:168601","PARKINSON DISEASE 1, AUTOSOMAL DOMINANT; PARK1" -"DOID:0050986","spinocerebellar ataxia type 40" -"OMIM:609284","NEMALINE MYOPATHY 1; NEM1" -"OMIM:167960","HUMAN PAPILLOMAVIRUS TYPE 18 INTEGRATION SITE 2; HPV18I2" -"OMIM:609285","NEMALINE MYOPATHY 4; NEM4" -"DOID:0050970","spinocerebellar ataxia type 19/22" -"OMIM:609286","PROGRESSIVE EXTERNAL OPHTHALMOPLEGIA WITH MITOCHONDRIAL DNA DELETIONS, AUTOSOMAL DOMINANT 3; PEOA3" -"OMIM:105580","ANAL CANAL CARCINOMA" -"OMIM:609289","SYNCOPE, FAMILIAL VASOVAGAL; VVS" -"DOID:0050957","spinocerebellar ataxia type 4" -"DOID:0050955","spinocerebellar ataxia type 2" -"OMIM:609296","B-CELL IMMUNODEFICIENCY, DISTAL LIMB ANOMALIES, AND UROGENITAL MALFORMATIONS" -"OMIM:609299","PROSTATE CANCER, HEREDITARY, 5" -"OMIM:105600","ANEMIA, CONGENITAL DYSERYTHROPOIETIC, TYPE III; CDAN3" -"DOID:0050974","spinocerebellar ataxia type 25" -"OMIM:600332","RIPPLING MUSCLE DISEASE 1; RMD1" -"OMIM:614814","ADAMS-OLIVER SYNDROME 3; AOS3" -"DOID:8689","anorexia nervosa" -"DOID:0060840","isolated microphthalmia 1" -"DOID:9210","geniculate herpes zoster" -"OMIM:600333","MOTOR NEURON DISEASE WITH DEMENTIA AND OPHTHALMOPLEGIA" -"OMIM:614815","JOUBERT SYNDROME 18; JBTS18" -"DOID:1558","angioedema" -"OMIM:614816","LOEYS-DIETZ SYNDROME 4; LDS4" -"OMIM:600334","TIBIAL MUSCULAR DYSTROPHY, TARDIVE; TMD" -"OMIM:614817","INTERSTITIAL NEPHRITIS, KARYOMEGALIC; KMIN" -"OMIM:600335","SUCCINIC ACIDEMIA" -"DOID:5258","granular cell leiomyosarcoma" -"OMIM:172900","PIGMENTED PURPURIC ERUPTION" -"OMIM:600343","PAROTID SALIVARY GLANDS, POLYCYSTIC DYSGENETIC DISEASE OF; PDDP" -"OMIM:614819","WEILL-MARCHESANI SYNDROME 3; WMS3" -"DOID:817","interstitial myocarditis" -"OMIM:600347","BREVICAN; BCAN" -"OMIM:614820","ALTERNATING HEMIPLEGIA OF CHILDHOOD 2; AHC2" -"OMIM:614822","SPERMATOGENIC FAILURE 10; SPGF10" -"OMIM:600348","BAND HETEROTOPIA; BH" -"DOID:9255","frontotemporal dementia" -"OMIM:600351","ENTEROPATHY, FAMILIAL, WITH VILLOUS EDEMA AND IMMUNOGLOBULIN G2 DEFICIENCY" -"OMIM:614823","AORTIC VALVE DISEASE 2; AOVD2" -"OMIM:614826","NYSTAGMUS 7, CONGENITAL, AUTOSOMAL DOMINANT; NYS7" -"OMIM:600356","PACHYDERMODACTYLY, FAMILIAL" -"DOID:0110100","atopic dermatitis 4" -"DOID:5268","myxoid leiomyosarcoma" -"DOID:418","systemic scleroderma" -"OMIM:600360","APLASIA CUTIS CONGENITA OF LIMBS, AUTOSOMAL RECESSIVE" -"OMIM:614830","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 8; MDDGA8" -"OMIM:600361","HEREDITARY MOTOR AND SENSORY NEUROPATHY V" -"OMIM:614831","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 13; SCAR13" -"OMIM:600363","SPASTIC PARAPLEGIA 6, AUTOSOMAL DOMINANT; SPG6" -"OMIM:614832","AMELOGENESIS IMPERFECTA, HYPOMATURATION TYPE, IIA4; AI2A4" -"OMIM:614833","MICROCEPHALY, SHORT STATURE, AND POLYMICROGYRIA WITH OR WITHOUT SEIZURES; MSSP" -"DOID:1206","Rett syndrome" -"DOID:9746","hemorrhoid" -"OMIM:600373","CODAS SYNDROME" -"OMIM:600376","TELANGIECTASIA, HEREDITARY HEMORRHAGIC, TYPE 2; HHT2" -"DOID:12732","intermediate uveitis" -"OMIM:614834","THYROTOXIC PERIODIC PARALYSIS, SUSCEPTIBILITY TO, 3; TTPP3" -"OMIM:614836","HUMAN HERPESVIRUS 8, SUSCEPTIBILITY TO; HHV8S" -"OMIM:113450","BRACHYDACTYLY-DISTAL SYMPHALANGISM SYNDROME" -"OMIM:600383","MESOMELIA-SYNOSTOSES SYNDROME" -"OMIM:614837","HYPOGONADOTROPIC HYPOGONADISM 8 WITH OR WITHOUT ANOSMIA; HH8" -"OMIM:600384","APHALANGIA, PARTIAL, WITH SYNDACTYLY AND DUPLICATION OF METATARSAL IV" -"OMIM:614838","HYPOGONADOTROPIC HYPOGONADISM 9 WITH OR WITHOUT ANOSMIA; HH9" -"OMIM:600399","PECTUS EXCAVATUM, MACROCEPHALY, SHORT STATURE, AND DYSPLASTIC NAILS" -"DOID:5253","conventional leiomyosarcoma" -"DOID:883","parasitic helminthiasis infectious disease" -"OMIM:614839","HYPOGONADOTROPIC HYPOGONADISM 10 WITH OR WITHOUT ANOSMIA; HH10" -"OMIM:600416","MUSCULAR DYSTROPHY, SCAPULOHUMERAL" -"DOID:10283","prostate cancer" -"OMIM:614840","HYPOGONADOTROPIC HYPOGONADISM 11 WITH OR WITHOUT ANOSMIA; HH11" -"DOID:2058","chronic mucocutaneous candidiasis" -"OMIM:600419","ANGIOKERATOMA CORPORIS DIFFUSUM WITH ARTERIOVENOUS FISTULAS" -"DOID:12030","panuveitis" -"OMIM:614841","HYPOGONADOTROPIC HYPOGONADISM 12 WITH OR WITHOUT ANOSMIA; HH12" -"OMIM:600430","CHROMOSOME 2q37 DELETION SYNDROME" -"DOID:0060883","intestinal hypomagnesemia 1" -"OMIM:600457","HYPERTRICHOSIS, ANTERIOR CERVICAL" -"OMIM:614842","HYPOGONADOTROPIC HYPOGONADISM 13 WITH OR WITHOUT ANOSMIA; HH13" -"OMIM:600458","ADENOMYOSIS" -"OMIM:113470","BRACHYMESOMELIA-RENAL SYNDROME" -"OMIM:614844","NEPHRONOPHTHISIS 14; NPHP14" -"OMIM:614845","NEPHRONOPHTHISIS 15; NPHP15" -"OMIM:600459","ARTERIAL DISSECTION WITH LENTIGINOSIS" -"DOID:0060108","brain glioma" -"OMIM:614846","TETRASOMY 15q26" -"OMIM:600460","CLEFT PALATE, CARDIAC DEFECT, GENITAL ANOMALIES, AND ECTRODACTYLY" -"OMIM:616964","Moved to 615225" -"OMIM:113310","BRACHYDACTYLY-ECTRODACTYLY WITH FIBULAR APLASIA OR HYPOPLASIA" -"DOID:5251","inflammatory leiomyosarcoma" -"DOID:10442","hypopyon ulcer" -"OMIM:614847","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 12; EIG12" -"OMIM:600461","HEMOLYTIC ANEMIA, LETHAL CONGENITAL NONSPHEROCYTIC, WITH GENITAL AND OTHER ABNORMALITIES" -"OMIM:600462","MYOPATHY, LACTIC ACIDOSIS, AND SIDEROBLASTIC ANEMIA 1; MLASA1" -"OMIM:614849","HERPES SIMPLEX ENCEPHALITIS, SUSCEPTIBILITY TO, 3" -"OMIM:614850","HERPES SIMPLEX ENCEPHALITIS, SUSCEPTIBILITY TO, 4" -"OMIM:600467","MALIGNANT HYPERTHERMIA, SUSCEPTIBILITY TO, 4" -"DOID:0060565","Ritscher-Schinzel syndrome" -"OMIM:600496","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 3; MODY3" -"OMIM:614851","SECKEL SYNDROME 7; SCKL7" -"DOID:2596","larynx cancer" -"DOID:11527","laryngostenosis" -"OMIM:179500","RAINDROP HYPOPIGMENTATION" -"OMIM:600501","ABCD SYNDROME; ABCDS" -"OMIM:614852","MICROCEPHALY 9, PRIMARY, AUTOSOMAL RECESSIVE; MCPH9" -"OMIM:614856","OSTEOGENESIS IMPERFECTA, TYPE XIII; OI13" -"OMIM:600510","GLAUCOMA-RELATED PIGMENT DISPERSION SYNDROME; GPDS1" -"OMIM:614857","METHYLMALONIC ACIDURIA AND HOMOCYSTINURIA, cblJ TYPE; MAHCJ" -"OMIM:113475","BRACHYMETATARSUS IV" -"OMIM:600511","SCHIZOPHRENIA 3; SCZD3" -"DOID:3388","periodontal disease" -"OMIM:600512","EPILEPSY, FAMILIAL TEMPORAL LOBE, 1; ETL1" -"OMIM:614858","HYPOGONADOTROPIC HYPOGONADISM 14 WITH OR WITHOUT ANOSMIA; HH14" -"OMIM:600513","EPILEPSY, NOCTURNAL FRONTAL LOBE, 1; ENFL1" -"OMIM:614859","PEROXISOME BIOGENESIS DISORDER 3A (ZELLWEGER); PBD3A" -"DOID:11130","secondary hypertension" -"OMIM:614860","DYSTONIA 23; DYT23" -"OMIM:600546","INTRAUTERINE GROWTH RETARDATION WITH INCREASED MITOMYCIN C SENSITIVITY" -"OMIM:113400","BRACHYDACTYLY-NYSTAGMUS-CEREBELLAR ATAXIA" -"DOID:5264","epithelioid leiomyosarcoma" -"OMIM:614861","DEAFNESS, AUTOSOMAL RECESSIVE 98; DFNB98" -"OMIM:600559","HYDROCEPHALUS, ENDOCARDIAL FIBROELASTOSIS, AND CATARACTS" -"OMIM:614862","PEROXISOME BIOGENESIS DISORDER 4A (ZELLWEGER); PBD4A" -"OMIM:600561","SPONDYLOEPIPHYSEAL DYSPLASIA WITH ATLANTOAXIAL INSTABILITY" -"OMIM:300716","MENTAL RETARDATION, X-LINKED 95; MRX95" -"DOID:0110042","Alzheimer's disease 3" -"DOID:2799","bronchiolitis obliterans" -"OMIM:300717","REDUCING BODY MYOPATHY, X-LINKED 1A, SEVERE, WITH INFANTILE OR EARLY CHILDHOOD ONSET; RBMX1A" -"OMIM:105210","AMYLOIDOSIS, HEREDITARY, TRANSTHYRETIN-RELATED" -"OMIM:300718","REDUCING BODY MYOPATHY, X-LINKED 1B, WITH LATE CHILDHOOD OR ADULT ONSET; RBMX1B" -"DOID:1759","American histoplasmosis" -"OMIM:300719","DEAFNESS, CATARACT, RETINITIS PIGMENTOSA, AND SPERM ABNORMALITIES" -"DOID:285","hairy cell leukemia" -"OMIM:300749","MENTAL RETARDATION AND MICROCEPHALY WITH PONTINE AND CEREBELLAR HYPOPLASIA; MICPCH" -"DOID:1405","primary angle-closure glaucoma" -"OMIM:105300","AMYOTROPHIC DYSTONIC PARAPLEGIA" -"OMIM:300750","SPASTIC PARAPLEGIA 34, X-LINKED; SPG34" -"DOID:0110048","Alzheimer's disease 15" -"OMIM:105400","AMYOTROPHIC LATERAL SCLEROSIS 1; ALS1" -"OMIM:300751","ANEMIA, SIDEROBLASTIC, 1; SIDBA1" -"DOID:2338","mandibular cancer" -"DOID:0110039","Alzheimer's disease 7" -"OMIM:105250","AMYLOIDOSIS, PRIMARY LOCALIZED CUTANEOUS, 1; PLCA1" -"DOID:0110046","Alzheimer's disease 13" -"OMIM:300752","PROTOPORPHYRIA, ERYTHROPOIETIC, X-LINKED; XLEPP" -"OMIM:300755","AGAMMAGLOBULINEMIA, X-LINKED; XLA" -"DOID:0060480","left ventricular noncompaction" -"DOID:0110047","Alzheimer's disease 14" -"OMIM:300756","ALZHEIMER DISEASE 16; AD16" -"OMIM:300758","HYPOSPADIAS 2, X-LINKED; HYSP2" -"OMIM:184250","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, STRUDWICK TYPE; SEMDSTWK" -"OMIM:300770","SURFACTANT METABOLISM DYSFUNCTION, PULMONARY, 4; SMDP4" -"OMIM:184200","SPONDYLOLISTHESIS" -"DOID:0060686","autosomal dominant nocturnal frontal lobe epilepsy 5" -"OMIM:300778","CORNEAL DYSTROPHY, LISCH EPITHELIAL; LECD" -"DOID:1618","breast fibroadenoma" -"OMIM:300779","CORNEAL DYSTROPHY, ENDOTHELIAL, X-LINKED; XECD" -"DOID:0110041","Alzheimer's disease 8" -"DOID:0110045","Alzheimer's disease 12" -"OMIM:300799","MENTAL RETARDATION, X-LINKED, SYNDROMIC, RAYMOND TYPE; MRXSR" -"DOID:0060466","gingival fibromatosis" -"DOID:0110050","Alzheimer's disease 18" -"OMIM:300801","CHROMOSOME Xp11.23-p11.22 DUPLICATION SYNDROME" -"OMIM:300802","MENTAL RETARDATION, X-LINKED 96; MRX96" -"OMIM:300803","MENTAL RETARDATION, X-LINKED 97; MRX97" -"DOID:0110040","Alzheimer's disease 4" -"OMIM:300804","JOUBERT SYNDROME 10; JBTS10" -"OMIM:184252","SPONDYLOMETAPHYSEAL DYSPLASIA, KOZLOWSKI TYPE; SMDK" -"DOID:0110037","Alzheimer's disease 5" -"OMIM:300807","THROMBOPHILIA, X-LINKED, DUE TO FACTOR IX DEFECT; THPH8" -"DOID:112","esophageal varix" -"OMIM:300809","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 15; SLEB15" -"OMIM:184253","SPONDYLOMETAPHYSEAL DYSPLASIA, ALGERIAN TYPE" -"OMIM:131300","CAMURATI-ENGELMANN DISEASE; CAEND" -"OMIM:300813","SARCOMA, SYNOVIAL" -"DOID:0110049","Alzheimer's disease 17" -"OMIM:300814","NYSTAGMUS 6, CONGENITAL, X-LINKED; NYS6" -"DOID:0050894","ameloblastoma" -"OMIM:131375","ENOLASE, SPERM SPECIFIC; ENO4" -"DOID:0060233","cardiofaciocutaneous syndrome" -"DOID:0060307","autosomal dominant non-syndromic intellectual disability" -"OMIM:300815","CHROMOSOME Xq28 DUPLICATION SYNDROME" -"DOID:0110051","Alzheimer's disease 19" -"OMIM:300816","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 6; COXPD6" -"OMIM:131500","EPICANTHUS" -"DOID:0110043","Alzheimer's disease 10" -"OMIM:300818","PAROXYSMAL NOCTURNAL HEMOGLOBINURIA 1; PNH1" -"DOID:0110044","Alzheimer's disease 11" -"OMIM:300829","CARDIOMYOPATHY, FATAL FETAL, DUE TO MYOCARDIAL CALCIFICATION" -"OMIM:131460","EPIBLEPHARON OF UPPER LID" -"DOID:0110036","Alzheimer's disease 16" -"OMIM:300830","AUTISM, SUSCEPTIBILITY TO, X-LINKED 4; AUTSX4" -"OMIM:300831","CK SYNDROME" -"OMIM:131450","EPIBLEPHARON OF LOWER LID" -"OMIM:131400","EOSINOPHILIA, FAMILIAL" -"OMIM:300833","46,XX SEX REVERSAL 3; SRXX3" -"DOID:0110035","Alzheimer's disease 2" -"DOID:3969","papillary thyroid carcinoma" -"OMIM:300834","MACULAR DEGENERATION, X-LINKED ATROPHIC" -"OMIM:131440","MYELOPROLIFERATIVE DISORDER, CHRONIC, WITH EOSINOPHILIA" -"OMIM:300835","ANEMIA, X-LINKED, WITH OR WITHOUT NEUTROPENIA AND/OR PLATELET ABNORMALITIES; XLANP" -"DOID:0110038","Alzheimer's disease 6" -"OMIM:300842","MCLEOD SYNDROME; MCLDS" -"OMIM:300843","BORNHOLM EYE DISEASE; BED" -"DOID:1059","intellectual disability" -"OMIM:300844","MENTAL RETARDATION, X-LINKED 19; MRX19" -"OMIM:300845","MOYAMOYA DISEASE 4 WITH SHORT STATURE, HYPERGONADOTROPIC HYPOGONADISM, AND FACIAL DYSMORPHISM; MYMY4" -"OMIM:131430","EOSINOPHILOPENIA" -"OMIM:179600","RAYNAUD DISEASE" -"OMIM:609304","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 3; EIEE3" -"OMIM:614863","PEROXISOME BIOGENESIS DISORDER 4B; PBD4B" -"OMIM:136120","FISH-EYE DISEASE; FED" -"OMIM:609306","SPINOCEREBELLAR ATAXIA 26; SCA26" -"OMIM:179613","RECOMBINANT CHROMOSOME 8 SYNDROME" -"OMIM:136400","FOCAL EPITHELIAL HYPERPLASIA OF THE ORAL MUCOSA" -"OMIM:614866","PEROXISOME BIOGENESIS DISORDER 5A (ZELLWEGER); PBD5A" -"OMIM:614867","PEROXISOME BIOGENESIS DISORDER 5B; PBD5B" -"OMIM:609307","SPINOCEREBELLAR ATAXIA 27; SCA27" -"OMIM:609308","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (LIMB-GIRDLE), TYPE C, 1; MDDGC1" -"OMIM:614868","T-CELL IMMUNODEFICIENCY, RECURRENT INFECTIONS, AND AUTOIMMUNITY WITH OR WITHOUT CARDIAC MALFORMATIONS; TIIAC" -"OMIM:609310","COLORECTAL CANCER, HEREDITARY NONPOLYPOSIS, TYPE 2; HNPCC2" -"OMIM:614869","USHER SYNDROME, TYPE IJ; USH1J" -"OMIM:609311","CHARCOT-MARIE-TOOTH DISEASE, TYPE 4H; CMT4H" -"OMIM:614870","PEROXISOME BIOGENESIS DISORDER 6A (ZELLWEGER); PBD6A" -"OMIM:609313","MENTAL RETARDATION, ENTEROPATHY, DEAFNESS, PERIPHERAL NEUROPATHY, ICHTHYOSIS, AND KERATODERMA; MEDNIK" -"OMIM:614871","PEROXISOME BIOGENESIS DISORDER 6B; PBD6B" -"DOID:0110918","hereditary spherocytosis type 3" -"OMIM:609319","HEMATOCRIT/HEMOGLOBIN QUANTITATIVE TRAIT LOCUS 1; HCHGQ1" -"OMIM:614872","PEROXISOME BIOGENESIS DISORDER 7A (ZELLWEGER); PBD7A" -"OMIM:614873","PEROXISOME BIOGENESIS DISORDER 7B; PBD7B" -"OMIM:609320","HEMATOCRIT/HEMOGLOBIN QUANTITATIVE TRAIT LOCUS 2; HCHGQ2" -"DOID:8557","oropharynx cancer" -"OMIM:614874","CILIARY DYSKINESIA, PRIMARY, 18; CILD18" -"OMIM:609322","RHABDOID TUMOR PREDISPOSITION SYNDROME 1; RTPS1" -"DOID:1205","allergic hypersensitivity disease" -"OMIM:170980","PERONEAL NERVE, ACCESSORY DEEP" -"OMIM:614875","METAPHYSEAL ENCHONDROMATOSIS WITH D-2-HYDROXYGLUTARIC ACIDURIA" -"OMIM:609324","EPIPHYSEAL DYSPLASIA, MULTIPLE, WITH SEVERE PROXIMAL FEMORAL DYSPLASIA" -"DOID:0110942","autosomal recessive osteopetrosis 1" -"OMIM:609325","EPIPHYSEAL DYSPLASIA, MULTIPLE, WITH MINIEPIPHYSES" -"OMIM:614876","PEROXISOME BIOGENESIS DISORDER 8A (ZELLWEGER); PBD8A" -"DOID:11638","presbyopia" -"OMIM:614877","PEROXISOME BIOGENESIS DISORDER 8B; PBD8B" -"OMIM:609334","CHROMOSOME 18 PERICENTRIC INVERSION" -"OMIM:609338","CAROTID INTIMAL MEDIAL THICKNESS 1" -"DOID:9744","type 1 diabetes mellitus" -"OMIM:614878","AUTOINFLAMMATION, ANTIBODY DEFICIENCY, AND IMMUNE DYSREGULATION, PLCG2-ASSOCIATED; APLAID" -"OMIM:614879","PEROXISOME BIOGENESIS DISORDER 9B; PBD9B" -"OMIM:609340","SPASTIC PARAPLEGIA 28, AUTOSOMAL RECESSIVE; SPG28" -"DOID:2089","constipation" -"OMIM:136300","FLYNN-AIRD SYNDROME" -"OMIM:136150","FLOOD FACTOR DEFICIENCY" -"OMIM:609345","CEREBRORENODIGITAL SYNDROME WITH LIMB MALFORMATIONS AND TRIRADIATE ACETABULA" -"OMIM:614880","HYPOGONADOTROPIC HYPOGONADISM 15 WITH OR WITHOUT ANOSMIA; HH15" -"DOID:2044","drug-induced hepatitis" -"DOID:4279","infundibulocystic basal cell carcinoma" -"OMIM:609352","EPIDERMOLYSIS BULLOSA SIMPLEX WITH MIGRATORY CIRCINATE ERYTHEMA" -"OMIM:614881","SPINAL MUSCULAR ATROPHY, DISTAL, AUTOSOMAL RECESSIVE, 5; DSMA5" -"OMIM:609354","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 5; BMND5" -"OMIM:614882","PEROXISOME BIOGENESIS DISORDER 10A (ZELLWEGER); PBD10A" -"OMIM:136480","FOURTH CRANIAL NERVE PALSY, FAMILIAL CONGENITAL" -"DOID:0060784","ectrodactyly, ectodermal dysplasia, and cleft lip-palate syndrome 1" -"OMIM:609363","COLLOID CYSTS OF THIRD VENTRICLE" -"OMIM:136500","FOCAL FACIAL DERMAL DYSPLASIA 1, BRAUER TYPE; FFDD1" -"OMIM:614883","PEROXISOME BIOGENESIS DISORDER 11A (ZELLWEGER); PBD11A" -"OMIM:614885","PEROXISOME BIOGENESIS DISORDER 11B; PBD11B" -"OMIM:609376","CATARACT 35; CTRCT35" -"OMIM:614886","PEROXISOME BIOGENESIS DISORDER 12A (ZELLWEGER); PBD12A" -"OMIM:609378","AUTISM, SUSCEPTIBILITY TO, 6; AUTS6" -"DOID:4025","steatitis" -"OMIM:136520","FOVEAL HYPOPLASIA 1; FVH1" -"OMIM:609384","FIBROSIS OF EXTRAOCULAR MUSCLES, CONGENITAL, 3C; CFEOM3C" -"OMIM:614887","PEROXISOME BIOGENESIS DISORDER 13A (ZELLWEGER); PBD13A" -"DOID:11302","cercarial dermatitis" -"DOID:8506","bullous pemphigoid" -"OMIM:614889","IMMUNODEFICIENCY 28; IMD28" -"OMIM:609400","AUTOIMMUNE DISEASE, SUSCEPTIBILITY TO, 4; AIS4" -"DOID:2051","maxillary sinusitis" -"OMIM:609402","PREECLAMPSIA/ECLAMPSIA 2; PEE2" -"OMIM:614890","IMMUNODEFICIENCY 29; IMD29" -"DOID:0110893","inflammatory bowel disease 13" -"DOID:0110944","autosomal recessive osteopetrosis 4" -"OMIM:609403","PREECLAMPSIA/ECLAMPSIA 3; PEE3" -"OMIM:136140","FLOATING-HARBOR SYNDROME; FLHS" -"OMIM:614891","IMMUNODEFICIENCY 30; IMD30" -"OMIM:136200","FLUSHING OF EARS AND SOMNOLENCE" -"OMIM:614892","IMMUNODEFICIENCY 31A; IMD31A" -"OMIM:609404","PREECLAMPSIA/ECLAMPSIA 4; PEE4" -"DOID:9507","ethmoid sinusitis" -"DOID:11401","xanthogranulomatous pyelonephritis" -"OMIM:614893","IMMUNODEFICIENCY 32A; IMD32A" -"OMIM:609408","HOLOPROSENCEPHALY 8; HPE8" -"DOID:0060829","Brooks-Wisniewski-Brown syndrome" -"OMIM:614894","IMMUNODEFICIENCY 32B; IMD32B" -"OMIM:609423","HUMAN IMMUNODEFICIENCY VIRUS TYPE 1, SUSCEPTIBILITY TO" -"DOID:1260","parametritis" -"DOID:2986","IgA glomerulonephritis" -"OMIM:609425","CHROMOSOME 3q29 DELETION SYNDROME" -"OMIM:614895","CHARCOT-MARIE-TOOTH DISEASE, DEMYELINATING, TYPE 4F; CMT4F" -"OMIM:609428","TUKEL SYNDROME" -"OMIM:614896","SINOATRIAL NODE DYSFUNCTION AND DEAFNESS; SANDD" -"DOID:3310","atopic dermatitis" -"OMIM:609432","SYNDACTYLY, MESOAXIAL SYNOSTOTIC, WITH PHALANGEAL REDUCTION; MSSD" -"OMIM:614897","HYPOGONADOTROPIC HYPOGONADISM 16 WITH OR WITHOUT ANOSMIA; HH16" -"DOID:0060497","pollen allergy" -"DOID:10791","frontal sinusitis" -"OMIM:609438","MENTAL RETARDATION, KERATOCONUS, FEBRILE SEIZURES, AND SINOATRIAL BLOCK" -"OMIM:614898","SPASTIC PARAPLEGIA 53, AUTOSOMAL RECESSIVE; SPG53" -"OMIM:614899","DEAFNESS, AUTOSOMAL RECESSIVE 93; DFNB93" -"OMIM:609439","DEAFNESS, AUTOSOMAL RECESSIVE 48; DFNB48" -"OMIM:614900","DIAMOND-BLACKFAN ANEMIA 11; DBA11" -"OMIM:609441","ACROMESOMELIC DYSPLASIA, DEMIRHAN TYPE; AMDD" -"DOID:0110919","hereditary spherocytosis type 4" -"DOID:13031","balanoposthitis" -"DOID:12211","filarial elephantiasis" -"OMIM:609442","VALPROATE EMBRYOPATHY, SUSCEPTIBILITY TO" -"OMIM:614915","LETHAL CONGENITAL CONTRACTURE SYNDROME 4; LCCS4" -"DOID:12143","neurogenic bladder" -"OMIM:609446","PAROXYSMAL NONKINESIGENIC DYSKINESIA, 3, WITH OR WITHOUT GENERALIZED EPILEPSY; PNKD3" -"OMIM:614916","VENTRICULAR TACHYCARDIA, CATECHOLAMINERGIC POLYMORPHIC, 4; CPVT4" -"DOID:0110992","Joubert syndrome 23" -"OMIM:180270","RETINOSCHISIS, AUTOSOMAL DOMINANT" -"DOID:0060058","lymphoma" -"DOID:10041","dysplastic nevus syndrome" -"DOID:3948","adrenocortical carcinoma" -"DOID:5723","optic atrophy" -"OMIM:180600","RINGED HAIR" -"DOID:9739","eustachian tube disease" -"DOID:0111001","Joubert syndrome 6" -"DOID:583","hemolytic anemia" -"DOID:10314","endocarditis" -"DOID:2474","vernal conjunctivitis" -"DOID:0110987","Joubert syndrome 18" -"DOID:5041","esophageal cancer" -"OMIM:180360","RHINY" -"OMIM:180500","AXENFELD-RIEGER SYNDROME, TYPE 1; RIEG1" -"DOID:8140","adrenal gland ganglioneuroblastoma" -"DOID:0110960","Gaucher's disease perinatal lethal" -"DOID:3587","pancreatic ductal carcinoma" -"DOID:0111000","Joubert syndrome 5" -"DOID:5719","adrenal medulla cancer" -"OMIM:180350","RHEUMATOID NODULOSIS" -"DOID:9388","lens-induced iridocyclitis" -"OMIM:180300","RHEUMATOID ARTHRITIS; RA" -"DOID:9512","simple chronic conjunctivitis" -"DOID:3275","thymoma" -"OMIM:180295","RHABDOMYOSARCOMA, EMBRYONAL, 2; RMSE2" -"DOID:0110983","Joubert syndrome 14" -"DOID:13868","hypoactive sexual desire disorder" -"DOID:0110986","Joubert syndrome 17" -"DOID:3748","esophagus squamous cell carcinoma" -"DOID:907","liver fibroma" -"DOID:0111002","Joubert syndrome 7" -"DOID:2373","hereditary elliptocytosis" -"DOID:660","adrenal cortex cancer" -"DOID:13326","chronic follicular conjunctivitis" -"DOID:0110985","Joubert syndrome 16" -"DOID:0110961","atypical Gaucher's disease due to saposin c deficiency" -"DOID:8923","skin melanoma" -"DOID:0110988","Joubert syndrome 2" -"DOID:0060376","Joubert syndrome with orofaciodigital defect" -"DOID:11244","neonatal anemia" -"DOID:0111004","Joubert syndrome 9" -"OMIM:608078","SCHIZOPHRENIA 11" -"OMIM:614229","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 11; SCAR11" -"OMIM:608088","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, TYPE I, WITH COUGH AND GASTROESOPHAGEAL REFLUX" -"DOID:4890","juvenile myoclonic epilepsy" -"DOID:4739","testicular Brenner tumor" -"OMIM:614230","CHROMOSOME 8q21.11 DELETION SYNDROME" -"OMIM:157900","MOEBIUS SYNDROME; MBS" -"OMIM:614231","MICROCEPHALY, EPILEPSY, AND DIABETES SYNDROME; MEDS" -"OMIM:608089","ENDOMETRIAL CANCER" -"OMIM:608091","JOUBERT SYNDROME 2; JBTS2" -"OMIM:158170","CHROMOSOME 9p DELETION SYNDROME" -"OMIM:614233","HYPERPIGMENTATION, FAMILIAL PROGRESSIVE, 1; FPH1" -"DOID:4398","pustulosis of palm and sole" -"OMIM:614237","HYPOTRICHOSIS 9; HYPT9" -"OMIM:160980","CARNEY COMPLEX, TYPE 1; CNC1" -"OMIM:608093","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ij; CDG1J" -"OMIM:157950","PERMANENT MOLARS, SECONDARY RETENTION OF" -"OMIM:608096","EPILEPSY, FAMILIAL TEMPORAL LOBE, 2; ETL2" -"OMIM:614238","HYPOTRICHOSIS 10; HYPT10" -"OMIM:158040","ANTIGEN DEFINED BY MONOCLONAL ANTIBODY T87" -"DOID:9547","non-secretory myeloma" -"OMIM:160900","MYOTONIC DYSTROPHY 1; DM1" -"DOID:2237","hepatitis" -"OMIM:614249","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 18; MRT18" -"OMIM:608097","PERIVENTRICULAR HETEROTOPIA WITH MICROCEPHALY, AUTOSOMAL RECESSIVE; ARPHM" -"DOID:4554","type C thymoma" -"OMIM:157960","MOLONEY LEUKEMIA VIRUS INTEGRATION SITE 2, MOUSE, HOMOLOG OF; MLVI2" -"OMIM:122470","CORNELIA DE LANGE SYNDROME 1; CDLS1" -"OMIM:160570","MYOPATHY WITH STORAGE OF GLYCOPROTEINS AND GLYCOSAMINOGLYCANS" -"OMIM:614250","NARCOLEPSY 7; NRCLP7" -"OMIM:608098","HETEROTOPIA, PERIVENTRICULAR, ASSOCIATED WITH CHROMOSOME 5p ANOMALIES" -"DOID:13809","familial combined hyperlipidemia" -"DOID:1156","chondrocalcinosis" -"DOID:0050819","Matthew-Wood syndrome" -"DOID:3985","ostertagiasis" -"DOID:0050737","autosomal recessive disease" -"DOID:4873","anterior horn cell disease" -"DOID:0060014","CD45 deficiency" -"DOID:3121","gallbladder cancer" -"DOID:14049","phaeohyphomycosis" -"DOID:1116","pertussis" -"DOID:0060007","CD3zeta deficiency" -"DOID:0050736","autosomal dominant disease" -"DOID:9423","blepharitis" -"DOID:0060015","interleukin-7 receptor alpha deficiency" -"DOID:11186","allescheriosis" -"DOID:1254","trichostrongylosis" -"DOID:0050475","Weill-Marchesani syndrome" -"DOID:0060011","recombinase activating gene 1 deficiency" -"DOID:9410","panhypopituitarism" -"DOID:0090012","severe combined immunodeficiency with sensitivity to ionizing radiation" -"DOID:0050852","limb ischemia" -"OMIM:183050","SPINOCEREBELLAR ATAXIA WITH RIGIDITY AND PERIPHERAL NEUROPATHY" -"DOID:5940","malignant peripheral nerve sheath tumor" -"DOID:9159","gas gangrene" -"DOID:2992","prostate neuroendocrine neoplasm" -"DOID:0050689","brachydactyly-syndactyly syndrome" -"DOID:9965","toxoplasmosis" -"DOID:0060016","CD3delta deficiency" -"DOID:2231","factor XII deficiency" -"DOID:2965","bursitis" -"DOID:12750","cyclosporiasis" -"DOID:10290","prostate lymphoma" -"DOID:0060018","CD3gamma deficiency" -"DOID:10289","prostate malignant phyllodes tumor" -"DOID:0090014","severe combined immunodeficiency, autosomal recessive, T cell-negative, B cell-positive, Nk cell-positive" -"DOID:2112","cystoisosporiasis" -"DOID:9550","indolent myeloma" -"DOID:0060019","coronin-1A deficiency" -"DOID:0060180","colitis" -"DOID:0060009","MHC class I deficiency" -"DOID:3332","haemonchiasis" -"DOID:9541","osteosclerotic myeloma" -"DOID:0050072","adiaspiromycosis" -"DOID:11603","infant gynecomastia" -"DOID:0060323","breast abscess" -"DOID:11557","acute serous otitis media" -"DOID:5998","microglandular adenosis" -"DOID:0110136","Bardet-Biedl syndrome 14" -"DOID:12894","Sjogren's syndrome" -"OMIM:608099","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2D; LGMD2D" -"DOID:0050047","Flinders Island spotted fever" -"OMIM:608104","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ih; CDG1H" -"DOID:0110126","Bardet-Biedl syndrome 4" -"OMIM:608105","EPILEPSY, ROLANDIC, WITH PAROXYSMAL EXERCISE-INDUCED DYSTONIA AND WRITER'S CRAMP; EPRPDC" -"DOID:0110137","Bardet-Biedl syndrome 15" -"OMIM:608106","IMMUNODEFICIENCY WITH HYPER-IgM, TYPE 5; HIGM5" -"DOID:0060050","autoimmune disease of blood" -"OMIM:608115","OVARIAN HYPERSTIMULATION SYNDROME; OHSS" -"OMIM:608118","ZINC DEFICIENCY, TRANSIENT NEONATAL; TNZD" -"DOID:0050052","Rocky Mountain spotted fever" -"DOID:0110135","Bardet-Biedl syndrome 13" -"OMIM:608133","RETINITIS PIGMENTOSA 7; RP7" -"DOID:2987","familial Mediterranean fever" -"OMIM:608149","KAGAMI-OGATA SYNDROME" -"DOID:0050160","inhalation anthrax" -"OMIM:608154","LIPODYSTROPHY, GENERALIZED, WITH MENTAL RETARDATION, DEAFNESS, SHORT STATURE, AND SLENDER BONES" -"OMIM:608156","NABLUS MASK-LIKE FACIAL SYNDROME; NMLFS" -"DOID:0110134","Bardet-Biedl syndrome 12" -"DOID:12132","Wegener's granulomatosis" -"DOID:849","rheumatoid lung disease" -"OMIM:608158","CoQ-RESPONSIVE OXPHOS DEFICIENCY" -"OMIM:608161","MACULAR DYSTROPHY, VITELLIFORM, 3; VMD3" -"DOID:0060032","autoimmune disease of musculoskeletal system" -"DOID:0110129","Bardet-Biedl syndrome 7" -"OMIM:608173","AUTOIMMUNE THYROID DISEASE, SUSCEPTIBILITY TO, 1" -"OMIM:183850","SPONDYLOEPIPHYSEAL DYSPLASIA WITH PUNCTATE CORNEAL DYSTROPHY" -"OMIM:608174","AUTOIMMUNE THYROID DISEASE, SUSCEPTIBILITY TO, 2" -"DOID:0090029","CINCA Syndrome" -"OMIM:608175","AUTOIMMUNE THYROID DISEASE, SUSCEPTIBILITY TO, 3; AITD3" -"OMIM:183900","SPONDYLOEPIPHYSEAL DYSPLASIA CONGENITA; SEDC" -"DOID:0050050","Japanese spotted fever" -"DOID:0110139","Bardet-Biedl syndrome 17" -"DOID:11103","rickettsialpox" -"OMIM:608176","AUTOIMMUNE THYROID DISEASE, SUSCEPTIBILITY TO, 4" -"DOID:0090018","autosomal dominant familial periodic fever" -"OMIM:608180","SYNPOLYDACTYLY 2; SPD2" -"DOID:0060051","autoimmune disease of cardiovascular system" -"OMIM:608184","IMMUNODEFICIENCY WITH HYPER-IgM, TYPE 4; HIGM4" -"OMIM:170700","PERIPHERAL DYSOSTOSIS" -"OMIM:608189","TROPICAL CALCIFIC PANCREATITIS" -"DOID:0060039","autoimmune disease of skin and connective tissue" -"OMIM:608194","CONE-ROD DYSTROPHY 13; CORD13" -"DOID:7512","localized intraductal papillomatosis" -"OMIM:608203","NEUTROPHIL IMMUNODEFICIENCY SYNDROME" -"DOID:9602","necrotizing fasciitis" -"DOID:10921","Siberian tick typhus" -"OMIM:608207","KALA-AZAR, SUSCEPTIBILITY TO, 1; KAZA1" -"OMIM:608217","SEIZURES, BENIGN FAMILIAL NEONATAL, 3; BFNS3" -"DOID:0060049","autoimmune disease of urogenital tract" -"OMIM:608219","DEAFNESS, AUTOSOMAL RECESSIVE 38; DFNB38" -"OMIM:608220","SPASTIC PARAPLEGIA 25, AUTOSOMAL RECESSIVE; SPG25" -"DOID:0060030","autoimmune disease of eyes, ear, nose and throat" -"OMIM:608223","ASPIRIN RESISTANCE" -"DOID:0060029","autoimmune disease of exocrine system" -"OMIM:608224","DEAFNESS, AUTOSOMAL DOMINANT 41; DFNA41" -"DOID:12900","Mikulicz disease" -"DOID:0110125","Bardet-Biedl syndrome 3" -"OMIM:608227","CRANIOFACIAL ABNORMALITIES, CATARACTS, CONGENITAL HEART DISEASE, SACRAL NEURAL TUBE DEFECTS, AND GROWTH AND DEVELOPMENTAL RETARDATION" -"DOID:4235","spindle cell sarcoma" -"OMIM:178500","PULMONARY FIBROSIS, IDIOPATHIC; IPF" -"OMIM:608232","LEUKEMIA, CHRONIC MYELOID; CML" -"DOID:0050043","Israeli tick typhus" -"OMIM:608233","HERMANSKY-PUDLAK SYNDROME 2; HPS2" -"DOID:13080","Jaccoud's syndrome" -"DOID:502","central nervous system mesenchymal non-meningothelial tumor" -"OMIM:608236","SLOWED NERVE CONDUCTION VELOCITY, AUTOSOMAL DOMINANT; SNCV" -"DOID:0110130","Bardet-Biedl syndrome 8" -"OMIM:171450","PHLEBECTASIA OF LIPS" -"DOID:0060031","autoimmune disease of gastrointestinal tract" -"OMIM:608244","OTOSCLEROSIS 3; OTSC3" -"DOID:7697","pancreatic ACTH hormone producing tumor" -"OMIM:608251","PHOBIA, SPECIFIC" -"OMIM:608257","MANDIBULOFACIAL DYSOSTOSIS WITH PTOSIS, AUTOSOMAL DOMINANT" -"DOID:12029","sympathetic ophthalmia" -"OMIM:608264","DEAFNESS, AUTOSOMAL RECESSIVE 40; DFNB40" -"DOID:0110124","Bardet-Biedl syndrome 2" -"OMIM:608265","DEAFNESS, AUTOSOMAL RECESSIVE 39; DFNB39" -"DOID:0060774","congenital diarrhea" -"OMIM:614251","PARKINSON DISEASE 18, AUTOSOMAL DOMINANT, SUSCEPTIBILITY TO; PARK18" -"OMIM:614252","ANEURYSM, INTRACRANIAL BERRY, 11; ANIB11" -"DOID:4731","atrophic rhinitis" -"OMIM:614254","MENTAL RETARDATION, AUTOSOMAL DOMINANT 8; MRD8" -"DOID:12140","Chagas disease" -"DOID:4730","vasomotor rhinitis" -"DOID:0090091","hypogonadotropic hypogonadism 23 with or without anosmia" -"OMIM:614255","MENTAL RETARDATION, AUTOSOMAL DOMINANT 9; MRD9" -"OMIM:614256","MENTAL RETARDATION, AUTOSOMAL DOMINANT 10; MRD10" -"DOID:4889","lymph node tuberculosis" -"OMIM:614257","MENTAL RETARDATION, AUTOSOMAL DOMINANT 11; MRD11" -"OMIM:614261","MICROCEPHALY-CAPILLARY MALFORMATION SYNDROME; MICCAP" -"OMIM:614262","ARTHROGRYPOSIS, PERTHES DISEASE, AND UPWARD GAZE PALSY; APUG" -"OMIM:614265","COMBINED MALONIC AND METHYLMALONIC ACIDURIA; CMAMMA" -"DOID:3803","Crigler-Najjar syndrome" -"DOID:0090084","hypogonadotropic hypogonadism 5 with or without anosmia" -"OMIM:614266","BARRETT ESOPHAGUS" -"OMIM:614278","PLATELET-ACTIVATING FACTOR ACETYLHYDROLASE DEFICIENCY; PAFAD" -"OMIM:614279","46,XY SEX REVERSAL 8; SRXY8" -"OMIM:614280","EPILEPSY, JUVENILE MYOCLONIC, SUSCEPTIBILITY TO, 9; EJM9" -"OMIM:614284","STICKLER SYNDROME, TYPE V; STL5" -"DOID:0090094","hypogonadotropic hypogonadism 1 with or without anosmia" -"OMIM:614286","MYELODYSPLASTIC SYNDROME; MDS" -"OMIM:150800","HEREDITARY LEIOMYOMATOSIS AND RENAL CELL CANCER; HLRCC" -"OMIM:614290","TETRASOMY 18p" -"OMIM:614291","BREAST-OVARIAN CANCER, FAMILIAL, SUSCEPTIBILITY TO, 4; BROVCA4" -"DOID:2312","nocardiosis" -"DOID:0090093","hypogonadotropic hypogonadism 21 with or without anosmia" -"DOID:12934","Kearns-Sayre syndrome" -"OMIM:614292","MYOPIA, HIGH, WITH CATARACT AND VITREORETINAL DEGENERATION; MCVD" -"DOID:6510","lung occult squamous cell carcinoma" -"DOID:1591","renovascular hypertension" -"OMIM:614293","HYDATIDIFORM MOLE, RECURRENT, 2; HYDM2" -"OMIM:614294","CHROMOSOME 15q25 DELETION SYNDROME" -"DOID:10177","malignant hypertensive renal disease" -"OMIM:614296","WOLFRAM-LIKE SYNDROME, AUTOSOMAL DOMINANT; WFSL" -"DOID:0050161","lower respiratory tract disease" -"OMIM:614298","NEURODEGENERATION WITH BRAIN IRON ACCUMULATION 4; NBIA4" -"DOID:0060226","acrofrontofacionasal dysostosis" -"OMIM:614299","MULTIPLE MITOCHONDRIAL DYSFUNCTIONS SYNDROME 2 WITH HYPERGLYCINEMIA; MMDS2" -"OMIM:614300","HYPERMETHIONINEMIA DUE TO ADENOSINE KINASE DEFICIENCY" -"DOID:1417","choroid disease" -"DOID:11088","asphyxia neonatorum" -"OMIM:614302","EMERY-DREIFUSS MUSCULAR DYSTROPHY 7, AUTOSOMAL DOMINANT; EDMD7" -"OMIM:614303","EDICT SYNDROME; EDICT" -"DOID:0090071","hypogonadotropic hypogonadism 11 with or without anosmia" -"DOID:9123","eczema herpeticum" -"OMIM:614305","SCLEROSTEOSIS 2; SOST2" -"DOID:0050888","syndromic intellectual disability" -"OMIM:614306","COGNITIVE IMPAIRMENT WITH OR WITHOUT CEREBELLAR ATAXIA; CIAT" -"OMIM:614307","ALPHA-METHYLACYL-CoA RACEMASE DEFICIENCY; AMACRD" -"DOID:9395","croup" -"OMIM:614317","VESICOURETERAL REFLUX 4; VUR4" -"DOID:4336","tinea favosa" -"DOID:12308","Dubin-Johnson syndrome" -"OMIM:150699","LEIOMYOMA, UTERINE; UL" -"OMIM:614318","VESICOURETERAL REFLUX 5; VUR5" -"OMIM:614319","VESICOURETERAL REFLUX 6; VUR6" -"OMIM:150700","LEIOMYOMA OF VULVA AND ESOPHAGUS" -"OMIM:614320","PANCREATIC CANCER, SUSCEPTIBILITY TO, 4; PNCA4" -"OMIM:614321","MYOPATHY, DISTAL, TATEYAMA TYPE; MPDT" -"DOID:0050097","ectothrix infectious disease" -"OMIM:614322","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 12; SCAR12" -"OMIM:150900","LENTIGINES" -"OMIM:614323","NEVOID HYPERMELANOSIS, LINEAR AND WHORLED; LWNH" -"OMIM:240400","HYPOASCORBEMIA" -"DOID:11197","serous conjunctivitis except viral" -"OMIM:240500","IMMUNODEFICIENCY, COMMON VARIABLE, 2; CVID2" -"OMIM:240600","GLYCOGEN STORAGE DISEASE 0, LIVER; GSD0A" -"OMIM:240800","HYPOGLYCEMIA, LEUCINE-INDUCED; LIH" -"OMIM:240900","HYPOINSULINEMIC HYPOGLYCEMIA WITH HEMIHYPERTROPHY; HIHGHH" -"OMIM:240950","HYPOGONADISM-CATARACT SYNDROME" -"OMIM:241000","HYPOGONADISM WITH LOW-GRADE MENTAL DEFICIENCY AND MICROCEPHALY" -"OMIM:241080","WOODHOUSE-SAKATI SYNDROME" -"OMIM:241090","HYPERGONADOTROPIC HYPOGONADISM AND PARTIAL ALOPECIA" -"OMIM:241100","HYPOGONADISM, MALE" -"OMIM:241120","HYPOHIDROSIS WITH ABNORMAL PALMAR DERMAL RIDGES" -"DOID:11782","astigmatism" -"OMIM:241150","HYPOKALEMIC ALKALOSIS, FAMILIAL, WITH SPECIFIC RENAL TUBULOPATHY" -"DOID:13619","extrahepatic cholestasis" -"OMIM:241200","BARTTER SYNDROME, TYPE 2, ANTENATAL; BARTS2" -"OMIM:241310","HYPOMANDIBULAR FACIOCRANIAL DYSOSTOSIS" -"DOID:11277","Plummer's disease" -"OMIM:241410","HYPOPARATHYROIDISM-RETARDATION-DYSMORPHISM SYNDROME; HRDS" -"DOID:0050674","congenital bile acid synthesis defect" -"OMIM:241500","HYPOPHOSPHATASIA, INFANTILE" -"OMIM:241510","HYPOPHOSPHATASIA, CHILDHOOD" -"DOID:9834","hyperopia" -"OMIM:241519","HYPOPHOSPHATEMIA, RENAL, WITH INTRACEREBRAL CALCIFICATIONS" -"OMIM:241520","HYPOPHOSPHATEMIC RICKETS, AUTOSOMAL RECESSIVE, 1; ARHR1" -"DOID:0110868","congenital stationary night blindness 1D" -"OMIM:241530","HYPOPHOSPHATEMIC RICKETS WITH HYPERCALCIURIA, HEREDITARY; HHRH" -"DOID:4442","cervical alveolar soft part sarcoma" -"OMIM:241540","HYPOPITUITARISM, CONGENITAL, WITH CENTRAL DIABETES INSIPIDUS" -"DOID:10794","sphenoid sinusitis" -"OMIM:241550","HYPOPLASTIC LEFT HEART SYNDROME 1; HLHS1" -"DOID:4112","cervical carcinosarcoma" -"OMIM:241600","IMMUNODEFICIENCY 43; IMD43" -"DOID:0060020","reticular dysgenesis" -"OMIM:241760","HYPOSPADIAS-MENTAL RETARDATION SYNDROME" -"OMIM:241800","HYPOTHALAMIC HAMARTOMAS" -"DOID:0060810","syndromic X-linked intellectual disability type 10" -"OMIM:241850","HYPOTHYROIDISM, THYROIDAL OR ATHYROIDAL, WITH SPIKY HAIR AND CLEFT PALATE" -"OMIM:242050","HYPOURICEMIA, HYPERCALCINURIA, AND DECREASED BONE DENSITY" -"DOID:3445","scrotal carcinoma" -"OMIM:242100","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 2; ARCI2" -"OMIM:242150","ICHTHYOSIFORM ERYTHRODERMA, CORNEAL INVOLVEMENT, AND DEAFNESS" -"OMIM:242300","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 1; ARCI1" -"DOID:8712","neurofibromatosis" -"OMIM:242400","ICHTHYOSIS CONGENITA WITH BILIARY ATRESIA" -"DOID:11512","Budd-Chiari syndrome" -"DOID:221","acute perichondritis of pinna" -"OMIM:242500","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 4B; ARCI4B" -"DOID:12273","anisometropia" -"OMIM:242510","ICHTHYOSIS WITH ALOPECIA, ECLABIUM, ECTROPION, AND MENTAL RETARDATION" -"OMIM:242520","ICHTHYOSIS, HEPATOSPLENOMEGALY, AND CEREBELLAR DEGENERATION" -"OMIM:242530","ICHTHYOSIS, MENTAL RETARDATION, DWARFISM, AND RENAL IMPAIRMENT" -"OMIM:242550","ICHTHYOSIS, SPLIT HAIRS, AND AMINO ACIDURIA" -"DOID:11850","transient refractive change" -"OMIM:608266","PARATHYROID CARCINOMA" -"DOID:0060060","non-Hodgkin lymphoma" -"OMIM:614324","OVARIAN DYSGENESIS 3; ODG3" -"DOID:11724","limb-girdle muscular dystrophy" -"OMIM:614325","PITT-HOPKINS-LIKE SYNDROME 2; PTHSL2" -"OMIM:608278","GROWTH FAILURE, MICROCEPHALY, MENTAL RETARDATION, CATARACTS, LARGE JOINT CONTRACTURES, OSTEOPOROSIS, CORTICAL DYSPLASIA, AND CEREBELLAR ATROPHY" -"DOID:5612","spinal cancer" -"OMIM:608279","CRANIOSYNOSTOSIS WITH OCULAR ABNORMALITIES AND HALLUCAL DEFECTS" -"OMIM:614326","FEINGOLD SYNDROME 2; FGLDS2" -"DOID:12849","autistic disorder" -"DOID:14068","blackwater fever" -"OMIM:608281","SCIMITAR ANOMALY, MULTIPLE CARDIAC MALFORMATIONS, AND CRANIOFACIAL AND CENTRAL NERVOUS SYSTEM ABNORMALITIES" -"OMIM:614327","TUMOR PREDISPOSITION SYNDROME; TPDS" -"OMIM:608290","LELIS SYNDROME" -"OMIM:614328","INFLAMMATORY SKIN AND BOWEL DISEASE, NEONATAL, 1; NISBD1" -"DOID:5798","macrotrabecular hepatoblastoma" -"OMIM:608316","CORONARY HEART DISEASE, SUSCEPTIBILITY TO, 2" -"OMIM:614329","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 31; MRT31" -"OMIM:614331","COLORECTAL CANCER, HEREDITARY NONPOLYPOSIS, TYPE 6; HNPCC6" -"OMIM:608318","CORONARY HEART DISEASE, SUSCEPTIBILITY TO, 4" -"DOID:0060230","basal ganglia calcification" -"OMIM:614332","CHROMOSOME 2p16.3 DELETION SYNDROME" -"OMIM:608320","CORONARY ARTERY DISEASE, AUTOSOMAL DOMINANT, 1; ADCAD1" -"DOID:2846","bruxism" -"OMIM:608323","CHARCOT-MARIE-TOOTH DISEASE, DOMINANT INTERMEDIATE C; CMTDIC" -"OMIM:614333","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 29; MRT29" -"DOID:13241","Behcet's disease" -"DOID:13258","typhoid fever" -"OMIM:614335","ARTHROGRYPOSIS, DISTAL, TYPE 1B; DA1B" -"OMIM:608328","WEILL-MARCHESANI SYNDROME 2; WMS2" -"OMIM:608340","CHARCOT-MARIE-TOOTH DISEASE, RECESSIVE INTERMEDIATE A; CMTRIA" -"OMIM:614337","COLORECTAL CANCER, HEREDITARY NONPOLYPOSIS, TYPE 4; HNPCC4" -"OMIM:614338","PANCREATIC LIPASE DEFICIENCY; PNLIPD" -"OMIM:608345","NYSTAGMUS 3, CONGENITAL, AUTOSOMAL DOMINANT; NYS3" -"OMIM:614340","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 27; MRT27" -"OMIM:608354","CAPILLARY MALFORMATION-ARTERIOVENOUS MALFORMATION; CMAVM" -"DOID:4505","pediatric angiosarcoma" -"DOID:7347","ovarian stromal hyperthecosis" -"OMIM:614341","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 33; MRT33" -"DOID:5419","schizophrenia" -"OMIM:608355","PARKES WEBER SYNDROME" -"OMIM:614342","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 30; MRT30" -"OMIM:608358","MYOPATHY, MYOSIN STORAGE, AUTOSOMAL DOMINANT; MSMA" -"OMIM:608361","SPONDYLOEPIPHYSEAL DYSPLASIA, KIMBERLEY TYPE; SEDK" -"OMIM:614343","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 19; MRT19" -"OMIM:614344","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 23; MRT23" -"OMIM:608363","CHROMOSOME 22q11.2 DUPLICATION SYNDROME" -"OMIM:608367","MYOPIA 17, AUTOSOMAL DOMINANT; MYP17" -"DOID:320","vascular myelopathy" -"OMIM:614345","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 24; MRT24" -"OMIM:614346","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 25; MRT25" -"OMIM:608371","OROFACIAL CLEFT 4; OFC4" -"DOID:13943","acute gonococcal prostatitis" -"OMIM:608372","DEAFNESS, AUTOSOMAL DOMINANT 49; DFNA49" -"OMIM:614347","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 28; MRT28" -"DOID:8577","ulcerative colitis" -"OMIM:614350","COLORECTAL CANCER, HEREDITARY NONPOLYPOSIS, TYPE 5; HNPCC5" -"OMIM:608380","RETINITIS PIGMENTOSA 26; RP26" -"DOID:0060500","drug allergy" -"DOID:1184","nephrotic syndrome" -"OMIM:614369","PERIPHERAL NEUROPATHY, MYOPATHY, HOARSENESS, AND HEARING LOSS; PNMHH" -"OMIM:608389","BRANCHIOOTIC SYNDROME 3; BOS3" -"OMIM:614370","SURFACTANT METABOLISM DYSFUNCTION, PULMONARY, 5; SMDP5" -"OMIM:608390","MYOTONIA, POTASSIUM-AGGRAVATED" -"OMIM:614371","DENGUE VIRUS, SUSCEPTIBILITY TO" -"OMIM:608391","AUTOIMMUNE DISEASE, SUSCEPTIBILITY TO, 2; AIS2" -"OMIM:614372","MANNOSE-BINDING LECTIN DEFICIENCY; MBLD" -"OMIM:608392","AUTOIMMUNE DISEASE, SUSCEPTIBILITY TO, 3; AIS3" -"DOID:322","myelitis" -"OMIM:608393","MICROCEPHALY 6, PRIMARY, AUTOSOMAL RECESSIVE; MCPH6" -"OMIM:614373","AMYOTROPHIC LATERAL SCLEROSIS 16, JUVENILE; ALS16" -"DOID:0050810","biotin deficiency" -"OMIM:608394","DEAFNESS, AUTOSOMAL DOMINANT 43; DFNA43" -"OMIM:614374","BLOOD GROUP, CHIDO/RODGERS SYSTEM" -"DOID:3283","invasive malignant thymoma" -"DOID:2951","motion sickness" -"DOID:10322","berylliosis" -"OMIM:614375","AORTIC ANEURYSM, FAMILIAL ABDOMINAL, 4; AAA4" -"OMIM:608404","PLATELET GLYCOPROTEIN IV DEFICIENCY" -"OMIM:614376","SHORT-RIB THORACIC DYSPLASIA 5 WITH OR WITHOUT POLYDACTYLY; SRTD5" -"OMIM:608406","VATER-LIKE DEFECTS WITH PULMONARY HYPERTENSION, LARYNGEAL WEBS, AND GROWTH DEFICIENCY" -"DOID:13406","pulmonary sarcoidosis" -"OMIM:608410","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 7; BMIQ7" -"OMIM:614377","NEPHRONOPHTHISIS 13; NPHP13" -"OMIM:614378","CRANIOECTODERMAL DYSPLASIA 4; CED4" -"OMIM:608415","PROLONGED ELECTRORETINAL RESPONSE SUPPRESSION; PERRS" -"OMIM:614379","COMPLEMENT COMPONENT 4B DEFICIENCY; C4BD" -"OMIM:608423","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 1F; LGMD1F" -"OMIM:614380","COMPLEMENT COMPONENT 4A DEFICIENCY; C4AD" -"OMIM:608432","CRANIOSYNOSTOSIS, CALCIFICATION OF BASAL GANGLIA, AND FACIAL DYSMORPHISM" -"DOID:0110851","rhizomelic chondrodysplasia punctata type 1" -"OMIM:608437","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 4; SLEB4" -"DOID:13198","endemic goiter" -"OMIM:614381","LEUKODYSTROPHY, HYPOMYELINATING, 8, WITH OR WITHOUT OLIGODONTIA AND/OR HYPOGONADOTROPIC HYPOGONADISM; HLD8" -"DOID:0050696","fetal alcohol spectrum disorder" -"OMIM:614382","BACTEREMIA, SUSCEPTIBILITY TO, 1; BACTS1" -"OMIM:608443","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 3; MRT3" -"DOID:10773","bubonic plague" -"OMIM:614383","BACTEREMIA, SUSCEPTIBILITY TO, 2; BACTS2" -"OMIM:608445","SPEECH-SOUND DISORDER" -"OMIM:142945","HOLOPROSENCEPHALY 3; HPE3" -"OMIM:601583","WILMS TUMOR 5; WT5" -"OMIM:601596","CHARCOT-MARIE-TOOTH DISEASE, TYPE 4C; CMT4C" -"OMIM:601606","TRICHOEPITHELIOMA, MULTIPLE FAMILIAL, 1" -"OMIM:175860","PALMOPLANTAR KERATODERMA, PUNCTATE TYPE II; PPKP2" -"OMIM:601608","SPASTIC PARAPLEGIA AND EVANS SYNDROME" -"DOID:12663","blastomycosis" -"OMIM:601612","LUNG AGENESIS, CONGENITAL HEART DEFECTS, AND THUMB ANOMALIES SYNDROME; LACHT" -"OMIM:164000","NOSE, ANOMALOUS SHAPE OF" -"OMIM:601616","IRIS PIGMENT EPITHELIUM ANOMALIES" -"DOID:4985","extraosseous Ewings sarcoma-primitive neuroepithelial tumor" -"DOID:13921","bacterial esophagitis" -"OMIM:601626","LEUKEMIA, ACUTE MYELOID; AML" -"OMIM:143000","HORNER SYNDROME, CONGENITAL" -"OMIM:601631","ANTERIOR SEGMENT DYSGENESIS 3; ASGD3" -"OMIM:601634","NEURAL TUBE DEFECTS, FOLATE-SENSITIVE; NTDFS" -"OMIM:601650","PARAGANGLIOMAS 2; PGL2" -"OMIM:142770","HLA MODIFIER" -"OMIM:601665","OBESITY" -"DOID:4659","extracutaneous mastocytoma" -"DOID:0060888","transient myeloproliferative syndrome" -"OMIM:163850","NODULI CUTANEI, MULTIPLE, WITH URINARY TRACT ABNORMALITIES" -"OMIM:601666","DIABETES MELLITUS, INSULIN-DEPENDENT, 15; IDDM15" -"OMIM:173000","PILONIDAL SINUS" -"OMIM:601668","SPONDYLOEPIMETAPHYSEAL DYSPLASIA WITH ABNORMAL DENTITION; SEMDAD" -"DOID:2581","chondrodysplasia punctata" -"OMIM:142900","HOLT-ORAM SYNDROME; HOS" -"OMIM:173100","ISOLATED GROWTH HORMONE DEFICIENCY, TYPE II; IGHD2" -"DOID:14484","sporotrichosis" -"OMIM:601675","TRICHOTHIODYSTROPHY 1, PHOTOSENSITIVE; TTD1" -"DOID:1781","thyroid cancer" -"OMIM:601676","ACUTE INSULIN RESPONSE" -"DOID:0050140","acute diarrhea" -"OMIM:164100","NYSTAGMUS 2, CONGENITAL, AUTOSOMAL DOMINANT; NYS2" -"OMIM:601678","BARTTER SYNDROME, TYPE 1, ANTENATAL; BARTS1" -"OMIM:142946","HOLOPROSENCEPHALY 4; HPE4" -"OMIM:601680","ARTHROGRYPOSIS, DISTAL, TYPE 2B; DA2B" -"OMIM:601682","GLAUCOMA 1, PRIMARY OPEN ANGLE, C; GLC1C" -"OMIM:601694","LEPTIN, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS 1; LEPQTL1" -"DOID:11430","endometriosis in scar of skin" -"DOID:8545","malignant hyperthermia" -"OMIM:143095","SPONDYLOEPIPHYSEAL DYSPLASIA WITH CONGENITAL JOINT DISLOCATIONS; SEDCJD" -"OMIM:163950","NOONAN SYNDROME 1; NS1" -"OMIM:143100","HUNTINGTON DISEASE; HD" -"OMIM:601696","NOVELTY SEEKING PERSONALITY TRAIT" -"OMIM:601700","SEBACEOUS GLAND HYPERPLASIA, FAMILIAL PRESENILE" -"DOID:13147","fungal esophagitis" -"OMIM:601701","ARTHROGRYPOSIS AND ECTODERMAL DYSPLASIA" -"DOID:0090100","ocular albinism with sensorineural deafness" -"DOID:4621","holoprosencephaly" -"OMIM:601705","T-CELL IMMUNODEFICIENCY, CONGENITAL ALOPECIA, AND NAIL DYSTROPHY" -"OMIM:601706","YEMENITE DEAF-BLIND HYPOPIGMENTATION SYNDROME" -"DOID:6297","viral esophagitis" -"DOID:13922","eosinophilic esophagitis" -"OMIM:143050","HUMERORADIAL SYNOSTOSIS" -"OMIM:601707","CURRY-JONES SYNDROME; CRJS" -"DOID:3968","papillary follicular thyroid adenocarcinoma" -"OMIM:163800","SICK SINUS SYNDROME 2; SSS2" -"OMIM:601708","SUPERIOR TRANSVERSE SCAPULAR LIGAMENT, CALCIFICATION OF, FAMILIAL" -"DOID:0080110","multiple pterygium syndrome" -"OMIM:601709","QUEBEC PLATELET DISORDER; QPD" -"DOID:0110943","autosomal recessive osteopetrosis 2" -"OMIM:601718","RETINITIS PIGMENTOSA 19; RP19" -"OMIM:142730","HISTIOCYTIC DERMATOARTHRITIS" -"OMIM:601744","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 1; SLEB1" -"DOID:0050545","visceral heterotaxy" -"OMIM:601759","PREAXIAL HALLUCAL POLYDACTYLY" -"DOID:0060340","ciliopathy" -"OMIM:601764","SEIZURES, BENIGN FAMILIAL INFANTILE, 1; BFIS1" -"DOID:12662","paracoccidioidomycosis" -"OMIM:601775","FOLATE LEVEL IN ERYTHROCYTES" -"OMIM:601776","EHLERS-DANLOS SYNDROME, MUSCULOCONTRACTURAL TYPE, 1; EDSMC1" -"OMIM:601777","CONE-ROD DYSTROPHY 6; CORD6" -"DOID:5914","nonencapsulated sclerosing carcinoma" -"OMIM:143020","HPA I RECOGNITION POLYMORPHISM, BETA-GLOBIN-RELATED; HPA1" -"DOID:8484","maple bark strippers' lung" -"OMIM:601780","CEROID LIPOFUSCINOSIS, NEURONAL, 6; CLN6" -"DOID:7089","tall cell variant papillary carcinoma" -"OMIM:601794","COLOBOMA-OBESITY-HYPOGENITALISM-MENTAL RETARDATION SYNDROME" -"OMIM:179300","RADIOULNAR SYNOSTOSIS" -"OMIM:156810","MICROGASTRIA-LIMB REDUCTION DEFECTS ASSOCIATION; MLRD" -"OMIM:156610","SKIN CREASES, CONGENITAL SYMMETRIC CIRCUMFERENTIAL, 1; CSCSC1" -"OMIM:148200","KERATITIS FUGAX HEREDITARIA" -"OMIM:179450","RAGWEED SENSITIVITY" -"OMIM:179400","RADIUS, APLASIA OF, WITH CLEFT LIP/PALATE" -"DOID:9946","steroid-induced glaucoma" -"OMIM:156830","MICROMELIC BONE DYSPLASIA WITH CLOVERLEAF SKULL" -"OMIM:148350","KERATODERMA, PALMOPLANTAR, WITH DEAFNESS" -"DOID:14456","Brucella melitensis brucellosis" -"OMIM:156620","MICROCEPHALY-DEAFNESS SYNDROME" -"OMIM:148390","KERATOSIS, FAMILIAL ACTINIC" -"DOID:6759","bone lymphoma" -"DOID:4160","differentiating neuroblastoma" -"DOID:11914","gastroparesis" -"OMIM:157170","HOLOPROSENCEPHALY 2; HPE2" -"OMIM:156580","MICROCEPHALY, AUTOSOMAL DOMINANT" -"OMIM:157150","MICROSPHEROPHAKIA WITH HERNIA" -"OMIM:156850","MICROPHTHALMIA, ISOLATED, WITH CATARACT 1; MCOPCT1" -"OMIM:156900","MICROPHTHALMIA, ISOLATED, WITH CORECTOPIA; MCOPCR" -"OMIM:148730","KERATOSIS, FOCAL PALMOPLANTAR AND GINGIVAL" -"DOID:3481","septicemic plague" -"DOID:13050","corpus luteum cyst" -"OMIM:148500","TYLOSIS WITH ESOPHAGEAL CANCER; TOC" -"DOID:11149","aqueous misdirection" -"DOID:0110144","Bartter disease type 3" -"DOID:11148","hypersecretion glaucoma" -"OMIM:148190","KERATITIS, HEREDITARY" -"DOID:5789","mixed hepatoblastoma" -"OMIM:148210","KERATITIS-ICHTHYOSIS-DEAFNESS SYNDROME, AUTOSOMAL DOMINANT" -"OMIM:148800","KLEEBLATTSCHAEDEL" -"DOID:1687","neovascular glaucoma" -"OMIM:148600","PALMOPLANTAR KERATODERMA, PUNCTATE TYPE IA; PPKP1A" -"OMIM:156600","MICROCORIA, CONGENITAL" -"OMIM:148360","KERATODERMA, PALMOPLANTAR, WITH NAIL DYSTROPHY AND HEREDITARY MOTOR-SENSORY NEUROPATHY" -"OMIM:157200","MIDPHALANGEAL HAIR" -"DOID:11120","psychologic dyspareunia" -"OMIM:148300","KERATOCONUS 1; KTCN1" -"DOID:14019","Brucella canis brucellosis" -"OMIM:148700","PALMOPLANTAR KERATODERMA I, STRIATE, FOCAL, OR DIFFUSE; PPKS1" -"DOID:10398","pneumonic plague" -"OMIM:157151","MICROSPHEROPHAKIA-METAPHYSEAL DYSPLASIA" -"OMIM:156700","MICROCORNEA, GLAUCOMA, AND ABSENT FRONTAL SINUSES" -"DOID:0050593","primary congenital glaucoma" -"DOID:9283","borderline glaucoma" -"DOID:302","substance abuse" -"DOID:14457","Brucella abortus brucellosis" -"OMIM:148370","KERATOLYTIC WINTER ERYTHEMA; KWE" -"OMIM:148520","KERATOSIS PALMARIS ET PLANTARIS WITH CLINODACTYLY" -"OMIM:608446","MYOCARDIAL INFARCTION, SUSCEPTIBILITY TO" -"OMIM:138920","GRANDDAD SYNDROME" -"OMIM:272450","SYNDESMODYSPLASIC DWARFISM" -"DOID:0050485","sennetsu fever" -"OMIM:614385","COLORECTAL CANCER, HEREDITARY NONPOLYPOSIS, TYPE 7; HNPCC7" -"OMIM:138790","GOITER, MULTINODULAR, CYSTIC RENAL DISEASE, AND DIGITAL ANOMALIES" -"OMIM:614388","ENCEPHALOPATHY DUE TO DEFECTIVE MITOCHONDRIAL AND PEROXISOMAL FISSION 1; EMPF1" -"OMIM:272460","SPONDYLOCARPOTARSAL SYNOSTOSIS SYNDROME; SCT" -"OMIM:608447","CAROTID INTIMAL MEDIAL THICKNESS 2" -"DOID:13622","campylobacteriosis" -"DOID:13575","non-renal secondary hyperparathyroidism" -"OMIM:614389","PREGNANCY LOSS, RECURRENT, SUSCEPTIBILITY TO, 1; RPRGL1" -"OMIM:608448","INFLAMMATORY BOWEL DISEASE 9; IBD9" -"OMIM:272600","TAPETORETINAL DEGENERATION WITH ATAXIA" -"OMIM:272620","TARDIVE DYSKINESIA" -"OMIM:608456","FAMILIAL ADENOMATOUS POLYPOSIS 2; FAP2" -"OMIM:614390","PREGNANCY LOSS, RECURRENT, SUSCEPTIBILITY TO, 2; RPRGL2" -"OMIM:614391","PREGNANCY LOSS, RECURRENT, SUSCEPTIBILITY TO, 3; RPRGL3" -"OMIM:272650","TATSUMI FACTOR DEFICIENCY" -"OMIM:608462","HIRSCHSPRUNG DISEASE, SUSCEPTIBILITY TO, 8; HSCR8" -"OMIM:608470","CORNEAL DYSTROPHY, REIS-BUCKLERS TYPE; CDRB" -"OMIM:614395","GRAFT-VERSUS-HOST DISEASE, SUSCEPTIBILITY TO; GVHDS" -"OMIM:272700","TAURODONTISM" -"OMIM:272750","GM2-GANGLIOSIDOSIS, AB VARIANT" -"OMIM:608471","CORNEAL DYSTROPHY, LATTICE TYPE IIIA; CDL3A" -"OMIM:614399","MYOPATHY, AREFLEXIA, RESPIRATORY DISTRESS, AND DYSPHAGIA, EARLY-ONSET; EMARDD" -"DOID:0110338","osteogenesis imperfecta type 17" -"DOID:12385","shigellosis" -"OMIM:272800","TAY-SACHS DISEASE; TSD" -"OMIM:608474","MYOPIA 5, AUTOSOMAL DOMINANT; MYP5" -"OMIM:614400","GLUCOCORTICOID THERAPY, RESPONSE TO; GCTR" -"OMIM:614401","ACCELERATED TUMOR FORMATION, SUSCEPTIBILITY TO; ACTFS" -"OMIM:272950","TEEBI-SHALTOUT SYNDROME; TBSH" -"OMIM:608484","CONGENITAL CORNEAL OPACITIES, CORNEA GUTTATA, AND CORECTOPIA" -"OMIM:614402","MICROPHTHALMIA, SYNDROMIC 11; MCOPS11" -"OMIM:608509","ALOPECIA UNIVERSALIS CONGENITA, XY GONADAL DYSGENESIS, AND LARYNGOMALACIA" -"OMIM:272980","TEETH, CONGENITAL ABSENCE OF, WITH TAURODONTIA AND SPARSE HAIR" -"OMIM:608516","MAJOR DEPRESSIVE DISORDER; MDD" -"OMIM:273000","TEETH, FUSED" -"OMIM:614407","MICROCEPHALY, CEREBELLAR HYPOPLASIA, AND CARDIAC CONDUCTION DEFECT SYNDROME; MCHCCD" -"OMIM:138800","GOITER, MULTINODULAR 1, WITH OR WITHOUT SERTOLI-LEYDIG CELL TUMORS; MNG1" -"OMIM:608518","OROFACIODIGITAL SYNDROME VII; OFD7" -"OMIM:273050","TEETH, NONERUPTION OF, WITH MAXILLARY HYPOPLASIA AND GENU VALGUM" -"OMIM:614408","MYOPATHY, CENTRONUCLEAR, 3; CNM3" -"DOID:4297","scimitar syndrome" -"OMIM:608520","MAJOR DEPRESSIVE DISORDER 1" -"OMIM:614409","SPASTIC PARAPLEGIA 46, AUTOSOMAL RECESSIVE; SPG46" -"OMIM:273120","TERATOMA, PINEAL" -"OMIM:614411","GLYCEROL QUANTITATIVE TRAIT LOCUS; GLYCQTL" -"OMIM:273150","TESTES, RUDIMENTARY" -"OMIM:608526","PERIODONTITIS, AGGRESSIVE, 2" -"OMIM:173580","PLATELET RESPONSIVENESS TO ADRENALINE, DEPRESSED" -"DOID:9499","disseminated eosinophilic collagen disease" -"OMIM:273250","TESTICULAR REGRESSION SYNDROME; TRS" -"OMIM:608540","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ik; CDG1K" -"OMIM:614414","DEAFNESS, AUTOSOMAL RECESSIVE 96; DFNB96" -"OMIM:614415","CHILBLAIN LUPUS 2; CHBL2" -"OMIM:273300","TESTICULAR GERM CELL TUMOR; TGCT" -"OMIM:608542","ANEURYSM, INTRACRANIAL BERRY, 2; ANIB2" -"DOID:12716","newborn respiratory distress syndrome" -"OMIM:138710","GLYCOPROTEIN, RENAL" -"OMIM:608543","SCHIZOPHRENIA 12" -"OMIM:273390","TETRAAMELIA WITH ECTODERMAL DYSPLASIA AND LACRIMAL DUCT ABNORMALITIES" -"OMIM:138770","GMS SYNDROME" -"OMIM:614416","RADIOHUMERAL FUSIONS WITH OTHER SKELETAL AND CRANIOFACIAL ANOMALIES; RHFCA" -"OMIM:608545","LARSEN-LIKE SYNDROME" -"OMIM:273395","TETRAAMELIA SYNDROME, AUTOSOMAL RECESSIVE; TETAMS" -"OMIM:614417","EPILEPSY, FAMILIAL TEMPORAL LOBE, 5; ETL5" -"OMIM:608553","LEBER CONGENITAL AMAUROSIS 9; LCA9" -"OMIM:614418","FEBRILE SEIZURES, FAMILIAL, 11; FEB11" -"DOID:3025","acinar cell carcinoma" -"OMIM:273400","TETRAMELIC DEFICIENCIES, ECTODERMAL DYSPLASIA, DEFORMED EARS, AND OTHER ABNORMALITIES" -"DOID:0060213","FTDALS1" -"OMIM:608556","LEGIONNAIRE DISEASE, SUSCEPTIBILITY TO" -"OMIM:614419","ASPARTATE AMINOTRANSFERASE, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS 1" -"OMIM:273490","THALAMIC DEGENERATION, SYMMETRIC INFANTILE" -"OMIM:614420","SYSTEMIC LUPUS ERYTHEMATOSUS 16; SLEB16" -"OMIM:608557","MYOCARDIAL INFARCTION, SUSCEPTIBILITY TO, 2" -"OMIM:273600","THALIDOMIDE SUSCEPTIBILITY" -"OMIM:614422","CATARACT 37; CTRCT37" -"OMIM:608558","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 5; BMIQ5" -"OMIM:273680","THANATOPHORIC DYSPLASIA, GLASGOW VARIANT" -"OMIM:614424","JOUBERT SYNDROME 14; JBTS14" -"OMIM:273730","THORACIC DYSPLASIA-HYDROCEPHALUS SYNDROME" -"OMIM:608559","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 6; BMIQ6" -"DOID:9498","pulmonary eosinophilia" -"OMIM:608562","POLYDACTYLY, POSTAXIAL, TYPE A4" -"OMIM:273740","THORACOMELIC DYSPLASIA" -"OMIM:614429","VENTRICULAR SEPTAL DEFECT 1; VSD1" -"OMIM:138900","URIC ACID CONCENTRATION, SERUM, QUANTITATIVE TRAIT LOCUS 1; UAQTL1" -"OMIM:273750","THREE M SYNDROME 1; 3M1" -"OMIM:614430","ATRIOVENTRICULAR SEPTAL DEFECT 4; AVSD4" -"OMIM:608565","DEAFNESS, AUTOSOMAL RECESSIVE 35; DFNB35" -"OMIM:614431","VENTRICULAR SEPTAL DEFECT 2; VSD2" -"OMIM:608567","SICK SINUS SYNDROME 1; SSS1" -"OMIM:273770","THREONINEMIA" -"DOID:14275","atrophic vulva" -"OMIM:614432","VENTRICULAR SEPTAL DEFECT 3; VSD3" -"OMIM:608569","CARDIOMYOPATHY, DILATED, 1O; CMD1O" -"DOID:11394","adult respiratory distress syndrome" -"OMIM:273800","GLANZMANN THROMBASTHENIA; GT" -"OMIM:614433","ATRIAL SEPTAL DEFECT 8; ASD8" -"OMIM:273900","THROMBOCYTOPENIA 3; THC3" -"OMIM:608571","ULNAR/FIBULAR RAY DEFECT AND BRACHYDACTYLY" -"DOID:11161","neonatal respiratory failure" -"OMIM:614434","CUTIS LAXA, AUTOSOMAL DOMINANT 2; ADCL2" -"OMIM:274000","THROMBOCYTOPENIA-ABSENT RADIUS SYNDROME; TAR" -"OMIM:608572","BURN-MCKEOWN SYNDROME; BMKS" -"OMIM:614435","HYPOPLASTIC LEFT HEART SYNDROME 2; HLHS2" -"OMIM:274150","THROMBOTIC THROMBOCYTOPENIC PURPURA, CONGENITAL; TTP" -"OMIM:608579","SEVERE CUTANEOUS ADVERSE REACTION, SUSCEPTIBILITY TO" -"OMIM:614436","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2P; CMT2P" -"OMIM:274190","THUMB AGENESIS, SHORT STATURE, AND IMMUNODEFICIENCY" -"OMIM:608580","MYOSIN, HEAVY CHAIN 16, SKELETAL MUSCLE, PSEUDOGENE; MYH16" -"OMIM:608583","ATRIAL FIBRILLATION, FAMILIAL, 1; ATFB1" -"OMIM:614437","CUTIS LAXA, AUTOSOMAL RECESSIVE, TYPE IB; ARCL1B" -"OMIM:274200","THUMB, DISTAL HYPEREXTENSIBILITY OF" -"OMIM:274205","THUMB, HYPOPLASTIC, WITH CHOROID COLOBOMA, POORLY DEVELOPED ANTIHELIX, AND DEAFNESS" -"OMIM:608584","ASTHMA-RELATED TRAITS, SUSCEPTIBILITY TO, 2" -"OMIM:614438","CUTIS LAXA, AUTOSOMAL RECESSIVE, TYPE IIIB; ARCL3B" -"OMIM:608585","BRACHIAL PALSY, FAMILIAL CONGENITAL" -"OMIM:274210","THYMIC APLASIA WITH FETAL DEATH" -"OMIM:614441","HYPERTROPHIC OSTEOARTHROPATHY, PRIMARY, AUTOSOMAL RECESSIVE, 2; PHOAR2" -"OMIM:608586","KERATOCONUS 3; KTCN3" -"OMIM:274230","THYMOMA, FAMILIAL" -"OMIM:614450","HYPOTHYROIDISM, CONGENITAL, NONGOITROUS, 6; CHNG6" -"OMIM:608594","LIPODYSTROPHY, CONGENITAL GENERALIZED, TYPE 1; CGL1" -"OMIM:614455","CHARCOT-MARIE-TOOTH DISEASE, DOMINANT INTERMEDIATE E; CMTDIE" -"OMIM:274240","THYROCEREBRORETINAL SYNDROME" -"OMIM:145300","HYPERSENSITIVITY PNEUMONITIS, FAMILIAL" -"OMIM:190320","TRICHODENTOOSSEOUS SYNDROME; TDO" -"OMIM:106400","ANKYLOSING VERTEBRAL HYPEROSTOSIS WITH TYLOSIS" -"OMIM:190330","TRICHOMEGALY; TCMGLY" -"OMIM:190340","DISCOID FIBROMAS, FAMILIAL MULTIPLE; FMDF" -"OMIM:145420","HYPERTELORISM, TEEBI TYPE" -"OMIM:145500","HYPERTENSION, ESSENTIAL" -"OMIM:190345","TRICHOEPITHELIOMAS, MULTIPLE DESMOPLASTIC" -"OMIM:190350","TRICHORHINOPHALANGEAL SYNDROME, TYPE I; TRPS1" -"DOID:13146","esophageal candidiasis" -"DOID:437","myasthenia gravis" -"OMIM:145410","OPITZ GBBB SYNDROME, TYPE II; GBBB2" -"DOID:9577","neonatal candidiasis" -"OMIM:145350","HYPERTAURINURIC CARDIOMYOPATHY" -"OMIM:190351","TRICHORHINOPHALANGEAL SYNDROME, TYPE III; TRPS3" -"OMIM:181400","SCAPULOPERONEAL SYNDROME, NEUROGENIC, KAESER TYPE; SCPNK" -"DOID:10460","nasopharyngitis" -"OMIM:190360","TRICHODYSPLASIA-XERODERMA" -"OMIM:170900","PERNICIOUS ANEMIA" -"DOID:2462","retinal vascular disease" -"OMIM:190400","TRIGEMINAL NEURALGIA" -"OMIM:145650","THYROID HORMONE RESISTANCE, SELECTIVE PITUITARY; PRTH" -"OMIM:190410","TRIGGER THUMB" -"DOID:6688","autoimmune lymphoproliferative syndrome" -"OMIM:190420","TRIGLYCERIDE STORAGE DISEASE, TYPE I" -"OMIM:190430","TRIGLYCERIDE STORAGE DISEASE, TYPE II" -"OMIM:145295","HYPERSECRETION OF ADRENAL ANDROGENS, FAMILIAL" -"OMIM:106300","SPONDYLOARTHROPATHY, SUSCEPTIBILITY TO, 1; SPDA1" -"OMIM:190440","TRIGONOCEPHALY 1; TRIGNO1" -"DOID:7880","luteoma" -"OMIM:145600","MALIGNANT HYPERTHERMIA, SUSCEPTIBILITY TO, 1; MHS1" -"OMIM:190445","TRIIODOTHYRONINE RECEPTOR AUXILIARY PROTEIN; TRAP" -"OMIM:145400","HYPERTELORISM" -"OMIM:190500","TRIPHALANGEAL THUMB WITH DOUBLE PHALANGES" -"OMIM:190600","TRIPHALANGEAL THUMB, NONOPPOSABLE" -"OMIM:190650","TRIPHALANGEAL THUMBS AND DISLOCATION OF PATELLA" -"OMIM:190680","TRIPHALANGEAL THUMBS WITH BRACHYECTRODACTYLY" -"OMIM:190685","DOWN SYNDROME" -"DOID:14262","oral candidiasis" -"OMIM:190800","TRISTICHIASIS" -"OMIM:135700","FIBROSIS OF EXTRAOCULAR MUSCLES, CONGENITAL, 1; CFEOM1" -"OMIM:135610","FIBRONECTIN-LIKE 2; FNL2" -"OMIM:190900","TRITANOPIA" -"DOID:8850","salivary gland cancer" -"DOID:13140","suppurative uveitis" -"DOID:9698","gonococcal endophthalmia" -"OMIM:191000","TROCHLEA OF THE HUMERUS, APLASIA OF" -"DOID:13999","contact blepharoconjunctivitis" -"OMIM:191100","TUBEROUS SCLEROSIS 1; TSC1" -"OMIM:145290","HYPERREFLEXIA; HRX" -"OMIM:191150","TUFTSIN DEFICIENCY" -"OMIM:191181","SUPPRESSOR OF TUMORIGENICITY 3; ST3" -"DOID:0050585","congenital generalized lipodystrophy" -"OMIM:191200","TUNE DEAFNESS" -"OMIM:191250","TWINNING DUE TO SUPERFETATION" -"OMIM:145590","HYPERTHERMIA, CUTANEOUS, WITH HEADACHES AND NAUSEA" -"OMIM:191270","TYROSINASE-LIKE; TYRL" -"DOID:8499","night blindness" -"OMIM:191390","INFLAMMATORY BOWEL DISEASE 11; IBD11" -"OMIM:191400","ULNA AND FIBULA, HYPOPLASIA OF" -"OMIM:191420","ULNA METAPHYSEAL DYSPLASIA SYNDROME" -"OMIM:191440","ULNAR HYPOPLASIA" -"DOID:6929","retinal edema" -"OMIM:191480","UNCOMBABLE HAIR SYNDROME 1; UHS1" -"OMIM:191482","UNCOMBABLE HAIR, RETINAL PIGMENTARY DYSTROPHY, DENTAL ANOMALIES, AND BRACHYDACTYLY" -"OMIM:191500","UNDRITZ ANOMALY" -"OMIM:191520","UPINGTON DISEASE" -"DOID:1862","jaw cancer" -"DOID:14512","candidal paronychia" -"OMIM:191530","URATE-BINDING GLOBULIN, DECREASE IN" -"OMIM:614456","MELANOMA, CUTANEOUS MALIGNANT, SUSCEPTIBILITY TO, 8; CMM8" -"OMIM:608600","LIPODYSTROPHY, FAMILIAL PARTIAL, TYPE 1; FPLD1" -"DOID:13589","female infertility of uterine origin" -"OMIM:114065","CALCIFIC AORTIC DISEASE WITH IMMUNOLOGIC ABNORMALITIES, FAMILIAL" -"OMIM:227090","ERYTHRODERMA, LETHAL CONGENITAL" -"DOID:0110116","autoimmune lymphoproliferative syndrome type 2B" -"DOID:4744","placenta accreta" -"OMIM:271200","SPINAL MUSCULAR ATROPHY, RYUKYUAN TYPE" -"OMIM:614457","ICHTHYOSIS, SPASTIC QUADRIPLEGIA, AND MENTAL RETARDATION; ISQMR" -"OMIM:608611","RIBOSE 5-PHOSPHATE ISOMERASE DEFICIENCY" -"OMIM:271220","SPINAL MUSCULAR ATROPHY, SCAPULOPERONEAL" -"OMIM:159500","MYELINATED OPTIC NERVE FIBERS" -"OMIM:227150","ETHANOLAMINOSIS" -"OMIM:614458","THIAMINE METABOLISM DYSFUNCTION SYNDROME 5 (EPISODIC ENCEPHALOPATHY TYPE); THMD5" -"OMIM:608612","MANDIBULOACRAL DYSPLASIA WITH TYPE B LIPODYSTROPHY; MADB" -"OMIM:271225","SPINAL MUSCULAR ATROPHY, TYPE I, WITH CONGENITAL BONE FRACTURES" -"DOID:13811","chronic subinvolution of uterus" -"OMIM:227210","EYEBROWS, DUPLICATION OF, WITH STRETCHABLE SKIN AND SYNDACTYLY" -"OMIM:271245","MITOCHONDRIAL DNA DEPLETION SYNDROME 7 (HEPATOCEREBRAL TYPE); MTDPS7" -"OMIM:608615","OLIGODONTIA-COLORECTAL CANCER SYNDROME; ODCRCS" -"OMIM:614462","HYPERGLYCINEMIA, LACTIC ACIDOSIS, AND SEIZURES; HGCLAS" -"OMIM:227220","SKIN/HAIR/EYE PIGMENTATION, VARIATION IN, 1; SHEP1" -"DOID:10892","hypospadias" -"OMIM:608622","HYPERTENSION, DIASTOLIC, RESISTANCE TO" -"OMIM:614464","JOUBERT SYNDROME 15; JBTS15" -"OMIM:159001","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 1B; LGMD1B" -"OMIM:271250","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 3; SCAR3" -"OMIM:227240","SKIN/HAIR/EYE PIGMENTATION, VARIATION IN, 5; SHEP5" -"OMIM:271270","SPINOCEREBELLAR ATAXIA WITH DYSMORPHISM" -"OMIM:608624","MIDFACE HYPOPLASIA, OBESITY, DEVELOPMENTAL DELAY, AND NEONATAL HYPOTONIA" -"OMIM:614465","JOUBERT SYNDROME 16; JBTS16" -"DOID:13580","cholestasis" -"OMIM:227250","FACIAL ABNORMALITIES, KYPHOSCOLIOSIS, AND MENTAL RETARDATION" -"OMIM:227255","FACIAL DYSMORPHISM WITH MULTIPLE MALFORMATIONS" -"OMIM:614466","CORONARY HEART DISEASE, SUSCEPTIBILITY TO, 6; CHDS6" -"OMIM:271310","SPINOCEREBELLAR DEGENERATION AND CORNEAL DYSTROPHY" -"OMIM:159300","MUSICAL PERFECT PITCH" -"OMIM:608627","AMYOTROPHIC LATERAL SCLEROSIS 8; ALS8" -"DOID:11727","facioscapulohumeral muscular dystrophy" -"OMIM:608629","JOUBERT SYNDROME 3; JBTS3" -"DOID:0050606","acrokeratosis verruciformis" -"DOID:3390","palmoplantar keratosis" -"DOID:0050628","advanced sleep phase syndrome" -"OMIM:113970","BURKITT LYMPHOMA; BL" -"OMIM:114140","CALLOSITIES, HEREDITARY PAINFUL" -"OMIM:227270","FACIOCARDIOMELIC DYSPLASIA, LETHAL" -"OMIM:614470","RAS-ASSOCIATED AUTOIMMUNE LEUKOPROLIFERATIVE DISORDER; RALD" -"OMIM:271322","SPINOCEREBELLAR DEGENERATION WITH SLOW EYE MOVEMENTS; SDSEM" -"DOID:9360","intrinsic asthma" -"OMIM:159420","MYDRIASIS, CONGENITAL" -"OMIM:608631","ASPERGER SYNDROME, SUSCEPTIBILITY TO, 2; ASPG2" -"OMIM:227280","FACIOCARDIORENAL SYNDROME" -"OMIM:608634","NEURONOPATHY, DISTAL HEREDITARY MOTOR, TYPE IIB; HMN2B" -"DOID:0060329","ectopic pregnancy" -"OMIM:614473","ARTERIAL CALCIFICATION, GENERALIZED, OF INFANCY, 2; GACI2" -"OMIM:271400","ASPLENIA, ISOLATED CONGENITAL; ICAS" -"OMIM:271500","SPLENOPORTAL VASCULAR ANOMALIES" -"OMIM:608636","CHROMOSOME 15q11-q13 DUPLICATION SYNDROME" -"OMIM:614474","ATRIOVENTRICULAR SEPTAL DEFECT 5; AVSD5" -"OMIM:227300","FACTOR V AND FACTOR VIII, COMBINED DEFICIENCY OF, 1; F5F8D1" -"DOID:4751","striatonigral degeneration" -"OMIM:608638","ASPERGER SYNDROME, SUSCEPTIBILITY TO, 1; ASPG1" -"OMIM:227310","FACTOR V AND FACTOR VIII, COMBINED DEFICIENCY OF, WITH NORMAL PROTEIN C AND PROTEIN C INHIBITOR" -"OMIM:271510","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, SPONASTRIME TYPE" -"OMIM:614475","ATRIAL SEPTAL DEFECT 9; ASD9" -"OMIM:271520","SPONDYLOCOSTAL DYSOSTOSIS WITH ANAL ATRESIA AND UROGENITAL ANOMALIES" -"OMIM:227320","FACIOTHORACOGENITAL SYNDROME" -"OMIM:608641","DEAFNESS, AUTOSOMAL DOMINANT 28; DFNA28" -"OMIM:114000","CAFFEY DISEASE" -"OMIM:614480","HYPERTRIGLYCERIDEMIA, TRANSIENT INFANTILE; HTGTI" -"OMIM:271530","BRACHYOLMIA TYPE 1, HOBAEK TYPE; BCYM1A" -"OMIM:608643","AROMATIC L-AMINO ACID DECARBOXYLASE DEFICIENCY" -"OMIM:227330","FACIODIGITOGENITAL SYNDROME, AUTOSOMAL RECESSIVE" -"OMIM:159400","MYASTHENIA, LIMB-GIRDLE, AUTOIMMUNE" -"OMIM:614482","CONGENITAL CATARACTS, HEARING LOSS, AND NEURODEGENERATION; CCHLND" -"DOID:9220","central sleep apnea" -"OMIM:271600","SPONDYLOEPIPHYSEAL DYSPLASIA TARDA, AUTOSOMAL RECESSIVE" -"OMIM:227400","FACTOR V DEFICIENCY" -"OMIM:614483","PORENCEPHALY 2; POREN2" -"OMIM:159100","MUSCULAR HYPOPLASIA, CONGENITAL UNIVERSAL, OF KRABBE" -"OMIM:608644","CILIARY DYSKINESIA, PRIMARY, 3; CILD3" -"OMIM:608645","DEAFNESS, AUTOSOMAL DOMINANT 31; DFNA31" -"OMIM:227500","FACTOR VII DEFICIENCY" -"DOID:0110368","retinitis pigmentosa 26" -"OMIM:182882","SPERM PROTAMINE P4; PRM4" -"OMIM:271620","SPONDYLOEPIPHYSEAL DYSPLASIA TARDA WITH MENTAL RETARDATION" -"OMIM:614485","TRIGONOCEPHALY 2; TRIGNO2" -"DOID:9551","smoldering myeloma" -"OMIM:227600","FACTOR X DEFICIENCY" -"OMIM:608646","CILIARY DYSKINESIA, PRIMARY, 4; CILD4" -"OMIM:614486","THROMBOPHILIA DUE TO THROMBOMODULIN DEFECT; THPH12" -"DOID:12192","sigmoid colon cancer" -"OMIM:271630","BRACHYOLMIA TYPE 1, TOLEDO TYPE; BCYM1B" -"OMIM:182900","SPHEROCYTOSIS, TYPE 1; SPH1" -"OMIM:614487","SPASTIC ATAXIA 5, AUTOSOMAL RECESSIVE; SPAX5" -"OMIM:608647","CILIARY DYSKINESIA, PRIMARY, 5; CILD5" -"OMIM:271640","SPONDYLOEPIMETAPHYSEAL DYSPLASIA WITH JOINT LAXITY, TYPE 1, WITH OR WITHOUT FRACTURES; SEMDJL1" -"OMIM:114150","CAMPTOBRACHYDACTYLY" -"OMIM:227645","FANCONI ANEMIA, COMPLEMENTATION GROUP C; FANCC" -"OMIM:227646","FANCONI ANEMIA, COMPLEMENTATION GROUP D2; FANCD2" -"OMIM:608649","ICHTHYOSIS PREMATURITY SYNDROME; IPS" -"OMIM:271650","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, IRAPA TYPE; SEMDIT" -"OMIM:159550","ATAXIA-PANCYTOPENIA SYNDROME; ATXPC" -"OMIM:614490","BLOOD GROUP, JUNIOR SYSTEM; JR" -"OMIM:608652","DEAFNESS, AUTOSOMAL DOMINANT 47; DFNA47" -"OMIM:227650","FANCONI ANEMIA, COMPLEMENTATION GROUP A; FANCA" -"OMIM:614491","PSEUDOHYPOALDOSTERONISM, TYPE IIB; PHA2B" -"OMIM:271665","SPONDYLOMETAEPIPHYSEAL DYSPLASIA, SHORT LIMB-HAND TYPE" -"OMIM:113950","BUNDLE BRANCH BLOCK, FAMILIAL ISOLATED COMPLETE RIGHT" -"OMIM:227810","FANCONI-BICKEL SYNDROME; FBS" -"OMIM:608653","DEAFNESS, AUTOSOMAL RECESSIVE 32; DFNB32" -"DOID:10591","pre-eclampsia" -"OMIM:271700","SPONDYLOPERIPHERAL DYSPLASIA" -"OMIM:614492","PSEUDOHYPOALDOSTERONISM, TYPE IIC; PHA2C" -"OMIM:227850","FANCONI-LIKE SYNDROME" -"OMIM:614493","WISKOTT-ALDRICH SYNDROME 2; WAS2" -"OMIM:271900","CANAVAN DISEASE" -"DOID:13381","pernicious anemia" -"OMIM:608654","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, TYPE V; HSAN5" -"OMIM:159580","MYELOPATHY, HTLV-1-ASSOCIATED; HAM" -"OMIM:614494","RETINITIS PIGMENTOSA 63; RP63" -"OMIM:271930","STRIATONIGRAL DEGENERATION, INFANTILE; SNDI" -"OMIM:608656","PROSTATE CANCER, HEREDITARY, 3" -"OMIM:228000","FARBER LIPOGRANULOMATOSIS; FRBRL" -"OMIM:159050","MUSCULAR DYSTROPHY, PSEUDOHYPERTROPHIC, WITH INTERNALIZED CAPILLARIES" -"OMIM:271950","SUBAORTIC STENOSIS, MEMBRANOUS" -"OMIM:608658","PROSTATE CANCER, HEREDITARY, 4" -"OMIM:614495","PSEUDOHYPOALDOSTERONISM, TYPE IID; PHA2D" -"OMIM:228020","FASCIAL DYSTROPHY, CONGENITAL" -"OMIM:271960","SUBAORTIC STENOSIS--SHORT STATURE SYNDROME" -"OMIM:614496","PSEUDOHYPOALDOSTERONISM, TYPE IIE; PHA2E" -"OMIM:228100","VISCERAL STEATOSIS, CONGENITAL" -"DOID:0060211","amyotrophic lateral sclerosis type 20" -"OMIM:114030","CAFE-AU-LAIT SPOTS, MULTIPLE" -"OMIM:608670","ROBIN SEQUENCE WITH DISTINCTIVE FACIAL APPEARANCE AND BRACHYDACTYLY" -"OMIM:271980","SUCCINIC SEMIALDEHYDE DEHYDROGENASE DEFICIENCY; SSADHD" -"OMIM:614497","MICROPHTHALMIA, ISOLATED, WITH COLOBOMA 7; MCOPCB7" -"OMIM:608673","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2L; CMT2L" -"DOID:0060068","marantic endocarditis" -"DOID:7998","hyperthyroidism" -"OMIM:159000","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 1A; LGMD1A" -"OMIM:228200","FEMUR-FIBULA-ULNA SYNDROME" -"OMIM:614498","RIGIDITY AND MULTIFOCAL SEIZURE SYNDROME, LETHAL NEONATAL; RMFSL" -"OMIM:159410","MYDRIATIC RESPONSE TO PHARMACOLOGIC AGENTS" -"OMIM:272000","SUCROSURIA, HIATUS HERNIA AND MENTAL RETARDATION" -"OMIM:608681","SPONDYLOCOSTAL DYSOSTOSIS 2, AUTOSOMAL RECESSIVE; SCDO2" -"OMIM:228250","FEMUR, UNILATERAL BIFID, WITH MONODACTYLOUS ECTRODACTYLY" -"OMIM:608687","SPINOCEREBELLAR ATAXIA 20; SCA20" -"OMIM:228300","HYPOGONADOTROPIC HYPOGONADISM 23 WITHOUT ANOSMIA; HH23" -"OMIM:272100","SUDANOPHILIC CEREBRAL SCLEROSIS" -"OMIM:114100","BASAL GANGLIA CALCIFICATION, IDIOPATHIC, CHILDHOOD-ONSET" -"OMIM:614499","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 34, WITH VARIANT LISSENCEPHALY; MRT34" -"OMIM:608688","AICAR TRANSFORMYLASE/IMP CYCLOHYDROLASE DEFICIENCY" -"OMIM:614500","CONE-ROD DYSTROPHY 16; CORD16" -"OMIM:272120","SUDDEN INFANT DEATH SYNDROME" -"DOID:0050105","endothrix infectious disease" -"OMIM:228355","FETAL IODINE DEFICIENCY DISORDER; FIDD" -"OMIM:608691","MAJOR DEPRESSIVE DISORDER 2" -"OMIM:228400","FEVER, FAMILIAL LIFELONG PERSISTENT" -"OMIM:272150","SUGARMAN BRACHYDACTYLY" -"OMIM:113960","BUTYRYLESTERASE 1" -"OMIM:614501","PSYCHOMOTOR RETARDATION, EPILEPSY, AND CRANIOFACIAL DYSMORPHISM; PMRED" -"OMIM:608695","GLAUCOMA 1, OPEN ANGLE, J; GLC1J" -"OMIM:614504","USHER SYNDROME, TYPE IIIB; USH3B" -"DOID:0050166","tuberculous salpingitis" -"DOID:869","cholesteatoma" -"OMIM:228520","FIBROCHONDROGENESIS 1; FBCG1" -"OMIM:272200","MULTIPLE SULFATASE DEFICIENCY; MSD" -"DOID:5850","inferior myocardial infarction" -"OMIM:614507","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ir; CDG1R" -"OMIM:228550","MYOFIBROMATOSIS, INFANTILE, 1; IMF1" -"OMIM:272300","SULFOCYSTEINURIA" -"OMIM:608696","GLAUCOMA 1, OPEN ANGLE, K; GLC1K" -"OMIM:614508","MIRROR MOVEMENTS 2; MRMV2" -"OMIM:228560","FIBROMATOSIS, GINGIVAL, WITH DISTINCTIVE FACIES" -"OMIM:608703","SPINOCEREBELLAR ATAXIA 25; SCA25" -"OMIM:272350","SUMMITT SYNDROME" -"OMIM:228600","HYALINE FIBROMATOSIS SYNDROME; HFS" -"OMIM:614514","THROMBOPHILIA DUE TO PROTEIN S DEFICIENCY, AUTOSOMAL RECESSIVE; THPH6" -"OMIM:272370","SUSCEPTIBILITY TO LYSIS BY ALLOREACTIVE NATURAL KILLER CELLS; EC1" -"OMIM:608709","LIPODYSTROPHY, PARTIAL, ACQUIRED, SUSCEPTIBILITY TO; APLD" -"OMIM:228800","FIBROSCLEROSIS, MULTIFOCAL" -"OMIM:608710","WEGENER GRANULOMATOSIS" -"OMIM:272430","COLD-INDUCED SWEATING SYNDROME 1; CISS1" -"OMIM:614519","HEMORRHAGE, INTRACEREBRAL, SUSCEPTIBILITY TO; ICH" -"OMIM:228900","FIBULAR HYPOPLASIA AND COMPLEX BRACHYDACTYLY" -"OMIM:272440","FILIPPI SYNDROME; FLPIS" -"OMIM:617635","MENTAL RETARDATION, AUTOSOMAL DOMINANT 47; MRD47" -"DOID:13072","acquired hyperkeratosis" -"OMIM:608716","MICROCEPHALY 5, PRIMARY, AUTOSOMAL RECESSIVE; MCPH5" -"OMIM:614520","ENCEPHALOMYOPATHY, MITOCHONDRIAL, DUE TO VOLTAGE-DEPENDENT ANION CHANNEL DEFICIENCY" -"OMIM:204500","CEROID LIPOFUSCINOSIS, NEURONAL, 2; CLN2" -"OMIM:204650","AMELOGENESIS IMPERFECTA, TYPE IC; AI1C" -"OMIM:204690","AMELOGENESIS IMPERFECTA, TYPE IG; AI1G" -"OMIM:204700","AMELOGENESIS IMPERFECTA, HYPOMATURATION TYPE, IIA1; AI2A1" -"OMIM:204730","AMINO ACIDURIA WITH MENTAL DEFICIENCY, DWARFISM, MUSCULAR DYSTROPHY, OSTEOPOROSIS, AND ACIDOSIS" -"DOID:10519","chronic fungal otitis externa" -"OMIM:204750","2-AMINOADIPIC 2-OXOADIPIC ACIDURIA; AMOXAD" -"OMIM:204800","AMOBARBITAL, DEFICIENT N-HYDROXYLATION OF" -"DOID:9206","Barrett's esophagus" -"OMIM:204850","AMYLOIDOSIS OF GINGIVA AND CONJUNCTIVA, WITH MENTAL RETARDATION" -"DOID:9164","achalasia" -"OMIM:204870","CORNEAL DYSTROPHY, GELATINOUS DROP-LIKE; GDLD" -"OMIM:204900","AMYLOIDOSIS, CUTANEOUS BULLOUS" -"OMIM:205000","AMYOTONIA CONGENITA" -"DOID:9021","esophageal leukoplakia" -"OMIM:205100","AMYOTROPHIC LATERAL SCLEROSIS 2, JUVENILE; ALS2" -"OMIM:205200","AMYOTROPHIC LATERAL SCLEROSIS, JUVENILE, WITH DEMENTIA" -"OMIM:205250","AMYOTROPHIC LATERAL SCLEROSIS WITH POLYGLUCOSAN BODIES" -"OMIM:205400","TANGIER DISEASE; TGD" -"OMIM:205700","ANEMIA, AUTOIMMUNE HEMOLYTIC" -"OMIM:205950","ANEMIA, SIDEROBLASTIC, 2, PYRIDOXINE-REFRACTORY; SIDBA2" -"DOID:0060215","Balo concentric sclerosis" -"DOID:10485","esophageal atresia" -"OMIM:206000","ANEMIA, SIDEROBLASTIC, PYRIDOXINE-RESPONSIVE, AUTOSOMAL RECESSIVE" -"OMIM:206100","ANEMIA, HYPOCHROMIC MICROCYTIC, WITH IRON OVERLOAD 1; AHMIO1" -"OMIM:206200","IRON-REFRACTORY IRON DEFICIENCY ANEMIA; IRIDA" -"OMIM:206300","ANEMIA, NONSPHEROCYTIC HEMOLYTIC, ASSOCIATED WITH ABNORMALITY OF RED CELL MEMBRANE" -"OMIM:206400","ANEMIA, NONSPHEROCYTIC HEMOLYTIC, POSSIBLY DUE TO DEFECT IN PORPHYRIN METABOLISM" -"OMIM:612840","LEUKOCYTE ADHESION DEFICIENCY, TYPE III; LAD3" -"OMIM:206500","ANENCEPHALY; ANPH" -"OMIM:206550","ANGIOLIPOMATOSIS, FAMILIAL" -"OMIM:206570","ANGIOMATOSIS, DIFFUSE CORTICOMENINGEAL, OF DIVRY AND VAN BOGAERT" -"OMIM:206600","ANHIDROSIS, FAMILIAL GENERALIZED, WITH ABNORMAL OR ABSENT SWEAT GLANDS" -"OMIM:206700","GILLESPIE SYNDROME; GLSP" -"DOID:11830","myopia" -"OMIM:206750","ANIRIDIA, PARTIAL, WITH UNILATERAL RENAL AGENESIS AND PSYCHOMOTOR RETARDATION" -"OMIM:206780","ANODONTIA OF PERMANENT DENTITION" -"OMIM:206800","NAIL DISORDER, NONSYNDROMIC CONGENITAL, 4; NDNC4" -"DOID:13902","white piedra" -"OMIM:206900","MICROPHTHALMIA, SYNDROMIC 3; MCOPS3" -"DOID:0050457","Sertoli cell-only syndrome" -"OMIM:206920","MICROPHTHALMIA WITH LIMB ANOMALIES; MLA" -"OMIM:207000","ANOSMIA FOR ISOBUTYRIC ACID" -"DOID:5003","eunuchism" -"OMIM:207300","ANTITHROMBIN, FAMILIAL HEMORRHAGIC DIATHESIS DUE TO" -"OMIM:182210","SHPRINTZEN OMPHALOCELE SYNDROME" -"OMIM:207410","ANTLEY-BIXLER SYNDROME WITHOUT GENITAL ANOMALIES OR DISORDERED STEROIDOGENESIS; ABS2" -"OMIM:182212","SHPRINTZEN-GOLDBERG CRANIOSYNOSTOSIS SYNDROME; SGS" -"OMIM:207500","ANUS, IMPERFORATE" -"DOID:4796","space motion sickness" -"DOID:4928","intrahepatic cholangiocarcinoma" -"DOID:3526","cerebral infarction" -"OMIM:107410","SERPIN PEPTIDASE INHIBITOR, CLADE A, MEMBER 2, PSEUDOGENE; SERPINA2P" -"DOID:13252","mesenteric vascular occlusion" -"OMIM:107320","ANTIPHOSPHOLIPID SYNDROME, FAMILIAL" -"DOID:11262","ornithosis" -"DOID:0110938","autosomal dominant osteopetrosis 2" -"OMIM:161100","NAILBEDS, PIGMENTATION OF" -"OMIM:107440","ANTIVIRAL STATE REPRESSOR, REGULATOR OF; AVRR" -"DOID:5574","VIPoma" -"OMIM:612852","OSTEOMYELITIS, STERILE MULTIFOCAL, WITH PERIOSTITIS AND PUSTULOSIS; OMPP" -"DOID:0050948","autosomal dominant hypophosphatemic rickets" -"DOID:0050599","abdominal tuberculosis" -"OMIM:161050","NAIL DISORDER, NONSYNDROMIC CONGENITAL, 1; NDNC1" -"DOID:8469","influenza" -"DOID:5559","mediastinal cancer" -"DOID:0110132","Bardet-Biedl syndrome 10" -"OMIM:107250","ANTERIOR SEGMENT DYSGENESIS 1; ASGD1" -"DOID:0050487","bacterial exanthem" -"OMIM:161070","NAIL HIGH-SULFUR PROTEIN" -"DOID:1639","skeletal tuberculosis" -"DOID:1638","central nervous system tuberculosis" -"OMIM:107290","ANTIPYRINE METABOLISM" -"OMIM:161000","NAEGELI-FRANCESCHETTI-JADASSOHN SYNDROME; NFJS" -"DOID:4962","pericardial tuberculosis" -"OMIM:107200","ANOSMIA, ISOLATED CONGENITAL; ANIC" -"DOID:2149","urogenital tuberculosis" -"DOID:106","pleural tuberculosis" -"DOID:8398","osteoarthritis" -"OMIM:178330","PTOSIS, STRABISMUS, AND ECTOPIC PUPILS" -"DOID:0110941","autosomal recessive osteopetrosis 3" -"OMIM:178370","PULMONARY ATRESIA WITH VENTRICULAR SEPTAL DEFECT" -"OMIM:178350","PUBIC BONE DYSPLASIA" -"OMIM:107100","ANORECTAL ANOMALIES" -"OMIM:178400","PULMONARY EDEMA OF MOUNTAINEERS, SUSCEPTIBILITY TO" -"DOID:0110946","autosomal recessive osteopetrosis 7" -"OMIM:107480","TOWNES-BROCKS SYNDROME 1; TBS1" -"DOID:9531","latent syphilis" -"DOID:9861","miliary tuberculosis" -"OMIM:161080","NAIL LOW-SULFUR PROTEIN" -"DOID:0060048","nosophobia" -"DOID:4762","vasculogenic impotence" -"OMIM:161200","NAIL-PATELLA SYNDROME; NPS" -"DOID:10047","nodular malignant melanoma" -"OMIM:608720","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, ADULT-ONSET, WITH ANOSMIA" -"OMIM:614521","THROMBOCYTHEMIA 3; THCYT3" -"OMIM:608728","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, MATRILIN-3 RELATED" -"DOID:0090109","autosomal dominant hypocalcemia" -"OMIM:614524","FIBROCHONDROGENESIS 2; FBCG2" -"OMIM:614526","CHROMOSOME 17q12 DUPLICATION SYNDROME" -"OMIM:608742","HYPERTENSION, ESSENTIAL, SUSCEPTIBILITY TO, 4" -"DOID:14033","malignant visceral pleura tumor" -"DOID:3535","Unverricht-Lundborg syndrome" -"OMIM:608747","INSULIN-LIKE GROWTH FACTOR I DEFICIENCY" -"OMIM:614527","CHROMOSOME 17q12 DELETION SYNDROME" -"OMIM:608751","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 8; CMH8" -"OMIM:614541","CHROMOSOME 16q22 DELETION SYNDROME" -"OMIM:608758","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 10; CMH10" -"OMIM:614546","EFAVIRENZ, POOR METABOLISM OF" -"OMIM:614557","EHLERS-DANLOS SYNDROME WITH PROGRESSIVE KYPHOSCOLIOSIS, MYOPATHY, AND HEARING LOSS; EDSKMH" -"OMIM:608762","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 3; EIG3" -"DOID:5166","endometrial stromal tumor" -"OMIM:608763","EHLERS-DANLOS SYNDROME, BEASLEY-COHEN TYPE" -"OMIM:614558","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 13; EIEE13" -"OMIM:608765","SCOLIOSIS, ISOLATED, SUSCEPTIBILITY TO, 3; IS3" -"OMIM:614559","INFANTILE CEREBELLAR-RETINAL DEGENERATION; ICRD" -"OMIM:608768","SPINOCEREBELLAR ATAXIA 8; SCA8" -"OMIM:614561","LEUKOENCEPHALOPATHY, BRAIN CALCIFICATIONS, AND CYSTS; LCC" -"OMIM:608776","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Il; CDG1L" -"OMIM:614563","MENTAL RETARDATION, AUTOSOMAL DOMINANT 13; MRD13" -"OMIM:608779","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIe; CDG2E" -"OMIM:614564","CUTANEOUS TELANGIECTASIA AND CANCER SYNDROME, FAMILIAL; FCTCS" -"OMIM:614565","NIGHT BLINDNESS, CONGENITAL STATIONARY, TYPE 1E; CSNB1E" -"OMIM:608781","ASPERGER SYNDROME, SUSCEPTIBILITY TO, 3; ASPG3" -"DOID:0060501","metal allergy" -"OMIM:614569","MULTIPLE ENCHONDROMATOSIS, MAFFUCCI TYPE" -"OMIM:608782","PYRUVATE DEHYDROGENASE PHOSPHATASE DEFICIENCY; PDHPD" -"OMIM:608787","OTOSCLEROSIS 5; OTSC5" -"OMIM:613953","IMMUNODEFICIENCY 51; IMD51" -"OMIM:613954","AMYOTROPHIC LATERAL SCLEROSIS 14 WITH OR WITHOUT FRONTOTEMPORAL DEMENTIA; ALS14" -"OMIM:607371","DYSTONIA, JUVENILE-ONSET; DJO" -"OMIM:613955","AMYLOIDOSIS, PRIMARY LOCALIZED CUTANEOUS, 2; PLCA2" -"OMIM:607373","AUTISM, SUSCEPTIBILITY TO, 8; AUTS8" -"DOID:0090044","dystonia 9" -"OMIM:113610","BRANCHIAL MYOCLONUS WITH SPASTIC PARAPARESIS AND CEREBELLAR ATAXIA" -"OMIM:613956","CANDIDIASIS, FAMILIAL, 6; CANDF6" -"OMIM:607395","STREPTOCOCCUS, GROUP A, SEVERITY OF INFECTION BY" -"OMIM:607398","GLUCOCORTICOID DEFICIENCY 2; GCCD2" -"OMIM:613957","SPERMATOGENIC FAILURE 8; SPGF8" -"OMIM:113600","BRANCHIAL CLEFT ANOMALIES" -"DOID:0090042","torsion dystonia 17" -"OMIM:613958","SPERMATOGENIC FAILURE 9; SPGF9" -"OMIM:607411","PATENT DUCTUS ARTERIOSUS 1; PDA1" -"OMIM:143870","HYPERCALCIURIA, ABSORPTIVE, 2; HCA2" -"OMIM:607413","ALZHEIMER DISEASE NEURONAL THREAD PROTEIN" -"DOID:4131","erythrasma" -"OMIM:613959","SCHIZOPHRENIA 16; SCZD16" -"OMIM:607417","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 2; MRT2" -"OMIM:613960","GRANULOMATOUS DISEASE, CHRONIC, AUTOSOMAL RECESSIVE, CYTOCHROME b-POSITIVE, TYPE III; CDG3" -"DOID:0090054","episodic kinesigenic dyskinesia 2" -"OMIM:613969","MYOPIA 19, AUTOSOMAL DOMINANT; MYP19" -"OMIM:113620","BRANCHIOOCULOFACIAL SYNDROME; BOFS" -"OMIM:607426","COENZYME Q10 DEFICIENCY, PRIMARY, 1; COQ10D1" -"OMIM:113480","BRACHYTELEPHALANGY WITH CHARACTERISTIC FACIES AND KALLMANN SYNDROME" -"OMIM:607432","LISSENCEPHALY 1; LIS1" -"DOID:0090043","dystonia 5" -"OMIM:613970","MENTAL RETARDATION, AUTOSOMAL DOMINANT 6, WITH OR WITHOUT SEIZURES; MRD6" -"OMIM:300355","MENTAL RETARDATION, X-LINKED 73; MRX73" -"DOID:0050962","spinocerebellar ataxia type 12" -"OMIM:300367","THROMBOCYTOPENIA, X-LINKED, WITH OR WITHOUT DYSERYTHROPOIETIC ANEMIA; XLTDA" -"OMIM:300372","MENTAL RETARDATION, X-LINKED 42; MRX42" -"DOID:4195","hyperglycemia" -"OMIM:300373","OSTEOPATHIA STRIATA WITH CRANIAL SCLEROSIS; OSCS" -"OMIM:104600","AMENORRHEA-GALACTORRHEA SYNDROME" -"DOID:0050980","spinocerebellar ataxia type 31" -"DOID:2455","angular blepharoconjunctivitis" -"OMIM:300376","MUSCULAR DYSTROPHY, BECKER TYPE; BMD" -"DOID:0050983","spinocerebellar ataxia type 36" -"OMIM:300378","RADIAL RAY DEFICIENCY, X-LINKED" -"OMIM:300387","MENTAL RETARDATION, X-LINKED 63; MRX63" -"OMIM:300388","POLYMICROGYRIA, BILATERAL PERISYLVIAN, X-LINKED; BPPX" -"DOID:0050979","spinocerebellar ataxia type 30" -"DOID:0050959","spinocerebellar ataxia type 8" -"OMIM:300400","SEVERE COMBINED IMMUNODEFICIENCY, X-LINKED; SCIDX1" -"DOID:0110327","hypertrophic cardiomyopathy 26" -"DOID:8543","Hodgkin's lymphoma, lymphocytic-histiocytic predominance" -"DOID:8042","testis polyembryoma" -"DOID:10930","borderline personality disorder" -"DOID:5345","testicular non-seminomatous germ cell cancer" -"DOID:9749","internal hemorrhoid" -"OMIM:300406","FG SYNDROME 3; FGS3" -"DOID:0050984","spinocerebellar ataxia type 37" -"OMIM:300419","MENTAL RETARDATION, X-LINKED, WITH OR WITHOUT SEIZURES, ARX-RELATED; MRXARX" -"OMIM:300422","FG SYNDROME 4; FGS4" -"DOID:0050882","spinocerebellar ataxia type 5" -"OMIM:300423","MENTAL RETARDATION, X-LINKED, SYNDROMIC, HEDERA TYPE; MRXSH" -"DOID:0060162","dentatorubral-pallidoluysian atrophy" -"DOID:5842","testis seminoma" -"OMIM:300424","RETINITIS PIGMENTOSA 23; RP23" -"DOID:0050988","GRID2-related spinocerebellar ataxia" -"OMIM:104500","AMELOGENESIS IMPERFECTA, TYPE IB; AI1B" -"OMIM:300425","AUTISM, SUSCEPTIBILITY TO, X-LINKED 1; AUTSX1" -"DOID:0050967","spinocerebellar ataxia type 17" -"OMIM:105120","AMYLOIDOSIS, FINNISH TYPE" -"OMIM:178995","PRURITIC URTICARIAL PAPULES AND PLAQUES OF PREGNANCY; PUPPP" -"OMIM:300428","MENTAL RETARDATION, X-LINKED 2; MRX2" -"DOID:0110378","retinitis pigmentosa 29" -"DOID:9745","perianal hematoma" -"OMIM:300431","ATKIN-FLAITZ SYNDROME" -"OMIM:178900","PUPILLARY MEMBRANE, PERSISTENCE OF" -"DOID:0050972","spinocerebellar ataxia type 21" -"OMIM:105150","CEREBRAL AMYLOID ANGIOPATHY, CST3-RELATED" -"OMIM:300433","MENTAL RETARDATION, X-LINKED 81; MRX81" -"DOID:0110839","Usher syndrome type 2C" -"DOID:1542","head and neck carcinoma" -"DOID:0050523","adult T-cell leukemia" -"OMIM:300434","STOCCO DOS SANTOS X-LINKED MENTAL RETARDATION SYNDROME; SDSX" -"OMIM:300436","MENTAL RETARDATION, X-LINKED 46; MRX46" -"DOID:0050968","autosomal dominant cerebellar ataxia, deafness and narcolepsy" -"OMIM:104510","AMELOGENESIS IMPERFECTA, TYPE IV; AI4" -"OMIM:300438","HSD10 MITOCHONDRIAL DISEASE; HSD10MD" -"OMIM:300448","ALPHA-THALASSEMIA MYELODYSPLASIA SYNDROME; ATMDS" -"OMIM:104530","AMELOGENESIS IMPERFECTA, TYPE IA; AI1A" -"OMIM:300454","MENTAL RETARDATION, X-LINKED 77; MRX77" -"DOID:0050960","spinocerebellar ataxia type 10" -"DOID:5732","pyosalpinx" -"OMIM:300455","RETINITIS PIGMENTOSA, X-LINKED, AND SINORESPIRATORY INFECTIONS, WITH OR WITHOUT DEAFNESS" -"OMIM:173650","KINDLER SYNDROME; KNDLRS" -"DOID:0110313","hypertrophic cardiomyopathy 7" -"OMIM:300464","CORONARY HEART DISEASE, SUSCEPTIBILITY TO, 3" -"DOID:0050975","spinocerebellar ataxia type 26" -"DOID:0050973","spinocerebellar ataxia type 23" -"OMIM:104570","AMELOONYCHOHYPOHIDROTIC SYNDROME" -"DOID:3362","coronary aneurysm" -"OMIM:300471","CUBITUS VALGUS WITH MENTAL RETARDATION AND UNUSUAL FACIES" -"DOID:0050978","spinocerebellar ataxia type 29" -"DOID:0050848","obstructive sleep apnea" -"OMIM:300472","CORPUS CALLOSUM, AGENESIS OF, WITH MENTAL RETARDATION, OCULAR COLOBOMA, AND MICROGNATHIA" -"DOID:4248","coronary stenosis" -"OMIM:300475","DEAFNESS, DYSTONIA, AND CEREBRAL HYPOMYELINATION; DDCH" -"OMIM:104310","ALZHEIMER DISEASE 2; AD2" -"DOID:3688","plexopathy" -"OMIM:300476","CONE-ROD DYSTROPHY, X-LINKED, 3; CORDX3" -"OMIM:104350","AMASTIA, BILATERAL, WITH URETERAL TRIPLICATION AND DYSMORPHISM" -"DOID:0050969","spinocerebellar ataxia type 18" -"DOID:12637","perineocele" -"OMIM:300484","OROFACIODIGITAL SYNDROME VIII; OFD8" -"OMIM:178800","PUPIL, EGG-SHAPED" -"OMIM:300486","MENTAL RETARDATION, X-LINKED, WITH CEREBELLAR HYPOPLASIA AND DISTINCTIVE FACIAL APPEARANCE" -"OMIM:105200","AMYLOIDOSIS, FAMILIAL VISCERAL" -"OMIM:300488","MENOPAUSE, NATURAL, AGE AT, QUANTITATIVE TRAIT LOCUS 1; MENOQ1" -"OMIM:300489","SPINAL MUSCULAR ATROPHY, DISTAL, X-LINKED 3; SMAX3" -"OMIM:104400","AMELIA AND TERMINAL TRANSVERSE HEMIMELIA" -"OMIM:300491","EPILEPSY, X-LINKED, WITH VARIABLE LEARNING DISABILITIES AND BEHAVIOR DISORDERS" -"OMIM:300494","ASPERGER SYNDROME, X-LINKED, SUSCEPTIBILITY TO, 1; ASPGX1" -"DOID:0050976","spinocerebellar ataxia type 27" -"OMIM:300495","AUTISM, SUSCEPTIBILITY TO, X-LINKED 2; AUTSX2" -"OMIM:123550","CRYOGLOBULINEMIA, FAMILIAL MIXED" -"OMIM:613972","MELANOMA, CUTANEOUS MALIGNANT, SUSCEPTIBILITY TO, 6; CMM6" -"OMIM:601427","ANTERIOR CHAMBER CLEAVAGE DISORDER, CEREBELLAR HYPOPLASIA, HYPOTHYROIDISM, AND TRACHEAL STENOSIS" -"OMIM:607446","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 3; BMIQ3" -"OMIM:601438","RHIZOMELIC DYSPLASIA, PATTERSON-LOWRY TYPE" -"OMIM:607447","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 4; BMIQ4" -"OMIM:613977","CYANOSIS, TRANSIENT NEONATAL; TNCY" -"OMIM:601449","DEAFNESS, PROGRESSIVE, WITH STAPES FIXATION" -"DOID:4280","nodular basal cell carcinoma" -"DOID:681","progressive bulbar palsy" -"OMIM:613978","HEMOGLOBIN H DISEASE; HBH" -"OMIM:607450","ARRHYTHMOGENIC RIGHT VENTRICULAR DYSPLASIA, FAMILIAL, 8; ARVD8" -"OMIM:601450","DISLOCATION OF HIP, CONGENITAL, WITH HYPEREXTENSIBILITY OF FINGERS AND FACIAL DYSMORPHISM" -"OMIM:607453","DEAFNESS, AUTOSOMAL DOMINANT 44; DFNA44" -"OMIM:613980","ATRIAL FIBRILLATION, FAMILIAL, 9; ATFB9" -"DOID:2960","photosensitive trichothiodystrophy" -"OMIM:607454","SPINOCEREBELLAR ATAXIA 21; SCA21" -"OMIM:601452","OCULOAURICULOFRONTONASAL SYNDROME; OAFNS" -"OMIM:613981","HYPOTRICHOSIS 3; HYPT3" -"OMIM:613982","OSTEOGENESIS IMPERFECTA, TYPE VI; OI6" -"OMIM:607457","GIL BLOOD GROUP" -"OMIM:601453","TRICHODENTAL DYSPLASIA" -"DOID:0050776","non-syndromic X-linked intellectual disability" -"OMIM:123540","CRYOFIBRINOGENEMIA, FAMILIAL PRIMARY" -"OMIM:601454","PSORIASIS 3, SUSCEPTIBILITY TO; PSORS3" -"OMIM:607458","SPINOCEREBELLAR ATAXIA 18; SCA18" -"OMIM:613983","RETINITIS PIGMENTOSA 60; RP60" -"OMIM:111380","BLOOD GROUP--OK; OK" -"OMIM:123450","CRI-DU-CHAT SYNDROME" -"DOID:4372","intracranial embolism" -"OMIM:601455","CHARCOT-MARIE-TOOTH DISEASE, TYPE 4D; CMT4D" -"OMIM:607459","SENSORY ATAXIC NEUROPATHY, DYSARTHRIA, AND OPHTHALMOPARESIS; SANDO" -"OMIM:613985","BETA-THALASSEMIA" -"OMIM:111400","BLOOD GROUP, P1PK SYSTEM" -"DOID:0110382","retinitis pigmentosa 48" -"OMIM:613986","PITUITARY HORMONE DEFICIENCY, COMBINED, 6; CPHD6" -"OMIM:607464","THYROID CARCINOMA, HURTHLE CELL" -"OMIM:601457","SEVERE COMBINED IMMUNODEFICIENCY, AUTOSOMAL RECESSIVE, T CELL-NEGATIVE, B CELL-NEGATIVE, NK CELL-POSITIVE" -"OMIM:123570","CRYPTOPHTHALMOS, UNILATERAL OR BILATERAL, ISOLATED" -"OMIM:601458","INFLAMMATORY BOWEL DISEASE 2; IBD2" -"DOID:7650","pulmonary type ovarian small cell carcinoma" -"DOID:6196","reactive arthritis" -"DOID:5138","leiomyomatosis" -"OMIM:613987","DYSKERATOSIS CONGENITA, AUTOSOMAL RECESSIVE 2; DKCB2" -"OMIM:607473","VITAMIN K-DEPENDENT CLOTTING FACTORS, COMBINED DEFICIENCY OF, 2; VKCFD2" -"OMIM:613988","DYSKERATOSIS CONGENITA, AUTOSOMAL RECESSIVE 3; DKCB3" -"OMIM:601462","MYASTHENIC SYNDROME, CONGENITAL, 1A, SLOW-CHANNEL; CMS1A" -"OMIM:607475","BOTHNIA RETINAL DYSTROPHY" -"OMIM:601466","PATENT DUCTUS VENOSUS; PDV" -"OMIM:613989","DYSKERATOSIS CONGENITA, AUTOSOMAL DOMINANT 2; DKCA2" -"OMIM:607476","NEWFOUNDLAND ROD-CONE DYSTROPHY; NFRCD" -"OMIM:613990","DYSKERATOSIS CONGENITA, AUTOSOMAL DOMINANT 3; DKCA3" -"OMIM:601471","FACIAL PARESIS, HEREDITARY CONGENITAL, 1; HCFP1" -"OMIM:607482","CARDIOMYOPATHY, DILATED, 1M; CMD1M" -"OMIM:601472","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2D; CMT2D" -"OMIM:614008","NESTOR-GUILLERMO PROGERIA SYNDROME; NGPS" -"OMIM:607483","THIAMINE METABOLISM DYSFUNCTION SYNDROME 2 (BIOTIN- OR THIAMINE-RESPONSIVE TYPE); THMD2" -"DOID:5140","gallbladder leiomyoma" -"DOID:4265","angiomyoma" -"DOID:8893","psoriasis" -"OMIM:607485","FRONTOTEMPORAL LOBAR DEGENERATION WITH TDP43 INCLUSIONS, GRN-RELATED" -"OMIM:601477","RIBBING DISEASE" -"OMIM:614009","BLEEDING DISORDER, PLATELET-TYPE, 13, SUSCEPTIBILITY TO; BDPLT13" -"OMIM:607486","KNOPS BLOOD GROUP SYSTEM; KN" -"OMIM:601492","MUCOPOLYSACCHARIDOSIS, TYPE IX; MPS9" -"OMIM:614017","CILIARY DYSKINESIA, PRIMARY, 16; CILD16" -"OMIM:607487","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 25; CMH25" -"OMIM:614018","EPILEPSY, PROGRESSIVE MYOCLONIC, 6; EPM6" -"DOID:4717","extragonadal germ cell cancer" -"OMIM:601493","CARDIOMYOPATHY, DILATED, 1C, WITH OR WITHOUT LEFT VENTRICULAR NONCOMPACTION; CMD1C" -"DOID:5127","bizarre leiomyoma" -"OMIM:601494","CARDIOMYOPATHY, DILATED, 1D; CMD1D" -"OMIM:614019","LISSENCEPHALY 4; LIS4" -"OMIM:607488","DYSTONIA 15, MYOCLONIC; DYT15" -"OMIM:601495","AGAMMAGLOBULINEMIA 1, AUTOSOMAL RECESSIVE; AGM1" -"DOID:0110379","retinitis pigmentosa 43" -"OMIM:614020","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 14; MRT14" -"DOID:13089","intracranial arterial disease" -"OMIM:607498","MIGRAINE WITH OR WITHOUT AURA, SUSCEPTIBILITY TO, 3" -"OMIM:614021","VENTRICULAR TACHYCARDIA, CATECHOLAMINERGIC POLYMORPHIC, 3; CPVT3" -"OMIM:601499","AXENFELD-RIEGER SYNDROME, TYPE 2; RIEG2" -"OMIM:607499","BULIMIA NERVOSA, SUSCEPTIBILITY TO, 1; BULN1" -"OMIM:601518","PROSTATE CANCER, HEREDITARY, 1; HPC1" -"OMIM:614022","ATRIAL FIBRILLATION, FAMILIAL, 10; ATFB10" -"OMIM:607501","MIGRAINE WITHOUT AURA, SUSCEPTIBILITY TO, 4" -"OMIM:614023","PHOSPHOSERINE PHOSPHATASE DEFICIENCY; PSPHD" -"OMIM:601536","ATHABASKAN BRAINSTEM DYSGENESIS SYNDROME; ABDS" -"OMIM:607504","HEADACHE ASSOCIATED WITH SEXUAL ACTIVITY; HSA" -"DOID:0110402","retinitis pigmentosa 45" -"OMIM:601537","MICROCEPHALY, RETINITIS PIGMENTOSA, AND SUTURAL CATARACT" -"OMIM:607507","PSORIATIC ARTHRITIS, SUSCEPTIBILITY TO" -"OMIM:614024","PROTEIN Z DEFICIENCY" -"OMIM:607508","MIGRAINE WITH OR WITHOUT AURA, SUSCEPTIBILITY TO, 5" -"OMIM:601539","PEROXISOME BIOGENESIS DISORDER 1B; PBD1B" -"OMIM:614025","HEPATIC LIPASE DEFICIENCY" -"DOID:0050127","sinusitis" -"OMIM:601543","DEAFNESS, AUTOSOMAL DOMINANT 12; DFNA12" -"OMIM:607514","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 10; BMIQ10" -"OMIM:614028","APOLIPOPROTEIN C-III DEFICIENCY" -"OMIM:614033","HYDROXYACYL GLUTATHIONE HYDROLASE DEFICIENCY" -"OMIM:607516","MIGRAINE WITH OR WITHOUT AURA, SUSCEPTIBILITY TO, 6" -"OMIM:601544","DEAFNESS, AUTOSOMAL DOMINANT 3A; DFNA3A" -"DOID:9699","ophthalmia neonatorum" -"OMIM:607523","NAIL DISORDER, NONSYNDROMIC CONGENITAL, 8; NDNC8" -"OMIM:601547","CATARACT 3, MULTIPLE TYPES; CTRCT3" -"OMIM:123500","CROUZON SYNDROME" -"OMIM:123557","CRYPTOTIA, FAMILIAL" -"DOID:5976","occlusion precerebral artery" -"OMIM:614034","HEME OXYGENASE 1 DEFICIENCY; HMOX1D" -"OMIM:601549","ALACRIMA, CONGENITAL, AUTOSOMAL RECESSIVE" -"DOID:5146","appendix leiomyoma" -"OMIM:607539","CAMPTOSYNPOLYDACTYLY, COMPLEX; CCSPD" -"OMIM:614035","DEAFNESS, AUTOSOMAL RECESSIVE 29; DFNB29" -"DOID:5123","mediastinum leiomyoma" -"OMIM:614036","ALPHA-2-MACROGLOBULIN DEFICIENCY; A2MD" -"DOID:4037","necrotizing gastritis" -"OMIM:601550","BLOOD GROUP--SWANN SYSTEM; SW" -"OMIM:607540","SECRETORY DIARRHEA, MYOPATHY, AND DEAFNESS" -"OMIM:601551","BLOOD GROUP--FROESE" -"OMIM:614037","LEUKOTRIENE C4 SYNTHASE DEFICIENCY" -"OMIM:123560","CRYPTOMICROTIA-BRACHYDACTYLY SYNDROME" -"OMIM:607541","CORNEAL DYSTROPHY, AVELLINO TYPE; CDA" -"OMIM:182600","SPASTIC PARAPLEGIA 3, AUTOSOMAL DOMINANT; SPG3A" -"OMIM:607543","SPONDYLOMETAPHYSEAL DYSPLASIA WITH BOWED FOREARMS AND FACIAL DYSMORPHISM" -"OMIM:601552","FACIAL DYSMORPHISM, LENS DISLOCATION, ANTERIOR SEGMENT ABNORMALITIES, AND SPONTANEOUS FILTERING BLEBS; FDLAB" -"OMIM:614038","LYMPHEDEMA, PRIMARY, WITH MYELODYSPLASIA" -"DOID:5139","cellular leiomyoma" -"DOID:9063","Ritter's disease" -"OMIM:607554","ATRIAL FIBRILLATION, FAMILIAL, 3; ATFB3" -"OMIM:601553","HYPOTRICHOSIS, CONGENITAL, WITH JUVENILE MACULAR DYSTROPHY; HJMD" -"OMIM:614039","CORTICAL DYSPLASIA, COMPLEX, WITH OTHER BRAIN MALFORMATIONS 1; CDCBM1" -"DOID:11390","cerebral arteritis" -"OMIM:607565","SPASTIC PARAPLEGIA, ATAXIA, AND MENTAL RETARDATION" -"OMIM:614042","MOYAMOYA DISEASE 5; MYMY5" -"OMIM:601559","STUVE-WIEDEMANN SYNDROME" -"DOID:4193","intracranial thrombosis" -"DOID:0111103","maturity-onset diabetes of the young type 4" -"OMIM:607569","MYOPATHY, DISTAL, WITH EARLY RESPIRATORY FAILURE, AUTOSOMAL DOMINANT" -"DOID:37","skin disease" -"OMIM:601560","MULTIPLE EPIPHYSEAL DYSPLASIA WITH ROBIN PHENOTYPE" -"OMIM:111250","BLOOD GROUP SYSTEM, LANDSTEINER-WIENER; LW" -"OMIM:614044","TRYPSINOGEN DEFICIENCY" -"OMIM:607572","LEPROSY, SUSCEPTIBILITY TO, 2; LPRS2" -"OMIM:601561","DYSSEGMENTAL DYSPLASIA WITH GLAUCOMA" -"OMIM:111360","BLOOD GROUP--NEWFOUNDLAND; NFLD" -"OMIM:614049","ATRIAL FIBRILLATION, FAMILIAL, 11; ATFB11" -"OMIM:607578","BREATH-HOLDING SPELLS" -"OMIM:601563","HORNS IN SHEEP" -"OMIM:614050","ATRIAL FIBRILLATION, FAMILIAL, 12; ATFB12" -"DOID:4123","nail disease" -"DOID:0110322","hypertrophic cardiomyopathy 16" -"DOID:0110326","hypertrophic cardiomyopathy 20" -"DOID:0110328","hypertrophic cardiomyopathy 25" -"OMIM:124200","DARIER-WHITE DISEASE; DAR" -"DOID:9537","Lassa fever" -"OMIM:152100","LIPOPROTEIN TYPES--Ld SYSTEM" -"DOID:0110307","hypertrophic cardiomyopathy 1" -"OMIM:152400","LIPOPROTEIN, VARIANT OF BETA" -"OMIM:123790","BEARE-STEVENSON CUTIS GYRATA SYNDROME; BSTVS" -"DOID:0110325","hypertrophic cardiomyopathy 19" -"DOID:0110309","hypertrophic cardiomyopathy 3" -"OMIM:124100","DANUBIAN ENDEMIC FAMILIAL NEPHROPATHY" -"DOID:0080014","chromosomal disease" -"OMIM:181000","SARCOIDOSIS, SUSCEPTIBILITY TO, 1; SS1" -"DOID:0080037","Worth's syndrome" -"OMIM:181200","SC(1) TRAIT OF SALIVA" -"DOID:4964","neurotic disorder" -"DOID:6846","familial melanoma" -"OMIM:180950","SALIVARY SUBSTANCE, CLOSTRIDIUM BOTULINUM TYPE" -"DOID:12387","nephrogenic diabetes insipidus" -"OMIM:180900","RUTHERFURD SYNDROME" -"DOID:0110324","hypertrophic cardiomyopathy 18" -"OMIM:151900","LIPOMATOSIS, MULTIPLE" -"DOID:14320","generalized anxiety disorder" -"OMIM:181300","SCAPULA, CONTOUR OF VERTEBRAL BORDER OF" -"DOID:0110315","hypertrophic cardiomyopathy 9" -"OMIM:181270","SCALP-EAR-NIPPLE SYNDROME; SENS" -"DOID:0110319","hypertrophic cardiomyopathy 13" -"DOID:9640","sarcocystosis" -"DOID:0110312","hypertrophic cardiomyopathy 6" -"DOID:0060498","Timothy grass allergy" -"DOID:6088","acute stress disorder" -"OMIM:181350","EMERY-DREIFUSS MUSCULAR DYSTROPHY 2, AUTOSOMAL DOMINANT; EDMD2" -"DOID:0110314","hypertrophic cardiomyopathy 8" -"DOID:0110308","hypertrophic cardiomyopathy 2" -"DOID:8295","scabies" -"OMIM:152300","LIPOPROTEIN TYPES--Lt SYSTEM" -"OMIM:123880","CYSTIC ANGIOMATOSIS OF BONE, DIFFUSE" -"OMIM:181030","SALIVARY GLAND ADENOMA, PLEOMORPHIC" -"DOID:4997","Camurati-Engelmann disease" -"OMIM:151800","LIPOMATOSIS, MULTIPLE SYMMETRIC; MSL" -"OMIM:123853","CYPRUS FACIAL NEUROMUSCULOSKELETAL SYNDROME" -"OMIM:123997","CYTOCHROME c OXIDASE, SUBUNIT 7A2, PSEUDOGENE 2; COX7A2P2" -"DOID:0110317","hypertrophic cardiomyopathy 11" -"DOID:1563","dermatomycosis" -"DOID:0110323","hypertrophic cardiomyopathy 17" -"OMIM:180920","APLASIA OF LACRIMAL AND SALIVARY GLANDS; ALSG" -"DOID:11252","microcytic anemia" -"OMIM:151700","LIPOMA OF THE CONJUNCTIVA" -"OMIM:151660","LIPODYSTROPHY, FAMILIAL PARTIAL, TYPE 2; FPLD2" -"DOID:8507","juvenile dermatitis herpetiformis" -"DOID:0110320","hypertrophic cardiomyopathy 14" -"DOID:12550","hepatic coma" -"OMIM:181250","SCALP DEFECTS AND POSTAXIAL POLYDACTYLY" -"OMIM:181010","SALIVARY DUCT CALCULI" -"OMIM:124000","MITOCHONDRIAL COMPLEX III DEFICIENCY, NUCLEAR TYPE 1; MC3DN1" -"DOID:0110318","hypertrophic cardiomyopathy 12" -"OMIM:181180","SAY SYNDROME" -"DOID:0110321","hypertrophic cardiomyopathy 15" -"DOID:0110316","hypertrophic cardiomyopathy 10" -"OMIM:123700","CUTIS LAXA, AUTOSOMAL DOMINANT 1; ADCL1" -"DOID:0060220","physical urticaria" -"OMIM:162000","HYPERURICEMIC NEPHROPATHY, FAMILIAL JUVENILE, 1; HNFJ1" -"OMIM:162210","NEUROFIBROMATOSIS, FAMILIAL SPINAL" -"OMIM:560000","RENAL TUBULOPATHY, DIABETES MELLITUS, AND CEREBELLAR ATAXIA" -"DOID:0050150","Pontiac fever" -"OMIM:580000","DEAFNESS, AMINOGLYCOSIDE-INDUCED" -"DOID:0110994","Joubert syndrome 25" -"DOID:0050587","trichotillomania" -"OMIM:598500","WOLFRAM SYNDROME, MITOCHONDRIAL FORM" -"DOID:2510","Kluver-Bucy syndrome" -"OMIM:600000","SPONDYLOCAMPTODACTYLY" -"OMIM:130300","ELECTROENCEPHALOGRAPHIC PECULIARITY: FRONTO-PRECENTRAL BETA WAVE GROUPS" -"OMIM:600001","HEART DEFECTS, CONGENITAL, AND OTHER CONGENITAL ANOMALIES; HDCA" -"OMIM:600002","EIKEN SYNDROME" -"DOID:0110991","Joubert syndrome 22" -"OMIM:600048","BREAST CANCER, 11-22 TRANSLOCATION-ASSOCIATED; BRCATA" -"DOID:0110525","autosomal recessive nonsyndromic deafness 77" -"DOID:0110147","Bartter disease type 5" -"OMIM:130180","ELECTROENCEPHALOGRAM, LOW-VOLTAGE" -"DOID:0050451","Brugada syndrome" -"DOID:12402","pyromania" -"OMIM:600057","EXSTROPHY OF BLADDER" -"OMIM:130200","ELECTROENCEPHALOGRAPHIC PECULIARITY: 14 AND 6 PER SEC. POSITIVE SPIKE PHENOMENON" -"DOID:12399","pathological gambling" -"OMIM:600059","RETINITIS PIGMENTOSA 13; RP13" -"DOID:0110999","Joubert syndrome 4" -"DOID:12400","kleptomania" -"OMIM:600060","DEAFNESS, AUTOSOMAL RECESSIVE 2; DFNB2" -"OMIM:600072","FATAL FAMILIAL INSOMNIA; FFI" -"OMIM:600080","MYELOCYTIC LEUKEMIA-LIKE SYNDROME, FAMILIAL, CHRONIC" -"DOID:0110993","Joubert syndrome 24" -"OMIM:600081","VITAMIN D HYDROXYLATION-DEFICIENT RICKETS, TYPE 1B; VDDR1B" -"DOID:5521","keratinizing squamous cell carcinoma" -"OMIM:600082","PROSTATIC HYPERPLASIA, BENIGN; BPH" -"OMIM:600084","MACROCYTOSIS, FAMILIAL" -"OMIM:162100","AMYOTROPHY, HEREDITARY NEURALGIC; HNA" -"OMIM:600089","PANCREATIC BETA CELL AGENESIS WITH NEONATAL DIABETES MELLITUS" -"OMIM:161900","RENAL FAILURE, PROGRESSIVE, WITH HYPERTENSION; RFH1" -"OMIM:600092","CHONDRODYSPLASIA-PSEUDOHERMAPHRODITISM SYNDROME" -"DOID:4359","amelanotic melanoma" -"OMIM:600093","SPONDYLOEPIPHYSEAL DYSPLASIA TARDA WITH CHARACTERISTIC FACIES" -"OMIM:162091","SCHWANNOMATOSIS 1; SWNTS1" -"DOID:0110998","Joubert syndrome 3" -"OMIM:600096","PUERTO RICAN INFANT HYPOTONIA SYNDROME" -"OMIM:600101","DEAFNESS, AUTOSOMAL DOMINANT 2A; DFNA2A" -"OMIM:600105","RETINITIS PIGMENTOSA 12; RP12" -"OMIM:600110","STARGARDT DISEASE 3; STGD3" -"DOID:6195","conjunctivitis" -"OMIM:600116","PARKINSON DISEASE 2, AUTOSOMAL RECESSIVE JUVENILE; PARK2" -"DOID:0110990","Joubert syndrome 21" -"OMIM:600117","DYSPHASIA, FAMILIAL DEVELOPMENTAL" -"OMIM:130190","ELECTROENCEPHALOGRAPHIC PATTERN, BETA FREQUENCY, QUANTITATIVE TRAIT LOCUS; EEGBQTL" -"OMIM:600118","WARBURG MICRO SYNDROME 1; WARBM1" -"OMIM:162200","NEUROFIBROMATOSIS, TYPE I; NF1" -"OMIM:600121","RHIZOMELIC CHONDRODYSPLASIA PUNCTATA, TYPE 3; RCDP3" -"OMIM:162240","NEUROFIBROMATOSIS-PHEOCHROMOCYTOMA-DUODENAL CARCINOID SYNDROME" -"OMIM:600122","MALE PSEUDOHERMAPHRODITISM/MENTAL RETARDATION SYNDROME, VERLOES TYPE" -"OMIM:600123","ATRIOVENTRICULAR SEPTAL DEFECT WITH BLEPHAROPHIMOSIS AND ANAL AND RADIAL DEFECTS" -"DOID:0110982","Joubert syndrome 13" -"OMIM:600131","EPILEPSY, CHILDHOOD ABSENCE, SUSCEPTIBILITY TO, 1; ECA1" -"OMIM:600132","RETINITIS PIGMENTOSA 14; RP14" -"OMIM:600138","RETINITIS PIGMENTOSA 11; RP11" -"DOID:0110984","Joubert syndrome 15" -"OMIM:130400","ELECTROENCEPHALOGRAPHIC PECULIARITY: OCCIPITAL SLOW BETA WAVES" -"OMIM:600142","CEREBRAL ARTERIOPATHY, AUTOSOMAL RECESSIVE, WITH SUBCORTICAL INFARCTS AND LEUKOENCEPHALOPATHY; CARASIL" -"OMIM:161950","IgA NEPHROPATHY, SUSCEPTIBILITY TO, 1; IGAN1" -"DOID:12401","intermittent explosive disorder" -"OMIM:600143","CEROID LIPOFUSCINOSIS, NEURONAL, 8; CLN8" -"OMIM:600145","SACRAL DEFECT WITH ANTERIOR MENINGOCELE" -"OMIM:162020","NERVE GROWTH FACTOR, ALPHA SUBUNIT; NGFA" -"OMIM:600148","GLYCEROL KINASE 2; GK2" -"DOID:0110995","Joubert syndrome 26" -"OMIM:130600","ELLIPTOCYTOSIS 2; EL2" -"DOID:0050873","follicular lymphoma" -"OMIM:600149","GLYCEROL KINASE 3 PSEUDOGENE; GK3P" -"OMIM:614052","MITOCHONDRIAL COMPLEX V (ATP SYNTHASE) DEFICIENCY, NUCLEAR TYPE 2; MC5DN2" -"OMIM:602347","CHOLESTASIS, PROGRESSIVE FAMILIAL INTRAHEPATIC, 3; PFIC3" -"OMIM:607584","SPASTIC PARAPLEGIA 24, AUTOSOMAL RECESSIVE; SPG24" -"DOID:10321","baritosis" -"OMIM:602361","GRACILE BONE DYSPLASIA; GCLEB" -"OMIM:614053","MITOCHONDRIAL COMPLEX V (ATP SYNTHASE) DEFICIENCY, NUCLEAR TYPE 3; MC5DN3" -"OMIM:607592","PROSTATE CANCER AGGRESSIVENESS QUANTITATIVE TRAIT LOCUS ON CHROMOSOME 19" -"DOID:7928","testis refractory cancer" -"DOID:0060342","acromelic frontonasal dysostosis" -"OMIM:602390","HEMOCHROMATOSIS, TYPE 2A; HFE2A" -"DOID:13141","uveitis" -"OMIM:614055","ACETYL-CoA ACETYLTRANSFERASE-2 DEFICIENCY; ACAT2D" -"OMIM:607594","IMMUNODEFICIENCY, COMMON VARIABLE, 1; CVID1" -"OMIM:614063","N-ACETYLASPARTATE DEFICIENCY; NACED" -"OMIM:607595","BRAIN SMALL VESSEL DISEASE WITH OR WITHOUT OCULAR ANOMALIES; BSVD" -"OMIM:602398","DESMOSTEROLOSIS" -"OMIM:607596","PONTOCEREBELLAR HYPOPLASIA, TYPE 1A; PCH1A" -"OMIM:614065","MYOPATHY, DISTAL, 4; MPD4" -"OMIM:602400","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 11; ARCI11" -"DOID:0111080","Fanconi anemia complementation group V" -"OMIM:602401","ECTODERMAL DYSPLASIA 8, HAIR/TOOTH/NAIL TYPE; ECTD8" -"OMIM:614066","SPASTIC PARAPLEGIA 47, AUTOSOMAL RECESSIVE; SPG47" -"OMIM:607597","MICROPHTHALMIA WITH CYST, BILATERAL FACIAL CLEFTS, AND LIMB ANOMALIES" -"DOID:10329","pneumoconiosis due to talc" -"OMIM:602404","PARKINSON DISEASE 3, AUTOSOMAL DOMINANT; PARK3" -"OMIM:607598","LETHAL CONGENITAL CONTRACTURE SYNDROME 2; LCCS2" -"OMIM:614067","SPASTIC PARAPLEGIA 52, AUTOSOMAL RECESSIVE; SPG52" -"OMIM:614069","IMMUNODEFICIENCY-CENTROMERIC INSTABILITY-FACIAL ANOMALIES SYNDROME 2; ICF2" -"OMIM:602418","WEYERS ULNAR RAY/OLIGODACTYLY SYNDROME" -"OMIM:607600","EPIDERMOLYSIS BULLOSA SIMPLEX SUPERFICIALIS; EBSS" -"DOID:6367","acral lentiginous melanoma" -"OMIM:607602","ICHTHYOSIS, CYCLIC, WITH EPIDERMOLYTIC HYPERKERATOSIS" -"OMIM:602429","GLAUCOMA 1, OPEN ANGLE, D; GLC1D" -"OMIM:614070","PSORIASIS 13, SUSCEPTIBILITY TO; PSORS13" -"DOID:10933","obsessive-compulsive disorder" -"OMIM:602433","AMYOTROPHIC LATERAL SCLEROSIS 4, JUVENILE; ALS4" -"OMIM:607616","NIEMANN-PICK DISEASE, TYPE B" -"OMIM:614072","HERMANSKY-PUDLAK SYNDROME 3; HPS3" -"DOID:0111082","Fanconi anemia complementation group L" -"DOID:5683","hereditary breast ovarian cancer" -"DOID:10328","siderosis" -"OMIM:607624","GRISCELLI SYNDROME, TYPE 2; GS2" -"OMIM:602440","AMYOTROPHY, MONOMELIC" -"OMIM:614073","HERMANSKY-PUDLAK SYNDROME 4; HPS4" -"OMIM:602450","SEVERE COMBINED IMMUNODEFICIENCY WITH SENSITIVITY TO IONIZING RADIATION" -"OMIM:607625","NIEMANN-PICK DISEASE, TYPE C2; NPC2" -"OMIM:614074","HERMANSKY-PUDLAK SYNDROME 5; HPS5" -"DOID:0111085","Fanconi anemia complementation group U" -"OMIM:614075","HERMANSKY-PUDLAK SYNDROME 6; HPS6" -"OMIM:602459","DEAFNESS, AUTOSOMAL DOMINANT 15; DFNA15" -"OMIM:607626","ICHTHYOSIS, LEUKOCYTE VACUOLES, ALOPECIA, AND SCLEROSING CHOLANGITIS; ILVASC" -"DOID:0111083","Fanconi anemia complementation group D2" -"OMIM:614076","HERMANSKY-PUDLAK SYNDROME 7; HPS7" -"OMIM:602471","SHORT STATURE, AUDITORY CANAL ATRESIA, MANDIBULAR HYPOPLASIA, AND SKELETAL ABNORMALITIES; SAMS" -"DOID:0050581","brachydactyly" -"OMIM:607628","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 11; EIG11" -"OMIM:614077","HERMANSKY-PUDLAK SYNDROME 8; HPS8" -"OMIM:607631","EPILEPSY, JUVENILE ABSENCE, SUSCEPTIBILITY TO, 1; EJA1" -"OMIM:602472","CREASES, INFRA-AURICULAR CUTANEOUS, WITH TALL STATURE AND ADVANCED BONE AGE" -"DOID:0111096","Fanconi anemia complementation group O" -"DOID:4295","follicular basal cell carcinoma" -"OMIM:614078","CHONDRODYSPLASIA WITH JOINT DISLOCATIONS, GPAPP TYPE" -"OMIM:607634","OSTEOPETROSIS, AUTOSOMAL DOMINANT 1; OPTA1" -"OMIM:602473","ENCEPHALOPATHY, ETHYLMALONIC; EE" -"OMIM:614079","ASPERGILLOSIS, SUSCEPTIBILITY TO" -"OMIM:602475","OSSIFICATION OF THE POSTERIOR LONGITUDINAL LIGAMENT OF SPINE; OPLL" -"OMIM:607636","VAN BUCHEM DISEASE, TYPE 2" -"DOID:9540","vascular skin disease" -"DOID:0111092","Fanconi anemia complementation group P" -"OMIM:614080","MULTIPLE CONGENITAL ANOMALIES-HYPOTONIA-SEIZURES SYNDROME 1; MCAHS1" -"OMIM:607641","NEURONOPATHY, DISTAL HEREDITARY MOTOR, TYPE VIIB; HMN7B" -"OMIM:602477","FEBRILE SEIZURES, FAMILIAL, 2; FEB2" -"DOID:0111086","Fanconi anemia complementation group G" -"OMIM:607644","CANDIDIASIS, FAMILIAL, 3; CANDF3" -"OMIM:614081","ANHAPTOGLOBINEMIA; AHP" -"OMIM:602481","MIGRAINE, FAMILIAL HEMIPLEGIC, 2; FHM2" -"DOID:10688","hypertrophy of breast" -"DOID:11247","disseminated intravascular coagulation" -"OMIM:607654","KERATOSIS PALMOPLANTARIS STRIATA III; PPKS3" -"OMIM:614082","FANCONI ANEMIA, COMPLEMENTATION GROUP G; FANCG" -"OMIM:602482","AXENFELD-RIEGER SYNDROME, TYPE 3; RIEG3" -"OMIM:614083","FANCONI ANEMIA, COMPLEMENTATION GROUP L; FANCL" -"OMIM:607655","SKIN FRAGILITY-WOOLLY HAIR SYNDROME; SFWHS" -"OMIM:602483","AURICULOCONDYLAR SYNDROME 1; ARCND1" -"OMIM:602484","PELVIC HYPOPLASIA WITH LOWER-LIMB ARTHROGRYPOSIS" -"OMIM:614089","ATRIAL SEPTAL DEFECT 3; ASD3" -"OMIM:607656","CURLY HAIR-ACRAL KERATODERMA-CARIES SYNDROME" -"OMIM:607658","HYPOTRICHOSIS-OSTEOLYSIS-PERIODONTITIS-PALMOPLANTAR KERATODERMA SYNDROME" -"OMIM:602485","HYPERINSULINEMIC HYPOGLYCEMIA, FAMILIAL, 3; HHF3" -"OMIM:614090","SICK SINUS SYNDROME 3, SUSCEPTIBILITY TO; SSS3" -"OMIM:602491","HYPERLIPIDEMIA, COMBINED, 1" -"OMIM:614091","SHORT-RIB THORACIC DYSPLASIA 7 WITH OR WITHOUT POLYDACTYLY; SRTD7" -"DOID:10326","Caplan's syndrome" -"OMIM:607665","TUBULOINTERSTITIAL NEPHRITIS WITH UVEITIS; TINU" -"OMIM:607671","DYSTONIA 13, TORSION, AUTOSOMAL DOMINANT; DYT13" -"DOID:10331","kaolin pneumoconiosis" -"OMIM:614096","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 8; COXPD8" -"OMIM:602497","CHONDRODYSPLASIA PUNCTATA, BRACHYTELEPHALANGIC, AUTOSOMAL" -"DOID:827","ureter tuberculosis" -"OMIM:614097","ACATALASEMIA" -"OMIM:602499","MACROPHTHALMIA, COLOBOMATOUS, WITH MICROCORNEA; MACOM" -"OMIM:607674","CATARACT, CONGENITAL, WITH MENTAL IMPAIRMENT AND DENTATE GYRUS ATROPHY" -"DOID:10330","slate pneumoconiosis" -"OMIM:614098","KEPPEN-LUBINSKY SYNDROME; KPLBS" -"OMIM:602501","MEGALENCEPHALY-CAPILLARY MALFORMATION-POLYMICROGYRIA SYNDROME; MCAP" -"OMIM:607676","IRAK4 DEFICIENCY" -"OMIM:614099","CRANIOECTODERMAL DYSPLASIA 3; CED3" -"OMIM:607677","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2I; CMT2I" -"OMIM:602511","PSEUDOACROMEGALY WITH SEVERE INSULIN RESISTANCE" -"DOID:0111094","Fanconi anemia complementation group N" -"OMIM:607678","CHARCOT-MARIE-TOOTH DISEASE, DEMYELINATING, TYPE 1D; CMT1D" -"OMIM:602522","BARTTER SYNDROME, TYPE 4A, NEONATAL, WITH SENSORINEURAL DEAFNESS; BARTS4A" -"OMIM:614100","CUTIS LAXA, NEONATAL, WITH MARFANOID PHENOTYPE" -"DOID:1911","endodermal sinus tumor" -"DOID:0110259","cataract 43" -"OMIM:602531","GRANGE SYNDROME; GRNG" -"OMIM:614101","PLASMA FIBRONECTIN DEFICIENCY" -"OMIM:607681","EPILEPSY, CHILDHOOD ABSENCE, SUSCEPTIBILITY TO, 2; ECA2" -"DOID:0111088","Fanconi anemia complementation group F" -"DOID:1573","communicating hydrocephalus" -"OMIM:607682","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 9; EIG9" -"DOID:0111081","Fanconi anemia complementation group T" -"OMIM:602535","MARSHALL-SMITH SYNDROME; MRSHSS" -"OMIM:614102","IMMUNOGLOBULIN KAPPA LIGHT CHAIN DEFICIENCY; IGKCD" -"OMIM:602540","ICHTHYOSIS, HYSTRIX-LIKE, WITH DEAFNESS" -"OMIM:607683","DEAFNESS, AUTOSOMAL DOMINANT 52; DFNA52" -"OMIM:614103","LIPEDEMA" -"DOID:0111097","Fanconi anemia complementation group J" -"DOID:9733","renal tuberculosis" -"OMIM:602541","MUSCULAR DYSTROPHY, CONGENITAL, MEGACONIAL TYPE; MDCMC" -"OMIM:607684","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2E; CMT2E" -"OMIM:614104","MENTAL RETARDATION, AUTOSOMAL DOMINANT 7; MRD7" -"OMIM:602551","JEJUNAL ATRESIA WITH RENAL ADYSPLASIA" -"OMIM:614105","METHYLMALONATE SEMIALDEHYDE DEHYDROGENASE DEFICIENCY; MMSDHD" -"OMIM:607685","HYPEREOSINOPHILIC SYNDROME, IDIOPATHIC; HES" -"DOID:0111091","Fanconi anemia complementation group I" -"OMIM:607687","HIGH DENSITY LIPOPROTEIN CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 3" -"OMIM:602553","ANAL ATRESIA, HYPOSPADIAS, AND PENOSCROTAL INVERSION" -"OMIM:614111","PYRUVATE DEHYDROGENASE E1-BETA DEFICIENCY; PDHBD" -"OMIM:607688","PARKINSON DISEASE 11, AUTOSOMAL DOMINANT, SUSCEPTIBILITY TO; PARK11" -"DOID:10323","byssinosis" -"OMIM:614113","MENTAL RETARDATION, AUTOSOMAL DOMINANT 2; MRD2" -"OMIM:602554","TORSION DYSTONIA WITH ONSET IN INFANCY" -"OMIM:207600","TAKAYASU ARTERITIS" -"OMIM:125460","DEOXYRIBOSE-5-PHOSPHATE ALDOLASE DEFICIENCY" -"OMIM:125370","DENTATORUBRAL-PALLIDOLUYSIAN ATROPHY; DRPLA" -"OMIM:207620","APHALANGY WITH HEMIVERTEBRAE" -"OMIM:186580","BLAU SYNDROME; BLAUS" -"DOID:820","myocarditis" -"OMIM:207720","APNEA, CENTRAL SLEEP" -"OMIM:125500","DENTINOGENESIS IMPERFECTA, SHIELDS TYPE III" -"OMIM:125440","DENTIN DYSPLASIA WITH SCLEROTIC BONES" -"OMIM:207731","APLASIA CUTIS CONGENITA WITH INTESTINAL LYMPHANGIECTASIA" -"OMIM:125420","DENTIN DYSPLASIA, TYPE II; DTDP2" -"OMIM:207740","APLASIA OF EXTENSOR MUSCLES OF FINGERS, UNILATERAL, WITH GENERALIZED POLYNEUROPATHY" -"OMIM:181405","SCAPULOPERONEAL SPINAL MUSCULAR ATROPHY; SPSMA" -"DOID:4278","scrotum basal cell carcinoma" -"OMIM:207750","APOLIPOPROTEIN C-II DEFICIENCY" -"DOID:0110010","achromatopsia 4" -"OMIM:207770","APROSENCEPHALY SYNDROME" -"OMIM:186575","SYNOVIAL CHONDROMATOSIS, FAMILIAL, WITH DWARFISM" -"OMIM:207780","AREDYLD" -"DOID:1287","cardiovascular system disease" -"OMIM:125400","DENTIN DYSPLASIA, TYPE I; DTDP1" -"OMIM:207790","ARACHNOID CYSTS, INTRACRANIAL" -"OMIM:207800","ARGININEMIA" -"DOID:13310","diphtheritic peritonitis" -"OMIM:207900","ARGININOSUCCINIC ACIDURIA" -"OMIM:207950","CHIARI MALFORMATION TYPE II" -"OMIM:186570","TARSAL-CARPAL COALITION SYNDROME; TCC" -"OMIM:208000","ARTERIAL CALCIFICATION, GENERALIZED, OF INFANCY, 1; GACI1" -"DOID:3819","toxicodendron dermatitis" -"DOID:11750","Bordetella parapertussis whooping cough" -"OMIM:208050","ARTERIAL TORTUOSITY SYNDROME; ATS" -"OMIM:186500","MULTIPLE SYNOSTOSES SYNDROME 1; SYNS1" -"DOID:525","central nervous system vasculitis" -"DOID:9471","meningitis" -"OMIM:208060","ARTERIOSCLEROSIS, SEVERE JUVENILE" -"OMIM:208080","ARTHROGRYPOSIS, DISTAL, WITH HYPOPITUITARISM, MENTAL RETARDATION, AND FACIAL ANOMALIES" -"DOID:1798","pancreatic endocrine carcinoma" -"DOID:3498","pancreatic ductal adenocarcinoma" -"DOID:13454","gonococcal synovitis" -"DOID:0014667","disease of metabolism" -"DOID:5742","pancreatic acinar cell adenocarcinoma" -"OMIM:186600","SYRINGOMAS, MULTIPLE" -"DOID:3777","granuloma annulare" -"OMIM:208081","ARTHROGRYPOSIS, DISTAL, WITH MENTAL RETARDATION AND CHARACTERISTIC FACIES" -"DOID:2702","pigmented villonodular synovitis" -"OMIM:208085","ARTHROGRYPOSIS, RENAL DYSFUNCTION, AND CHOLESTASIS 1; ARCS1" -"OMIM:208100","ARTHROGRYPOSIS MULTIPLEX CONGENITA, NEUROGENIC TYPE; AMCN" -"OMIM:186400","SYNOSTOSES, TARSAL, CARPAL, AND DIGITAL" -"OMIM:208150","FETAL AKINESIA DEFORMATION SEQUENCE; FADS" -"OMIM:165660","OSLAM SYNDROME" -"OMIM:125520","CAYLER CARDIOFACIAL SYNDROME" -"OMIM:208155","ILLUM SYNDROME" -"OMIM:208158","ARTHROGRYPOSIS WITH HYPERKERATOSIS" -"DOID:5580","pancreatic gastrinoma" -"DOID:4404","occupational dermatitis" -"OMIM:186350","SYNDACTYLY-POLYDACTYLY-EARLOBE SYNDROME" -"OMIM:208230","ARTHROPATHY, PROGRESSIVE PSEUDORHEUMATOID, OF CHILDHOOD; PPAC" -"OMIM:208250","CAMPTODACTYLY-ARTHROPATHY-COXA VARA-PERICARDITIS SYNDROME; CACP" -"DOID:0060857","septooptic dysplasia" -"OMIM:125490","DENTINOGENESIS IMPERFECTA 1; DGI1" -"OMIM:125480","MAJOR AFFECTIVE DISORDER 1; MAFD1" -"OMIM:208300","ASCITES, CHYLOUS" -"OMIM:186300","SYNDACTYLY, TYPE V; SDTY5" -"DOID:13159","scrotum squamous cell carcinoma" -"OMIM:208400","ASPARTYLGLUCOSAMINURIA; AGU" -"OMIM:125350","FAILURE OF TOOTH ERUPTION, PRIMARY; PFE" -"DOID:0060567","erythema elevatum diutinum" -"OMIM:208500","SHORT-RIB THORACIC DYSPLASIA 1 WITH OR WITHOUT POLYDACTYLY; SRTD1" -"DOID:4432","pancreatic somatostatinoma" -"OMIM:208530","RIGHT ATRIAL ISOMERISM; RAI" -"DOID:8947","diabetic retinopathy" -"DOID:10568","early yaws" -"OMIM:208540","RENAL-HEPATIC-PANCREATIC DYSPLASIA 1; RHPD1" -"DOID:5741","pancreatic vasoactive intestinal peptide producing tumor" -"OMIM:208550","ASTHMA, NASAL POLYPS, AND ASPIRIN INTOLERANCE" -"OMIM:186700","SYRINGOMYELIA, NONCOMMUNICATING ISOLATED" -"OMIM:208600","ASTHMA, SHORT STATURE, AND ELEVATED IgA" -"OMIM:208700","ATAXIA WITH MYOCLONIC EPILEPSY AND PRESENILE DEMENTIA" -"OMIM:186550","LIEBENBERG SYNDROME; LBNBG" -"OMIM:208750","ATAXIA, DEAFNESS, AND CARDIOMYOPATHY" -"DOID:4433","pancreatic delta cell neoplasm" -"OMIM:208850","ATAXIA-DEAFNESS-RETARDATION SYNDROME" -"DOID:9909","hordeolum" -"OMIM:208870","ATAXIA-MICROCEPHALY-CATARACT SYNDROME" -"DOID:7698","non-functioning pancreatic endocrine tumor" -"DOID:0060000","infective endocarditis" -"DOID:1063","interstitial nephritis" -"OMIM:208900","ATAXIA-TELANGIECTASIA; AT" -"OMIM:601165","CLEFT LIP/PALATE WITH CHARACTERISTIC FACIES, INTESTINAL MALROTATION, AND LETHAL CONGENITAL HEART DISEASE" -"OMIM:601800","SKIN/HAIR/EYE PIGMENTATION, VARIATION IN, 3; SHEP3" -"OMIM:607694","LEUKODYSTROPHY, HYPOMYELINATING, 7, WITH OR WITHOUT OLIGODONTIA AND/OR HYPOGONADOTROPIC HYPOGONADISM; HLD7" -"OMIM:601170","MUSCULAR DYSTROPHY, CONGENITAL, WITH SEVERE CENTRAL NERVOUS SYSTEM ATROPHY AND ABSENCE OF LARGE MYELINATED FIBERS" -"OMIM:607706","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, WITH VOCAL CORD PARESIS, AUTOSOMAL RECESSIVE" -"OMIM:601803","PALLISTER-KILLIAN SYNDROME; PKS" -"OMIM:601808","CHROMOSOME 18q DELETION SYNDROME" -"OMIM:601186","MICROPHTHALMIA, SYNDROMIC 9; MCOPS9" -"OMIM:607721","NOONAN SYNDROME-LIKE DISORDER WITH LOOSE ANAGEN HAIR 1; NSLH1" -"OMIM:601187","GURRIERI SYNDROME" -"OMIM:607728","POROKERATOSIS 4, DISSEMINATED SUPERFICIAL ACTINIC TYPE; POROK4" -"OMIM:179250","RADIAL HYPOPLASIA, TRIPHALANGEAL THUMBS, HYPOSPADIAS, AND MAXILLARY DIASTEMA" -"DOID:0060587","Noonan syndrome 9" -"OMIM:601809","SPONDYLOSPINAL THORACIC DYSOSTOSIS" -"OMIM:601811","PREMATURE AGING SYNDROME, OKAMOTO TYPE" -"OMIM:607731","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2H; CMT2H" -"OMIM:601188","SUPPRESSION OF TUMORIGENICITY 12; ST12" -"OMIM:179270","RADIAL RAY HYPOPLASIA WITH CHOANAL ATRESIA" -"OMIM:601195","IRON OVERLOAD IN AFRICA" -"OMIM:601812","PREMATURE AGING SYNDROME, PENTTINEN TYPE; PENTT" -"OMIM:607734","CHARCOT-MARIE-TOOTH DISEASE, DEMYELINATING, TYPE 1F; CMT1F" -"OMIM:135400","HYPERTRICHOSIS, CONGENITAL GENERALIZED, WITH OR WITHOUT GINGIVAL HYPERPLASIA; HTC3" -"OMIM:601198","HYPOCALCEMIA, AUTOSOMAL DOMINANT 1; HYPOC1" -"OMIM:607736","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2J; CMT2J" -"OMIM:601813","EXUDATIVE VITREORETINOPATHY 4; EVR4" -"OMIM:179280","RADIAL-RENAL SYNDROME" -"OMIM:601200","PLEUROPULMONARY BLASTOMA; PPB" -"OMIM:601815","PHOSPHOGLYCERATE DEHYDROGENASE DEFICIENCY; PHGDHD" -"OMIM:607745","SEIZURES, BENIGN FAMILIAL INFANTILE, 3; BFIS3" -"OMIM:601816","BILIRUBIN, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS 1; BILIQTL1" -"OMIM:607748","HYPERCHOLANEMIA, FAMILIAL; FHCA" -"OMIM:601202","CATARACT 24; CTRCT24" -"DOID:0060583","Noonan syndrome 5" -"OMIM:601820","HYPERINSULINEMIC HYPOGLYCEMIA, FAMILIAL, 2; HHF2" -"OMIM:607765","BILE ACID SYNTHESIS DEFECT, CONGENITAL, 1; CBAS1" -"OMIM:601208","DIABETES MELLITUS, INSULIN-DEPENDENT, 11; IDDM11" -"DOID:5093","thoracic cancer" -"OMIM:601829","ACROFACIAL DYSOSTOSIS, PALAGONIA TYPE" -"OMIM:607778","ACROCAPITOFEMORAL DYSPLASIA; ACFD" -"OMIM:601214","NAXOS DISEASE; NXD" -"OMIM:607785","JUVENILE MYELOMONOCYTIC LEUKEMIA; JMML" -"OMIM:601216","DENTAL ANOMALIES AND SHORT STATURE; DASS" -"OMIM:601846","VACUOLAR NEUROMYOPATHY" -"OMIM:135500","ZIMMERMANN-LABAND SYNDROME 1; ZLS1" -"OMIM:607791","CHARCOT-MARIE-TOOTH DISEASE, DOMINANT INTERMEDIATE D; CMTDID" -"OMIM:601217","ALOPECIA-MENTAL RETARDATION SYNDROME WITH CONVULSIONS AND HYPERGONADOTROPIC HYPOGONADISM" -"OMIM:601847","CHOLESTASIS, PROGRESSIVE FAMILIAL INTRAHEPATIC, 2; PFIC2" -"OMIM:601220","OSTEOPOROSIS AND OCULOCUTANEOUS HYPOPIGMENTATION SYNDROME; OOCH" -"OMIM:607801","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 1C; LGMD1C" -"OMIM:601853","GOMEZ-LOPEZ-HERNANDEZ SYNDROME; GLHS" -"DOID:0060580","Noonan syndrome 2" -"OMIM:601859","AUTOIMMUNE LYMPHOPROLIFERATIVE SYNDROME; ALPS" -"DOID:0060582","Noonan syndrome 4" -"OMIM:601221","TISSUE-SPECIFIC EXTINGUISHER 3" -"OMIM:607812","CRANIOLENTICULOSUTURAL DYSPLASIA; CLSD" -"OMIM:607821","DEAFNESS, AUTOSOMAL RECESSIVE 37; DFNB37" -"OMIM:601223","NEURONAL INTESTINAL DYSPLASIA, TYPE B" -"OMIM:601868","DEAFNESS, AUTOSOMAL DOMINANT 13; DFNA13" -"DOID:0060890","ectopic Cushing syndrome" -"OMIM:607822","ALZHEIMER DISEASE 3; AD" -"OMIM:601869","DEAFNESS, AUTOSOMAL RECESSIVE 15; DFNB15" -"OMIM:601224","POTOCKI-SHAFFER SYNDROME" -"DOID:0110655","long QT syndrome 14" -"DOID:4972","myelodysplastic/myeloproliferative neoplasm" -"OMIM:607823","HYPOTRICHOSIS-LYMPHEDEMA-TELANGIECTASIA SYNDROME; HLTS" -"OMIM:601876","SPERM-SPECIFIC ANTIGEN 1; SSFA1" -"OMIM:601228","POLYPOSIS SYNDROME, HEREDITARY MIXED, 1; HMPS1" -"OMIM:601230","DERMATITIS HERPETIFORMIS, FAMILIAL" -"OMIM:607829","MITRAL VALVE PROLAPSE 2; MVP2" -"OMIM:601884","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 1; BMND1" -"OMIM:601238","CEREBELLAR ATAXIA, CAYMAN TYPE; ATCAY" -"OMIM:601885","CATARACT 14, MULTIPLE TYPES; CTRCT14" -"OMIM:607831","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2K; CMT2K" -"OMIM:601277","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 4A; ARCI4A" -"DOID:0050580","hereditary lymphedema" -"OMIM:607832","FOCAL SEGMENTAL GLOMERULOSCLEROSIS 3, SUSCEPTIBILITY TO; FSGS3" -"DOID:3876","colonic pseudo-obstruction" -"DOID:7086","multicentric papillary thyroid carcinoma" -"OMIM:601887","MALIGNANT HYPERTHERMIA, SUSCEPTIBILITY TO, 5" -"OMIM:179200","RADIAL HEADS, POSTERIOR DISLOCATION OF" -"OMIM:601283","DIABETES MELLITUS, NONINSULIN-DEPENDENT, 1; NIDDM1" -"OMIM:601888","MALIGNANT HYPERTHERMIA, SUSCEPTIBILITY TO, 6" -"DOID:14292","vulvar dystrophy" -"DOID:6082","pediatric testicular germ cell tumor" -"OMIM:607834","ANXIETY" -"OMIM:601287","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2F; LGMD2F" -"OMIM:607836","AUTOIMMUNE DISEASE, SUSCEPTIBILITY TO, 1; AIS1" -"OMIM:601894","GLOMERULOPATHY WITH FIBRONECTIN DEPOSITS 2; GFND2" -"OMIM:135300","FIBROMATOSIS, GINGIVAL, 1; GINGF1" -"OMIM:607841","DEAFNESS, AUTOSOMAL DOMINANT 48; DFNA48" -"OMIM:179010","PYLORIC STENOSIS, INFANTILE HYPERTROPHIC, 1; IHPS1" -"OMIM:601308","MYELOID TUMOR SUPPRESSOR" -"OMIM:179000","PURPURA SIMPLEX" -"OMIM:601927","LYMPHEDEMA, CARDIAC SEPTAL DEFECTS, AND CHARACTERISTIC FACIES" -"OMIM:607842","AURAL ATRESIA, CONGENITAL; CAA" -"OMIM:601941","DIABETES MELLITUS, INSULIN-DEPENDENT, 6; IDDM6" -"OMIM:601315","EPITHELIAL BASOLATERAL CHLORIDE CONDUCTANCE REGULATOR, RABBIT, HOMOLOG OF" -"OMIM:135580","FIBROMUSCULAR DYSPLASIA; FMDA" -"OMIM:601942","DIABETES MELLITUS, INSULIN-DEPENDENT, 10; IDDM10" -"OMIM:607847","NEUTROPENIA, NONIMMUNE CHRONIC IDIOPATHIC, OF ADULTS" -"OMIM:601316","DEAFNESS, AUTOSOMAL DOMINANT 10; DFNA10" -"OMIM:607850","OSTEOARTHRITIS SUSCEPTIBILITY 3; OS3" -"OMIM:601952","KERATOSIS LINEARIS WITH ICHTHYOSIS CONGENITA AND SCLEROSING KERATODERMA; KLICK" -"OMIM:601317","DEAFNESS, AUTOSOMAL DOMINANT 11; DFNA11" -"DOID:0111077","pyruvate kinase deficiency of red cells" -"OMIM:601954","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2G; LGMD2G" -"OMIM:607853","PANIC DISORDER 2" -"OMIM:601318","DIABETES MELLITUS, INSULIN-DEPENDENT, 13; IDDM13" -"DOID:0050026","human monocytic ehrlichiosis" -"OMIM:601319","ODONTOMICRONYCHIAL DYSPLASIA" -"OMIM:607855","MUSCULAR DYSTROPHY, CONGENITAL MEROSIN-DEFICIENT, 1A; MDC1A" -"OMIM:601957","ODONTOTRICHOUNGUAL-DIGITAL-PALMAR SYNDROME" -"OMIM:135290","DESMOID DISEASE, HEREDITARY" -"OMIM:607857","PSORIASIS 9, SUSCEPTIBILITY TO; PSORS9" -"OMIM:601976","OTOFACIOOSSEOUS-GONADAL SYNDROME" -"OMIM:601321","NEUROFIBROMATOSIS-NOONAN SYNDROME; NFNS" -"DOID:0060588","Noonan syndrome 10" -"OMIM:601977","THROMBOCYTHEMIA 2; THCYT2" -"DOID:5556","testicular malignant germ cell cancer" -"OMIM:607859","ANGIOMA, TUFTED" -"OMIM:601322","PORENCEPHALY, CEREBELLAR HYPOPLASIA, AND INTERNAL MALFORMATIONS" -"OMIM:601331","RENAL DYSPLASIA, CYSTIC, SUSCEPTIBILITY TO; CYSRD" -"OMIM:607864","CAUDAL DUPLICATION ANOMALY" -"OMIM:601979","HYPERZINCEMIA WITH FUNCTIONAL ZINC DEPLETION" -"DOID:3901","vulvitis" -"DOID:0060586","Noonan syndrome 8" -"OMIM:607872","CHROMOSOME 1p36 DELETION SYNDROME" -"DOID:0110980","Joubert syndrome 1" -"OMIM:601992","FRIEDREICH ATAXIA 2; FRDA2" -"OMIM:601338","CEREBELLAR ATAXIA, AREFLEXIA, PES CAVUS, OPTIC ATROPHY, AND SENSORINEURAL HEARING LOSS; CAPOS" -"OMIM:602014","HYPOMAGNESEMIA 1, INTESTINAL; HOMG1" -"OMIM:607876","EPILEPSY, FAMILIAL ADULT MYOCLONIC, 2; FAME2" -"OMIM:601341","ATROPHIA MACULOSA VARIOLIFORMIS CUTIS, FAMILIAL; AMVC" -"OMIM:135550","FIBROMATOSIS, GINGIVAL, WITH PROGRESSIVE DEAFNESS" -"OMIM:601344","SPINAL DYSPLASIA, ANHALT TYPE" -"OMIM:602025","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 9; BMIQ9" -"DOID:1115","sarcoma" -"OMIM:607893","OVARIAN CANCER, SUSCEPTIBILITY TO, 1; OVCAS1" -"OMIM:601345","ECTODERMAL DYSPLASIA WITH NATAL TEETH, TURNPENNY TYPE" -"DOID:0060578","Noonan syndrome 1" -"OMIM:602032","ECTODERMAL DYSPLASIA 4, HAIR/NAIL TYPE; ECTD4" -"OMIM:607903","HYPOTRICHOSIS 6; HYPT6" -"DOID:0050872","large cell neuroendocrine carcinoma" -"OMIM:300218","MENTAL RETARDATION, X-LINKED, SYNDROMIC 7; MRXS7" -"OMIM:614114","MOSAIC VARIEGATED ANEUPLOIDY SYNDROME 2; MVA2" -"DOID:0110240","cataract 20 multiple types" -"DOID:5517","stomach carcinoma" -"OMIM:614115","CORTICAL MALFORMATIONS, OCCIPITAL; OCCM" -"OMIM:300219","MYOTUBULAR MYOPATHY WITH ABNORMAL GENITAL DEVELOPMENT" -"DOID:0110248","cataract 30" -"OMIM:614116","NEUROPATHY, HEREDITARY SENSORY, TYPE IE; HSN1E" -"OMIM:300221","LYMPHOMA, HODGKIN, X-LINKED PSEUDOAUTOSOMAL" -"OMIM:300228","TESTICULAR GERM CELL TUMOR 1; TGCT1" -"OMIM:614120","HYDROLETHALUS SYNDROME 2; HLS2" -"DOID:0111020","cone-rod dystrophy 9" -"OMIM:614122","CHITOTRIOSIDASE DEFICIENCY; CHITD" -"OMIM:300232","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, X-LINKED, WITH MENTAL DETERIORATION" -"DOID:10341","chronic meningitis" -"OMIM:300233","RADIOULNAR SYNOSTOSIS, RADIAL RAY ABNORMALITIES, AND SEVERE MALFORMATIONS IN THE MALE" -"DOID:0110245","cataract 38" -"OMIM:614128","LACTATE DEHYDROGENASE B DEFICIENCY; LDHBD" -"DOID:0110256","cataract 21 multiple types" -"DOID:0110252","cataract 37" -"OMIM:300238","MENTAL RETARDATION, X-LINKED, SYNDROMIC 11; MRXS11" -"OMIM:614129","PERRAULT SYNDROME 3; PRLTS3" -"OMIM:300243","MENTAL RETARDATION, X-LINKED, SYNDROMIC, CHRISTIANSON TYPE; MRXSCH" -"OMIM:614131","FOCAL SEGMENTAL GLOMERULOSCLEROSIS 6; FSGS6" -"OMIM:614134","STICKLER SYNDROME, TYPE IV; STL4" -"OMIM:300244","TERMINAL OSSEOUS DYSPLASIA; TOD" -"DOID:0110262","cataract 45" -"OMIM:614135","EPIPHYSEAL DYSPLASIA, MULTIPLE, 6; EDM6" -"OMIM:300245","PTOSIS, HEREDITARY CONGENITAL 2" -"DOID:327","syringomyelia" -"DOID:848","arthritis" -"OMIM:300257","DANON DISEASE" -"OMIM:614149","NAIL DISORDER, NONSYNDROMIC CONGENITAL, 9; NDNC9" -"DOID:13027","transient global amnesia" -"OMIM:614152","DEAFNESS, AUTOSOMAL DOMINANT 64; DFNA64" -"OMIM:300259","MYCOBACTERIUM TUBERCULOSIS, SUSCEPTIBILITY TO, X-LINKED" -"OMIM:162300","MULTIPLE ENDOCRINE NEOPLASIA, TYPE IIB; MEN2B" -"DOID:10983","Alport syndrome" -"DOID:12377","spinal muscular atrophy" -"DOID:0110263","cataract 19 multiple types" -"OMIM:614153","SPINOCEREBELLAR ATAXIA 36; SCA36" -"OMIM:300260","LUBS X-LINKED MENTAL RETARDATION SYNDROME; MRXSL" -"OMIM:162260","NEUROFIBROMATOSIS, TYPE III, MIXED CENTRAL AND PERIPHERAL; NF3A" -"OMIM:614156","HYPERBILIVERDINEMIA; HBLVD" -"OMIM:300261","ARMFIELD X-LINKED MENTAL RETARDATION SYNDROME; MRXSA" -"DOID:0110264","cataract 33" -"DOID:5340","anterograde amnesia" -"DOID:0111033","African iron overload" -"OMIM:300262","ABIDI X-LINKED MENTAL RETARDATION SYNDROME; MRXSAB" -"OMIM:614157","NAIL DISORDER, NONSYNDROMIC CONGENITAL, 10; NDNC10" -"DOID:0110267","cataract 44" -"DOID:0110243","cataract 46 juvenile-onset" -"DOID:12217","Lewy body dementia" -"OMIM:300263","SIDERIUS X-LINKED MENTAL RETARDATION SYNDROME; MRXSSD" -"OMIM:614158","BLEEDING DISORDER, PLATELET-TYPE, 14; BDPLT14" -"DOID:0111017","cone-rod dystrophy 10" -"DOID:0110239","cataract 12 multiple types" -"OMIM:300266","SPASTIC PARAPLEGIA 16, X-LINKED; SPG16" -"OMIM:614160","MUSCLE HYPERTROPHY; MSLHP" -"DOID:3082","interstitial lung disease" -"OMIM:300270","ADRENOMYODYSTROPHY" -"OMIM:614162","IMMUNODEFICIENCY 31C; IMD31C" -"DOID:11246","DIC in newborn" -"OMIM:162350","CEROID LIPOFUSCINOSIS, NEURONAL, 4B, AUTOSOMAL DOMINANT; CLN4B" -"DOID:0111026","cone-rod dystrophy 20" -"OMIM:614163","DELAYED SLEEP PHASE DISORDER, SUSCEPTIBILITY TO; DSPD" -"OMIM:300271","MENTAL RETARDATION, X-LINKED 72; MRX72" -"OMIM:300273","GOITER, MULTINODULAR 2; MNG2" -"OMIM:614164","GLUTATHIONE PEROXIDASE DEFICIENCY; GPXD" -"OMIM:162270","NEUROFIBROMATOSIS, TYPE IV, OF RICCARDI; NF4" -"DOID:7327","pseudosarcomatous fibromatosis" -"OMIM:609633","MAJOR AFFECTIVE DISORDER 3; MAFD3" -"DOID:0110241","cataract 41" -"OMIM:614165","PARAGANGLIOMAS 5; PGL5" -"OMIM:300280","URUGUAY FACIOCARDIOMUSCULOSKELETAL SYNDROME" -"DOID:0110261","cataract 35" -"OMIM:300291","ECTODERMAL DYSPLASIA, HYPOHIDROTIC, WITH IMMUNE DEFICIENCY" -"OMIM:614166","MYOPIA 20, AUTOSOMAL DOMINANT; MYP20" -"OMIM:162370","NEUROPATHY, CONGENITAL, WITH ARTHROGRYPOSIS MULTIPLEX" -"OMIM:614167","MYOPIA 21, AUTOSOMAL DOMINANT; MYP21" -"DOID:7894","mite infestation" -"OMIM:300299","NEUTROPENIA, SEVERE CONGENITAL, X-LINKED; SCNX" -"DOID:9655","oral mucosa leukoplakia" -"OMIM:300301","ECTODERMAL DYSPLASIA, ANHIDROTIC, WITH IMMUNODEFICIENCY, OSTEOPETROSIS, AND LYMPHEDEMA; OLEDAID" -"OMIM:614170","BRITTLE CORNEA SYNDROME 2; BCS2" -"DOID:5579","gastric gastrinoma" -"OMIM:614171","HERMANSKY-PUDLAK SYNDROME 9; HPS9" -"OMIM:300306","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 11; BMIQ11" -"DOID:0060651","MYH-9 related disease" -"OMIM:300310","AGAMMAGLOBULINEMIA, X-LINKED, TYPE 2; AGMX2" -"DOID:0110265","cataract 31 multiple types" -"OMIM:614172","IMMUNODEFICIENCY 21; IMD21" -"DOID:0060042","atypical autism" -"OMIM:300321","FG SYNDROME 2; FGS2" -"OMIM:614173","JOUBERT SYNDROME 13; JBTS13" -"DOID:3162","malignant spindle cell melanoma" -"OMIM:614175","MECKEL SYNDROME, TYPE 10; MKS10" -"OMIM:300322","LESCH-NYHAN SYNDROME; LNS" -"DOID:11335","sarcoidosis" -"OMIM:162380","NEUROPATHY, HEREDITARY SENSORIMOTOR, WITH UPPER MOTOR NEURON, VISUAL PATHWAY AND AUTONOMIC DISTURBANCE" -"OMIM:300323","KELLEY-SEEGMILLER SYNDROME" -"OMIM:614180","RETINITIS PIGMENTOSA 61; RP61" -"OMIM:300324","MENTAL RETARDATION, X-LINKED 53; MRX53" -"OMIM:614181","RETINITIS PIGMENTOSA 62; RP62" -"DOID:10538","gastric fundus cancer" -"OMIM:300331","THROMBOCYTHEMIA, X-LINKED; THCYTX" -"OMIM:614185","GELEOPHYSIC DYSPLASIA 2; GPHYSD2" -"DOID:10548","cardia cancer" -"OMIM:614186","LEBER CONGENITAL AMAUROSIS 16; LCA16" -"DOID:14397","protozoal dysentery" -"DOID:5700","gastric liposarcoma" -"OMIM:300337","HYPOMELANOSIS OF ITO; HMI" -"DOID:0110232","cataract 29" -"DOID:12309","urticaria pigmentosa" -"OMIM:300345","MICROPHTHALMIA, ISOLATED, WITH COLOBOMA 1; MCOPCB1" -"DOID:0110254","cataract 25" -"OMIM:614187","HYPERTELORISM, PREAURICULAR SINUS, PUNCTAL PITS, AND DEAFNESS; HPPD" -"OMIM:614188","CRANIOSYNOSTOSIS AND DENTAL ANOMALIES; CRSDA" -"DOID:0111009","cone-rod dystrophy 1" -"OMIM:300351","GRAVES DISEASE, SUSCEPTIBILITY TO, X-LINKED 1" -"DOID:0050537","posterior polar cataract" -"DOID:0110246","cataract 26 multiple types" -"OMIM:614190","PIGMENTED NODULAR ADRENOCORTICAL DISEASE, PRIMARY, 3; PPNAD3" -"OMIM:300352","CEREBRAL CREATINE DEFICIENCY SYNDROME 1; CCDS1" -"DOID:0111006","X-linked cone-rod dystrophy 2" -"DOID:0110244","cataract 28" -"OMIM:300354","MENTAL RETARDATION, X-LINKED, SYNDROMIC, CABEZAS TYPE; MRXSC" -"OMIM:614192","MACROCEPHALY, MACROSOMIA, AND FACIAL DYSMORPHISM SYNDROME; MMFD" -"DOID:0110423","dilated cardiomyopathy 1C" -"DOID:0110449","dilated cardiomyopathy 1M" -"DOID:4176","blood group incompatibility" -"DOID:0110452","dilated cardiomyopathy 1T" -"DOID:0110440","dilated cardiomyopathy 1J" -"DOID:0110437","dilated cardiomyopathy 1K" -"DOID:0110429","dilated cardiomyopathy 1H" -"DOID:0110445","dilated cardiomyopathy 1KK" -"DOID:0060572","Ritscher-Schinzel syndrome 2" -"DOID:0110454","dilated cardiomyopathy 1S" -"DOID:268","liver angiosarcoma" -"DOID:0050131","motility-related diarrhea" -"DOID:8913","dermatophytosis" -"OMIM:607906","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ii; CDG1I" -"OMIM:614193","TRANSFERRIN SERUM LEVEL QUANTITATIVE TRAIT LOCUS 2; TFQTL2" -"DOID:3342","bone inflammation disease" -"OMIM:131850","EPIDERMOLYSIS BULLOSA DYSTROPHICA, PRETIBIAL" -"OMIM:614195","CRANIOFACIAL ANOMALIES AND ANTERIOR SEGMENT DYSGENESIS SYNDROME; CAASDS" -"OMIM:607907","DERMATOFIBROSARCOMA PROTUBERANS; DFSP" -"OMIM:160990","MYOTONIC MYOPATHY WITH CYLINDRICAL SPIRALS" -"OMIM:158280","MOTION SICKNESS" -"DOID:2519","testicular disease" -"OMIM:131760","EPIDERMOLYSIS BULLOSA SIMPLEX, DOWLING-MEARA TYPE; EBSDM" -"OMIM:614196","NEPHROTIC SYNDROME, TYPE 6; NPHS6" -"OMIM:607921","RETINITIS PIGMENTOSA 30; RP30" -"OMIM:607932","MICROPHTHALMIA, SYNDROMIC 6; MCOPS6" -"OMIM:614198","MYASTHENIC SYNDROME, CONGENITAL, 16; CMS16" -"OMIM:607936","PEELING SKIN SYNDROME 4; PSS4" -"OMIM:160565","MYOPATHY, TUBULAR AGGREGATE, 1; TAM1" -"OMIM:614199","NEPHROTIC SYNDROME, TYPE 5, WITH OR WITHOUT OCULAR ABNORMALITIES; NPHS5" -"OMIM:122850","CRANIOACROFACIAL SYNDROME" -"OMIM:614200","BLEEDING DISORDER, PLATELET-TYPE, 9; BDPLT9" -"OMIM:607941","ATRIAL SEPTAL DEFECT 2; ASD2" -"OMIM:131900","EPIDERMOLYSIS BULLOSA SIMPLEX, GENERALIZED" -"OMIM:607944","SPONDYLOENCHONDRODYSPLASIA WITH IMMUNE DYSREGULATION; SPENCDI" -"OMIM:614201","BLEEDING DISORDER, PLATELET-TYPE, 11; BDPLT11" -"OMIM:122750","COXA VARA" -"OMIM:614202","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 15; MRT15" -"OMIM:607948","MYCOBACTERIUM TUBERCULOSIS, SUSCEPTIBILITY TO" -"OMIM:122780","COXOAURICULAR SYNDROME" -"OMIM:614203","PARKINSON DISEASE 17; PARK17" -"OMIM:158300","ARTHROGRYPOSIS, DISTAL, TYPE 7; DA7" -"DOID:0090079","hypogonadotropic hypogonadism 17 with or without anosmia" -"OMIM:607949","MYCOBACTERIUM TUBERCULOSIS, SUSCEPTIBILITY TO, 1" -"OMIM:614204","PSORIASIS 14, PUSTULAR; PSORS14" -"DOID:1875","impotence" -"OMIM:607965","SYSTEMIC LUPUS ERYTHEMATOSUS WITH NEPHRITIS, SUSCEPTIBILITY TO, 1; SLEN1" -"OMIM:158000","MONILETHRIX; MNLIX" -"OMIM:607966","SYSTEMIC LUPUS ERYTHEMATOSUS WITH NEPHRITIS, SUSCEPTIBILITY TO, 2; SLEN2" -"OMIM:158050","MONKEY RED BLOOD CELL RECEPTOR; MRBC" -"OMIM:614205","THREE M SYNDROME 3; 3M3" -"DOID:5690","atypical lipomatous tumor" -"OMIM:131705","TRANSIENT BULLOUS DERMOLYSIS OF THE NEWBORN; TBDN" -"DOID:9072","lethal midline granuloma" -"OMIM:131600","EPIDERMOID CYSTS" -"OMIM:614207","HYPERPHOSPHATASIA WITH MENTAL RETARDATION SYNDROME 3; HPMRS3" -"OMIM:607967","SYSTEMIC LUPUS ERYTHEMATOSUS WITH NEPHRITIS, SUSCEPTIBILITY TO, 3; SLEN3" -"DOID:3012","Li-Fraumeni syndrome" -"OMIM:122880","CRANIOFACIAL-DEAFNESS-HAND SYNDROME; CDHS" -"OMIM:614208","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 16; MRT16" -"OMIM:608013","GAUCHER DISEASE, PERINATAL LETHAL" -"OMIM:158250","NONDISJUNCTION" -"DOID:3282","dendritic cell thymoma" -"OMIM:608022","DIAPHANOSPONDYLODYSOSTOSIS" -"OMIM:614209","MECKEL SYNDROME, TYPE 9; MKS9" -"OMIM:122550","CORTICOSTERONE SIDE-CHAIN ISOMERASE; CSCI" -"OMIM:614210","LUNG CANCER SUSCEPTIBILITY 5; LNCR5" -"OMIM:608026","HYPERTENSIVE NEPHROPATHY; HNP1" -"DOID:127","leiomyoma" -"OMIM:158030","ANTIGEN DEFINED BY MONOCLONAL ANTIBODY AJ9" -"OMIM:614211","DEAFNESS, AUTOSOMAL DOMINANT 33; DFNA33" -"OMIM:608027","PONTOCEREBELLAR HYPOPLASIA, TYPE 3; PCH3" -"OMIM:608028","THAI SYMPHALANGISM SYNDROME" -"OMIM:614212","ENCEPHALOPATHY, ACUTE, INFECTION-INDUCED, SUSCEPTIBILITY TO, 4; IIAE4" -"OMIM:608029","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 6; SCAR6" -"OMIM:614213","NEUROPATHY, HEREDITARY SENSORY, TYPE IIC; HSN2C" -"OMIM:131880","EPIDERMOLYSIS BULLOSA WITH DEFICIENCY OF GALACTOSYLHYDROXYLYSYL GLUCOSYLTRANSFERASE" -"DOID:3281","combined thymoma" -"DOID:2018","hyperinsulinism" -"OMIM:160700","MYOPIA 2, AUTOSOMAL DOMINANT; MYP2" -"OMIM:122860","CRANIODIAPHYSEAL DYSPLASIA, AUTOSOMAL DOMINANT; CDD" -"OMIM:614219","ADAMS-OLIVER SYNDROME 2; AOS2" -"OMIM:608030","AMYOTROPHIC LATERAL SCLEROSIS 6 WITH OR WITHOUT FRONTOTEMPORAL DEMENTIA; ALS6" -"OMIM:608031","AMYOTROPHIC LATERAL SCLEROSIS 7; ALS7" -"OMIM:614220","BILIARY CIRRHOSIS, PRIMARY, 4; PBC4" -"DOID:14228","oligospermia" -"OMIM:608033","ENCEPHALOPATHY, ACUTE, INFECTION-INDUCED, SUSCEPTIBILITY TO, 3; IIAE3" -"OMIM:614221","BILIARY CIRRHOSIS, PRIMARY, 5; PBC5" -"OMIM:614222","WARBURG MICRO SYNDROME 3; WARBM3" -"OMIM:608035","MELANOMA, CUTANEOUS MALIGNANT, SUSCEPTIBILITY TO, 4; CMM4" -"OMIM:157980","MOMO SYNDROME" -"OMIM:158100","MONOPHALANGY OF GREAT TOE" -"OMIM:614223","NARCOLEPSY 6, SUSCEPTIBILITY TO; NRCLP6" -"OMIM:608036","DIABETES MELLITUS, NONINSULIN-DEPENDENT, 4" -"OMIM:608045","REPRESSOR OF TELOMERASE EXPRESSION 1" -"OMIM:614224","RETINAL ARTERIAL MACROANEURYSM WITH SUPRAVALVULAR PULMONIC STENOSIS; RAMSVPS" -"OMIM:160750","MYOSITIS" -"OMIM:608049","AUTISM, SUSCEPTIBILITY TO, 3; AUTS3" -"OMIM:614225","WARBURG MICRO SYNDROME 2; WARBM2" -"DOID:9544","refractory plasma cell neoplasm" -"OMIM:122580","COSTOCORACOID LIGAMENT, CONGENITALLY SHORT" -"DOID:12336","male infertility" -"OMIM:157800","CARDIOSPONDYLOCARPOFACIAL SYNDROME; CSCF" -"OMIM:160800","MYOTONIA CONGENITA, AUTOSOMAL DOMINANT" -"OMIM:614226","HOLOPROSENCEPHALY 11; HPE11" -"OMIM:608051","MACULAR DYSTROPHY, RETINAL, 2; MCDR2" -"DOID:10603","glucose intolerance" -"DOID:2163","nasal cavity disease" -"OMIM:122700","COUMARIN RESISTANCE" -"OMIM:131750","EPIDERMOLYSIS BULLOSA DYSTROPHICA, AUTOSOMAL DOMINANT; DDEB" -"OMIM:608063","BILE AND PANCREATIC DUCTS, COMPLETE ABSENCE OF" -"OMIM:614227","HYPERURICEMIC NEPHROPATHY, FAMILIAL JUVENILE, 3; HNFJ3" -"DOID:3278","encapsulated thymoma" -"OMIM:608068","NEUTROPHILIC DERMATOSIS, ACUTE FEBRILE" -"OMIM:614228","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2O; CMT2O" -"OMIM:122600","SPONDYLOCOSTAL DYSOSTOSIS 5; SCDO5" -"OMIM:131800","EPIDERMOLYSIS BULLOSA SIMPLEX, LOCALIZED" -"OMIM:165720","OSTEOARTHRITIS SUSCEPTIBILITY 1; OS1" -"OMIM:165700","THIEMANN DISEASE" -"DOID:8946","severe nonproliferative diabetic retinopathy" -"OMIM:212140","CARNITINE DEFICIENCY, SYSTEMIC PRIMARY; CDSP" -"OMIM:212160","CARNITINE DEFICIENCY, MYOPATHIC" -"DOID:13208","background diabetic retinopathy" -"DOID:0070015","autosomal recessive dyskeratosis congenita 1" -"OMIM:212200","CARNOSINEMIA" -"DOID:3953","adrenal gland cancer" -"OMIM:212350","SENGERS SYNDROME" -"OMIM:165670","OSSIFIED EAR CARTILAGES" -"OMIM:212360","PALMOPLANTAR KERATODERMA AND CONGENITAL ALOPECIA 2; PPKCA2" -"OMIM:212400","CATARACT AND CONGENITAL ICHTHYOSIS" -"OMIM:166260","GNATHODIAPHYSEAL DYSPLASIA; GDD" -"DOID:0070018","autosomal dominant dyskeratosis congenita 3" -"DOID:9191","diabetic macular edema" -"DOID:9903","meibomian cyst" -"OMIM:212500","CATARACT 46, JUVENILE-ONSET; CTRCT46" -"DOID:13533","osteopetrosis" -"DOID:396","Loeffler endocarditis" -"OMIM:171300","PHEOCHROMOCYTOMA" -"OMIM:212540","CATARACT, MICROCEPHALY, FAILURE TO THRIVE, KYPHOSCOLIOSIS SYNDROME" -"DOID:0070026","Revesz syndrome" -"OMIM:212550","OPTIC DISC ANOMALIES WITH RETINAL AND/OR MACULAR DYSTROPHY; ODRMD" -"OMIM:171420","PHEOCHROMOCYTOMA--ISLET CELL TUMOR SYNDROME" -"DOID:0070025","X-linked dyskeratosis congenita" -"DOID:4947","cholangiocarcinoma" -"OMIM:171400","MULTIPLE ENDOCRINE NEOPLASIA, TYPE IIA; MEN2A" -"OMIM:212710","CATARACT-ATAXIA-DEAFNESS-RETARDATION SYNDROME" -"OMIM:166210","OSTEOGENESIS IMPERFECTA, TYPE II; OI2" -"DOID:13207","proliferative diabetic retinopathy" -"OMIM:212720","MARTSOLF SYNDROME" -"OMIM:212750","CELIAC DISEASE, SUSCEPTIBILITY TO, 1; CELIAC1" -"DOID:13825","squamous blepharitis" -"DOID:8399","trombiculiasis" -"OMIM:166600","OSTEOPETROSIS, AUTOSOMAL DOMINANT 2; OPTA2" -"OMIM:212780","CENANI-LENZ SYNDACTYLY SYNDROME; CLSS" -"OMIM:212790","PREMATURE CENTROMERE DIVISION; PCD" -"OMIM:212800","CEPHALIN LIPIDOSIS" -"OMIM:212835","CEREBELLAR ATAXIA AND ECTODERMAL DYSPLASIA" -"OMIM:166230","OSTEOGENESIS IMPERFECTA WITH OPALESCENT TEETH, BLUE SCLERAE AND WORMIAN BONES, BUT WITHOUT FRACTURES" -"OMIM:166350","OSSEOUS HETEROPLASIA, PROGRESSIVE; POH" -"DOID:11180","non-suppurative otitis media" -"OMIM:212840","GORDON HOLMES SYNDROME; GDHS" -"OMIM:212850","CEREBELLAR ATAXIA AND NEUROSENSORY DEAFNESS" -"OMIM:212890","CEREBELLAR ATAXIA, BENIGN, WITH THERMOANALGESIA" -"OMIM:166300","MULTICENTRIC CARPOTARSAL OSTEOLYSIS SYNDROME; MCTO" -"OMIM:212895","CEREBELLAR ATAXIA, EARLY-ONSET, WITH RETAINED TENDON REFLEXES; EOCA" -"DOID:10852","middle ear cholesterol granuloma" -"OMIM:213000","CEREBELLAR HYPOPLASIA" -"OMIM:213002","CEREBELLAR HYPOPLASIA WITH ENDOSTEAL SCLEROSIS" -"DOID:5015","fibrolamellar carcinoma" -"DOID:0070016","autosomal dominant dyskeratosis congenita 2" -"OMIM:166200","OSTEOGENESIS IMPERFECTA, TYPE I; OI1" -"OMIM:213010","CEREBELLAR VERMIS APLASIA WITH ASSOCIATED FEATURES SUGGESTING SMITH-LEMLI-OPITZ SYNDROME AND MECKEL SYNDROME" -"OMIM:171100","PHAGOCYTOSIS, PLASMA-RELATED DEFECT IN" -"OMIM:213100","CEREBELLOPARENCHYMAL DISORDER II; CPD2" -"DOID:1894","noninfectious dermatoses of eyelid" -"OMIM:165680","OSSICULAR MALFORMATIONS, FAMILIAL" -"OMIM:213200","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 2; SCAR2" -"OMIM:213300","JOUBERT SYNDROME 1; JBTS1" -"DOID:5502","lice infestation" -"OMIM:171200","THIOUREA TASTING" -"OMIM:166450","OSTEOMESOPYKNOSIS" -"OMIM:213400","CEREBELLOPARENCHYMAL DISORDER V; CPD5" -"DOID:13823","parasitic eyelid infestation" -"DOID:2456","blepharoconjunctivitis" -"OMIM:213500","CEREBRAL ANGIOPATHY, DYSPHORIC" -"OMIM:613686","SPONDYLOCOSTAL DYSOSTOSIS 4, AUTOSOMAL RECESSIVE; SCDO4" -"OMIM:617668","ENCEPHALOPATHY, NEONATAL SEVERE, WITH LACTIC ACIDOSIS AND BRAIN ABNORMALITIES; NELABA" -"OMIM:606660","MELANOMA, UVEAL, SUSCEPTIBILITY TO, 1" -"OMIM:613688","LONG QT SYNDROME 2; LQT2" -"OMIM:617669","ENCEPHALOPATHY, PROGRESSIVE, EARLY-ONSET, WITH BRAIN ATROPHY AND SPASTICITY; PEBAS" -"OMIM:606661","MELANOMA, UVEAL, SUSCEPTIBILITY TO, 2" -"DOID:3565","meningioma" -"OMIM:613689","MAMMARY-DIGITAL-NAIL SYNDROME; MDNS" -"OMIM:606662","WAARDENBURG SYNDROME, TYPE 2C; WS2C" -"OMIM:617671","HELIX SYNDROME; HELIX" -"OMIM:606664","GLYCINE N-METHYLTRANSFERASE DEFICIENCY" -"OMIM:617672","NEURODEGENERATION, CHILDHOOD-ONSET, WITH BRAIN ATROPHY; CONDBA" -"DOID:0060248","Simpson-Golabi-Behmel syndrome" -"OMIM:613690","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 7; CMH7" -"OMIM:606668","INFLAMMATORY BOWEL DISEASE 8; IBD8" -"OMIM:613693","LONG QT SYNDROME 6; LQT6" -"OMIM:617675","MYOPATHY, MITOCHONDRIAL, AND ATAXIA; MMYAT" -"OMIM:617681","BLEPHAROCHEILODONTIC SYNDROME 2; BCDS2" -"OMIM:606674","INFLAMMATORY BOWEL DISEASE 6; IBD6" -"OMIM:613694","CARDIOMYOPATHY, DILATED, 1U; CMD1U" -"OMIM:617682","PILAROWSKI-BJORNSSON SYNDROME; PILBOS" -"OMIM:613695","LONG QT SYNDROME 5; LQT5" -"OMIM:606675","INFLAMMATORY BOWEL DISEASE 4; IBD4" -"OMIM:139090","GRAY PLATELET SYNDROME; GPS" -"OMIM:606685","CARDIOMYOPATHY, DILATED, 1L; CMD1L" -"OMIM:613697","CARDIOMYOPATHY, DILATED, 1V; CMD1V" -"OMIM:617686","PITUITARY ADENOMA 3, MULTIPLE TYPES; PITA3" -"DOID:1729","retinal vascular occlusion" -"OMIM:613700","SUPERNUMERARY DER(22)t(8;22) SYNDROME" -"OMIM:139100","GRAYING OF HAIR, PRECOCIOUS" -"OMIM:606688","SPONGIFORM ENCEPHALOPATHY WITH NEUROPSYCHIATRIC FEATURES" -"DOID:0050130","osmotic diarrhea" -"DOID:13328","diabetic cataract" -"OMIM:617690","OVARIAN DYSGENESIS 5; ODG5" -"OMIM:613702","KLIPPEL-FEIL SYNDROME 3, AUTOSOMAL DOMINANT; KFS3" -"OMIM:606689","GLAUCOMA 1, OPEN ANGLE, B; GLC1B" -"OMIM:617691","SPINOCEREBELLAR ATAXIA 44; SCA44" -"DOID:8478","actinomycosis" -"OMIM:617694","AL KAISSI SYNDROME; ALKAS" -"OMIM:613703","MICROPHTHALMIA, ISOLATED, WITH COLOBOMA 6; MCOPCB6" -"DOID:12932","endomyocardial fibrosis" -"OMIM:139000","GRANULOSIS RUBRA NASI" -"DOID:0110230","cataract 34 multiple types" -"OMIM:606690","LYMPHANGIOLEIOMYOMATOSIS; LAM" -"OMIM:613704","MICROPHTHALMIA, ISOLATED 7; MCOP7" -"OMIM:617695","PONTOCEREBELLAR HYPOPLASIA, TYPE 11; PCH11" -"OMIM:606693","KUFOR-RAKEB SYNDROME; KRS" -"DOID:11829","degenerative myopia" -"OMIM:617698","3-METHYLGLUTACONIC ACIDURIA, TYPE IX; MGCA9" -"OMIM:606703","DYSKINESIA, FAMILIAL, WITH FACIAL MYOKYMIA; FDFM" -"DOID:0110251","cataract 15 multiple types" -"OMIM:613705","OROFACIAL CLEFT 10; OFC10" -"DOID:0050458","juvenile myelomonocytic leukemia" -"OMIM:606705","DEAFNESS, AUTOSOMAL DOMINANT 36; DFNA36" -"OMIM:613706","NOONAN SYNDROME 7; NS7" -"OMIM:617706","SPERMATOGENIC FAILURE 22; SPGF22" -"OMIM:613707","LEOPARD SYNDROME 3; LPRD3" -"OMIM:606708","SPLIT-HAND/FOOT MALFORMATION 5; SHFM5" -"OMIM:617707","SPERMATOGENIC FAILURE 23; SPGF23" -"OMIM:139280","GUANYLATE KINASE 2; GUK2" -"OMIM:606711","SPECIFIC LANGUAGE IMPAIRMENT 1; SLI1" -"OMIM:617709","NEURODEVELOPMENTAL DISORDER WITH MICROCEPHALY, ATAXIA, AND SEIZURES; NEDMAS" -"OMIM:613708","NEUROPATHY, HEREDITARY SENSORY, TYPE ID; HSN1D" -"DOID:0110228","cataract 8 multiple types" -"OMIM:606712","SPECIFIC LANGUAGE IMPAIRMENT 2; SLI2" -"OMIM:139210","MYHRE SYNDROME; MYHRS" -"OMIM:613710","THIAMINE METABOLISM DYSFUNCTION SYNDROME 4 (BILATERAL STRIATAL DEGENERATION AND PROGRESSIVE POLYNEUROPATHY TYPE); THMD4" -"OMIM:617710","NEURODEVELOPMENTAL DISORDER, MITOCHONDRIAL, WITH ABNORMAL MOVEMENTS AND LACTIC ACIDOSIS, WITH OR WITHOUT SEIZURES; NEMMLAS" -"OMIM:138930","GRANT SYNDROME" -"OMIM:613711","HIRSCHSPRUNG DISEASE, SUSCEPTIBILITY TO, 3; HSCR3" -"OMIM:606713","VAN DER WOUDE SYNDROME 2; VWS2" -"OMIM:617712","OOCYTE MATURATION DEFECT 3; OOMD3" -"OMIM:613712","HIRSCHSPRUNG DISEASE, SUSCEPTIBILITY TO, 4; HSCR4" -"OMIM:606719","MELANOMA-PANCREATIC CANCER SYNDROME" -"OMIM:617713","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 33; COXPD33" -"DOID:9240","erythromelalgia" -"OMIM:606721","PARTIAL LIPODYSTROPHY, CONGENITAL CATARACTS, AND NEURODEGENERATION SYNDROME; LCCNS" -"OMIM:613717","TREACHER COLLINS SYNDROME 2; TCS2" -"OMIM:617717","AUDITORY NEUROPATHY AND OPTIC ATROPHY; ANOA" -"DOID:12918","thromboangiitis obliterans" -"OMIM:606744","SECKEL SYNDROME 2; SCKL2" -"OMIM:613718","DEAFNESS, AUTOSOMAL RECESSIVE 74; DFNB74" -"OMIM:617719","EPIPHYSEAL DYSPLASIA, MULTIPLE, 7; EDM7" -"DOID:4029","gastritis" -"OMIM:613720","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 7; EIEE7" -"DOID:0060185","Clostridium difficile colitis" -"OMIM:606752","ACUTE HEMORRHAGIC LEUKOENCEPHALITIS" -"OMIM:613721","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 11; EIEE11" -"OMIM:606762","HYPERINSULINEMIC HYPOGLYCEMIA, FAMILIAL, 6; HHF6" -"DOID:0110236","cataract 39 multiple types" -"OMIM:613722","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 12; EIEE12" -"OMIM:606763","CILIARY DYSKINESIA, PRIMARY, 2; CILD2" -"OMIM:606764","GASTROINTESTINAL STROMAL TUMOR; GIST" -"OMIM:613723","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2Q; LGMD2Q" -"OMIM:606766","SPERMATOGENIC FAILURE 3; SPGF3" -"OMIM:613724","LEUKOENCEPHALOPATHY WITH DYSTONIA AND MOTOR NEUROPATHY; LKDMN" -"OMIM:613728","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 10; SCAR10" -"OMIM:606768","MYOPATHY, DISTAL, WITH ANTERIOR TIBIAL ONSET; DMAT" -"DOID:1168","familial hyperlipidemia" -"OMIM:606770","ADIPONECTIN, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS 2; ADIPQTL2" -"OMIM:613729","CHROMOSOME 7q11.23 DELETION SYNDROME, DISTAL, 1.2-MB" -"DOID:1272","telangiectasis" -"OMIM:606771","ADIPONECTIN, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS 3; ADIPQTL3" -"OMIM:613730","HEMORRHAGIC DESTRUCTION OF THE BRAIN, SUBEPENDYMAL CALCIFICATION, AND CATARACTS; HDBSCC" -"OMIM:613731","RETINITIS PIGMENTOSA 4; RP4" -"DOID:326","ischemia" -"OMIM:606772","MENTAL RETARDATION, OBESITY, MANDIBULAR PROGNATHISM, AND EYE AND SKIN ANOMALIES" -"OMIM:606773","HEMIFACIAL MYOHYPERPLASIA; HMH" -"OMIM:613735","BRAIN MALFORMATIONS AND URINARY TRACT DEFECTS; BRMUTD" -"DOID:0060186","chemical colitis" -"OMIM:613736","ACNE INVERSA, FAMILIAL, 2; ACNINV2" -"OMIM:606777","GLUT1 DEFICIENCY SYNDROME 1; GLUT1DS1" -"DOID:10300","Raynaud disease" -"OMIM:613737","ACNE INVERSA, FAMILIAL, 3; ACNINV3" -"OMIM:606785","CRIGLER-NAJJAR SYNDROME, TYPE II" -"OMIM:613743","ADRENAL INSUFFICIENCY, CONGENITAL, WITH 46,XY SEX REVERSAL, PARTIAL OR COMPLETE" -"OMIM:606787","PERIPHERAL ARTERIAL OCCLUSIVE DISEASE 1" -"OMIM:613744","SPASTIC PARAPLEGIA 51, AUTOSOMAL RECESSIVE; SPG51" -"DOID:0110250","cataract 16 multiple types" -"OMIM:606788","ANOREXIA NERVOSA, SUSCEPTIBILITY TO, 1; ANON1" -"DOID:0110268","cataract 22 multiple types" -"OMIM:613750","RETINITIS PIGMENTOSA 27; RP27" -"OMIM:606789","FETAL HEMOGLOBIN QUANTITATIVE TRAIT LOCUS 4; HBFQTL4" -"OMIM:165590","OROFACIODIGITAL SYNDROME X; OFD10" -"OMIM:601346","MARTINEZ-FRIAS SYNDROME" -"OMIM:300062","MENTAL RETARDATION, X-LINKED 14; MRX14" -"DOID:1393","visual pathway disease" -"OMIM:165600","ORBITAL MARGIN, HYPOPLASIA OF" -"OMIM:601347","MYELODYSPLASIA, IMMUNODEFICIENCY, FACIAL DYSMORPHISM, SHORT STATURE, AND PSYCHOMOTOR DELAY" -"OMIM:300064","MENTAL RETARDATION, X-LINKED, WITH CRANIOFACIAL DYSMORPHISM" -"OMIM:165210","ONCOGENE BMYC; BMYC" -"OMIM:300066","DEAFNESS, X-LINKED 4; DFNX4" -"DOID:9368","keratoconjunctivitis" -"OMIM:601348","ECTRODACTYLY OF LOWER LIMBS, CONGENITAL HEART DEFECT, AND MICROGNATHIA" -"OMIM:165550","OPTIC NERVE HYPOPLASIA, BILATERAL" -"OMIM:601349","MICROPHTHALMIA, SYNDROMIC 8; MCOPS8" -"OMIM:300067","LISSENCEPHALY, X-LINKED, 1; LISX1" -"DOID:0050424","familial adenomatous polyposis" -"DOID:11406","choroiditis" -"DOID:4251","conjunctival disease" -"OMIM:137750","GLAUCOMA 1, OPEN ANGLE, A; GLC1A" -"OMIM:300068","ANDROGEN INSENSITIVITY SYNDROME; AIS" -"OMIM:137763","GLAUCOMA AND SLEEP APNEA" -"OMIM:601350","SHORT STATURE SYNDROME, BRUSSELS TYPE" -"DOID:0080079","nonsyndromic congenital nail disorder 1" -"OMIM:165150","OPHTHALMOPLEGIA, PROGRESSIVE, WITH SCROTAL TONGUE AND MENTAL DEFICIENCY" -"OMIM:300071","NIGHT BLINDNESS, CONGENITAL STATIONARY, TYPE 2A; CSNB2A" -"OMIM:601351","GROWTH RETARDATION, DEAFNESS, FEMORAL EPIPHYSEAL DYSPLASIA, AND LACRIMAL DUCT OBSTRUCTION" -"OMIM:300073","FETAL AKINESIA SYNDROME, X-LINKED" -"OMIM:601352","MENTAL RETARDATION, MICROCEPHALY, EPILEPSY, AND COARSE FACE" -"DOID:790","ocular hypotension" -"OMIM:601353","BRACHYCEPHALY, DEAFNESS, CATARACT, MICROSTOMIA, AND MENTAL RETARDATION" -"DOID:2745","narcissistic personality disorder" -"OMIM:300076","IMMUNONEUROLOGIC DISORDER, X-LINKED" -"DOID:13087","Lown-Ganong-Levine syndrome" -"OMIM:601355","MICROCEPHALY, CONGENITAL HEART DISEASE, UNILATERAL RENAL AGENESIS, AND HYPOSEGMENTED LUNGS" -"OMIM:300082","COGNITIVE FUNCTION 1, SOCIAL; CGF1" -"OMIM:165199","OPTIC ATROPHY, HEARING LOSS, AND PERIPHERAL NEUROPATHY, AUTOSOMAL DOMINANT" -"OMIM:300085","CONE-ROD DYSTROPHY, X-LINKED, 2; CORDX2" -"DOID:0060164","pain disorder" -"OMIM:165300","OPTIC ATROPHY 3, AUTOSOMAL DOMINANT; OPA3" -"OMIM:601356","LETHAL SHORT-LIMB SKELETAL DYSPLASIA, AL GAZALI TYPE" -"DOID:1242","globe disease" -"OMIM:601357","BRACHIAL AMELIA, CLEFT LIP, AND HOLOPROSENCEPHALY; ACLH" -"OMIM:300087","X INACTIVATION, FAMILIAL SKEWED, 1; SXI1" -"DOID:334","histrionic personality disorder" -"DOID:0050630","Aland Island eye disease" -"OMIM:300088","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 9; EIEE9" -"OMIM:601358","NICOLAIDES-BARAITSER SYNDROME; NCBRS" -"DOID:238","pupil disease" -"DOID:0060838","isolated microphthalmia 7" -"DOID:9722","ophthalmia nodosa" -"OMIM:601360","AMELIA, AUTOSOMAL RECESSIVE" -"OMIM:300100","ADRENOLEUKODYSTROPHY; ALD" -"OMIM:165290","ONCOGENE RMYC; RMYC" -"OMIM:300106","SPONDYLOEPIMETAPHYSEAL DYSPLASIA, X-LINKED; SEMDX" -"DOID:1094","attention deficit hyperactivity disorder" -"DOID:10141","asthenopia" -"OMIM:601362","DIGEORGE SYNDROME/VELOCARDIOFACIAL SYNDROME COMPLEX 2" -"OMIM:164900","OPHTHALMOMANDIBULOMELIC DYSPLASIA" -"DOID:1509","avoidant personality disorder" -"OMIM:601363","WILMS TUMOR 4; WT4" -"OMIM:300113","X-LINKED B CELL SURFACE ANTIGEN, MOUSE, HOMOLOG-LIKE 1; XLRL" -"OMIM:137900","GLOBULIN ANOMALY INVOLVING BETA (2A)-GLOBULIN" -"DOID:6579","chest wall bone cancer" -"OMIM:137600","ANTERIOR SEGMENT DYSGENESIS 4; ASGD4" -"OMIM:300114","MENTAL RETARDATION, X-LINKED 49; MRX49" -"DOID:0050633","ocular albinism" -"OMIM:601367","STROKE, ISCHEMIC" -"DOID:12215","oligohydramnios" -"OMIM:601369","DEAFNESS, AUTOSOMAL DOMINANT 9; DFNA9" -"OMIM:300115","MENTAL RETARDATION, X-LINKED 50; MRX50" -"OMIM:300123","MENTAL RETARDATION, X-LINKED, WITH PANHYPOPITUITARISM" -"OMIM:601370","HOLOPROSENCEPHALY, SEMILOBAR, WITH CRANIOSYNOSTOSIS" -"OMIM:137700","GLAUCOMA WITH ELEVATED EPISCLERAL VENOUS PRESSURE" -"OMIM:601371","CATARACT, AGE-RELATED NUCLEAR" -"OMIM:300125","MIGRAINE WITH OR WITHOUT AURA, SUSCEPTIBILITY TO, 2" -"DOID:2212","coagulation protein disease" -"OMIM:601372","CHOREA, REMITTING, WITH NYSTAGMUS AND CATARACT" -"OMIM:300129","HEMATOPOIETIC STEM CELL KINETICS, CONTROL OF" -"OMIM:165510","OPTIC ATROPHY WITH NEGATIVE ELECTRORETINOGRAMS" -"OMIM:300136","DIABETES MELLITUS, INSULIN-DEPENDENT, X-LINKED, SUSCEPTIBILITY TO" -"OMIM:601374","APROSENCEPHALY AND CEREBELLAR DYSGENESIS" -"DOID:10031","compensatory emphysema" -"OMIM:137940","HYPOTRICHOSIS-LYMPHEDEMA-TELANGIECTASIA-RENAL DEFECT SYNDROME; HLTRS" -"OMIM:601375","ECTODERMAL DYSPLASIA, HIDROTIC, CHRISTIANSON-FOURIE TYPE" -"OMIM:300143","MENTAL RETARDATION, X-LINKED 21; MRX21" -"OMIM:601376","CHONDRODYSPLASIA, LETHAL, WITH LONG BONE ANGULATION AND MIXED BONE DENSITY" -"OMIM:300147","PROSTATE CANCER, HEREDITARY, X-LINKED 1; HPCX1" -"OMIM:300148","MENTAL RETARDATION, EPILEPTIC SEIZURES, HYPOGONADISM AND HYPOGENITALISM, MICROCEPHALY, AND OBESITY; MEHMO" -"OMIM:601379","HUNTER-MCALPINE CRANIOSYNOSTOSIS SYNDROME" -"OMIM:137800","GLIOMA SUSCEPTIBILITY 1; GLM1" -"OMIM:300155","RETINITIS PIGMENTOSA 24; RP24" -"OMIM:601382","CHARCOT-MARIE-TOOTH DISEASE, TYPE 4B1; CMT4B1" -"OMIM:165200","OPTIC ATROPHY WITH DEMYELINATING DISEASE OF CNS" -"OMIM:165098","OPHTHALMOPLEGIA, FAMILIAL TOTAL, WITH IRIS TRANSILLUMINATION" -"OMIM:300158","ARTHROGRYPOSIS, CONGENITAL, LOWER LIMB, X-LINKED; ACLLX" -"OMIM:601386","DEAFNESS, AUTOSOMAL RECESSIVE 12; DFNB12" -"DOID:10533","viral pneumonia" -"OMIM:165500","OPTIC ATROPHY 1; OPA1" -"DOID:1229","paranoid schizophrenia" -"OMIM:137760","GLAUCOMA, PRIMARY OPEN ANGLE; POAG" -"OMIM:300166","MICROPHTHALMIA, SYNDROMIC 2; MCOPS2" -"OMIM:601388","DIABETES MELLITUS, INSULIN-DEPENDENT, 12; IDDM12" -"OMIM:137920","RENAL CYSTS AND DIABETES SYNDROME; RCAD" -"OMIM:601389","CERVICAL RIBS, SPRENGEL ANOMALY, ANAL ATRESIA, AND URETHRAL OBSTRUCTION" -"OMIM:300179","X INACTIVATION, FAMILIAL SKEWED, 2; SXI2" -"DOID:900","hepatopulmonary syndrome" -"OMIM:300184","HYPOTONIA, CONGENITAL NYSTAGMUS, ATAXIA, AND ABNORMAL AUDITORY BRAINSTEM RESPONSES" -"OMIM:601390","VAN MALDERGEM SYNDROME 1; VMLDS1" -"OMIM:165000","OPHTHALMOPLEGIA, FAMILIAL STATIC" -"DOID:10646","schizotypal personality disorder" -"OMIM:300194","AMME COMPLEX" -"OMIM:601399","PLATELET DISORDER, FAMILIAL, WITH ASSOCIATED MYELOID MALIGNANCY; FPDMM" -"DOID:0090075","hypogonadotropic hypogonadism 15 with or without anosmia" -"OMIM:601407","DIABETES MELLITUS, NONINSULIN-DEPENDENT, 2; NIDDM2" -"OMIM:300200","ADRENAL HYPOPLASIA, CONGENITAL; AHC" -"OMIM:164891","ONCOGENE YUASA" -"OMIM:300209","SIMPSON-GOLABI-BEHMEL SYNDROME, TYPE 2; SGBS2" -"OMIM:601410","DIABETES MELLITUS, TRANSIENT NEONATAL, 1" -"OMIM:601412","DEAFNESS, AUTOSOMAL DOMINANT 7; DFNA7" -"OMIM:300210","MENTAL RETARDATION, X-LINKED 58; MRX58" -"OMIM:300211","EPISODIC MUSCLE WEAKNESS, X-LINKED; EMWX" -"OMIM:601414","RETINITIS PIGMENTOSA 18; RP18" -"DOID:9603","intravascular fasciitis" -"DOID:0050445","X-linked hypophosphatemic rickets" -"OMIM:300215","LISSENCEPHALY, X-LINKED, 2; LISX2" -"OMIM:601419","MYOPATHY, MYOFIBRILLAR, 1; MFM1" -"OMIM:300216","COATS DISEASE" -"OMIM:601420","MICROCEPHALY, CORPUS CALLOSUM DYSGENESIS, AND CLEFT LIP/PALATE" -"DOID:0110438","dilated cardiomyopathy 1JJ" -"DOID:8200","tertiary syphilis" -"OMIM:259450","BRUCK SYNDROME 1; BRKS1" -"OMIM:223400","DUODENAL ATRESIA" -"OMIM:223500","DWARFISM, LOW-BIRTH-WEIGHT TYPE, WITH UNRESPONSIVENESS TO GROWTH HORMONE" -"OMIM:259500","OSTEOGENIC SARCOMA" -"OMIM:223540","DWARFISM, MENTAL RETARDATION, AND EYE ABNORMALITY" -"OMIM:259550","OSTEOID OSTEOMA" -"OMIM:259600","MULTICENTRIC OSTEOLYSIS, NODULOSIS, AND ARTHROPATHY; MONA" -"OMIM:223550","DWARFISM, PROPORTIONATE, WITH HIP DISLOCATION" -"DOID:0110441","dilated cardiomyopathy 2B" -"OMIM:259610","OSTEOLYSIS SYNDROME, RECESSIVE" -"OMIM:223800","DYGGVE-MELCHIOR-CLAUSEN DISEASE; DMC" -"OMIM:223900","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, TYPE III; HSAN3" -"DOID:0110448","dilated cardiomyopathy 1HH" -"OMIM:259650","OSTEOMA OF MIDDLE EAR" -"OMIM:224000","DYSAUTONOMIA-LIKE DISORDER" -"OMIM:259660","OSTEOMALACIA, SCLEROSING, WITH CEREBRAL CALCIFICATION" -"OMIM:224050","CEREBELLAR ATAXIA, MENTAL RETARDATION, AND DYSEQUILIBRIUM SYNDROME 1; CAMRQ1" -"OMIM:259680","CHRONIC RECURRENT MULTIFOCAL OSTEOMYELITIS; CRMO" -"DOID:0110425","dilated cardiomyopathy 1A" -"OMIM:224100","ANEMIA, CONGENITAL DYSERYTHROPOIETIC, TYPE II; CDAN2" -"OMIM:259690","OSTEOPENIA AND SPARSE HAIR" -"DOID:0050268","ophthalmomyiasis" -"DOID:0110434","dilated cardiomyopathy 1Z" -"OMIM:224120","ANEMIA, CONGENITAL DYSERYTHROPOIETIC, TYPE Ia; CDAN1A" -"OMIM:259700","OSTEOPETROSIS, AUTOSOMAL RECESSIVE 1; OPTB1" -"OMIM:259710","OSTEOPETROSIS, AUTOSOMAL RECESSIVE 2; OPTB2" -"DOID:0110433","dilated cardiomyopathy 1E" -"OMIM:224230","DYSKERATOSIS CONGENITA, AUTOSOMAL RECESSIVE 1; DKCB1" -"DOID:9997","peripartum cardiomyopathy" -"OMIM:164310","OCULOPHARYNGODISTAL MYOPATHY; OPDM" -"DOID:3172","papillary adenoma" -"OMIM:259720","OSTEOPETROSIS, AUTOSOMAL RECESSIVE 5; OPTB5" -"OMIM:224250","DYSMYELINATION WITH JAUNDICE" -"OMIM:164300","OCULOPHARYNGEAL MUSCULAR DYSTROPHY; OPMD" -"DOID:0110424","dilated cardiomyopathy 1CC" -"OMIM:259730","OSTEOPETROSIS, AUTOSOMAL RECESSIVE 3; OPTB3" -"OMIM:224300","DYSOSTEOSCLEROSIS" -"OMIM:224400","DYSSEGMENTAL DYSPLASIA, ROLLAND-DESBUQUOIS TYPE" -"DOID:0110460","dilated cardiomyopathy 2A" -"OMIM:259750","OSTEOPOROSIS, JUVENILE" -"DOID:0050428","nonepidermolytic palmoplantar keratoderma" -"DOID:4156","primary syphilis" -"DOID:4838","myoepithelial carcinoma" -"OMIM:259770","OSTEOPOROSIS-PSEUDOGLIOMA SYNDROME; OPPG" -"OMIM:224410","DYSSEGMENTAL DYSPLASIA, SILVERMAN-HANDMAKER TYPE; DDSH" -"OMIM:224500","DYSTONIA 2, TORSION, AUTOSOMAL RECESSIVE; DYT2" -"OMIM:259775","RAINE SYNDROME; RNS" -"OMIM:224550","DYSTONIA WITH RINGBINDEN" -"DOID:0110450","dilated cardiomyopathy 1II" -"OMIM:259780","OTOONYCHOPERONEAL SYNDROME" -"OMIM:259900","HYPEROXALURIA, PRIMARY, TYPE I; HP1" -"OMIM:224690","MEIER-GORLIN SYNDROME 1; MGORS1" -"DOID:0050426","Stevens-Johnson syndrome" -"DOID:8567","Hodgkin's lymphoma" -"OMIM:260000","HYPEROXALURIA, PRIMARY, TYPE II; HP2" -"OMIM:224700","EBSTEIN ANOMALY" -"DOID:1067","open-angle glaucoma" -"DOID:11459","pseudotumor cerebri" -"OMIM:260005","5-OXOPROLINASE DEFICIENCY; OPLAHD" -"OMIM:224750","SCHOPF-SCHULZ-PASSARGE SYNDROME; SSPS" -"OMIM:224800","ECTODERMAL DYSPLASIA AND NEUROSENSORY DEAFNESS" -"OMIM:260100","PA POLYMORPHISM OF ALPHA-2-GLOBULIN" -"DOID:0110456","dilated cardiomyopathy 1R" -"OMIM:180700","ROBINOW SYNDROME, AUTOSOMAL DOMINANT 1; DRS1" -"OMIM:224900","ECTODERMAL DYSPLASIA 10B, HYPOHIDROTIC/HAIR/TOOTH TYPE, AUTOSOMAL RECESSIVE; ECTD10B" -"DOID:0110458","dilated cardiomyopathy 1BB" -"OMIM:260130","PACHYONYCHIA CONGENITA, AUTOSOMAL RECESSIVE" -"DOID:0110432","dilated cardiomyopathy 1NN" -"OMIM:260150","PALANT CLEFT PALATE SYNDROME" -"OMIM:225000","ROSSELLI-GULIENETTI SYNDROME" -"DOID:0110446","dilated cardiomyopathy 1W" -"OMIM:260200","PALLIDAL DEGENERATION, PROGRESSIVE, WITH RETINITIS PIGMENTOSA" -"DOID:0110457","dilated cardiomyopathy 1Y" -"OMIM:225040","ECTODERMAL DYSPLASIA, HYPOHIDROTIC, WITH HYPOTHYROIDISM AND AGENESIS OF THE CORPUS CALLOSUM" -"DOID:139","squamous cell papilloma" -"OMIM:180730","ROMBO SYNDROME" -"DOID:0110451","dilated cardiomyopathy 1O" -"OMIM:260300","PARKINSON DISEASE 15, AUTOSOMAL RECESSIVE EARLY-ONSET; PARK15" -"OMIM:225050","ECTODERMAL DYSPLASIA, HYPOHIDROTIC, WITH HYPOTHYROIDISM AND CILIARY DYSKINESIA" -"DOID:3179","inverted papilloma" -"OMIM:260350","PANCREATIC CANCER" -"DOID:2682","intracystic papillary adenoma" -"OMIM:225060","CLEFT LIP/PALATE-ECTODERMAL DYSPLASIA SYNDROME; CLPED1" -"DOID:10127","cerebral artery occlusion" -"DOID:0110426","dilated cardiomyopathy 1D" -"OMIM:225100","ECTOPIA LENTIS 2, ISOLATED, AUTOSOMAL RECESSIVE; ECTOL2" -"OMIM:260370","PANCREATIC AGENESIS 1; PAGEN1" -"DOID:6712","anterior spinal artery syndrome" -"OMIM:260400","SHWACHMAN-DIAMOND SYNDROME; SDS" -"OMIM:225200","ECTOPIA LENTIS ET PUPILLAE" -"DOID:2127","brain germinoma" -"DOID:0110444","dilated cardiomyopathy 1X" -"DOID:0110442","dilated cardiomyopathy 1Q" -"DOID:0060224","atrial fibrillation" -"OMIM:260450","PANCREATIC INSUFFICIENCY, COMBINED EXOCRINE" -"OMIM:225250","HYPOTHYROIDISM, CONGENITAL, NONGOITROUS, 5; CHNG5" -"OMIM:260470","PANENCEPHALITIS, SUBACUTE SCLEROSING" -"OMIM:225280","ECTODERMAL DYSPLASIA, ECTRODACTYLY, AND MACULAR DYSTROPHY SYNDROME; EEMS" -"DOID:2213","hemorrhagic disease" -"DOID:5408","Paget's disease of bone" -"DOID:0110431","dilated cardiomyopathy 1I" -"OMIM:260480","PANCREATITIS, SCLEROSING CHOLANGITIS, AND SICCA COMPLEX" -"OMIM:225290","ECTRODACTYLY-POLYDACTYLY" -"DOID:0110435","dilated cardiomyopathy 1GG" -"OMIM:225300","SPLIT-HAND/FOOT MALFORMATION 6; SHFM6" -"OMIM:260500","PAPILLOMA OF CHOROID PLEXUS; CPP" -"OMIM:260530","PARANA HARD-SKIN SYNDROME" -"OMIM:225310","EHLERS-DANLOS SYNDROME WITH PLATELET DYSFUNCTION FROM FIBRONECTIN ABNORMALITY" -"DOID:9856","congenital syphilis" -"DOID:0110443","dilated cardiomyopathy 1B" -"OMIM:225320","EHLERS-DANLOS SYNDROME, AUTOSOMAL RECESSIVE, CARDIAC VALVULAR FORM" -"OMIM:260540","PARKINSON-DEMENTIA SYNDROME" -"OMIM:225400","EHLERS-DANLOS SYNDROME, TYPE VI; EDS6" -"DOID:7444","diffuse intraductal papillomatosis" -"OMIM:260555","PARTINGTON-ANDERSON SYNDROME" -"DOID:0110447","dilated cardiomyopathy 1DD" -"DOID:4157","secondary syphilis" -"OMIM:225410","EHLERS-DANLOS SYNDROME, TYPE VII, AUTOSOMAL RECESSIVE" -"OMIM:260565","PEHO SYNDROME; PEHO" -"OMIM:613751","HETEROTAXY, VISCERAL, 4, AUTOSOMAL; HTX4" -"DOID:3709","rectum mucinous adenocarcinoma" -"OMIM:606798","BLEPHAROSPASM, BENIGN ESSENTIAL" -"OMIM:167030","NEPHROLITHIASIS, CALCIUM OXALATE; CAON" -"OMIM:613752","HYPERMETHIONINEMIA WITH S-ADENOSYLHOMOCYSTEINE HYDROLASE DEFICIENCY" -"OMIM:606799","STROKE, SUSCEPTIBILITY TO, 1" -"OMIM:166910","OVALOCYTOSIS, HEREDITARY HEMOLYTIC, WITH DEFECTIVE ERYTHROPOIESIS" -"DOID:2533","splenic infarction" -"OMIM:173500","PLATELET GROUPS--Ko SYSTEM; HPA-2" -"DOID:9402","epididymitis" -"OMIM:606812","FUMARASE DEFICIENCY; FMRD" -"OMIM:613756","RETINITIS PIGMENTOSA 49; RP49" -"OMIM:606824","GLUCOSE/GALACTOSE MALABSORPTION; GGM" -"DOID:0060388","chromosomal deletion syndrome" -"OMIM:613757","MACULAR DEGENERATION, AGE-RELATED, 6; ARMD6" -"DOID:9246","cerebral amyloid angiopathy" -"OMIM:613758","RETINITIS PIGMENTOSA 47; RP47" -"OMIM:606835","DIGITAL ARTHROPATHY-BRACHYDACTYLY, FAMILIAL; FDAB" -"DOID:0060585","Noonan syndrome 7" -"OMIM:613759","INFECTIONS, RECURRENT, WITH ENCEPHALOPATHY, HEPATIC DYSFUNCTION, AND CARDIOVASCULAR MALFORMATIONS" -"OMIM:606840","PARASOMNIA, SLEEP BRUXISM TYPE; PSMNSB" -"DOID:12333","male genital organ stricture" -"OMIM:613761","MACULAR DEGENERATION, AGE-RELATED, 5; ARMD5" -"OMIM:606842","CARDIONEUROMYOPATHY WITH HYALINE MASSES AND NEMALINE RODS" -"OMIM:167000","OVARIAN CANCER" -"DOID:1733","cryptosporidiosis" -"OMIM:613762","46,XY SEX REVERSAL 6; SRXY6" -"OMIM:606843","IMMUNODEFICIENCY WITH HYPER-IgM, TYPE 3; HIGM3" -"OMIM:613763","CATARACT 16, MULTIPLE TYPES; CTRCT16" -"OMIM:606851","CREE MENTAL RETARDATION SYNDROME" -"DOID:47","prostate disease" -"OMIM:613765","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 9; CMH9" -"DOID:0060581","Noonan syndrome 3" -"OMIM:606852","PARKINSON DISEASE 10; PARK10" -"DOID:936","brain disease" -"OMIM:606854","POLYMICROGYRIA, BILATERAL FRONTOPARIETAL; BFPP" -"OMIM:613767","RETINITIS PIGMENTOSA 45; RP45" -"OMIM:606856","PANCREATIC CANCER, SUSCEPTIBILITY TO, 1" -"DOID:0110455","dilated cardiomyopathy 1U" -"OMIM:166990","OSTEOCHONDRODYSPLASIA, RHIZOMELIC, WITH CALLOSAL AGENESIS, THROMBOCYTOPENIA, HYDROCEPHALUS, AND HYPERTENSION" -"OMIM:166970","OVARIAN FIBROMATA" -"OMIM:613769","RETINITIS PIGMENTOSA 44; RP44" -"OMIM:606864","PARAGANGLIOMA AND GASTRIC STROMAL SARCOMA" -"OMIM:613776","CHROMOSOME 17p13.1 DELETION SYNDROME" -"DOID:9120","amyloidosis" -"OMIM:606874","HIRSCHSPRUNG DISEASE, SUSCEPTIBILITY TO, 6; HSCR6" -"OMIM:613778","MACULAR DEGENERATION, AGE-RELATED, 8; ARMD8" -"DOID:1561","cognitive disorder" -"OMIM:166950","TERATOMA, OVARIAN" -"OMIM:166900","OVALOCYTOSIS, SOUTHEAST ASIAN; SAO" -"OMIM:613779","COMPLEMENT COMPONENT 3 DEFICIENCY, AUTOSOMAL RECESSIVE; C3D" -"DOID:1289","neurodegenerative disease" -"DOID:0110427","dilated cardiomyopathy 1V" -"DOID:9912","hydrocele" -"OMIM:606875","HIRSCHSPRUNG DISEASE, SUSCEPTIBILITY TO, 7; HSCR7" -"OMIM:606889","ALZHEIMER DISEASE 4" -"OMIM:613780","AORTIC ANEURYSM, FAMILIAL THORACIC 7; AAT7" -"OMIM:606893","VASCULAR MALFORMATION, PRIMARY INTRAOSSEOUS" -"DOID:3444","scrotum Paget's disease" -"OMIM:613783","COMPLEMENT COMPONENT C1s DEFICIENCY; C1SD" -"OMIM:613784","MACULAR DEGENERATION, AGE-RELATED, 12; ARMD12" -"OMIM:606894","DUODENOJEJUNAL ATRESIA WITH VOLVULUS, ABSENT DORSAL MESENTERY, AND ABSENT SUPERIOR MESENTERIC ARTERY" -"DOID:11204","allergic conjunctivitis" -"OMIM:606895","SYMPHALANGISM, DISTAL, WITH MICRODONTIA, DENTAL PULP STONES, AND NARROWED ZYGOMATIC ARCH" -"DOID:12335","male genital organ vascular disease" -"DOID:4087","testicular pure germ cell tumor" -"DOID:10914","amnestic disorder" -"OMIM:613789","COMPLEMENT COMPONENT 8 DEFICIENCY, TYPE II; C8D2" -"OMIM:613790","COMPLEMENT COMPONENT 8 DEFICIENCY, TYPE I; C8D1" -"OMIM:606896","DYSLEXIA, SUSCEPTIBILITY TO, 5; DYX5" -"OMIM:613791","MASP2 DEFICIENCY" -"OMIM:606928","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 3; BMND3" -"DOID:11997","spermatocele" -"OMIM:606943","USHER SYNDROME, TYPE IG; USH1G" -"DOID:8488","polyhydramnios" -"OMIM:613792","CHROMOSOME 3pter-p25 DELETION SYNDROME" -"OMIM:606952","ALBINISM, OCULOCUTANEOUS, TYPE IB; OCA1B" -"OMIM:613793","BLOOD GROUP, CROMER SYSTEM; CROM" -"DOID:5259","colon leiomyosarcoma" -"DOID:1307","dementia" -"OMIM:606960","INSULINOMA TUMOR SUPPRESSOR GENE LOCUS" -"OMIM:167200","PACHYONYCHIA CONGENITA 1; PC1" -"OMIM:613794","RETINITIS PIGMENTOSA 20; RP20" -"DOID:9365","vesiculitis" -"OMIM:606963","PULMONARY DISEASE, CHRONIC OBSTRUCTIVE; COPD" -"DOID:319","spinal cord disease" -"OMIM:613795","LOEYS-DIETZ SYNDROME 3; LDS3" -"OMIM:606966","NEPHRONOPHTHISIS 4; NPHP4" -"OMIM:613796","IMMUNODEFICIENCY 31B; IMD31B" -"OMIM:606972","EPILEPSY, IDIOPATHIC GENERALIZED, SUSCEPTIBILITY TO, 2; EIG2" -"OMIM:613800","MEIER-GORLIN SYNDROME 2; MGORS2" -"OMIM:613801","RETINITIS PIGMENTOSA 40; RP40" -"OMIM:606984","HYPERRENINEMIC HYPOALDOSTERONISM, FAMILIAL, 2" -"OMIM:167100","HYPERTROPHIC OSTEOARTHROPATHY, PRIMARY, AUTOSOMAL DOMINANT; PHOAD" -"OMIM:613803","MEIER-GORLIN SYNDROME 3; MGORS3" -"DOID:10823","malignant essential hypertension" -"OMIM:606995","SENIOR-LOKEN SYNDROME 3; SLSN3" -"OMIM:606996","SENIOR-LOKEN SYNDROME 4; SLSN4" -"OMIM:613804","MEIER-GORLIN SYNDROME 4; MGORS4" -"OMIM:607004","BRACHYDACTYLY, TYPE A1, B; BDA1B" -"OMIM:613805","MEIER-GORLIN SYNDROME 5; MGORS5" -"DOID:3490","Noonan syndrome" -"DOID:0050949","autosomal recessive hypophosphatemic rickets" -"DOID:0050644","arterial calcification of infancy" -"OMIM:613806","CHOLANGITIS, PRIMARY SCLEROSING; PSC" -"OMIM:607014","HURLER SYNDROME" -"DOID:3520","pediatric fibrosarcoma" -"DOID:2394","ovarian cancer" -"DOID:14265","pulmonary valve insufficiency" -"OMIM:607015","HURLER-SCHEIE SYNDROME" -"OMIM:613807","CILIARY DYSKINESIA, PRIMARY, 14; CILD14" -"DOID:2738","pseudoxanthoma elasticum" -"DOID:11786","splenic sequestration" -"DOID:2988","antiphospholipid syndrome" -"OMIM:613808","CILIARY DYSKINESIA, PRIMARY, 15; CILD15" -"OMIM:607016","SCHEIE SYNDROME" -"OMIM:613809","RETINITIS PIGMENTOSA 39; RP39" -"OMIM:607017","DEAFNESS, AUTOSOMAL DOMINANT 21; DFNA21" -"OMIM:613810","RETINITIS PIGMENTOSA 43; RP43" -"OMIM:270710","Fitzsimmons-Guilbert syndrome" -"OMIM:607039","DEAFNESS, AUTOSOMAL RECESSIVE 22; DFNB22" -"DOID:0110351","osteogenesis imperfecta type 11" -"DOID:0110462","autosomal recessive nonsyndromic deafness 101" -"DOID:0110478","autosomal recessive nonsyndromic deafness 20" -"DOID:0110342","osteogenesis imperfecta type 13" -"DOID:2556","relapsing polychondritis" -"DOID:13135","exophthalmic ophthalmoplegia" -"DOID:0110514","autosomal recessive nonsyndromic deafness 62" -"DOID:0110490","autosomal recessive nonsyndromic deafness 31" -"DOID:0110530","autosomal recessive nonsyndromic deafness 84B" -"OMIM:180020","RETINAL CONE DYSTROPHY 1; RCD1" -"DOID:9955","hypoplastic left heart syndrome" -"DOID:9265","histidine metabolism disease" -"DOID:0050695","malignant pleural solitary fibrous tumor" -"OMIM:172290","PHOSPHOGLYCOPROTEIN 1; PGP1" -"DOID:2780","rectosigmoid junction neoplasm" -"DOID:0110522","autosomal recessive nonsyndromic deafness 71" -"DOID:0110472","autosomal recessive nonsyndromic deafness 17" -"DOID:0060005","autoimmune disease of endocrine system" -"DOID:0110493","autosomal recessive nonsyndromic deafness 35" -"DOID:3602","toxic encephalopathy" -"DOID:0110531","autosomal recessive nonsyndromic deafness 85" -"DOID:5672","large intestine cancer" -"DOID:0090073","hypogonadotropic hypogonadism 13 with or without anosmia" -"DOID:363","uterine cancer" -"DOID:0110337","osteogenesis imperfecta type 7" -"DOID:0110508","autosomal recessive nonsyndromic deafness 51" -"DOID:0110505","autosomal recessive nonsyndromic deafness 48" -"DOID:11427","endosalpingiosis" -"DOID:0050720","ornithine translocase deficiency" -"DOID:0110340","osteogenesis imperfecta type 4" -"DOID:4658","benign mastocytoma" -"DOID:0110656","long QT syndrome 15" -"DOID:0110348","osteogenesis imperfecta type 12" -"DOID:0110486","autosomal recessive nonsyndromic deafness 28" -"DOID:6419","tetralogy of Fallot" -"DOID:0110532","autosomal recessive nonsyndromic deafness 86" -"DOID:0110465","autosomal recessive nonsyndromic deafness 104" -"DOID:0110310","hypertrophic cardiomyopathy 4" -"DOID:10986","discitis" -"DOID:0110467","autosomal recessive nonsyndromic deafness 12" -"DOID:14702","branchiootorenal syndrome" -"DOID:0110343","osteogenesis imperfecta type 14" -"DOID:9256","colorectal cancer" -"DOID:0110481","autosomal recessive nonsyndromic deafness 23" -"DOID:0050915","rectum adenoma" -"DOID:0110336","osteogenesis imperfecta type 8" -"DOID:0110520","autosomal recessive nonsyndromic deafness 7" -"DOID:0110334","osteogenesis imperfecta type 1" -"DOID:0110347","osteogenesis imperfecta type 15" -"DOID:0110479","autosomal recessive nonsyndromic deafness 21" -"DOID:1060","Hartnup disease" -"DOID:13832","patent ductus arteriosus" -"DOID:0110538","autosomal recessive nonsyndromic deafness 96" -"DOID:14021","Tietze's syndrome" -"DOID:955","benign neurilemmoma" -"DOID:0060103","central nervous system primitive neuroectodermal neoplasm" -"DOID:0050861","colorectal adenocarcinoma" -"DOID:0110509","autosomal recessive nonsyndromic deafness 53" -"OMIM:176200","PORPHYRIA VARIEGATA" -"DOID:12689","acoustic neuroma" -"DOID:9565","dextrocardia" -"DOID:0110645","long QT syndrome 2" -"DOID:0110536","autosomal recessive nonsyndromic deafness 91" -"DOID:0110345","osteogenesis imperfecta type 16" -"DOID:0110468","autosomal recessive nonsyndromic deafness 13" -"DOID:1993","rectum cancer" -"DOID:0110502","autosomal recessive nonsyndromic deafness 45" -"DOID:11432","endometriosis of ovary" -"DOID:538","internuclear ophthalmoplegia" -"DOID:956","peripheral nerve schwannoma" -"DOID:3202","neurilemmoma of the fifth cranial nerve" -"DOID:0060770","dextro-looped transposition of the great arteries" -"DOID:5777","rectum neuroendocrine neoplasm" -"DOID:0110350","osteogenesis imperfecta type 6" -"OMIM:246450","3-HYDROXY-3-METHYLGLUTARYL-CoA LYASE DEFICIENCY; HMGCLD" -"OMIM:607044","T-BOX 24" -"OMIM:613811","PONTOCEREBELLAR HYPOPLASIA, TYPE 2D; PCH2D" -"OMIM:134750","FELTY SYNDROME" -"OMIM:607053","HIGH DENSITY LIPOPROTEIN CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 2; HDLCQ2" -"DOID:2133","central nervous system sarcoma" -"OMIM:246470","LEUKEMIA, ACUTE MYELOCYTIC, WITH POLYPOSIS COLI AND COLON CANCER" -"OMIM:613812","BILE ACID SYNTHESIS DEFECT, CONGENITAL, 3; CBAS3" -"OMIM:613818","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (LIMB-GIRDLE), TYPE C, 9; MDDGC9" -"OMIM:246500","LEUKOMELANODERMA, INFANTILISM, MENTAL RETARDATION, HYPODONTIA, HYPOTRICHOSIS" -"OMIM:607060","PARKINSON DISEASE 8, AUTOSOMAL DOMINANT; PARK8" -"OMIM:246550","LICHTENSTEIN SYNDROME" -"OMIM:613819","SHORT-RIB THORACIC DYSPLASIA 4 WITH OR WITHOUT POLYDACTYLY; SRTD4" -"OMIM:607078","EPIPHYSEAL DYSPLASIA, MULTIPLE, 5; EDM5" -"OMIM:607080","46,XY GONADAL DYSGENESIS, PARTIAL, WITH MINIFASCICULAR NEUROPATHY" -"OMIM:613820","NEPHRONOPHTHISIS 12; NPHP12" -"OMIM:246555","LIMB DEFECTS, DISTAL TRANSVERSE, WITH MENTAL RETARDATION AND SPASTICITY" -"OMIM:607084","DEAFNESS, AUTOSOMAL RECESSIVE 31; DFNB31" -"OMIM:246560","SPLIT-HAND/FOOT MALFORMATION 3; SHFM3" -"DOID:0060551","poikiloderma with neutropenia" -"OMIM:613823","SECKEL SYNDROME 5; SCKL5" -"OMIM:613824","NEPHRONOPHTHISIS 9; NPHP9" -"OMIM:607085","MYASTHENIA GRAVIS WITH THYMUS HYPERPLASIA" -"OMIM:134720","FECUNDITY GENE, BOOROOLA, OF SHEEP, HOMOLOG OF" -"OMIM:246570","FIBULAR APLASIA, TIBIAL CAMPOMELIA, AND OLIGOSYNDACTYLY SYNDROME" -"DOID:1526","panniculitis" -"OMIM:607086","AORTIC ANEURYSM, FAMILIAL THORACIC 1; AAT1" -"OMIM:246650","LIPASE DEFICIENCY, COMBINED" -"OMIM:613825","COMPLEMENT COMPONENT 9 DEFICIENCY; C9D" -"OMIM:607087","AORTIC ANEURYSM, FAMILIAL THORACIC 2; AAT2" -"OMIM:246700","CHYLOMICRON RETENTION DISEASE; CMRD" -"OMIM:613826","LEBER CONGENITAL AMAUROSIS 6; LCA6" -"DOID:0060655","autosomal recessive congenital ichthyosis" -"OMIM:246900","DIHYDROLIPOAMIDE DEHYDROGENASE DEFICIENCY; DLDD" -"OMIM:607088","SPINAL MUSCULAR ATROPHY, DISTAL, AUTOSOMAL RECESSIVE, 3; DSMA3" -"OMIM:613827","RETINITIS PIGMENTOSA 48; RP48" -"OMIM:135100","FIBRODYSPLASIA OSSIFICANS PROGRESSIVA; FOP" -"OMIM:607091","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IId; CDG2D" -"OMIM:247100","LIPOID PROTEINOSIS OF URBACH AND WIETHE" -"OMIM:613828","GENERALIZED EPILEPSY WITH FEBRILE SEIZURES PLUS, TYPE 8; GEFSP8" -"DOID:2732","Rothmund-Thomson syndrome" -"DOID:2468","psychotic disorder" -"OMIM:613829","LEBER CONGENITAL AMAUROSIS 7; LCA7" -"OMIM:247150","LIP PRINTS" -"OMIM:607095","ANAUXETIC DYSPLASIA 1; ANXD1" -"DOID:0060762","lethal restrictive dermopathy" -"OMIM:613830","NIGHT BLINDNESS, CONGENITAL STATIONARY, TYPE 1D; CSNB1D" -"OMIM:247200","MILLER-DIEKER LISSENCEPHALY SYNDROME; MDLS" -"OMIM:607101","DEAFNESS, AUTOSOMAL RECESSIVE 30; DFNB30" -"OMIM:135150","BIRT-HOGG-DUBE SYNDROME; BHD" -"OMIM:607107","NASOPHARYNGEAL CARCINOMA" -"DOID:3137","multiple symmetrical lipomatosis" -"OMIM:134780","FEMORAL-FACIAL SYNDROME; FFS" -"OMIM:613834","MULTISYSTEMIC SMOOTH MUSCLE DYSFUNCTION SYNDROME" -"DOID:9098","sebaceous gland disease" -"OMIM:247410","LYMPHEDEMA-HYPOPARATHYROIDISM SYNDROME" -"OMIM:247420","LUTHERAN NULL" -"OMIM:613835","LEBER CONGENITAL AMAUROSIS 8; LCA8" -"OMIM:607115","CINCA SYNDROME; CINCA" -"DOID:3083","chronic obstructive pulmonary disease" -"OMIM:613836","ADIPONECTIN, SERUM LEVEL OF, QUANTITATIVE TRAIT LOCUS 5; ADIPQTL5" -"OMIM:607116","ALZHEIMER DISEASE 8" -"DOID:0110827","Usher syndrome type 2" -"OMIM:134900","FIBRINOLYTIC DEFECT" -"OMIM:247430","LYMPHOBLASTIC TRANSFORMATION, INHIBITION OF" -"OMIM:247440","LYMPHEDEMA, CONGENITAL RECESSIVE" -"OMIM:613837","LEBER CONGENITAL AMAUROSIS 11; LCA11" -"OMIM:134610","FAMILIAL MEDITERRANEAN FEVER, AUTOSOMAL DOMINANT" -"DOID:2731","vesiculobullous skin disease" -"DOID:14448","46 XY gonadal dysgenesis" -"OMIM:607131","AL-GAZALI-BAKALINOVA SYNDROME; AGBK" -"OMIM:613838","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 16; CMH16" -"OMIM:247450","LYMPHOBLASTIC TRANSFORMATION, INTRINSIC DEFECT IN" -"OMIM:607132","LARYNGEAL ATRESIA, ENCEPHALOCELE, AND LIMB DEFORMITIES" -"DOID:0110213","isolated cleft palate" -"OMIM:613839","MEGALOBLASTIC ANEMIA DUE TO DIHYDROFOLATE REDUCTASE DEFICIENCY" -"OMIM:247610","LYMPHOID INTERSTITIAL PNEUMONIA; LIP" -"OMIM:607134","SPECIFIC LANGUAGE IMPAIRMENT 3; SLI3" -"DOID:341","peripheral vascular disease" -"DOID:1383","sweat gland disease" -"OMIM:607135","CREATININE CLEARANCE QUANTITATIVE TRAIT LOCUS" -"OMIM:613843","LEBER CONGENITAL AMAUROSIS 15; LCA15" -"OMIM:247630","LYMPHOID SYSTEM DETERIORATION, PROGRESSIVE" -"DOID:0060472","Kindler syndrome" -"OMIM:607136","SPINOCEREBELLAR ATAXIA 17; SCA17" -"OMIM:247640","LYMPHOBLASTIC LEUKEMIA, ACUTE, WITH LYMPHOMATOUS FEATURES; LALL" -"OMIM:613845","HYPERURICEMIA, PULMONARY HYPERTENSION, RENAL FAILURE, AND ALKALOSIS SYNDROME; HUPRAS" -"DOID:0111089","Fanconi anemia complementation group D1" -"OMIM:247650","LYMPHOKINE DEFICIENCY" -"OMIM:607140","ANGIOID STREAKS" -"DOID:3488","cellulitis" -"OMIM:613848","OSTEOGENESIS IMPERFECTA, TYPE X; OI10" -"OMIM:247800","LYMPHOPENIC HYPERGAMMAGLOBULINEMIA, ANTIBODY DEFICIENCY, AUTOIMMUNE HEMOLYTIC ANEMIA, AND GLOMERULONEPHRITIS" -"OMIM:607143","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ig; CDG1G" -"DOID:13081","hemangioma of subcutaneous tissue" -"OMIM:613849","OSTEOGENESIS IMPERFECTA, TYPE XII; OI12" -"OMIM:613850","INOSINE TRIPHOSPHATASE DEFICIENCY" -"OMIM:247950","LYSINE MALABSORPTION SYNDROME" -"OMIM:607151","MOYAMOYA DISEASE 2; MYMY2" -"DOID:10123","pigmentation disease" -"DOID:0111090","Fanconi anemia complementation group R" -"OMIM:607152","SPASTIC PARAPLEGIA 19, AUTOSOMAL DOMINANT; SPG19" -"OMIM:613852","FUCOSYLTRANSFERASE 6 DEFICIENCY" -"DOID:0111095","Fanconi anemia complementation group A" -"OMIM:247990","MACDERMOT-WINTER SYNDROME" -"DOID:7365","Kimura disease" -"DOID:0050908","myelodysplastic syndrome" -"OMIM:607154","ALLERGIC RHINITIS" -"OMIM:613854","TRANSPOSITION OF THE GREAT ARTERIES, DEXTRO-LOOPED 3; DTGA3" -"OMIM:248000","MACROCEPHALY/MEGALENCEPHALY SYNDROME, AUTOSOMAL RECESSIVE; MGCPH" -"OMIM:248010","MACROEPIPHYSEAL DYSPLASIA WITH OSTEOPOROSIS, WRINKLED SKIN, AND AGED APPEARANCE" -"OMIM:613855","EPISODIC ATAXIA, TYPE 5; EA5" -"OMIM:607155","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (LIMB-GIRDLE), TYPE C, 5; MDDGC5" -"DOID:2733","skin atrophy" -"DOID:0050467","erythrokeratodermia variabilis" -"OMIM:613856","ACHROMATOPSIA 4; ACHM4" -"OMIM:248100","MACROSOMIA ADIPOSA CONGENITA" -"OMIM:607161","MULTIPLE CONGENITAL ANOMALIES SYNDROME WITH CLOVERLEAF SKULL" -"OMIM:607174","MENINGIOMA, FAMILIAL, SUSCEPTIBILITY TO" -"OMIM:248110","MACROSOMIA WITH MICROPHTHALMIA, LETHAL" -"OMIM:613857","OROFACIAL CLEFT 13; OFC13" -"OMIM:613860","FICOLIN 3 DEFICIENCY" -"OMIM:248190","HYPOMAGNESEMIA 5, RENAL, WITH OCULAR INVOLVEMENT; HOMG5" -"OMIM:607196","MICROCEPHALY, AMISH TYPE; MCPHA" -"DOID:0060283","peeling skin syndrome" -"DOID:14131","midline cystocele" -"DOID:0111093","Fanconi anemia complementation group Q" -"OMIM:248200","STARGARDT DISEASE 1; STGD1" -"OMIM:607197","DEAFNESS, AUTOSOMAL RECESSIVE" -"DOID:0050448","hereditary mucosal leukokeratosis" -"OMIM:613861","RETINITIS PIGMENTOSA 59; RP59" -"OMIM:134700","FAVISM, SUSCEPTIBILITY TO" -"DOID:11629","pelvic muscle wasting" -"OMIM:613862","RETINITIS PIGMENTOSA 38; RP38" -"OMIM:607200","THYROID DYSHORMONOGENESIS 6; TDH6" -"DOID:3486","necrobiosis lipoidica" -"OMIM:248250","HYPOMAGNESEMIA 3, RENAL; HOMG3" -"DOID:12369","prolapse of urethra" -"DOID:11315","African histoplasmosis" -"OMIM:613863","GENERALIZED EPILEPSY WITH FEBRILE SEIZURES PLUS, TYPE 7; GEFSP7" -"OMIM:248260","MAGNESIUM, ELEVATED RED CELL" -"OMIM:607202","CELIAC DISEASE, SUSCEPTIBILITY TO, 5; CELIAC5" -"OMIM:607208","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 6; EIEE6" -"OMIM:613865","DEAFNESS, AUTOSOMAL RECESSIVE 61; DFNB61" -"DOID:2320","obstructive lung disease" -"DOID:0111098","Fanconi anemia complementation group B" -"DOID:2457","giant papillary conjunctivitis" -"OMIM:248300","MAL DE MELEDA; MDM" -"DOID:0111084","Fanconi anemia complementation group E" -"OMIM:613869","MYOPATHY, MYOFIBRILLAR, FATAL INFANTILE HYPERTONIC, ALPHA-B CRYSTALLIN-RELATED" -"OMIM:607214","ANONYCHIA, TOTAL, WITH MICROCEPHALY" -"OMIM:248310","PLASMODIUM FALCIPARUM BLOOD INFECTION LEVEL" -"DOID:2053","reactive cutaneous fibrous lesion" -"DOID:10718","giardiasis" -"OMIM:248340","3MC SYNDROME 3; 3MC3" -"OMIM:607221","EPILEPSY, PARTIAL, WITH PERICENTRAL SPIKES; PEPS" -"OMIM:613870","HIRSCHSPRUNG DISEASE, CARDIAC DEFECTS, AND AUTONOMIC DYSFUNCTION; HCAD" -"DOID:3140","scleredema adultorum" -"DOID:1283","enterocele" -"OMIM:144755","HYPEROSTOSIS CRANIALIS INTERNA" -"DOID:4292","morpheaform basal cell carcinoma" -"OMIM:123100","CRANIOSYNOSTOSIS 1; CRS1" -"OMIM:145200","HYPERPIGMENTATION OF FULDAUER AND KUIJPERS" -"OMIM:123000","CRANIOMETAPHYSEAL DYSPLASIA, AUTOSOMAL DOMINANT; CMDD" -"OMIM:145001","HYPERPARATHYROIDISM 2 WITH JAW TUMORS; HRPT2" -"OMIM:123320","CREATINE PHOSPHOKINASE, ELEVATED SERUM" -"DOID:3457","invasive lobular carcinoma" -"DOID:4512","conventional angiosarcoma" -"OMIM:155350","MEGALENCEPHALY, AUTOSOMAL DOMINANT" -"OMIM:123150","JACKSON-WEISS SYNDROME; JWS" -"OMIM:123155","HYDROCEPHALUS, AUTOSOMAL DOMINANT; HDCPH1" -"OMIM:172150","6-PHOSPHOGLUCONOLACTONASE DEFICIENCY" -"OMIM:155200","MEDIOSTERNAL DEPIGMENTATION LINE" -"OMIM:172110","PHOSPHOGLUCOMUTASE 4" -"OMIM:155150","MEDIAN-ULNAR NERVE COMMUNICATIONS" -"OMIM:122900","CRANIOFACIAL DYSOSTOSIS WITH DIAPHYSEAL HYPERPLASIA" -"DOID:7214","noninvasive malignant thymoma" -"OMIM:145100","HYPERPIGMENTATION OF EYELIDS" -"OMIM:144800","HYPEROSTOSIS FRONTALIS INTERNA" -"DOID:178","vascular disease" -"DOID:0060001","withdrawal disorder" -"OMIM:155145","CLEFT, MEDIAN, OF UPPER LIP WITH POLYPS OF FACIAL SKIN AND NASAL MUCOSA" -"OMIM:123050","CRANIORHINY" -"OMIM:155255","MEDULLOBLASTOMA; MDB" -"DOID:4294","adenoid basal cell carcinoma" -"OMIM:183020","SPINAL MUSCULAR ATROPHY, SEGMENTAL" -"OMIM:123270","CREATINE KINASE, BRAIN TYPE, ECTOPIC EXPRESSION OF; CKBE" -"OMIM:145000","HYPERPARATHYROIDISM 1; HRPT1" -"OMIM:155310","VISCERAL MYOPATHY; VSCM" -"OMIM:123400","CREUTZFELDT-JAKOB DISEASE; CJD" -"OMIM:155140","MECKEL DIVERTICULUM" -"OMIM:145270","HYPERPROGLUCAGONEMIA" -"OMIM:145250","HYPERPIGMENTATION WITH OR WITHOUT HYPOPIGMENTATION, FAMILIAL PROGRESSIVE; FPHH" -"OMIM:155240","THYROID CARCINOMA, FAMILIAL MEDULLARY; MTC" -"OMIM:145260","PSEUDOHYPOALDOSTERONISM, TYPE IIA; PHA2A" -"DOID:318","progressive muscular atrophy" -"DOID:0110233","cataract 27" -"DOID:0070022","autosomal recessive dyskeratosis congenita 5" -"OMIM:266150","PYRUVATE CARBOXYLASE DEFICIENCY" -"DOID:0110260","cataract 7" -"OMIM:266200","PYRUVATE KINASE DEFICIENCY OF RED CELLS" -"OMIM:266250","RADICULONEUROPATHY, FATAL NEONATAL" -"OMIM:183400","SPLIT LOWER LIP" -"OMIM:160120","EPISODIC ATAXIA, TYPE 1; EA1" -"DOID:13822","tetanic cataract" -"OMIM:266255","RADIOULNAR SYNOSTOSIS, UNILATERAL, WITH DEVELOPMENTAL RETARDATION AND HYPOTONIA" -"DOID:974","upper respiratory tract disease" -"OMIM:159595","MYELOPROLIFERATIVE SYNDROME, TRANSIENT" -"OMIM:266265","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIc; CDG2C" -"DOID:0110311","hypertrophic cardiomyopathy 21" -"DOID:82","myotonic cataract" -"OMIM:266270","RAMON SYNDROME" -"DOID:0110231","cataract 1 multiple types" -"DOID:2626","choroid plexus papilloma" -"DOID:3407","carotid artery disease" -"DOID:862","diplegia of upper limb" -"OMIM:159600","MYOCLONIC EPILEPSY, HARTUNG TYPE" -"OMIM:159800","MYOCLONUS, CEREBELLAR ATAXIA, AND DEAFNESS" -"OMIM:266280","RAPADILINO SYNDROME" -"DOID:0110257","cataract 24" -"OMIM:266300","SKIN/HAIR/EYE PIGMENTATION, VARIATION IN, 2; SHEP2" -"DOID:0110266","cataract 9 multiple types" -"DOID:14202","adult dermatomyositis" -"DOID:0110249","cataract 11 multiple types" -"OMIM:266350","RED SKIN PIGMENT ANOMALY OF NEW GUINEA" -"DOID:12206","dengue hemorrhagic fever" -"DOID:0110258","cataract 10 multiple types" -"OMIM:160500","MYOPATHY, DISTAL, 1; MPD1" -"OMIM:266400","REESE RETINAL DYSPLASIA" -"OMIM:183802","SPLIT-HAND WITH OBSTRUCTIVE UROPATHY, SPINA BIFIDA, AND DIAPHRAGMATIC DEFECTS" -"DOID:0110247","cataract 36" -"OMIM:266500","REFSUM DISEASE, CLASSIC" -"OMIM:266510","PEROXISOME BIOGENESIS DISORDER 3B; PBD3B" -"OMIM:266600","INFLAMMATORY BOWEL DISEASE (CROHN DISEASE) 1; IBD1" -"DOID:0110271","cataract 23" -"OMIM:266810","RENAL AND MULLERIAN DUCT HYPOPLASIA" -"DOID:0090086","hypogonadotropic hypogonadism 6 with or without anosmia" -"DOID:4976","elephantiasis" -"OMIM:266900","SENIOR-LOKEN SYNDROME 1; SLSN1" -"DOID:11624","penile neoplasm" -"DOID:0090078","hypogonadotropic hypogonadism 7 with or without anosmia" -"OMIM:266910","RENAL DYSPLASIA-LIMB DEFECTS SYNDROME" -"DOID:0110237","cataract 42" -"OMIM:183600","SPLIT-HAND/FOOT MALFORMATION 1; SHFM1" -"DOID:0110270","cataract 17 multiple types" -"OMIM:266920","SHORT-RIB THORACIC DYSPLASIA 9 WITH OR WITHOUT POLYDACTYLY; SRTD9" -"OMIM:183700","SPLIT-FOOT DEFORMITY WITH MANDIBULOFACIAL DYSOSTOSIS" -"OMIM:267000","PERLMAN SYNDROME; PRLMNS" -"OMIM:267010","MECKEL SYNDROME, TYPE 7; MKS7" -"DOID:10481","diaphragm disease" -"DOID:3620","central nervous system cancer" -"DOID:0110234","cataract 4 multiple types" -"DOID:1352","paranasal sinus disease" -"OMIM:267200","RENAL TUBULAR ACIDOSIS III" -"OMIM:183300","SPLENOGONADAL FUSION WITH LIMB DEFECTS AND MICROGNATHIA" -"OMIM:267300","RENAL TUBULAR ACIDOSIS, DISTAL, WITH PROGRESSIVE NERVE DEAFNESS" -"DOID:0110227","cataract 32 multiple types" -"DOID:0110242","cataract 13 with adult i phenotype" -"OMIM:267400","RENAL, GENITAL, AND MIDDLE EAR ANOMALIES" -"OMIM:160010","MYOGLOBINURIA, AUTOSOMAL DOMINANT" -"DOID:0110253","cataract 14 multiple types" -"OMIM:267430","RENAL TUBULAR DYSGENESIS; RTD" -"DOID:1222","cartilage disease" -"OMIM:267450","RESPIRATORY DISTRESS SYNDROME IN PREMATURE INFANTS" -"OMIM:183086","SPINOCEREBELLAR ATAXIA 6; SCA6" -"OMIM:160150","MYOPATHY, CENTRONUCLEAR, 1; CNM1" -"OMIM:267480","RESPIRATORY UNDERRESPONSIVENESS TO HYPOXIA AND HYPERCAPNIA" -"DOID:0110255","cataract 5 multiple types" -"OMIM:267500","RETICULAR DYSGENESIS" -"DOID:0110272","cataract 40" -"OMIM:267700","HEMOPHAGOCYTIC LYMPHOHISTIOCYTOSIS, FAMILIAL, 1; FHL1" -"OMIM:159900","DYSTONIA 11, MYOCLONIC; DYT11" -"OMIM:267730","RETICULUM CELL SARCOMA" -"OMIM:159950","SPINAL MUSCULAR ATROPHY WITH PROGRESSIVE MYOCLONIC EPILEPSY; SMAPME" -"DOID:10011","thyroid lymphoma" -"OMIM:183090","SPINOCEREBELLAR ATAXIA 2; SCA2" -"OMIM:267740","RETINAL DEGENERATION AND EPILEPSY" -"OMIM:267750","KNOBLOCH SYNDROME 1; KNO1" -"OMIM:183840","SPONDYLOARTHROPATHY, SUSCEPTIBILITY TO, 2; SPDA2" -"OMIM:183500","SPLIT-HAND AND SPLIT-FOOT WITH HYPODONTIA" -"OMIM:267760","RETINAL DEGENERATION WITH NANOPHTHALMOS, CYSTIC MACULAR DEGENERATION, AND ANGLE CLOSURE GLAUCOMA" -"OMIM:160300","MYOPATHY, DISTAL, INFANTILE-ONSET" -"DOID:0110235","cataract 2 multiple types" -"DOID:731","urinary system benign neoplasm" -"DOID:0110229","cataract 6 multiple types" -"OMIM:183849","SPONDYLOEPIMETAPHYSEAL DYSPLASIA WITH HYPOTRICHOSIS" -"OMIM:267800","RETINAL DYSTROPHY, RETICULAR PIGMENTARY, OF POSTERIOR POLE" -"OMIM:183800","SPLIT-HAND WITH CONGENITAL NYSTAGMUS, FUNDAL CHANGES, AND CATARACTS" -"OMIM:183100","SPINOCEREBELLAR ATROPHY WITH PUPILLARY PARALYSIS" -"OMIM:267900","RETINAL TELANGIECTASIA AND HYPOGAMMAGLOBULINEMIA" -"DOID:0110238","cataract 18" -"DOID:9669","senile cataract" -"OMIM:268000","RETINITIS PIGMENTOSA; RP" -"OMIM:159700","MYOCLONUS AND ATAXIA" -"DOID:3213","demyelinating disease" -"OMIM:268010","RETINITIS PIGMENTOSA INVERSA WITH DEAFNESS" -"DOID:5648","choroid plexus carcinoma" -"OMIM:183350","SPLENOMEGALY SYNDROME WITH SPLENIC GERMINAL CENTER HYPOPLASIA AND REDUCED CIRCULATING T HELPER CELLS" -"OMIM:268020","RETINITIS PIGMENTOSA, DEAFNESS, MENTAL RETARDATION, AND HYPOGONADISM" -"DOID:2340","craniosynostosis" -"OMIM:607225","SPASTIC PARALYSIS, INFANTILE-ONSET ASCENDING; IAHSP" -"OMIM:613873","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 17; CMH17" -"OMIM:113670","HYPERTROPHY OF THE BREAST, JUVENILE; JHB" -"DOID:0090056","dystonia 12" -"OMIM:607236","HYPOPREBETALIPOPROTEINEMIA, ACANTHOCYTOSIS, RETINITIS PIGMENTOSA, AND PALLIDAL DEGENERATION" -"OMIM:613874","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 18; CMH18" -"DOID:5679","retinal disease" -"OMIM:607239","DEAFNESS, AUTOSOMAL RECESSIVE 33; DFNB33" -"OMIM:613875","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 19; CMH19" -"DOID:11330","erysipelas" -"OMIM:607248","GLIOMA SUSCEPTIBILITY 4; GLM4" -"OMIM:613876","CARDIOMYOPATHY, FAMILIAL HYPERTROPHIC, 20; CMH20" -"DOID:0050837","multifocal dystonia" -"DOID:0090033","myoclonic dystonia" -"OMIM:613877","LIPODYSTROPHY, FAMILIAL PARTIAL, TYPE 4; FPLD4" -"OMIM:607250","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE, WITH AXONAL NEUROPATHY; SCAN1" -"DOID:0060319","cardiac arrest" -"OMIM:113700","BREASTS AND/OR NIPPLES, APLASIA OR HYPOPLASIA OF, 1; BNAH1" -"DOID:0050835","generalized dystonia" -"OMIM:607258","HYPERCALCIURIA, ABSORPTIVE, 1" -"OMIM:143880","HYPERCALCEMIA, INFANTILE, 1; HCINF1" -"OMIM:613881","CARDIOMYOPATHY, DILATED, 1HH; CMD1HH" -"OMIM:613882","HYPOMAGNESEMIA 6, RENAL; HOMG6" -"OMIM:607259","SPASTIC PARAPLEGIA 7, AUTOSOMAL RECESSIVE; SPG7" -"OMIM:607271","CASPASE 8 DEFICIENCY" -"DOID:0090047","paroxysmal nonkinesigenic dyskinesia 2" -"OMIM:613884","CHROMOSOME 13q14 DELETION SYNDROME" -"OMIM:607276","RESTING HEART RATE, VARIATION IN" -"OMIM:613885","MECKEL SYNDROME, TYPE 8; MKS8" -"DOID:0090049","paroxysmal nonkinesigenic dyskinesia 1" -"DOID:5772","central nervous system hematologic cancer" -"DOID:12986","leukostasis" -"OMIM:607277","ASTHMA-RELATED TRAITS, SUSCEPTIBILITY TO, 1" -"DOID:9406","hypopituitarism" -"OMIM:613886","OBESITY, HYPERPHAGIA, AND DEVELOPMENTAL DELAY; OBHD" -"DOID:2349","arteriosclerosis" -"DOID:4293","clear cell basal cell carcinoma" -"OMIM:607278","OSTEOFIBROUS DYSPLASIA, SUSCEPTIBILITY TO; OSFD" -"DOID:9563","bronchiectasis" -"OMIM:613887","CATARACT 36; CTRCT36" -"OMIM:182280","SMALL CELL CANCER OF THE LUNG" -"DOID:1858","McCune Albright syndrome" -"OMIM:607279","SYSTEMIC LUPUS ERYTHEMATOSUS WITH HEMOLYTIC ANEMIA, SUSCEPTIBILITY TO, 1; SLEH1" -"OMIM:613908","SPINOCEREBELLAR ATAXIA 35; SCA35" -"OMIM:613909","SPINOCEREBELLAR ATAXIA 32; SCA32" -"OMIM:607304","CATARACT 27; CTRCT27" -"OMIM:607308","MAMMOGRAPHIC DENSITY" -"DOID:11885","ureteral benign neoplasm" -"OMIM:613912","COMPLEMENT FACTOR D DEFICIENCY; CFDD" -"OMIM:607313","GAZE PALSY, FAMILIAL HORIZONTAL, WITH PROGRESSIVE SCOLIOSIS, 1; HGPPS1" -"OMIM:613913","LIPODYSTROPHY, PARTIAL, ACQUIRED, WITH LOW COMPLEMENT COMPONENT C3, WITH OR WITHOUT GLOMERULONEPHRITIS; APLDC3" -"OMIM:613916","DEAFNESS, AUTOSOMAL RECESSIVE 89; DFNB89" -"OMIM:607317","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 4; SCAR4" -"DOID:0090045","childhood onset GLUT1 deficiency syndrome 2" -"OMIM:613925","MEGALENCEPHALIC LEUKOENCEPHALOPATHY WITH SUBCORTICAL CYSTS 2A; MLC2A" -"OMIM:607323","DUANE-RADIAL RAY SYNDROME; DRRS" -"DOID:0090046","dystonia 21" -"OMIM:607324","POLYDACTYLY, POSTAXIAL, TYPE A3; PAPA3" -"OMIM:613926","MEGALENCEPHALIC LEUKOENCEPHALOPATHY WITH SUBCORTICAL CYSTS 2B, REMITTING, WITH OR WITHOUT MENTAL RETARDATION; MLC2B" -"DOID:3159","photosensitivity disease" -"OMIM:607326","SMITH-MCCORT DYSPLASIA 1; SMC1" -"OMIM:613930","ALOPECIA-MENTAL RETARDATION SYNDROME 3; APMR3" -"OMIM:607329","HYPERTENSION, ESSENTIAL, SUSCEPTIBILITY TO, 3" -"DOID:865","vasculitis" -"DOID:10808","gastric ulcer" -"OMIM:613933","ACETYL-CoA CARBOXYLASE DEFICIENCY; ACACAD" -"OMIM:607330","LATHOSTEROLOSIS" -"OMIM:613938","PARASOMNIA, SLEEPWALKING TYPE; PSMNSW" -"DOID:9993","hypoglycemia" -"OMIM:607339","CORONARY HEART DISEASE, SUSCEPTIBILITY TO, 1" -"OMIM:613943","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 8; ARCI8" -"OMIM:113477","BRACHYMORPHISM-ONYCHODYSPLASIA-DYSPHALANGISM SYNDROME" -"DOID:2590","familial nephrotic syndrome" -"OMIM:613944","IgA NEPHROPATHY, SUSCEPTIBILITY TO, 2; IGAN2" -"OMIM:607341","FOCAL CORTICAL DYSPLASIA, TYPE II; FCORD2" -"DOID:10320","asbestosis" -"OMIM:607346","SPINOCEREBELLAR ATAXIA 19; SCA19" -"DOID:0090038","torsion dystonia 2" -"OMIM:613949","OKT4 EPITOPE DEFICIENCY" -"OMIM:613950","SCHIZOPHRENIA 15; SCZD15" -"OMIM:113650","BRANCHIOOTORENAL SYNDROME 1; BOR1" -"OMIM:607354","SCOLIOSIS, ISOLATED, SUSCEPTIBILITY TO, 2; IS2" -"DOID:11491","acquired night blindness" -"OMIM:607361","MECKEL SYNDROME, TYPE 3; MKS3" -"OMIM:613951","FANCONI ANEMIA, COMPLEMENTATION GROUP P; FANCP" -"OMIM:113500","BRACHYOLMIA TYPE 3; BCYM3" -"DOID:767","muscular atrophy" -"DOID:0050836","focal dystonia" -"DOID:0090037","torsion dystonia 13" -"OMIM:607364","BARTTER SYNDROME, TYPE 3; BARTS3" -"DOID:264","hemangiopericytoma" -"OMIM:109160","AZOTEMIA, FAMILIAL" -"DOID:2914","immune system disease" -"DOID:12679","nephrocalcinosis" -"OMIM:109180","BABOON M7 VIRUS INTEGRATION SITE; BEVI" -"OMIM:102400","ACROOSTEOLYSIS" -"DOID:12386","balantidiasis" -"OMIM:109200","ALOPECIA, ANDROGENETIC, 1; AGA1" -"DOID:4455","hereditary renal cell carcinoma" -"DOID:4677","keratitis" -"DOID:3733","theileriasis" -"OMIM:102650","ADACTYLIA, UNILATERAL" -"DOID:10428","stable condition keratoconus" -"DOID:13226","oculoglandular tularemia" -"OMIM:109400","BASAL CELL NEVUS SYNDROME; BCNS" -"DOID:5805","subvalvular aortic stenosis" -"DOID:1947","trichomoniasis" -"DOID:9245","Alagille syndrome" -"DOID:946","dientamoebiasis" -"DOID:5128","deep leiomyoma" -"DOID:4450","renal cell carcinoma" -"DOID:4844","benign ependymoma" -"DOID:0050811","congenital adrenal hyperplasia" -"DOID:3946","pituitary-dependent Cushing's disease" -"DOID:2113","coccidiosis" -"OMIM:102520","ACRORENAL SYNDROME" -"DOID:8534","gastroesophageal reflux disease" -"DOID:2843","long QT syndrome" -"DOID:11503","diabetic autonomic neuropathy" -"DOID:0060157","diffuse alopecia areata" -"DOID:77","gastrointestinal system disease" -"DOID:1679","cystitis" -"DOID:3312","bipolar disorder" -"DOID:2530","splenic abscess" -"OMIM:109300","BANKI SYNDROME" -"DOID:0110430","dilated cardiomyopathy 1G" -"DOID:0110439","dilated cardiomyopathy 1P" -"DOID:12556","acute kidney tubular necrosis" -"DOID:0060275","pontocerebellar hypoplasia type 6" -"DOID:11257","social phobia" -"OMIM:102350","ACROMIAL DIMPLES" -"OMIM:109350","GASTROESOPHAGEAL REFLUX; GER" -"DOID:918","liver inflammatory pseudotumor" -"DOID:0060561","DMD-related dilated cardiomyopathy" -"OMIM:102370","ACROMICRIC DYSPLASIA; ACMICD" -"DOID:5614","eye disease" -"DOID:0080036","SOST-related sclerosing bone dysplasia" -"DOID:0050242","primary amebic meningoencephalitis" -"OMIM:102660","ADAMANTINOMA OF LONG BONES" -"DOID:0060262","gallbladder disease" -"DOID:5016","hepatocellular clear cell carcinoma" -"DOID:2326","gastroenteritis" -"OMIM:102500","HAJDU-CHENEY SYNDROME; HJCYS" -"OMIM:102510","ACROPECTOROVERTEBRAL DYSPLASIA; ACRPV" -"OMIM:109500","BASILAR IMPRESSION, PRIMARY" -"DOID:11990","ulceroglandular tularemia" -"DOID:9643","babesiosis" -"DOID:0110453","dilated cardiomyopathy 1EE" -"DOID:11984","hypertrophic cardiomyopathy" -"DOID:76","stomach disease" -"OMIM:109540","B-CELL GROWTH FACTOR; BCGF" -"DOID:2150","ovarian lymphoma" -"DOID:2531","hematologic cancer" -"DOID:0080171","esophageal atresia/tracheoesophageal fistula" -"DOID:1924","hypogonadism" -"DOID:0110459","dilated cardiomyopathy 1FF" -"DOID:7127","radiation cystitis" -"OMIM:102590","ACYLASE, COBALT-ACTIVATED" -"OMIM:109150","MACHADO-JOSEPH DISEASE; MJD" -"DOID:13148","acute cystitis" -"DOID:0110428","dilated cardiomyopathy 1AA" -"DOID:12252","Cushing's syndrome" -"DOID:0060901","Waldenstroem's macroglobulinemia" -"DOID:0050425","restless legs syndrome" -"DOID:0110461","dilated cardiomyopathy 3B" -"DOID:13884","sick sinus syndrome" -"OMIM:102530","SPERMATOGENIC FAILURE 6; SPGF6" -"DOID:0110436","dilated cardiomyopathy 1L" -"DOID:13548","secondary Parkinson disease" -"DOID:10536","malignant gastric granular cell tumor" -"DOID:535","sleep disorder" -"DOID:9181","amebiasis" -"DOID:0050246","granulomatous amebic encephalitis" -"DOID:2999","granulosa cell tumor" -"DOID:4521","cervix endometrial stromal tumor" -"DOID:2670","transitional papilloma" -"DOID:9976","heroin dependence" -"OMIM:605805","DERMATITIS, ATOPIC, 4; ATOD4" -"DOID:683","motor neuritis" -"DOID:2862","glucosephosphate dehydrogenase deficiency" -"OMIM:605808","BIRDSHOT CHORIORETINOPATHY" -"OMIM:605809","MYASTHENIC SYNDROME, CONGENITAL, 4A, SLOW-CHANNEL; CMS4A" -"OMIM:175690","POLYSYNDACTYLY, CROSSED" -"OMIM:605814","CITRULLINEMIA, TYPE II, NEONATAL-ONSET" -"DOID:10324","anthracosilicosis" -"OMIM:605818","DEAFNESS, AUTOSOMAL RECESSIVE 27; DFNB27" -"OMIM:605820","NONAKA MYOPATHY; NM" -"OMIM:177000","PROTOPORPHYRIA, ERYTHROPOIETIC; EPP" -"OMIM:605822","SPONDYLOOCULAR SYNDROME; SOS" -"OMIM:605827","BASALOID FOLLICULAR HAMARTOMA SYNDROME, GENERALIZED, AUTOSOMAL DOMINANT; GBFHS" -"OMIM:605833","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 2; BMND2" -"DOID:3389","Papillon-Lefevre disease" -"OMIM:605838","BABY RATTLE PELVIS DYSPLASIA" -"DOID:3136","scalp dermatosis" -"OMIM:605841","NARCOLEPSY 2, SUSCEPTIBILITY TO; NRCLP2" -"DOID:0060280","primary pigmented nodular adrenocortical disease" -"DOID:4702","mongolian spot" -"OMIM:605844","DERMATITIS, ATOPIC, 5; ATOD5" -"OMIM:605845","DERMATITIS, ATOPIC, 6; ATOD6" -"DOID:0111067","congenital bile acid synthesis defect 6" -"DOID:0111068","congenital bile acid synthesis defect 4" -"OMIM:605850","DIMETHYLGLYCINE DEHYDROGENASE DEFICIENCY; DMGDHD" -"OMIM:605856","SHORT STATURE, MENTAL RETARDATION, CALLOSAL AGENESIS, HEMINASAL HYPOPLASIA, MICROPHTHALMIA, AND ATYPICAL CLEFTING" -"DOID:4603","epidermolytic hyperkeratosis" -"OMIM:605899","GLYCINE ENCEPHALOPATHY; GCE" -"DOID:230","lateral sclerosis" -"OMIM:605909","PARKINSON DISEASE 6, AUTOSOMAL RECESSIVE EARLY-ONSET; PARK6" -"OMIM:605911","3-HYDROXY-3-METHYLGLUTARYL-CoA SYNTHASE-2 DEFICIENCY; HMGCS2D" -"OMIM:605913","BLEEDING DISORDER, EAST TEXAS TYPE" -"OMIM:605934","HOLOPROSENCEPHALY 6; HPE6" -"OMIM:605935","ARTHROPATHY, EROSIVE" -"OMIM:605944","LIVER FIBROCYSTIC DISEASE AND POLYDACTYLY" -"DOID:8881","rosacea" -"OMIM:605945","CRUMPLED HELICES AND SMALL MOUTH" -"OMIM:605946","METAPHYSEAL DYSPLASIA, BRAUN-TINSCHERT TYPE" -"OMIM:605967","ACROPECTORAL SYNDROME; ACRPS" -"DOID:0110133","Bardet-Biedl syndrome 11" -"OMIM:605990","NEPHROLITHIASIS, URIC ACID, SUSCEPTIBILITY TO" -"DOID:1483","gingival disease" -"OMIM:606002","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 1; SCAR1" -"OMIM:606003","TRANSALDOLASE DEFICIENCY" -"DOID:8552","chronic myeloid leukemia" -"OMIM:606012","DEAFNESS, AUTOSOMAL DOMINANT 18; DFNA18" -"OMIM:115430","CARPAL TUNNEL SYNDROME; CTS1" -"OMIM:606035","FASTING INSULIN LEVEL QUANTITATIVE TRAIT LOCUS 1; FIQTL1" -"OMIM:606049","ACROMEGALOID FEATURES, OVERGROWTH, CLEFT PALATE, AND HERNIA" -"OMIM:606053","AUTISM, SUSCEPTIBILITY TO, 5; AUTS5" -"OMIM:606054","PROPIONIC ACIDEMIA" -"DOID:0080161","cutaneous candidiasis" -"OMIM:606056","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIb; CDG2B" -"OMIM:606068","RETINITIS PIGMENTOSA 28; RP28" -"OMIM:175700","GREIG CEPHALOPOLYSYNDACTYLY SYNDROME; GCPS" -"OMIM:606069","HEMOCHROMATOSIS, TYPE 4; HFE4" -"DOID:5694","esophagus liposarcoma" -"DOID:1556","arthus reaction" -"DOID:0110407","retinitis pigmentosa 57" -"OMIM:617370","PEROXISOME BIOGENESIS DISORDER 10B; PBD10B" -"OMIM:613454","RETT SYNDROME, CONGENITAL VARIANT" -"DOID:0110146","Bartter disease type 4b" -"OMIM:154230","46,XY SEX REVERSAL 4; SRXY4" -"OMIM:153870","MACULAR DYSTROPHY, CONCENTRIC ANNULAR" -"OMIM:617383","AVASCULAR NECROSIS OF FEMORAL HEAD, PRIMARY, 2; ANFH2" -"OMIM:613456","FRONTONASAL DYSPLASIA 3; FND3" -"OMIM:617384","HYPERPHENYLALANINEMIA, MILD, NON-BH4-DEFICIENT; HPANBH4" -"OMIM:613457","CHROMOSOME 14q11-q22 DELETION SYNDROME" -"OMIM:613458","CHROMOSOME 16p13.3 DUPLICATION SYNDROME" -"OMIM:617386","NUCLEAR RECEPTOR SUBFAMILY 1, GROUP H, MEMBER 5, PSEUDOGENE; NR1H5P" -"DOID:0060457","posterior polymorphous corneal dystrophy" -"OMIM:617388","AUTOINFLAMMATION WITH ARTHRITIS AND DYSKERATOSIS; AIADK" -"OMIM:613459","BIRTH WEIGHT QUANTITATIVE TRAIT LOCUS 2; BWQTL2" -"OMIM:103500","TIETZ ALBINISM-DEAFNESS SYNDROME; TADS" -"OMIM:617389","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 53; EIEE53" -"OMIM:613460","FASTING PLASMA GLUCOSE LEVEL QUANTITATIVE TRAIT LOCUS 6; FGQTL6" -"DOID:2559","opiate dependence" -"OMIM:613462","FASTING PLASMA GLUCOSE LEVEL QUANTITATIVE TRAIT LOCUS 4; FGQTL4" -"OMIM:617391","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 54; EIEE54" -"OMIM:617392","ECTODERMAL DYSPLASIA 13, HAIR/TOOTH TYPE; ECTD13" -"OMIM:613463","FASTING PLASMA GLUCOSE LEVEL QUANTITATIVE TRAIT LOCUS 5; FGQTL5" -"DOID:4065","mixed type rhabdomyosarcoma" -"DOID:750","peptic ulcer disease" -"OMIM:617393","NEURODEVELOPMENTAL DISORDER WITH EPILEPSY, CATARACTS, FEEDING DIFFICULTIES, AND DELAYED BRAIN MYELINATION; NECFM" -"OMIM:613464","RETINITIS PIGMENTOSA 51; RP51" -"DOID:2729","dyskeratosis congenita" -"OMIM:103580","PSEUDOHYPOPARATHYROIDISM, TYPE IA; PHP1A" -"OMIM:153840","MACULAR DYSTROPHY, VITELLIFORM, 1; VMD1" -"OMIM:613470","HEMOLYTIC ANEMIA, NONSPHEROCYTIC, DUE TO GLUCOSE PHOSPHATE ISOMERASE DEFICIENCY" -"OMIM:617394","SCLEROSING CHOLANGITIS, NEONATAL; NSC" -"OMIM:103285","ADULT SYNDROME" -"DOID:5418","schizoaffective disorder" -"OMIM:613471","REYNOLDS SYNDROME" -"OMIM:617395","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIq; CDG2Q" -"OMIM:617396","ANAUXETIC DYSPLASIA 2; ANXD2" -"OMIM:613477","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 5; EIEE5" -"OMIM:617397","PSEUDO-TORCH SYNDROME 2; PTORCH2" -"OMIM:613480","LYMPHEDEMA, HEREDITARY, IC; LMPH1C" -"OMIM:103780","ALCOHOL DEPENDENCE" -"OMIM:617402","CUTIS LAXA, AUTOSOMAL RECESSIVE, TYPE IIC; ARCL2C" -"OMIM:613485","LONG QT SYNDROME 13; LQT13" -"OMIM:617403","CUTIS LAXA, AUTOSOMAL RECESSIVE, TYPE IID; ARCL2D" -"OMIM:613488","MYXOID LIPOSARCOMA" -"DOID:1838","Menkes disease" -"OMIM:613489","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIj; CDG2J" -"OMIM:617404","MUSCULAR DYSTROPHY, CONGENITAL, WITH CATARACTS AND INTELLECTUAL DISABILITY; MDCCAID" -"OMIM:617405","SHORT-RIB THORACIC DYSPLASIA 17 WITH OR WITHOUT POLYDACTYLY; SRTD17" -"OMIM:613490","ALPHA-1-ANTITRYPSIN DEFICIENCY; A1ATD" -"DOID:863","nervous system disease" -"OMIM:613493","IMMUNODEFICIENCY, COMMON VARIABLE, 3; CVID3" -"OMIM:617406","BARDET-BIEDL SYNDROME 21; BBS21" -"OMIM:613494","IMMUNODEFICIENCY, COMMON VARIABLE, 4; CVID4" -"OMIM:617408","DIAMOND-BLACKFAN ANEMIA 16; DBA16" -"OMIM:103470","ALBINISM, OCULAR, WITH SENSORINEURAL DEAFNESS" -"OMIM:617409","DIAMOND-BLACKFAN ANEMIA 17; DBA17" -"OMIM:613495","IMMUNODEFICIENCY, COMMON VARIABLE, 5; CVID5" -"OMIM:613496","IMMUNODEFICIENCY, COMMON VARIABLE, 6; CVID6" -"OMIM:617412","BRACHYCEPHALY, TRICHOMEGALY, AND DEVELOPMENTAL DELAY; BTDD" -"OMIM:613498","SEX HORMONE-BINDING GLOBULIN CIRCULATING LEVEL QUANTITATIVE TRAIT LOCUS; SXGQTL1" -"OMIM:617425","IMMUNOSKELETAL DYSPLASIA WITH NEURODEVELOPMENTAL ABNORMALITIES; ISDNA" -"DOID:14159","obstructive hydrocephalus" -"DOID:4079","heart valve disease" -"OMIM:613500","AGAMMAGLOBULINEMIA 2, AUTOSOMAL RECESSIVE; AGM2" -"OMIM:617432","MENTAL RETARDATION, AUTOSOMAL RECESSIVE 60; MRT60" -"OMIM:153890","MACULAR DYSTROPHY, FENESTRATED SHEEN TYPE" -"OMIM:613501","AGAMMAGLOBULINEMIA 3, AUTOSOMAL RECESSIVE; AGM3" -"OMIM:617433","RETINITIS PIGMENTOSA 78; RP78" -"DOID:9230","pompholyx" -"OMIM:617435","LOPES-MACIEL-RODAN SYNDROME; LOMARS" -"OMIM:613502","AGAMMAGLOBULINEMIA 4, AUTOSOMAL RECESSIVE; AGM4" -"DOID:8432","polycythemia" -"OMIM:617439","CRANIOSYNOSTOSIS 7; CRS7" -"OMIM:613506","AGAMMAGLOBULINEMIA 5, AUTOSOMAL DOMINANT; AGM5" -"OMIM:103400","AINHUM" -"OMIM:153880","MACULAR DYSTROPHY, DOMINANT CYSTOID; DCMD" -"OMIM:613507","GLYCOGEN STORAGE DISEASE XV; GSD15" -"DOID:219","colon cancer" -"OMIM:617441","THROMBOCYTOPENIA, ANEMIA, AND MYELOFIBROSIS; THAMY" -"DOID:0060755","familial temporal lobe epilepsy 2" -"OMIM:617442","PREMATURE OVARIAN FAILURE 13; POF13" -"OMIM:613508","SODIUM SERUM LEVEL QUANTITATIVE TRAIT LOCUS 1; SSQTL1" -"OMIM:154020","HYPOMAGNESEMIA 2, RENAL; HOMG2" -"OMIM:617443","BLEEDING DISORDER, PLATELET-TYPE, 21; BDPLT21" -"OMIM:613509","CHROMOSOME 4q21 DELETION SYNDROME" -"DOID:2860","hemoglobinopathy" -"DOID:0111056","platelet-type bleeding disorder 3" -"DOID:0110417","retinitis pigmentosa 34" -"OMIM:103420","ALACRIMA, CONGENITAL, AUTOSOMAL DOMINANT" -"DOID:0060176","gamma-amino butyric acid metabolism disorder" -"OMIM:617450","INTELLECTUAL DEVELOPMENTAL DISORDER WITH GASTROINTESTINAL DIFFICULTIES AND HIGH PAIN THRESHOLD; IDDGIP" -"OMIM:613517","MICROPHTHALMIA, ISOLATED 6; MCOP6" -"DOID:0110357","retinitis pigmentosa 35" -"OMIM:617452","INTELLECTUAL DEVELOPMENTAL DISORDER WITH DYSMORPHIC FACIES, SEIZURES, AND DISTAL LIMB ANOMALIES; IDDFSDA" -"OMIM:613518","DERMATITIS, ATOPIC, 8; ATOD8" -"OMIM:617460","RETINITIS PIGMENTOSA 79; RP79" -"OMIM:613519","DERMATITIS, ATOPIC, 9; ATOD9" -"DOID:2527","nephrosis" -"OMIM:103300","HYPOGLOSSIA-HYPODACTYLIA" -"OMIM:617466","TOWNES-BROCKS SYNDROME 2; TBS2" -"OMIM:613523","CHROMOSOME 8p11 MYELOPROLIFERATIVE SYNDROME" -"DOID:1273","respiratory syncytial virus infectious disease" -"DOID:0060605","anterior segment mesenchymal dysgenesis" -"OMIM:613530","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 1H; LGMD1H" -"OMIM:617468","ARTHROGRYPOSIS MULTIPLEX CONGENITA, NEUROGENIC, WITH MYELIN DEFECT; AMCNMY" -"OMIM:617475","SPECIFIC GRANULE DEFICIENCY 2; SGD2" -"OMIM:613533","CHROMOSOME 17q21.31 DUPLICATION SYNDROME" -"OMIM:613544","CHROMOSOME 6q11-q14 DELETION SYNDROME" -"OMIM:617478","STRUCTURAL HEART DEFECTS AND RENAL ANOMALIES SYNDROME; SHDRA" -"DOID:0060270","pontocerebellar hypoplasia type 2D" -"DOID:1414","ovarian dysfunction" -"OMIM:221760","DERMATOGLYPHICS--PALMAR TRIRADIUS d, ABSENCE OF" -"DOID:5697","liposarcoma of the ovary" -"OMIM:605249","SEBASTIAN SYNDROME; SBS" -"OMIM:605253","NEUROPATHY, CONGENITAL HYPOMYELINATING OR AMYELINATING, AUTOSOMAL RECESSIVE; CHN" -"OMIM:221770","POLYCYSTIC LIPOMEMBRANOUS OSTEODYSPLASIA WITH SCLEROSING LEUKOENCEPHALOPATHY; PLOSL" -"OMIM:112600","BRACHYDACTYLY, TYPE A2; BDA2" -"DOID:0060268","pontocerebellar hypoplasia type 2B" -"DOID:2229","factor XI deficiency" -"DOID:4242","kidney sarcoma" -"OMIM:605258","IMMUNODEFICIENCY WITH HYPER-IgM, TYPE 2; HIGM2" -"OMIM:221780","DERMATOGLYPHICS--HYPOTHENAR RADIAL ARCH" -"DOID:11608","fungal meningitis" -"DOID:9140","xeroderma of eyelid" -"DOID:0060839","isolated microphthalmia 2" -"OMIM:605259","SPINOCEREBELLAR ATAXIA 13; SCA13" -"OMIM:221790","DERMATOLEUKODYSTROPHY" -"OMIM:113000","BRACHYDACTYLY, TYPE B1; BDB1" -"OMIM:113301","BRACHYDACTYLY, TYPE E, WITH ATRIAL SEPTAL DEFECT, TYPE II" -"DOID:0060836","isolated microphthalmia 4" -"OMIM:221800","DERMOCHONDROCORNEAL DYSTROPHY" -"OMIM:605274","MESOMELIC DYSPLASIA, SAVARIRAYAN TYPE" -"DOID:3381","liposarcoma of bone" -"DOID:4451","renal carcinoma" -"OMIM:221810","DERMATOOSTEOLYSIS, KIRGHIZIAN TYPE" -"OMIM:605275","NOONAN SYNDROME 2; NS2" -"DOID:0060835","isolated microphthalmia 6" -"DOID:11839","glans penis cancer" -"OMIM:221820","LEUKOENCEPHALOPATHY, HEREDITARY DIFFUSE, WITH SPHEROIDS; HDLS" -"DOID:7571","malignant cystic nephroma" -"OMIM:605280","SPASTIC PARAPLEGIA 13, AUTOSOMAL DOMINANT; SPG13" -"OMIM:112450","BRACHYDACTYLY, PREAXIAL, WITH HALLUX VARUS AND THUMB ABDUCTION" -"OMIM:221900","PERSISTENT HYPERPLASTIC PRIMARY VITREOUS, AUTOSOMAL RECESSIVE; PHPVAR" -"OMIM:605282","TEMTAMY PREAXIAL BRACHYDACTYLY SYNDROME; TPBS" -"DOID:5696","larynx liposarcoma" -"OMIM:221950","DEXTROCARDIA WITH UNUSUAL FACIES AND MICROPHTHALMIA" -"OMIM:605285","NEUROPATHY, HEREDITARY MOTOR AND SENSORY, RUSSE TYPE; HMSNR" -"DOID:5698","fibroblastic liposarcoma" -"OMIM:605289","SPLIT-HAND/FOOT MALFORMATION 4; SHFM4" -"DOID:3449","penis carcinoma" -"OMIM:221995","DIABETES INSIPIDUS, NEPHROGENIC, WITH MENTAL RETARDATION AND INTRACEREBRAL CALCIFICATION" -"OMIM:222100","DIABETES MELLITUS, INSULIN-DEPENDENT; IDDM" -"OMIM:605293","OPTIC ATROPHY 4; OPA4" -"DOID:5363","myxoid liposarcoma" -"OMIM:605309","MACROCEPHALY/AUTISM SYNDROME" -"OMIM:222300","WOLFRAM SYNDROME 1; WFS1" -"DOID:0060267","pontocerebellar hypoplasia type 2A" -"DOID:9675","pulmonary emphysema" -"OMIM:222350","DIAMINOPENTANURIA" -"OMIM:605321","FRONTOOCULAR SYNDROME" -"DOID:0060837","isolated microphthalmia 5" -"DOID:305","carcinoma" -"OMIM:605355","NEMALINE MYOPATHY 5; NEM5" -"OMIM:222400","DIAPHRAGMATIC HERNIA 2; DIH2" -"DOID:14248","chronic atticoantral disease" -"DOID:1596","mental depression" -"OMIM:605361","SPINOCEREBELLAR ATAXIA 14; SCA14" -"OMIM:222448","DONNAI-BARROW SYNDROME" -"OMIM:112440","BRACHYDACTYLY, COMBINED B AND E TYPES" -"DOID:5712","cutaneous liposarcoma" -"OMIM:605362","CARDIOMYOPATHY, DILATED, 1J; CMD1J" -"OMIM:222470","TRICHOHEPATOENTERIC SYNDROME 1; THES1" -"OMIM:605364","PSORIASIS 6, SUSCEPTIBILITY TO; PSORS6" -"OMIM:222500","DIASTEMATOMYELIA" -"DOID:0060842","isolated microphthalmia 3" -"DOID:12554","hemolytic-uremic syndrome" -"OMIM:112800","BRACHYDACTYLY, TYPE A4; BDA4" -"OMIM:605365","BREAST CANCER 3; BRCA3" -"DOID:0050838","segmental dystonia" -"OMIM:222600","DIASTROPHIC DYSPLASIA; DTD" -"DOID:1893","eczematous dermatitis of eyelid" -"DOID:5703","mixed liposarcoma" -"OMIM:222690","DIBASIC AMINO ACIDURIA I" -"OMIM:605373","PARAGANGLIOMAS 3; PGL3" -"OMIM:222700","LYSINURIC PROTEIN INTOLERANCE; LPI" -"DOID:11243","anemia of prematurity" -"OMIM:605375","EPILEPSY, NOCTURNAL FRONTAL LOBE, 3; ENFL3" -"DOID:10155","intestinal cancer" -"OMIM:222730","DICARBOXYLIC AMINOACIDURIA; DCBXA" -"OMIM:605376","HETEROTAXY, VISCERAL, 2, AUTOSOMAL; HTX2" -"OMIM:222748","DIHYDROPYRIMIDINASE DEFICIENCY; DPYSD" -"OMIM:112500","BRACHYDACTYLY, TYPE A1; BDA1" -"OMIM:605387","CATARACT 31, MULTIPLE TYPES; CTRCT31" -"OMIM:112910","OSEBOLD-REMONDINI SYNDROME" -"DOID:0060266","pontocerebellar hypoplasia type 1B" -"OMIM:605388","CEREBRAL PALSY, ATAXIC, AUTOSOMAL RECESSIVE" -"OMIM:222765","RHIZOMELIC CHONDRODYSPLASIA PUNCTATA, TYPE 2; RCDP2" -"OMIM:222800","BISPHOSPHOGLYCERATE MUTASE DEFICIENCY" -"OMIM:605389","HYPOTRICHOSIS 1; HYPT1" -"DOID:11612","polycystic ovary syndrome" -"DOID:0060354","Stormorken syndrome" -"DOID:7707","rectum signet ring adenocarcinoma" -"OMIM:605400","FIBROMATOSIS, GINGIVAL, WITH HYPERTRICHOSIS AND MENTAL RETARDATION" -"OMIM:222900","SUCRASE-ISOMALTASE DEFICIENCY, CONGENITAL; CSID" -"DOID:12294","atypical depressive disorder" -"DOID:0060841","isolated microphthalmia 8" -"OMIM:223000","LACTASE DEFICIENCY, CONGENITAL" -"OMIM:112430","LONG-THUMB BRACHYDACTYLY SYNDROME" -"OMIM:113100","BRACHYDACTYLY, TYPE C; BDC" -"OMIM:605407","SEGAWA SYNDROME, AUTOSOMAL RECESSIVE" -"DOID:13520","neonatal infective mastitis" -"OMIM:605419","SCHIZOPHRENIA 10; SCZD10" -"DOID:5695","pediatric liposarcoma" -"OMIM:223100","LACTOSE INTOLERANCE, ADULT TYPE" -"OMIM:182250","SINGLETON-MERTEN SYNDROME 1; SGMRT1" -"OMIM:223200","DISORGANIZATION, MOUSE, HOMOLOG OF" -"OMIM:113300","BRACHYDACTYLY, TYPE E1; BDE1" -"OMIM:605428","DEAFNESS, AUTOSOMAL RECESSIVE 26; DFNB26" -"OMIM:112700","BRACHYDACTYLY, TYPE A3; BDA3" -"OMIM:605429","DEAFNESS, NONSYNDROMIC, MODIFIER 1; DFNM1" -"DOID:12043","kernicterus due to isoimmunization" -"OMIM:223300","DISSEMINATED SCLEROSIS WITH NARCOLEPSY" -"DOID:11838","penis sarcoma" -"DOID:5702","pleomorphic liposarcoma" -"OMIM:605432","RADIOULNAR SYNOSTOSIS WITH AMEGAKARYOCYTIC THROMBOCYTOPENIA 1; RUSAT1" -"OMIM:223320","DIVERTICULOSIS, SMALL-INTESTINAL" -"OMIM:113200","BRACHYDACTYLY, TYPE D; BDD" -"DOID:5714","intracranial liposarcoma" -"OMIM:223330","DIVERTICULOSIS OF BOWEL, HERNIA, AND RETINAL DETACHMENT" -"OMIM:605462","BASAL CELL CARCINOMA, SUSCEPTIBILITY TO, 1; BCC1" -"DOID:310","MERRF syndrome" -"DOID:582","hemoglobinuria" -"OMIM:605463","RADIATION SENSITIVITY/CHROMOSOME INSTABILITY SYNDROME, AUTOSOMAL DOMINANT" -"OMIM:223340","DK PHOCOMELIA SYNDROME" -"DOID:5711","vulvar liposarcoma" -"OMIM:605472","USHER SYNDROME, TYPE IIC; USH2C" -"OMIM:223350","DOHLE BODIES AND LEUKEMIA" -"OMIM:223360","DOPAMINE BETA-HYDROXYLASE DEFICIENCY, CONGENITAL" -"DOID:5709","mixed-type liposarcoma" -"OMIM:112410","HYPERTENSION AND BRACHYDACTYLY SYNDROME; HTNB" -"OMIM:613453","DEAFNESS, AUTOSOMAL RECESSIVE 91; DFNB91" -"OMIM:605479","CHOLESTASIS, BENIGN RECURRENT INTRAHEPATIC, 2; BRIC2" -"OMIM:223370","DUBOWITZ SYNDROME" -"OMIM:605480","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 3; SLEB3" -"DOID:1895","allergic contact dermatitis of eyelid" -"OMIM:605526","ALZHEIMER DISEASE 6" -"OMIM:223380","DOPAMINE BETA-HYDROXYLASE, PLASMA, THERMOLABILITY OF" -"OMIM:276800","TYROSINOSIS" -"OMIM:613545","MACROSTOMIA, ISOLATED" -"OMIM:606070","AMYOTROPHIC LATERAL SCLEROSIS 21; ALS21" -"DOID:0110496","autosomal recessive nonsyndromic deafness 38" -"OMIM:617480","46,XX SEX REVERSAL 4; SRXX4" -"OMIM:276820","ULNA AND FIBULA, ABSENCE OF, WITH SEVERE LIMB DEFICIENCY" -"OMIM:617481","NEURODEVELOPMENTAL DISORDER WITH MICROCEPHALY, HYPOTONIA, AND VARIABLE BRAIN ANOMALIES; NMIHBA" -"OMIM:122000","CORNEAL DYSTROPHY, POSTERIOR POLYMORPHOUS, 1; PPCD1" -"OMIM:613546","AROMATASE DEFICIENCY" -"OMIM:606071","HEREDITARY MOTOR AND SENSORY NEUROPATHY, TYPE IIC; HMSN2C" -"OMIM:613547","STATURE QUANTITATIVE TRAIT LOCUS 22; STQTL22" -"OMIM:617493","NEURODEVELOPMENTAL DISORDER WITH INVOLUNTARY MOVEMENTS; NEDIM" -"OMIM:606072","RIPPLING MUSCLE DISEASE 2; RMD2" -"DOID:12332","hematocele of tunica vaginalis testis" -"DOID:0110466","autosomal recessive nonsyndromic deafness 105" -"OMIM:276821","ULNAR HYPOPLASIA WITH MENTAL RETARDATION" -"OMIM:276822","ULNAR AGENESIS AND ENDOCARDIAL FIBROELASTOSIS" -"OMIM:617506","NOONAN SYNDROME-LIKE DISORDER WITH LOOSE ANAGEN HAIR 2; NSLH2" -"OMIM:613548","STATURE QUANTITATIVE TRAIT LOCUS 23; STQTL23" -"DOID:0110484","autosomal recessive nonsyndromic deafness 26" -"DOID:1749","squamous cell carcinoma" -"OMIM:606082","GOITER, MULTINODULAR 3; MNG3" -"DOID:0110535","autosomal recessive nonsyndromic deafness 9" -"OMIM:276880","UROCANASE DEFICIENCY; UROCD" -"OMIM:613549","STATURE QUANTITATIVE TRAIT LOCUS 24; STQTL24" -"OMIM:606129","DIAMOND-BLACKFAN ANEMIA 2; DBA2" -"OMIM:617507","PEHO-LIKE SYNDROME; PEHOL" -"DOID:13074","tinea unguium" -"OMIM:276900","USHER SYNDROME, TYPE I; USH1" -"OMIM:613550","NEPHRONOPHTHISIS 11; NPHP11" -"OMIM:617514","IMMUNODEFICIENCY 52; IMD52" -"OMIM:606156","SENER SYNDROME" -"OMIM:606159","NEURODEGENERATION WITH BRAIN IRON ACCUMULATION 3; NBIA3" -"DOID:0110482","autosomal recessive nonsyndromic deafness 24" -"DOID:11343","scleral disease" -"OMIM:276901","USHER SYNDROME, TYPE IIA; USH2A" -"OMIM:617516","STANKIEWICZ-ISIDOR SYNDROME; STISS" -"OMIM:156400","METAPHYSEAL CHONDRODYSPLASIA, JANSEN TYPE" -"OMIM:613551","AUTOIMMUNE DISEASE, SUSCEPTIBILITY TO, 6; AIS6" -"DOID:0110498","autosomal recessive nonsyndromic deafness 4" -"OMIM:613554","VON WILLEBRAND DISEASE, TYPE 2; VWD2" -"OMIM:276902","USHER SYNDROME, TYPE IIIA; USH3A" -"DOID:10835","chylocele of tunica vaginalis" -"OMIM:617519","MYOPATHY, CONGENITAL, WITH NEUROPATHY AND DEAFNESS; CMND" -"OMIM:606164","DIAMOND-BLACKFAN ANEMIA 15 WITH MANDIBULOFACIAL DYSOSTOSIS; DBA15" -"OMIM:276904","USHER SYNDROME, TYPE IC; USH1C" -"OMIM:617520","MICROCEPHALY 18, PRIMARY, AUTOSOMAL DOMINANT; MCPH18" -"OMIM:613558","DEAFNESS, AUTOSOMAL DOMINANT 51; DFNA51" -"OMIM:606170","GENITOPATELLAR SYNDROME; GTPTS" -"DOID:0110516","autosomal recessive nonsyndromic deafness 65" -"DOID:3247","rhabdomyosarcoma" -"OMIM:276950","VACTERL ASSOCIATION WITH HYDROCEPHALUS" -"OMIM:606174","BACULUM, CONGENITAL ABSENCE OF" -"OMIM:617523","NEURODEVELOPMENTAL DISORDER WITH MIDBRAIN AND HINDBRAIN MALFORMATIONS; NEDMHM" -"OMIM:613559","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 7; COXPD7" -"DOID:0090020","split hand-foot malformation" -"DOID:0110488","autosomal recessive nonsyndromic deafness 3" -"DOID:5576","inhibited male orgasm" -"OMIM:606175","CARNITINE ACETYLTRANSFERASE DEFICIENCY" -"OMIM:277000","MAYER-ROKITANSKY-KUSTER-HAUSER SYNDROME" -"OMIM:617524","ERYTHROKERATODERMIA VARIABILIS ET PROGRESSIVA 2; EKVP2" -"OMIM:613561","MYOPATHY, LACTIC ACIDOSIS, AND SIDEROBLASTIC ANEMIA 2; MLASA2" -"OMIM:617525","ERYTHROKERATODERMIA VARIABILIS ET PROGRESSIVA 3; EKVP3" -"OMIM:277100","VALINEMIA" -"OMIM:613563","NOONAN SYNDROME-LIKE DISORDER WITH OR WITHOUT JUVENILE MYELOMONOCYTIC LEUKEMIA; NSLL" -"DOID:2664","sweat gland neoplasm" -"DOID:0110475","autosomal recessive nonsyndromic deafness 1A" -"OMIM:606176","DIABETES MELLITUS, PERMANENT NEONATAL; PNDM" -"OMIM:613564","CHROMOSOME 2p12-p11.2 DELETION SYNDROME" -"OMIM:277150","VAN BOGAERT-HOZAY SYNDROME" -"OMIM:617526","ERYTHROKERATODERMIA VARIABILIS ET PROGRESSIVA 4; EKVP4" -"DOID:0110512","autosomal recessive nonsyndromic deafness 6" -"OMIM:606177","PARS PLANITIS" -"OMIM:606179","ANEURYSMAL BONE CYSTS" -"OMIM:613566","FETAL HEMOGLOBIN QUANTITATIVE TRAIT LOCUS 6; HBFQTL6" -"OMIM:277170","OROFACIODIGITAL SYNDROME VI; OFD6" -"OMIM:617527","NEURODEVELOPMENTAL DISORDER WITH PROGRESSIVE MICROCEPHALY, SPASTICITY, AND BRAIN ANOMALIES; NDMSBA" -"OMIM:606183","LARYNGEAL ABDUCTOR PARALYSIS WITH CEREBELLAR ATAXIA AND MOTOR NEUROPATHY" -"DOID:0110510","autosomal recessive nonsyndromic deafness 55" -"OMIM:613571","DISORDERED STEROIDOGENESIS DUE TO CYTOCHROME P450 OXIDOREDUCTASE DEFICIENCY" -"OMIM:617532","INTELLECTUAL DEVELOPMENTAL DISORDER WITH NEUROPSYCHIATRIC FEATURES; IDDNPF" -"OMIM:277175","VASCULAR HYALINOSIS" -"OMIM:277180","VAS DEFERENS, CONGENITAL BILATERAL APLASIA OF; CBAVD" -"DOID:0110518","autosomal recessive nonsyndromic deafness 67" -"OMIM:613573","ECTODERMAL DYSPLASIA-SYNDACTYLY SYNDROME 1; EDSS1" -"OMIM:156510","METAPHYSEAL DYSPLASIA WITH MAXILLARY HYPOPLASIA WITH OR WITHOUT BRACHYDACTYLY; MDMHB" -"OMIM:176240","POSTAXIAL OLIGODACTYLY, TETRAMELIC" -"OMIM:606187","ALZHEIMER DISEASE 7" -"OMIM:617537","RAHMAN SYNDROME; RMNS" -"OMIM:617540","PITUITARY ADENOMA 5, MULTIPLE TYPES; PITA5" -"OMIM:606190","MENINGIOMA, RADIATION-INDUCED" -"OMIM:277200","RIGHT VENTRICULAR HYPOPLASIA, ISOLATED" -"OMIM:613575","RETINITIS PIGMENTOSA 55; RP55" -"DOID:10079","cysticercosis" -"OMIM:606215","ATRIOVENTRICULAR SEPTAL DEFECT; AVSD" -"OMIM:277300","SPONDYLOCOSTAL DYSOSTOSIS 1, AUTOSOMAL RECESSIVE; SCDO1" -"OMIM:613576","ECTODERMAL DYSPLASIA-SYNDACTYLY SYNDROME 2; EDSS2" -"OMIM:617542","GAZE PALSY, FAMILIAL HORIZONTAL, WITH PROGRESSIVE SCOLIOSIS, 2; HGPPS2" -"OMIM:613581","RETINITIS PIGMENTOSA 56; RP56" -"OMIM:606217","ATRIOVENTRICULAR SEPTAL DEFECT, SUSCEPTIBILITY TO, 2; AVSD2" -"OMIM:617547","RETINAL DYSTROPHY WITH OR WITHOUT MACULAR STAPHYLOMA; RDMS" -"DOID:5241","hemangioblastoma" -"OMIM:277320","VISCERAL MYOPATHY, FAMILIAL, WITH EXTERNAL OPHTHALMOPLEGIA" -"OMIM:277350","HYPERCAROTENEMIA AND VITAMIN A DEFICIENCY, AUTOSOMAL RECESSIVE" -"OMIM:606220","MENTAL RETARDATION, SHORT STATURE, FACIAL ANOMALIES, AND JOINT DISLOCATIONS" -"OMIM:613582","RETINITIS PIGMENTOSA 57; RP57" -"OMIM:617557","GABRIELE-DE VRIES SYNDROME; GADEVS" -"DOID:14037","aorta atresia" -"DOID:4782","subacute glomerulonephritis" -"OMIM:277380","METHYLMALONIC ACIDURIA AND HOMOCYSTINURIA, cblF TYPE" -"OMIM:613587","OCCULT MACULAR DYSTROPHY; OCMD" -"OMIM:617560","SPASTIC ATAXIA 8, AUTOSOMAL RECESSIVE, WITH HYPOMYELINATING LEUKODYSTROPHY; SPAX8" -"OMIM:606232","PHELAN-MCDERMID SYNDROME; PHMDS" -"DOID:0110539","autosomal recessive nonsyndromic deafness 97" -"OMIM:613589","LOW DENSITY LIPOPROTEIN CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 6; LDLCQ6" -"DOID:3183","childhood oligodendroglioma" -"OMIM:277400","METHYLMALONIC ACIDURIA AND HOMOCYSTINURIA, cblC TYPE" -"DOID:0050125","dengue shock syndrome" -"DOID:0110504","autosomal recessive nonsyndromic deafness 47" -"OMIM:606240","THYROID CANCER, NONMEDULLARY, 3; NMTC3" -"OMIM:617561","COHEN-GIBSON SYNDROME; COGIS" -"OMIM:613600","TORSADE DE POINTES, SHORT-COUPLED VARIANT" -"OMIM:617562","MECKEL SYNDROME 13; MKS13" -"DOID:0110533","autosomal recessive nonsyndromic deafness 88" -"DOID:5223","infertility" -"OMIM:277410","METHYLMALONIC ACIDURIA AND HOMOCYSTINURIA, cblD TYPE" -"OMIM:606242","MENTAL RETARDATION, MICROCEPHALY, GROWTH RETARDATION, JOINT CONTRACTURES, AND FACIAL DYSMORPHISM" -"OMIM:277440","VITAMIN D-DEPENDENT RICKETS, TYPE 2A; VDDR2A" -"OMIM:156300","METACHROMASIA OF FIBROBLASTS" -"OMIM:617563","OROFACIODIGITAL SYNDROME XVI; OFD16" -"DOID:0110483","autosomal recessive nonsyndromic deafness 25" -"DOID:10316","pneumoconiosis" -"OMIM:613601","EARLY REPOLARIZATION ASSOCIATED WITH VENTRICULAR FIBRILLATION" -"OMIM:606243","ALVEOLAR SOFT PART SARCOMA; ASPS" -"DOID:0110497","autosomal recessive nonsyndromic deafness 39" -"DOID:13800","inclusion conjunctivitis" -"OMIM:613603","CHROMOSOME 4q32.1-q32.2 TRIPLICATION SYNDROME" -"OMIM:606255","STATURE AS A QUANTITATIVE TRAIT" -"OMIM:617564","MEIER-GORLIN SYNDROME 8; MGORS8" -"OMIM:277450","VITAMIN K-DEPENDENT CLOTTING FACTORS, COMBINED DEFICIENCY OF, 1; VKCFD1" -"OMIM:277460","VITAMIN E, FAMILIAL ISOLATED DEFICIENCY OF; VED" -"OMIM:606256","STATURE QUANTITATIVE TRAIT LOCUS 2; STQTL2" -"OMIM:613604","CHROMOSOME 16p12.2-p11.2 DELETION SYNDROME, 7.1- TO 8.7-MB" -"OMIM:617565","PERRAULT SYNDROME 6; PRLTS6" -"OMIM:613606","FORSYTHE-WAKELING SYNDROME; FWS" -"OMIM:156530","METATROPIC DYSPLASIA" -"OMIM:277465","VITILIGO, PROGRESSIVE, WITH MENTAL RETARDATION AND URETHRAL DUPLICATION" -"OMIM:606257","STATURE QUANTITATIVE TRAIT LOCUS 3; STQTL3" -"OMIM:617571","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 14; ARCI14" -"DOID:0110469","autosomal recessive nonsyndromic deafness 14" -"DOID:0110529","autosomal recessive nonsyndromic deafness 84A" -"OMIM:617572","EXUDATIVE VITREORETINOPATHY 7; EVR7" -"OMIM:613608","EPILEPSY, FAMILIAL ADULT MYOCLONIC, 3; FAME3" -"OMIM:277470","PONTOCEREBELLAR HYPOPLASIA, TYPE 2A; PCH2A" -"DOID:1532","pleural disease" -"OMIM:606258","STATURE QUANTITATIVE TRAIT LOCUS 4; STQTL4" -"OMIM:606263","PAGET DISEASE OF BONE 4; PDB4" -"OMIM:277480","VON WILLEBRAND DISEASE, TYPE 3; VWD3" -"OMIM:613610","CRANIOECTODERMAL DYSPLASIA 2; CED2" -"OMIM:156310","METACHROMATIC LEUKODYSTROPHY, ADULT-ONSET, WITH NORMAL ARYLSULFATASE A" -"OMIM:617574","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 13; ARCI13" -"OMIM:606282","DEAFNESS, AUTOSOMAL DOMINANT 24; DFNA24" -"OMIM:617575","NEPHROTIC SYNDROME 14; NPHS14" -"OMIM:613611","CHOANAL ATRESIA AND LYMPHEDEMA" -"DOID:0110491","autosomal recessive nonsyndromic deafness 32" -"OMIM:156500","METAPHYSEAL CHONDRODYSPLASIA, SCHMID TYPE; MCDS" -"DOID:4780","anti-basement membrane glomerulonephritis" -"OMIM:277580","WAARDENBURG SYNDROME, TYPE 4A; WS4A" -"OMIM:613612","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE IIi; CDG2I" -"OMIM:277590","WEAVER SYNDROME; WVS" -"OMIM:617576","SPERMATOGENIC FAILURE 18; SPGF18" -"OMIM:606324","PARKINSON DISEASE 7, AUTOSOMAL RECESSIVE EARLY-ONSET; PARK7" -"OMIM:606325","HETEROTAXY, VISCERAL, 3, AUTOSOMAL; HTX3" -"DOID:3463","breast disease" -"OMIM:617577","CILIARY DYSKINESIA, PRIMARY, 37; CILD37" -"OMIM:121820","CORNEAL DYSTROPHY, EPITHELIAL BASEMENT MEMBRANE; EBMD" -"OMIM:613615","SENIOR-LOKEN SYNDROME 7; SLSN7" -"OMIM:277600","WEILL-MARCHESANI SYNDROME 1; WMS1" -"OMIM:121900","CORNEAL DYSTROPHY, GROENOUW TYPE I; CDGG1" -"OMIM:613616","HYPEROXALURIA, PRIMARY, TYPE III; HP3" -"OMIM:277700","WERNER SYNDROME; WRN" -"OMIM:617584","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 25; SCAR25" -"OMIM:156520","METATARSUS VARUS, TYPE I" -"OMIM:606346","DEAFNESS, AUTOSOMAL DOMINANT 22; DFNA22" -"OMIM:277720","WHISTLING FACE SYNDROME, RECESSIVE FORM" -"OMIM:613617","RETINITIS PIGMENTOSA 58; RP58" -"OMIM:606348","INFLAMMATORY BOWEL DISEASE 5; IBD5" -"DOID:4974","actinobacillosis" -"OMIM:617585","IMMUNODEFICIENCY 53; IMD53" -"OMIM:121850","CORNEAL DYSTROPHY, FLECK" -"OMIM:606349","GAMBLING, PATHOLOGIC" -"DOID:0110513","autosomal recessive nonsyndromic deafness 61" -"DOID:3910","lung adenocarcinoma" -"OMIM:277730","WERNICKE-KORSAKOFF SYNDROME" -"OMIM:617592","SPERMATOGENIC FAILURE 19; SPGF19" -"OMIM:613618","CHROMOSOME 17q23.1-q23.2 DUPLICATION SYNDROME" -"OMIM:156550","KNIEST DYSPLASIA" -"OMIM:613623","AGENESIS OF THE CORPUS CALLOSUM AND CONGENITAL LYMPHEDEMA" -"OMIM:277740","WHITE FORELOCK WITH MALFORMATIONS" -"OMIM:617593","SPERMATOGENIC FAILURE 20; SPGF20" -"OMIM:606353","PRIMARY LATERAL SCLEROSIS, JUVENILE; PLSJ" -"DOID:0050564","autosomal dominant nonsyndromic deafness" -"OMIM:604855","HYALURONAN METABOLISM, DEFECT IN" -"OMIM:253220","MUCOPOLYSACCHARIDOSIS, TYPE VII; MPS7" -"OMIM:124400","DARWINIAN TUBERCLE OF PINNA" -"OMIM:175780","PORENCEPHALY 1; POREN1" -"OMIM:253240","MUCUS INSPISSATION OF RESPIRATORY TRACT" -"OMIM:604856","LANGERHANS CELL HISTIOCYTOSIS" -"DOID:0110068","FTDALS3" -"OMIM:253250","MULIBREY NANISM" -"OMIM:604864","OSTEOARTHRITIS WITH MILD CHONDRODYSPLASIA; OSCDP" -"DOID:0060278","pontocerebellar hypoplasia type 9" -"DOID:0050752","amyotrophic lateral sclerosis type 8" -"OMIM:253260","BIOTINIDASE DEFICIENCY" -"OMIM:124300","DARWINIAN TUBERCLE OF PINNA" -"OMIM:604901","NORTH AMERICAN INDIAN CHILDHOOD CIRRHOSIS; NAIC" -"OMIM:118800","PAROXYSMAL NONKINESIGENIC DYSKINESIA 1; PNKD1" -"DOID:9008","psoriatic arthritis" -"DOID:0060203","amyotrophic lateral sclerosis type 12" -"OMIM:118830","CHYLOMICRONEMIA, FAMILIAL, DUE TO CIRCULATING INHIBITOR OF LIPOPROTEIN LIPASE" -"OMIM:604906","SCHIZOPHRENIA 9; SCZD9" -"OMIM:253270","HOLOCARBOXYLASE SYNTHETASE DEFICIENCY" -"OMIM:253280","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 3; MDDGA3" -"DOID:0060202","amyotrophic lateral sclerosis type 11" -"OMIM:604916","HYDRONEPHROSIS, CONGENITAL, WITH CLEFT PALATE, CHARACTERISTIC FACIES, HYPOTONIA, AND MENTAL RETARDATION" -"OMIM:253290","MULTIPLE PTERYGIUM SYNDROME, LETHAL TYPE; LMPS" -"OMIM:604919","BECKER NEVUS SYNDROME" -"OMIM:118650","CHONDRODYSPLASIA PUNCTATA, AUTOSOMAL DOMINANT" -"DOID:0060214","FTDALS2" -"OMIM:143860","HYPERCHLORHIDROSIS, ISOLATED" -"OMIM:253300","SPINAL MUSCULAR ATROPHY, TYPE I; SMA1" -"OMIM:604922","CORTICAL DEFECTS, WORMIAN BONES, AND DENTINOGENESIS IMPERFECTA" -"DOID:2945","severe acute respiratory syndrome" -"OMIM:604928","WOLFRAM SYNDROME 2; WFS2" -"OMIM:253310","LETHAL CONGENITAL CONTRACTURE SYNDROME 1; LCCS1" -"OMIM:253320","MULTICORE MYOPATHY WITH MENTAL RETARDATION, SHORT STATURE, AND HYPOGONADOTROPIC HYPOGONADISM" -"DOID:0060209","amyotrophic lateral sclerosis type 18" -"OMIM:118651","CHONDRODYSPLASIA PUNCTATA, TIBIA-METACARPAL TYPE" -"OMIM:124950","DEAFNESS, SENSORINEURAL, WITH PERIPHERAL NEUROPATHY AND ARTERIAL DISEASE" -"OMIM:604931","CORTISONE REDUCTASE DEFICIENCY 1; CORTRD1" -"OMIM:167400","PAROXYSMAL EXTREME PAIN DISORDER" -"OMIM:604966","PROTOCADHERIN-ALPHA GENE CLUSTER; PCDHA@" -"OMIM:253400","SPINAL MUSCULAR ATROPHY, TYPE III; SMA3" -"DOID:11125","qualitative platelet defect" -"DOID:0060273","pontocerebellar hypoplasia type 4" -"DOID:0110069","FTDALS4" -"OMIM:604967","PROTOCADHERIN-BETA GENE CLUSTER; PCDHB@" -"OMIM:167300","PAGET DISEASE, EXTRAMAMMARY" -"OMIM:253550","SPINAL MUSCULAR ATROPHY, TYPE II; SMA2" -"OMIM:118670","CHONDRONECTIN" -"DOID:0060197","amyotrophic lateral sclerosis type 5" -"OMIM:124900","DEAFNESS, AUTOSOMAL DOMINANT 1; DFNA1" -"DOID:0060182","microscopic colitis" -"OMIM:167250","PAGET DISEASE OF BONE 3; PDB3" -"OMIM:604968","PROTOCADHERIN-GAMMA GENE CLUSTER; PCDHG@" -"OMIM:253590","MUSCULAR DYSTROPHY, ADULT-ONSET, WITH LEUKOENCEPHALOPATHY" -"OMIM:605013","MICROHYDRANENCEPHALY; MHAC" -"OMIM:253600","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2A; LGMD2A" -"DOID:2703","synovitis" -"DOID:0060198","amyotrophic lateral sclerosis type 6" -"OMIM:605019","HYPOBETALIPOPROTEINEMIA, FAMILIAL, 2; FHBL2" -"DOID:0060279","pontocerebellar hypoplasia type 10" -"OMIM:253601","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2B; LGMD2B" -"DOID:1926","Gaucher's disease" -"OMIM:253700","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2C; LGMD2C" -"DOID:0090080","hypogonadotropic hypogonadism 16 with or without anosmia" -"OMIM:605021","MYOCLONIC EPILEPSY, FAMILIAL INFANTILE; FIME" -"OMIM:124480","DEAFNESS, CONGENITAL, WITH ONYCHODYSTROPHY, AUTOSOMAL DOMINANT; DDOD" -"OMIM:605026","DIABETES MELLITUS, CONGENITAL AUTOIMMUNE" -"OMIM:253800","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH BRAIN AND EYE ANOMALIES), TYPE A, 4; MDDGA4" -"DOID:0060210","amyotrophic lateral sclerosis type 19" -"OMIM:118700","CHOREA, BENIGN HEREDITARY; BHC" -"OMIM:605027","LYMPHOMA, NON-HODGKIN, FAMILIAL" -"OMIM:253900","MUSCULAR DYSTROPHY, CONGENITAL, PRODUCING ARTHROGRYPOSIS" -"DOID:0060318","acute promyelocytic leukemia" -"OMIM:143465","ATTENTION DEFICIT-HYPERACTIVITY DISORDER; ADHD" -"OMIM:254000","MUSCULAR DYSTROPHY, CONGENITAL, WITH INFANTILE CATARACT AND HYPOGONADISM" -"OMIM:167320","INCLUSION BODY MYOPATHY WITH EARLY-ONSET PAGET DISEASE WITH OR WITHOUT FRONTOTEMPORAL DEMENTIA 1; IBMPFD1" -"OMIM:605028","LOW DENSITY LIPOPROTEIN CHOLESTEROL, MILD ELEVATION OF" -"OMIM:118750","CHOREOATHETOSIS, FAMILIAL INVERTED" -"OMIM:167210","PACHYONYCHIA CONGENITA 2; PC2" -"OMIM:605039","BOHRING-OPITZ SYNDROME; BOPS" -"OMIM:254090","ULLRICH CONGENITAL MUSCULAR DYSTROPHY 1; UCMD1" -"DOID:0060206","amyotrophic lateral sclerosis type 15" -"OMIM:254100","MUSCULAR DYSTROPHY, CONGENITAL, WITH RAPID PROGRESSION" -"OMIM:605040","CLAVICULAR HYPOPLASIA, ZYGOMATIC ARCH HYPOPLASIA, AND MICROGNATHIA" -"OMIM:143850","ORTHOSTATIC HYPOTENSIVE DISORDER, STREETEN TYPE" -"OMIM:254110","MUSCULAR DYSTROPHY, LIMB-GIRDLE, TYPE 2H; LGMD2H" -"DOID:1522","cecum lymphoma" -"DOID:4901","peritoneal serous adenocarcinoma" -"DOID:0060193","amyotrophic lateral sclerosis type 1" -"OMIM:605041","BROOKE-SPIEGLER SYNDROME; BRSS" -"OMIM:254120","MUSCULAR HYPERTONIA, LETHAL" -"OMIM:605055","ALZHEIMER DISEASE, FAMILIAL EARLY-ONSET, WITH COEXISTING AMYLOID AND PRION PATHOLOGY" -"OMIM:167700","PALMOMENTAL REFLEX" -"DOID:0060274","pontocerebellar hypoplasia type 5" -"OMIM:143460","5-HYDROXYTRYPTAMINE OXYGENASE REGULATOR; HTOR" -"DOID:1724","duodenal ulcer" -"OMIM:124500","VOHWINKEL SYNDROME; VOWNKL" -"OMIM:254130","MIYOSHI MUSCULAR DYSTROPHY 1; MMD1" -"OMIM:605067","TRICUSPID ATRESIA" -"DOID:0060194","amyotrophic lateral sclerosis type 2" -"OMIM:605074","RENAL CELL CARCINOMA, PAPILLARY, 1; RCCP1" -"OMIM:254150","MUSK, INABILITY TO SMELL" -"OMIM:167220","PACMAN DYSPLASIA" -"OMIM:124490","DEAFNESS, CONDUCTIVE STAPEDIAL, WITH EAR MALFORMATION AND FACIAL PALSY" -"OMIM:605105","EARLY RESPONSE TO NEURAL INDUCTION GENE" -"DOID:2073","perinatal intestinal perforation" -"OMIM:143400","CONGENITAL ANOMALIES OF KIDNEY AND URINARY TRACT 2; CAKUT2" -"OMIM:254190","MYASTHENIA, CONGENITAL, REFRACTORY TO ACETYLCHOLINESTERASE INHIBITORS" -"OMIM:254200","MYASTHENIA GRAVIS; MG" -"OMIM:605115","HYPERTENSION, EARLY-ONSET, AUTOSOMAL DOMINANT, WITH SEVERE EXACERBATION IN PREGNANCY" -"DOID:332","amyotrophic lateral sclerosis" -"OMIM:254210","MYASTHENIC SYNDROME, CONGENITAL, 6, PRESYNAPTIC; CMS6" -"OMIM:605130","WIEDEMANN-STEINER SYNDROME; WDSTS" -"DOID:0060195","amyotrophic lateral sclerosis type 3" -"DOID:0060187","diversion colitis" -"OMIM:605192","DEAFNESS, AUTOSOMAL DOMINANT 23; DFNA23" -"OMIM:254300","MYASTHENIC SYNDROME, CONGENITAL, 10; CMS10" -"OMIM:143200","WAGNER VITREORETINOPATHY; WGVRP" -"OMIM:254400","MYCOSIS FUNGOIDES" -"OMIM:605201","HIGH DENSITY LIPOPROTEIN CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 14; HDLCQ14" -"DOID:0060200","amyotrophic lateral sclerosis type 9" -"OMIM:167600","PALMARIS LONGUS MUSCLE, ABSENCE OF" -"OMIM:254450","MYELOFIBROSIS" -"OMIM:605218","SYSTEMIC LUPUS ERYTHEMATOSUS, SUSCEPTIBILITY TO, 2; SLEB2" -"DOID:0060199","amyotrophic lateral sclerosis type 7" -"OMIM:605225","INFLAMMATORY BOWEL DISEASE 7; IBD7" -"OMIM:167730","NASOPALPEBRAL LIPOMA-COLOBOMA SYNDROME; NPLCS" -"DOID:0060212","amyotrophic lateral sclerosis type 21" -"OMIM:143470","HYPERALPHALIPOPROTEINEMIA 1; HALP1" -"OMIM:167500","PALATOPHARYNGEAL INCOMPETENCE" -"OMIM:254500","MYELOMA, MULTIPLE" -"OMIM:254600","MYELOPEROXIDASE DEFICIENCY; MPOD" -"OMIM:605229","SPASTIC PARAPLEGIA 14, AUTOSOMAL RECESSIVE; SPG14" -"OMIM:125000","DEAFNESS, UNILATERAL" -"OMIM:605231","BARDET-BIEDL SYNDROME 6; BBS6" -"OMIM:124700","DEAFNESS, MID-TONE NEURAL" -"OMIM:254700","MYELOPROLIFERATIVE DISEASE, AUTOSOMAL RECESSIVE" -"OMIM:143500","GILBERT SYNDROME" -"OMIM:254770","EPILEPSY, MYOCLONIC JUVENILE; EJM" -"OMIM:605233","DIANZANI AUTOIMMUNE LYMPHOPROLIFERATIVE DISEASE" -"DOID:0060276","pontocerebellar hypoplasia type 7" -"OMIM:605244","CARNEY COMPLEX, TYPE 2; CNC2" -"OMIM:254780","MYOCLONIC EPILEPSY OF LAFORA" -"OMIM:175750","POPLITEAL CYST" -"DOID:0060677","catecholaminergic polymorphic ventricular tachycardia 3" -"OMIM:606367","IMMUNODEFICIENCY 41 WITH LYMPHOPROLIFERATION AND AUTOIMMUNITY; IMD41" -"DOID:1070","primary open angle glaucoma" -"DOID:12236","primary biliary cirrhosis" -"DOID:8646","substance-induced psychosis" -"OMIM:606369","MACROCEPHALY AND EPILEPTIC ENCEPHALOPATHY" -"OMIM:606391","MATURITY-ONSET DIABETES OF THE YOUNG; MODY" -"DOID:0080163","otulipenia" -"OMIM:606392","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 4; MODY4" -"OMIM:606394","MATURITY-ONSET DIABETES OF THE YOUNG, TYPE 6; MODY6" -"OMIM:606407","HYPOTONIA-CYSTINURIA SYNDROME" -"DOID:5240","retinal hemangioblastoma" -"DOID:0060692","platelet-type bleeding disorder 8" -"DOID:0050352","foodborne botulism" -"DOID:0050565","autosomal recessive nonsyndromic deafness" -"OMIM:606408","EHLERS-DANLOS SYNDROME DUE TO TENASCIN-X DEFICIENCY" -"OMIM:606438","HUNTINGTON DISEASE-LIKE 2; HDL2" -"OMIM:606445","PERSISTENT POLYCLONAL B-CELL LYMPHOCYTOSIS; PPBL" -"OMIM:606451","DEAFNESS, AUTOSOMAL DOMINANT 30; DFNA30" -"DOID:11725","Cornelia de Lange syndrome" -"OMIM:606460","LONGEVITY 2" -"DOID:9723","vitreous abscess" -"OMIM:606482","CHARCOT-MARIE-TOOTH DISEASE, DOMINANT INTERMEDIATE B; CMTDIB" -"DOID:0050353","wound botulism" -"OMIM:606483","CHARCOT-MARIE-TOOTH DISEASE, DOMINANT INTERMEDIATE A; CMTDIA" -"OMIM:606519","PHACE ASSOCIATION" -"OMIM:606527","MEGARBANE SYNDROME" -"DOID:75","lymphatic system disease" -"DOID:0111028","hemochromatosis type 4" -"OMIM:606528","HOMOZYGOUS 11p15-p14 DELETION SYNDROME" -"DOID:0050141","intestinal botulism" -"OMIM:606529","CRANIOSYNOSTOSIS SYNDROME, AUTOSOMAL RECESSIVE" -"OMIM:606545","ICHTHYOSIS, CONGENITAL, AUTOSOMAL RECESSIVE 3; ARCI3" -"OMIM:606552","EPISODIC ATAXIA, TYPE 4; EA4" -"DOID:14059","paraurethral gland cancer" -"OMIM:606554","EPISODIC ATAXIA, TYPE 3; EA3" -"DOID:3304","germinoma" -"DOID:12139","dysthymic disorder" -"DOID:1176","bronchial disease" -"DOID:1659","supratentorial cancer" -"DOID:0110377","retinitis pigmentosa 49" -"OMIM:606574","ALBINISM, OCULOCUTANEOUS, TYPE IV; OCA4" -"DOID:934","viral infectious disease" -"OMIM:606579","VITILIGO-ASSOCIATED MULTIPLE AUTOIMMUNE DISEASE SUSCEPTIBILITY 1; VAMAS1" -"OMIM:606581","POLYSUBSTANCE ABUSE, SUSCEPTIBILITY TO; PSAB" -"DOID:3646","necrosis of pituitary" -"OMIM:606593","LIG4 SYNDROME" -"OMIM:606595","CHARCOT-MARIE-TOOTH DISEASE, AXONAL, TYPE 2F; CMT2F" -"OMIM:606612","MUSCULAR DYSTROPHY-DYSTROGLYCANOPATHY (CONGENITAL WITH OR WITHOUT MENTAL RETARDATION), TYPE B, 5; MDDGB5" -"OMIM:606613","HIGH DENSITY LIPOPROTEIN CHOLESTEROL LEVEL QUANTITATIVE TRAIT LOCUS 1; HDLCQ1" -"OMIM:606616","DYSLEXIA, SUSCEPTIBILITY TO, 6; DYX6" -"OMIM:606631","CAMURATI-ENGELMANN DISEASE, TYPE 2" -"OMIM:606632","ODOR, MALE, WOMEN'S CHOICE OF" -"DOID:2769","tic disorder" -"DOID:12190","descending colon cancer" -"OMIM:606640","AMYOTROPHIC LATERAL SCLEROSIS 3; ALS3" -"DOID:10697","chronic endophthalmitis" -"OMIM:606641","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 1; BMIQ1" -"DOID:218","ascending colon cancer" -"DOID:1520","colon carcinoma" -"OMIM:606643","BODY MASS INDEX QUANTITATIVE TRAIT LOCUS 2; BMIQ2" -"DOID:13544","low tension glaucoma" -"DOID:1441","autosomal dominant cerebellar ataxia" -"DOID:0050563","nonsyndromic deafness" -"DOID:0060678","catecholaminergic polymorphic ventricular tachycardia 4" -"OMIM:606656","BASAL GANGLIA CALCIFICATION, IDIOPATHIC, 2; IBGC2" -"DOID:5260","colon sarcoma" -"DOID:0090041","torsion dystonia 4" -"OMIM:606657","GLAUCOMA, NORMAL TENSION, SUSCEPTIBILITY TO" -"DOID:261","transverse colon cancer" -"DOID:612","primary immunodeficiency disease" -"OMIM:606658","SPINOCEREBELLAR ATAXIA 15; SCA15" -"DOID:9779","bowel dysfunction" -"DOID:0111016","cone-rod dystrophy 13" -"OMIM:613625","FACTOR V AND FACTOR VIII, COMBINED DEFICIENCY OF, 2; F5F8D2" -"DOID:11428","endometriosis of intestine" -"OMIM:617595","BIRK-LANDAU-PEREZ SYNDROME; BILAPES" -"OMIM:300496","AUTISM, SUSCEPTIBILITY TO, X-LINKED 3; AUTSX3" -"DOID:12355","prostatocystitis" -"DOID:5353","colonic disease" -"OMIM:617596","MALEYLACETOACETATE ISOMERASE DEFICIENCY; MAAID" -"OMIM:613627","BRACHYDACTYLY, TYPE A1, WITH SHORT STATURE, SCOLIOSIS, MICROCEPHALY, PTOSIS, HEARING LOSS, AND MENTAL RETARDATION" -"OMIM:300497","ASPERGER SYNDROME, X-LINKED, SUSCEPTIBILITY TO, 2; ASPGX2" -"DOID:8439","postgastrectomy syndrome" -"OMIM:300498","MENTAL RETARDATION, X-LINKED 45; MRX45" -"DOID:0111012","cone-rod dystrophy 7" -"OMIM:613628","ODONTOID HYPOPLASIA" -"OMIM:617598","MOSAIC VARIEGATED ANEUPLOIDY SYNDROME 3; MVA3" -"OMIM:613630","COCOON SYNDROME" -"OMIM:300500","ALBINISM, OCULAR, TYPE I; OA1" -"OMIM:617599","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 55; EIEE55" -"DOID:0111024","cone-rod dystrophy 18" -"DOID:0111102","maturity-onset diabetes of the young type 3" -"OMIM:613636","TUBERCULIN SKIN TEST REACTIVITY, ABSENCE OF" -"DOID:8476","Whipple disease" -"OMIM:617600","MENTAL RETARDATION, AUTOSOMAL DOMINANT 45; MRD45" -"DOID:13306","diphtheritic cystitis" -"DOID:0111008","X-linked cone-rod dystrophy 1" -"OMIM:300504","MENTAL RETARDATION, X-LINKED 52; MRX52" -"OMIM:613637","TUBERCULIN SKIN TEST REACTIVITY QUANTITATIVE TRAIT LOCUS" -"OMIM:617601","MENTAL RETARDATION, AUTOSOMAL DOMINANT 46; MRD46" -"OMIM:300505","MENTAL RETARDATION, X-LINKED 84; MRX84" -"DOID:8501","fundus dystrophy" -"OMIM:300509","DYSLEXIA, SUSCEPTIBILITY TO, 9; DYX9" -"OMIM:617602","CONGENITAL HEART DEFECTS AND SKELETAL MALFORMATIONS SYNDROME; CHDSKM" -"OMIM:613638","CHROMOSOME 19p13.13 DELETION SYNDROME" -"DOID:2639","breast pericanalicular fibroadenoma" -"DOID:8704","genital herpes" -"DOID:100","intestinal infectious disease" -"DOID:0111132","focal segmental glomerulosclerosis 7" -"OMIM:300510","OVARIAN DYSGENESIS 2; ODG2" -"OMIM:613640","NEUROPATHY, HEREDITARY SENSORY AND AUTONOMIC, TYPE IC; HSAN1C" -"OMIM:617604","MICROCEPHALY, SHORT STATURE, AND LIMB ABNORMALITIES; MISSLA" -"OMIM:613641","CHARCOT-MARIE-TOOTH DISEASE, RECESSIVE INTERMEDIATE B; CMTRIB" -"OMIM:300511","PREMATURE OVARIAN FAILURE 2A; POF2A" -"OMIM:617605","DEAFNESS, AUTOSOMAL DOMINANT 71; DFNA71" -"DOID:10124","corneal disease" -"DOID:0111010","cone-rod dystrophy 5" -"DOID:1680","chronic cystitis" -"OMIM:617606","DEAFNESS, AUTOSOMAL DOMINANT 72; DFNA72" -"OMIM:300514","FANCONI ANEMIA, COMPLEMENTATION GROUP B; FANCB" -"OMIM:613642","CARDIOMYOPATHY, DILATED, 1GG; CMD1GG" -"DOID:0110393","retinitis pigmentosa 66" -"DOID:0111013","cone-rod dystrophy 3" -"OMIM:300518","MENTAL RETARDATION, X-LINKED 82; MRX82" -"OMIM:617607","AMELOGENESIS IMPERFECTA, TYPE IIIB; AI3B" -"DOID:0110361","retinitis pigmentosa 75" -"OMIM:613643","PARKINSON DISEASE 5, AUTOSOMAL DOMINANT, SUSCEPTIBILITY TO; PARK5" -"DOID:8886","chorioretinitis" -"DOID:9370","exophthalmos" -"OMIM:617609","NEPHROTIC SYNDROME 15; NPHS15" -"OMIM:613646","METHYLMALONIC ACIDURIA, TRANSIENT, DUE TO TRANSCOBALAMIN RECEPTOR DEFECT" -"DOID:13949","interstitial cystitis" -"OMIM:300519","MENTAL RETARDATION, X-LINKED, SYNDROMIC, MARTIN-PROBST TYPE; MRXSMP" -"DOID:2656","breast intracanalicular fibroadenoma" -"OMIM:300523","ALLAN-HERNDON-DUDLEY SYNDROME; AHDS" -"DOID:1400","lacrimal apparatus disease" -"OMIM:617610","POLYCYSTIC KIDNEY DISEASE 5; PKD5" -"DOID:0111018","cone-rod dystrophy 11" -"DOID:0111131","focal segmental glomerulosclerosis 6" -"DOID:13248","mucocele of appendix" -"OMIM:613647","SPASTIC PARAPLEGIA 48, AUTOSOMAL RECESSIVE; SPG48" -"DOID:1285","rectal disease" -"OMIM:617613","MULTIPLE MITOCHONDRIAL DYSFUNCTIONS SYNDROME 5; MMDS5" -"DOID:0110376","retinitis pigmentosa 41" -"OMIM:105835","ANGEL-SHAPED PHALANGOEPIPHYSEAL DYSPLASIA; ASPED" -"DOID:13976","peptic esophagitis" -"DOID:0060260","ptosis" -"OMIM:300534","MENTAL RETARDATION, X-LINKED, SYNDROMIC, CLAES-JENSEN TYPE; MRXSCJ" -"OMIM:613652","C1q DEFICIENCY; C1QD" -"OMIM:617616","SKRABAN-DEARDORFF SYNDROME; SKDEAS" -"OMIM:300536","BONE MINERAL DENSITY QUANTITATIVE TRAIT LOCUS 4; BMND4" -"DOID:1518","cecal disease" -"DOID:0110422","autosomal recessive pericentral pigmentary retinopathy" -"DOID:0111134","focal segmental glomerulosclerosis 9" -"OMIM:613656","MIGRAINE WITH OR WITHOUT AURA, SUSCEPTIBILITY TO, 13; MGR13" -"DOID:0110374","retinitis pigmentosa 68" -"OMIM:613657","D-2-HYDROXYGLUTARIC ACIDURIA 2; D2HGA2" -"OMIM:617622","JOUBERT SYNDROME 30; JBTS30" -"DOID:10176","neuroretinitis" -"DOID:10606","blind loop syndrome" -"OMIM:300539","NEPHROGENIC SYNDROME OF INAPPROPRIATE ANTIDIURESIS; NSIAD" -"DOID:3480","uveal disease" -"OMIM:613658","RAJAB SYNDROME" -"OMIM:300554","HYPOPHOSPHATEMIC RICKETS, X-LINKED RECESSIVE" -"OMIM:617626","FIBROMATOSIS, GINGIVAL, 5; GINGF5" -"DOID:0111015","Newfoundland cone-rod dystrophy" -"DOID:0060216","Cogan syndrome" -"DOID:10880","iliac vein thrombophlebitis" -"OMIM:613659","GASTRIC CANCER" -"OMIM:300555","DENT DISEASE 2" -"DOID:9799","eye degenerative disease" -"OMIM:617629","SCHIZOPHRENIA 19; SCZD19" -"OMIM:300557","PARKINSON DISEASE 12; PARK12" -"OMIM:617633","SPINOCEREBELLAR ATAXIA, AUTOSOMAL RECESSIVE 26; SCAR26" -"OMIM:613660","CONE-ROD DYSTROPHY 15; CORD15" -"OMIM:613661","CONGENITAL DISORDER OF GLYCOSYLATION, TYPE Ip; CDG1P" -"DOID:0060463","NUT midline carcinoma" -"DOID:0111022","cone-rod dystrophy 16" -"DOID:0111011","cone-rod dystrophy 6" -"DOID:9335","scotoma" -"OMIM:300558","MENTAL RETARDATION, X-LINKED 30; MRX30" -"DOID:3576","sagittal sinus thrombosis" -"OMIM:617637","DEAFNESS, AUTOSOMAL RECESSIVE 106; DFNB106" -"OMIM:613662","MITOCHONDRIAL DNA DEPLETION SYNDROME 4B (MNGIE TYPE); MTDPS4B" -"OMIM:300559","GLYCOGEN STORAGE DISEASE, TYPE IXd; GSD9D" -"DOID:0111130","focal segmental glomerulosclerosis 5" -"DOID:0090019","sitosterolemia" -"OMIM:613668","MICROCEPHALY, POSTNATAL PROGRESSIVE, WITH SEIZURES AND BRAIN ATROPHY" -"OMIM:300577","MENTAL RETARDATION, X-LINKED 91; MRX91" -"DOID:10607","tropical sprue" -"OMIM:617638","IMMUNODEFICIENCY 11B WITH ATOPIC DERMATITIS; IMD11B" -"DOID:0111019","cone-rod dystrophy 12" -"OMIM:300578","CHROMOSOME Xp11.3 DELETION SYNDROME" -"OMIM:613670","MENTAL RETARDATION WITH LANGUAGE IMPAIRMENT AND WITH OR WITHOUT AUTISTIC FEATURES" -"DOID:0060217","Cogan-Reese syndrome" -"DOID:13507","trigonitis" -"DOID:0111007","X-linked cone-rod dystrophy 3" -"OMIM:617639","DEAFNESS, AUTOSOMAL RECESSIVE 107; DFNB107" -"OMIM:617641","CONGENITAL ANOMALIES OF KIDNEY AND URINARY TRACT SYNDROME WITH OR WITHOUT HEARING LOSS, ABNORMAL EARS, OR DEVELOPMENTAL DELAY; CAKUTHED" -"OMIM:300580","MYOPATHY, CONGENITAL, WITH FIBER-TYPE DISPROPORTION, X-LINKED; CFTDX" -"OMIM:613671","MENTAL RETARDATION, ANTERIOR MAXILLARY PROTRUSION, AND STRABISMUS; MRAMS" -"OMIM:106050","ANGIOMA SERPIGINOSUM, AUTOSOMAL DOMINANT" -"DOID:14392","thrombophlebitis migrans" -"DOID:0060321","umbilical hernia" -"OMIM:300581","FG SYNDROME 5; FGS5" -"OMIM:613672","SPASTIC ATAXIA 4, AUTOSOMAL RECESSIVE; SPAX4" -"OMIM:617642","POLYDACTYLY, POSTAXIAL, TYPE A7; PAPA7" -"DOID:9868","intestinal disaccharidase deficiency" -"DOID:110","lens disease" -"DOID:0111014","cone-rod dystrophy 8" -"DOID:3177","verrucous papilloma" -"OMIM:617643","CEREBELLAR ATROPHY, DEVELOPMENTAL DELAY, AND SEIZURES; CADEDS" -"OMIM:613673","ANEMIA, CONGENITAL DYSERYTHROPOIETIC, TYPE IV; CDAN4" -"OMIM:300582","SHORT STATURE, IDIOPATHIC, X-LINKED; ISS" -"OMIM:617644","SPERMATOGENIC FAILURE 21; SPGF21" -"OMIM:173420","PLATELET DISORDER, UNDEFINED" -"OMIM:613674","VESICOURETERAL REFLUX 3; VUR3" -"OMIM:300584","IMMUNODEFICIENCY WITHOUT ANHIDROTIC ECTODERMAL DYSPLASIA" -"DOID:0111025","cone-rod dystrophy 19" -"OMIM:105830","ANGELMAN SYNDROME; AS" -"OMIM:613675","CHROMOSOME 17q11.2 DELETION SYNDROME, 1.4-MB" -"OMIM:617654","DEAFNESS, AUTOSOMAL RECESSIVE 108; DFNB108" -"DOID:1727","retinal vein occlusion" -"DOID:0111023","cone-rod dystrophy 17" -"OMIM:300589","NYSTAGMUS 5, CONGENITAL, X-LINKED; NYS5" -"DOID:13419","neurogenic bowel" -"DOID:0110411","retinitis pigmentosa 60" -"OMIM:613676","SECKEL SYNDROME 4; SCKL4" -"OMIM:617660","VERTEBRAL, CARDIAC, RENAL, AND LIMB DEFECTS SYNDROME 1; VCRL1" -"OMIM:300590","CORNELIA DE LANGE SYNDROME 2; CDLS2" -"DOID:1627","intraductal papilloma" -"DOID:13249","pneumatosis cystoides intestinalis" -"OMIM:617661","VERTEBRAL, CARDIAC, RENAL, AND LIMB DEFECTS SYNDROME 2; VCRL2" -"DOID:8505","dermatitis herpetiformis" -"OMIM:300591","STATURE QUANTITATIVE TRAIT LOCUS 6; STQTL6" -"DOID:4072","duodenal disease" -"DOID:0110419","retinitis pigmentosa with or without situs inversus" -"OMIM:613677","HYPERALDOSTERONISM, FAMILIAL, TYPE III; HALD3" -"OMIM:105805","ANEURYSM OF INTERVENTRICULAR SEPTUM" -"OMIM:300600","ALAND ISLAND EYE DISEASE; AIED" -"OMIM:617662","JOINT LAXITY, SHORT STATURE, AND MYOPIA; JLSM" -"OMIM:613678","BRACHYOLMIA TYPE 2; BCYM2" -"OMIM:617663","DEAFNESS, AUTOSOMAL DOMINANT 73; DFNA73" -"OMIM:613679","PROTHROMBIN DEFICIENCY, CONGENITAL" -"OMIM:300602","CLARK-BARAITSER SYNDROME" -"DOID:0111005","cone-rod dystrophy 2" -"DOID:10034","eye accommodation disease" -"OMIM:300604","PREMATURE OVARIAN FAILURE 2B; POF2B" -"OMIM:617664","COMBINED OXIDATIVE PHOSPHORYLATION DEFICIENCY 32; COXPD32" -"DOID:0060680","pigment dispersion syndrome" -"OMIM:105800","ANEURYSM, INTRACRANIAL BERRY, 1; ANIB1" -"DOID:5022","aflatoxins-related hepatocellular carcinoma" -"DOID:8633","chronic intestinal vascular insufficiency" -"OMIM:613680","BEAULIEU-BOYCOTT-INNES SYNDROME; BBIS" -"OMIM:617665","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 56; EIEE56" -"OMIM:300605","RETINITIS PIGMENTOSA 34; RP34" -"OMIM:613681","CHROMOSOME 2q31.1 DUPLICATION SYNDROME" -"DOID:8643","duodenitis" -"OMIM:300607","EPILEPTIC ENCEPHALOPATHY, EARLY INFANTILE, 8; EIEE8" -"DOID:10376","amblyopia" -"OMIM:617666","FRASER SYNDROME 2; FRASRS2" -"DOID:0111021","cone-rod dystrophy 15" -"DOID:7138","cystitis cystica" -"OMIM:613684","RUBINSTEIN-TAYBI SYNDROME 2; RSTS2" -"OMIM:173450","PLATELET FACTOR 3 DEFICIENCY" -"DOID:11716","prediabetes syndrome" -"OMIM:613685","DEAFNESS, AUTOSOMAL RECESSIVE 83; DFNB83" -"OMIM:300612","BROOKS-WISNIEWSKI-BROWN SYNDROME" -"OMIM:617667","FRASER SYNDROME 3; FRASRS3" -"OMIM:166400","OSTEOMAS OF MANDIBLE" -"OMIM:212080","CARDIAC LIPIDOSIS, FAMILIAL" -"OMIM:212090","CARDIAC SEPTAL DEFECTS WITH COARCTATION OF THE AORTA" -"OMIM:166000","ENCHONDROMATOSIS, MULTIPLE, OLLIER TYPE" -"OMIM:166250","OSTEOGLOPHONIC DYSPLASIA; OGD" -"OMIM:212093","CARDIAC VALVULAR DEFECT, DEVELOPMENTAL; CVDD" -"DOID:9483","ulcerative blepharitis" -"OMIM:212100","CARDIOAUDITORY SYNDROME OF SANCHEZ CASCOS" -"OMIM:166220","OSTEOGENESIS IMPERFECTA, TYPE IV; OI4" -"OMIM:212112","CARDIOMYOPATHY, DILATED, WITH HYPERGONADOTROPIC HYPOGONADISM" -"OMIM:165800","SHORT STATURE AND ADVANCED BONE AGE, WITH OR WITHOUT EARLY-ONSET OSTEOARTHRITIS AND/OR OSTEOCHONDRITIS DISSECANS; SSOAOD" -"OMIM:212130","CARDIOMYOPATHY ASSOCIATED WITH MYOPATHY AND SUDDEN DEATH" -"OMIM:212135","CARDIOSKELETAL SYNDROME, KUWAITI TYPE" -"OMIM:171000","PEYRONIE DISEASE" -"OMIM:212138","CARNITINE-ACYLCARNITINE TRANSLOCASE DEFICIENCY; CACTD" \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/run_build_master_kg.sh b/code/reasoningtool/kg-construction/run_build_master_kg.sh deleted file mode 100644 index a75c68474..000000000 --- a/code/reasoningtool/kg-construction/run_build_master_kg.sh +++ /dev/null @@ -1,2 +0,0 @@ -#!/bin/bash -python3 BuildMasterKG.py 1>stdout.log 2>stderr.log diff --git a/code/reasoningtool/kg-construction/tests/DrugMapperTests.py b/code/reasoningtool/kg-construction/tests/DrugMapperTests.py deleted file mode 100644 index 499e03b65..000000000 --- a/code/reasoningtool/kg-construction/tests/DrugMapperTests.py +++ /dev/null @@ -1,119 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from DrugMapper import DrugMapper - -class DrugMapperTestCase(unittest.TestCase): - - def test_map_drug_to_hp_with_side_effects(self): - hp_set = DrugMapper.map_drug_to_hp_with_side_effects('KWHRDNMACVLHCE-UHFFFAOYSA-N') - self.assertIsNotNone(hp_set) - self.assertEqual(56, len(hp_set)) - if 'HP:0004395' not in hp_set or 'HP:0000802' not in hp_set or 'HP:0001250' not in hp_set: - self.assertFalse() - - hp_set = DrugMapper.map_drug_to_hp_with_side_effects("CHEMBL521") - self.assertIsNotNone(hp_set) - self.assertEqual(0, len(hp_set)) - - hp_set = DrugMapper.map_drug_to_hp_with_side_effects("CHEMBL:521") - self.assertIsNotNone(hp_set) - self.assertEqual(0, len(hp_set)) - - hp_set = DrugMapper.map_drug_to_hp_with_side_effects("ChEMBL:521") - self.assertIsNotNone(hp_set) - self.assertEqual(0, len(hp_set)) - - def test_map_drug_to_UMLS(self): - # test case for ibuprofen - umls_results = DrugMapper.map_drug_to_UMLS("ChEMBL:521") - self.assertIsNotNone(umls_results) - self.assertIsNotNone(umls_results['indications']) - self.assertIsNotNone(umls_results['contraindications']) - self.assertEqual(11, len(umls_results['indications'])) - self.assertEqual(83, len(umls_results['contraindications'])) - - # test case for Penicillin V - umls_results = DrugMapper.map_drug_to_UMLS("CHEMBL615") - self.assertIsNotNone(umls_results) - self.assertIsNotNone(umls_results['indications']) - self.assertIsNotNone(umls_results['contraindications']) - self.assertEqual(12, len(umls_results['indications'])) - self.assertEqual(3, len(umls_results['contraindications'])) - - # test case for Cetirizine - umls_results = DrugMapper.map_drug_to_UMLS("CHEMBL1000") - self.assertIsNotNone(umls_results) - self.assertIsNotNone(umls_results['indications']) - self.assertIsNotNone(umls_results['contraindications']) - self.assertEqual(9, len(umls_results['indications'])) - self.assertEqual(13, len(umls_results['contraindications'])) - - # test case for Amoxicillin - umls_results = DrugMapper.map_drug_to_UMLS("CHEMBL1082") - self.assertIsNotNone(umls_results) - self.assertIsNotNone(umls_results['indications']) - self.assertIsNotNone(umls_results['contraindications']) - self.assertEqual(24, len(umls_results['indications'])) - self.assertEqual(17, len(umls_results['contraindications'])) - - def test_map_drug_to_ontology(self): - # test case for ibuprofen - onto_results = DrugMapper.map_drug_to_ontology("ChEMBL:521") - self.assertIsNotNone(onto_results) - self.assertIsNotNone(onto_results['indications']) - self.assertIsNotNone(onto_results['contraindications']) - self.assertEqual(10, len(onto_results['indications'])) - self.assertEqual(89, len(onto_results['contraindications'])) - - # test case for Penicillin V - onto_results = DrugMapper.map_drug_to_ontology("CHEMBL615") - self.assertIsNotNone(onto_results) - self.assertIsNotNone(onto_results['indications']) - self.assertIsNotNone(onto_results['contraindications']) - self.assertEqual(7, len(onto_results['indications'])) - self.assertEqual(6, len(onto_results['contraindications'])) - - # test case for Cetirizine - onto_results = DrugMapper.map_drug_to_ontology("CHEMBL1000") - self.assertIsNotNone(onto_results) - self.assertIsNotNone(onto_results['indications']) - self.assertIsNotNone(onto_results['contraindications']) - self.assertEqual(8, len(onto_results['indications'])) - self.assertEqual(23, len(onto_results['contraindications'])) - - # test case for Amoxicillin - onto_results = DrugMapper.map_drug_to_ontology("CHEMBL1082") - self.assertIsNotNone(onto_results) - self.assertIsNotNone(onto_results['indications']) - self.assertIsNotNone(onto_results['contraindications']) - self.assertEqual(6, len(onto_results['indications'])) - self.assertEqual(21, len(onto_results['contraindications'])) - - # test case for Amoxicillin - onto_results = DrugMapper.map_drug_to_ontology("CHEMBL1082") - self.assertIsNotNone(onto_results) - self.assertIsNotNone(onto_results['indications']) - self.assertIsNotNone(onto_results['contraindications']) - self.assertEqual(6, len(onto_results['indications'])) - self.assertEqual(21, len(onto_results['contraindications'])) - - # test case for CHEMBL2107884 - onto_results = DrugMapper.map_drug_to_ontology("CHEMBL2107884") - self.assertIsNotNone(onto_results) - self.assertIsNotNone(onto_results['indications']) - self.assertIsNotNone(onto_results['contraindications']) - self.assertEqual({'DOID:5870', 'DOID:9498'}, onto_results['indications']) - self.assertEqual(set(), onto_results['contraindications']) - - # test case for CHEMBL250270 - onto_results = DrugMapper.map_drug_to_ontology("CHEMBL250270") - self.assertIsNotNone(onto_results) - self.assertIsNotNone(onto_results['indications']) - self.assertIsNotNone(onto_results['contraindications']) - self.assertEqual({'DOID:10763', 'HP:0000822'}, onto_results['indications']) - self.assertEqual(set(), onto_results['contraindications']) diff --git a/code/reasoningtool/kg-construction/tests/KGTests.py b/code/reasoningtool/kg-construction/tests/KGTests.py deleted file mode 100644 index 291280860..000000000 --- a/code/reasoningtool/kg-construction/tests/KGTests.py +++ /dev/null @@ -1,523 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from Neo4jConnection import Neo4jConnection - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../../") # code directory -from RTXConfiguration import RTXConfiguration - - -class KGTestCase(unittest.TestCase): - - rtxConfig = RTXConfiguration() - rtxConfig.neo4j_kg2 = 'KG2pre' - - def test_anatomical_entity_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("UBERON:0001753") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "UBERON:0001753") - self.assertEqual(nodes['n']['name'], "cementum") - self.assertEqual(nodes['n']['description'], "Odontoid tissue that is deposited by cementoblasts onto dentine " - "tissue and functions to attach teeth, odontodes and other " - "odontogenic derivatives to bone tissue and the integument.") - self.assertEqual(nodes['n']['category'], "anatomical_entity") - - conn.close() - - def test_biological_process_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("GO:0048817") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "GO:0048817") - self.assertEqual(nodes['n']['name'], "negative regulation of hair follicle maturation") - self.assertEqual(nodes['n']['description'], "Any process that stops, prevents, or reduces the frequency, " - "rate or extent of hair follicle maturation.") - self.assertEqual(nodes['n']['category'], "biological_process") - - conn.close() - - def test_cellular_component_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("GO:0071005") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "GO:0071005") - self.assertEqual(nodes['n']['name'], "U2-type precatalytic spliceosome") - self.assertEqual(nodes['n']['description'], "A spliceosomal complex that is formed by the recruitment of the " - "preassembled U4/U6.U5 tri-snRNP to the prespliceosome. Although " - "all 5 snRNPs are present, the precatalytic spliceosome is " - "catalytically inactive. The precatalytic spliceosome includes " - "many proteins in addition to those found in the U1, U2 and " - "U4/U6.U5 snRNPs.") - self.assertEqual(nodes['n']['category'], "cellular_component") - - conn.close() - - def test_chemical_substance_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("CHEMBL1236962") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "CHEMBL1236962") - self.assertEqual(nodes['n']['name'], "omipalisib") - self.assertEqual(nodes['n']['description'], "None") - self.assertEqual(nodes['n']['category'], "chemical_substance") - - conn.close() - - def test_disease_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("DOID:6016") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "DOID:6016") - self.assertEqual(nodes['n']['name'], "adult central nervous system mature teratoma") - self.assertEqual(nodes['n']['description'], "None") - self.assertEqual(nodes['n']['category'], "disease") - - conn.close() - - def test_metabolite_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("KEGG:C19630") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "KEGG:C19630") - self.assertEqual(nodes['n']['name'], "Diketone") - self.assertEqual(nodes['n']['description'], "None") - self.assertEqual(nodes['n']['category'], "metabolite") - - conn.close() - - def test_microRNA_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("NCBIGene:100302124") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "NCBIGene:100302124") - self.assertEqual(nodes['n']['name'], "MIR1288") - self.assertEqual(nodes['n']['symbol'], "MIR1288") - self.assertEqual(nodes['n']['category'], "microRNA") - - conn.close() - - def test_molecular_function_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("GO:0030898") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "GO:0030898") - self.assertEqual(nodes['n']['name'], "actin-dependent ATPase activity") - self.assertEqual(nodes['n']['description'], "Catalysis of the reaction: ATP + H2O = ADP + phosphate. This " - "reaction requires the presence of an actin filament to accelerate" - " release of ADP and phosphate.") - self.assertEqual(nodes['n']['category'], "molecular_function") - - conn.close() - - def test_pathway_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("REACT:R-HSA-69895") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "REACT:R-HSA-69895") - self.assertEqual(nodes['n']['name'], "Transcriptional activation of cell cycle inhibitor p21 ") - self.assertEqual(nodes['n']['description'], "Both p53-independent and p53-dependent mechanisms of induction of " - "p21 mRNA have been demonstrated. p21 is transcriptionally " - "activated by p53 after DNA damage (el-Deiry et al., 1993).") - self.assertEqual(nodes['n']['category'], "pathway") - - conn.close() - - def test_phenotypic_feature_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("HP:0010559") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "HP:0010559") - self.assertEqual(nodes['n']['name'], "Vertical clivus") - self.assertEqual(nodes['n']['description'], "An abnormal vertical orientation of the clivus (which normally " - "forms a kind of slope from the sella turcica down to the region " - "of the foramen magnum).") - self.assertEqual(nodes['n']['category'], "phenotypic_feature") - - conn.close() - - def test_protein_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_node("Q8IWB1") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "Q8IWB1") - self.assertEqual(nodes['n']['name'], "inositol 1,4,5-trisphosphate receptor interacting protein") - self.assertEqual(nodes['n']['description'], "This gene encodes a membrane-associated protein that binds the " - "inositol 1,4,5-trisphosphate receptor (ITPR). The encoded protein" - " enhances the sensitivity of ITPR to intracellular calcium " - "signaling. Alternative splicing results in multiple transcript " - "variants. [provided by RefSeq, Dec 2012].") - self.assertEqual(nodes['n']['category'], "protein") - self.assertEqual(nodes['n']['id'], "UniProtKB:Q8IWB1") - - conn.close() - - def test_affects_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("DOID:653") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("GO:0009117") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("affects", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'Monarch_SciGraph') - self.assertEqual(result['r']['relation'], 'disease_causes_disruption_of') - - conn.close() - - def test_capable_of_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("UBERON:0001004") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("GO:0003016") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("capable_of", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'Monarch_SciGraph') - self.assertEqual(result['r']['relation'], 'capable_of') - - conn.close() - - def test_causes_or_contributes_to_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("CHEMBL601719") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("HP:0000975") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("causes_or_contributes_to", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'SIDER') - self.assertEqual(result['r']['relation'], 'causes_or_contributes_to') - - conn.close() - - def test_contraindicated_for_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("CHEMBL945") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("HP:0011106") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("contraindicated_for", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'MyChem.info') - self.assertEqual(result['r']['relation'], 'contraindicated_for') - - conn.close() - - def test_expressed_in_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("Q6VY07") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("UBERON:0002082") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("expressed_in", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'BioLink') - self.assertEqual(result['r']['relation'], 'expressed_in') - - conn.close() - - def test_gene_associated_with_condition_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("P21397") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("DOID:0060693") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("gene_associated_with_condition", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'DisGeNet') - self.assertEqual(result['r']['relation'], 'gene_associated_with_condition') - - conn.close() - - def test_gene_mutations_contribute_to_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("Q7Z6L0") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("OMIM:128200") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("gene_mutations_contribute_to", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'OMIM') - self.assertEqual(result['r']['relation'], 'gene_mutations_contribute_to') - - conn.close() - - def test_has_part_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("UBERON:0001037") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("GO:0045095") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("has_part", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'Monarch_SciGraph') - self.assertEqual(result['r']['relation'], 'has_part') - - conn.close() - - def test_has_phenotype_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("DOID:0050177") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("HP:0011447") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("has_phenotype", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'BioLink') - self.assertEqual(result['r']['relation'], 'has_phenotype') - - conn.close() - - def test_indicated_for_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("CHEMBL1200979") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("HP:0002590") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("indicated_for", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'MyChem.info') - self.assertEqual(result['r']['relation'], 'indicated_for') - - conn.close() - - def test_involved_in_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("Q9UQ53") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("GO:0006491") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("involved_in", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'gene_ontology') - self.assertEqual(result['r']['relation'], 'involved_in') - - conn.close() - - def test_negatively_regulates_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("CHEMBL449158") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("Q7Z6L0") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("negatively_regulates", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'DGIdb;MyCancerGenomeClinicalTrial') - self.assertEqual(result['r']['relation'], 'inhibitor') - - conn.close() - - def test_participates_in_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("Q9UJX3") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("REACT:R-HSA-400253") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("participates_in", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'reactome') - self.assertEqual(result['r']['relation'], 'participates_in') - - conn.close() - - def test_physically_interacts_with_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("P41235") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("Q9UQ53") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("physically_interacts_with", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'PC2') - self.assertEqual(result['r']['relation'], 'physically_interacts_with') - - conn.close() - - def test_positively_regulates_with_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("CHEMBL1451") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("P04150") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("positively_regulates", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'DGIdb;GuideToPharmacologyInteractions') - self.assertEqual(result['r']['relation'], 'agonist') - - conn.close() - - def test_regulates_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("Q03052") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("Q9UQ53") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("regulates", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'PC2') - self.assertEqual(result['r']['relation'], 'regulates_expression_of') - - conn.close() - - def test_subclass_of_relationships(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - # get the source node - nodes = conn.get_node("GO:1901515") - s_uuid = nodes['n']['UUID'] - - # get the target node - nodes = conn.get_node("GO:0022857") - t_uuid = nodes['n']['UUID'] - - result = conn.get_relationship("subclass_of", s_uuid, t_uuid) - - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'gene_ontology') - self.assertEqual(result['r']['relation'], 'subclass_of') - - conn.close() - - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/Neo4jConnectionTests.py b/code/reasoningtool/kg-construction/tests/Neo4jConnectionTests.py deleted file mode 100644 index 131d57d26..000000000 --- a/code/reasoningtool/kg-construction/tests/Neo4jConnectionTests.py +++ /dev/null @@ -1,208 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from Neo4jConnection import Neo4jConnection - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../../") # code directory -from RTXConfiguration import RTXConfiguration - -class Neo4jConnectionTestCase(unittest.TestCase): - - rtxConfig = RTXConfiguration() - - def test_get_pathway_node(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_pathway_node("REACT:R-HSA-8866654") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['id'], "REACT:R-HSA-8866654") - - conn.close() - - def test_get_pathway_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_pathway_nodes() - - self.assertIsNotNone(nodes) - self.assertLess(0, len(nodes)) - - conn.close() - - def test_get_protein_node(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_protein_node("UniProtKB:P53814") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['id'], "UniProtKB:P53814") - - conn.close() - - def test_get_protein_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_protein_nodes() - - self.assertIsNotNone(nodes) - self.assertLess(0, len(nodes)) - - conn.close() - - def test_get_microRNA_node(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_microRNA_node("NCBIGene:100616151") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['id'], "NCBIGene:100616151") - - conn.close() - - def test_get_microRNA_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_microRNA_nodes() - - self.assertIsNotNone(nodes) - self.assertLess(0, len(nodes)) - - conn.close() - - def test_get_chemical_substance_node(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_chemical_substance_node("CHEMBL1350") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['rtx_name'], "CHEMBL1350") - - conn.close() - - def test_get_chemical_substance_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_chemical_substance_nodes() - - self.assertIsNotNone(nodes) - self.assertLess(0, len(nodes)) - conn.close() - - def test_get_bio_process_node(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_bio_process_node("GO:0097289") - - self.assertIsNotNone(nodes) - self.assertEqual(nodes['n']['id'], "GO:0097289") - - conn.close() - - def test_get_bio_process_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_bio_process_nodes() - - self.assertIsNotNone(nodes) - self.assertLess(0, len(nodes)) - - conn.close() - - def test_get_node_names(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - names = conn.get_node_names('disease') - self.assertIsNotNone(names) - self.assertEqual(len(names), 19573) - - names = conn.get_node_names('chemical_substance') - self.assertIsNotNone(names) - self.assertEqual(len(names), 2226) - - conn.close() - - def test_get_cellular_component_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_cellular_component_nodes() - print(len(nodes)) - self.assertIsNotNone(nodes) - self.assertLess(0, len(nodes)) - - conn.close() - - def test_get_molecular_function_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_molecular_function_nodes() - print(len(nodes)) - self.assertIsNotNone(nodes) - self.assertLess(0, len(nodes)) - - conn.close() - - def test_get_metabolite_nodes(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_metabolite_nodes() - print(len(nodes)) - self.assertIsNotNone(nodes) - self.assertLess(0, len(nodes)) - - conn.close() - - # def test_create_disease_has_phenotype(self): - # f = open('config.json', 'r') - # config_data = f.read() - # f.close() - # config = json.loads(config_data) - # - # conn = Neo4jConnection(config['url'], config['username'], config['password']) - # - # # fake data - # array = [{"d_id": "OMIM:605543", "p_id": 'HP:0000726'}, - # {"d_id": "OMIM:605543", "p_id": 'HP:0000738'}, - # {"d_id": "OMIM:605543", "p_id": 'HP:0001278'}, - # {"d_id": "OMIM:605543", "p_id": 'HP:0001300'}, - # {"d_id": "DOID:3218", "p_id": 'HP:0000476'}, - # {"d_id": "DOID:3218", "p_id": 'HP:0000952'}] - # - # conn.create_disease_has_phenotype(array) - # conn.close() - - def test_count_has_phenotype_relation(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - result = conn.count_has_phenotype_relation({"d_id": "DOID:3218", "p_id": "HP:0002245"}) - self.assertIsNotNone(result) - self.assertEqual(1, result) - - result = conn.count_has_phenotype_relation({"d_id": "DOID:3218", "p_id": "HP:0002244"}) - self.assertIsNotNone(result) - self.assertEqual(0, result) - - conn.close() - - def test_get_relationship(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - result = conn.get_relationship("affects", "16364fa8-96e0-11e8-b6f4-0242ac110002", - "d2cc6c24-96e0-11e8-b6f4-0242ac110002") - self.assertIsNotNone(result) - self.assertEqual(result['r']['provided_by'], 'Monarch_SciGraph') - self.assertEqual(result['r']['relation'], 'disease_causes_disruption_of') - - conn.close() - - -if __name__ == '__main__': - unittest.main() - diff --git a/code/reasoningtool/kg-construction/tests/QueryBioLinkExtendedTests.py b/code/reasoningtool/kg-construction/tests/QueryBioLinkExtendedTests.py deleted file mode 100644 index 7042b1977..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryBioLinkExtendedTests.py +++ /dev/null @@ -1,50 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryBioLinkExtended import QueryBioLinkExtended as QBLEx - - -def get_from_test_file(key): - f = open('query_test_data.json', 'r') - test_data = f.read() - try: - test_data_dict = json.loads(test_data) - f.close() - return test_data_dict[key] - except ValueError: - f.close() - return None - - -class QueryBioLinkExtendedTestCase(unittest.TestCase): - - def test_get_anatomy_entity(self): - extended_info_json = QBLEx.get_anatomy_entity('UBERON:0004476') - self.assertIsNotNone(extended_info_json) - if extended_info_json != "UNKNOWN": - self.assertEqual(json.loads(extended_info_json), json.loads(get_from_test_file('UBERON:0004476'))) - - def test_get_phenotype_entity(self): - extended_info_json = QBLEx.get_phenotype_entity('HP:0011515') - self.assertIsNotNone(extended_info_json) - if extended_info_json != "UNKNOWN": - self.assertEqual(json.loads(extended_info_json), json.loads(get_from_test_file('HP:0011515'))) - - def test_get_disease_entity(self): - extended_info_json = QBLEx.get_disease_entity('DOID:3965') - self.assertIsNotNone(extended_info_json) - if extended_info_json != "UNKNOWN": - self.assertEqual(json.loads(extended_info_json), json.loads(get_from_test_file('DOID:3965'))) - - def test_get_bio_process_entity(self): - extended_info_json = QBLEx.get_bio_process_entity('GO:0097289') - self.assertIsNotNone(extended_info_json) - if extended_info_json != "UNKNOWN": - self.assertEqual(json.loads(extended_info_json), json.loads(get_from_test_file('GO:0097289'))) - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryBioLinkTests.py b/code/reasoningtool/kg-construction/tests/QueryBioLinkTests.py deleted file mode 100644 index d3acd108d..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryBioLinkTests.py +++ /dev/null @@ -1,218 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryBioLink import QueryBioLink as QBL - - -def get_from_test_file(key): - f = open('query_test_data.json', 'r') - test_data = f.read() - try: - test_data_dict = json.loads(test_data) - f.close() - return test_data_dict[key] - except ValueError: - f.close() - return None - - -class QueryBioLinkTestCase(unittest.TestCase): - - def test_get_anatomy_entity(self): - result = QBL.get_anatomy_entity('UBERON:0004476') - self.assertIsNotNone(result) - if result != "None": - self.assertDictEqual(json.loads(result), json.loads(get_from_test_file('UBERON:0004476'))) - - # invalid id, code == 500 - result = QBL.get_anatomy_entity('UBERON:000447600') - self.assertIsNotNone(result) - self.assertEqual(result, "None") - - def test_get_phenotype_entity(self): - result = QBL.get_phenotype_entity('HP:0011515') - self.assertIsNotNone(result) - if result != "None": - self.assertEqual(json.loads(result), json.loads(get_from_test_file('HP:0011515'))) - - # invalid id, code == 500 - result = QBL.get_phenotype_entity('HP:00115150') - self.assertIsNotNone(result) - self.assertEqual(result, "None") - - def test_get_disease_entity(self): - result = QBL.get_disease_entity('DOID:3965') - self.assertIsNotNone(result) - if result != "None": - self.assertEqual(json.loads(result), json.loads(get_from_test_file('DOID:3965'))) - - # invalid id, code == 500 - result = QBL.get_disease_entity('DOID:39650') - self.assertIsNotNone(result) - self.assertEqual(result, "None") - - def test_get_bio_process_entity(self): - result = QBL.get_bio_process_entity('GO:0097289') - self.assertIsNotNone(result) - if result != "None": - self.assertEqual(json.loads(result), json.loads(get_from_test_file('GO:0097289'))) - - # invalid id, code == 500 - result = QBL.get_bio_process_entity('GO:00972890') - self.assertIsNotNone(result) - self.assertEqual(result, "None") - - def test_get_label_for_disease(self): - # unknown_resp = QBL.get_label_for_disease('XXX') - # self.assertEqual(unknown_resp, 'UNKNOWN') - - chlr_label = QBL.get_label_for_disease('DOID:1498') # cholera - # self.assertIsNone(chlr_label) - self.assertEqual(chlr_label, "cholera") - - pd_label = QBL.get_label_for_disease('OMIM:605543') # Parkinson’s disease 4 - self.assertEqual(pd_label, "autosomal dominant Parkinson disease 4") - - def test_get_phenotypes_for_disease_desc(self): - ret_dict = QBL.get_phenotypes_for_disease_desc('OMIM:605543') # Parkinson’s disease 4 - - known_dict = {'HP:0000726': 'Dementia', - 'HP:0001824': 'Weight loss', - 'HP:0002459': 'Dysautonomia', - 'HP:0100315': 'Lewy bodies', - 'HP:0011999': 'Paranoia', - 'HP:0001278': 'Orthostatic hypotension', - 'HP:0000738': 'Hallucinations', - 'HP:0001300': 'Parkinsonism'} - - self.assertDictEqual(ret_dict, known_dict) - - def test_get_diseases_for_gene_desc(self): - empty_dict = QBL.get_diseases_for_gene_desc('NCBIGene:407053') # MIR96 - self.assertEqual(len(empty_dict), 0) - - # TODO find an NCBIGene that `get_diseases_for_gene_desc` would return a non-empty result - - def test_get_genes_for_disease_desc(self): - pd_genes = QBL.get_genes_for_disease_desc('OMIM:605543') # Parkinson’s disease 4 - self.assertEqual(len(pd_genes), 1) - self.assertEqual(pd_genes[0], 'HGNC:11138') - - def test_get_label_for_phenotype(self): - mcd_label = QBL.get_label_for_phenotype('HP:0000003') # Multicystic kidney dysplasia - self.assertEqual(mcd_label, "Multicystic kidney dysplasia") - - def test_get_phenotypes_for_gene(self): - # NEK1, NIMA related kinase 1 - nek1_list = QBL.get_phenotypes_for_gene('NCBIGene:4750') - known_list = ['HP:0000003', 'HP:0000023', 'HP:0000054', 'HP:0000062', - 'HP:0000089', 'HP:0000105', 'HP:0000110', 'HP:0000171', - 'HP:0000204', 'HP:0000248', 'HP:0000256', 'HP:0000286', - 'HP:0000348', 'HP:0000358', 'HP:0000369', 'HP:0000377', - 'HP:0000470', 'HP:0000695', 'HP:0000773', 'HP:0000774', - 'HP:0000800', 'HP:0000882', 'HP:0000888', 'HP:0000895', - 'HP:0001169', 'HP:0001274', 'HP:0001302', 'HP:0001320', - 'HP:0001360', 'HP:0001395', 'HP:0001405', 'HP:0001511', - 'HP:0001538', 'HP:0001539', 'HP:0001541', 'HP:0001561', - 'HP:0001629', 'HP:0001631', 'HP:0001643', 'HP:0001655', - 'HP:0001744', 'HP:0001762', 'HP:0001769', 'HP:0001773', - 'HP:0001789', 'HP:0001831', 'HP:0002023', 'HP:0002089', - 'HP:0002093', 'HP:0002240', 'HP:0002323', 'HP:0002350', - 'HP:0002557', 'HP:0002566', 'HP:0002979', 'HP:0002980', - 'HP:0003016', 'HP:0003022', 'HP:0003026', 'HP:0003038', - 'HP:0003811', 'HP:0005054', 'HP:0005257', 'HP:0005349', - 'HP:0005766', 'HP:0005817', 'HP:0005873', 'HP:0006426', - 'HP:0006488', 'HP:0006610', 'HP:0006956', 'HP:0008501', - 'HP:0008873', 'HP:0009381', 'HP:0010306', 'HP:0010442', - 'HP:0010454', 'HP:0010579', 'HP:0012368', 'HP:0100259', - 'HP:0100750'] - - - # Sequence does not matter here - self.assertSetEqual(set(nek1_list), set(known_list)) - - def test_get_phenotypes_for_gene_desc(self): - # Test for issue #22 - # CFTR, cystic fibrosis transmembrane conductance regulator - cftr_dict = QBL.get_phenotypes_for_gene_desc('NCBIGene:1080') - - known_dict = {'HP:0000952': 'Jaundice', - 'HP:0011227': 'Elevated C-reactive protein level', - 'HP:0030247': 'Splanchnic vein thrombosis', - 'HP:0012379': 'Abnormal enzyme/coenzyme activity', - 'HP:0001974': 'Leukocytosis'} - - self.assertDictEqual(cftr_dict, known_dict) - - def test_get_anatomies_for_gene(self): - mir96_dict = QBL.get_anatomies_for_gene('NCBIGene:407053') # MIR96 - - known_dict = {'UBERON:0000007': 'pituitary gland', - 'UBERON:0001301': 'epididymis', - 'UBERON:0000074': 'renal glomerulus', - 'UBERON:0000006': 'islet of Langerhans'} - - self.assertDictEqual(mir96_dict, known_dict) - - def test_get_genes_for_anatomy(self): - iol_list = QBL.get_genes_for_anatomy('UBERON:0000006') # islet of Langerhans - known_list = ['HGNC:1298', 'ENSEMBL:ENSG00000221639', 'HGNC:6357', 'HGNC:37207', - 'HGNC:378', 'MGI:108094', 'HGNC:40742', 'MGI:3694898', 'MGI:3697701', - 'HGNC:16713', 'ENSEMBL:ENSG00000260329', 'MGI:1351502', 'MGI:1277193', - 'MGI:1914926', 'HGNC:6081', 'HGNC:29161', 'HGNC:16523', 'HGNC:16015', - 'MGI:1920185', 'HGNC:24483', 'HGNC:2458', 'HGNC:23472', 'HGNC:25538', - 'MGI:1924233', 'HGNC:31602', 'HGNC:7517', 'HGNC:28510', 'HGNC:9772', - 'HGNC:41140', 'HGNC:4057', 'HGNC:17407', 'HGNC:29859', 'HGNC:51653', - 'HGNC:20711', 'MGI:88588', 'MGI:3642232', 'HGNC:42000', 'MGI:1916998', - 'HGNC:491', 'HGNC:28177', 'MGI:2177763', 'MGI:1914721', 'HGNC:18003', - 'HGNC:13812', 'HGNC:23817', 'HGNC:13452', 'MGI:2148019', 'HGNC:3391', - 'HGNC:15518', 'HGNC:28145', 'MGI:96432', 'HGNC:23488', 'ENSEMBL:ENSG00000233895', - 'HGNC:28695', 'MGI:3036267', 'MGI:5477162', 'MGI:88175', 'HGNC:10808', - 'HGNC:23467', 'MGI:109589', 'HGNC:26777', 'MGI:108471', 'HGNC:3528', 'HGNC:18817', - 'ENSEMBL:ENSG00000177764', 'HGNC:5192', 'MGI:109124', 'MGI:1336885', 'MGI:88610', - 'HGNC:25629', 'HGNC:17859', 'MGI:2685955', 'HGNC:21222', 'HGNC:52164', 'HGNC:29612', - 'HGNC:24913', 'MGI:2159649', 'HGNC:6532', 'HGNC:29125', 'HGNC:1706', 'MGI:1917904', - 'HGNC:1388', 'HGNC:1960', 'ENSEMBL:ENSG00000260526', 'HGNC:16275', 'MGI:1922469', - 'HGNC:3518', 'HGNC:6172', 'MGI:97010', 'ENSEMBL:ENSG00000121848', 'HGNC:24045', - 'HGNC:6003', 'HGNC:24172', 'MGI:2429955', 'HGNC:6130', 'MGI:1927126', 'HGNC:11513', - 'MGI:1922935', 'MGI:1922977', 'HGNC:26460'] - - # Sequence does not matter here - self.assertSetEqual(set(iol_list), set(known_list)) - - def test_get_anatomies_for_phenotype(self): - mcd_dict = QBL.get_anatomies_for_phenotype('HP:0000003') # Multicystic kidney dysplasia - - known_dict = {'UBERON:0002113': 'kidney'} - - self.assertDictEqual(mcd_dict, known_dict) - - def test_map_disease_to_phenotype(self): - - results = QBL.map_disease_to_phenotype("OMIM:605543") - self.assertIsNotNone(results) - self.assertEqual(['HP:0000726', 'HP:0000738', 'HP:0001278', 'HP:0001300', - 'HP:0001824', 'HP:0002459', 'HP:0011999', 'HP:0100315'], results) - - results = QBL.map_disease_to_phenotype("DOID:3218") - self.assertIsNotNone(results) - self.assertEqual(57, len(results)) - - # invalid parameter - results = QBL.map_disease_to_phenotype(605543) - self.assertEqual([], results) - - # invalid parameter - results = QBL.map_disease_to_phenotype("OMIM_605543") - self.assertEqual([], results) - - # invalid parameter - results = QBL.map_disease_to_phenotype("DOID_14477") - self.assertEqual([], results) - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryCOHDTests.py b/code/reasoningtool/kg-construction/tests/QueryCOHDTests.py deleted file mode 100644 index b0834d5b4..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryCOHDTests.py +++ /dev/null @@ -1,842 +0,0 @@ -from unittest import TestCase - -import os, sys - -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0, parentdir) - -from QueryCOHD import QueryCOHD - - -class QueryCOHDTestCases(TestCase): - def test_find_concept_ids(self): - # result = QueryCOHD.find_concept_ids("cancer", "Condition", dataset_id=1, min_count=0) - # self.assertIsNotNone(result) - # self.assertEqual(len(result), 84) - # self.assertEqual(result[0], {'concept_class_id': 'Clinical Finding', - # 'concept_code': '92546004', - # 'concept_count': 368.0, - # 'concept_id': 192855, - # 'concept_name': 'Cancer in situ of urinary bladder', 'domain_id': 'Condition', - # 'vocabulary_id': 'SNOMED'}) - - # default dataset_id and min_count - result = QueryCOHD.find_concept_ids("cancer", "Condition") - self.assertIsNotNone(result) - self.assertEqual(len(result), 3) - self.assertEqual(result[0], {'concept_class_id': 'Clinical Finding', - 'concept_code': '92546004', - 'concept_count': 368.0, - 'concept_id': 192855, - 'concept_name': 'Cancer in situ of urinary bladder', 'domain_id': 'Condition', - 'vocabulary_id': 'SNOMED'}) - - # default dataset_id and domain - result = QueryCOHD.find_concept_ids("cancer") - self.assertIsNotNone(result) - self.assertEqual(len(result), 37) - self.assertEqual(result[0], {'concept_class_id': 'Procedure', - 'concept_code': '15886004', - 'concept_count': 4195.0, - 'concept_id': 4048727, - 'concept_name': 'Screening for cancer', - 'domain_id': 'Procedure', - 'vocabulary_id': 'SNOMED'}) - - # invalid name value - result = QueryCOHD.find_concept_ids("cancer1", "Condition") - self.assertEqual(result, []) - - # invalid domain value - result = QueryCOHD.find_concept_ids("cancer", "Conditi") - self.assertEqual(result, []) - - # timeout case (backend timeout issue has been fixed) - result = QueryCOHD.find_concept_ids("ibuprofen", "Drug", dataset_id=1, min_count=0) - self.assertIsNotNone(result) - self.assertEqual(len(result), 1000) - self.assertEqual(result[0], {'concept_class_id': 'Clinical Drug', - 'concept_code': '197806', - 'concept_count': 115101, - 'concept_id': 19019073, - 'concept_name': 'Ibuprofen 600 MG Oral Tablet', - 'domain_id': 'Drug', - 'vocabulary_id': 'RxNorm'}) - - def test_get_paired_concept_freq(self): - result = QueryCOHD.get_paired_concept_freq("2008271", "192855", 1) - self.assertIsNotNone(result) - self.assertEqual(result['concept_frequency'], 0.000005585247351056813) - self.assertEqual(result['concept_count'], 10) - - # default dataset_id - result = QueryCOHD.get_paired_concept_freq("2008271", "192855") - self.assertIsNotNone(result) - self.assertEqual(result['concept_frequency'], 0.000005585247351056813) - self.assertEqual(result['concept_count'], 10) - - # invalid ID value - result = QueryCOHD.get_paired_concept_freq("2008271", "2008271") - self.assertEqual(result, {}) - - # invalid parameter type - result = QueryCOHD.get_paired_concept_freq(2008271, 192855) - self.assertEqual(result, {}) - - def test_get_individual_concept_freq(self): - result = QueryCOHD.get_individual_concept_freq("192855", 1) - self.assertIsNotNone(result) - self.assertEqual(result['concept_frequency'], 0.0002055371025188907) - self.assertEqual(result['concept_count'], 368) - - # default dataset id - result = QueryCOHD.get_individual_concept_freq("192855") - self.assertIsNotNone(result) - self.assertEqual(result['concept_frequency'], 0.0002055371025188907) - self.assertEqual(result['concept_count'], 368) - - # invalid ID value - result = QueryCOHD.get_individual_concept_freq("0", 1) - self.assertEqual(result, {}) - - # invalid concept_id type - result = QueryCOHD.get_individual_concept_freq(2008271, 1) - self.assertEqual(result, {}) - - def test_get_associated_concept_domain_freq(self): - result = QueryCOHD.get_associated_concept_domain_freq('192855', 'Procedure', 2) - self.assertIsNotNone(result) - self.assertEqual(result[0]['concept_frequency'], 0.0002508956097182718) - self.assertEqual(len(result), 655) - - # default dataset_id - result = QueryCOHD.get_associated_concept_domain_freq('192855', 'Procedure') - self.assertIsNotNone(result) - self.assertEqual(result[0]['concept_frequency'], 0.00016867447000191573) - self.assertEqual(len(result), 159) - - # invalid concept ID value - result = QueryCOHD.get_associated_concept_domain_freq("0", "drug") - self.assertEqual(result, []) - - # invalid domain value - result = QueryCOHD.get_associated_concept_domain_freq("192855", "dru") - self.assertEqual(result, []) - - # invalid concept type - result = QueryCOHD.get_associated_concept_domain_freq(192855, "drug") - self.assertEqual(result, []) - - def test_get_concepts(self): - result = QueryCOHD.get_concepts(["192855", "2008271"]) - self.assertIsNotNone(result) - self.assertEqual(len(result), 2) - self.assertEqual(result, [{'concept_class_id': 'Clinical Finding', 'concept_code': '92546004', - 'concept_id': 192855, 'concept_name': 'Cancer in situ of urinary bladder', - 'domain_id': 'Condition', 'vocabulary_id': 'SNOMED'}, - {'concept_class_id': '4-dig billing code', 'concept_code': '99.25', - 'concept_id': 2008271, 'concept_name': 'Injection or infusion of cancer ' - 'chemotherapeutic substance', - 'domain_id': 'Procedure', 'vocabulary_id': 'ICD9Proc'}]) - - result = QueryCOHD.get_concepts(["192855"]) - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'concept_class_id': 'Clinical Finding', 'concept_code': '92546004', - 'concept_id': 192855, 'concept_name': 'Cancer in situ of urinary bladder', - 'domain_id': 'Condition', 'vocabulary_id': 'SNOMED'}]) - - # invalid concept_id type - result = QueryCOHD.get_concepts(["192855", 2008271]) - self.assertEqual(result, []) - - def test_get_xref_from_OMOP(self): - result = QueryCOHD.get_xref_from_OMOP("192855", "UMLS", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 6) - self.assertEqual(result[0], {"intermediate_omop_concept_code": "92546004", - "intermediate_omop_concept_id": 192855, - "intermediate_omop_concept_name": "Cancer in situ of urinary bladder", - "intermediate_omop_vocabulary_id": "SNOMED", - "intermediate_oxo_curie": "SNOMEDCT:92546004", - "intermediate_oxo_label": "Cancer in situ of urinary bladder", - "omop_distance": 0, - "oxo_distance": 1, - "source_omop_concept_code": "92546004", - "source_omop_concept_id": 192855, - "source_omop_concept_name": "Cancer in situ of urinary bladder", - "source_omop_vocabulary_id": "SNOMED", - "target_curie": "UMLS:C0154091", - "target_label": "Cancer in situ of urinary bladder", - "total_distance": 1 - }) - - # default distance - result = QueryCOHD.get_xref_from_OMOP("192855", "UMLS") - self.assertIsNotNone(result) - self.assertEqual(len(result), 6) - self.assertEqual(result[0], {"intermediate_omop_concept_code": "92546004", - "intermediate_omop_concept_id": 192855, - "intermediate_omop_concept_name": "Cancer in situ of urinary bladder", - "intermediate_omop_vocabulary_id": "SNOMED", - "intermediate_oxo_curie": "SNOMEDCT:92546004", - "intermediate_oxo_label": "Cancer in situ of urinary bladder", - "omop_distance": 0, - "oxo_distance": 1, - "source_omop_concept_code": "92546004", - "source_omop_concept_id": 192855, - "source_omop_concept_name": "Cancer in situ of urinary bladder", - "source_omop_vocabulary_id": "SNOMED", - "target_curie": "UMLS:C0154091", - "target_label": "Cancer in situ of urinary bladder", - "total_distance": 1 - }) - - # invalid concept id - result = QueryCOHD.get_xref_from_OMOP("1928551", "UMLS", 2) - self.assertEqual(result, []) - - # invalid mapping_targets - result = QueryCOHD.get_xref_from_OMOP("1928551", "UMS", 2) - self.assertEqual(result, []) - - # invalid distance format - result = QueryCOHD.get_xref_from_OMOP("1928551", "UMLS", "2") - self.assertEqual(result, []) - - def test_get_xref_to_OMOP(self): - result = QueryCOHD.get_xref_to_OMOP("DOID:8398", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 3) - self.assertEqual(result[0], {'intermediate_oxo_id': 'ICD9CM:715.3', 'intermediate_oxo_label': '', - 'omop_concept_name': 'Localized osteoarthrosis uncertain if primary OR secondary', - 'omop_distance': 1, 'omop_domain_id': 'Condition', 'omop_standard_concept_id': 72990, - 'oxo_distance': 1, 'source_oxo_id': 'DOID:8398', 'source_oxo_label': 'osteoarthritis', - 'total_distance': 2}) - - # default distance - result = QueryCOHD.get_xref_to_OMOP("DOID:8398") - self.assertIsNotNone(result) - self.assertEqual(len(result), 3) - self.assertEqual(result[0], {'intermediate_oxo_id': 'ICD9CM:715.3', 'intermediate_oxo_label': '', - 'omop_concept_name': 'Localized osteoarthrosis uncertain if primary OR secondary', - 'omop_distance': 1, 'omop_domain_id': 'Condition', - 'omop_standard_concept_id': 72990, - 'oxo_distance': 1, 'source_oxo_id': 'DOID:8398', - 'source_oxo_label': 'osteoarthritis', - 'total_distance': 2}) - - # default distance - result = QueryCOHD.get_xref_to_OMOP("DOID:8398") - self.assertIsNotNone(result) - self.assertEqual(len(result), 3) - - # invalid curie id - result = QueryCOHD.get_xref_to_OMOP("DOID:83981", 2) - self.assertEqual(result, []) - - # invalid distance format - result = QueryCOHD.get_xref_to_OMOP("DOID:8398", "2") - self.assertEqual(result, []) - - def test_get_map_from_standard_concept_id(self): - result = QueryCOHD.get_map_from_standard_concept_id("72990", "ICD9CM") - self.assertIsNotNone(result) - self.assertEqual(len(result), 10) - self.assertEqual(result[0], {"concept_class_id": "4-dig nonbill code", "concept_code": "715.3", - "concept_id": 44834979, - "concept_name": "Osteoarthrosis, localized, not specified whether primary or secondary", - "domain_id": "Condition", "standard_concept": None, "vocabulary_id": "ICD9CM" - }) - - # default vocabulary - result = QueryCOHD.get_map_from_standard_concept_id("72990") - self.assertIsNotNone(result) - self.assertEqual(len(result), 12) - self.assertEqual(result[0], {"concept_class_id": "Diagnosis", "concept_code": "116253", "concept_id": 45930832, - "concept_name": "Localized Osteoarthrosis Uncertain If Primary or Secondary", - "domain_id": "Condition", "standard_concept": None, "vocabulary_id": "CIEL"}) - - # invalid concept_id id - result = QueryCOHD.get_map_from_standard_concept_id("DOID:839812", 2) - self.assertEqual(result, []) - - # invalid concept_id format - result = QueryCOHD.get_map_from_standard_concept_id(8398, 2) - self.assertEqual(result, []) - - def test_get_map_to_standard_concept_id(self): - result = QueryCOHD.get_map_to_standard_concept_id("715.3", "ICD9CM") - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result[0], {"source_concept_code": "715.3", "source_concept_id": 44834979, - "source_concept_name": "Osteoarthrosis, localized, not specified whether primary or secondary", - "source_vocabulary_id": "ICD9CM", "standard_concept_id": 72990, - "standard_concept_name": "Localized osteoarthrosis uncertain if primary OR secondary", - "standard_domain_id": "Condition" - }) - - # default vocabulary - result = QueryCOHD.get_map_to_standard_concept_id("715.3") - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result[0], {"source_concept_code": "715.3", "source_concept_id": 44834979, - "source_concept_name": "Osteoarthrosis, localized, not specified whether primary or secondary", - "source_vocabulary_id": "ICD9CM", "standard_concept_id": 72990, - "standard_concept_name": "Localized osteoarthrosis uncertain if primary OR secondary", - "standard_domain_id": "Condition" - }) - - # invalid concept_code id - result = QueryCOHD.get_map_from_standard_concept_id("725.3") - self.assertEqual(result, []) - - # invalid concept_code format - result = QueryCOHD.get_map_from_standard_concept_id(725.3) - self.assertEqual(result, []) - - def test_get_vocabularies(self): - result = QueryCOHD.get_vocabularies() - self.assertIsNotNone(result) - self.assertEqual(len(result), 73) - self.assertEqual(result[0]['vocabulary_id'], 'ABMS') - self.assertEqual(result[1]['vocabulary_id'], 'AMT') - - def test_get_associated_concept_freq(self): - result = QueryCOHD.get_associated_concept_freq("192855", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 2735) - self.assertEqual(result[0], {'associated_concept_id': 197508, - 'associated_concept_name': 'Malignant tumor of urinary bladder', - 'associated_domain_id': 'Condition', - 'concept_count': 1477, - 'concept_frequency': 0.0002753141274545969, - 'concept_id': 192855, - 'dataset_id': 2}) - - # default dataset_id - result = QueryCOHD.get_associated_concept_freq("192855") - self.assertIsNotNone(result) - self.assertEqual(len(result), 768) - self.assertEqual(result[0], {'associated_concept_id': 2213216, - 'associated_concept_name': 'Cytopathology, selective cellular enhancement technique with interpretation (eg, liquid based slide preparation method), except cervical or vaginal', - 'associated_domain_id': 'Measurement', - 'concept_count': 330, - 'concept_frequency': 0.0001843131625848748, - 'concept_id': 192855, - 'dataset_id': 1}) - - # invalid conecpt_id value - result = QueryCOHD.get_associated_concept_freq("1928551") - self.assertEqual(result, []) - - # invalid dataset_id value - result = QueryCOHD.get_associated_concept_freq("192855", 10) - self.assertEqual(result, []) - - # invalid concept format - result = QueryCOHD.get_associated_concept_freq(192855) - self.assertEqual(result, []) - - # invalid dataset_id format - result = QueryCOHD.get_associated_concept_freq("192855", "1") - self.assertEqual(result, []) - - def test_get_most_frequent_concepts(self): - # default domain and dataset_id - result = QueryCOHD.get_most_frequent_concepts(10) - self.assertIsNotNone(result) - self.assertEqual(len(result), 10) - self.assertEqual(result[0], {'concept_class_id': 'Undefined', - 'concept_count': 1189172, - 'concept_frequency': 0.6641819762950932, - 'concept_id': 44814653, - 'concept_name': 'Unknown', - 'dataset_id': 1, - 'domain_id': 'Observation', - 'vocabulary_id': 'PCORNet'}) - - # default dataset_id - result = QueryCOHD.get_most_frequent_concepts(10, "Condition") - self.assertIsNotNone(result) - self.assertEqual(len(result), 10) - self.assertEqual(result[0], { - 'concept_class_id': 'Clinical Finding', - 'concept_count': 233790, - 'concept_frequency': 0.1305774978203572, - 'concept_id': 320128, - 'concept_name': 'Essential hypertension', - 'dataset_id': 1, - 'domain_id': 'Condition', - 'vocabulary_id': 'SNOMED'}) - - # no default value - result = QueryCOHD.get_most_frequent_concepts(10, "Condition", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 10) - self.assertEqual(result[0], {'concept_class_id': 'Clinical Finding', - 'concept_count': 459776, - 'concept_frequency': 0.08570265962394365, - 'concept_id': 320128, - 'concept_name': 'Essential hypertension', - 'dataset_id': 2, - 'domain_id': 'Condition', - 'vocabulary_id': 'SNOMED'}) - - # invalid num value - result = QueryCOHD.get_most_frequent_concepts(-10) - self.assertEqual(result, []) - - # invalid num type - result = QueryCOHD.get_most_frequent_concepts("10") - self.assertEqual(result, []) - - # invalid domain value - result = QueryCOHD.get_most_frequent_concepts(10, "Condition1") - self.assertEqual(result, []) - - # invalid domain type - result = QueryCOHD.get_most_frequent_concepts(10, 1, 2) - self.assertEqual(result, []) - - # invalid dataset_id value - result = QueryCOHD.get_most_frequent_concepts(10, "Condition", 10) - self.assertEqual(result, []) - - # invalid dataset_id type - result = QueryCOHD.get_most_frequent_concepts(10, "Condition", "2") - self.assertEqual(result, []) - - # # num == 0 - # result = QueryCOHD.get_most_frequent_concepts(0, "Condition", 2) - # self.assertEqual(result, []) - - def test_get_chi_square(self): - # default dataset_id - result = QueryCOHD.get_chi_square("192855", "2008271", "Condition") - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'chi_square': 306.2816108187519, - 'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'dataset_id': 1, - 'p-value': 1.4101531778039801e-68}]) - - # dataset_id == 2 - result = QueryCOHD.get_chi_square("192855", "2008271", "Condition", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'chi_square': 7065.7865572100745, - 'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'dataset_id': 2, - 'p-value': 0.0}]) - - # default domain and dataset_id - result = QueryCOHD.get_chi_square("192855", "2008271") - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'chi_square': 306.2816108187519, - 'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'dataset_id': 1, - 'p-value': 1.4101531778039801e-68}]) - - # no concept_id_2, default domain and dataset_id - result = QueryCOHD.get_chi_square("192855") - self.assertIsNotNone(result) - self.assertEqual(len(result), 768) - - # no concept_id_2, default dataset_id - result = QueryCOHD.get_chi_square("192855", "", "Condition") - self.assertIsNotNone(result) - self.assertEqual(len(result), 226) - - # no concept_id_2, dataset_id == 2 - result = QueryCOHD.get_chi_square("192855", "", "Condition", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 991) - - # no concept_id_2, dataset_id == 2, default domain - result = QueryCOHD.get_chi_square("192855", "", "", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 2735) - - # invalid concept_id_1 type - result = QueryCOHD.get_chi_square(192855, "", "", 1) - self.assertEqual(result, []) - - # invalid concept_id_2 type - result = QueryCOHD.get_chi_square("192855", 2008271, "", 1) - self.assertEqual(result, []) - - # invalid dataset_id value - result = QueryCOHD.get_chi_square("192855", "2008271", "condition", 10) - self.assertEqual(result, []) - - def test_get_obs_exp_ratio(self): - # default dataset_id - result = QueryCOHD.get_obs_exp_ratio("192855", "2008271", "Procedure") - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'dataset_id': 1, - 'expected_count': 0.3070724311632227, - 'ln_ratio': 3.483256720088832, - 'observed_count': 10}]) - - # dataset_id == 2 - result = QueryCOHD.get_obs_exp_ratio("192855", "2008271", "Procedure", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'dataset_id': 2, - 'expected_count': 5.171830872499735, - 'ln_ratio': 3.634887899455015, - 'observed_count': 196}]) - # default domain - result = QueryCOHD.get_obs_exp_ratio("192855", "2008271") - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'dataset_id': 1, - 'expected_count': 0.3070724311632227, - 'ln_ratio': 3.483256720088832, - 'observed_count': 10}]) - - # default domain, dataset_id == 2 - result = QueryCOHD.get_obs_exp_ratio("192855", "2008271", "", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'dataset_id': 2, - 'expected_count': 5.171830872499735, - 'ln_ratio': 3.634887899455015, - 'observed_count': 196}]) - - # default concept_id_2, domain and dataset_id - result = QueryCOHD.get_obs_exp_ratio("192855") - self.assertIsNotNone(result) - self.assertEqual(len(result), 768) - - # default concept_id_2 and domain, dataset_id == 2 - result = QueryCOHD.get_obs_exp_ratio("192855", "", "", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 2735) - - # default concept_id_2 and dataset_id - result = QueryCOHD.get_obs_exp_ratio("192855", "", "Procedure") - self.assertIsNotNone(result) - self.assertEqual(len(result), 159) - - # default concept_id_2 - result = QueryCOHD.get_obs_exp_ratio("192855", "", "Procedure", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 655) - - # invalid concept_id_1 type - result = QueryCOHD.get_obs_exp_ratio(192855, "2008271", "", 2) - self.assertEqual(result, []) - - # invalid concept_id_2 type - result = QueryCOHD.get_obs_exp_ratio("192855", 2008271, "", 2) - self.assertEqual(result, []) - - # invalid dataset_id type - result = QueryCOHD.get_obs_exp_ratio("192855", "2008271", "", "2") - self.assertEqual(result, []) - - def test_get_relative_frequency(self): - # default dataset_id - result = QueryCOHD.get_relative_frequency("192855", "2008271", "Procedure") - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'concept_2_count': 1494, - 'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'concept_pair_count': 10, - 'dataset_id': 1, - 'relative_frequency': 0.006693440428380187}]) - - # dataset_id == 2 - result = QueryCOHD.get_relative_frequency("192855", "2008271", "Procedure", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'concept_2_count': 17127, - 'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'concept_pair_count': 196, - 'dataset_id': 2, - 'relative_frequency': 0.011443918958369825}]) - - # default domain - result = QueryCOHD.get_relative_frequency("192855", "2008271") - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'concept_2_count': 1494, - 'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'concept_pair_count': 10, - 'dataset_id': 1, - 'relative_frequency': 0.006693440428380187}]) - - # default domain, dataset_id == 2 - result = QueryCOHD.get_relative_frequency("192855", "2008271", "", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result, [{'concept_2_count': 17127, - 'concept_id_1': 192855, - 'concept_id_2': 2008271, - 'concept_pair_count': 196, - 'dataset_id': 2, - 'relative_frequency': 0.011443918958369825}]) - - # default concept_id_2, domain and dataset_id - result = QueryCOHD.get_relative_frequency("192855") - self.assertIsNotNone(result) - self.assertEqual(len(result), 768) - - # default concept_id_2 and domain, dataset_id == 2 - result = QueryCOHD.get_relative_frequency("192855", "", "", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 2735) - - # default concept_id_2 and dataset_id - result = QueryCOHD.get_relative_frequency("192855", "", "Procedure") - self.assertIsNotNone(result) - self.assertEqual(len(result), 159) - - # default concept_id_2 - result = QueryCOHD.get_relative_frequency("192855", "", "Procedure", 2) - self.assertIsNotNone(result) - self.assertEqual(len(result), 655) - - # invalid concept_id_1 type - result = QueryCOHD.get_relative_frequency(192855, "2008271", "", 2) - self.assertEqual(result, []) - - # invalid concept_id_2 type - result = QueryCOHD.get_relative_frequency("192855", 2008271, "", 2) - self.assertEqual(result, []) - - # invalid dataset_id type - result = QueryCOHD.get_relative_frequency("192855", "2008271", "", "2") - self.assertEqual(result, []) - - def test_get_datasets(self): - result = QueryCOHD.get_datasets() - self.assertIsNotNone(result) - self.assertEqual(len(result), 3) - self.assertEqual(result, [{'dataset_description': "Clinical data from 2013-2017. Each concept's count reflects " - "the use of that specific concept.", - 'dataset_id': 1, - 'dataset_name': "5-year non-hierarchical"}, - {'dataset_description': "Clinical data from all years in the database. Each concept's" - " count reflects the use of that specific concept.", - 'dataset_id': 2, - 'dataset_name': "Lifetime non-hierarchical"}, - { - "dataset_description": "Clinical data from 2013-2017. Each concept's count includes" - " use of that concept and descendant concepts.", - "dataset_id": 3, - "dataset_name": "5-year hierarchical"} - ]) - - def test_get_domain_counts(self): - result = QueryCOHD.get_domain_counts(1) - self.assertIsNotNone(result) - self.assertEqual(len(result), 10) - self.assertEqual(result[0], {'count': 10159, - 'dataset_id': 1, - 'domain_id': 'Condition'}) - - # default dataset_id - result = QueryCOHD.get_domain_counts() - self.assertIsNotNone(result) - self.assertEqual(len(result), 10) - self.assertEqual(result[0], {'count': 10159, - 'dataset_id': 1, - 'domain_id': 'Condition'}) - - # invalid dataset_id value - result = QueryCOHD.get_domain_counts(-1) - self.assertEqual(result, []) - - # invalid dataset_id type - result = QueryCOHD.get_domain_counts("1") - self.assertEqual(result, []) - - def test_get_domain_pair_counts(self): - result = QueryCOHD.get_domain_pair_counts(1) - self.assertIsNotNone(result) - self.assertEqual(len(result), 50) - self.assertEqual(result[0], {'count': 1933917, - 'dataset_id': 1, - 'domain_id_1': 'Condition', - 'domain_id_2': 'Condition'}) - - # default dataset_id - result = QueryCOHD.get_domain_pair_counts() - self.assertIsNotNone(result) - self.assertEqual(len(result), 50) - self.assertEqual(result[0], {'count': 1933917, - 'dataset_id': 1, - 'domain_id_1': 'Condition', - 'domain_id_2': 'Condition'}) - - # invalid dataset_id value - result = QueryCOHD.get_domain_pair_counts(-1) - self.assertEqual(result, []) - - # invalid dataset_id type - result = QueryCOHD.get_domain_pair_counts('1') - self.assertEqual(result, []) - - def test_get_patient_count(self): - result = QueryCOHD.get_patient_count(2) - self.assertIsNotNone(result) - self.assertEqual(result, {'count': 5364781.0, 'dataset_id': 2}) - - # default dataset_id - result = QueryCOHD.get_patient_count() - self.assertIsNotNone(result) - self.assertEqual(result, {'count': 1790431.0, 'dataset_id': 1}) - - # invalid dataset_id value - result = QueryCOHD.get_patient_count(-1) - self.assertEqual(result, {}) - - # invalid dataset_id type - result = QueryCOHD.get_patient_count('1') - self.assertEqual(result, {}) - - def test_get_concept_ancestors(self): - result = QueryCOHD.get_concept_ancestors('19019073', 'RxNorm', 'Ingredient', 1) - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result[0], {'ancestor_concept_id': 1177480, - 'concept_class_id': 'Ingredient', - 'concept_code': '5640', - 'concept_count': 174, - 'concept_name': 'Ibuprofen', - 'domain_id': 'Drug', - 'max_levels_of_separation': 2, - 'min_levels_of_separation': 2, - 'standard_concept': 'S', - 'vocabulary_id': 'RxNorm'}) - - # default dataset_id - result = QueryCOHD.get_concept_ancestors('19019073', 'RxNorm', 'Ingredient') - self.assertIsNotNone(result) - self.assertEqual(len(result), 1) - self.assertEqual(result[0], {'ancestor_concept_id': 1177480, - 'concept_class_id': 'Ingredient', - 'concept_code': '5640', - 'concept_count': 233514, - 'concept_name': 'Ibuprofen', - 'domain_id': 'Drug', - 'max_levels_of_separation': 2, - 'min_levels_of_separation': 2, - 'standard_concept': 'S', - 'vocabulary_id': 'RxNorm'}) - - # default concept_class_id - result = QueryCOHD.get_concept_ancestors('19019073', 'RxNorm') - self.assertIsNotNone(result) - self.assertEqual(len(result), 4) - self.assertEqual(result[0], { - "ancestor_concept_id": 19019073, - "concept_class_id": "Clinical Drug", - "concept_code": "197806", - "concept_count": 121104, - "concept_name": "Ibuprofen 600 MG Oral Tablet", - "domain_id": "Drug", - "max_levels_of_separation": 0, - "min_levels_of_separation": 0, - "standard_concept": "S", - "vocabulary_id": "RxNorm"}) - - # default vocabulary_id - result = QueryCOHD.get_concept_ancestors('19019073') - self.assertIsNotNone(result) - self.assertEqual(len(result), 8) - self.assertEqual(result[0], { - "ancestor_concept_id": 19019073, - "concept_class_id": "Clinical Drug", - "concept_code": "197806", - "concept_count": 121104, - "concept_name": "Ibuprofen 600 MG Oral Tablet", - "domain_id": "Drug", - "max_levels_of_separation": 0, - "min_levels_of_separation": 0, - "standard_concept": "S", - "vocabulary_id": "RxNorm"}) - - def test_get_concept_descendants(self): - result = QueryCOHD.get_concept_descendants('19019073', 'RxNorm', 'Branded Drug', 1) - self.assertIsNotNone(result) - self.assertEqual(len(result), 3) - self.assertEqual(result[0], { - "concept_class_id": "Branded Drug", - "concept_code": "206913", - "concept_count": 14744, - "concept_name": "Ibuprofen 600 MG Oral Tablet [Ibu]", - "descendant_concept_id": 19033921, - "domain_id": "Drug", - "max_levels_of_separation": 0, - "min_levels_of_separation": 0, - "standard_concept": "S", - "vocabulary_id": "RxNorm"}) - - # default dataset_id - result = QueryCOHD.get_concept_descendants('19019073', 'RxNorm', 'Branded Drug') - self.assertIsNotNone(result) - self.assertEqual(len(result), 3) - self.assertEqual(result[0], { - "concept_class_id": "Branded Drug", - "concept_code": "206913", - "concept_count": 14853, - "concept_name": "Ibuprofen 600 MG Oral Tablet [Ibu]", - "descendant_concept_id": 19033921, - "domain_id": "Drug", - "max_levels_of_separation": 0, - "min_levels_of_separation": 0, - "standard_concept": "S", - "vocabulary_id": "RxNorm"}) - - # default concept_class_id - result = QueryCOHD.get_concept_descendants('19019073', 'RxNorm') - self.assertIsNotNone(result) - self.assertEqual(len(result), 4) - self.assertEqual(result[0], { - "concept_class_id": "Clinical Drug", - "concept_code": "197806", - "concept_count": 121104, - "concept_name": "Ibuprofen 600 MG Oral Tablet", - "descendant_concept_id": 19019073, - "domain_id": "Drug", - "max_levels_of_separation": 0, - "min_levels_of_separation": 0, - "standard_concept": "S", - "vocabulary_id": "RxNorm"}) - - # default vocabulary_id - result = QueryCOHD.get_concept_descendants('19019073') - self.assertIsNotNone(result) - self.assertEqual(len(result), 4) - self.assertEqual(result[0], { - "concept_class_id": "Clinical Drug", - "concept_code": "197806", - "concept_count": 121104, - "concept_name": "Ibuprofen 600 MG Oral Tablet", - "descendant_concept_id": 19019073, - "domain_id": "Drug", - "max_levels_of_separation": 0, - "min_levels_of_separation": 0, - "standard_concept": "S", - "vocabulary_id": "RxNorm"}) - diff --git a/code/reasoningtool/kg-construction/tests/QueryChEMBLTests.py b/code/reasoningtool/kg-construction/tests/QueryChEMBLTests.py deleted file mode 100644 index e029e1eee..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryChEMBLTests.py +++ /dev/null @@ -1,102 +0,0 @@ -from unittest import TestCase - -import os, sys - -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0, parentdir) - -from QueryChEMBL import QueryChEMBL as QC - - -class QueryChEMBLTestCase(TestCase): - def test_get_target_uniprot_ids_for_drug(self): - - ret_dict = QC.get_target_uniprot_ids_for_drug('clothiapine') - known_dict = {'P41595': 1.0, 'P28335': 1.0, 'P28223': 1.0, 'P21917': 1.0, - 'Q8WXA8': 1.0, 'Q70Z44': 1.0, 'A5X5Y0': 1.0, 'P46098': 1.0, - 'O95264': 1.0, 'P21728': 0.99999999997, 'P35367': 0.99999999054, - 'P21918': 0.9999999767, 'P08913': 0.99999695255, 'P18089': 0.99998657797, - 'P14416': 0.99996045438, 'P25100': 0.99889195616, 'P18825': 0.9579773931, - 'P08173': 0.93840796993, 'P08912': 0.65816349122, 'P34969': 0.28285795246, - 'P35348': 0.28214156802, 'P04637': 0.20348218778, 'P11229': 0.17088734668, - 'P10635': 0.14031224569, 'P06746': 0.06658649159} - - for key, value in ret_dict.items(): - self.assertLess(abs(value - known_dict[key]), 0.1) - - # empty string - ret_dict = QC.get_target_uniprot_ids_for_drug('') - self.assertDictEqual(ret_dict, {}) - - # invalid parameter type - ret_dict = QC.get_target_uniprot_ids_for_drug(0) - self.assertDictEqual(ret_dict, {}) - - def test_get_chembl_ids_for_drug(self): - - ret_set = QC.get_chembl_ids_for_drug('clothiapine') - known_set = {'CHEMBL304902'} - self.assertSetEqual(ret_set, known_set) - - # empty string - ret_set = QC.get_chembl_ids_for_drug('') - self.assertEqual(ret_set, set()) - - # invalid parameter type - ret_set = QC.get_chembl_ids_for_drug(0) - self.assertEqual(ret_set, set()) - - def test_get_target_uniprot_ids_for_chembl_id(self): - - # test case CHEMBL304902 - ret_dict = QC.get_target_uniprot_ids_for_chembl_id('CHEMBL304902') - known_dict = {'P28223': 1.0, 'P41595': 1.0, 'P28335': 1.0, 'P21917': 1.0, - 'P46098': 1.0, 'Q8WXA8': 1.0, 'Q70Z44': 1.0, 'A5X5Y0': 1.0, - 'O95264': 1.0, 'P21728': 0.99999999997, 'P35367': 0.99999999054, - 'P21918': 0.9999999767, 'P08913': 0.99999695255, 'P18089': 0.99998657797, - 'P14416': 0.99996045438, 'P25100': 0.99889195616, 'P18825': 0.9579773931, - 'P08173': 0.93840796993, 'P08912': 0.65816349122, 'P34969': 0.28285795246, - 'P35348': 0.28214156802, 'P04637': 0.20348218778, 'P11229': 0.17088734668, - 'P10635': 0.14031224569, 'P06746': 0.06658649159} - for key, value in ret_dict.items(): - self.assertLess(abs(value - known_dict[key]), 0.1) - - # test case CHEMBL521 (ibuprofen) - ret_dict = QC.get_target_uniprot_ids_for_chembl_id('CHEMBL521') - known_dict = {'P23219': 1.0, 'P35354': 1.0, 'P08473': 0.99980037155, 'O00763': 0.99266688751, - 'Q04609': 0.98942916865, 'P08253': 0.94581002279, 'P17752': 0.91994871445, - 'P03956': 0.89643421164, 'P42892': 0.87107050119, 'Q9GZN0': 0.86383549859, - 'P12821': 0.8620779016, 'P15144': 0.85733534851, 'Q9BYF1': 0.83966001458, - 'P22894': 0.78062167118, 'P14780': 0.65826285102, 'P08254': 0.61116303205, - 'P37268': 0.25590346332, 'P17655': 0.1909881306, 'P07858': 0.1306186469, - 'P06734': 0.1130695383, 'P50052': 0.111298188} - for key, value in ret_dict.items(): - self.assertLess(abs(value - known_dict[key]), 0.1) - - # empty string - ret_dict = QC.get_target_uniprot_ids_for_chembl_id('') - self.assertDictEqual(ret_dict, {}) - - # invalid parameter type - ret_dict = QC.get_target_uniprot_ids_for_chembl_id(0) - self.assertDictEqual(ret_dict, {}) - - def test_get_mechanisms_for_chembl_id(self): - - ret_array = QC.get_mechanisms_for_chembl_id("CHEMBL521") - self.assertEqual(ret_array[0]['action_type'], 'INHIBITOR') - self.assertEqual(ret_array[0]['mechanism_of_action'], 'Cyclooxygenase inhibitor') - self.assertEqual(ret_array[0]['molecule_chembl_id'], 'CHEMBL521') - self.assertEqual(ret_array[0]['target_chembl_id'], 'CHEMBL2094253') - - # empty result - ret_array = QC.get_mechanisms_for_chembl_id('CHEMBL2094253') - self.assertEqual(ret_array, []) - - # empty input string - ret_array = QC.get_mechanisms_for_chembl_id('') - self.assertEqual(ret_array, []) - - # invalid parameter type - ret_array = QC.get_mechanisms_for_chembl_id(0) - self.assertEqual(ret_array, []) \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryEBIOLSExtendedTests.py b/code/reasoningtool/kg-construction/tests/QueryEBIOLSExtendedTests.py deleted file mode 100644 index bad55a43f..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryEBIOLSExtendedTests.py +++ /dev/null @@ -1,77 +0,0 @@ -from unittest import TestCase -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryEBIOLSExtended import QueryEBIOLSExtended as QEBIEx - - -def get_from_test_file(key): - f = open('query_desc_test_data.json', 'r') - test_data = f.read() - try: - test_data_dict = json.loads(test_data) - f.close() - return test_data_dict[key] - except ValueError: - f.close() - return None - - -class QueryEBIOLSExtendedTestCase(TestCase): - def test_get_anatomy_description(self): - desc = QEBIEx.get_anatomy_description('UBERON:0004476') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('UBERON:0004476')) - - desc = QEBIEx.get_anatomy_description('UBERON:00044760') - self.assertEqual(desc, 'None') - - desc = QEBIEx.get_anatomy_description('CL:0000038') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('CL:0000038')) - - desc = QEBIEx.get_anatomy_description('CL:00000380') - self.assertEqual(desc, 'None') - - def test_get_phenotype_description(self): - desc = QEBIEx.get_phenotype_description('GO:0042535') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('GO:0042535')) - - desc = QEBIEx.get_phenotype_description('GO:00425350') - self.assertEqual(desc, 'None') - - def test_get_bio_process_description(self): - desc = QEBIEx.get_bio_process_description('HP:0011105') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('HP:0011105')) - - desc = QEBIEx.get_bio_process_description('HP:00111050') - self.assertEqual(desc, 'None') - - def test_get_cellular_component_description(self): - desc = QEBIEx.get_cellular_component_description('GO:0005573') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('GO:0005573')) - - desc = QEBIEx.get_cellular_component_description('GO:00055730') - self.assertEqual(desc, 'None') - - def test_get_molecular_function_description(self): - desc = QEBIEx.get_molecular_function_description('GO:0004689') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('GO:0004689')) - - desc = QEBIEx.get_molecular_function_description('GO:00046890') - self.assertEqual(desc, 'None') - - def test_get_disease_description(self): - desc = QEBIEx.get_disease_description('OMIM:613573') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('OMIM:613573')) - - desc = QEBIEx.get_disease_description('OMIM:6135730') - self.assertEqual(desc, 'None') \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryEBIOLSTests.py b/code/reasoningtool/kg-construction/tests/QueryEBIOLSTests.py deleted file mode 100644 index 6946708ff..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryEBIOLSTests.py +++ /dev/null @@ -1,77 +0,0 @@ -from unittest import TestCase -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryEBIOLS import QueryEBIOLS as QEBI - - -def get_from_test_file(key): - f = open('query_desc_test_data.json', 'r') - test_data = f.read() - try: - test_data_dict = json.loads(test_data) - f.close() - return test_data_dict[key] - except ValueError: - f.close() - return None - - -class QueryEBIOLSTestCase(TestCase): - def test_get_anatomy_description(self): - desc = QEBI.get_anatomy_description('UBERON:0004476') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('UBERON:0004476')) - - desc = QEBI.get_anatomy_description('UBERON:00044760') - self.assertEqual(desc, 'None') - - desc = QEBI.get_anatomy_description('CL:0000038') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('CL:0000038')) - - desc = QEBI.get_anatomy_description('CL:00000380') - self.assertEqual(desc, 'None') - - def test_get_phenotype_description(self): - desc = QEBI.get_phenotype_description('GO:0042535') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('GO:0042535')) - - desc = QEBI.get_phenotype_description('GO:00425350') - self.assertEqual(desc, 'None') - - def test_get_bio_process_description(self): - desc = QEBI.get_bio_process_description('HP:0011105') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('HP:0011105')) - - desc = QEBI.get_bio_process_description('HP:00111050') - self.assertEqual(desc, 'None') - - def test_get_cellular_component_description(self): - desc = QEBI.get_cellular_component_description('GO:0005573') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('GO:0005573')) - - desc = QEBI.get_cellular_component_description('GO:00055730') - self.assertEqual(desc, 'None') - - def test_get_molecular_function_description(self): - desc = QEBI.get_molecular_function_description('GO:0004689') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('GO:0004689')) - - desc = QEBI.get_molecular_function_description('GO:00046890') - self.assertEqual(desc, 'None') - - def test_get_disease_description(self): - desc = QEBI.get_disease_description('OMIM:613573') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('OMIM:613573')) - - desc = QEBI.get_disease_description('OMIM:6135730') - self.assertEqual(desc, 'None') \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryHMDBTests.py b/code/reasoningtool/kg-construction/tests/QueryHMDBTests.py deleted file mode 100644 index 53ce57720..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryHMDBTests.py +++ /dev/null @@ -1,21 +0,0 @@ -from unittest import TestCase - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryHMDB import QueryHMDB - -class QueryHMDBTestCases(TestCase): - def test_get_compound_desc(self): - - desc = QueryHMDB.get_compound_desc('http://www.hmdb.ca/metabolites/HMDB0060288') - self.assertIsNotNone(desc) - self.assertEqual(desc, "N8-Acetylspermidine belongs to the class of organic compounds known as carboximidic acids. These are organic acids with the general formula RC(=N)-OH (R=H, organic group). N8-Acetylspermidine exists as a solid, slightly soluble (in water), and an extremely weak acidic (essentially neutral) compound (based on its pKa). N8-Acetylspermidine has been detected in multiple biofluids, such as saliva, urine, and blood. N8-Acetylspermidine exists in all eukaryotes, ranging from yeast to humans. Outside of the human body, N8-acetylspermidine can be found in a number of food items such as sweet bay, gooseberry, hedge mustard, and burbot. This makes N8-acetylspermidine a potential biomarker for the consumption of these food products.") - - # wrong url - desc = QueryHMDB.get_compound_desc('http://www.hmdb.ca/metabolites/HMDB00602880') - self.assertEqual(desc, "None") - - desc = QueryHMDB.get_compound_desc(820) - self.assertEqual(desc, "None") \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryKEGGTests.py b/code/reasoningtool/kg-construction/tests/QueryKEGGTests.py deleted file mode 100644 index 1da1763c1..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryKEGGTests.py +++ /dev/null @@ -1,80 +0,0 @@ -from unittest import TestCase - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryKEGG import QueryKEGG - - -class QueryKEGGTestCases(TestCase): - def test_map_kegg_compound_to_enzyme_commission_ids(self): - - ids = QueryKEGG.map_kegg_compound_to_enzyme_commission_ids('KEGG:C00022') - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 146) - self.assertTrue('ec:1.3.1.110' in ids) - - ids = QueryKEGG.map_kegg_compound_to_enzyme_commission_ids('KEGG:C00100') - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 25) - self.assertEqual(ids, {'ec:3.13.1.4', 'ec:2.1.3.1', 'ec:4.1.1.9', 'ec:6.4.1.3', 'ec:6.2.1.13', - 'ec:6.2.1.17', 'ec:6.2.1.1', 'ec:2.3.3.5', 'ec:2.3.3.11', 'ec:2.3.1.9', 'ec:2.3.1.94', - 'ec:2.3.1.8', 'ec:2.3.1.54', 'ec:2.3.1.222', 'ec:2.3.1.176', 'ec:2.3.1.168', - 'ec:2.3.1.16', 'ec:2.8.3.1', 'ec:1.3.1.84', 'ec:1.3.1.95', 'ec:1.2.7.1', 'ec:1.2.1.87', - 'ec:1.2.1.27', 'ec:1.3.8.7', 'ec:4.1.3.24'}) - - # empty result - ids = QueryKEGG.map_kegg_compound_to_enzyme_commission_ids('KEGG:C00200') - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 0) - - # wrong arg format - ids = QueryKEGG.map_kegg_compound_to_enzyme_commission_ids('GO:2342343') - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 0) - - # wrong arg type - ids = QueryKEGG.map_kegg_compound_to_enzyme_commission_ids(1000) - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 0) - - def test_map_kegg_compound_to_pub_chem_id(self): - - pubchem_id = QueryKEGG.map_kegg_compound_to_pub_chem_id("KEGG:C00190") - self.assertIsNotNone(pubchem_id) - self.assertEqual(pubchem_id, "3490") - - # wrong arg format - pubchem_id = QueryKEGG.map_kegg_compound_to_pub_chem_id("GO:2342343") - self.assertIsNone(pubchem_id) - - # wrong arg type - pubchem_id = QueryKEGG.map_kegg_compound_to_pub_chem_id(100) - self.assertIsNone(pubchem_id) - - def test_map_kegg_compound_to_hmdb_id(self): - - hmdb_id = QueryKEGG.map_kegg_compound_to_hmdb_id('KEGG:C00022') - self.assertIsNotNone(hmdb_id) - self.assertEqual(hmdb_id, "HMDB0000243") - - hmdb_id = QueryKEGG.map_kegg_compound_to_hmdb_id('KEGG:C19033') - self.assertIsNotNone(hmdb_id) - self.assertEqual(hmdb_id, "HMDB0036574") - - # wrong arg format - hmdb_id = QueryKEGG.map_kegg_compound_to_hmdb_id("GO:2342343") - self.assertIsNone(hmdb_id) - - # wrong arg format - hmdb_id = QueryKEGG.map_kegg_compound_to_hmdb_id("43") - self.assertIsNone(hmdb_id) - - # wrong arg format - hmdb_id = QueryKEGG.map_kegg_compound_to_hmdb_id("C00022") - self.assertIsNone(hmdb_id) - - # wrong arg type - hmdb_id = QueryKEGG.map_kegg_compound_to_hmdb_id(100) - self.assertIsNone(hmdb_id) \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryMyChemTests.py b/code/reasoningtool/kg-construction/tests/QueryMyChemTests.py deleted file mode 100644 index 051141199..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryMyChemTests.py +++ /dev/null @@ -1,133 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryMyChem import QueryMyChem as QMC - - -def get_from_test_file(filename, key): - f = open(filename, 'r') - test_data = f.read() - try: - test_data_dict = json.loads(test_data) - f.close() - return test_data_dict[key] - except ValueError: - f.close() - return None - - -class QueryMyChemTestCase(unittest.TestCase): - - def test_get_chemical_substance_entity(self): - extended_info_json = QMC.get_chemical_substance_entity('ChEMBL:1200766') - self.maxDiff = None - self.assertIsNotNone(extended_info_json) - if extended_info_json != "None": - self.assertEqual(json.loads(extended_info_json), - json.loads(get_from_test_file('query_test_data.json', 'ChEMBL:1200766'))) - - def test_get_chemical_substance_description(self): - desc = QMC.get_chemical_substance_description('ChEMBL:154') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('query_desc_test_data.json', 'ChEMBL:154')) - - desc = QMC.get_chemical_substance_description('ChEMBL:20883') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('query_desc_test_data.json', 'ChEMBL:20883')) - - desc = QMC.get_chemical_substance_description('ChEMBL:110101020') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('query_desc_test_data.json', 'ChEMBL:110101020')) - - def test_get_drug_side_effects(self): - side_effects_set = QMC.get_drug_side_effects('KWHRDNMACVLHCE-UHFFFAOYSA-N') - self.assertIsNotNone(side_effects_set) - self.assertEqual(122, len(side_effects_set)) - if 'UMLS:C0013378' not in side_effects_set: - self.assertFalse() - if 'UMLS:C0022660' not in side_effects_set: - self.assertFalse() - - side_effects_set = QMC.get_drug_side_effects('CHEMBL:521') - self.assertIsNotNone(side_effects_set) - self.assertEqual(0, len(side_effects_set)) - - side_effects_set = QMC.get_drug_side_effects('ChEMBL:521') - self.assertIsNotNone(side_effects_set) - self.assertEqual(0, len(side_effects_set)) - - def test_get_drug_use(self): - # test case for ibuprofen - drug_use = QMC.get_drug_use("CHEMBL:521") - self.assertIsNotNone(drug_use) - self.assertIsNotNone(drug_use['indications']) - self.assertIsNotNone(drug_use['contraindications']) - self.assertEqual(12, len(drug_use['indications'])) - self.assertEqual(85, len(drug_use['contraindications'])) - self.assertEqual(drug_use['indications'][0]['snomed_concept_id'], 315642008) - self.assertEqual(drug_use['indications'][0]['snomed_full_name'], 'Influenza-like symptoms') - self.assertEqual(drug_use['contraindications'][0]['snomed_concept_id'], 24526004) - self.assertEqual(drug_use['contraindications'][0]['snomed_full_name'], 'Inflammatory bowel disease') - - # test CHEMBL ID with no colon - drug_use = QMC.get_drug_use("CHEMBL521") - self.assertIsNotNone(drug_use) - self.assertIsNotNone(drug_use['indications']) - self.assertIsNotNone(drug_use['contraindications']) - self.assertEqual(12, len(drug_use['indications'])) - self.assertEqual(85, len(drug_use['contraindications'])) - - # test CHEMBL ID with a lower h - drug_use = QMC.get_drug_use("ChEMBL:521") - self.assertIsNotNone(drug_use) - self.assertIsNotNone(drug_use['indications']) - self.assertIsNotNone(drug_use['contraindications']) - self.assertEqual(12, len(drug_use['indications'])) - self.assertEqual(85, len(drug_use['contraindications'])) - - # test case for Penicillin V - drug_use = QMC.get_drug_use("CHEMBL615") - self.assertIsNotNone(drug_use) - self.assertIsNotNone(drug_use['indications']) - self.assertIsNotNone(drug_use['contraindications']) - self.assertEqual(17, len(drug_use['indications'])) - self.assertEqual(3, len(drug_use['contraindications'])) - - # test case for Cetirizine - drug_use = QMC.get_drug_use("CHEMBL1000") - self.assertIsNotNone(drug_use) - self.assertIsNotNone(drug_use['indications']) - self.assertIsNotNone(drug_use['contraindications']) - self.assertEqual(9, len(drug_use['indications'])) - self.assertEqual(14, len(drug_use['contraindications'])) - - # test case for Amoxicillin - drug_use = QMC.get_drug_use("CHEMBL1082") - self.assertIsNotNone(drug_use) - self.assertIsNotNone(drug_use['indications']) - self.assertIsNotNone(drug_use['contraindications']) - self.assertEqual(40, len(drug_use['indications'])) - self.assertEqual(17, len(drug_use['contraindications'])) - - # test case for CHEMBL2107884 - drug_use = QMC.get_drug_use("CHEMBL2107884") - self.assertIsNotNone(drug_use) - self.assertIsNotNone(drug_use['indications']) - self.assertIsNotNone(drug_use['contraindications']) - self.assertEqual(1, len(drug_use['indications'])) - self.assertEqual(0, len(drug_use['contraindications'])) - - # test case for CHEMBL250270 - drug_use = QMC.get_drug_use("CHEMBL250270") - self.assertIsNotNone(drug_use) - self.assertIsNotNone(drug_use['indications']) - self.assertIsNotNone(drug_use['contraindications']) - self.assertEqual(1, len(drug_use['indications'])) - self.assertEqual(0, len(drug_use['contraindications'])) - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryMyGeneExtendedTests.py b/code/reasoningtool/kg-construction/tests/QueryMyGeneExtendedTests.py deleted file mode 100644 index 13942f07f..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryMyGeneExtendedTests.py +++ /dev/null @@ -1,62 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryMyGeneExtended import QueryMyGeneExtended - - -def get_from_test_file(filename, key): - f = open(filename, 'r') - test_data = f.read() - try: - test_data_dict = json.loads(test_data) - f.close() - return test_data_dict[key] - except ValueError: - f.close() - return None - - -class QueryMyGeneExtendedTestCase(unittest.TestCase): - - def test_get_protein_entity(self): - - extended_info_json = QueryMyGeneExtended.get_protein_entity("UniProtKB:O60884") - self.maxDiff = None - self.assertIsNotNone(extended_info_json) - if extended_info_json != "UNKNOWN": - self.assertEqual(len(json.loads(extended_info_json)), - len(json.loads(get_from_test_file('query_test_data.json', 'UniProtKB:O60884')))) - - def test_get_microRNA_entity(self): - - extended_info_json = QueryMyGeneExtended.get_microRNA_entity("NCBIGene: 100847086") - self.maxDiff = None - self.assertIsNotNone(extended_info_json) - if extended_info_json != "UNKNOWN": - self.assertEqual(len(json.loads(extended_info_json)), - len(json.loads(get_from_test_file('query_test_data.json', 'NCBIGene: 100847086')))) - - def test_get_protein_desc(self): - - desc = QueryMyGeneExtended.get_protein_desc("UniProtKB:O60884") - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('query_desc_test_data.json','UniProtKB:O60884')) - - desc = QueryMyGeneExtended.get_protein_desc("UniProtKB:O608840") - self.assertEqual(desc, 'None') - - def test_get_microRNA_desc(self): - - desc = QueryMyGeneExtended.get_microRNA_desc("NCBIGene: 100847086") - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('query_desc_test_data.json', 'NCBIGene: 100847086')) - - desc = QueryMyGeneExtended.get_microRNA_desc("NCBIGene: 1008470860") - self.assertEqual(desc, 'None') - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryMyGeneTests.py b/code/reasoningtool/kg-construction/tests/QueryMyGeneTests.py deleted file mode 100644 index f79a02721..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryMyGeneTests.py +++ /dev/null @@ -1,113 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryMyGene import QueryMyGene - - -def get_from_test_file(filename, key): - f = open(filename, 'r') - test_data = f.read() - try: - test_data_dict = json.loads(test_data) - f.close() - return test_data_dict[key] - except ValueError: - f.close() - return None - - -class QueryMyGeneTestCase(unittest.TestCase): - - def test_get_protein_entity(self): - mg = QueryMyGene() - extended_info_json = mg.get_protein_entity("UniProtKB:O60884") - self.maxDiff = None - self.assertIsNotNone(extended_info_json) - if extended_info_json != "None": - self.assertEqual(len(json.loads(extended_info_json)), - len(json.loads(get_from_test_file('query_test_data.json', 'UniProtKB:O60884')))) - - # invalid parameter - extended_info_json = mg.get_protein_entity(100847086) - self.assertEqual(extended_info_json, "None") - - def test_get_microRNA_entity(self): - mg = QueryMyGene() - extended_info_json = mg.get_microRNA_entity("NCBIGene: 100847086") - self.maxDiff = None - self.assertIsNotNone(extended_info_json) - if extended_info_json != "None": - self.assertEqual(len(json.loads(extended_info_json)), - len(json.loads(get_from_test_file('query_test_data.json', 'NCBIGene:100847086')))) - - # invalid parameter - extended_info_json = mg.get_microRNA_entity(100847086) - self.assertEqual(extended_info_json, "None") - - def test_get_protein_desc(self): - mg = QueryMyGene() - desc = mg.get_protein_desc("UniProtKB:O60884") - self.assertIsNotNone(desc) - self.assertEqual(desc, "The protein encoded by this gene belongs to the evolutionarily conserved DNAJ/HSP40 " - "family of proteins, which regulate molecular chaperone activity by stimulating ATPase " - "activity. DNAJ proteins may have up to 3 distinct domains: a conserved 70-amino acid J " - "domain, usually at the N terminus; a glycine/phenylalanine (G/F)-rich region; and a " - "cysteine-rich domain containing 4 motifs resembling a zinc finger domain. The product " - "of this gene works as a cochaperone of Hsp70s in protein folding and mitochondrial " - "protein import in vitro. [provided by RefSeq, Jul 2008].") - - desc = mg.get_protein_desc("UniProtKB:O608840") - self.assertEqual(desc, 'None') - - # invalid parameter - desc = mg.get_protein_desc(608840) - self.assertEqual(desc, 'None') - - def test_get_microRNA_desc(self): - mg = QueryMyGene() - desc = mg.get_microRNA_desc("NCBIGene: 100847086") - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('query_desc_test_data.json', 'NCBIGene:100847086')) - self.assertEqual(desc, "microRNAs (miRNAs) are short (20-24 nt) non-coding RNAs that are involved in " - "post-transcriptional regulation of gene expression in multicellular organisms by " - "affecting both the stability and translation of mRNAs. miRNAs are transcribed by RNA " - "polymerase II as part of capped and polyadenylated primary transcripts (pri-miRNAs) " - "that can be either protein-coding or non-coding. The primary transcript is cleaved by " - "the Drosha ribonuclease III enzyme to produce an approximately 70-nt stem-loop " - "precursor miRNA (pre-miRNA), which is further cleaved by the cytoplasmic Dicer " - "ribonuclease to generate the mature miRNA and antisense miRNA star (miRNA*) products. " - "The mature miRNA is incorporated into a RNA-induced silencing complex (RISC), which " - "recognizes target mRNAs through imperfect base pairing with the miRNA and most commonly" - " results in translational inhibition or destabilization of the target mRNA. The RefSeq" - " represents the predicted microRNA stem-loop. [provided by RefSeq, Sep 2009].") - - desc = mg.get_microRNA_desc("NCBIGene: 1008470860") - self.assertEqual(desc, 'None') - - # invalid parameter - desc = mg.get_microRNA_desc(1008470860) - self.assertEqual(desc, 'None') - - def test_get_protein_name(self): - mg = QueryMyGene() - name = mg.get_protein_name("UniProtKB:O60884") - self.assertIsNotNone(name) - self.assertEqual(name, "DnaJ heat shock protein family (Hsp40) member A2") - - name = mg.get_protein_name("UniProtKB:P05231") - self.assertIsNotNone(name) - self.assertEqual(name, "interleukin 6") - - name = mg.get_protein_name("UniProtKB:O608840") - self.assertEqual(name, 'None') - - # invalid parameter - name = mg.get_protein_name(608840) - self.assertEqual(name, 'None') - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryOMIMExtendedTests.py b/code/reasoningtool/kg-construction/tests/QueryOMIMExtendedTests.py deleted file mode 100644 index 387fc10a4..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryOMIMExtendedTests.py +++ /dev/null @@ -1,40 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryOMIMExtended import QueryOMIMExtended - - -def get_from_test_file(filename, key): - f = open(filename, 'r') - test_data = f.read() - try: - test_data_dict = json.loads(test_data) - f.close() - return test_data_dict[key] - except ValueError: - f.close() - return None - - -class QueryOMIMExtendedTestCase(unittest.TestCase): - def test_get_disease_entity(self): - qo = QueryOMIMExtended() - desc = qo.disease_mim_to_description('OMIM:100100') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('query_desc_test_data.json', 'OMIM:100100')) - - desc = qo.disease_mim_to_description('OMIM:614747') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('query_desc_test_data.json', 'OMIM:614747')) - - desc = qo.disease_mim_to_description('OMIM:61447') - self.assertIsNotNone(desc) - self.assertEqual(desc, 'None') - - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryOMIMTests.py b/code/reasoningtool/kg-construction/tests/QueryOMIMTests.py deleted file mode 100644 index c8afd24c6..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryOMIMTests.py +++ /dev/null @@ -1,58 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryOMIM import QueryOMIM - - -class QueryOMIMExtendedTestCase(unittest.TestCase): - - def test_disease_mim_to_gene_symbols_and_uniprot_ids(self): - qo = QueryOMIM() - - res = qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:603903') - self.assertIsNotNone(res) - self.assertEqual(res, {'gene_symbols': set(), 'uniprot_ids': {'P68871'}}) - - res = qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:613074') - self.assertIsNotNone(res) - self.assertEqual(res, {'gene_symbols': {'MIR96'}, 'uniprot_ids': set()}) - - # test issue 1 - res = qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:603918') - self.assertIsNotNone(res) - self.assertEqual(res, {'gene_symbols': set(), 'uniprot_ids': set()}) - - # empty result - res = qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:129905') - self.assertIsNotNone(res) - self.assertEqual(res, {'gene_symbols': set(), 'uniprot_ids': set()}) - - # invalid parameter - res = qo.disease_mim_to_gene_symbols_and_uniprot_ids(603903) - self.assertIsNotNone(res) - self.assertEqual(res, {'gene_symbols': set(), 'uniprot_ids': set()}) - - - def test_disease_mim_to_description(self): - qo = QueryOMIM() - desc = qo.disease_mim_to_description('OMIM:100100') - self.assertIsNotNone(desc) - self.assertEqual(desc, "In its rare complete form, 'prune belly' syndrome comprises megacystis (massively " - "enlarged bladder) with disorganized detrusor muscle, cryptorchidism, and thin abdominal" - " musculature with overlying lax skin (summary by {23:Weber et al., 2011}).") - - desc = qo.disease_mim_to_description('OMIM:614747') - self.assertEqual(desc, "None") - - desc = qo.disease_mim_to_description('OMIM:61447') - self.assertEqual(desc, 'None') - - desc = qo.disease_mim_to_description(614747) - self.assertEqual(desc, 'None') - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryPubChemTests.py b/code/reasoningtool/kg-construction/tests/QueryPubChemTests.py deleted file mode 100644 index b1df6af48..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryPubChemTests.py +++ /dev/null @@ -1,59 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryPubChem import QueryPubChem - - -class QueryPubChemTestCase(unittest.TestCase): - - def test_get_chembl_ids_for_drug(self): - - sets = QueryPubChem.get_chembl_ids_for_drug('gne-493') - self.assertIsNotNone(sets) - self.assertEqual(sets, {'CHEMBL1084926'}) - - def test_get_pubchem_id_for_chembl_id(self): - - pubchem_id = QueryPubChem.get_pubchem_id_for_chembl_id('CHEMBL521') - self.assertIsNotNone(pubchem_id) - self.assertEqual(pubchem_id, '3672') - - # empty result - pubchem_id = QueryPubChem.get_pubchem_id_for_chembl_id('chembl521') - self.assertIsNone(pubchem_id) - - # wrong id - pubchem_id = QueryPubChem.get_pubchem_id_for_chembl_id('3400') - self.assertIsNone(pubchem_id) - - def test_get_pubmed_id_for_pubchem_id(self): - - pubmed_ids = QueryPubChem.get_pubmed_id_for_pubchem_id('3500') - self.assertIsNotNone(pubmed_ids) - self.assertEqual(pubmed_ids, ['10860942[uid]', '11961255[uid]']) - - # wrong id - pubmed_ids = QueryPubChem.get_pubmed_id_for_pubchem_id('35000') - self.assertIsNone(pubmed_ids) - - def test_get_description_url(self): - - url = QueryPubChem.get_description_url("3324") - self.assertIsNotNone(url) - self.assertEqual(url, "http://www.hmdb.ca/metabolites/HMDB0000243") - - # empty result - url = QueryPubChem.get_description_url("3500") - self.assertIsNone(url) - - # wrong arg format - url = QueryPubChem.get_description_url("GO:2342343") - self.assertIsNone(url) - - # wrong arg type - url = QueryPubChem.get_description_url(3500) - self.assertIsNone(url) \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryReactomTests.py b/code/reasoningtool/kg-construction/tests/QueryReactomTests.py deleted file mode 100644 index b22865e85..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryReactomTests.py +++ /dev/null @@ -1,55 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryReactome import QueryReactome as QR - -def get_from_test_file(filename, key): - f = open(filename, 'r') - test_data = f.read() - try: - test_data_dict = json.loads(test_data) - f.close() - return test_data_dict[key] - except ValueError: - f.close() - return None - - -class QueryReactomeTestCase(unittest.TestCase): - def test_get_pathway_entity(self): - extended_info_json = QR.get_pathway_entity('REACT:R-HSA-70326') - self.maxDiff = None - self.assertIsNotNone(extended_info_json) - if extended_info_json != "None": - self.assertEqual(json.loads(extended_info_json), json.loads(get_from_test_file('query_test_data.json', 'REACT:R-HSA-70326'))) - - extended_info_json = QR.get_pathway_entity('REACT:R-HSA-703260') - self.assertEqual(extended_info_json, "None") - - extended_info_json = QR.get_pathway_entity(70326) - self.assertEqual(extended_info_json, "None") - - def test_get_pathway_desc(self): - desc = QR.get_pathway_desc('REACT:R-HSA-70326') - self.assertIsNotNone(desc) - self.assertEqual(desc, "Glucose is the major form in which dietary sugars are made available to cells of the " - "human body. Its breakdown is a major source of energy for all cells, and is essential " - "for the brain and red blood cells. Glucose utilization begins with its uptake by cells " - "and conversion to glucose 6-phosphate, which cannot traverse the cell membrane. Fates " - "open to cytosolic glucose 6-phosphate include glycolysis to yield pyruvate, glycogen " - "synthesis, and the pentose phosphate pathway. In some tissues, notably the liver and " - "kidney, glucose 6-phosphate can be synthesized from pyruvate by the pathway of " - "gluconeogenesis.") - - desc = QR.get_pathway_desc('REACT:R-HSA-703260') - self.assertEqual(desc, 'None') - - desc = QR.get_pathway_desc(70326) - self.assertEqual(desc, 'None') - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryReactomeExtendedTests.py b/code/reasoningtool/kg-construction/tests/QueryReactomeExtendedTests.py deleted file mode 100644 index 7a18aa631..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryReactomeExtendedTests.py +++ /dev/null @@ -1,39 +0,0 @@ -import unittest -import json - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryReactomeExtended import QueryReactomeExtended as QREx - -def get_from_test_file(filename, key): - f = open(filename, 'r') - test_data = f.read() - try: - test_data_dict = json.loads(test_data) - f.close() - return test_data_dict[key] - except ValueError: - f.close() - return None - - -class QueryReactomeExtendedTestCase(unittest.TestCase): - def test_get_pathway_entity(self): - extended_info_json = QREx.get_pathway_entity('REACT:R-HSA-70326') - self.maxDiff = None - self.assertIsNotNone(extended_info_json) - if extended_info_json != "UNKNOWN": - self.assertEqual(json.loads(extended_info_json), json.loads(get_from_test_file('query_test_data.json', 'REACT:R-HSA-70326'))) - - def test_get_pathway_desc(self): - desc = QREx.get_pathway_desc('REACT:R-HSA-70326') - self.assertIsNotNone(desc) - self.assertEqual(desc, get_from_test_file('query_desc_test_data.json', 'REACT:R-HSA-70326')) - - desc = QREx.get_pathway_desc('REACT:R-HSA-703260') - self.assertEqual(desc, 'None') - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/QueryUniprotExtendedTests.py b/code/reasoningtool/kg-construction/tests/QueryUniprotExtendedTests.py deleted file mode 100644 index c270af907..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryUniprotExtendedTests.py +++ /dev/null @@ -1,22 +0,0 @@ -from unittest import TestCase - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryUniprotExtended import QueryUniprotExtended as QUEx - - -class QueryUniprotExtendedTestCase(TestCase): - def test_get_protein_name(self): - name = QUEx.get_protein_name('UniProtKB:P01358') - self.assertIsNotNone(name) - self.assertEqual(name, 'Gastric juice peptide 1') - - name = QUEx.get_protein_name('UniProtKB:Q9Y471') - self.assertIsNotNone(name) - self.assertEqual(name, 'Inactive cytidine monophosphate-N-acetylneuraminic acid hydroxylase') - - name = QUEx.get_protein_name('UniProtKB:Q9Y47') - self.assertIsNotNone(name) - self.assertEqual(name, 'UNKNOWN') diff --git a/code/reasoningtool/kg-construction/tests/QueryUniprotTests.py b/code/reasoningtool/kg-construction/tests/QueryUniprotTests.py deleted file mode 100644 index 89d24bb1e..000000000 --- a/code/reasoningtool/kg-construction/tests/QueryUniprotTests.py +++ /dev/null @@ -1,79 +0,0 @@ -from unittest import TestCase - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from QueryUniprot import QueryUniprot - - -class QueryUniprotTestCase(TestCase): - def test_map_enzyme_commission_id_to_uniprot_ids(self): - # short results - ids = QueryUniprot.map_enzyme_commission_id_to_uniprot_ids("ec:1.4.1.17") - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 3) - self.assertEqual(ids, {'Q5FB93', 'Q4U331', 'G8Q0U6'}) - - # empty result - ids = QueryUniprot.map_enzyme_commission_id_to_uniprot_ids("ec:1.3.1.110") - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 0) - - # long results - ids = QueryUniprot.map_enzyme_commission_id_to_uniprot_ids("ec:1.2.1.22") - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 1172) - self.assertTrue('A0A1R4INE8' in ids) - - # fake id - ids = QueryUniprot.map_enzyme_commission_id_to_uniprot_ids("ec:4.4.1.xx") - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 0) - - # wrong arg format - ids = QueryUniprot.map_enzyme_commission_id_to_uniprot_ids("R-HSA-1912422") - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 0) - - # wrong arg type - ids = QueryUniprot.map_enzyme_commission_id_to_uniprot_ids(1912422) - self.assertIsNotNone(ids) - self.assertEqual(len(ids), 0) - - def test_get_protein_name(self): - name = QueryUniprot.get_protein_name('UniProtKB:P01358') - self.assertIsNotNone(name) - self.assertEqual(name, 'Gastric juice peptide 1') - - name = QueryUniprot.get_protein_name('UniProtKB:Q9Y471') - self.assertIsNotNone(name) - self.assertEqual(name, 'Inactive cytidine monophosphate-N-acetylneuraminic acid hydroxylase') - - # empty result - name = QueryUniprot.get_protein_name('UniProtKB:Q9Y47') - self.assertIsNotNone(name) - self.assertEqual(name, 'UNKNOWN') - - # invalid parameter - name = QueryUniprot.get_protein_name(12345) - self.assertEqual(name, "UNKNOWN") - - def test_get_protein_gene_symbol(self): - symbol = QueryUniprot.get_protein_gene_symbol('UniProtKB:P20848') - self.assertIsNotNone(symbol) - self.assertEqual(symbol, "SERPINA2") - - # empty result - symbol = QueryUniprot.get_protein_gene_symbol('UniProtKB:P01358') - self.assertIsNotNone(symbol) - self.assertEqual(symbol, "None") - - symbol = QueryUniprot.get_protein_gene_symbol('UniProtKB:Q96P88') - self.assertIsNotNone(symbol) - self.assertEqual(symbol, "GNRHR2") - - # invalid parameter format, 404 error - symbol = QueryUniprot.get_protein_gene_symbol('UniProtKB:P013580') - self.assertIsNotNone(symbol) - self.assertEqual(symbol, "None") \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/UpdateModuleTestSuite.py b/code/reasoningtool/kg-construction/tests/UpdateModuleTestSuite.py deleted file mode 100644 index 153883534..000000000 --- a/code/reasoningtool/kg-construction/tests/UpdateModuleTestSuite.py +++ /dev/null @@ -1,53 +0,0 @@ -""" - Before running the test suite, create config.json in the same directory as UpdateModuleTestSuite.py - - config.json - { - "url":"bolt://localhost:7687" - "username":"xxx", - "password":"xxx" - } - - - Run this module outside `tests` folder. - $ cd [git repo]/code/reasoningtool/kg-construction/tests - $ python3 -m unittest UpdateModuleTestSuite.py -""" - - -import unittest - -from UpdateNodesInfoTests import UpdateNodesInfoTestCase -from UpdateNodesInfoDescTests import UpdateNodesInfoDescTestCase -from UpdateNodesNameTests import UpdateNodesNameTestCase -from Neo4jConnectionTests import Neo4jConnectionTestCase -from QueryBioLinkExtendedTests import QueryBioLinkExtendedTestCase -from QueryMyChemTests import QueryMyChemTestCase -from QueryMyGeneExtendedTests import QueryMyGeneExtendedTestCase -from QueryReactomeExtendedTests import QueryReactomeExtendedTestCase -from QueryOMIMExtendedTests import QueryOMIMExtendedTestCase -from QueryEBIOLSExtendedTests import QueryEBIOLSExtendedTestCase -from QueryUniprotExtendedTests import QueryUniprotExtendedTestCase - - -class UpdateModuleTestSuite(unittest.TestSuite): - def suite(self): - suite = unittest.TestSuite() - - suite.addTest(UpdateNodesInfoTestCase()) - suite.addTest(UpdateNodesInfoDescTestCase()) - suite.addTest(UpdateNodesNameTestCase()) - suite.addTest(Neo4jConnectionTestCase()) - suite.addTest(QueryBioLinkExtendedTestCase()) - suite.addTest(QueryMyChemTestCase()) - suite.addTest(QueryMyGeneExtendedTestCase()) - suite.addTest(QueryReactomeExtendedTestCase()) - suite.addTest(QueryOMIMExtendedTestCase()) - suite.addTest(QueryEBIOLSExtendedTestCase()) - suite.addTest(QueryUniprotExtendedTestCase()) - - return suite - - -if __name__ == '__main__': - unittest.main() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/UpdateNodesInfoDescTests.py b/code/reasoningtool/kg-construction/tests/UpdateNodesInfoDescTests.py deleted file mode 100644 index 2bb76de74..000000000 --- a/code/reasoningtool/kg-construction/tests/UpdateNodesInfoDescTests.py +++ /dev/null @@ -1,311 +0,0 @@ -import unittest -import json -import random - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from Neo4jConnection import Neo4jConnection -from QueryEBIOLS import QueryEBIOLS -from QueryOMIM import QueryOMIM -from QueryMyGene import QueryMyGene -from QueryMyChem import QueryMyChem -from QueryReactome import QueryReactome -from QueryKEGG import QueryKEGG -from QueryPubChem import QueryPubChem -from QueryHMDB import QueryHMDB - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../../") # code directory -from RTXConfiguration import RTXConfiguration - - -def random_int_list(start, stop, length): - start, stop = (int(start), int(stop)) if start <= stop else (int(stop), int(start)) - length = int(abs(length)) if length else 0 - random_list = [] - for i in range(length): - random_list.append(random.randint(start, stop)) - return random_list - - -class UpdateNodesInfoDescTestCase(unittest.TestCase): - - rtxConfig = RTXConfiguration() - - def test_update_anatomy_nodes_desc(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_anatomy_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 100) - - for i in random_indexes: - # retrieve data from API - node_id = nodes[i] - desc = QueryEBIOLS.get_anatomy_description(node_id) - - # retrieve data from Neo4j - node = conn.get_anatomy_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - - def test_update_phenotype_nodes_desc(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_phenotype_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 100) - - for i in random_indexes: - # retrieve data from API - node_id = nodes[i] - desc = QueryEBIOLS.get_phenotype_description(node_id) - - # retrieve data from Neo4j - node = conn.get_phenotype_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - - def test_update_microRNA_nodes_desc(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_microRNA_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 100) - - mg = QueryMyGene() - for i in random_indexes: - # retrieve data from API - node_id = nodes[i] - desc = mg.get_microRNA_desc(node_id) - - # retrieve data from Neo4j - node = conn.get_microRNA_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - - def test_update_pathway_nodes_desc(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_pathway_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes) - 1, 100) - - for i in random_indexes: - # retrieve data from API - node_id = nodes[i] - desc = QueryReactome.get_pathway_desc(node_id) - - # retrieve data from Neo4j - node = conn.get_pathway_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - - def test_update_protein_nodes_desc(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_protein_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 100) - - mg = QueryMyGene() - for i in random_indexes: - # retrieve data from API - node_id = nodes[i] - desc = mg.get_protein_desc(node_id) - - # retrieve data from Neo4j - node = conn.get_protein_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - - def test_update_disease_nodes_desc(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_disease_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 100) - - qo = QueryOMIM() - for i in random_indexes: - # retrieve data from API - node_id = nodes[i] - if node_id[:4] == "OMIM": - desc = qo.disease_mim_to_description(node_id) - elif node_id[:4] == "DOID": - desc = QueryEBIOLS.get_disease_description(node_id) - - # retrieve data from Neo4j - node = conn.get_disease_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - - def test_update_chemical_substance_entity(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_chemical_substance_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 100) - - for i in random_indexes: - # retrieve data from API - node_id = nodes[i] - desc = QueryMyChem.get_chemical_substance_description(node_id) - - # retrieve data from Neo4j - node = conn.get_chemical_substance_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['rtx_name']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['rtx_name']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - - def test_update_bio_process_entity(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_bio_process_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 100) - - for i in random_indexes: - # retrieve data from API - node_id = nodes[i] - desc = QueryEBIOLS.get_bio_process_description(node_id) - - # retrieve data from Neo4j - node = conn.get_bio_process_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - - def test_update_cellular_component_desc(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_cellular_component_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 100) - - for i in random_indexes: - # retrieve data from BioLink API - node_id = nodes[i] - desc = QueryEBIOLS.get_cellular_component_description(node_id) - - # retrieve data from Neo4j - node = conn.get_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - - def test_update_molecular_function_desc(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_molecular_function_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 100) - - for i in random_indexes: - # retrieve data from BioLink API - node_id = nodes[i] - desc = QueryEBIOLS.get_molecular_function_description(node_id) - - # retrieve data from Neo4j - node = conn.get_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - - def test_update_metabolite_desc(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_metabolite_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes) - 1, 100) - - for i in random_indexes: - # retrieve data from BioLink API - node_id = nodes[i] - pubchem_id = QueryKEGG.map_kegg_compound_to_pub_chem_id(node_id) - hmdb_url = QueryPubChem.get_description_url(pubchem_id) - desc = QueryHMDB.get_compound_desc(hmdb_url) - - # retrieve data from Neo4j - node = conn.get_node(node_id) - self.assertIsNotNone(node) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['description']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['description'] != "None": - self.assertEqual(desc, node['n']['description']) - - conn.close() - -if __name__ == '__main__': - unittest.main() - - diff --git a/code/reasoningtool/kg-construction/tests/UpdateNodesInfoTests.py b/code/reasoningtool/kg-construction/tests/UpdateNodesInfoTests.py deleted file mode 100644 index 6fa2f70c2..000000000 --- a/code/reasoningtool/kg-construction/tests/UpdateNodesInfoTests.py +++ /dev/null @@ -1,230 +0,0 @@ -import unittest -import json -import random - -import os,sys -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from Neo4jConnection import Neo4jConnection -from QueryBioLink import QueryBioLink -from QueryMyGene import QueryMyGene -from QueryReactome import QueryReactome -from QueryMyChem import QueryMyChem -# from QueryEBIOLS import QueryEBIOLS - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../../") # code directory -from RTXConfiguration import RTXConfiguration - -def random_int_list(start, stop, length): - start, stop = (int(start), int(stop)) if start <= stop else (int(stop), int(start)) - length = int(abs(length)) if length else 0 - random_list = [] - for i in range(length): - random_list.append(random.randint(start, stop)) - return random_list - - -class UpdateNodesInfoTestCase(unittest.TestCase): - - rtxConfig = RTXConfiguration() - - def test_update_anatomy_entity(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_anatomy_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 10) - - for i in random_indexes: - # retrieve data from BioLink API - node_id = nodes[i] - extended_info_json_from_api = QueryBioLink.get_anatomy_entity(node_id) - - # retrieve data from Neo4j - node = conn.get_anatomy_node(node_id) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['extended_info_json']) - self.assertEqual(node_id, node['n']['id']) - self.maxDiff = None - if node['n']['extended_info_json'] != "None": - self.assertEqual(json.loads(extended_info_json_from_api), json.loads(node['n']['extended_info_json'])) - - conn.close() - - def test_update_phenotype_entity(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_phenotype_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 10) - - for i in random_indexes: - # retrieve data from BioLink API - node_id = nodes[i] - extended_info_json_from_api = QueryBioLink.get_phenotype_entity(node_id) - - # retrieve data from Neo4j - node = conn.get_phenotype_node(node_id) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['extended_info_json']) - self.assertEqual(node_id, node['n']['id']) - self.maxDiff = None - if node['n']['extended_info_json'] != "None": - self.assertEqual(json.loads(extended_info_json_from_api), json.loads(node['n']['extended_info_json'])) - - conn.close() - - def test_update_microRNA_entity(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_microRNA_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 10) - - mg = QueryMyGene() - for i in random_indexes: - # retrieve data from MyGene API - node_id = nodes[i] - extended_info_json_from_api = mg.get_microRNA_entity(node_id) - - # retrieve data from Neo4j - node = conn.get_microRNA_node(node_id) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['extended_info_json']) - self.assertEqual(node_id, node['n']['id']) - self.maxDiff = None - if node['n']['extended_info_json'] != "None": - self.assertEqual(len(json.loads(extended_info_json_from_api)), len(json.loads(node['n']['extended_info_json']))) - - conn.close() - - def test_update_pathway_entity(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_pathway_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 10) - - for i in random_indexes: - # retrieve data from Reactome API - node_id = nodes[i] - extended_info_json_from_api = QueryReactome.get_pathway_entity(node_id) - - # retrieve data from Neo4j - node = conn.get_pathway_node(node_id) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['extended_info_json']) - self.assertEqual(node_id, node['n']['id']) - self.maxDiff = None - if node['n']['extended_info_json'] != "None": - self.assertEqual(json.loads(extended_info_json_from_api), json.loads(node['n']['extended_info_json'])) - - conn.close() - - def test_update_protein_entity(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_protein_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 10) - - mg = QueryMyGene() - for i in random_indexes: - # retrieve phenotype entities from MyGene API - node_id = nodes[i] - extended_info_json_from_api = mg.get_protein_entity(node_id) - - # retrieve data from Neo4j - node = conn.get_protein_node(node_id) - self.maxDiff = None - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['extended_info_json']) - self.assertEqual(node_id, node['n']['id']) - if node['n']['extended_info_json'] != "None": - self.assertEqual(len(json.loads(extended_info_json_from_api)), len(json.loads(node['n']['extended_info_json']))) - - conn.close() - - def test_update_disease_entity(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_disease_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 10) - - for i in random_indexes: - # retrieve data from BioLink API - node_id = nodes[i] - extended_info_json_from_api = QueryBioLink.get_disease_entity(node_id) - - # retrieve data from Neo4j - node = conn.get_disease_node(node_id) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['extended_info_json']) - self.assertEqual(node_id, node['n']['id']) - self.maxDiff = None - if node['n']['extended_info_json'] != "None": - self.assertEqual(json.loads(extended_info_json_from_api), json.loads(node['n']['extended_info_json'])) - - conn.close() - - def test_update_chemical_substance_entity(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_chemical_substance_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 10) - - for i in random_indexes: - # retrieve data from MyChem API - node_id = nodes[i] - extended_info_json_from_api = QueryMyChem.get_chemical_substance_entity(node_id) - - # retrieve data from Neo4j - node = conn.get_chemical_substance_node(node_id) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['extended_info_json']) - self.assertEqual(node_id, node['n']['id']) - self.maxDiff = None - if node['n']['extended_info_json'] != "None": - self.assertEqual(json.loads(extended_info_json_from_api), json.loads(node['n']['extended_info_json'])) - - conn.close() - - def test_update_bio_process_entity(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_bio_process_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes)-1, 10) - - for i in random_indexes: - # retrieve data from BioLink API - node_id = nodes[i] - extended_info_json_from_api = QueryBioLink.get_bio_process_entity(node_id) - - # retrieve data from Neo4j - node = conn.get_bio_process_node(node_id) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['extended_info_json']) - self.assertEqual(node_id, node['n']['id']) - self.maxDiff = None - if node['n']['extended_info_json'] != "None": - self.assertEqual(json.loads(extended_info_json_from_api), json.loads(node['n']['extended_info_json'])) - - conn.close() - - -if __name__ == '__main__': - unittest.main() - - diff --git a/code/reasoningtool/kg-construction/tests/UpdateNodesNameTests.py b/code/reasoningtool/kg-construction/tests/UpdateNodesNameTests.py deleted file mode 100644 index d06ecd353..000000000 --- a/code/reasoningtool/kg-construction/tests/UpdateNodesNameTests.py +++ /dev/null @@ -1,63 +0,0 @@ -from unittest import TestCase -import json -import random -import os,sys - -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from Neo4jConnection import Neo4jConnection -from QueryUniprot import QueryUniprot -from QueryMyGene import QueryMyGene - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../../") # code directory -from RTXConfiguration import RTXConfiguration - - -def random_int_list(start, stop, length): - start, stop = (int(start), int(stop)) if start <= stop else (int(stop), int(start)) - length = int(abs(length)) if length else 0 - random_list = [] - for i in range(length): - random_list.append(random.randint(start, stop)) - return random_list - - -class UpdateNodesNameTestCase(TestCase): - - rtxConfig = RTXConfiguration() - - def test_update_protein_names_old(self): - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - - protein_nodes_ids = ['UniProtKB:P01358', 'UniProtKB:P20848', 'UniProtKB:Q9Y471', 'UniProtKB:O60397', - 'UniProtKB:Q8IZJ3', 'UniProtKB:Q7Z2Y8', 'UniProtKB:Q8IWN7', 'UniProtKB:Q156A1'] - - for protein_id in protein_nodes_ids: - node = conn.get_protein_node(protein_id) - name = QueryUniprot.get_protein_name(protein_id) - - self.assertIsNotNone(node) - self.assertIsNotNone(name) - self.assertEqual(name, node['n']['name']) - - def test_update_protein_names(self): - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - nodes = conn.get_protein_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(nodes) - 1, 10) - - mg = QueryMyGene() - - for i in random_indexes: - # retrieve data from BioLink API - node_id = nodes[i] - name = mg.get_protein_name(node_id) - - # retrieve data from Neo4j - node = conn.get_protein_node(node_id) - self.assertIsNotNone(node['n']['id']) - self.assertIsNotNone(node['n']['name']) - self.assertEqual(node_id, node['n']['id']) - self.assertEqual(name, node['n']['name']) \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/__init__.py b/code/reasoningtool/kg-construction/tests/__init__.py deleted file mode 100644 index e69de29bb..000000000 diff --git a/code/reasoningtool/kg-construction/tests/query_desc_test_data.json b/code/reasoningtool/kg-construction/tests/query_desc_test_data.json deleted file mode 100644 index 6ba55b03c..000000000 --- a/code/reasoningtool/kg-construction/tests/query_desc_test_data.json +++ /dev/null @@ -1 +0,0 @@ -{"UniProtKB:O60884": "The protein encoded by this gene belongs to the evolutionarily conserved DNAJ/HSP40 family of proteins, which regulate molecular chaperone activity by stimulating ATPase activity. DNAJ proteins may have up to 3 distinct domains: a conserved 70-amino acid J domain, usually at the N terminus; a glycine/phenylalanine (G/F)-rich region; and a cysteine-rich domain containing 4 motifs resembling a zinc finger domain. The product of this gene works as a cochaperone of Hsp70s in protein folding and mitochondrial protein import in vitro. [provided by RefSeq, Jul 2008].", "UniProtKB:O608840": "None", "NCBIGene: 100847086": "microRNAs (miRNAs) are short (20-24 nt) non-coding RNAs that are involved in post-transcriptional regulation of gene expression in multicellular organisms by affecting both the stability and translation of mRNAs. miRNAs are transcribed by RNA polymerase II as part of capped and polyadenylated primary transcripts (pri-miRNAs) that can be either protein-coding or non-coding. The primary transcript is cleaved by the Drosha ribonuclease III enzyme to produce an approximately 70-nt stem-loop precursor miRNA (pre-miRNA), which is further cleaved by the cytoplasmic Dicer ribonuclease to generate the mature miRNA and antisense miRNA star (miRNA*) products. The mature miRNA is incorporated into a RNA-induced silencing complex (RISC), which recognizes target mRNAs through imperfect base pairing with the miRNA and most commonly results in translational inhibition or destabilization of the target mRNA. The RefSeq represents the predicted microRNA stem-loop. [provided by RefSeq, Sep 2009].", "NCBIGene: 1008470860": "None", "NCBIGene:100847086": "microRNAs (miRNAs) are short (20-24 nt) non-coding RNAs that are involved in post-transcriptional regulation of gene expression in multicellular organisms by affecting both the stability and translation of mRNAs. miRNAs are transcribed by RNA polymerase II as part of capped and polyadenylated primary transcripts (pri-miRNAs) that can be either protein-coding or non-coding. The primary transcript is cleaved by the Drosha ribonuclease III enzyme to produce an approximately 70-nt stem-loop precursor miRNA (pre-miRNA), which is further cleaved by the cytoplasmic Dicer ribonuclease to generate the mature miRNA and antisense miRNA star (miRNA*) products. The mature miRNA is incorporated into a RNA-induced silencing complex (RISC), which recognizes target mRNAs through imperfect base pairing with the miRNA and most commonly results in translational inhibition or destabilization of the target mRNA. The RefSeq represents the predicted microRNA stem-loop. [provided by RefSeq, Sep 2009].", "NCBIGene:1008470860": "None", "OMIM:100100": "In its rare complete form, 'prune belly' syndrome comprises megacystis (massively enlarged bladder) with disorganized detrusor muscle, cryptorchidism, and thin abdominal musculature with overlying lax skin (summary by {23:Weber et al., 2011}).", "OMIM:614747": "None", "OMIM:61447": "None", "REACT:R-HSA-70326": "Glucose is the major form in which dietary sugars are made available to cells of the human body. Its breakdown is a major source of energy for all cells, and is essential for the brain and red blood cells. Glucose utilization begins with its uptake by cells and conversion to glucose 6-phosphate, which cannot traverse the cell membrane. Fates open to cytosolic glucose 6-phosphate include glycolysis to yield pyruvate, glycogen synthesis, and the pentose phosphate pathway. In some tissues, notably the liver and kidney, glucose 6-phosphate can be synthesized from pyruvate by the pathway of gluconeogenesis.", "REACT:R-HSA-703260": "None"} \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/query_test_data.json b/code/reasoningtool/kg-construction/tests/query_test_data.json deleted file mode 100644 index a28947c19..000000000 --- a/code/reasoningtool/kg-construction/tests/query_test_data.json +++ /dev/null @@ -1 +0,0 @@ -{"ChEMBL:1200766": "{\"_id\": \"FIJFURWTHCVONZ-UHFFFAOYSA-N\", \"chembl\": {\"_license\": \"http://bit.ly/2KAUCAm\", \"availability_type\": -1, \"black_box_warning\": 0, \"chirality\": -1, \"dosed_ingredient\": false, \"first_in_class\": -1, \"inchi\": \"InChI=1S/C10H10N4O2S.Ag/c11-8-2-4-9(5-3-8)17(15,16)14-10-12-6-1-7-13-10;/h1-7H,11H2,(H,12,13,14);\", \"inchi_key\": \"FIJFURWTHCVONZ-UHFFFAOYSA-N\", \"inorganic_flag\": -1, \"max_phase\": 0, \"molecule_chembl_id\": \"CHEMBL1200766\", \"molecule_hierarchy\": {\"molecule_chembl_id\": \"CHEMBL1200766\", \"parent_chembl_id\": \"CHEMBL439\"}, \"molecule_properties\": {\"acd_logd\": -0.8, \"acd_logp\": -0.07, \"acd_most_apka\": 6.81, \"acd_most_bpka\": 1.57, \"alogp\": 0.86, \"aromatic_rings\": 2, \"full_molformula\": \"C10H10AgN4O2S\", \"full_mwt\": 358.15, \"hba\": 5, \"hba_lipinski\": 6, \"hbd\": 2, \"hbd_lipinski\": 3, \"heavy_atoms\": 17, \"molecular_species\": \"NEUTRAL\", \"mw_freebase\": 250.28, \"mw_monoisotopic\": 250.0524, \"num_lipinski_ro5_violations\": 0, \"num_ro5_violations\": 0, \"psa\": 97.97, \"qed_weighted\": 0.79, \"ro3_pass\": false, \"rtb\": 3}, \"molecule_type\": \"Small molecule\", \"natural_product\": -1, \"oral\": false, \"parenteral\": false, \"polymer_flag\": false, \"pref_name\": \"SILVER SULFADIAZINE\", \"prodrug\": -1, \"smiles\": \"[Ag].Nc1ccc(cc1)S(=O)(=O)Nc2ncccn2\", \"structure_type\": \"MOL\", \"therapeutic_flag\": false, \"topical\": false, \"withdrawn_flag\": false, \"xrefs\": {\"wikipedia\": {\"url_stub\": \"Silver_sulfadiazine\"}}}, \"pubchem\": {\"_license\": \"http://bit.ly/2AqoLOc\", \"chiral_atom_count\": 0, \"chiral_bond_count\": 0, \"cid\": 31011, \"complexity\": 327, \"covalently-bonded_unit_count\": 2, \"defined_atom_stereocenter_count\": 0, \"defined_bond_stereocenter_count\": 0, \"exact_mass\": 356.958, \"formal_charge\": 0, \"heavy_atom_count\": 18, \"hydrogen_bond_acceptor_count\": 6, \"hydrogen_bond_donor_count\": 2, \"inchi\": \"InChI=1S/C10H10N4O2S.Ag/c11-8-2-4-9(5-3-8)17(15,16)14-10-12-6-1-7-13-10;/h1-7H,11H2,(H,12,13,14);\", \"inchi_key\": \"FIJFURWTHCVONZ-UHFFFAOYSA-N\", \"isotope_atom_count\": 0, \"iupac\": {\"traditional\": \"4-amino-N-(2-pyrimidyl)benzenesulfonamide;silver\"}, \"molecular_formula\": \"C10H10AgN4O2S\", \"molecular_weight\": 358.144, \"monoisotopic_weight\": 356.958, \"rotatable_bond_count\": 3, \"smiles\": {\"isomeric\": \"C1=CN=C(N=C1)NS(=O)(=O)C2=CC=C(C=C2)N.[Ag]\"}, \"tautomers_count\": 2, \"topological_polar_surface_area\": 106, \"undefined_atom_stereocenter_count\": 0, \"undefined_bond_stereocenter_count\": 0}}", "UniProtKB:O60884": "{\"max_score\": 14.96799, \"took\": 3, \"total\": 1, \"hits\": [{\"HGNC\": \"14884\", \"MIM\": \"611322\", \"_id\": \"10294\", \"_score\": 14.96799, \"accession\": {\"genomic\": [\"AC018845.7\", \"CH471092.1\", \"KF511225.1\", \"NC_000016.10\"], \"protein\": [\"AAH13044.1\", \"AAH15809.1\", \"BAG35864.1\", \"CAA04669.1\", \"CAA73791.1\", \"EAW82693.1\", \"EAW82694.1\", \"NP_005871.1\", \"O60884.1\"], \"rna\": [\"AF088046.1\", \"AJ001309.1\", \"AK313031.1\", \"BC013044.2\", \"BC015809.2\", \"BU677823.1\", \"DB097731.1\", \"NM_005880.4\", \"Y13350.1\"], \"translation\": [{\"protein\": \"BAG35864.1\", \"rna\": \"AK313031.1\"}, {\"protein\": \"NP_005871.1\", \"rna\": \"NM_005880.4\"}, {\"protein\": \"AAH13044.1\", \"rna\": \"BC013044.2\"}, {\"protein\": \"CAA73791.1\", \"rna\": \"Y13350.1\"}, {\"protein\": \"CAA04669.1\", \"rna\": \"AJ001309.1\"}, {\"protein\": \"AAH15809.1\", \"rna\": \"BC015809.2\"}]}, \"alias\": [\"CPR3\", \"DJ3\", \"DJA2\", \"DNAJ\", \"DNJ3\", \"HIRIP4\", \"PRO3015\", \"RDJ2\"], \"ensembl\": {\"gene\": \"ENSG00000069345\", \"protein\": [\"ENSP00000314030\", \"ENSP00000460104\", \"ENSP00000477579\"], \"transcript\": [\"ENST00000317089\", \"ENST00000563158\", \"ENST00000569553\", \"ENST00000617000\"], \"translation\": [{\"protein\": \"ENSP00000314030\", \"rna\": \"ENST00000317089\"}, {\"protein\": \"ENSP00000460104\", \"rna\": \"ENST00000563158\"}, {\"protein\": \"ENSP00000477579\", \"rna\": \"ENST00000617000\"}], \"type_of_gene\": \"protein_coding\"}, \"entrezgene\": \"10294\", \"exac\": {\"all\": {\"exp_lof\": 16.9542504978, \"exp_mis\": 143.627955446, \"exp_syn\": 59.3341433404, \"lof_z\": 3.83819258298381, \"mis_z\": 2.6784656561571, \"mu_lof\": 1.18895584304e-06, \"mu_mis\": 1.25940449658e-05, \"mu_syn\": 5.02750568952e-06, \"n_lof\": 1.0, \"n_mis\": 78.0, \"n_syn\": 59.0, \"p_li\": 0.985455360988873, \"p_null\": 1.48315451346589e-06, \"p_rec\": 0.0145431558566137, \"syn_z\": 0.0268921532205812}, \"bp\": 1239, \"cds_end\": 47007483, \"cds_start\": 46990940, \"n_exons\": 9, \"nonpsych\": {\"exp_lof\": 15.162924589, \"exp_mis\": 129.81485506, \"exp_syn\": 53.5208152658, \"lof_z\": 3.57201559189748, \"mis_z\": 3.09063346007544, \"mu_lof\": 1.18895584304e-06, \"mu_mis\": 1.25940449658e-05, \"mu_syn\": 5.02750568952e-06, \"n_lof\": 1.0, \"n_mis\": 60.0, \"n_syn\": 52.0, \"p_li\": 0.97543234050995, \"p_null\": 6.57814454072261e-06, \"p_rec\": 0.0245610813455088, \"syn_z\": 0.130882008705208}, \"nontcga\": {\"exp_lof\": 15.5801407973, \"exp_mis\": 132.119958327, \"exp_syn\": 54.5696417429, \"lof_z\": 3.64382370415299, \"mis_z\": 2.82253762052664, \"mu_lof\": 1.18895584304e-06, \"mu_mis\": 1.25940449658e-05, \"mu_syn\": 5.02750568952e-06, \"n_lof\": 1.0, \"n_mis\": 67.0, \"n_syn\": 53.0, \"p_li\": 0.976856422595422, \"p_null\": 4.64567542143199e-06, \"p_rec\": 0.0231389317291569, \"syn_z\": 0.134538567487857}, \"transcript\": \"ENST00000317089.5\"}, \"exons\": [{\"cdsend\": 46973572, \"cdsstart\": 46957028, \"chr\": \"16\", \"position\": [[46955361, 46957220], [46959002, 46959130], [46959274, 46959419], [46964610, 46964807], [46967512, 46967646], [46968083, 46968164], [46971348, 46971572], [46971895, 46971955], [46973494, 46973714]], \"strand\": -1, \"transcript\": \"NM_005880\", \"txend\": 46973714, \"txstart\": 46955361}], \"exons_hg19\": [{\"cdsend\": 47007483, \"cdsstart\": 46990940, \"chr\": \"16\", \"position\": [[46989273, 46991132], [46992914, 46993042], [46993186, 46993331], [46998522, 46998719], [47001424, 47001558], [47001995, 47002076], [47005260, 47005484], [47005807, 47005867], [47007405, 47007625]], \"strand\": -1, \"transcript\": \"NM_005880\", \"txend\": 47007625, \"txstart\": 46989273}], \"generif\": [{\"pubmed\": 18595009, \"text\": \"Rdj2 modulates G protein signaling and further suggest that chaperoning G proteins is an emerging theme of the J protein network.\"}, {\"pubmed\": 18684711, \"text\": \"Bag1 NEF increased refolding by Hsc70 and DJA2, as did the newly characterized NEF Hsp110\"}, {\"pubmed\": 19940115, \"text\": \"Hsp40 type 1 chaperones DJA1 (DNAJA1/Hdj2) and DJA2 (DNAJA2) as key modulators of hERG degradation\"}, {\"pubmed\": 23091061, \"text\": \"The DNAJA2 substrate release mechanism is essential for chaperone-mediated folding.\"}, {\"pubmed\": 24318877, \"text\": \"we combined the Hsp70-NEF pairs with cochaperones of the J protein family (DnaJA1, DnaJA2, DnaJB1, and DnaJB4) to generate 16 permutations.\"}], \"genomic_pos\": {\"chr\": \"16\", \"end\": 46973788, \"ensemblgene\": \"ENSG00000069345\", \"start\": 46955362, \"strand\": -1}, \"genomic_pos_hg19\": {\"chr\": \"16\", \"end\": 47007699, \"start\": 46989299, \"strand\": -1}, \"go\": {\"BP\": [{\"evidence\": \"TAS\", \"gocategory\": \"BP\", \"id\": \"GO:0008284\", \"pubmed\": 9383053, \"term\": \"positive regulation of cell proliferation\"}, {\"evidence\": \"IEA\", \"gocategory\": \"BP\", \"id\": \"GO:0009408\", \"term\": \"response to heat\"}, {\"evidence\": \"IEA\", \"gocategory\": \"BP\", \"id\": \"GO:0032781\", \"term\": \"positive regulation of ATPase activity\"}, {\"evidence\": \"IDA\", \"gocategory\": \"BP\", \"id\": \"GO:0042026\", \"pubmed\": 21231916, \"term\": \"protein refolding\"}], \"CC\": [{\"evidence\": \"IBA\", \"gocategory\": \"CC\", \"id\": \"GO:0005829\", \"pubmed\": 21873635, \"term\": \"cytosol\"}, {\"evidence\": \"IDA\", \"gocategory\": \"CC\", \"id\": \"GO:0005829\", \"pubmed\": 21231916, \"term\": \"cytosol\"}, {\"evidence\": \"TAS\", \"gocategory\": \"CC\", \"id\": \"GO:0005829\", \"term\": \"cytosol\"}, {\"evidence\": \"IEA\", \"gocategory\": \"CC\", \"id\": \"GO:0016020\", \"term\": \"membrane\"}, {\"evidence\": \"HDA\", \"gocategory\": \"CC\", \"id\": \"GO:0070062\", \"pubmed\": 19056867, \"term\": \"extracellular exosome\"}], \"MF\": [{\"category\": \"MF\", \"evidence\": \"IDA\", \"id\": \"GO:0001671\", \"pubmed\": 24318877, \"term\": \"ATPase activator activity\"}, {\"category\": \"MF\", \"evidence\": \"IPI\", \"id\": \"GO:0005515\", \"pubmed\": [22085931, 25036637], \"term\": \"protein binding\"}, {\"category\": \"MF\", \"evidence\": \"IEA\", \"id\": \"GO:0005524\", \"term\": \"ATP binding\"}, {\"category\": \"MF\", \"evidence\": \"IEA\", \"id\": \"GO:0031072\", \"term\": \"heat shock protein binding\"}, {\"category\": \"MF\", \"evidence\": \"IEA\", \"id\": \"GO:0046872\", \"term\": \"metal ion binding\"}, {\"category\": \"MF\", \"evidence\": \"IDA\", \"id\": \"GO:0051082\", \"pubmed\": 21231916, \"term\": \"unfolded protein binding\"}, {\"category\": \"MF\", \"evidence\": \"IPI\", \"id\": \"GO:0051087\", \"pubmed\": 21231916, \"term\": \"chaperone binding\"}]}, \"homologene\": {\"genes\": [[3702, 823531], [3702, 832267], [4530, 4333580], [4530, 4334359], [4896, 2539671], [4932, 855661], [5141, 3874567], [6239, 3565862], [7955, 406814], [8364, 448048], [9031, 415744], [9544, 695169], [9598, 473274], [9606, 10294], [9615, 478143], [9913, 360006], [10090, 56445], [10116, 84026], [28985, 2895719], [33169, 4619974], [318829, 2678160]], \"id\": 21193}, \"interpro\": [{\"desc\": \"Heat shock protein DnaJ, cysteine-rich domain\", \"id\": \"IPR001305\", \"short_desc\": \"HSP_DnaJ_Cys-rich_dom\"}, {\"desc\": \"HSP40/DnaJ peptide-binding\", \"id\": \"IPR008971\", \"short_desc\": \"HSP40/DnaJ_pept-bd\"}, {\"desc\": \"Heat shock protein DnaJ, cysteine-rich domain superfamily\", \"id\": \"IPR036410\", \"short_desc\": \"HSP_DnaJ_Cys-rich_dom_sf\"}, {\"desc\": \"DnaJ domain\", \"id\": \"IPR001623\", \"short_desc\": \"DnaJ_domain\"}, {\"desc\": \"Chaperone DnaJ, C-terminal\", \"id\": \"IPR002939\", \"short_desc\": \"DnaJ_C\"}, {\"desc\": \"Chaperone DnaJ\", \"id\": \"IPR012724\", \"short_desc\": \"DnaJ\"}, {\"desc\": \"DnaJ domain, conserved site\", \"id\": \"IPR018253\", \"short_desc\": \"DnaJ_domain_CS\"}, {\"desc\": \"Chaperone J-domain superfamily\", \"id\": \"IPR036869\", \"short_desc\": \"J_dom_sf\"}], \"ipi\": \"IPI00032406\", \"map_location\": \"16q11.2\", \"name\": \"DnaJ heat shock protein family (Hsp40) member A2\", \"other_names\": [\"DnaJ (Hsp40) homolog, subfamily A, member 2\", \"HIRA interacting protein 4\", \"cell cycle progression 3 protein\", \"cell cycle progression restoration gene 3 protein\", \"dnaJ homolog subfamily A member 2\", \"renal carcinoma antigen NY-REN-14\"], \"pantherdb\": {\"HGNC\": \"14884\", \"ortholog\": [{\"MGI\": \"1931882\", \"ortholog_type\": \"LDO\", \"panther_family\": \"PTHR43888\", \"taxid\": 10090, \"uniprot_kb\": \"Q9QYJ0\"}, {\"RGD\": \"71001\", \"ortholog_type\": \"LDO\", \"panther_family\": \"PTHR43888\", \"taxid\": 10116, \"uniprot_kb\": \"O35824\"}, {\"Ensembl\": \"ENSGALG00000004115\", \"ortholog_type\": \"LDO\", \"panther_family\": \"PTHR43888\", \"taxid\": 9031, \"uniprot_kb\": \"Q5ZIZ7\"}, {\"ZFIN\": \"ZDB-GENE-030131-2884\", \"ortholog_type\": \"O\", \"panther_family\": \"PTHR43888\", \"taxid\": 7955, \"uniprot_kb\": \"A5WVI9\"}, {\"ZFIN\": \"ZDB-GENE-040426-2884\", \"ortholog_type\": \"LDO\", \"panther_family\": \"PTHR43888\", \"taxid\": 7955, \"uniprot_kb\": \"A0A0R4IH71\"}, {\"WormBase\": \"WBGene00001037\", \"ortholog_type\": \"LDO\", \"panther_family\": \"PTHR43888\", \"taxid\": 6239, \"uniprot_kb\": \"O16303\"}, {\"FlyBase\": \"FBgn0032474\", \"ortholog_type\": \"LDO\", \"panther_family\": \"PTHR43888\", \"taxid\": 7227, \"uniprot_kb\": \"M9PD23\"}, {\"SGD\": \"S000005021\", \"ortholog_type\": \"O\", \"panther_family\": \"PTHR43888\", \"taxid\": 4932, \"uniprot_kb\": \"P53940\"}, {\"SGD\": \"S000005008\", \"ortholog_type\": \"LDO\", \"panther_family\": \"PTHR43888\", \"taxid\": 4932, \"uniprot_kb\": \"P25491\"}, {\"PomBase\": \"SPBC1734.11\", \"ortholog_type\": \"LDO\", \"panther_family\": \"PTHR43888\", \"taxid\": 4896, \"uniprot_kb\": \"O74752\"}, {\"dictyBase\": \"DDB_G0291568\", \"ortholog_type\": \"O\", \"panther_family\": \"PTHR43888\", \"taxid\": 352472, \"uniprot_kb\": \"Q54ED3\"}, {\"dictyBase\": \"DDB_G0280037\", \"ortholog_type\": \"LDO\", \"panther_family\": \"PTHR43888\", \"taxid\": 352472, \"uniprot_kb\": \"Q54VQ1\"}, {\"TAIR\": \"AT5G22060\", \"ortholog_type\": \"O\", \"panther_family\": \"PTHR43888\", \"taxid\": 3702, \"uniprot_kb\": \"P42825\"}, {\"Gene\": \"AT3G44110\", \"ortholog_type\": \"O\", \"panther_family\": \"PTHR43888\", \"taxid\": 3702, \"uniprot_kb\": \"Q94AW8\"}], \"uniprot_kb\": \"O60884\"}, \"pathway\": {\"kegg\": {\"id\": \"hsa04141\", \"name\": \"Protein processing in endoplasmic reticulum - Homo sapiens (human)\"}, \"reactome\": [{\"id\": \"R-HSA-2262752\", \"name\": \"Cellular responses to stress\"}, {\"id\": \"R-HSA-3371497\", \"name\": \"HSP90 chaperone cycle for steroid hormone receptors (SHR)\"}, {\"id\": \"R-HSA-8953897\", \"name\": \"Cellular responses to external stimuli\"}]}, \"pfam\": [\"PF00226\", \"PF00684\", \"PF01556\"], \"pharmgkb\": \"PA27409\", \"pharos\": {\"target_id\": 17188}, \"prosite\": [\"PS50076\", \"PS51188\"], \"reagent\": {\"GNF_Qia_hs-genome_v1_siRNA\": [{\"id\": \"GNF169458\", \"relationship\": \"is\"}, {\"id\": \"GNF180364\", \"relationship\": \"is\"}, {\"id\": \"GNF191270\", \"relationship\": \"is\"}, {\"id\": \"GNF202176\", \"relationship\": \"is\"}], \"GNF_hs-ORFeome1_1_reads\": {\"id\": \"GNF157599\", \"relationship\": \"similar to\"}, \"GNF_hs-Origene\": {\"id\": \"GNF031491\", \"relationship\": \"is\"}, \"GNF_mm+hs-MGC\": [{\"id\": \"GNF003716\", \"relationship\": \"is\"}, {\"id\": \"GNF003717\", \"relationship\": \"is\"}], \"GNF_mm+hs_RetroCDNA\": [{\"id\": \"GNF234573\", \"relationship\": \"is\"}, {\"id\": \"GNF284811\", \"relationship\": \"is\"}], \"NOVART_hs-genome_siRNA\": [{\"id\": \"GNF100103\", \"relationship\": \"is\"}, {\"id\": \"GNF139758\", \"relationship\": \"is\"}]}, \"refseq\": {\"genomic\": \"NC_000016.10\", \"protein\": \"NP_005871.1\", \"rna\": \"NM_005880.4\", \"translation\": {\"protein\": \"NP_005871.1\", \"rna\": \"NM_005880.4\"}}, \"reporter\": {\"HG-U133_Plus_2\": [\"209157_at\", \"226994_at\"], \"HG-U95Av2\": \"34201_at\", \"HG-U95B\": \"51644_at\", \"HTA-2_0\": \"TC16001087.hg.1\", \"HuEx-1_0\": \"3690084\", \"HuGene-1_1\": \"8001185\", \"HuGene-2_1\": \"16826218\"}, \"retired\": [9237, 55499, 124142], \"summary\": \"The protein encoded by this gene belongs to the evolutionarily conserved DNAJ/HSP40 family of proteins, which regulate molecular chaperone activity by stimulating ATPase activity. DNAJ proteins may have up to 3 distinct domains: a conserved 70-amino acid J domain, usually at the N terminus; a glycine/phenylalanine (G/F)-rich region; and a cysteine-rich domain containing 4 motifs resembling a zinc finger domain. The product of this gene works as a cochaperone of Hsp70s in protein folding and mitochondrial protein import in vitro. [provided by RefSeq, Jul 2008].\", \"symbol\": \"DNAJA2\", \"taxid\": 9606, \"type_of_gene\": \"protein-coding\", \"umls\": {\"cui\": \"C1423023\"}, \"unigene\": \"Hs.368078\", \"uniprot\": {\"Swiss-Prot\": \"O60884\", \"TrEMBL\": [\"I3L320\", \"A0A024R6S1\", \"A0A087WT48\"]}, \"wikipedia\": {\"url_stub\": \"DNAJA2\"}}]}", "NCBIGene:100847086": "{\"max_score\": 22.198946, \"took\": 3, \"total\": 1, \"hits\": [{\"HGNC\": \"43456\", \"_id\": \"100847086\", \"_score\": 22.198946, \"accession\": {\"genomic\": [\"AL358216.33\", \"NC_000010.11\"], \"rna\": [\"LM611615.1\", \"NR_049884.1\"]}, \"alias\": \"mir-5699\", \"ensembl\": {\"gene\": \"ENSG00000263511\", \"transcript\": \"ENST00000578903\", \"translation\": [], \"type_of_gene\": \"miRNA\"}, \"entrezgene\": \"100847086\", \"exons\": [{\"cdsend\": 641778, \"cdsstart\": 641778, \"chr\": \"10\", \"position\": [[641688, 641778]], \"strand\": -1, \"transcript\": \"NR_049884\", \"txend\": 641778, \"txstart\": 641688}], \"exons_hg19\": [{\"cdsend\": 687718, \"cdsstart\": 687718, \"chr\": \"10\", \"position\": [[687628, 687718]], \"strand\": -1, \"transcript\": \"NR_049884\", \"txend\": 687718, \"txstart\": 687628}], \"genomic_pos\": {\"chr\": \"10\", \"end\": 641778, \"ensemblgene\": \"ENSG00000263511\", \"start\": 641689, \"strand\": -1}, \"genomic_pos_hg19\": {\"chr\": \"10\", \"end\": 687718, \"start\": 687629, \"strand\": -1}, \"map_location\": \"10p15.3\", \"miRBase\": \"MI0019306\", \"name\": \"microRNA 5699\", \"other_names\": \"hsa-mir-5699\", \"refseq\": {\"genomic\": \"NC_000010.11\", \"rna\": \"NR_049884.1\"}, \"summary\": \"microRNAs (miRNAs) are short (20-24 nt) non-coding RNAs that are involved in post-transcriptional regulation of gene expression in multicellular organisms by affecting both the stability and translation of mRNAs. miRNAs are transcribed by RNA polymerase II as part of capped and polyadenylated primary transcripts (pri-miRNAs) that can be either protein-coding or non-coding. The primary transcript is cleaved by the Drosha ribonuclease III enzyme to produce an approximately 70-nt stem-loop precursor miRNA (pre-miRNA), which is further cleaved by the cytoplasmic Dicer ribonuclease to generate the mature miRNA and antisense miRNA star (miRNA*) products. The mature miRNA is incorporated into a RNA-induced silencing complex (RISC), which recognizes target mRNAs through imperfect base pairing with the miRNA and most commonly results in translational inhibition or destabilization of the target mRNA. The RefSeq represents the predicted microRNA stem-loop. [provided by RefSeq, Sep 2009].\", \"symbol\": \"MIR5699\", \"taxid\": 9606, \"type_of_gene\": \"ncRNA\", \"umls\": {\"cui\": \"C3471092\"}}]}", "NCBIGene: 100847086": "{\"max_score\": 21.416672, \"took\": 2, \"total\": 1, \"hits\": [{\"HGNC\": \"43456\", \"_id\": \"100847086\", \"_score\": 21.416672, \"accession\": {\"genomic\": [\"AL358216.33\", \"NC_000010.11\"], \"rna\": [\"LM611615.1\", \"NR_049884.1\"]}, \"alias\": \"mir-5699\", \"ensembl\": {\"gene\": \"ENSG00000263511\", \"transcript\": \"ENST00000578903\", \"translation\": [], \"type_of_gene\": \"miRNA\"}, \"entrezgene\": \"100847086\", \"exons\": [{\"cdsend\": 641778, \"cdsstart\": 641778, \"chr\": \"10\", \"position\": [[641688, 641778]], \"strand\": -1, \"transcript\": \"NR_049884\", \"txend\": 641778, \"txstart\": 641688}], \"exons_hg19\": [{\"cdsend\": 687718, \"cdsstart\": 687718, \"chr\": \"10\", \"position\": [[687628, 687718]], \"strand\": -1, \"transcript\": \"NR_049884\", \"txend\": 687718, \"txstart\": 687628}], \"genomic_pos\": {\"chr\": \"10\", \"end\": 641778, \"ensemblgene\": \"ENSG00000263511\", \"start\": 641689, \"strand\": -1}, \"genomic_pos_hg19\": {\"chr\": \"10\", \"end\": 687718, \"start\": 687629, \"strand\": -1}, \"map_location\": \"10p15.3\", \"miRBase\": \"MI0019306\", \"name\": \"microRNA 5699\", \"other_names\": \"hsa-mir-5699\", \"refseq\": {\"genomic\": \"NC_000010.11\", \"rna\": \"NR_049884.1\"}, \"summary\": \"microRNAs (miRNAs) are short (20-24 nt) non-coding RNAs that are involved in post-transcriptional regulation of gene expression in multicellular organisms by affecting both the stability and translation of mRNAs. miRNAs are transcribed by RNA polymerase II as part of capped and polyadenylated primary transcripts (pri-miRNAs) that can be either protein-coding or non-coding. The primary transcript is cleaved by the Drosha ribonuclease III enzyme to produce an approximately 70-nt stem-loop precursor miRNA (pre-miRNA), which is further cleaved by the cytoplasmic Dicer ribonuclease to generate the mature miRNA and antisense miRNA star (miRNA*) products. The mature miRNA is incorporated into a RNA-induced silencing complex (RISC), which recognizes target mRNAs through imperfect base pairing with the miRNA and most commonly results in translational inhibition or destabilization of the target mRNA. The RefSeq represents the predicted microRNA stem-loop. [provided by RefSeq, Sep 2009].\", \"symbol\": \"MIR5699\", \"taxid\": 9606, \"type_of_gene\": \"ncRNA\", \"umls\": {\"cui\": \"C3471092\"}}]}", "REACT:R-HSA-70326": "[{\"dbId\": 70263, \"displayName\": \"Gluconeogenesis\", \"stId\": \"R-HSA-70263\", \"stIdVersion\": \"R-HSA-70263.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"Gluconeogenesis\"], \"releaseDate\": \"2003-02-03\", \"speciesName\": \"Homo sapiens\", \"hasDiagram\": false, \"hasEHLD\": false, \"schemaClass\": \"Pathway\", \"className\": \"Pathway\"}, {\"dbId\": 198458, \"displayName\": \"Efflux of glucose from the endoplasmic reticulum\", \"stId\": \"R-HSA-198458\", \"stIdVersion\": \"R-HSA-198458.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"Efflux of glucose from the endoplasmic reticulum\"], \"releaseDate\": \"2005-09-26\", \"speciesName\": \"Homo sapiens\", \"category\": \"uncertain\", \"className\": \"Reaction\", \"schemaClass\": \"BlackBoxEvent\"}, {\"dbId\": 3266566, \"displayName\": \"G6PC2 hydrolyzes glucose 6-phosphate to form glucose and orthophosphate (islet)\", \"stId\": \"R-HSA-3266566\", \"stIdVersion\": \"R-HSA-3266566.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"G6PC2 hydrolyzes glucose 6-phosphate to form glucose and orthophosphate (islet)\", \"alpha-D-Glucose 6-phosphate + H2O => alpha-D-Glucose + Orthophosphate (G6PC2 - islet)\"], \"releaseDate\": \"2013-06-11\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 198513, \"displayName\": \"Cytosolic glucose 6-phosphate is exchanged for orthophosphate from the endoplasmic reticulum lumen by SLC37A4\", \"stId\": \"R-HSA-198513\", \"stIdVersion\": \"R-HSA-198513.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"Cytosolic glucose 6-phosphate is exchanged for orthophosphate from the endoplasmic reticulum lumen by SLC37A4\", \"alpha-D-glucose 6-phosphate (cytosol) + orthophosphate (ER lumen) => alpha-D-glucose 6-phosphate (ER lumen) + orthophosphate (cytosol) (SLC37A4)\"], \"releaseDate\": \"2005-09-26\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 198508, \"displayName\": \"malate + NAD+ <=> oxaloacetate + NADH + H+\", \"stId\": \"R-HSA-198508\", \"stIdVersion\": \"R-HSA-198508.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"malate + NAD+ <=> oxaloacetate + NADH + H+\", \"(S)-malate + NAD+ <=> oxaloacetate + NADH + H+\"], \"releaseDate\": \"2005-09-26\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 372843, \"displayName\": \"malate [mitochondrial matrix] + orthophosphate [cytosol] <=> malate [cytosol] + orthophosphate [mitochondrial matrix]\", \"stId\": \"R-HSA-372843\", \"stIdVersion\": \"R-HSA-372843.1\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"malate [mitochondrial matrix] + orthophosphate [cytosol] <=> malate [cytosol] + orthophosphate [mitochondrial matrix]\"], \"releaseDate\": \"2008-09-30\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 198440, \"displayName\": \"malate [mitochondrial matrix] + alpha-ketoglutarate [cytosol] <=> malate [cytosol] + alpha-ketoglutarate [mitochondrial matrix]\", \"stId\": \"R-HSA-198440\", \"stIdVersion\": \"R-HSA-198440.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"malate [mitochondrial matrix] + alpha-ketoglutarate [cytosol] <=> malate [cytosol] + alpha-ketoglutarate [mitochondrial matrix]\", \"Exchange of malate and alpha-ketoglutarate (2-oxoglutarate) across the inner mitochondrial membrane\"], \"releaseDate\": \"2005-09-26\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 71783, \"displayName\": \"Oxaloacetate + NADH + H+ <=> (S)-Malate + NAD+\", \"stId\": \"R-HSA-71783\", \"stIdVersion\": \"R-HSA-71783.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"Oxaloacetate + NADH + H+ <=> (S)-Malate + NAD+\"], \"releaseDate\": \"2007-09-04\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 372448, \"displayName\": \"SLC25A12,13 exchange cytosolic L-Glu for mitochondrial matrix L-Asp\", \"stId\": \"R-HSA-372448\", \"stIdVersion\": \"R-HSA-372448.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"SLC25A12,13 exchange cytosolic L-Glu for mitochondrial matrix L-Asp\", \"aspartate [mitochondrial matrix] + glutamate [cytosol] => aspartate [cytosol] + glutamate [mitochondrial matrix]\"], \"releaseDate\": \"2009-06-01\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 372449, \"displayName\": \"phosphoenolpyruvate [mitochondrial matrix] + citrate [cytosol] => phosphoenolpyruvate [cytosol] + citrate [mitochondrial matrix]\", \"stId\": \"R-HSA-372449\", \"stIdVersion\": \"R-HSA-372449.1\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"phosphoenolpyruvate [mitochondrial matrix] + citrate [cytosol] => phosphoenolpyruvate [cytosol] + citrate [mitochondrial matrix]\", \"Exchange of cytosolic citrate for mitochondrial phosphoenolpyruvate\"], \"releaseDate\": \"2008-09-30\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70501, \"displayName\": \"Pyruvate + CO2 + ATP => ADP + Orthophosphate + Oxaloacetate\", \"stId\": \"R-HSA-70501\", \"stIdVersion\": \"R-HSA-70501.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"Pyruvate + CO2 + ATP => ADP + Orthophosphate + Oxaloacetate\", \"Pyruvate, CO2, and ATP react to form oxaloacetate, ADP, and orthophosphate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70241, \"displayName\": \"oxaloacetate + GTP => phosphoenolpyruvate + GDP + CO2 [cytosol]\", \"stId\": \"R-HSA-70241\", \"stIdVersion\": \"R-HSA-70241.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"oxaloacetate + GTP => phosphoenolpyruvate + GDP + CO2 [cytosol]\", \"Oxaloacetate and GTP react to form phosphoenolpyruvate, CO2, and GDP [cytosol]\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70494, \"displayName\": \"Phosphoenolpyruvate + H2O <=> 2-Phospho-D-glycerate\", \"stId\": \"R-HSA-70494\", \"stIdVersion\": \"R-HSA-70494.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"Phosphoenolpyruvate + H2O <=> 2-Phospho-D-glycerate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70486, \"displayName\": \"ATP + 3-Phospho-D-glycerate <=> ADP + 1,3-bisphospho-D-glycerate\", \"stId\": \"R-HSA-70486\", \"stIdVersion\": \"R-HSA-70486.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"ATP + 3-Phospho-D-glycerate <=> ADP + 1,3-bisphospho-D-glycerate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 372819, \"displayName\": \"oxaloacetate + GTP => phosphoenolpyruvate + GDP + CO2 [mitochondrial matrix]\", \"stId\": \"R-HSA-372819\", \"stIdVersion\": \"R-HSA-372819.1\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"oxaloacetate + GTP => phosphoenolpyruvate + GDP + CO2 [mitochondrial matrix]\"], \"releaseDate\": \"2008-09-30\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 376851, \"displayName\": \"Exchange of alpha-ketoglutarate (2-oxoglutarate) and malate across the inner mitochondrial membrane\", \"stId\": \"R-HSA-376851\", \"stIdVersion\": \"R-HSA-376851.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"Exchange of alpha-ketoglutarate (2-oxoglutarate) and malate across the inner mitochondrial membrane\", \"malate [cytosol] + alpha-ketoglutarate [mitochondrial matrix] <=> malate [mitochondrial matrix] + alpha-ketoglutarate [cytosol]\"], \"releaseDate\": \"2008-06-30\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 71445, \"displayName\": \"2-Phospho-D-glycerate <=> 3-Phospho-D-glycerate\", \"stId\": \"R-HSA-71445\", \"stIdVersion\": \"R-HSA-71445.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"2-Phospho-D-glycerate <=> 3-Phospho-D-glycerate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70613, \"displayName\": \"oxaloacetate + glutamate <=> aspartate + alpha-ketoglutarate [GOT2]\", \"stId\": \"R-HSA-70613\", \"stIdVersion\": \"R-HSA-70613.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"oxaloacetate + glutamate <=> aspartate + alpha-ketoglutarate [GOT2]\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 3257122, \"displayName\": \"SLC37A1, SLC37A2 exchange G6P for Pi across the endoplasmic reticulum membrane\", \"stId\": \"R-HSA-3257122\", \"stIdVersion\": \"R-HSA-3257122.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"SLC37A1, SLC37A2 exchange G6P for Pi across the endoplasmic reticulum membrane\", \"alpha-D-glucose 6-phosphate (cytosol) + orthophosphate (ER lumen) => alpha-D-glucose 6-phosphate (ER lumen) + orthophosphate (cytosol) (SLC37A1 or SLC37A2)\"], \"releaseDate\": \"2017-03-27\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70482, \"displayName\": \"1,3-bisphospho-D-glycerate + NADH + H+ <=> D-glyceraldehyde 3-phosphate + Orthophosphate + NAD+\", \"stId\": \"R-HSA-70482\", \"stIdVersion\": \"R-HSA-70482.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"1,3-bisphospho-D-glycerate + NADH + H+ <=> D-glyceraldehyde 3-phosphate + Orthophosphate + NAD+\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 71825, \"displayName\": \"G6PC hydrolyzes glucose 6-phosphate to form glucose and orthophosphate (liver)\", \"stId\": \"R-HSA-71825\", \"stIdVersion\": \"R-HSA-71825.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"G6PC hydrolyzes glucose 6-phosphate to form glucose and orthophosphate (liver)\", \"alpha-D-Glucose 6-phosphate + H2O => alpha-D-Glucose + Orthophosphate (G6PC - liver)\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70481, \"displayName\": \"D-glyceraldehyde 3-phosphate <=> dihydroxyacetone phosphate\", \"stId\": \"R-HSA-70481\", \"stIdVersion\": \"R-HSA-70481.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"D-glyceraldehyde 3-phosphate <=> dihydroxyacetone phosphate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70479, \"displayName\": \"D-fructose 1,6-bisphosphate + H2O => D-fructose 6-phosphate + orthophosphate\", \"stId\": \"R-HSA-70479\", \"stIdVersion\": \"R-HSA-70479.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"D-fructose 1,6-bisphosphate + H2O => D-fructose 6-phosphate + orthophosphate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70475, \"displayName\": \"D-fructose 6-phosphate <=> alpha-D-Glucose 6-phosphate\", \"stId\": \"R-HSA-70475\", \"stIdVersion\": \"R-HSA-70475.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"D-fructose 6-phosphate <=> alpha-D-Glucose 6-phosphate\"], \"releaseDate\": \"2003-09-03\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 71495, \"displayName\": \"dihydroxyacetone phosphate + D-glyceraldehyde 3-phosphate <=> D-fructose 1,6-bisphosphate\", \"stId\": \"R-HSA-71495\", \"stIdVersion\": \"R-HSA-71495.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"dihydroxyacetone phosphate + D-glyceraldehyde 3-phosphate <=> D-fructose 1,6-bisphosphate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 3262512, \"displayName\": \"G6PC3 hydrolyzes glucose 6-phosphate to form glucose and orthophosphate (ubiquitous)\", \"stId\": \"R-HSA-3262512\", \"stIdVersion\": \"R-HSA-3262512.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"G6PC3 hydrolyzes glucose 6-phosphate to form glucose and orthophosphate (ubiquitous)\", \"alpha-D-Glucose 6-phosphate + H2O => alpha-D-Glucose + Orthophosphate (G6PC3 - ubiquitous)\"], \"releaseDate\": \"2013-06-11\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70592, \"displayName\": \"aspartate + alpha-ketoglutarate <=> oxaloacetate + glutamate [GOT1]\", \"stId\": \"R-HSA-70592\", \"stIdVersion\": \"R-HSA-70592.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"aspartate + alpha-ketoglutarate <=> oxaloacetate + glutamate [GOT1]\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70171, \"displayName\": \"Glycolysis\", \"stId\": \"R-HSA-70171\", \"stIdVersion\": \"R-HSA-70171.5\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"Glycolysis\"], \"releaseDate\": \"2003-02-03\", \"speciesName\": \"Homo sapiens\", \"hasDiagram\": false, \"hasEHLD\": false, \"schemaClass\": \"Pathway\", \"className\": \"Pathway\"}, {\"dbId\": 70467, \"displayName\": \"D-fructose 6-phosphate + ATP => D-fructose 1,6-bisphosphate + ADP\", \"stId\": \"R-HSA-70467\", \"stIdVersion\": \"R-HSA-70467.4\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"D-fructose 6-phosphate + ATP => D-fructose 1,6-bisphosphate + ADP\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 5696021, \"displayName\": \"ADPGK:Mg2+ phosphorylates Glc to G6P\", \"stId\": \"R-HSA-5696021\", \"stIdVersion\": \"R-HSA-5696021.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"ADPGK:Mg2+ phosphorylates Glc to G6P\"], \"releaseDate\": \"2015-09-22\", \"speciesName\": \"Homo sapiens\", \"isChimeric\": false, \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 170822, \"displayName\": \"Regulation of Glucokinase by Glucokinase Regulatory Protein\", \"stId\": \"R-HSA-170822\", \"stIdVersion\": \"R-HSA-170822.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"Regulation of Glucokinase by Glucokinase Regulatory Protein\"], \"releaseDate\": \"2005-06-13\", \"speciesName\": \"Homo sapiens\", \"hasDiagram\": false, \"hasEHLD\": false, \"schemaClass\": \"Pathway\", \"className\": \"Pathway\"}, {\"dbId\": 170810, \"displayName\": \"nucleoplasmic GCK1:GKRP complex => glucokinase (GCK1) + glucokinase regulatory protein (GKRP)\", \"stId\": \"R-HSA-170810\", \"stIdVersion\": \"R-HSA-170810.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"nucleoplasmic GCK1:GKRP complex => glucokinase (GCK1) + glucokinase regulatory protein (GKRP)\", \"Dissociation of the nucleoplasmic GCK1:GKRP complex\"], \"releaseDate\": \"2005-06-13\", \"speciesName\": \"Homo sapiens\", \"category\": \"dissociation\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 170824, \"displayName\": \"glucokinase (GCK1) + glucokinase regulatory protein (GKRP) <=> GCK1:GKRP complex\", \"stId\": \"R-HSA-170824\", \"stIdVersion\": \"R-HSA-170824.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"glucokinase (GCK1) + glucokinase regulatory protein (GKRP) <=> GCK1:GKRP complex\"], \"releaseDate\": \"2005-06-13\", \"speciesName\": \"Homo sapiens\", \"category\": \"binding\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 170825, \"displayName\": \"glucokinase [nucleoplasm] => glucokinase [cytosol]\", \"stId\": \"R-HSA-170825\", \"stIdVersion\": \"R-HSA-170825.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"glucokinase [nucleoplasm] => glucokinase [cytosol]\"], \"releaseDate\": \"2005-06-13\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 170799, \"displayName\": \"cytosolic GCK1:GKRP complex <=> glucokinase (GCK1) + glucokinase regulatory protein (GKRP)\", \"stId\": \"R-HSA-170799\", \"stIdVersion\": \"R-HSA-170799.4\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"cytosolic GCK1:GKRP complex <=> glucokinase (GCK1) + glucokinase regulatory protein (GKRP)\"], \"releaseDate\": \"2005-06-13\", \"speciesName\": \"Homo sapiens\", \"category\": \"dissociation\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 170796, \"displayName\": \"NPC transports GCK1:GKRP from cytosol to nucleoplasm\", \"stId\": \"R-HSA-170796\", \"stIdVersion\": \"R-HSA-170796.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"NPC transports GCK1:GKRP from cytosol to nucleoplasm\", \"Transport of glucokinase (GCK1):GKRP complex to the nucleus\"], \"releaseDate\": \"2006-04-24\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 163750, \"displayName\": \"Dephosphorylation of phosphoPFKFB1 by PP2A complex\", \"stId\": \"R-HSA-163750\", \"stIdVersion\": \"R-HSA-163750.3\", \"isInDisease\": false, \"isInferred\": true, \"name\": [\"Dephosphorylation of phosphoPFKFB1 by PP2A complex\"], \"releaseDate\": \"2005-09-26\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70471, \"displayName\": \"alpha-D-glucose 6-phosphate <=> D-fructose 6-phosphate\", \"stId\": \"R-HSA-70471\", \"stIdVersion\": \"R-HSA-70471.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"alpha-D-glucose 6-phosphate <=> D-fructose 6-phosphate\", \"Glucose 6-phosphate is isomerized to form fructose-6-phosphate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 71654, \"displayName\": \"3-Phospho-D-glycerate <=> 2-Phospho-D-glycerate\", \"stId\": \"R-HSA-71654\", \"stIdVersion\": \"R-HSA-71654.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"3-Phospho-D-glycerate <=> 2-Phospho-D-glycerate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 71496, \"displayName\": \"D-fructose 1,6-bisphosphate <=> dihydroxyacetone phosphate + D-glyceraldehyde 3-phosphate\", \"stId\": \"R-HSA-71496\", \"stIdVersion\": \"R-HSA-71496.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"D-fructose 1,6-bisphosphate <=> dihydroxyacetone phosphate + D-glyceraldehyde 3-phosphate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 71850, \"displayName\": \"1,3-bisphospho-D-glycerate + ADP <=> 3-phospho-D-glycerate + ADP\", \"stId\": \"R-HSA-71850\", \"stIdVersion\": \"R-HSA-71850.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"1,3-bisphospho-D-glycerate + ADP <=> 3-phospho-D-glycerate + ADP\", \"1,3-Bisphosphoglycerate and ADP react to form 3-phosphoglycerate and ATP\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 71660, \"displayName\": \"2-Phospho-D-glycerate <=> Phosphoenolpyruvate + H2O\", \"stId\": \"R-HSA-71660\", \"stIdVersion\": \"R-HSA-71660.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"2-Phospho-D-glycerate <=> Phosphoenolpyruvate + H2O\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70449, \"displayName\": \"D-glyceraldehyde 3-phosphate + orthophosphate + NAD+ <=> 1,3-bisphospho-D-glycerate + NADH + H+\", \"stId\": \"R-HSA-70449\", \"stIdVersion\": \"R-HSA-70449.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"D-glyceraldehyde 3-phosphate + orthophosphate + NAD+ <=> 1,3-bisphospho-D-glycerate + NADH + H+\", \"Glyceraldehyde 3 phosphate, NAD+, and orthophosphate react to form 1,3 bisphosphoglycerate and NADH + H+\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 6799604, \"displayName\": \"GNPDA1,2 hexamers deaminate GlcN6P to Fru(6)P\", \"stId\": \"R-HSA-6799604\", \"stIdVersion\": \"R-HSA-6799604.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"GNPDA1,2 hexamers deaminate GlcN6P to Fru(6)P\"], \"releaseDate\": \"2016-03-23\", \"speciesName\": \"Homo sapiens\", \"isChimeric\": false, \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70420, \"displayName\": \"HK1,2,3,GCK phosphorylate Glc to form G6P\", \"stId\": \"R-HSA-70420\", \"stIdVersion\": \"R-HSA-70420.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"HK1,2,3,GCK phosphorylate Glc to form G6P\", \"alpha-D-Glucose + ATP => alpha-D-glucose 6-phosphate + ADP\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70262, \"displayName\": \"Fructose 2,6-bisphosphate is hydrolyzed to form fructose-6-phosphate and orthophosphate\", \"stId\": \"R-HSA-70262\", \"stIdVersion\": \"R-HSA-70262.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"Fructose 2,6-bisphosphate is hydrolyzed to form fructose-6-phosphate and orthophosphate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 70454, \"displayName\": \"dihydroxyacetone phosphate <=> D-glyceraldehyde 3-phosphate\", \"stId\": \"R-HSA-70454\", \"stIdVersion\": \"R-HSA-70454.2\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"dihydroxyacetone phosphate <=> D-glyceraldehyde 3-phosphate\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 71670, \"displayName\": \"phosphoenolpyruvate + ADP => pyruvate + ATP\", \"stId\": \"R-HSA-71670\", \"stIdVersion\": \"R-HSA-71670.3\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"phosphoenolpyruvate + ADP => pyruvate + ATP\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 6798335, \"displayName\": \"BPGM dimer isomerises 1,3BPG to 2,3BPG\", \"stId\": \"R-HSA-6798335\", \"stIdVersion\": \"R-HSA-6798335.1\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"BPGM dimer isomerises 1,3BPG to 2,3BPG\"], \"releaseDate\": \"2016-03-23\", \"speciesName\": \"Homo sapiens\", \"isChimeric\": false, \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 8955760, \"displayName\": \"PGM2L1:Mg2+ phosphorylates G6P to G1,6BP\", \"stId\": \"R-HSA-8955760\", \"stIdVersion\": \"R-HSA-8955760.1\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"PGM2L1:Mg2+ phosphorylates G6P to G1,6BP\"], \"releaseDate\": \"2017-03-27\", \"speciesName\": \"Homo sapiens\", \"isChimeric\": false, \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 8955794, \"displayName\": \"PGP:Mg2+ dimer hydrolyses 3PG to glycerol\", \"stId\": \"R-HSA-8955794\", \"stIdVersion\": \"R-HSA-8955794.1\", \"isInDisease\": false, \"isInferred\": true, \"name\": [\"PGP:Mg2+ dimer hydrolyses 3PG to glycerol\"], \"releaseDate\": \"2017-03-27\", \"speciesName\": \"Homo sapiens\", \"isChimeric\": false, \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 71802, \"displayName\": \"D-fructose 6-phosphate + ATP => D-fructose 2,6-bisphosphate + ADP\", \"stId\": \"R-HSA-71802\", \"stIdVersion\": \"R-HSA-71802.4\", \"isInDisease\": false, \"isInferred\": false, \"name\": [\"D-fructose 6-phosphate + ATP => D-fructose 2,6-bisphosphate + ADP\", \"Fructose 6-phosphate and ATP react to form fructose 2,6-bisphosphate and ADP\"], \"releaseDate\": \"2004-07-06\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}, {\"dbId\": 163773, \"displayName\": \"Phosphorylation of PF2K-Pase by PKA catalytic subunit\", \"stId\": \"R-HSA-163773\", \"stIdVersion\": \"R-HSA-163773.3\", \"isInDisease\": false, \"isInferred\": true, \"name\": [\"Phosphorylation of PF2K-Pase by PKA catalytic subunit\"], \"releaseDate\": \"2005-09-26\", \"speciesName\": \"Homo sapiens\", \"category\": \"transition\", \"className\": \"Reaction\", \"schemaClass\": \"Reaction\"}]"} \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/tests/test_patchKG.py b/code/reasoningtool/kg-construction/tests/test_patchKG.py deleted file mode 100644 index a0e387594..000000000 --- a/code/reasoningtool/kg-construction/tests/test_patchKG.py +++ /dev/null @@ -1,51 +0,0 @@ -from unittest import TestCase - -import os,sys -import json -import random - -parentdir = os.path.dirname(os.path.dirname(os.path.abspath(__file__))) -sys.path.insert(0,parentdir) - -from Neo4jConnection import Neo4jConnection -from QueryBioLink import QueryBioLink - -sys.path.append(os.path.dirname(os.path.abspath(__file__))+"/../../../") # code directory -from RTXConfiguration import RTXConfiguration - - -def random_int_list(start, stop, length): - start, stop = (int(start), int(stop)) if start <= stop else (int(stop), int(start)) - length = int(abs(length)) if length else 0 - random_list = [] - for i in range(length): - random_list.append(random.randint(start, stop)) - return random_list - - -class TestPatchKG(TestCase): - - rtxConfig = RTXConfiguration() - - def test_add_disease_has_phenotype_relations(self): - - conn = Neo4jConnection(self.rtxConfig.neo4j_bolt, self.rtxConfig.neo4j_username, self.rtxConfig.neo4j_password) - disease_nodes = conn.get_disease_nodes() - - # generate random number array - random_indexes = random_int_list(0, len(disease_nodes) - 1, 10) - - # query BioLink - relation_array = [] - for random_index in random_indexes: - d_id = disease_nodes[random_index] - hp_array = QueryBioLink.map_disease_to_phenotype(d_id) - for hp_id in hp_array: - relation_array.append({"d_id": d_id, "p_id": hp_id}) - - # query Neo4j Database - for relation_item in relation_array: - result = conn.count_has_phenotype_relation(relation_item) - self.assertEqual(result, 1) - - conn.close() diff --git a/code/reasoningtool/kg-construction/timestamp/GenerateTimestampTSV.py b/code/reasoningtool/kg-construction/timestamp/GenerateTimestampTSV.py deleted file mode 100644 index 0cc25aa71..000000000 --- a/code/reasoningtool/kg-construction/timestamp/GenerateTimestampTSV.py +++ /dev/null @@ -1,79 +0,0 @@ -""" This module defines the class GenerateTimestampTSV. -It is written to generate a timestamp TSV. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from QueryChEMBLTimestamp import QueryChEMBLTimestamp -from QueryDisGeNETTimestamp import QueryDisGeNETTimestamp -from QueryDrugBankTimestamp import QueryDrugBankTimestamp -from QueryKEGGTimestamp import QueryKEGGTimestamp -from QueryOMIMTimestamp import QueryOMIMTimestamp -from QueryDGIdbTimestamp import QueryDGIdbTimestamp -from QueryDisontTimestamp import QueryDisontTimestamp -from QueryEBIOLSTimestamp import QueryEBIOLSTimestamp -from QueryHMDBTimestamp import QueryHMDBTimestamp -from QueryMiRBaseTimestamp import QueryMiRBaseTimestamp -from QueryMyChemTimestamp import QueryMyChemTimestamp -from QueryMyGeneTimestamp import QueryMyGeneTimestamp -from QueryNCBITimestamp import QueryNCBITimestamp -from QueryReactomeTimestamp import QueryReactomeTimestamp - - -class GenerateTimestampTSV: - FILE_NAME = 'timestamp.tsv' - - @staticmethod - def __process_all_databases(): - content = '' - # ChEMBL - content += 'ChEMBL\t' + QueryChEMBLTimestamp.get_timestamp() + '\n' - # DisGeNET - content += 'DisGeNET\t' + QueryDisGeNETTimestamp.get_timestamp() + '\n'\ - # Disont - content += 'Disont\t' + QueryDisontTimestamp.get_timestamp() + '\n' - # DrugBank - content += 'DrugBank\t' + QueryDrugBankTimestamp.get_timestamp() + '\n' - # DGIdb - content += 'DGIdb\t' + QueryDGIdbTimestamp.get_timestamp() + '\n' - # EBIOLS - content += 'EBIOLS\t' + QueryEBIOLSTimestamp.get_timestamp() + '\n' - # HMDB - content += 'HMDB\t' + QueryHMDBTimestamp.get_timestamp() + '\n' - # KEGG - content += 'KEGG\t' + QueryKEGGTimestamp.get_timestamp() + '\n' - # MiRBase - content += 'MiRBase\t' + QueryMiRBaseTimestamp.get_timestamp() + '\n' - # MyChem - content += 'MyChem\t' + QueryMyChemTimestamp.get_timestamp() + '\n' - # MyGene - content += 'MyGene\t' + QueryMyGeneTimestamp.get_timestamp() + '\n' - # NCBI - content += 'NCBI\t' + QueryNCBITimestamp.get_timestamp() + '\n' - # OMIM - content += 'OMIM\t' + QueryOMIMTimestamp.get_timestamp() + '\n' - # Reactome - content += 'Reactome\t' + QueryReactomeTimestamp.get_timestamp() + '\n' - - - try: - wf = open(GenerateTimestampTSV.FILE_NAME, 'w+') - wf.write(content) - wf.close() - except OSError as err: - print("writing file, OS error: {0}".format(err)) - - @staticmethod - def generate_timestamp_tsv(): - GenerateTimestampTSV.__process_all_databases() - - -if __name__ == '__main__': - GenerateTimestampTSV.generate_timestamp_tsv() \ No newline at end of file diff --git a/code/reasoningtool/kg-construction/timestamp/QueryChEMBLTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryChEMBLTimestamp.py deleted file mode 100644 index 4f1d73bb4..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryChEMBLTimestamp.py +++ /dev/null @@ -1,45 +0,0 @@ -""" This module defines the class QueryChEMBLTimestamp. -It is written to get the release date of ChEMBL Database. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve - - -class QueryChEMBLTimestamp: - - @staticmethod - def get_timestamp(): - url = "https://chembl.gitbook.io/chembl-interface-documentation/downloads" - soup = retrieve(url) - tbody_tag = soup.find('tbody') - # release date in row 1 col 2 - i = 0 - for tr in tbody_tag.children: - if i == 1: - j = 0 - for td in tr.children: - if j == 2: - date = td.text - d = date.split() - if len(d) == 2: - return d[0] + ",01," + d[1] - else: - return None - j += 1 - i += 1 - return None - - -if __name__ == '__main__': - print(QueryChEMBLTimestamp.get_timestamp()) - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryDGIdbTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryDGIdbTimestamp.py deleted file mode 100644 index 2bf494e35..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryDGIdbTimestamp.py +++ /dev/null @@ -1,46 +0,0 @@ -""" This module defines the class QueryDGIdbTimestamp. -It is written to get the release date of DGIdb. - -http://www.dgidb.org/downloads -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve -from datetime import datetime - -class QueryDGIdbTimestamp: - - @staticmethod - def get_timestamp(): - url = "http://www.dgidb.org/downloads" - soup = retrieve(url) - footer_tag = soup.find(id="footer") - if footer_tag: - date_tag = footer_tag.findChildren("p")[0] - if date_tag: - date = date_tag.text.split()[-1] - r = date.split('-') - if len(r) == 3: - d = datetime(int(r[0]), int(r[1]), int(r[2])) - return d.strftime("%b,%d,%Y") - else: - return None - else: - return None - else: - return None - - -if __name__ == '__main__': - print(QueryDGIdbTimestamp.get_timestamp()) - - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryDisGeNETTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryDisGeNETTimestamp.py deleted file mode 100644 index c3e09df94..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryDisGeNETTimestamp.py +++ /dev/null @@ -1,42 +0,0 @@ -""" This module defines the class QueryDisGeNETTimestamp. -It is written to get the release date of DisGeNET. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve - - -class QueryDisGeNETTimestamp: - - @staticmethod - def get_timestamp(): - url = "http://www.disgenet.org/dbinfo" - soup = retrieve(url) - version_his_tag = soup.find(id="versionHistory") - if version_his_tag: - date = version_his_tag.find_next_sibling("p").text - r = date.split() - if len(r) == 3: - if len(r[1]) == 2: - r[1] = '0' + r[1] - return r[0] + "," + r[1] + r[2] - else: - return None - else: - return None - - -if __name__ == '__main__': - print(QueryDisGeNETTimestamp.get_timestamp()) - - - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryDisontTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryDisontTimestamp.py deleted file mode 100644 index e0899a5ce..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryDisontTimestamp.py +++ /dev/null @@ -1,44 +0,0 @@ -""" This module defines the class QueryDisontTimestamp. -It is written to get the release date of Disease Ontology Database. - -http://www.disease-ontology.org/news/ -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve -from datetime import datetime - - -class QueryDisontTimestamp: - - @staticmethod - def get_timestamp(): - url = "http://www.disease-ontology.org/news/" - soup = retrieve(url) - content_tag = soup.find(id='content') - - date_tag = content_tag.findChildren('p')[0] - if date_tag: - date = date_tag.text.split()[-1] - r = date.split('-') - if len(r) == 3: - d = datetime(int(r[0]), int(r[1]), int(r[2])) - return d.strftime("%b,%d,%Y") - else: - return None - else: - return None - - -if __name__ == '__main__': - print(QueryDisontTimestamp.get_timestamp()) - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryDrugBankTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryDrugBankTimestamp.py deleted file mode 100644 index c1b006334..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryDrugBankTimestamp.py +++ /dev/null @@ -1,36 +0,0 @@ -""" This module defines the class QueryDrugBankTimestamp. -It is written to get the release date of DrugBank. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve - -class QueryDrugBankTimestamp: - - @staticmethod - def get_timestamp(): - url = "https://www.drugbank.ca/release_notes" - soup = retrieve(url) - version_tags = soup.find_all("div", attrs={"class": "card-header"}) - if len(version_tags) > 0: - version_tag = version_tags[0].text - r = version_tag.split() - return r[-3] + "," + r[-2] + r[-1] - else: - return None - - -if __name__ == '__main__': - print(QueryDrugBankTimestamp.get_timestamp()) - - - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryEBIOLSTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryEBIOLSTimestamp.py deleted file mode 100644 index dfd7b37b4..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryEBIOLSTimestamp.py +++ /dev/null @@ -1,39 +0,0 @@ -""" This module defines the class QueryEBIOLSTimestamp. -It is written to get the release date of EBIOLS Database. - -https://www.ebi.ac.uk/ols/index -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve - - -class QueryEBIOLSTimestamp: - - @staticmethod - def get_timestamp(): - url = "https://www.ebi.ac.uk/ols/index" - soup = retrieve(url) - aside_tag = soup.find('aside') - if aside_tag is None or len(aside_tag) == 0: - return None - date_tag = aside_tag.findChildren('h5') - if date_tag is None or len(date_tag) == 0: - return None - - r = date_tag[0].text.split() - return r[2] + "," + r[1] + ',' + r[3] - - -if __name__ == '__main__': - print(QueryEBIOLSTimestamp.get_timestamp()) - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryHMDBTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryHMDBTimestamp.py deleted file mode 100644 index e569243aa..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryHMDBTimestamp.py +++ /dev/null @@ -1,39 +0,0 @@ -""" This module defines the class QueryHMDBTimestamp. -It is written to get the release date of HMDB Database. - -http://www.hmdb.ca/release-notes -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve - - -class QueryHMDBTimestamp: - - @staticmethod - def get_timestamp(): - url = "http://www.hmdb.ca/release-notes" - soup = retrieve(url) - main_tag = soup.find('main') - if main_tag is None or len(main_tag) == 0: - return None - date_tag = main_tag.findChildren('h2') - if date_tag is None or len(date_tag) == 0: - return None - - r = date_tag[0].text.split() - return r[-2] + "01," + r[-1] - - -if __name__ == '__main__': - print(QueryHMDBTimestamp.get_timestamp()) - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryKEGGTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryKEGGTimestamp.py deleted file mode 100644 index 0bda750bf..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryKEGGTimestamp.py +++ /dev/null @@ -1,39 +0,0 @@ -""" This module defines the class QueryKEGGTimestamp. -It is written to get the release date of KEGG. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve - -class QueryKEGGTimestamp: - - @staticmethod - def get_timestamp(): - url = "https://www.genome.jp/kegg/docs/relnote.html" - soup = retrieve(url) - main_tags = soup.find_all(id="main") - if len(main_tags) > 0: - main_tag = main_tags[0].text - index = main_tag.find("Current release") + len("Current release") - r = main_tag[index:].split() - if len(r[3]) == 2: - r[3] = '0' + r[3] - return r[2] + "," + r[3] + r[4] - else: - return None - - -if __name__ == '__main__': - print(QueryKEGGTimestamp.get_timestamp()) - - - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryMiRBaseTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryMiRBaseTimestamp.py deleted file mode 100644 index ebda76b08..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryMiRBaseTimestamp.py +++ /dev/null @@ -1,39 +0,0 @@ -""" This module defines the class QueryMiRBaseTimestamp. -It is written to get the release date of EBIOLS Database. - -http://www.mirbase.org/ -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve - - -class QueryMiRBaseTimestamp: - - @staticmethod - def get_timestamp(): - url = "http://www.mirbase.org/" - soup = retrieve(url) - right_col_tag = soup.find(id='rightColumn') - if right_col_tag is None or len(right_col_tag) == 0: - return None - date_tag = right_col_tag.findChildren('p') - if date_tag is None or len(date_tag) == 0: - return None - r = date_tag[0].text.split() - - return r[-2] + ",01," + r[-1] - - -if __name__ == '__main__': - print(QueryMiRBaseTimestamp.get_timestamp()) - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryMyChemTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryMyChemTimestamp.py deleted file mode 100644 index 28100aad6..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryMyChemTimestamp.py +++ /dev/null @@ -1,58 +0,0 @@ -""" This module defines the class QueryMyChemTimestamp. -It is written to get the release date of MyChem Database. - -https://mychem.info/v1/metadata -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -import requests -import sys -import json -from datetime import datetime - - -class QueryMyChemTimestamp: - TIMEOUT_SEC = 120 - - @staticmethod - def get_timestamp(): - url = "https://mychem.info/v1/metadata" - - try: - res = requests.get(url, timeout=QueryMyChemTimestamp.TIMEOUT_SEC) - except BaseException as e: - print(url, file=sys.stderr) - print('%s received for URL: %s' % (e, url), file=sys.stderr) - return None - - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - - if res is None: - return None - # remove all \n characters using json api and convert the string to one line - json_dict = json.loads(res.text) - if 'build_date' in json_dict.keys(): - build_date = json_dict['build_date'][:10] - r = build_date.split('-') - d = datetime(int(r[0]), int(r[1]), int(r[2])) - return d.strftime("%b,%d,%Y") - else: - return None - - -if __name__ == '__main__': - print(QueryMyChemTimestamp.get_timestamp()) - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryMyGeneTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryMyGeneTimestamp.py deleted file mode 100644 index be197f1ea..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryMyGeneTimestamp.py +++ /dev/null @@ -1,58 +0,0 @@ -""" This module defines the class QueryMyGeneTimestamp. -It is written to get the release date of MyGene Database. - -https://mygene.info/v3/metadata -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -import requests -import sys -import json -from datetime import datetime - - -class QueryMyGeneTimestamp: - TIMEOUT_SEC = 120 - - @staticmethod - def get_timestamp(): - url = "https://mygene.info/v3/metadata" - - try: - res = requests.get(url, timeout=QueryMyGeneTimestamp.TIMEOUT_SEC) - except BaseException as e: - print(url, file=sys.stderr) - print('%s received for URL: %s' % (e, url), file=sys.stderr) - return None - - status_code = res.status_code - if status_code != 200: - print(url, file=sys.stderr) - print('Status code ' + str(status_code) + ' for url: ' + url, file=sys.stderr) - return None - - if res is None: - return None - # remove all \n characters using json api and convert the string to one line - json_dict = json.loads(res.text) - if 'build_date' in json_dict.keys(): - build_date = json_dict['build_date'][:10] - r = build_date.split('-') - d = datetime(int(r[0]), int(r[1]), int(r[2])) - return d.strftime("%b,%d,%Y") - else: - return None - - -if __name__ == '__main__': - print(QueryMyGeneTimestamp.get_timestamp()) - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryNCBITimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryNCBITimestamp.py deleted file mode 100644 index 1e1932355..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryNCBITimestamp.py +++ /dev/null @@ -1,39 +0,0 @@ -""" This module defines the class QueryNCBITimestamp. -It is written to get the release date of NCBI Database. - -https://www.ncbi.nlm.nih.gov/books/NBK25499/#chapter4.Release_Notes -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve - - -class QueryNCBITimestamp: - - @staticmethod - def get_timestamp(): - url = "https://www.ncbi.nlm.nih.gov/books/NBK25499/#chapter4.Release_Notes" - soup = retrieve(url) - main_tag = soup.find(id='chapter4.Release_Notes') - if main_tag is None or len(main_tag) == 0: - return None - date_tag = main_tag.findChildren('h3') - if date_tag is None or len(date_tag) == 0: - return None - - r = date_tag[0].text.split() - return r[-3] + "," + r[-2] + r[-1] - - -if __name__ == '__main__': - print(QueryNCBITimestamp.get_timestamp()) - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryOMIMTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryOMIMTimestamp.py deleted file mode 100644 index 40b3eca7d..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryOMIMTimestamp.py +++ /dev/null @@ -1,31 +0,0 @@ -""" This module defines the class QueryOMIMTimestamp. -It is written to get the release date of OMIM. -https://www.omim.org/statistics/update -The OMIM is updated every month, so the release date is set to the first day of the current month. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -import time - - -class QueryOMIMTimestamp: - - @staticmethod - def get_timestamp(): - return time.strftime("%b,01,%Y", time.localtime()) - - -if __name__ == '__main__': - print(QueryOMIMTimestamp.get_timestamp()) - - - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryReactomeTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryReactomeTimestamp.py deleted file mode 100644 index 1d9da932f..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryReactomeTimestamp.py +++ /dev/null @@ -1,39 +0,0 @@ -""" This module defines the class QueryReactomeTimestamp. -It is written to get the release date of Reactome Database. - -https://reactome.org/ -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -from ScrapingHelper import retrieve - - -class QueryReactomeTimestamp: - - @staticmethod - def get_timestamp(): - url = "https://reactome.org/" - soup = retrieve(url) - main_tag = soup.find(id='fav-portfolio1') - if main_tag is None or len(main_tag) == 0: - return None - date_tag = main_tag.findChildren('h3') - if date_tag is None or len(date_tag) == 0: - return None - - r = date_tag[0].text.split() - return r[-3] + "," + r[-2] + r[-1] - - -if __name__ == '__main__': - print(QueryReactomeTimestamp.get_timestamp()) - - diff --git a/code/reasoningtool/kg-construction/timestamp/QueryUniProtTimestamp.py b/code/reasoningtool/kg-construction/timestamp/QueryUniProtTimestamp.py deleted file mode 100644 index 326782b90..000000000 --- a/code/reasoningtool/kg-construction/timestamp/QueryUniProtTimestamp.py +++ /dev/null @@ -1,29 +0,0 @@ -""" This module defines the class QueryUniProtTimestamp. -It is written to get the release date of UniProt Database. -""" - -__author__ = "" -__copyright__ = "" -__credits__ = ['Deqing Qu', 'Stephen Ramsey'] -__license__ = "" -__version__ = "" -__maintainer__ = "" -__email__ = "" -__status__ = "Prototype" - -import requests - -class QueryChEMBLTimestamp: - - @staticmethod - def get_timestamp(): - url = "ftp://ftp.uniprot.org/pub/databases/uniprot/relnotes.txt" - r = requests.get(url) - - return r - - -if __name__ == '__main__': - print(QueryChEMBLTimestamp.get_timestamp()) - - diff --git a/code/reasoningtool/kg-construction/timestamp/ScrapingHelper.py b/code/reasoningtool/kg-construction/timestamp/ScrapingHelper.py deleted file mode 100644 index 4e8f65853..000000000 --- a/code/reasoningtool/kg-construction/timestamp/ScrapingHelper.py +++ /dev/null @@ -1,31 +0,0 @@ -import requests -from time import sleep -from bs4 import BeautifulSoup -import random -import sys - -# retrieve data from URL -def retrieve(url: str): - # retrieves content at the specified url - print("*", url) - sleep(1) # *never* web scrape faster than 1 request per second - UAS = ("Mozilla/5.0 (Windows NT 6.1; WOW64; rv:40.0) Gecko/20100101 Firefox/40.1", - "Mozilla/5.0 (Windows NT 6.3; rv:36.0) Gecko/20100101 Firefox/36.0", - "Mozilla/5.0 (Macintosh; Intel Mac OS X 10_10; rv:33.0) Gecko/20100101 Firefox/33.0", - "Mozilla/5.0 (Windows NT 6.1) AppleWebKit/537.36 (KHTML, like Gecko) Chrome/41.0.2228.0 Safari/537.36", - "Mozilla/5.0 (Macintosh; Intel Mac OS X 10_10_1) AppleWebKit/537.36 (KHTML, like Gecko) Chrome/41.0.2227.1 Safari/537.36", - "Mozilla/5.0 (Windows NT 6.1; WOW64) AppleWebKit/537.36 (KHTML, like Gecko) Chrome/41.0.2227.0 Safari/537.36", - "Mozilla/5.0 (Macintosh; Intel Mac OS X 10_13_2) AppleWebKit/537.36 (KHTML, like Gecko) Chrome/72.0.3626.109 Safari/537.36" - ) - ua = UAS[random.randrange(len(UAS))] - headers = {'user-agent': ua, 'Cache-Control': 'no-cache'} - try: - r = requests.get(url, headers=headers, verify=False) # get the HTML; ignore SSL errors (present on this particular site) - except BaseException as e: - print(url, file=sys.stderr) - print('%s received for URL: %s' % (e, url), file=sys.stderr) - return None - soup = BeautifulSoup(r.text, "lxml") # parse the HTML - return soup - - diff --git a/code/reasoningtool/kg-construction/timestamp/timestamp.tsv b/code/reasoningtool/kg-construction/timestamp/timestamp.tsv deleted file mode 100644 index 8d1a92ef7..000000000 --- a/code/reasoningtool/kg-construction/timestamp/timestamp.tsv +++ /dev/null @@ -1,14 +0,0 @@ -ChEMBL March,01,2019 -DisGeNET May,13,2019 -Disont Mar,07,2019 -DrugBank April,02,2019 -DGIdb Jan,25,2018 -EBIOLS May,28,2019 -HMDB January,01,2018 -KEGG May,01,2019 -MiRBase October,01,2018 -MyChem May,13,2019 -MyGene May,28,2019 -NCBI June,24,2015 -OMIM May,01,2019 -Reactome March,25,2019 diff --git a/code/reasoningtool/tests/QueryBioLinkTests.py b/code/reasoningtool/tests/QueryBioLinkTests.py deleted file mode 100644 index a5e16db76..000000000 --- a/code/reasoningtool/tests/QueryBioLinkTests.py +++ /dev/null @@ -1,126 +0,0 @@ -import unittest -from QueryBioLink import QueryBioLink as QBL - - -class QueryBioLinkTestCase(unittest.TestCase): - def test_get_label_for_disease(self): - # unknown_resp = QBL.get_label_for_disease('XXX') - # self.assertEqual(unknown_resp, 'UNKNOWN') - - chlr_label = QBL.get_label_for_disease('DOID:1498') # cholera - self.assertIsNone(chlr_label) - - pd_label = QBL.get_label_for_disease('OMIM:605543') # Parkinson’s disease 4 - self.assertEqual(pd_label, "Parkinson Disease 4, Autosomal Dominant") - - def test_get_phenotypes_for_disease_desc(self): - ret_dict = QBL.get_phenotypes_for_disease_desc('OMIM:605543') # Parkinson’s disease 4 - - known_dict = {'HP:0000726': 'Dementia', - 'HP:0001824': 'Weight loss', - 'HP:0002459': 'Dysautonomia', - 'HP:0100315': 'Lewy bodies', - 'HP:0011999': 'Paranoia', - 'HP:0001278': 'Orthostatic hypotension', - 'HP:0000738': 'Hallucinations', - 'HP:0001300': 'Parkinsonism'} - - self.assertDictEqual(ret_dict, known_dict) - - def test_get_diseases_for_gene_desc(self): - empty_dict = QBL.get_diseases_for_gene_desc('NCBIGene:407053') # MIR96 - self.assertEqual(len(empty_dict), 0) - - # TODO find an NCBIGene that `get_diseases_for_gene_desc` would return a non-empty result - - def test_get_genes_for_disease_desc(self): - pd_genes = QBL.get_genes_for_disease_desc('OMIM:605543') # Parkinson’s disease 4 - self.assertEqual(len(pd_genes), 1) - self.assertEqual(pd_genes[0], 'HGNC:11138') - - def test_get_label_for_phenotype(self): - mcd_label = QBL.get_label_for_phenotype('HP:0000003') # Multicystic kidney dysplasia - self.assertEqual(mcd_label, "Multicystic kidney dysplasia") - - def test_get_phenotypes_for_gene(self): - # NEK1, NIMA related kinase 1 - nek1_list = QBL.get_phenotypes_for_gene('NCBIGene:4750') - - known_list = ['HP:0000003', 'HP:0000054', 'HP:0000062', 'HP:0000105', - 'HP:0000110', 'HP:0000171', 'HP:0000204', 'HP:0000248', - 'HP:0000773', 'HP:0000774', 'HP:0000888', 'HP:0000895', - 'HP:0001274', 'HP:0001302', 'HP:0001320', 'HP:0001395', - 'HP:0001629', 'HP:0001631', 'HP:0001762', 'HP:0001789', - 'HP:0002023', 'HP:0002089', 'HP:0002350', 'HP:0002566', - 'HP:0002980', 'HP:0003016', 'HP:0003022', 'HP:0003038', - 'HP:0005054', 'HP:0005257', 'HP:0005349', 'HP:0005766', - 'HP:0005817', 'HP:0005873', 'HP:0006426', 'HP:0006956', - 'HP:0010454', 'HP:0010579', 'HP:0100259'] - - # Sequence does not matter here - self.assertSetEqual(set(nek1_list), set(known_list)) - - def test_get_phenotypes_for_gene_desc(self): - # Test for issue #22 - # CFTR, cystic fibrosis transmembrane conductance regulator - cftr_dict = QBL.get_phenotypes_for_gene_desc('NCBIGene:1080') - - known_dict = {'HP:0000952': 'Jaundice', - 'HP:0011227': 'Elevated C-reactive protein level', - 'HP:0030247': 'Splanchnic vein thrombosis', - 'HP:0012379': 'Abnormal enzyme/coenzyme activity', - 'HP:0001974': 'Leukocytosis'} - - self.assertDictEqual(cftr_dict, known_dict) - - def test_get_anatomies_for_gene(self): - mir96_dict = QBL.get_anatomies_for_gene('NCBIGene:407053') # MIR96 - - known_dict = {'UBERON:0000007': 'pituitary gland', - 'UBERON:0001301': 'epididymis', - 'UBERON:0000074': 'renal glomerulus', - 'UBERON:0000006': 'islet of Langerhans'} - - self.assertDictEqual(mir96_dict, known_dict) - - def test_get_genes_for_anatomy(self): - iol_list = QBL.get_genes_for_anatomy('UBERON:0000006') # islet of Langerhans - - known_list = ['MGI:1929735', 'HGNC:28826', 'HGNC:31579', 'HGNC:28995', - 'HGNC:24172', 'HGNC:6130', 'MGI:2429955', 'MGI:1922935', - 'MGI:1927126', 'HGNC:11513', 'MGI:3647725', 'HGNC:1960', - 'MGI:1922977', 'HGNC:6172', 'MGI:1922469', 'HGNC:3518', - 'MGI:97010', 'ENSEMBL:ENSG00000237404', 'HGNC:20253', - 'HGNC:14676', 'MGI:1915416', 'MGI:1891697', 'HGNC:30237', - 'HGNC:12970', 'HGNC:30766', 'HGNC:51534', 'ENSEMBL:ENSG00000271946', - 'HGNC:17013', 'HGNC:25481', 'MGI:104755', 'MGI:1336199', - 'ENSEMBL:ENSG00000261159', 'MGI:98003', 'MGI:1916344', 'HGNC:28412', - 'MGI:88082', 'MGI:2656825', 'MGI:1918345', 'HGNC:20189', 'HGNC:33526', - 'HGNC:31481', 'ENSEMBL:ENSG00000248632', 'MGI:3615306', 'MGI:109177', - 'HGNC:2697', 'MGI:1342304', 'HGNC:3816', 'HGNC:11656', 'HGNC:29332', - 'HGNC:6294', 'HGNC:13787', 'HGNC:18994', 'MGI:2387188', 'MGI:3584508', - 'ENSEMBL:ENSG00000244306', 'HGNC:29101', 'MGI:1919247', 'HGNC:23433', - 'HGNC:31393', 'MGI:1347084', 'MGI:1316650', 'MGI:2179507', 'MGI:96163', - 'MGI:2146012', 'MGI:1916043', 'HGNC:10435', 'HGNC:48629', 'HGNC:23094', - 'HGNC:25139', 'MGI:2444946', 'HGNC:34236', 'HGNC:26466', 'HGNC:3725', - 'MGI:2141207', 'HGNC:50580', 'HGNC:18294', 'HGNC:33754', 'MGI:1924150', - 'HGNC:12499', 'HGNC:17451', 'NCBIGene:100506691', 'HGNC:2522', - 'MGI:106199', 'HGNC:17811', 'HGNC:8001', 'ENSEMBL:ENSG00000167765', - 'HGNC:33520', 'HGNC:7200', 'HGNC:11996', 'HGNC:29503', 'HGNC:30021', - 'MGI:2139593', 'HGNC:24825', 'ENSEMBL:ENSMUSG00000093459', - 'ENSEMBL:ENSG00000265179', 'HGNC:18696', 'MGI:5504148', 'HGNC:1553', - 'MGI:1353654', 'MGI:88139'] - - # Sequence does not matter here - self.assertSetEqual(set(iol_list), set(known_list)) - - def test_get_anatomies_for_phenotype(self): - mcd_dict = QBL.get_anatomies_for_phenotype('HP:0000003') # Multicystic kidney dysplasia - - known_dict = {'UBERON:0002113': 'kidney'} - - self.assertDictEqual(mcd_dict, known_dict) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryChEMBLTests.py b/code/reasoningtool/tests/QueryChEMBLTests.py deleted file mode 100644 index 3f60ad3c7..000000000 --- a/code/reasoningtool/tests/QueryChEMBLTests.py +++ /dev/null @@ -1,46 +0,0 @@ -import unittest -from QueryChEMBL import QueryChEMBL as QC - - -class QueryChEMBLTestCase(unittest.TestCase): - def test_get_target_uniprot_ids_for_drug(self): - ret_dict = QC.get_target_uniprot_ids_for_drug('clothiapine') - - known_dict = {'P21728': 0.99999999997, 'P21918': 0.9999999824, - 'P14416': 0.99996980427, 'P35367': 0.99996179618, - 'P08913': 0.99973447457, 'P18089': 0.99638618971, - 'P21917': 0.99500274146, 'P28335': 0.98581821496, - 'P18825': 0.97356918354, 'P28223': 0.96867458111, - 'Q9H3N8': 0.83028164473, 'P34969': 0.39141293908, - 'P41595': 0.31891025293, 'P08173': 0.18274693348, - 'P11229': 0.16526971365, 'P04637': 0.12499267788, - 'P35462': 0.11109632984, 'P10635': 0.09162534744, - 'P25100': 0.0855003718, 'P06746': 0.04246537619} - self.assertDictEqual(ret_dict, known_dict) - - def test_get_chembl_ids_for_drug(self): - ret_set = QC.get_chembl_ids_for_drug('clothiapine') - - known_set = {'CHEMBL304902'} - - self.assertSetEqual(ret_set, known_set) - - def test_get_target_uniprot_ids_for_chembl_id(self): - ret_dict = QC.get_target_uniprot_ids_for_chembl_id('CHEMBL304902') - - known_dict = {'P21728': 0.99999999997, 'P21918': 0.9999999824, - 'P14416': 0.99996980427, 'P35367': 0.99996179618, - 'P08913': 0.99973447457, 'P18089': 0.99638618971, - 'P21917': 0.99500274146, 'P28335': 0.98581821496, - 'P18825': 0.97356918354, 'P28223': 0.96867458111, - 'Q9H3N8': 0.83028164473, 'P34969': 0.39141293908, - 'P41595': 0.31891025293, 'P08173': 0.18274693348, - 'P11229': 0.16526971365, 'P04637': 0.12499267788, - 'P35462': 0.11109632984, 'P10635': 0.09162534744, - 'P25100': 0.0855003718, 'P06746': 0.04246537619} - - self.assertDictEqual(ret_dict, known_dict) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryDisGeNetTests.py b/code/reasoningtool/tests/QueryDisGeNetTests.py deleted file mode 100644 index 7a358055c..000000000 --- a/code/reasoningtool/tests/QueryDisGeNetTests.py +++ /dev/null @@ -1,21 +0,0 @@ -import unittest -from QueryDisGeNet import QueryDisGeNet - - -class QueryDisGeNetTestCase(unittest.TestCase): - def test_query_mesh_id_to_uniprot_ids_desc(self): - ret_dict = QueryDisGeNet.query_mesh_id_to_uniprot_ids_desc('D016779') - - known_dict = {'P35228': 'NOS2', 'P17927': 'CR1', 'P01375': 'TNF', - 'P09601': 'HMOX1', 'P15260': 'IFNGR1', 'P29460': 'IL12B', - 'Q96D42': 'HAVCR1', 'P05112': 'IL4', 'P17181': 'IFNAR1', - 'P16671': 'CD36', 'P17948': 'FLT1', 'P03956': 'MMP1', - 'P15692': 'VEGFA', 'P39060': 'COL18A1', 'P12821': 'ACE', - 'P01584': 'IL1B', 'P14778': 'IL1R1', 'P29474': 'NOS3', - 'Q9NR96': 'TLR9', 'P01889': 'HLA-B', 'P03989': 'HLA-B', - 'P10319': 'HLA-B'} - - self.assertDictEqual(ret_dict, known_dict) - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryDisontTests.py b/code/reasoningtool/tests/QueryDisontTests.py deleted file mode 100644 index c922a9815..000000000 --- a/code/reasoningtool/tests/QueryDisontTests.py +++ /dev/null @@ -1,25 +0,0 @@ -import unittest -from QueryDisont import QueryDisont as QD - - -class QueryDisontTestCase(unittest.TestCase): - def test_query_disont_to_child_disonts(self): - ret_set = QD.query_disont_to_child_disonts('DOID:9352') - known_set = {11712, 1837, 10182} - self.assertSetEqual(ret_set, known_set) - - def test_query_disont_to_label(self): - ret_label = QD.query_disont_to_label("DOID:0050741") - self.assertEqual(ret_label, "alcohol dependence") - - def test_query_disont_to_child_disonts_desc(self): - ret_dict = QD.query_disont_to_child_disonts_desc("DOID:9352") # type 2 diabetes mellitus - known_dict = {'DOID:1837': 'diabetic ketoacidosis', - 'DOID:10182': 'diabetic peripheral angiopathy', - 'DOID:11712': 'lipoatrophic diabetes'} - - self.assertDictEqual(ret_dict, known_dict) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryGeneProfTests.py b/code/reasoningtool/tests/QueryGeneProfTests.py deleted file mode 100644 index 861698816..000000000 --- a/code/reasoningtool/tests/QueryGeneProfTests.py +++ /dev/null @@ -1,46 +0,0 @@ -import unittest -from QueryGeneProf import QueryGeneProf as QGP - - -class QueryGeneProfTestCase(unittest.TestCase): - def test_gene_symbol_to_geneprof_ids(self): - ret_set = QGP.gene_symbol_to_geneprof_ids('HMOX1') - known_set = {16269} - self.assertSetEqual(ret_set, known_set) - - def test_geneprof_id_to_transcription_factor_gene_symbols(self): - ret_set = QGP.geneprof_id_to_transcription_factor_gene_symbols(16269) - known_set = {'IRF1', 'ELK4', 'WRNIP1', 'FLI1', 'E2F4', 'KDM4A', 'GATA6', - 'SPI1', 'GATA1', 'CDX2', 'ETV1', 'WHSC1', 'SOX2', 'CTCF', - 'CUX1', 'ZNF143', 'HDAC1', 'MAFF', 'SREBF1', 'BACH1', 'MAZ', - 'TRIM28', 'USF2', 'KDM5B', 'BRCA1', 'SMARCC1', 'CCNT2', 'TBP', - 'ZMIZ1', 'CHD1', 'UBTF', 'SAP30', 'STAT3', 'RBBP5', 'BRD7', - 'POU5F1', 'MYC', 'MAX', 'KLF4', 'RAD21', 'PPARG', 'HSF1', - 'ZC3H11A', 'HCFC1', 'SMARCB1', 'JUN', 'SMARCA4', 'RCOR1', - 'TAL1', 'TFAP2A', 'CHD7', 'CEBPB', 'BHLHE40', 'JUND', 'BCL6', - 'E2F1', 'MAFK', 'STAT1', 'ZNF384', 'CREBBP', 'ZNF263', 'SMARCC2', - 'E2F6', 'MXI1', 'POU2F1', 'KDM1A', 'HMGN3', 'POLR3A', 'SETDB1', - 'PHF8', 'TBL1XR1', 'GTF2F1', 'RFX5', 'ESRRA', 'HNF4A', 'FOXA1', - 'NFE2', 'HDAC2', 'EOMES', 'EP300', 'FOS'} - - self.assertSetEqual(ret_set, known_set) - - def test_gene_symbol_to_transcription_factor_gene_symbols(self): - ret_set = QGP.gene_symbol_to_transcription_factor_gene_symbols('IRF1') - known_set = {'POU5F1', 'CREBBP', 'SMARCC1', 'BRD7', 'SIRT6', 'SPI1', - 'SUZ12', 'CDX2', 'ELK1', 'EP300', 'GATA2', 'E2F6', 'ESRRA', - 'RBBP5', 'JUN', 'TFAP2A', 'TAF2', 'HCFC1', 'MAZ', 'CUX1', 'MAX', - 'HNF4A', 'EOMES', 'ETS1', 'KDM4A', 'TBL1XR1', 'ZNF143', 'ZC3H11A', - 'BRCA1', 'ETV1', 'GATA3', 'CTNNB1', 'POLR3A', 'PHF8', 'FOS', 'USF2', - 'RUNX1', 'RFX5', 'WRNIP1', 'ZNF263', 'UBTF', 'CEBPB', 'SMARCA4', 'GATA1', - 'CHD7', 'TAL1', 'BHLHE40', 'E2F4', 'FOXA1', 'SMC3', 'MAFF', 'DDX5', 'BACH1', - 'EZH2', 'CTCF', 'CHD1', 'MYC', 'KDM5B', 'HDAC2', 'ZNF384', 'RAD21', 'WHSC1', - 'PRDM14', 'NFATC1', 'IRF1', 'KDM1A', 'HDAC6', 'SAP30', 'CCNT2', 'KLF4', - 'SMARCB1', 'TRIM28', 'HMGN3', 'GTF2F1', 'STAT3', 'JUND', 'MXI1', 'CHD2', - 'TBP', 'E2F1', 'SREBF1', 'HDAC1', 'SETDB1', 'ZMIZ1', 'STAT1', 'RCOR1'} - - self.assertSetEqual(ret_set, known_set) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryMiRBaseTests.py b/code/reasoningtool/tests/QueryMiRBaseTests.py deleted file mode 100644 index 9edc295cf..000000000 --- a/code/reasoningtool/tests/QueryMiRBaseTests.py +++ /dev/null @@ -1,17 +0,0 @@ -import unittest -from QueryMiRBase import QueryMiRBase as QMB - - -class QueryMiRBaseTestCase(unittest.TestCase): - def test_convert_mirbase_id_to_mir_gene_symbol(self): - res_symbol = QMB.convert_mirbase_id_to_mir_gene_symbol('MIMAT0027666') - self.assertEqual(res_symbol, "MIR6883") - - def test_convert_mirbase_id_to_mature_mir_ids(self): - ret_set = QMB.convert_mirbase_id_to_mature_mir_ids('MI0014240') - known_set = {'MIMAT0015079'} - self.assertSetEqual(ret_set, known_set) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryMiRGateTests.py b/code/reasoningtool/tests/QueryMiRGateTests.py deleted file mode 100644 index c966499ad..000000000 --- a/code/reasoningtool/tests/QueryMiRGateTests.py +++ /dev/null @@ -1,45 +0,0 @@ -import unittest -from QueryMiRGate import QueryMiRGate as QMG - - -class QueryMiRGateTestCase(unittest.TestCase): - def test_get_microrna_ids_that_regulate_gene_symbol(self): - res_ids = QMG.get_microrna_ids_that_regulate_gene_symbol('HMOX1') - known_ids = {'MIMAT0002174', 'MIMAT0000077', 'MIMAT0021021', 'MIMAT0023252', - 'MIMAT0016901', 'MIMAT0019723', 'MIMAT0019941', 'MIMAT0018996', - 'MIMAT0015029', 'MIMAT0019227', 'MIMAT0014989', 'MIMAT0015078', - 'MIMAT0005920', 'MIMAT0014978', 'MIMAT0024616', 'MIMAT0019012', - 'MIMAT0022726', 'MIMAT0018965', 'MIMAT0019913', 'MIMAT0014990', - 'MIMAT0019028', 'MIMAT0019806', 'MIMAT0015238', 'MIMAT0025852', - 'MIMAT0019844', 'MIMAT0005905', 'MIMAT0023696', 'MIMAT0005871', - 'MIMAT0019829', 'MIMAT0019041', 'MIMAT0019699', 'MIMAT0004776', - 'MIMAT0019218'} - - self.assertSetEqual(res_ids, known_ids) - - def test_get_gene_symbols_regulated_by_microrna(self): - res_ids = QMG.get_gene_symbols_regulated_by_microrna('MIMAT0018979') - - known_ids = {'NISCH', 'MED16', 'FAM53C', 'DGKA', 'GFAP', 'TMEM208', 'COPS7A', - 'ELSPBP1', 'FKTN', 'RP11-617B3.2', 'ELP5', 'AC025335.1', 'PCBP1-AS1', - 'TRAF3', 'P4HA2', 'RABL2A', 'HSP90AB1', 'ST13', 'GPX4', 'HMGN2', - 'RP11-317J19.1', 'DNAJA4', 'TUBA1B', 'COL1A1', 'C22orf25', 'DHX30', - 'LINC00469', 'PROM2', 'CTD-2062F14.3', 'SSBP1', 'BIRC6', 'RP11-998D10.7', - 'NPTX2', 'GPR85', 'CDCA5', 'ATF7IP', 'AC010148.1', 'AGAP3', 'BMPER', - 'MAGED1', 'REG1A', 'DUSP11', 'TCF12', 'SPTBN2', 'SEMA4G', 'DRG2', 'DUS4L', - 'AC012067.1', 'BMF', 'PPM1M', 'TPM1', 'AC105344.2', 'LPIN1', 'PHKG2', - 'RP11-84C10.2', 'IFI27', 'AP001442.2', 'CDK14', 'LRIG2', 'EEFSEC', 'C17orf75', - 'IKBKB', 'MIR655', 'RP11-473I1.10', 'CDH18', 'NSD1', 'ZNF330', 'NCAM1', - 'TCAIM', 'LINC00665', 'ILF3', 'SCRN1', 'PELI3', 'FAR1', 'EWSR1', 'RP11-116K4.1', - 'MAOA', 'OR9Q2', 'LDHC', 'MTRR', 'IL36G', 'MUS81', 'MS4A7', 'AC010731.3', - 'GCNT3', 'RAB26', 'IFT122', 'MORC3', 'RP11-526N18.1', 'SRR', 'EIF3B', 'PTPRA', - 'CTD-2014E2.6', 'TRGV3', 'TRAFD1', 'BBS1', 'ABCC3', 'POLR2J', 'EGFL8.1', 'DECR1', - 'IL20RB', 'METTL21D', 'C1QTNF6', 'CTD-2354A18.1', 'HOOK2', 'NAT9', 'EIF4E2', - 'PABPN1', 'C16orf13', 'LRRC53', 'TRGV7', 'DDX19A', 'CHTOP', 'ZNF707', 'BCAS3', - 'WDR46', 'RP11-467D18.2', 'ART3'} - - self.assertSetEqual(res_ids, known_ids) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryModuleTestSuite.py b/code/reasoningtool/tests/QueryModuleTestSuite.py deleted file mode 100644 index 36314ff7d..000000000 --- a/code/reasoningtool/tests/QueryModuleTestSuite.py +++ /dev/null @@ -1,52 +0,0 @@ -import unittest -from tests.QueryBioLinkTests import QueryBioLinkTestCase -from tests.QueryChEMBLTests import QueryChEMBLTestCase -from tests.QueryDisGeNetTests import QueryDisGeNetTestCase -from tests.QueryDisontTests import QueryDisontTestCase -from tests.QueryGeneProfTests import QueryGeneProfTestCase -from tests.QueryMiRBaseTests import QueryMiRBaseTestCase -from tests.QueryMiRGateTests import QueryMiRGateTestCase -from tests.QueryMyGeneTests import QueryMyGeneTestCase -from tests.QueryNCBIeUtilsTests import QueryNCBIeUtilsTestCase -from tests.QueryOMIMTests import QueryOMIMTestCase -from tests.QueryPC2Tests import QueryPC2TestCase -from tests.QueryPharosTests import QueryPharosTestCase -from tests.QueryReactomeTests import QueryReactomeTestCase -from tests.QuerySciGraphTests import QuerySciGraphTestCase -from tests.QueryUniprotTests import QueryUniprotTestCase - - -class QueryModuleTestSuite(unittest.TestSuite): - def suite(self): - suite = unittest.TestSuite() - - suite.addTest(QueryBioLinkTestCase()) - suite.addTest(QueryChEMBLTestCase()) - suite.addTest(QueryDisGeNetTestCase()) - suite.addTest(QueryDisontTestCase()) - suite.addTest(QueryGeneProfTestCase()) - - suite.addTest(QueryMiRBaseTestCase()) - suite.addTest(QueryMiRGateTestCase()) - suite.addTest(QueryMyGeneTestCase()) - suite.addTest(QueryNCBIeUtilsTestCase()) - suite.addTest(QueryOMIMTestCase()) - - suite.addTest(QueryPC2TestCase()) - suite.addTest(QueryPharosTestCase()) - suite.addTest(QueryReactomeTestCase()) - suite.addTest(QuerySciGraphTestCase()) - suite.addTest(QueryUniprotTestCase()) - - self.run(suite) - - -if __name__ == '__main__': - """ - Run this module outside `tests` folder. - - John@Workstation ~/Documents/Git-repo/NCATS/code/reasoningtool (master) - $ python -m unittest tests/QueryModuleTestSuite.py - - """ - unittest.main() diff --git a/code/reasoningtool/tests/QueryMyGeneTests.py b/code/reasoningtool/tests/QueryMyGeneTests.py deleted file mode 100644 index 969767ef7..000000000 --- a/code/reasoningtool/tests/QueryMyGeneTests.py +++ /dev/null @@ -1,36 +0,0 @@ -import unittest -from QueryMyGene import QueryMyGene - - -class QueryMyGeneTestCase(unittest.TestCase): - @classmethod - def setUpClass(cls): - cls.mg = QueryMyGene() - - def test_convert_gene_symbol_to_uniprot_id(self): - uniprot_ids = self.mg.convert_gene_symbol_to_uniprot_id('A2M') - known_ids = {'P01023'} - self.assertSetEqual(uniprot_ids, known_ids) - - def test_convert_uniprot_id_to_gene_symbol(self): - gene_symbols = self.mg.convert_uniprot_id_to_gene_symbol('Q05925') - know_symbols = {'EN1'} - self.assertSetEqual(gene_symbols, know_symbols) - - def test_convert_uniprot_id_to_entrez_gene_ID(self): - entrez_ids = self.mg.convert_uniprot_id_to_entrez_gene_ID("P09601") - known_ids = {3162} - self.assertSetEqual(entrez_ids, known_ids) - - def test_convert_gene_symbol_to_entrez_gene_ID(self): - entrez_ids = self.mg.convert_gene_symbol_to_entrez_gene_ID('MIR96') - known_ids = {407053} - self.assertSetEqual(entrez_ids, known_ids) - - def test_convert_entrez_gene_ID_to_mirbase_ID(self): - mirbase_ids = self.mg.convert_entrez_gene_ID_to_mirbase_ID(407053) - known_ids = {'MI0000098'} - self.assertSetEqual(mirbase_ids, known_ids) - - -if __name__ == '__main__': diff --git a/code/reasoningtool/tests/QueryNCBIeUtilsTests.py b/code/reasoningtool/tests/QueryNCBIeUtilsTests.py deleted file mode 100644 index 811da739f..000000000 --- a/code/reasoningtool/tests/QueryNCBIeUtilsTests.py +++ /dev/null @@ -1,61 +0,0 @@ -import unittest -from QueryNCBIeUtils import QueryNCBIeUtils - - -class QueryNCBIeUtilsTestCase(unittest.TestCase): - def test_get_clinvar_uids_for_disease_or_phenotype_string(self): - res_set = QueryNCBIeUtils.get_clinvar_uids_for_disease_or_phenotype_string("Parkinson's disease") - # TODO too many IDs in the result; how to evaluate the correctness? - self.assertTrue(len(res_set) > 0) - - def test_get_mesh_uids_for_mesh_term(self): - res_uid = QueryNCBIeUtils.get_mesh_uids_for_mesh_term('Leukemia, Promyelocytic, Acute') - known_uid = ['68015473'] - self.assertListEqual(res_uid, known_uid) - - def test_get_mesh_uid_for_medgen_uid(self): - mesh_uid = QueryNCBIeUtils.get_mesh_uid_for_medgen_uid(41393) - known_uid = {68003550} - self.assertSetEqual(mesh_uid, known_uid) - - def test_get_mesh_terms_for_mesh_uid(self): - mesh_terms = QueryNCBIeUtils.get_mesh_terms_for_mesh_uid(68003550) - known_terms = ['Cystic Fibrosis', 'Fibrosis, Cystic', 'Mucoviscidosis', - 'Pulmonary Cystic Fibrosis', 'Cystic Fibrosis, Pulmonary', - 'Pancreatic Cystic Fibrosis', 'Cystic Fibrosis, Pancreatic', - 'Fibrocystic Disease of Pancreas', 'Pancreas Fibrocystic Disease', - 'Pancreas Fibrocystic Diseases', 'Cystic Fibrosis of Pancreas'] - self.assertSetEqual(set(mesh_terms), set(known_terms)) - - def test_get_mesh_terms_for_omim_id(self): - mesh_terms = QueryNCBIeUtils.get_mesh_terms_for_omim_id(219700) # OMIM preferred name: "CYSTIC FIBROSIS" - known_terms = ['Cystic Fibrosis', 'Fibrosis, Cystic', 'Mucoviscidosis', - 'Pulmonary Cystic Fibrosis', 'Cystic Fibrosis, Pulmonary', - 'Pancreatic Cystic Fibrosis', 'Cystic Fibrosis, Pancreatic', - 'Fibrocystic Disease of Pancreas', 'Pancreas Fibrocystic Disease', - 'Pancreas Fibrocystic Diseases', 'Cystic Fibrosis of Pancreas'] - self.assertSetEqual(set(mesh_terms), set(known_terms)) - - def test_get_medgen_uid_for_omim_id(self): - medgen_ids = QueryNCBIeUtils.get_medgen_uid_for_omim_id(219550) - known_ids = {346587} - self.assertSetEqual(medgen_ids, known_ids) - - def test_get_pubmed_hits_count(self): - hits = QueryNCBIeUtils.get_pubmed_hits_count('"Cholera"[MeSH Terms]') - self.assertEqual(hits, 8104) - - def test_normalized_google_distance(self): - ngd = QueryNCBIeUtils.normalized_google_distance("Cystic Fibrosis", "Cholera") - self.assertAlmostEqual(ngd, 0.69697006) - - def test_is_mesh_term(self): - self.assertTrue(QueryNCBIeUtils.is_mesh_term("Cholera")) - self.assertFalse(QueryNCBIeUtils.is_mesh_term("Foo")) - - - - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryOMIMTests.py b/code/reasoningtool/tests/QueryOMIMTests.py deleted file mode 100644 index 255b2b36e..000000000 --- a/code/reasoningtool/tests/QueryOMIMTests.py +++ /dev/null @@ -1,18 +0,0 @@ -import unittest -from QueryOMIM import QueryOMIM - - -class QueryOMIMTestCase(unittest.TestCase): - def setUp(self): - self.qo = QueryOMIM() - - # test issue 1 - def test_disease_mim_to_gene_symbols_and_uniprot_ids(self): - ret_dict = self.qo.disease_mim_to_gene_symbols_and_uniprot_ids('OMIM:603918') - known_dict = {'gene_symbols': set(), 'uniprot_ids': set()} - - self.assertDictEqual(ret_dict, known_dict) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryPC2Tests.py b/code/reasoningtool/tests/QueryPC2Tests.py deleted file mode 100644 index d9ae30e43..000000000 --- a/code/reasoningtool/tests/QueryPC2Tests.py +++ /dev/null @@ -1,19 +0,0 @@ -import unittest -from QueryPC2 import QueryPC2 - - -class QueryPC2TestCase(unittest.TestCase): - def test_pathway_id_to_uniprot_ids(self): - pw_id = QueryPC2.pathway_id_to_uniprot_ids("R-HSA-1480926") - # TODO find a pathway id such that the return value is not empty - pass - - def test_uniprot_id_to_reactome_pathways(self): - ret_set = QueryPC2.uniprot_id_to_reactome_pathways("P68871") - known_set = {'R-HSA-5653656', 'R-HSA-109582', 'R-HSA-2173782', - 'R-HSA-168256', 'R-HSA-382551', 'R-HSA-168249', 'R-HSA-1480926'} - self.assertSetEqual(ret_set, known_set) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryPharosTests.py b/code/reasoningtool/tests/QueryPharosTests.py deleted file mode 100644 index 1bb354ae1..000000000 --- a/code/reasoningtool/tests/QueryPharosTests.py +++ /dev/null @@ -1,85 +0,0 @@ -import unittest -from QueryPharos import QueryPharos - - -class QueryPharosTestCase(unittest.TestCase): - def test_query_drug_name_to_targets(self): - targets = QueryPharos.query_drug_name_to_targets("lovastatin") - known_targets = [{'id': 19672, 'name': '3-hydroxy-3-methylglutaryl-coenzyme A reductase'}, - {'id': 14711, 'name': 'Integrin alpha-L'}, - {'id': 3939, 'name': 'Farnesyl pyrophosphate synthase'}, - {'id': 14764, 'name': 'Integrin beta-3'}, - {'id': 13844, 'name': 'Cytochrome P450 2D6'}, - {'id': 16824, 'name': 'Prostacyclin receptor'}, - {'id': 8600, 'name': 'Prostaglandin G/H synthase 2'}, - {'id': 18746, 'name': 'Cytochrome P450 3A5'}, - {'id': 17657, 'name': 'Serine/threonine-protein kinase mTOR'}, - {'id': 7520, 'name': 'C-C chemokine receptor type 5'}] - self.assertListEqual(targets, known_targets) - - def test_query_target_to_diseases(self): - diseases = QueryPharos.query_target_to_diseases("16824") - known_diseases = [{'id': '37', 'name': 'ulcerative colitis'}, - {'id': '2163', 'name': 'Heart Diseases'}, - {'id': '574', 'name': 'Asthma, Aspirin-Induced'}, - {'id': '31', 'name': 'osteosarcoma'}, - {'id': '95', 'name': 'lung adenocarcinoma'}, - {'id': '1516', 'name': 'severe asthma'}, - {'id': '39', 'name': "Crohn's disease"}, - {'id': '195', 'name': 'Hypertension'}, - {'id': '1335', 'name': 'Primary pulmonary hypertension'}, - {'id': '9901', 'name': 'Arteriosclerosis obliterans'}, - {'id': '4429', 'name': 'Intermittent claudication'}, - {'id': '192', 'name': 'Atherosclerosis'}, - {'id': '193', 'name': 'Coronary artery disease'}, - {'id': '245', 'name': 'pulmonary arterial hypertension'}, - {'id': '1273', 'name': 'Pulmonary hypertension'}, - {'id': '3746', 'name': 'Nasal discharge'}, - {'id': '501', 'name': 'Cough'}, - {'id': '1371', 'name': 'Nasal congestion'}, - {'id': '142', 'name': 'Allergic rhinitis'}, - {'id': '1350', 'name': 'Rhinitis'}, - {'id': '1024', 'name': 'Common cold'}] - self.assertListEqual(diseases, known_diseases) - - def test_query_target_to_drugs(self): - drugs = QueryPharos.query_target_to_drugs("16824") - known_drugs = [{'id': 8411409, 'name': 'selexipag', 'action': 'AGONIST'}, - {'id': 8411420, 'name': 'iloprost', 'action': 'AGONIST'}, - {'id': 8099182, 'name': 'epoprostenol', 'action': 'AGONIST'}, - {'id': 8411432, 'name': 'beraprost', 'action': 'AGONIST'}, - {'id': 8411443, 'name': 'treprostinil', 'action': 'AGONIST'}] - self.assertListEqual(drugs, known_drugs) - - def test_query_drug_to_targets(self): - targets = QueryPharos.query_drug_to_targets("254599") - known_targets = [{'id': 10000655, 'name': 'HMGCR'}] - self.assertListEqual(targets, known_targets) - - def test_query_target_name(self): - target_name = QueryPharos.query_target_name("16824") - self.assertEqual(target_name, "Prostacyclin receptor") - - def test_query_target_uniprot_accession(self): - term = QueryPharos.query_target_uniprot_accession("19672") - self.assertEqual(term, "P04035") - - def test_query_disease_name(self): - disease_name = QueryPharos.query_disease_name("501") - self.assertEqual(disease_name, "Cough") - - def test_query_drug_name(self): - drug_name = QueryPharos.query_drug_name("254599") - self.assertEqual(drug_name, "lovastatin") - - def test_query_drug_id_by_name(self): - drug_id = QueryPharos.query_drug_id_by_name('lovastatin') - self.assertEqual(drug_id, 254599) - - def test_query_disease_id_by_name(self): - disease_id = QueryPharos.query_disease_id_by_name("Cough") - self.assertEqual(disease_id, 501) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryReactomeTests.py b/code/reasoningtool/tests/QueryReactomeTests.py deleted file mode 100644 index 2c2b8e827..000000000 --- a/code/reasoningtool/tests/QueryReactomeTests.py +++ /dev/null @@ -1,43 +0,0 @@ -import unittest -from QueryReactome import QueryReactome - - -class QueryReactomeTestCase(unittest.TestCase): - def test_query_uniprot_id_to_reactome_pathway_ids_desc(self): - uniprot_ids = QueryReactome.query_uniprot_id_to_reactome_pathway_ids_desc('P68871') - # TODO too many IDs here; how to evaluate correctness - self.assertTrue(len(uniprot_ids) > 0) - - def test_query_reactome_pathway_id_to_uniprot_ids_desc(self): - pw_ids = QueryReactome.query_reactome_pathway_id_to_uniprot_ids_desc('R-HSA-5423646') - known_ids = {'P08684': 'CYP3A4', - 'P20815': 'CYP3A5', - 'P10620': 'MGST1', - 'O14880': 'MGST3', - 'Q99735': 'MGST2', - 'Q9H4B8': 'DPEP3', - 'Q9H4A9': 'DPEP2', - 'P16444': 'DPEP1', - 'Q16696': 'CYP2A13', - 'Q03154': 'ACY1', - 'Q96HD9': 'ACY3', - 'Q6P531': 'GGT6', - 'P36269': 'GGT5', - 'A6NGU5': 'GGT3P', - 'Q9UJ14': 'GGT7', - 'P19440': 'GGT1', - 'P05177': 'CYP1A2', - 'O95154': 'AKR7A3', - 'Q8NHP1': 'AKR7L', - 'O43488': 'AKR7A2'} - self.assertDictEqual(pw_ids, known_ids) - - def test_query_uniprot_id_to_interacting_uniprot_ids_desc(self): - res_uniprot_ids = QueryReactome.query_uniprot_id_to_interacting_uniprot_ids_desc('P68871') - known_ids = {'P69905': 'HBA', 'P02008': 'HBAZ'} - - self.assertDictEqual(res_uniprot_ids, known_ids) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QuerySciGraphTests.py b/code/reasoningtool/tests/QuerySciGraphTests.py deleted file mode 100644 index ab4a651d9..000000000 --- a/code/reasoningtool/tests/QuerySciGraphTests.py +++ /dev/null @@ -1,25 +0,0 @@ -import unittest -from QuerySciGraph import QuerySciGraph - - -class QuerySciGraphTestCase(unittest.TestCase): - def test_get_disont_ids_for_mesh_id(self): - disont_ids = QuerySciGraph.get_disont_ids_for_mesh_id('MESH:D005199') - known_ids = {'DOID:13636'} - self.assertSetEqual(disont_ids, known_ids) - - def test_query_sub_phenotypes_for_phenotype(self): - sub_phenotypes = QuerySciGraph.query_sub_phenotypes_for_phenotype("HP:0000107") # Renal cyst - known_phenotypes = {'HP:0100877': 'Renal diverticulum', - 'HP:0000108': 'Renal corticomedullary cysts', - 'HP:0000803': 'Renal cortical cysts', - 'HP:0000003': 'Multicystic kidney dysplasia', - 'HP:0008659': 'Multiple small medullary renal cysts', - 'HP:0005562': 'Multiple renal cysts', - 'HP:0000800': 'Cystic renal dysplasia', - 'HP:0012581': 'Solitary renal cyst'} - self.assertDictEqual(sub_phenotypes, known_phenotypes) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/QueryUniprotTests.py b/code/reasoningtool/tests/QueryUniprotTests.py deleted file mode 100644 index ede1ac0f9..000000000 --- a/code/reasoningtool/tests/QueryUniprotTests.py +++ /dev/null @@ -1,15 +0,0 @@ -import unittest -from QueryUniprot import QueryUniprot - - -class QueryUniprotTestCase(unittest.TestCase): - def test_uniprot_id_to_reactome_pathways(self): - res_set = QueryUniprot.uniprot_id_to_reactome_pathways("P68871") - known_set = {'R-HSA-983231', 'R-HSA-2168880', 'R-HSA-1237044', - 'R-HSA-6798695', 'R-HSA-1247673'} - - self.assertSetEqual(res_set, known_set) - - -if __name__ == '__main__': - unittest.main() diff --git a/code/reasoningtool/tests/README.md b/code/reasoningtool/tests/README.md deleted file mode 100644 index 713e13f74..000000000 --- a/code/reasoningtool/tests/README.md +++ /dev/null @@ -1,4 +0,0 @@ -To run the test suite for the python modules that are used by the RTX reasoning tool engine: - - cd [git-repo]/code/reasoningtool - python3 -m unittest tests/QueryModuleTestSuite.py diff --git a/code/reasoningtool/tests/__init__.py b/code/reasoningtool/tests/__init__.py deleted file mode 100644 index e69de29bb..000000000