The largest database of trusted experimental protocols

RGAP

RGAP (Receptor Guanylate Activating Protein) is a family of transmembrane proteins that activate guanylate cyclase, an enzyme responsible for the production of the second messenger cyclic GMP.
These proteins play a crucial role in signal transduction pathways, often involved in the regulation of vascular tone, neurotransmission, and other physiological processes.
RGAP proteins contain extracellular ligand-binding domains and intracellular guanylate cyclase domains, allowing them to transduce extracellular signals into intracellular cGMP production.
Research on RGAP has provided insights into the mechanisms of cellular signaling and its implications in health and disease.
The study of RGAP has led to a better undrestanding of its potential as a therapeutic target in conditions such as hypertension, neurological disorders, and cardiovascular disease.

Most cited protocols related to «RGAP»

The first step in analysis of an RNA-seq data set is to align (map) the reads to the genome, which is complicated by the presence of introns. Because introns can be very long, particularly in mammalian genomes, the alignment program must be capable of aligning a read in two or more pieces that can be widely separated on a chromosome. The size of RNA-seq data sets, numbering in the tens of millions or even hundreds of millions of reads, demands that spliced alignment programs also be very efficient. The TopHat program achieves efficiency primarily through the use of the Bowtie aligner [13 (link)], an extremely fast and memory-efficient program for aligning unspliced reads to the genome. TopHat uses Bowtie to find all reads that align entirely within exons, and creates a set of partial exons from these alignments. It then creates hypothetical intron boundaries between the partial exons, and uses Bowtie to re-align the initially unmapped (IUM) reads and find those that define introns.
TopHat-Fusion implements several major changes to the original TopHat algorithm, all designed to enable discovery of fusion transcripts (Figure 2). After identifying the set of IUM reads, it splits each read into multiple 25-bp pieces, with the final segment being 25 bp or longer; for example, an 80-bp read will be split into three segments of length 25, 25, and 30 (Figure 3).
The algorithm then uses Bowtie to map the 25-bp segments to the genome. For normal transcripts, the TopHat algorithm requires that segments must align in a pattern consistent with introns; that is, the segments may be separated by a user-defined maximum intron length, and they must align in the same orientation along the same chromosome. For fusion transcripts, TopHat-Fusion relaxes both these constraints, allowing it to detect fusions across chromosomes as well as fusions caused by inversions.
Following the mapping step, we filter out candidate fusion events involving multi-copy genes or other repetitive sequences, on the assumption that these sequences cause mapping artifacts. However, some multi-mapped reads (reads that align to multiple locations) might correspond to genuine fusions: for example, in Kinsella et al. [19 (link)], the known fusion genes HOMEZ-MYH6 and KIAA1267-ARL17A were supported by 2 and 11 multi-mapped read pairs, respectively. Therefore, instead of eliminating all multi-mapped reads, we impose an upper bound M (default M = 2) on the number of mappings per read. If a read or a pair of reads has M or fewer multi-mappings, then all mappings for that read are considered. Reads with > M mappings are discarded.
To further reduce the likelihood of false positives, we require that each read mapping across a fusion point have at least 13 bases matching on both sides of the fusion, with no more than two mismatches. We consider alignments to be fusion candidates when the two 'sides' of the event either (a) reside on different chromosomes or (b) reside on the same chromosome and are separated by at least 100,000 bp. The latter are the results of intra-chromosomal rearrangements or possibly read-through transcription events. We chose the 100,000-bp minimum distance as a compromise that allows TopHat-Fusion to detect intra-chromosomal rearrangements while excluding most but not all read-through transcripts. Intra-chromosomal fusions may also include inversions.
As shown in Figure 3a, after splitting an IUM read into three segments, the first and last segments might be mapped to two different chromosomes. Once this pattern of alignment is detected, the algorithm uses the three segments from the IUM read to find the fusion point. After finding the precise location, the segments are re-aligned, moving inward from the left and right boundaries of the original DNA fragment. The resulting mappings are combined together to give full read alignments. For this re-mapping step, TopHat-Fusion extracts 22 bp immediately flanking each fusion point and concatenates them to create 44-bp 'spliced fusion contigs' (Figure 4a). It then creates a Bowtie index (using the bowtie-build program [13 (link)]) from the spliced contigs. Using this index, it runs Bowtie to align all the segments of all IUM reads against the spliced fusion contigs. For a 25-bp segment to be mapped to a 44-bp contig, it has to span the fusion point by at least 3 bp. (For more details, see Additional files 10, 11 and 12.)
After stitching together the segment mappings to produce full alignments, we collect those reads that have at least one alignment spanning the entire read. We then choose the best alignment for each read using a heuristic scoring function, defined below. We assign penalties for alignments that span introns (-2), indels (-4), or fusions (-4). For each potential fusion, we require that spanning reads have at least 13 bp aligned on both sides of the fusion point. (This requirement alone eliminates many false positives.) After applying the penalties, if a read has more than one alignment with the same minimum penalty score, then the read with the fewest mismatches is selected. For example, in Figure 4b, IUM read 1 (in blue) is aligned to three different locations: (1) chromosome i with no gap, (2) chromosome j where it spans an intron, and (3) a fusion contig formed between chromosome m and chromosome n. Our scoring function prefers (1), followed by (2), and by (3). For IUM read 2 (Figure 4b, in green), we have two alignments: (1) a fusion formed between chromosome i and chromosome j, and (2) an alignment to chromosome k with a small deletion. These two alignments both incur the same penalty, but we select (1) because it has fewer mismatches.
We imposed further filters for each data set: (1) in the breast cancer cell lines (BT474, SKBR3, KPL4, MCF7), we required two supporting pairs and the sum of spanning reads and supporting pairs to be at least 5; (2) in the VCaP paired-end reads, we required the sum of spanning reads and supporting pairs to be at least 10; (3) in the UHR paired-end reads, we required (i) three spanning reads and two supporting pairs or (ii) the sum of spanning reads and supporting pairs to be at least 10; and (4) in the UHR single-end reads, we required two spanning reads. These numbers were determined empirically using known fusions as a quality control. All candidates that fail to satisfy these filters were eliminated.
In order to remove false positive fusions caused by repeats, we extract the two 23-base sequences spanning each fusion point and then map them against the entire human genome. We convert the resulting alignments into a list of pairs (chromosome name, genomic coordinate - for example, chr14:374384). For each 23-mer adjacent to a fusion point, we test to determine if the other 23-mer occurs within 100,000 bp on the same chromosome. If so, then it is likely a repeat and we eliminate the fusion candidate. We further require that at least one side of a fusion contains an annotated gene (based on known genes from RefSeq), otherwise the fusion is filtered out. These steps alone reduced the number of fusion candidates in our experiments from 105 to just a few hundred.
As reported in Edgren et al. [12 (link)], true fusion transcripts have reads mapping uniformly in a wide window across the fusion point, whereas false positive fusions are narrowly covered. Using this idea, TopHat-Fusion examines a 600-bp window around each fusion (300-bp each side), and rejects fusion candidates for which the reads fail to cover this window (Figure 5b). The final process is to sort fusions based on how well-distributed the reads are (Figure 6). The scoring scheme prefers alignments that have no gaps (or small gaps) and uniform depth.
Even with strict parameters for the initial alignment, many of the segments will map to multiple locations, which can make it appear that a read spans two chromosomes. Thus the algorithm may find large numbers of false positives, primarily due to the presence of millions of repetitive sequences in the human genome. Even after filtering to choose the best alignment per read, the experiments reported here yielded initial sets of about 400,000 and 135,000 fusion gene candidates from the breast cancer (BT474, SKBR3, KPL4, MCF7) and prostate cancer (VCaP) cell lines, respectively. The additional filtering steps eliminated the vast majority of these false positives, reducing the output to 76 and 19 fusion candidates, respectively, all of which have strong supporting evidence (Tables 2 and 3).
The scoring function used to rank fusion candidates uses the number of paired reads in which the reads map on either side of the fusion point in a consistent orientation (Figure 5a) as well as the number of reads in conflict with the fusion point. Conflicting reads align entirely to either of the two chromosomes and span the point at which the chromosome break should occur (Figure 5b).
The overall fusion score is computed as:
score=lcount+rcount+minmax_avg,lavg+minmax_avg,ravglcount-rcount-minmax_avg,|lavg-ravg|lgap+rgap-lder+rder×max_avg+ratemin1000,dist
where lcount is the number of bases covered in a 300-bp window on the left (Figure 6), lavg is the average read coverage on the left, max_avg is 300, lgap is the length of any gap on the left, rate is the ratio between the number of supporting mate pairs and the number of contradicting reads, |lavg - ravg| is a penalty for expression differences on either side of the fusion, and dist is the sum of distances between each end of a pair and a fusion. (For single-end reads, the rate uses spanning reads rather than mate pairs.) The variance in coverage lder is:
lder=square root of sum of ((lavg-ldepthn)lavg)2lwindow from n=1ton=lwindow
where lwindow is the size of the left window (300 bp).
TopHat-Fusion outputs alignments of singleton reads and paired-end reads mapped across fusion points in SAM format [28 (link)], enabling further downstream analyses [29 (link)], such as transcript assembly and differential gene expression. The parameters in the filtering steps can be changed as needed for a particular data set.
Full text: Click here
Publication 2011
The effects of all bi-allelic SNPs (low, medium and high effects) on the genome were determined based on the pre-built release 7.0 annotation from the Rice Genome Annotation Project (http://rice.plantbiology.msu.edu/) using SnpEff51 (link) release 4.1l, with parameters -v -noLog -canon rice7. Using sequence ontology terms, a low-effect SNP was classified as ‘synonymous_variant’, ‘splice_region_variant’, ‘initiator_codon_variant’, ‘5_prime_UTR_premature_start_codon_gain_variant’ or ‘stop_retained_variant’. A moderate-effect SNP was identified as a ‘missense_variant’ and a high-effect SNP as a ‘start_lost’, ‘stop_gained’, ‘stop_lost’, ‘splice_donor_variant’ or ‘splice_acceptor_variant’. For indel effects, only indels with lengths that were not multiples of three were counted and SNPs overlapped with protein-coding regions (CDSs of RGAP 715 (link) genes) were considered as the most disruptive effects on genes. Results of the SNP and indel effect analysis are given in Supplementary Data 2 Tables 3, 4. We computed the SNP numbers (proportions) of rare SNPs and homozygous singletons for a ‘typical genome’ of a subpopulation as the median SNP number (proportion) of the SNPs in a given category among those genomes for that subpopulation (Supplementary Data 2 Table 5).
Full text: Click here
Publication 2018
5' Untranslated Regions Alleles Codon, Initiator Donors Genes Genome Homozygote INDEL Mutation Missense Mutation Open Reading Frames Oryza sativa Population Group Premature Birth rGAP Silent Mutation Single Nucleotide Polymorphism Triglyceride Storage Disease with Ichthyosis
The GO terms and assignments for rice genes were downloaded from Gramene database (http://www.gramene.org/) (Jaiswal[2011 (link)]) and KO from KEGG database (http://www.genome.jp/kegg/) (Kanehisa et al.[2010 (link)]). The RAP rice gene locus IDs in KEGG database were converted to RGAP IDs using RAP-DB ID converter tool (http://rapdb.dna.affrc.go.jp/tools/converter) (Tanaka et al.[2008 (link)]). Then hypergeometric distribution was used to calculate the p value for GO and KO enrichment analyses.
Full text: Click here
Publication 2012
Genes Genes, vpr Genome Oryza sativa rGAP
As of March 2012, microarray data from 105 rice microarray experiments (1,867 hybridizations) were collected from NCBI GEO (Barrett et al.[2009 (link)]), EBI ArrayExpress (Parkinson et al.[2007 (link)]) and PLEXdb (Dash et al.[2012 (link)]). The raw data was downloaded and experiments without raw data were discarded. For one-channel array (Affymetrix), MAS 5.0 method provided by the R package, affy, for the Affymetrix rice array was used to conduct background correction, normalization, probe specific background correction, probe summarization and convert probe level data to expression values (Affymetrix[2012 ]). The trimmed mean target intensity of each array was arbitrarily set to 500. The data were then log2 transformed. For two-channel arrays (Agilent 22K and 44K, BGI/Yale, NSF 20K and 45K), R package marray in Bioconductor was used to do the normalization with within-array Lowess and between-array MAD scale normalization methods (Cleveland[1979 (link)]; Wang et al.[2002 (link)]). The color-swap hybridizations were manually corrected to make them comparable among other samples. In case of Agilent 44K array data used for meta-profiling analyses, we converted the median signal intensities of Cy3 to log2 median intensities and then normalized the log2 intensities using the quantile normalization method (Bolstad et al.[2003 (link)]). The sequences of probes were extracted from each platform website and then mapped onto RGAP V6, RAP V3 and KOME cDNAs using NCBI Blast with 100% identity over 100% coverage (Altschul et al.[1990 (link)]). Regarding Affymetrixprobeset which have 11 probe pairs, the probeset with at least half perfect-match (PM) probes matched onto cDNA sequence was considered as mapped.
The ROAD database was constructed with PHP (Hypertext Preprocessor) and MySQL, run on a Windows 2003 server. The http address ishttp://www.ricearray.org. Heatmap and classic line plots were generated by the PHP library JpGraph (http://jpgraph.net/).
Full text: Click here
Publication 2012
Acid Hybridizations, Nucleic cDNA Library DNA, Complementary Microarray Analysis Oryza sativa rGAP
GSTs were identified by keyword, domain name and HMMER searches of rice proteome available at Rice Genome Annotation Project [49 ] database using the Hidden Markov Model (HMM) profile (build 2.3.2) of GST_N domain (PF02798) downloaded from PFam. The presence of GST_N domain in individual protein was further confirmed by SMART analysis. Multiple sequence alignment analyses were performed using ClustalX (version 1.83) program. The GST genes present on duplicated chromosomal segments were identified by segmental genome duplication of rice available at RGAP with the maximum length distance permitted between collinear gene pairs of 500 kb. The GST genes separated by a maximum of five genes were identified as tandemly duplicated genes. The unrooted phylogenetic trees were constructed by neighbor-joining method and displayed using Treeview program. Putative conserved motifs were identified using MEME (version 4.1.0) program [50 ].
Full text: Click here
Publication 2010
Chromosomes Genes Genes, Duplicate Genome O-(glucuronic acid 2-sulfate)-(1--3)-O-(2,5)-andydrotalitol 6-sulfate Oryza sativa Proteins Proteome rGAP Segmental Duplications, Genomic Sequence Analysis

Most recents protocols related to «RGAP»

Not available on PMC !
The bioinformatics apparatuses Impact and Phytozome and Rice Genome Explanation Venture Data set (RGAP) data sets are used to distinguish and choose qualities that have been displayed to present resistance to explicit biotic burdens in rice. Qualities were considered from both rice and other related species that show potential for upgrading biotic pressure resistance.
Publication 2024
Twenty-seven amino acid sequences of HAK from rice and 13 amino acid sequences of HAK from Arabidopsis were obtained from the rice genome database RGAP (http://rice.plantbiology.msu.edu/) and the Arabidopsis database TAIR (https://www.arabidopsis.org/), respectively. These sequences were aligned with Moso bamboo sequences using ClustalX2.1 software, and the sequence alignment results were used to construct a phylogenetic tree using MEGA11 software with the Maximum likelihood (ML) method and 1000 bootstrap replicates for evaluation.
Full text: Click here
Publication 2024
The markers located in the earlier identified genomic region associated with the traits improving seedling vigor of rice under DSR were screened. All the gene files for the reference genome were retrieved from RGAP. The selected markers then screened for the donor specificity using the merged variant file created using BCF tools. All the shortlisted markers were aligned with the reference genome using BLAST and the markers showing alignment at the multiple loci were rejected. Only the high specificity markers aligning at desired locus with low e-value were selected.
Full text: Click here
Publication 2024
The Rice Genome Annotation Project (RGAP) database (https://rice.uga.edu/cgi-bin/gbrowser/rice, accessed on 20, 4 2023) was used to retrieve the functional candidate genes at CI of core MQTL. The above database was then used to obtain the description of the CGs in the core MQTL intervals. To enhance the accuracy of our assumptions on CGs, the orthologous genes in the core MQTL regions were placed over the genomes of sorghum and maize. The TBtools software [42 (link)] was used to visualize the gene density and orthologue genes in sorghum and maize.
Full text: Click here
Publication 2024
Whole genome information for Arabidopsis and rice were downloaded from the Arabidopsis Information Resource, version 10 (TAIR 10) (http://www.arabidopsis.org) and the RGAP 7 database (http://rice.plantbiology.msu.edu/), respectively. The KNOX protein sequences from Arabidopsis, rice, and Moso bamboo were aligned using ClustalX. Subsequently, to gain insights into the phylogenetic relationships among these sequences, MEGA 7.0 was used to construct the phylogenetic tree using the neighbor-joining (NJ) method [56 (link)], with 1000 bootstrap replicates. Motifs of the KNOX proteins were then analyzed using MEME [57 (link)]. Furthermore, conserved domains of the KNOX proteins were predicted by the NCBI Batch Web CDD-Search Tool (https://www.ncbi.nlm.nih.gov/Structure/bwrpsb/bwrpsb.cgi). Finally, the protein structures were visualized using TBtools [58 (link)].
Full text: Click here
Publication 2024

Top products related to «RGAP»

Sourced in United States, China, Germany, Canada, Hong Kong, Italy, United Kingdom, Sweden, Japan, Spain, Australia, Norway, Denmark, Switzerland, India, France, Cameroon, Brazil
The HiSeq 2000 platform is a high-throughput DNA sequencing system designed for large-scale genomic research. It utilizes sequencing-by-synthesis technology to generate high-quality DNA sequence data. The HiSeq 2000 is capable of processing multiple samples simultaneously, producing large volumes of sequencing data in a single run.
Sourced in United States, China, Germany, United Kingdom, Hong Kong, Canada, Switzerland, Australia, France, Japan, Italy, Sweden, Denmark, Cameroon, Spain, India, Netherlands, Belgium, Norway, Singapore, Brazil
The HiSeq 2000 is a high-throughput DNA sequencing system designed by Illumina. It utilizes sequencing-by-synthesis technology to generate large volumes of sequence data. The HiSeq 2000 is capable of producing up to 600 gigabases of sequence data per run.
Sourced in United States, Germany, Canada, China, France, United Kingdom, Japan, Netherlands, Italy, Spain, Australia, Belgium, Denmark, Switzerland, Singapore, Sweden, Ireland, Lithuania, Austria, Poland, Morocco, Hong Kong, India
The Agilent 2100 Bioanalyzer is a lab instrument that provides automated analysis of DNA, RNA, and protein samples. It uses microfluidic technology to separate and detect these biomolecules with high sensitivity and resolution.
Sourced in United States, Germany, China, United Kingdom, Sao Tome and Principe, Macao, Italy, Japan, Canada, France, Switzerland, Israel, Australia, Spain, India, Ireland, Brazil, Poland, Netherlands, Sweden, Denmark, Hungary, Austria, Mongolia
The LPS laboratory equipment is a high-precision device used for various applications in scientific research and laboratory settings. It is designed to accurately measure and monitor specific parameters essential for various experimental procedures. The core function of the LPS is to provide reliable and consistent data collection, ensuring the integrity of research results. No further details or interpretations can be provided while maintaining an unbiased and factual approach.
Sourced in United States, Germany, United Kingdom, Italy, China
Primer Express 3.0 is a software tool designed for the design of real-time PCR primers and probes. The software uses proprietary algorithms to recommend optimal primer and probe sequences based on user-provided input sequences and parameters.
Sourced in United States, Germany, United Kingdom, China, Canada, Japan, Italy, France, Belgium, Switzerland, Singapore, Uruguay, Australia, Spain, Poland, India, Austria, Denmark, Netherlands, Jersey, Finland, Sweden
The FACSCalibur is a flow cytometry system designed for multi-parameter analysis of cells and other particles. It features a blue (488 nm) and a red (635 nm) laser for excitation of fluorescent dyes. The instrument is capable of detecting forward scatter, side scatter, and up to four fluorescent parameters simultaneously.
Sourced in United States
The SYBR Green PCR Master Mix kit is a ready-to-use solution for performing real-time polymerase chain reaction (PCR) analysis. It contains all the necessary components, including a DNA polymerase, SYBR Green I dye, and buffer, to facilitate the amplification and detection of target DNA sequences.
Sourced in United States, Canada
The PJET1.2/blunt cloning vector is a plasmid-based cloning vector designed for the insertion and propagation of DNA fragments. It features a blunt cloning site, allowing for the direct ligation of DNA fragments without the need for restriction enzyme digestion or the generation of compatible sticky ends. The vector backbone provides antibiotic resistance and a origin of replication, facilitating the selection and amplification of the cloned DNA in bacterial hosts.
Sourced in United States, Germany, China, United Kingdom, Japan, Canada, France, Italy, Australia, Spain, Denmark, Switzerland, Singapore, Poland, Ireland, Belgium, Netherlands, Lithuania, Austria, Brazil
The NanoDrop 2000 spectrophotometer is an instrument designed to measure the concentration and purity of a wide range of biomolecular samples, including nucleic acids and proteins. It utilizes a unique sample retention system that requires only 1-2 microliters of sample to perform the analysis.
Sourced in United States, Germany, Italy, China, United Kingdom, Switzerland, Canada, Spain, Australia, France, Israel, Singapore, Japan, Sweden, India
ITaq Universal SYBR Green Supermix is a pre-mixed, ready-to-use solution containing all the necessary components, including SYBR Green I dye, for real-time PCR amplification and detection. It is designed for sensitive and reliable quantification of DNA targets.

More about "RGAP"

RGAP (Receptor Guanylate Activating Protein) is a family of transmembrane proteins that play a crucial role in cellular signaling and physiological processes.
These proteins activate guanylate cyclase, an enzyme responsible for the production of the second messenger cyclic GMP (cGMP).
RGAP proteins contain extracellular ligand-binding domains and intracellular guanylate cyclase domains, allowing them to transduce extracellular signals into intracellular cGMP production.
The study of RGAP has provided valuable insights into the mechanisms of signal transduction, with implications in the understanding and treatment of various health conditions.
RGAP-mediated pathways are involved in the regulation of vascular tone, neurotransmission, and other important physiological processes.
Researchers have utilized advanced analytical tools, such as the HiSeq 2000 platform and the Agilent 2100 Bioanalyzer, to study the expression and function of RGAP proteins.
Techniques like quantitative PCR, using Primer Express 3.0 and SYBR Green PCR Master Mix kit, have been employed to measure RGAP-related gene expression.
Additionally, flow cytometry with the FACSCalibur instrument has been employed to investigate the cellular distribution and localization of RGAP proteins.
The NanoDrop 2000 spectrophotometer has also been utilized to assess the purity and concentration of RGAP-related biomolecules.
The PJET1.2/blunt cloning vector has been used in the study of RGAP, facilitating the cloning and expression of RGAP-related genes.
Furthermore, the ITaq Universal SYBR Green Supermix has been employed in qPCR assays to quantify RGAP-mediated signaling pathways.
Overall, the research on RGAP has provided valuable insights into cellular signaling mechanisms and their implications in health and disease, with potential therapeutic applications in conditions such as hypertension, neurological disorders, and cardiovascular disease.